From 3367a408b25efd4f720dd600e894e10269020013 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Thu, 8 Nov 2018 12:03:24 -0500 Subject: [PATCH 001/469] Add single2 method to Pair that can compute and return the Hessian matrix --- src/pair.cpp | 14 +++++++++++++- src/pair.h | 14 ++++++++++---- src/pair_lj_smooth_linear.cpp | 27 +++++++++++++++++++++++++-- src/pair_lj_smooth_linear.h | 1 + 4 files changed, 49 insertions(+), 7 deletions(-) diff --git a/src/pair.cpp b/src/pair.cpp index 18d561bdb5..f76bb54c36 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -301,7 +301,7 @@ void Pair::init_style() specific pair style can override this function ------------------------------------------------------------------------- */ -void Pair::init_list(int /*which*/, NeighList *ptr) +void Pair::init_list(int which, NeighList *ptr) { list = ptr; } @@ -1740,6 +1740,18 @@ void Pair::init_bitmap(double inner, double outer, int ntablebits, /* ---------------------------------------------------------------------- */ +void Pair::pairTensor(double fforce, double dfac, double delr[3], double phiTensor[6]) { + int m = 0; + for (int k=0; k<3; k++) { + phiTensor[m] = fforce; + for (int l=k; l<3; l++) { + if (l>k) phiTensor[m] = 0; + phiTensor[m++] += delr[k]*delr[l] * dfac; + } + } +} +/* ---------------------------------------------------------------------- */ + double Pair::memory_usage() { double bytes = comm->nthreads*maxeatom * sizeof(double); diff --git a/src/pair.h b/src/pair.h index c1a9e6eef8..a9506480be 100644 --- a/src/pair.h +++ b/src/pair.h @@ -145,6 +145,16 @@ class Pair : protected Pointers { return 0.0; } + void pairTensor(double fforce, double dfac, double delr[3], double phiTensor[6]); + + virtual double single2(int, int, int, int, + double, double[3], double, double, + double& fforce, double d2u[6]) { + fforce = 0.0; + for (int i=0; i<6; i++) d2u[i] = 0; + return 0.0; + } + virtual void settings(int, char **) = 0; virtual void coeff(int, char **) = 0; @@ -207,10 +217,6 @@ class Pair : protected Pointers { typedef union {int i; float f;} union_int_float_t; - // Accessor for the user-intel package to determine virial calc for hybrid - - inline int fdotr_is_set() const { return vflag_fdotr; } - protected: int vflag_fdotr; int maxeatom,maxvatom; diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 17c789bcee..4cf8d6d3db 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -326,9 +326,9 @@ void PairLJSmoothLinear::read_restart_settings(FILE *fp) /* ---------------------------------------------------------------------- */ -double PairLJSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, +double PairLJSmoothLinear::single(int i, int j, int itype, int jtype, double rsq, - double /*factor_coul*/, double factor_lj, + double factor_coul, double factor_lj, double &fforce) { double r2inv,r6inv,forcelj,philj,r,rinv; @@ -347,3 +347,26 @@ double PairLJSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, return factor_lj*philj; } + +double PairLJSmoothLinear::single2(int i, int j, int itype, int jtype, double rsq, + double delr[3], double factor_coul, double factor_lj, + double &fforce, double d2u[6]) +{ + double r2inv,r6inv,forcelj,philj,r,rinv; + + r2inv = 1.0/rsq; + r6inv = r2inv*r2inv*r2inv; + rinv = sqrt(r2inv); + r = sqrt(rsq); + forcelj = r6inv*(lj1[itype][jtype]*r6inv-lj2[itype][jtype]); + forcelj = rinv*forcelj - dljcut[itype][jtype]; + fforce = factor_lj*forcelj*rinv; + + philj = r6inv*(lj3[itype][jtype]*r6inv-lj4[itype][jtype]); + philj = philj - ljcut[itype][jtype] + + (r-cut[itype][jtype])*dljcut[itype][jtype]; + + double d2r = factor_lj * r6inv * (13.0*lj1[itype][jtype]*r6inv - 7.0*lj2[itype][jtype])/rsq; + pairTensor(fforce, -(fforce + d2r) / rsq, delr, d2u); + return factor_lj*philj; +} diff --git a/src/pair_lj_smooth_linear.h b/src/pair_lj_smooth_linear.h index c18c442a18..9cee9f2951 100644 --- a/src/pair_lj_smooth_linear.h +++ b/src/pair_lj_smooth_linear.h @@ -38,6 +38,7 @@ class PairLJSmoothLinear : public Pair { void write_restart_settings(FILE *); void read_restart_settings(FILE *); double single(int, int, int, int, double, double, double, double &); + double single2(int, int, int, int, double, double[3], double, double, double&, double[6]); protected: double cut_global; -- GitLab From 29cd4eb5b6584d62dfc331ad9e58343264334b62 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Thu, 8 Nov 2018 12:03:51 -0500 Subject: [PATCH 002/469] Add HMA compute --- doc/src/compute.txt | 71 +----- doc/src/compute_hma.txt | 147 +++++++++++++ doc/src/computes.txt | 9 +- src/compute_hma.cpp | 470 ++++++++++++++++++++++++++++++++++++++++ src/compute_hma.h | 66 ++++++ 5 files changed, 689 insertions(+), 74 deletions(-) create mode 100644 doc/src/compute_hma.txt create mode 100644 src/compute_hma.cpp create mode 100644 src/compute_hma.h diff --git a/doc/src/compute.txt b/doc/src/compute.txt index 857795ffe5..676c00d7a5 100644 --- a/doc/src/compute.txt +++ b/doc/src/compute.txt @@ -173,65 +173,43 @@ There are also additional accelerated compute styles included in the LAMMPS distribution for faster performance on CPUs, GPUs, and KNLs. The individual style names on the "Commands compute"_Commands_compute.html doc page are followed by one or more of -(g,i,k,o,t) to indicate which accelerated styles exist. +(g,i,k,o,t) to indicate which accerlerated styles exist. -"ackland/atom"_compute_ackland_atom.html - "aggregate/atom"_compute_cluster_atom.html - aggregate ID for each atom -"angle"_compute_angle.html - -"angle/local"_compute_angle_local.html - "angle/local"_compute_bond_local.html - theta and energy of each angle "angmom/chunk"_compute_angmom_chunk.html - angular momentum for each chunk -"basal/atom"_compute_basal_atom.html - "body/local"_compute_body_local.html - attributes of body sub-particles "bond"_compute_bond.html - values computed by a bond style "bond/local"_compute_bond_local.html - distance and energy of each bond "centro/atom"_compute_centro_atom.html - centro-symmetry parameter for each atom "chunk/atom"_compute_chunk_atom.html - assign chunk IDs to each atom -"chunk/spread/atom"_compute_chunk_spread_atom.html - spreads chunk values to each atom in chunk "cluster/atom"_compute_cluster_atom.html - cluster ID for each atom "cna/atom"_compute_cna_atom.html - common neighbor analysis (CNA) for each atom -"cnp/atom"_compute_cnp_atom.html - "com"_compute_com.html - center-of-mass of group of atoms "com/chunk"_compute_com_chunk.html - center-of-mass for each chunk "contact/atom"_compute_contact_atom.html - contact count for each spherical particle "coord/atom"_compute_coord_atom.html - coordination number for each atom "damage/atom"_compute_damage_atom.html - Peridynamic damage for each atom -"dihedral"_compute_dihedral.html - "dihedral/local"_compute_dihedral_local.html - angle of each dihedral "dilatation/atom"_compute_dilatation_atom.html - Peridynamic dilatation for each atom -"dipole/chunk"_compute_dipole_chunk.html - "displace/atom"_compute_displace_atom.html - displacement of each atom -"dpd"_compute_dpd.html - -"dpd/atom"_compute_dpd_atom.html - -"edpd/temp/atom"_compute_edpd_temp_atom.html - -"entropy/atom"_compute_entropy_atom.html - "erotate/asphere"_compute_erotate_asphere.html - rotational energy of aspherical particles "erotate/rigid"_compute_erotate_rigid.html - rotational energy of rigid bodies "erotate/sphere"_compute_erotate_sphere.html - rotational energy of spherical particles "erotate/sphere/atom"_compute_erotate_sphere.html - rotational energy for each spherical particle -"erotate/sphere/atom"_compute_erotate_sphere_atom.html - "event/displace"_compute_event_displace.html - detect event on atom displacement -"fep"_compute_fep.html - -"force/tally"_compute_tally.html - "fragment/atom"_compute_cluster_atom.html - fragment ID for each atom -"global/atom"_compute_global_atom.html - "group/group"_compute_group_group.html - energy/force between two groups of atoms "gyration"_compute_gyration.html - radius of gyration of group of atoms "gyration/chunk"_compute_gyration_chunk.html - radius of gyration for each chunk "heat/flux"_compute_heat_flux.html - heat flux through a group of atoms -"heat/flux/tally"_compute_tally.html - "hexorder/atom"_compute_hexorder_atom.html - bond orientational order parameter q6 -"improper"_compute_improper.html - +"hma"_compute_hma.html - harmonically mapped averaging for atomic crystals "improper/local"_compute_improper_local.html - angle of each improper "inertia/chunk"_compute_inertia_chunk.html - inertia tensor for each chunk "ke"_compute_ke.html - translational kinetic energy "ke/atom"_compute_ke_atom.html - kinetic energy for each atom -"ke/atom/eff"_compute_ke_atom_eff.html - -"ke/eff"_compute_ke_eff.html - "ke/rigid"_compute_ke_rigid.html - translational kinetic energy of rigid bodies -"meso/e/atom"_compute_meso_e_atom.html - -"meso/rho/atom"_compute_meso_rho_atom.html - -"meso/t/atom"_compute_meso_t_atom.html - "msd"_compute_msd.html - mean-squared displacement of group of atoms "msd/chunk"_compute_msd_chunk.html - mean-squared displacement for each chunk "msd/nongauss"_compute_msd_nongauss.html - MSD and non-Gaussian parameter of group of atoms @@ -241,77 +219,36 @@ compute"_Commands_compute.html doc page are followed by one or more of "pair/local"_compute_pair_local.html - distance/energy/force of each pairwise interaction "pe"_compute_pe.html - potential energy "pe/atom"_compute_pe_atom.html - potential energy for each atom -"pe/mol/tally"_compute_tally.html - -"pe/tally"_compute_tally.html - "plasticity/atom"_compute_plasticity_atom.html - Peridynamic plasticity for each atom "pressure"_compute_pressure.html - total pressure and pressure tensor -"pressure/cylinder"_compute_pressure_cylinder.html - -"pressure/uef"_compute_pressure_uef.html - "property/atom"_compute_property_atom.html - convert atom attributes to per-atom vectors/arrays -"property/chunk"_compute_property_chunk.html - extract various per-chunk attributes "property/local"_compute_property_local.html - convert local attributes to localvectors/arrays -"ptm/atom"_compute_ptm_atom.html - +"property/chunk"_compute_property_chunk.html - extract various per-chunk attributes "rdf"_compute_rdf.html - radial distribution function g(r) histogram of group of atoms "reduce"_compute_reduce.html - combine per-atom quantities into a single global value -"reduce/chunk"_compute_reduce_chunk.html - reduce per-atom quantities within each chunk "reduce/region"_compute_reduce.html - same as compute reduce, within a region "rigid/local"_compute_rigid_local.html - extract rigid body attributes -"saed"_compute_saed.html - "slice"_compute_slice.html - extract values from global vector or array -"smd/contact/radius"_compute_smd_contact_radius.html - -"smd/damage"_compute_smd_damage.html - -"smd/hourglass/error"_compute_smd_hourglass_error.html - -"smd/internal/energy"_compute_smd_internal_energy.html - -"smd/plastic/strain"_compute_smd_plastic_strain.html - -"smd/plastic/strain/rate"_compute_smd_plastic_strain_rate.html - -"smd/rho"_compute_smd_rho.html - -"smd/tlsph/defgrad"_compute_smd_tlsph_defgrad.html - -"smd/tlsph/dt"_compute_smd_tlsph_dt.html - -"smd/tlsph/num/neighs"_compute_smd_tlsph_num_neighs.html - -"smd/tlsph/shape"_compute_smd_tlsph_shape.html - -"smd/tlsph/strain"_compute_smd_tlsph_strain.html - -"smd/tlsph/strain/rate"_compute_smd_tlsph_strain_rate.html - -"smd/tlsph/stress"_compute_smd_tlsph_stress.html - -"smd/triangle/vertices"_compute_smd_triangle_vertices.html - -"smd/triangle/vertices"_compute_smd_triangle_vertices.html - -"smd/ulsph/num/neighs"_compute_smd_ulsph_num_neighs.html - -"smd/ulsph/strain"_compute_smd_ulsph_strain.html - -"smd/ulsph/strain/rate"_compute_smd_ulsph_strain_rate.html - -"smd/ulsph/stress"_compute_smd_ulsph_stress.html - -"smd/vol"_compute_smd_vol.html - "sna/atom"_compute_sna_atom.html - calculate bispectrum coefficients for each atom "snad/atom"_compute_sna_atom.html - derivative of bispectrum coefficients for each atom "snav/atom"_compute_sna_atom.html - virial contribution from bispectrum coefficients for each atom -"spin"_compute_spin.html - "stress/atom"_compute_stress_atom.html - stress tensor for each atom -"stress/mop"_compute_stress_mop.html - -"stress/mop/profile"_compute_stress_mop.html - -"stress/tally"_compute_tally.html - -"tdpd/cc/atom"_compute_tdpd_cc_atom.html - "temp"_compute_temp.html - temperature of group of atoms "temp/asphere"_compute_temp_asphere.html - temperature of aspherical particles "temp/body"_compute_temp_body.html - temperature of body particles "temp/chunk"_compute_temp_chunk.html - temperature of each chunk "temp/com"_compute_temp_com.html - temperature after subtracting center-of-mass velocity -"temp/cs"_compute_temp_cs.html - "temp/deform"_compute_temp_deform.html - temperature excluding box deformation velocity -"temp/deform/eff"_compute_temp_deform_eff.html - -"temp/drude"_compute_temp_drude.html - -"temp/eff"_compute_temp_eff.html - "temp/partial"_compute_temp_partial.html - temperature excluding one or more dimensions of velocity "temp/profile"_compute_temp_profile.html - temperature excluding a binned velocity profile "temp/ramp"_compute_temp_ramp.html - temperature excluding ramped velocity component "temp/region"_compute_temp_region.html - temperature of a region of atoms -"temp/region/eff"_compute_temp_region_eff.html - -"temp/rotate"_compute_temp_rotate.html - "temp/sphere"_compute_temp_sphere.html - temperature of spherical particles -"temp/uef"_compute_temp_uef.html - "ti"_compute_ti.html - thermodynamic integration free energy values "torque/chunk"_compute_torque_chunk.html - torque applied on each chunk "vacf"_compute_vacf.html - velocity-autocorrelation function of group of atoms "vcm/chunk"_compute_vcm_chunk.html - velocity of center-of-mass for each chunk -"voronoi/atom"_compute_voronoi_atom.html - Voronoi volume and neighbors for each atom -"xrd"_compute_xrd.html - :ul +"voronoi/atom"_compute_voronoi_atom.html - Voronoi volume and neighbors for each atom :ul [Restrictions:] none diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt new file mode 100644 index 0000000000..f71ddc9e2e --- /dev/null +++ b/doc/src/compute_hma.txt @@ -0,0 +1,147 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Section_commands.html#comm) + +:line + +compute hma command :h3 + +[Syntax:] + +compute ID group-ID hma temp-ID keyword ... :pre + +ID, group-ID are documented in "compute"_compute.html command :l +hma = style name of this compute command :l +temp-ID = ID of fix that specifies the set temperature during canonical simulation :l +keyword = {anharmonic} {u} {p Pharm} {cv} :l + {anharmonic} = compute will return anharmonic property values + {u} = compute will return potential energy + {p} = compute will return pressure. the following keyword must be the difference between the harmonic pressure and lattice pressure as described below + {cv} = compute will return the heat capacity :pre +:ule + +[Examples:] + +compute 2 all hma 1 u +compute 2 all hma 1 anharmonic u p 0.9 +compute 2 all hma 1 u cv :pre + + + +[Description:] + +Define a computation that calculates the properties of a solid (potential +energy, pressure or heat capacity), using the harmonically-mapped averaging +(HMA) method. +This command yields much higher precision than the equivalent compute commands +("compute pe"_compute_pe.html, "compute pressure"_compute_pressure.html, etc.) +commands during a canonical simulation of an atomic crystal. + + +In this method, the analytically known harmonic behavior of a crystal is removed from the traditional ensemble +averages, which leads to an accurate and precise measurement of the anharmonic contributions without contamination +by noise produced by the already-known harmonic behavior. +A detailed description of this method can be found in ("Moustafa"_#hma-Moustafa). The potential energy is computed by the formula: + +\begin\{equation\} +\left< U\right>_\{HMA\} = \frac\{d(N-1)\}\{2\beta\} + \left< U + \frac\{1\}\{2\} F\bullet\Delta r \right> +\end\{equation\} + +where \(N\) is the number of atoms in the system, \(\beta\) is the reciprocal of the thermodynamic temperature, \(d\) is the +dimensionality of the system (2 or 3 for 2d/3d), \(F\bullet\Delta r\) is the sum of dot products of the +atomic force vectors and displacement (from lattice sites) vectors, and \(U\) is the sum of +pair, bond, angle, dihedral, improper, kspace (long-range), and fix energies. + +The pressure is computed by the formula: + +\begin\{equation\} +\left< P\right>_\{HMA\} = \Delta \hat P + \left< P_\{vir\} + \frac\{\beta \Delta \hat P - \rho\}\{d(N-1)\} F\bullet\Delta r \right> +\end\{equation\} + +where \(\rho\) is the number density of the system, \(\Delta \hat P\) is the +difference between theh harmonic and lattice pressure, and \(P_\{vir\}\) is +the virial pressure computed as the sum of pair, bond, angle, dihedral, +improper, kspace (long-range), and fix contributions to the force on each +atom. Although the method will work for any value of \(\Delta \hat P\) +specified (use pressure "units"_units.html), the precision of the resultant +pressure is sensitive to \(\Delta \hat P\); the precision tends to be +best when \(\Delta \hat P\) is the actual the difference between the lattice +pressure and harmonic pressure. + +\begin\{equation\} +\left_\{HMA\} = \frac\{d k_B (N-1)\}\{2\} + \beta \left( \left< +U_\{HMA\}^2 \right> - \left^2 \right)/T + \frac\{1\}\{4 T\} +\left< F\bullet\Delta r + \Delta r \bullet \Phi \bullet \Delta r \right> +\end\{equation\} + +where \(\Phi\) is the Hessian of second derivatives. The compute hma command +computes the full expression for \(C_V\) except for the +\(\left^2\) in the variance term, which can be obtained by +passing the {u} keyword; you must add this extra contribution to the \(C_V\) +value reported by this compute. The variance term can cause significant +roundoff error when computing \(C_V\). To address this, the {anharmonic} +keyword can be passed and/or the output format can be speicified with more +digits. + +thermo_modify format float '%22.15e' :pre + +The {anharmonic} keyword will instruct the compute to return anharmonic +properties rather than the full properties (lattice, harmonic and anharmonic). +When using this keyword, the compute must be first active (it must be included +via a "thermo_style custom"_thermo_style.html command) while the atoms are +still at their lattice sites (before equilibration). + +The temp-ID specified with compute hma command should be same as the fix-ID of Nose-Hoover ("fix nvt"_fix_nh.html) or +Berendsen ("fix temp/berendsen"_fix_temp_berendsen.html) thermostat used for the simulation. While using this command, Langevin thermostat +("fix langevin"_fix_langevin.html) +should be avoided as its extra forces interfere with the HMA implementation. + + + +NOTE: Compute hma command should be used right after the energy minimization, when the atoms are at their lattice sites. +The simulation should not be started before this command has been used in the input script. + + +The following example illustrates the placement of this command in the input script: + + +min_style cg +minimize 1e-35 1e-15 50000 500000 +compute 1 all hma thermostatid u +fix thermostatid all nvt temp 600.0 600.0 100.0 :pre + + + +NOTE: Compute hma should be used when the atoms of the solid do not diffuse. Diffusion will reduce the precision in the potential energy computation. + + +NOTE: The "fix_modify energy yes"_fix_modify.html command must also be specified if a fix is to contribute potential energy to this command. + +:line + +[Output info:] + +This compute calculates a global vector that includes the n properties +requested as arguments to the command (the potential energy, pressure or heat +capacity). The elements of the vector can be accessed by indices 1-n by any +command that uses global vector values as input. See the "Howto +output"_Howto_output.html doc page for an overview of LAMMPS output options. + +The vector values calculated by this compute are "extensive". The +scalar value will be in energy "units"_units.html. + +[Restrictions:] Usage restricted to canonical (NVT) ensemble simulation only. + +[Related commands:] + +"compute pe"_compute_pe.html, "compute pressure"_compute_pressure.html + +[Default:] none + +:line + +:link(hma-Moustafa) +[(Moustafa)] Sabry G. Moustafa, Andrew J. Schultz, and David A. Kofke, {Very fast averaging of thermal properties of crystals by molecular simulation}, +"Phys. Rev. E \[92\], 043303 (2015)"_https://link.aps.org/doi/10.1103/PhysRevE.92.043303 diff --git a/doc/src/computes.txt b/doc/src/computes.txt index 926b8da222..c636633b38 100644 --- a/doc/src/computes.txt +++ b/doc/src/computes.txt @@ -6,7 +6,6 @@ Computes :h1 :maxdepth: 1 compute_ackland_atom - compute_adf compute_angle compute_angle_local compute_angmom_chunk @@ -16,7 +15,6 @@ Computes :h1 compute_bond_local compute_centro_atom compute_chunk_atom - compute_chunk_spread_atom compute_cluster_atom compute_cna_atom compute_cnp_atom @@ -46,6 +44,7 @@ Computes :h1 compute_gyration_chunk compute_heat_flux compute_hexorder_atom + compute_hma compute_improper compute_improper_local compute_inertia_chunk @@ -68,15 +67,12 @@ Computes :h1 compute_pe_atom compute_plasticity_atom compute_pressure - compute_pressure_cylinder compute_pressure_uef compute_property_atom compute_property_chunk compute_property_local - compute_ptm_atom compute_rdf compute_reduce - compute_reduce_chunk compute_rigid_local compute_saed compute_slice @@ -94,7 +90,7 @@ Computes :h1 compute_smd_tlsph_strain compute_smd_tlsph_strain_rate compute_smd_tlsph_stress - compute_smd_triangle_vertices + compute_smd_triangle_mesh_vertices compute_smd_ulsph_num_neighs compute_smd_ulsph_strain compute_smd_ulsph_strain_rate @@ -103,7 +99,6 @@ Computes :h1 compute_sna_atom compute_spin compute_stress_atom - compute_stress_mop compute_tally compute_tdpd_cc_atom compute_temp diff --git a/src/compute_hma.cpp b/src/compute_hma.cpp new file mode 100644 index 0000000000..ac976080ce --- /dev/null +++ b/src/compute_hma.cpp @@ -0,0 +1,470 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include +#include +#include +#include "compute_hma.h" +#include "atom.h" +#include "update.h" +#include "force.h" +#include "pair.h" +#include "bond.h" +#include "angle.h" +#include "dihedral.h" +#include "improper.h" +#include "kspace.h" +#include "group.h" +#include "domain.h" +#include "modify.h" +#include "fix.h" +#include "fix_store.h" +#include "memory.h" +#include "error.h" +#include "comm.h" +#include "neighbor.h" +#include "neigh_request.h" +#include "neigh_list.h" + +#include + + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), id_temp(NULL), deltaR(NULL) +{ + if (narg < 4) error->all(FLERR,"Illegal compute hma command"); + if (igroup) error->all(FLERR,"Compute hma must use group all"); + if (strcmp(arg[3],"NULL") == 0) {error->all(FLERR,"fix ID specifying the set temperature of canonical simulation is required");} + else { + int n = strlen(arg[3]) + 1; + id_temp = new char[n]; + strcpy(id_temp,arg[3]); + } + + create_attribute = 1; + extscalar = 1; + timeflag = 1; + +// (from compute displace/atom) create a new fix STORE style +// our new fix's id (id_fix)= compute-ID + COMPUTE_STORE +// our new fix's group = same as compute group + + int n = strlen(id) + strlen("_COMPUTE_STORE") + 1; + id_fix = new char[n]; + strcpy(id_fix,id); + strcat(id_fix,"_COMPUTE_STORE"); + + char **newarg = new char*[6]; + newarg[0] = id_fix; + newarg[1] = group->names[igroup]; + newarg[2] = (char *) "STORE"; + newarg[3] = (char *) "peratom"; + newarg[4] = (char *) "1"; + newarg[5] = (char *) "3"; + modify->add_fix(6,newarg); + fix = (FixStore *) modify->fix[modify->nfix-1]; + + delete [] newarg; + + // calculate xu,yu,zu for fix store array + // skip if reset from restart file + + if (fix->restart_reset) fix->restart_reset = 0; + else { + double **xoriginal = fix->astore; + double **x = atom->x; + imageint *image = atom->image; + int nlocal = atom->nlocal; + + for (int i = 0; i < nlocal; i++) + domain->unmap(x[i],image[i],xoriginal[i]); + } + + vector_flag = 1; + extvector = -1; + comm_forward = 0; // 3 if 2nd derivative needed + + computeU = computeP = computeCv = -1; + returnAnharmonic = 0; + std::vector extvec; + for (int iarg=4; iarg narg) error->all(FLERR,"Illegal fix hma command"); + computeP = extvec.size(); + deltaPcap = force->numeric(FLERR, arg[iarg+1]); + extvec.push_back(0); + iarg++; + } + else if (!strcasecmp(arg[iarg], "cv")) { + computeCv = extvec.size(); + comm_forward = 3; + extvec.push_back(1); + } + else if (!strcasecmp(arg[iarg], "anharmonic")) { + returnAnharmonic = -1; + } + else { + error->all(FLERR,"Illegal fix hma command"); + } + } + + if (extvec.size() == 0) { + error->all(FLERR,"Illegal fix hma command"); + } + size_vector = extvec.size(); + memory->create(vector, size_vector, "hma::vector"); + extlist = new int[size_vector]; + for (int i=0; i-1 || computeCv>-1) { + peflag = 1; + } + if (computeP>-1) { + pressflag = 1; + } + + nmax = 0; +} + +/* ---------------------------------------------------------------------- */ + +ComputeHMA::~ComputeHMA() +{ + // check nfix in case all fixes have already been deleted + if (modify->nfix) modify->delete_fix(id_fix); + + delete [] id_fix; + delete [] id_temp; + delete [] extlist; + memory->destroy(vector); + memory->destroy(deltaR); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeHMA::init() { + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->compute = 1; + neighbor->requests[irequest]->occasional = 1; +} + +void ComputeHMA::init_list(int id, NeighList *ptr) { + list = ptr; +} + +void ComputeHMA::setup() +{ + int dummy=0; + int ifix = modify->find_fix(id_temp); + if (ifix < 0) error->all(FLERR,"Could not find compute hma temperature ID"); + double * temperat = (double *) modify->fix[ifix]->extract("t_target",dummy); + if (temperat==NULL) error->all(FLERR,"Could not find compute hma temperature ID"); + finaltemp = * temperat; + + + // set fix which stores original atom coords + + int ifix2 = modify->find_fix(id_fix); + if (ifix2 < 0) error->all(FLERR,"Could not find compute hma ID"); + fix = (FixStore *) modify->fix[ifix2]; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeHMA::compute_vector() +{ + invoked_vector = update->ntimestep; + +// dx,dy,dz = displacement of atom from original position + // original unwrapped position is stored by fix + // for triclinic, need to unwrap current atom coord via h matrix + + // grow deltaR array if necessary + + if (comm_forward>0 && atom->nmax > nmax) { + memory->destroy(deltaR); + nmax = atom->nmax; + memory->create(deltaR,nmax,3,"hma:deltaR"); + } + + double **xoriginal = fix->astore; + double fdr = 0.0; + double **x = atom->x; + double **f = atom->f; + + imageint *image = atom->image; + int nlocal = atom->nlocal; + + double *h = domain->h; + double xprd = domain->xprd; + double yprd = domain->yprd; + double zprd = domain->zprd; + + double u = 0.0; + if (computeU>-1 || computeCv>-1) { + if (force->pair) u += force->pair->eng_vdwl + force->pair->eng_coul; + if (force->bond) u += force->bond->energy; + if (force->angle) u += force->angle->energy; + if (force->dihedral) u += force->dihedral->energy; + if (force->improper) u += force->improper->energy; + } + + int dimension = domain->dimension; + double p = 0, vol = 0; + if (computeP>-1) { + p = virial_compute(dimension); + vol = xprd * yprd; + if (dimension == 3) vol *= zprd; + p *= force->nktv2p / (dimension*vol); + if (returnAnharmonic == -1) { + pLat = p; + } + } + + if (domain->triclinic == 0) { + for (int i = 0; i < nlocal; i++) { + int xbox = (image[i] & IMGMASK) - IMGMAX; + int ybox = (image[i] >> IMGBITS & IMGMASK) - IMGMAX; + int zbox = (image[i] >> IMG2BITS) - IMGMAX; + double dx = x[i][0] + xbox*xprd - xoriginal[i][0]; + double dy = x[i][1] + ybox*yprd - xoriginal[i][1]; + double dz = x[i][2] + zbox*zprd - xoriginal[i][2]; + if (comm_forward>0) { + deltaR[i][0] = dx; + deltaR[i][1] = dy; + deltaR[i][2] = dz; + } + fdr += dx*f[i][0] + dy*f[i][1] + dz*f[i][2]; + } + } + else { + for (int i = 0; i < nlocal; i++) { + int xbox = (image[i] & IMGMASK) - IMGMAX; + int ybox = (image[i] >> IMGBITS & IMGMASK) - IMGMAX; + int zbox = (image[i] >> IMG2BITS) - IMGMAX; + double dx = x[i][0] + h[0]*xbox + h[5]*ybox + h[4]*zbox - xoriginal[i][0]; + double dy = x[i][1] + h[1]*ybox + h[3]*zbox - xoriginal[i][1]; + double dz = x[i][2] + h[2]*zbox - xoriginal[i][2]; + if (comm_forward>0) { + deltaR[i][0] = dx; + deltaR[i][1] = dy; + deltaR[i][2] = dz; + } + fdr += ((dx*f[i][0])+(dy*f[i][1])+(dz*f[i][2])); + } + } + + double phiSum = 0.0; + if (computeCv>-1) { + comm->forward_comm_compute(this); + int *type = atom->type; + double** cutsq = force->pair->cutsq; + if (force->pair) { + double **x = atom->x; + double **f = atom->f; + int *type = atom->type; + int nlocal = atom->nlocal; + double *special_lj = force->special_lj; + double *special_coul = force->special_coul; + int newton_pair = force->newton_pair; + + if (update->firststep == update->ntimestep) neighbor->build_one(list,1); + else neighbor->build_one(list); + int inum = list->inum; + int *ilist = list->ilist; + int *numneigh = list->numneigh; + int **firstneigh = list->firstneigh; + + for (int ii = 0; ii < inum; ii++) { + int i = ilist[ii]; + double fac = (newton_pair || i < nlocal) ? 1.0 : 0.5; + double* ix = x[i]; + int itype = type[i]; + int *jlist = firstneigh[i]; + int jnum = numneigh[i]; + double *idr = deltaR[i]; + for (int jj = 0; jj < jnum; jj++) { + int j = jlist[jj]; + if (!newton_pair && j>=nlocal) fac -= 0.5; + double factor_lj = special_lj[sbmask(j)]; + double factor_coul = special_coul[sbmask(j)]; + j &= NEIGHMASK; + double* jx = x[j]; + double delr[3]; + delr[0] = ix[0] - jx[0]; + delr[1] = ix[1] - jx[1]; + delr[2] = ix[2] - jx[2]; + double rsq = delr[0]*delr[0] + delr[1]*delr[1] + delr[2]*delr[2]; + int jtype = type[j]; + if (rsq < cutsq[itype][jtype]) { + double* jdr = deltaR[j]; + double fforce, d2u[6]; + force->pair->single2(i, j, itype, jtype, rsq, delr, factor_coul, factor_lj, fforce, d2u); + int m = 0; + for (int k=0; k<3; k++) { + double a = fac; + for (int l=k; l<3; l++) { + phiSum += a*(idr[k]*jdr[l]+jdr[k]*idr[l])*d2u[m]; + phiSum -= a*(idr[k]*idr[l]*d2u[m] + jdr[k]*jdr[l]*d2u[m]); + m++; + if (k==l) a *= 2; + } + } + } + } + } + } + } + +//adding PE for this processor + +//adding the energies of all processors + + double fdrTotal; + MPI_Allreduce(&fdr,&fdrTotal,1,MPI_DOUBLE,MPI_SUM,world); + double uTotal; + if (computeU>-1 || computeCv>-1) { + MPI_Allreduce(&u,&uTotal,1,MPI_DOUBLE,MPI_SUM,world); + if (returnAnharmonic == -1) { + uLat = uTotal; + } + if (computeU>-1) { + if (returnAnharmonic) { + vector[computeU] = uTotal - uLat + 0.5*fdrTotal; + } + else { + vector[computeU] = uTotal + 0.5*fdrTotal + 0.5*dimension*(atom->natoms - 1)*force->boltz*finaltemp; + } + } + } + + if (computeP>-1) { + double fv = ((deltaPcap)-(force->boltz*finaltemp*force->nktv2p*atom->natoms/vol))/(force->boltz*finaltemp*dimension*(atom->natoms - 1)); + if (returnAnharmonic) { + vector[computeP] = p - pLat + (fv*fdrTotal); + } + else { + vector[computeP] = p + (fv*fdrTotal) + deltaPcap; + } + } + + if (computeCv>-1) { + if (computeU==-1) MPI_Allreduce(&u,&uTotal,1,MPI_DOUBLE,MPI_SUM,world); + double buTot; + if (returnAnharmonic) { + buTot = (uTotal - uLat + 0.5*fdrTotal)/finaltemp; + } + else { + buTot = (uTotal + 0.5*fdrTotal)/finaltemp + 0.5*dimension*(atom->natoms - 1)*force->boltz; + } + double one = -0.25*(fdr + phiSum)/finaltemp; + double Cv; + MPI_Allreduce(&one,&Cv,1,MPI_DOUBLE,MPI_SUM,world); + vector[computeCv] = Cv + buTot*buTot; + if (!returnAnharmonic) { + vector[computeCv] += 0.5*dimension*(atom->natoms-1); + } + } + if (returnAnharmonic == -1) { + returnAnharmonic = 1; + } +} + +double ComputeHMA::virial_compute(int n) { + double v = 0; + + // sum contributions to virial from forces and fixes + + if (force->pair) v += sumVirial(n, force->pair->virial); + if (force->bond) v += sumVirial(n, force->bond->virial); + if (force->angle) v += sumVirial(n, force->angle->virial); + if (force->dihedral) v += sumVirial(n, force->dihedral->virial); + if (force->improper) v += sumVirial(n, force->improper->virial); + for (int i = 0; i < modify->nfix; i++) + if (modify->fix[i]->thermo_virial) v += sumVirial(n, modify->fix[i]->virial); + + // sum virial across procs + + double virial; + MPI_Allreduce(&v,&virial,1,MPI_DOUBLE,MPI_SUM,world); + + // KSpace virial contribution is already summed across procs + + if (force->kspace) + for (int i = 0; i < n; i++) virial += force->kspace->virial[i]; + return virial; +} + +/* ---------------------------------------------------------------------- */ + +int ComputeHMA::pack_forward_comm(int n, int *list, double *buf, + int pbc_flag, int *pbc) +{ + double **xoriginal = fix->astore; + imageint *image = atom->image; + double **x = atom->x; + double *h = domain->h; + double xprd = domain->xprd; + double yprd = domain->yprd; + double zprd = domain->zprd; + + int m = 0; + for (int ii = 0; ii < n; ii++) { + int i = list[ii]; + buf[m++] = deltaR[i][0]; + buf[m++] = deltaR[i][1]; + buf[m++] = deltaR[i][2]; + } + return m; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeHMA::unpack_forward_comm(int n, int first, double *buf) +{ + double **xoriginal = fix->astore; + int i,m,last; + + m = 0; + last = first + n; + for (i = first; i < last; i++) { + deltaR[i][0] = buf[m++]; + deltaR[i][1] = buf[m++]; + deltaR[i][2] = buf[m++]; + } +} + + +/* ---------------------------------------------------------------------- + initialize one atom's storage values, called when atom is created +------------------------------------------------------------------------- */ + +void ComputeHMA::set_arrays(int i) +{ + double **xoriginal = fix->astore; + double **x = atom->x; + xoriginal[i][0] = x[i][0]; + xoriginal[i][1] = x[i][1]; + xoriginal[i][2] = x[i][2]; +} diff --git a/src/compute_hma.h b/src/compute_hma.h new file mode 100644 index 0000000000..f40103c3c4 --- /dev/null +++ b/src/compute_hma.h @@ -0,0 +1,66 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS + +ComputeStyle(HMA,ComputeHMA) + +#else + +#ifndef LMP_COMPUTE_HMA_H +#define LMP_COMPUTE_HMA_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeHMA : public Compute { + public: + ComputeHMA(class LAMMPS *, int, char **); + ~ComputeHMA(); + void setup(); + void init(); + void init_list(int, class NeighList *); + void compute_vector(); + void set_arrays(int); + int pack_forward_comm(int, int *, double *, int, int *); + void unpack_forward_comm(int, int, double *); + + private: + int nmax; + int atomsingroup; + char *id_fix; + char *id_temp; + double finaltemp; + class FixStore *fix; + double boltz, nktv2p, inv_volume; + double deltaPcap; + double virial_compute(int); + static double sumVirial(int n, double* v) { + double x = 0; + for (int i=0; i Date: Fri, 9 Nov 2018 21:28:41 -0500 Subject: [PATCH 003/469] Cleanup, add memory_usage method --- src/compute_hma.cpp | 23 +++++++++++++---------- src/compute_hma.h | 1 + 2 files changed, 14 insertions(+), 10 deletions(-) diff --git a/src/compute_hma.cpp b/src/compute_hma.cpp index ac976080ce..c0a7901640 100644 --- a/src/compute_hma.cpp +++ b/src/compute_hma.cpp @@ -59,9 +59,9 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : extscalar = 1; timeflag = 1; -// (from compute displace/atom) create a new fix STORE style -// our new fix's id (id_fix)= compute-ID + COMPUTE_STORE -// our new fix's group = same as compute group + // (from compute displace/atom) create a new fix STORE style + // our new fix's id (id_fix)= compute-ID + COMPUTE_STORE + // our new fix's group = same as compute group int n = strlen(id) + strlen("_COMPUTE_STORE") + 1; id_fix = new char[n]; @@ -169,7 +169,8 @@ void ComputeHMA::init() { neighbor->requests[irequest]->occasional = 1; } -void ComputeHMA::init_list(int id, NeighList *ptr) { +void ComputeHMA::init_list(int id, NeighList *ptr) +{ list = ptr; } @@ -196,12 +197,7 @@ void ComputeHMA::compute_vector() { invoked_vector = update->ntimestep; -// dx,dy,dz = displacement of atom from original position - // original unwrapped position is stored by fix - // for triclinic, need to unwrap current atom coord via h matrix - // grow deltaR array if necessary - if (comm_forward>0 && atom->nmax > nmax) { memory->destroy(deltaR); nmax = atom->nmax; @@ -391,7 +387,8 @@ void ComputeHMA::compute_vector() } } -double ComputeHMA::virial_compute(int n) { +double ComputeHMA::virial_compute(int n) +{ double v = 0; // sum contributions to virial from forces and fixes @@ -468,3 +465,9 @@ void ComputeHMA::set_arrays(int i) xoriginal[i][1] = x[i][1]; xoriginal[i][2] = x[i][2]; } + +double ComputeHMA::memory_usage() +{ + double bytes = nmax * 3 * sizeof(double); + return bytes; +} diff --git a/src/compute_hma.h b/src/compute_hma.h index f40103c3c4..44906b53a1 100644 --- a/src/compute_hma.h +++ b/src/compute_hma.h @@ -35,6 +35,7 @@ class ComputeHMA : public Compute { void set_arrays(int); int pack_forward_comm(int, int *, double *, int, int *); void unpack_forward_comm(int, int, double *); + double memory_usage(); private: int nmax; -- GitLab From 101948ce1e2c0084b1b4e9774446e9e751a98132 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Thu, 21 Feb 2019 01:49:04 +0100 Subject: [PATCH 004/469] Added a Morse potential option to 'fix wall/region' --- src/fix_wall_region.cpp | 34 ++++++++++++++++++++++++++++++---- src/fix_wall_region.h | 2 ++ 2 files changed, 32 insertions(+), 4 deletions(-) diff --git a/src/fix_wall_region.cpp b/src/fix_wall_region.cpp index ff147d7446..2b16ec3bf4 100644 --- a/src/fix_wall_region.cpp +++ b/src/fix_wall_region.cpp @@ -31,7 +31,7 @@ using namespace LAMMPS_NS; using namespace FixConst; using namespace MathConst; -enum{LJ93,LJ126,LJ1043,COLLOID,HARMONIC}; +enum{LJ93,LJ126,LJ1043,MORSE,COLLOID,HARMONIC}; /* ---------------------------------------------------------------------- */ @@ -39,7 +39,7 @@ FixWallRegion::FixWallRegion(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), idregion(NULL) { - if (narg != 8) error->all(FLERR,"Illegal fix wall/region command"); + if (narg < 8) error->all(FLERR,"Illegal fix wall/region command"); scalar_flag = 1; vector_flag = 1; @@ -63,6 +63,7 @@ FixWallRegion::FixWallRegion(LAMMPS *lmp, int narg, char **arg) : if (strcmp(arg[4],"lj93") == 0) style = LJ93; else if (strcmp(arg[4],"lj126") == 0) style = LJ126; else if (strcmp(arg[4],"lj1043") == 0) style = LJ1043; + else if (strcmp(arg[4],"morse") == 0) style = MORSE; else if (strcmp(arg[4],"colloid") == 0) style = COLLOID; else if (strcmp(arg[4],"harmonic") == 0) style = HARMONIC; else error->all(FLERR,"Illegal fix wall/region command"); @@ -73,6 +74,14 @@ FixWallRegion::FixWallRegion(LAMMPS *lmp, int narg, char **arg) : sigma = force->numeric(FLERR,arg[6]); cutoff = force->numeric(FLERR,arg[7]); + if (style == MORSE) { + if (narg != 9) + error->all(FLERR,"Illegal fix wall/region command"); + else + alpha = force->numeric(FLERR,arg[8]); + } else if (narg != 8) + error->all(FLERR,"Illegal fix wall/region command"); + if (cutoff <= 0.0) error->all(FLERR,"Fix wall/region cutoff <= 0.0"); eflag = 0; @@ -157,12 +166,15 @@ void FixWallRegion::init() coeff5 = coeff1 * 10.0; coeff6 = coeff2 * 4.0; coeff7 = coeff3 * 3.0; - double rinv = 1.0/cutoff; double r2inv = rinv*rinv; double r4inv = r2inv*r2inv; offset = coeff1*r4inv*r4inv*r2inv - coeff2*r4inv - coeff3*pow(cutoff+coeff4,-3.0); + } else if (style == MORSE) { + coeff1 = 2 * epsilon * alpha; + double alpha_dr = -alpha * (cutoff - sigma); + offset = epsilon * (exp(2.0*alpha_dr) - 2.0*exp(alpha_dr)); } else if (style == COLLOID) { coeff1 = -4.0/315.0 * epsilon * pow(sigma,6.0); coeff2 = -2.0/3.0 * epsilon; @@ -253,6 +265,7 @@ void FixWallRegion::post_force(int vflag) if (style == LJ93) lj93(region->contact[m].r); else if (style == LJ126) lj126(region->contact[m].r); else if (style == LJ1043) lj1043(region->contact[m].r); + else if (style == MORSE) morse(region->contact[m].r); else if (style == COLLOID) colloid(region->contact[m].r,radius[i]); else harmonic(region->contact[m].r); @@ -287,7 +300,7 @@ void FixWallRegion::post_force(int vflag) /* ---------------------------------------------------------------------- */ -void FixWallRegion::post_force_respa(int vflag, int ilevel, int /*iloop*/) +void FixWallRegion::post_force_respa(int vflag, int ilevel, int iloop) { if (ilevel == ilevel_respa) post_force(vflag); } @@ -375,6 +388,19 @@ void FixWallRegion::lj1043(double r) coeff3*pow(r+coeff4,-3.0) - offset; } +/* ---------------------------------------------------------------------- + Morse interaction for particle with wall + compute eng and fwall = magnitude of wall force +------------------------------------------------------------------------- */ + +void FixWallRegion::morse(double r) +{ + double dr = r - sigma; + double dexp = exp(-alpha * dr); + fwall = coeff1 * (dexp*dexp - dexp) / r; + eng = epsilon * (dexp*dexp - 2.0*dexp) - offset; +} + /* ---------------------------------------------------------------------- colloid interaction for finite-size particle of rad with wall compute eng and fwall = magnitude of wall force diff --git a/src/fix_wall_region.h b/src/fix_wall_region.h index e3688c99ee..663a12b257 100644 --- a/src/fix_wall_region.h +++ b/src/fix_wall_region.h @@ -41,6 +41,7 @@ class FixWallRegion : public Fix { private: int style,iregion; double epsilon,sigma,cutoff; + double alpha; int eflag; double ewall[4],ewall_all[4]; int ilevel_respa; @@ -53,6 +54,7 @@ class FixWallRegion : public Fix { void lj93(double); void lj126(double); void lj1043(double); + void morse(double); void colloid(double, double); void harmonic(double); }; -- GitLab From 4ea7d733e8eab688c29948d45e61536f367b4ee2 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Thu, 21 Feb 2019 02:17:19 +0100 Subject: [PATCH 005/469] Initial commit... --- src/USER-MISC/pair_cosine_squared.cpp | 473 ++++++++++++++++++++++++++ src/USER-MISC/pair_cosine_squared.h | 95 ++++++ 2 files changed, 568 insertions(+) create mode 100644 src/USER-MISC/pair_cosine_squared.cpp create mode 100644 src/USER-MISC/pair_cosine_squared.h diff --git a/src/USER-MISC/pair_cosine_squared.cpp b/src/USER-MISC/pair_cosine_squared.cpp new file mode 100644 index 0000000000..db3d8a6aa7 --- /dev/null +++ b/src/USER-MISC/pair_cosine_squared.cpp @@ -0,0 +1,473 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + Contributing authors: Eugen Rozic (University College London) +------------------------------------------------------------------------- */ + +#include +#include +#include +#include +#include "pair_cosine_squared.h" +#include "atom.h" +#include "comm.h" +#include "force.h" +#include "neighbor.h" +#include "neigh_list.h" +#include "neigh_request.h" +#include "update.h" +#include "integrate.h" +#include "respa.h" +#include "math_const.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +/* ---------------------------------------------------------------------- */ + +PairCosineSquared::PairCosineSquared(LAMMPS *lmp) : Pair(lmp) +{ + writedata = 1; +} + +/* ---------------------------------------------------------------------- */ + +PairCosineSquared::~PairCosineSquared() +{ + if (allocated) { + memory->destroy(setflag); + memory->destroy(cutsq); + + memory->destroy(epsilon); + memory->destroy(sigma); + memory->destroy(w); + memory->destroy(cut); + memory->destroy(wcaflag); + + memory->destroy(lj12_e); + memory->destroy(lj6_e); + memory->destroy(lj12_f); + memory->destroy(lj6_f); + } +} + +/* ---------------------------------------------------------------------- + allocate all arrays +------------------------------------------------------------------------- */ + +void PairCosineSquared::allocate() +{ + allocated = 1; + int n = atom->ntypes; + memory->create(setflag, n+1, n+1, "pair:setflag"); + memory->create(cutsq, n+1, n+1, "pair:cutsq"); + + memory->create(cut, n+1, n+1, "pair:cut"); + memory->create(epsilon, n+1, n+1, "pair:epsilon"); + memory->create(sigma, n+1, n+1, "pair:sigma"); + memory->create(w, n+1, n+1, "pair:w"); + memory->create(wcaflag, n+1, n+1, "pair:wcaflag"); + + memory->create(lj12_e, n+1, n+1, "pair:lj12_e"); + memory->create(lj6_e, n+1, n+1, "pair:lj6_e"); + memory->create(lj12_f, n+1, n+1, "pair:lj12_f"); + memory->create(lj6_f, n+1, n+1, "pair:lj6_f"); + + for (int i = 1; i <= n; i++) { + for (int j = i; j <= n; j++) { + setflag[i][j] = 0; + wcaflag[i][j] = 0; + } + } +} + +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ + +void PairCosineSquared::settings(int narg, char **arg) +{ + if (narg != 1) { + error->all(FLERR, "Illegal pair_style command (wrong number of params)"); + } + + cut_global = force->numeric(FLERR, arg[0]); + + // reset cutoffs that have been explicitly set + + if (allocated) { + int i, j; + for (i = 1; i <= atom->ntypes; i++) + for (j = i+1; j <= atom->ntypes; j++) + if (setflag[i][j]) + cut[i][j] = cut_global; + } +} + + +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ + +void PairCosineSquared::coeff(int narg, char **arg) +{ + if (narg < 4 || narg > 6) + error->all(FLERR, "Incorrect args for pair coefficients (too few or too many)"); + + if (!allocated) + allocate(); + + int ilo, ihi, jlo, jhi; + force->bounds(FLERR, arg[0], atom->ntypes, ilo, ihi); + force->bounds(FLERR, arg[1], atom->ntypes, jlo, jhi); + + double epsilon_one = force->numeric(FLERR, arg[2]); + double sigma_one = force->numeric(FLERR, arg[3]); + + double cut_one = cut_global; + double wca_one = 0; + if (narg == 6) { + cut_one = force->numeric(FLERR, arg[4]); + if (strcmp(arg[5], "wca") == 0) { + wca_one = 1; + } else { + error->all(FLERR, "Incorrect args for pair coefficients (unknown option)"); + } + } else if (narg == 5) { + if (strcmp(arg[4], "wca") == 0) { + wca_one = 1; + } else { + cut_one = force->numeric(FLERR, arg[4]); + } + } + + if (cut_one <= sigma_one) + error->all(FLERR, "Incorrect args for pair coefficients (cutoff <= sigma)"); + + int count = 0; + for (int i = ilo; i <= ihi; i++) { + for (int j = MAX(jlo,i); j <= jhi; j++) { + epsilon[i][j] = epsilon_one; + sigma[i][j] = sigma_one; + cut[i][j] = cut_one; + wcaflag[i][j] = wca_one; + setflag[i][j] = 1; + count++; + } + } + + if (count == 0) + error->all(FLERR, "Incorrect args for pair coefficients (none set)"); +} + +/* ---------------------------------------------------------------------- + init specific to this pair style (unneccesary) +------------------------------------------------------------------------- */ + +/* +void PairCosineSquared::init_style() +{ + neighbor->request(this,instance_me); +} +*/ + +/* ---------------------------------------------------------------------- + init for one type pair i,j and corresponding j,i +------------------------------------------------------------------------- */ + +double PairCosineSquared::init_one(int i, int j) +{ + if (setflag[i][j] == 0) + error->all(FLERR, "Mixing not supported in pair_style cosine/squared"); + + epsilon[j][i] = epsilon[i][j]; + sigma[j][i] = sigma[i][j]; + cut[j][i] = cut[i][j]; + wcaflag[j][i] = wcaflag[i][j]; + + w[j][i] = w[i][j] = cut[i][j] - sigma[i][j]; + + if (wcaflag[i][j]) { + lj12_e[j][i] = lj12_e[i][j] = epsilon[i][j] * pow(sigma[i][j], 12.0); + lj6_e[j][i] = lj6_e[i][j] = 2.0 * epsilon[i][j] * pow(sigma[i][j], 6.0); + lj12_f[j][i] = lj12_f[i][j] = 12.0 * epsilon[i][j] * pow(sigma[i][j], 12.0); + lj6_f[j][i] = lj6_f[i][j] = 12.0 * epsilon[i][j] * pow(sigma[i][j], 6.0); + } + + // Note: cutsq is set in pair.cpp + + return cut[i][j]; +} + +/* ---------------------------------------------------------------------- + this is here to throw errors & warnings for given options +------------------------------------------------------------------------- */ + +void PairCosineSquared::modify_params(int narg, char **arg) +{ + Pair::modify_params(narg, arg); + + int iarg = 0; + while (iarg < narg) { + if (strcmp(arg[iarg], "mix") == 0) { + error->all(FLERR, "pair_modify mix not supported for pair_style cosine/squared"); + } else if (strcmp(arg[iarg], "shift") == 0) { + error->warning(FLERR, "pair_modify shift is meaningless for pair_style cosine/squared"); + offset_flag = 0; + } else if (strcmp(arg[iarg], "tail") == 0) { + error->warning(FLERR, "pair_modify tail is meaningless for pair_style cosine/squared"); + tail_flag = 0; + } + iarg++; + } +} + +/* ---------------------------------------------------------------------- + proc 0 writes to restart file +------------------------------------------------------------------------- */ + +void PairCosineSquared::write_restart(FILE *fp) +{ + write_restart_settings(fp); + + int i, j; + for (i = 1; i <= atom->ntypes; i++) + for (j = i; j <= atom->ntypes; j++) { + fwrite(&setflag[i][j], sizeof(int), 1, fp); + if (setflag[i][j]) { + fwrite(&epsilon[i][j], sizeof(double), 1, fp); + fwrite(&sigma[i][j], sizeof(double), 1, fp); + fwrite(&cut[i][j], sizeof(double), 1, fp); + fwrite(&wcaflag[i][j], sizeof(int), 1, fp); + } + } +} + +/* ---------------------------------------------------------------------- + proc 0 reads from restart file, bcasts +------------------------------------------------------------------------- */ + +void PairCosineSquared::read_restart(FILE *fp) +{ + read_restart_settings(fp); + allocate(); + + int i,j; + int me = comm->me; + for (i = 1; i <= atom->ntypes; i++) { + for (j = i; j <= atom->ntypes; j++) { + if (me == 0) + fread(&setflag[i][j], sizeof(int), 1, fp); + MPI_Bcast(&setflag[i][j], 1, MPI_INT, 0, world); + if (setflag[i][j]) { + if (me == 0) { + fread(&epsilon[i][j], sizeof(double), 1, fp); + fread(&sigma[i][j], sizeof(double), 1, fp); + fread(&cut[i][j], sizeof(double), 1, fp); + fread(&wcaflag[i][j], sizeof(int), 1, fp); + } + MPI_Bcast(&epsilon[i][j], 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&sigma[i][j], 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&cut[i][j], 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&wcaflag[i][j], 1, MPI_INT, 0, world); + } + } + } +} + +/* ---------------------------------------------------------------------- + proc 0 writes to restart file +------------------------------------------------------------------------- */ + +void PairCosineSquared::write_restart_settings(FILE *fp) +{ + fwrite(&cut_global, sizeof(double), 1, fp); +} + +/* ---------------------------------------------------------------------- + proc 0 reads from restart file, bcasts +------------------------------------------------------------------------- */ + +void PairCosineSquared::read_restart_settings(FILE *fp) +{ + int me = comm->me; + if (me == 0) { + fread(&cut_global, sizeof(double), 1, fp); + } + MPI_Bcast(&cut_global, 1, MPI_DOUBLE, 0, world); +} + +/* ---------------------------------------------------------------------- + proc 0 writes to data file +------------------------------------------------------------------------- */ + +void PairCosineSquared::write_data(FILE *fp) +{ + for (int i = 1; i <= atom->ntypes; i++) + fprintf(fp, "%d %g %g %g %d\n", i, epsilon[i][i], sigma[i][i], + cut[i][i], wcaflag[i][i]); +} + +/* ---------------------------------------------------------------------- + proc 0 writes all pairs to data file +------------------------------------------------------------------------- */ + +void PairCosineSquared::write_data_all(FILE *fp) +{ + for (int i = 1; i <= atom->ntypes; i++) + for (int j = i; j <= atom->ntypes; j++) + fprintf(fp, "%d %d %g %g %g %d\n", i, j, epsilon[i][j], sigma[i][j], + cut[i][j], wcaflag[i][j]); +} + +/* ---------------------------------------------------------------------- */ + +void PairCosineSquared::compute(int eflag, int vflag) +{ + int i, j, ii, jj, inum, jnum, itype, jtype; + int *ilist, *jlist, *numneigh, **firstneigh; + double xtmp, ytmp, ztmp, delx, dely, delz, evdwl, fpair; + double r, rsq, r2inv, r6inv; + double factor_lj, force_lj, force_cos, cosone; + + evdwl = 0.0; + if (eflag || vflag) + ev_setup(eflag, vflag); + else + evflag = vflag_fdotr = 0; + + double **x = atom->x; + double **f = atom->f; + int *type = atom->type; + int nlocal = atom->nlocal; + double *special_lj = force->special_lj; + int newton_pair = force->newton_pair; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // loop over neighbors of my atoms + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + itype = type[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + factor_lj = special_lj[sbmask(j)]; + j &= NEIGHMASK; + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; + jtype = type[j]; + + if (rsq < cutsq[itype][jtype]) { + + /* + This is exactly what the "single" method does, in fact it could be called + here instead of repeating the code but here energy calculation is optional + so a little bit of calculation is possibly saved + */ + + r = sqrt(rsq); + + if (r <= sigma[itype][jtype]) { + if (wcaflag[itype][jtype]) { + r2inv = 1.0/rsq; + r6inv = r2inv*r2inv*r2inv; + force_lj = r6inv*(lj12_f[itype][jtype]*r6inv - lj6_f[itype][jtype]); + fpair = factor_lj*force_lj*r2inv; + if (eflag) { + evdwl = factor_lj*r6inv * + (lj12_e[itype][jtype]*r6inv - lj6_e[itype][jtype]); + } + } else { + fpair = 0.0; + if (eflag) { + evdwl = -factor_lj*epsilon[itype][jtype]; + } + } + } else { + force_cos = -(MY_PI*epsilon[itype][jtype] / (2.0*w[itype][jtype])) * + sin(MY_PI*(r-sigma[itype][jtype]) / w[itype][jtype]); + fpair = factor_lj*force_cos / r; + if (eflag) { + cosone = cos(MY_PI*(r-sigma[itype][jtype]) / (2.0*w[itype][jtype])); + evdwl = -factor_lj*epsilon[itype][jtype]*cosone*cosone; + } + } + + f[i][0] += delx*fpair; + f[i][1] += dely*fpair; + f[i][2] += delz*fpair; + + if (newton_pair || j < nlocal) { + f[j][0] -= delx*fpair; + f[j][1] -= dely*fpair; + f[j][2] -= delz*fpair; + } + + if (evflag) + ev_tally(i, j, nlocal, newton_pair, evdwl, 0.0, fpair, delx, dely, delz); + } + } + } + + if (vflag_fdotr) + virial_fdotr_compute(); +} + +/* ---------------------------------------------------------------------- + This is used be pair_write; + it is called only if rsq < cutsq[itype][jtype], no need to check that +------------------------------------------------------------------------- */ + +double PairCosineSquared::single(int i, int j, int itype, int jtype, double rsq, + double factor_coul, double factor_lj, + double &fforce) +{ + double r, r2inv, r6inv, cosone, force, energy; + + r = sqrt(rsq); + + if (r <= sigma[itype][jtype]) { + if (wcaflag[itype][jtype]) { + r2inv = 1.0/rsq; + r6inv = r2inv*r2inv*r2inv; + force = r6inv*(lj12_f[itype][jtype]*r6inv - lj6_f[itype][jtype])*r2inv; + energy = r6inv*(lj12_e[itype][jtype]*r6inv - lj6_e[itype][jtype]); + } else { + force = 0.0; + energy = -epsilon[itype][jtype]; + } + } else { + cosone = cos(MY_PI*(r-sigma[itype][jtype]) / (2.0*w[itype][jtype])); + force = -(MY_PI*epsilon[itype][jtype] / (2.0*w[itype][jtype])) * + sin(MY_PI*(r-sigma[itype][jtype]) / w[itype][jtype]) / r; + energy = -epsilon[itype][jtype]*cosone*cosone; + } + fforce = factor_lj*force; + return factor_lj*energy; +} + diff --git a/src/USER-MISC/pair_cosine_squared.h b/src/USER-MISC/pair_cosine_squared.h new file mode 100644 index 0000000000..8c294e0d36 --- /dev/null +++ b/src/USER-MISC/pair_cosine_squared.h @@ -0,0 +1,95 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + Contributing authors: Eugen Rozic (University College London) +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS + +PairStyle(cosine/squared, PairCosineSquared) + +#else + +#ifndef LMP_PAIR_LJ_COS_SQ_H +#define LMP_PAIR_LJ_COS_SQ_H + +#include "pair.h" + +namespace LAMMPS_NS { + +class PairCosineSquared : public Pair { + public: + PairCosineSquared(class LAMMPS *); + virtual ~PairCosineSquared(); + void settings(int, char **); + void coeff(int, char **); + // void init_style(); + double init_one(int, int); + void modify_params(int, char **); + void write_restart(FILE *); + void read_restart(FILE *); + void write_restart_settings(FILE *); + void read_restart_settings(FILE *); + void write_data(FILE *); + void write_data_all(FILE *); + virtual void compute(int, int); + double single(int, int, int, int, double, double, double, double &); + // void *extract(const char *, int &); + +/* RESPA stuff not implemented... + void compute_inner(); + void compute_middle(); + void compute_outer(int, int); +*/ + + protected: + double cut_global; + double **epsilon, **sigma, **w, **cut; + int **wcaflag; + double **lj12_e, **lj6_e, **lj12_f, **lj6_f; + + virtual void allocate(); +}; + +} // namespace LAMMPS_NS + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Incorrect args for pair coefficients + +Self-explanatory. Check the input script or data file. + +E: Mixing not supported in pair_style cosine/squared + +Self-explanatory. All coefficients need to be specified explicitly. + +E: pair_modify mix not supported for pair_style cosine/squared + +Same as above, only when calling "pair_modify" command + +W: pair_modify shift/tail is meaningless for pair_style cosine/squared + +This style by definition gets to zero at cutoff distance, so there is nothing +to shift and there is no tail contribution + +*/ + -- GitLab From 14353c5ea52ff3780873ad93821838dcae46f387 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Sun, 3 Mar 2019 01:52:43 +0100 Subject: [PATCH 006/469] Added WCA-only option (sigma == cutoff case with wca) --- src/USER-MISC/pair_cosine_squared.cpp | 25 ++++++++++++++++++++----- 1 file changed, 20 insertions(+), 5 deletions(-) diff --git a/src/USER-MISC/pair_cosine_squared.cpp b/src/USER-MISC/pair_cosine_squared.cpp index db3d8a6aa7..0229af7a08 100644 --- a/src/USER-MISC/pair_cosine_squared.cpp +++ b/src/USER-MISC/pair_cosine_squared.cpp @@ -153,8 +153,15 @@ void PairCosineSquared::coeff(int narg, char **arg) } } - if (cut_one <= sigma_one) - error->all(FLERR, "Incorrect args for pair coefficients (cutoff <= sigma)"); + if (cut_one < sigma_one) { + error->all(FLERR, "Incorrect args for cosine/squared pair coeffs (cutoff < sigma)"); + } else if (cut_one == sigma_one) { + if (wca_one == 0) { + error->all(FLERR, "Incorrect args for cosine/squared pair coeffs (cutoff = sigma w/o wca)") + } else { + error->warning(FLERR, "Cosine/squared set to WCA only (cutoff = sigma)") + } + } int count = 0; for (int i = ilo; i <= ihi; i++) { @@ -224,10 +231,10 @@ void PairCosineSquared::modify_params(int narg, char **arg) if (strcmp(arg[iarg], "mix") == 0) { error->all(FLERR, "pair_modify mix not supported for pair_style cosine/squared"); } else if (strcmp(arg[iarg], "shift") == 0) { - error->warning(FLERR, "pair_modify shift is meaningless for pair_style cosine/squared"); + error->warning(FLERR, "pair_modify shift has no effect on pair_style cosine/squared"); offset_flag = 0; } else if (strcmp(arg[iarg], "tail") == 0) { - error->warning(FLERR, "pair_modify tail is meaningless for pair_style cosine/squared"); + error->warning(FLERR, "pair_modify tail has no effect on pair_style cosine/squared"); tail_flag = 0; } iarg++; @@ -399,8 +406,12 @@ void PairCosineSquared::compute(int eflag, int vflag) force_lj = r6inv*(lj12_f[itype][jtype]*r6inv - lj6_f[itype][jtype]); fpair = factor_lj*force_lj*r2inv; if (eflag) { - evdwl = factor_lj*r6inv * + evdwl = factor_lj*r6inv* (lj12_e[itype][jtype]*r6inv - lj6_e[itype][jtype]); + if (sigma[itype][jtype] == cut[itype][jtype]) { + // this is the WCA-only case (it requires this shift by definition) + evdwl += factor_lj*epsilon[itype][jtype] + } } } else { fpair = 0.0; @@ -457,6 +468,10 @@ double PairCosineSquared::single(int i, int j, int itype, int jtype, double rsq, r6inv = r2inv*r2inv*r2inv; force = r6inv*(lj12_f[itype][jtype]*r6inv - lj6_f[itype][jtype])*r2inv; energy = r6inv*(lj12_e[itype][jtype]*r6inv - lj6_e[itype][jtype]); + if (sigma[itype][jtype] == cut[itype][jtype]) { + // this is the WCA-only case (it requires this shift by definition) + energy += epsilon[itype][jtype] + } } else { force = 0.0; energy = -epsilon[itype][jtype]; -- GitLab From 05f739a5a007d3da97cf7b89b6ec83df3890b7fc Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Sun, 3 Mar 2019 01:55:02 +0100 Subject: [PATCH 007/469] Bugfix for WCA-only option (trivial) --- src/USER-MISC/pair_cosine_squared.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/USER-MISC/pair_cosine_squared.cpp b/src/USER-MISC/pair_cosine_squared.cpp index 0229af7a08..67cefd894b 100644 --- a/src/USER-MISC/pair_cosine_squared.cpp +++ b/src/USER-MISC/pair_cosine_squared.cpp @@ -157,9 +157,9 @@ void PairCosineSquared::coeff(int narg, char **arg) error->all(FLERR, "Incorrect args for cosine/squared pair coeffs (cutoff < sigma)"); } else if (cut_one == sigma_one) { if (wca_one == 0) { - error->all(FLERR, "Incorrect args for cosine/squared pair coeffs (cutoff = sigma w/o wca)") + error->all(FLERR, "Incorrect args for cosine/squared pair coeffs (cutoff = sigma w/o wca)"); } else { - error->warning(FLERR, "Cosine/squared set to WCA only (cutoff = sigma)") + error->warning(FLERR, "Cosine/squared set to WCA only (cutoff = sigma)"); } } @@ -410,7 +410,7 @@ void PairCosineSquared::compute(int eflag, int vflag) (lj12_e[itype][jtype]*r6inv - lj6_e[itype][jtype]); if (sigma[itype][jtype] == cut[itype][jtype]) { // this is the WCA-only case (it requires this shift by definition) - evdwl += factor_lj*epsilon[itype][jtype] + evdwl += factor_lj*epsilon[itype][jtype]; } } } else { @@ -470,7 +470,7 @@ double PairCosineSquared::single(int i, int j, int itype, int jtype, double rsq, energy = r6inv*(lj12_e[itype][jtype]*r6inv - lj6_e[itype][jtype]); if (sigma[itype][jtype] == cut[itype][jtype]) { // this is the WCA-only case (it requires this shift by definition) - energy += epsilon[itype][jtype] + energy += epsilon[itype][jtype]; } } else { force = 0.0; -- GitLab From bbec50bef1795ae2737afb9b1cea75cf1bbdb355 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 29 Mar 2019 15:06:49 -0400 Subject: [PATCH 008/469] Add HMA examples --- examples/USER/hma/README | 22 + examples/USER/hma/hma.in | 36 + examples/USER/hma/log.6Nov18.hma.g++.1 | 10159 +++++++++++++++++++++++ examples/USER/hma/log.6Nov18.hma.g++.4 | 10159 +++++++++++++++++++++++ 4 files changed, 20376 insertions(+) create mode 100644 examples/USER/hma/README create mode 100644 examples/USER/hma/hma.in create mode 100644 examples/USER/hma/log.6Nov18.hma.g++.1 create mode 100644 examples/USER/hma/log.6Nov18.hma.g++.4 diff --git a/examples/USER/hma/README b/examples/USER/hma/README new file mode 100644 index 0000000000..5af6ec15fa --- /dev/null +++ b/examples/USER/hma/README @@ -0,0 +1,22 @@ +The example input script sets up a simple FCC crystal using the Lennard-Jones +potential. The script sets up the HMA compute to calculate the energy, pressure +and heat capacity. The output columns are: + +1: timestep +2: measured temperature +3: potential energy +4: HMA potential energy +5: pressure +6: HMA pressure +7: HMA heat capacity contribution + +Averages of the potential energy (#3 and #4) agree although #4 (HMA) is more precise. + +Averages of the pressure (#5 and #6) agree once the ideal gas +contribution is included; #6 (HMA) is more precise. + +The heat capacity can be computed from colume #3 (convential) as +Cv = Var(#3)/(k T^2) + +With HMA, the heat capacity can be computed from column #4 and #7 as +Cv = #7 + Var(#4)/(k T^2) diff --git a/examples/USER/hma/hma.in b/examples/USER/hma/hma.in new file mode 100644 index 0000000000..50c6dd96fb --- /dev/null +++ b/examples/USER/hma/hma.in @@ -0,0 +1,36 @@ +# Harmonically mapped average example + +units lj +dimension 3 +boundary p p p +atom_style atomic +atom_modify map array +# ---------- Create Atoms ---------------------------- +lattice fcc 1.0 +region box block 0 4 0 4 0 4 units lattice +create_box 1 box +lattice fcc 1.0 orient x 1 0 0 orient y 0 1 0 orient z 0 0 1 +create_atoms 1 region box +# ---------- Define Interatomic Potential --------------------- +pair_style lj/smooth/linear 3 +pair_coeff * * 1.0 1.0 +mass 1 1.0 + +atom_modify sort 0 1 +velocity all create 0.1 45678 dist gaussian + +compute u all pe + +compute p all pressure NULL pair + +compute hma all HMA settemp u p 9.579586686264458 cv + +timestep 0.005 + +fix settemp all nvt temp 1.0 1.0 0.5 +thermo_style custom elapsed temp c_u c_hma[1] c_p c_hma[2] c_hma[3] +thermo_modify format float '%22.15e' +thermo 500 +run 20000 +thermo 20 +run 200000 diff --git a/examples/USER/hma/log.6Nov18.hma.g++.1 b/examples/USER/hma/log.6Nov18.hma.g++.1 new file mode 100644 index 0000000000..fba304d783 --- /dev/null +++ b/examples/USER/hma/log.6Nov18.hma.g++.1 @@ -0,0 +1,10159 @@ +LAMMPS (31 Aug 2018) +# Harmonically mapped average example + +units lj +dimension 3 +boundary p p p +atom_style atomic +atom_modify map array +# ---------- Create Atoms ---------------------------- +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874 1.5874 1.5874 +region box block 0 4 0 4 0 4 units lattice +create_box 1 box +Created orthogonal box = (0 0 0) to (6.3496 6.3496 6.3496) + 1 by 1 by 1 MPI processor grid +lattice fcc 1.0 orient x 1 0 0 orient y 0 1 0 orient z 0 0 1 +Lattice spacing in x,y,z = 1.5874 1.5874 1.5874 +create_atoms 1 region box +Created 256 atoms + Time spent = 0.000558853 secs +# ---------- Define Interatomic Potential --------------------- +pair_style lj/smooth/linear 3 +pair_coeff * * 1.0 1.0 +mass 1 1.0 + +atom_modify sort 0 1 +velocity all create 0.1 45678 dist gaussian + +compute u all pe + +compute p all pressure NULL pair + +compute hma all HMA settemp u p 9.579586686264458 cv + +timestep 0.005 + +fix settemp all nvt temp 1.0 1.0 0.5 +thermo_style custom elapsed temp c_u c_hma[1] c_p c_hma[2] c_hma[3] +thermo_modify format float '%22.15e' +thermo 500 +run 20000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 3.3 + ghost atom cutoff = 3.3 + binsize = 1.65, bins = 4 4 4 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair lj/smooth/linear, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard + (2) compute HMA, occasional, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 3.425 | 3.425 | 3.425 Mbytes +Elapsed Temp c_u c_hma[1] c_p c_hma[2] c_hma[3] + 0 9.999999999999984e-02 -7.321210550029651e+00 -5.827069925029651e+00 -3.541123363606526e+00 6.038463322657933e+00 8.693908581888376e+03 + 500 2.386148283497847e-01 -7.031289207724356e+00 -5.841955950103862e+00 -1.905706169928171e+00 5.923629444055504e+00 8.738341241696249e+03 + 1000 1.033640532939756e+00 -5.899129588008281e+00 -5.989693420271868e+00 4.270084606318116e+00 4.750053066752854e+00 9.185409687897396e+03 + 1500 9.066678783388608e-01 -6.084949363864708e+00 -6.008077972326689e+00 3.223989663631114e+00 4.665397089651815e+00 9.241882696308397e+03 + 2000 8.653666754537616e-01 -6.040261189331211e+00 -6.030563879284796e+00 3.468617809376976e+00 4.524301264317375e+00 9.311127705836057e+03 + 2500 1.037531298248839e+00 -6.132639377068311e+00 -5.988640354751864e+00 2.977362159634933e+00 4.804226829552658e+00 9.182209655823657e+03 + 3000 1.021622746681649e+00 -5.898542445856487e+00 -6.009151612939077e+00 4.221727087636999e+00 4.586592133535478e+00 9.245164803297535e+03 + 3500 1.106519160715706e+00 -5.970546432235779e+00 -6.015249245376119e+00 3.866123627527625e+00 4.609433156737818e+00 9.263945750662717e+03 + 4000 9.930240066865930e-01 -5.912152557873307e+00 -6.025083715886064e+00 4.138611283233161e+00 4.490143097883684e+00 9.294225198089340e+03 + 4500 9.646555658575586e-01 -6.015677130022131e+00 -6.036721545560821e+00 3.568689708725919e+00 4.447849418089985e+00 9.330138922961722e+03 + 5000 9.434923165946090e-01 -6.027456548570741e+00 -6.014550053270733e+00 3.565441638398635e+00 4.639552731684967e+00 9.261770624752438e+03 + 5500 1.026864240931640e+00 -6.061505823962392e+00 -6.019404988381412e+00 3.401241932620071e+00 4.642991445609312e+00 9.276731237911577e+03 + 6000 9.983312526598234e-01 -5.946349587454857e+00 -5.983050555300542e+00 3.979901469071073e+00 4.769158832244731e+00 9.165087115091061e+03 + 6500 1.006036143286260e+00 -5.945850544079388e+00 -6.071303751273131e+00 3.946077295974201e+00 4.225705566446658e+00 9.437216768355414e+03 + 7000 9.981593359539495e-01 -5.990330698910480e+00 -6.037063892399898e+00 3.663774642188439e+00 4.395425413233882e+00 9.331181435130977e+03 + 7500 9.507280203289744e-01 -5.984730396336532e+00 -5.991644972746507e+00 3.755491186444424e+00 4.715786618671108e+00 9.191404619772287e+03 + 8000 9.048837157594684e-01 -6.079029085917312e+00 -5.964267902838972e+00 3.230203589004437e+00 4.889180061475951e+00 9.107693071292861e+03 + 8500 9.883413333994134e-01 -6.002876846326834e+00 -6.011751334719937e+00 3.642240804100097e+00 4.591282118424260e+00 9.253163154010274e+03 + 9000 1.056758147654552e+00 -6.036760797857792e+00 -6.002535828890329e+00 3.520846457975964e+00 4.717371526083967e+00 9.224856128595033e+03 + 9500 1.035347515567710e+00 -5.969647617813958e+00 -5.990309632036265e+00 3.813299824718261e+00 4.694655341617407e+00 9.187302608800977e+03 + 10000 1.023738343179159e+00 -5.877099589117778e+00 -6.048562900734738e+00 4.344908960531808e+00 4.360340091365503e+00 9.366720846528935e+03 + 10500 1.069815794809561e+00 -5.913367214053245e+00 -6.010777075880958e+00 4.147089675758311e+00 4.587747175016184e+00 9.250158711907829e+03 + 11000 9.776294387160251e-01 -5.925772082085378e+00 -5.989277934483906e+00 4.082344757077178e+00 4.717684325105934e+00 9.184160813848264e+03 + 11500 9.499730095716009e-01 -5.976861040295939e+00 -6.004120411932708e+00 3.808317456317362e+00 4.651789926004906e+00 9.229684845202884e+03 + 12000 9.782073857977380e-01 -6.066220802750934e+00 -6.031270148041170e+00 3.304122260466307e+00 4.504814328406108e+00 9.313293791801259e+03 + 12500 9.552683271823048e-01 -6.108551273751968e+00 -5.979666568626595e+00 3.136478232915417e+00 4.876554154588973e+00 9.154740057331765e+03 + 13000 8.742841944497640e-01 -6.013421944223564e+00 -6.021450865532995e+00 3.577734470946406e+00 4.531631162316097e+00 9.283015239817061e+03 + 13500 1.004344955842980e+00 -5.899309998559693e+00 -6.011273141389537e+00 4.232629792927130e+00 4.589720100557810e+00 9.251678010621874e+03 + 14000 9.987696680587935e-01 -5.929715246484374e+00 -6.008152969607664e+00 4.103967501967555e+00 4.653565957595201e+00 9.242036851405348e+03 + 14500 1.006604156366316e+00 -6.153189106822779e+00 -5.973434451881044e+00 2.841124235115949e+00 4.873303280734345e+00 9.135699098879228e+03 + 15000 9.051321416654020e-01 -6.031733280212374e+00 -5.972657495662279e+00 3.559001586802186e+00 4.898223883636946e+00 9.133297115127007e+03 + 15500 9.682672962081463e-01 -6.067136130017134e+00 -5.966412476549884e+00 3.354912150470541e+00 4.933282955614485e+00 9.114211079881910e+03 + 16000 1.015665897061745e+00 -6.059784334366720e+00 -5.980063616786515e+00 3.369338836061829e+00 4.827107533148539e+00 9.155963314807441e+03 + 16500 1.006968180883997e+00 -5.995526549328130e+00 -5.964005551783969e+00 3.802449041277696e+00 4.983447487034876e+00 9.106875404577086e+03 + 17000 1.042050305358167e+00 -5.919486263379956e+00 -6.013086895161285e+00 4.122119914992582e+00 4.584650602653237e+00 9.257241816102296e+03 + 17500 1.013492134662422e+00 -5.898786232899295e+00 -5.988108507110901e+00 4.246935217818169e+00 4.734032896717861e+00 9.180541556032720e+03 + 18000 1.045293495070465e+00 -6.013155802624135e+00 -6.000945960251793e+00 3.631220305239846e+00 4.701331109608827e+00 9.219959027336774e+03 + 18500 9.134705431704426e-01 -5.943263213107316e+00 -6.036334213909798e+00 4.028889501874485e+00 4.494461412575806e+00 9.328923769735196e+03 + 19000 1.007628738828841e+00 -6.062647924602851e+00 -5.961993496778848e+00 3.347669071096405e+00 4.925642371884200e+00 9.100752827583676e+03 + 19500 1.000237087620137e+00 -5.934759822585448e+00 -6.020766118588664e+00 4.035509558295610e+00 4.541648097213850e+00 9.280908870426259e+03 + 20000 9.615364955745067e-01 -5.859940462234714e+00 -5.981549364677676e+00 4.480555066266412e+00 4.782257929522093e+00 9.160435351560425e+03 +Loop time of 33.5763 on 1 procs for 20000 steps with 256 atoms + +Performance: 257324.049 tau/day, 595.658 timesteps/s +99.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 30.404 | 30.404 | 30.404 | 0.0 | 90.55 +Neigh | 2.1959 | 2.1959 | 2.1959 | 0.0 | 6.54 +Comm | 0.50746 | 0.50746 | 0.50746 | 0.0 | 1.51 +Output | 0.16503 | 0.16503 | 0.16503 | 0.0 | 0.49 +Modify | 0.237 | 0.237 | 0.237 | 0.0 | 0.71 +Other | | 0.06721 | | | 0.20 + +Nlocal: 256 ave 256 max 256 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 2116 ave 2116 max 2116 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 19135 ave 19135 max 19135 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 19135 +Ave neighs/atom = 74.7461 +Neighbor list builds = 1946 +Dangerous builds = 1902 +thermo 20 +run 200000 +Per MPI rank memory allocation (min/avg/max) = 3.806 | 3.806 | 3.806 Mbytes +Elapsed Temp c_u c_hma[1] c_p c_hma[2] c_hma[3] + 0 9.615364955745067e-01 -5.859940462234714e+00 -5.981549364677676e+00 4.480555066266412e+00 4.782257929522093e+00 9.160435351560425e+03 + 20 1.020600011999315e+00 -5.958432657247554e+00 -5.970407876039725e+00 3.888068459330918e+00 4.819304899867157e+00 9.126408714227488e+03 + 40 9.814651761832457e-01 -5.909251537070915e+00 -5.991660882363840e+00 4.211003703521785e+00 4.737796490044842e+00 9.191407419668969e+03 + 60 1.017977787037964e+00 -5.969196214125930e+00 -5.964268442742594e+00 3.868843363187895e+00 4.897139389041168e+00 9.107658398968413e+03 + 80 1.014099325641110e+00 -5.967528512390698e+00 -5.995071997895454e+00 3.830673462482372e+00 4.672514506373457e+00 9.201917832597679e+03 + 100 9.996875356603929e-01 -5.951588326170250e+00 -6.038052192222564e+00 3.956276886785969e+00 4.459787987673556e+00 9.334249364612955e+03 + 120 1.012056868305871e+00 -5.978870473165807e+00 -6.025850442982817e+00 3.772945936859251e+00 4.503179680043147e+00 9.296565936440789e+03 + 140 9.767869134157122e-01 -5.935832220940478e+00 -5.962749498947353e+00 4.000315968594315e+00 4.845752792843529e+00 9.103038302449055e+03 + 160 9.892523056702491e-01 -5.959324837828405e+00 -5.989985114179447e+00 3.844041265550217e+00 4.667985214080106e+00 9.186300645060488e+03 + 180 9.515078978028194e-01 -5.906073543975624e+00 -5.989405874738726e+00 4.168541295586040e+00 4.690034156707802e+00 9.184525321314130e+03 + 200 9.472636015419604e-01 -5.901747840949999e+00 -6.059197474754500e+00 4.085216465358702e+00 4.181116302801172e+00 9.399653985979861e+03 + 220 9.987356397412785e-01 -5.979817989736361e+00 -6.023113896710152e+00 3.732212025258467e+00 4.483600227395010e+00 9.288140153203587e+03 + 240 1.038054632582729e+00 -6.041406960780349e+00 -5.980798008747044e+00 3.486347567353394e+00 4.834373549133644e+00 9.158206331469573e+03 + 260 9.871325901445797e-01 -5.972400207772776e+00 -5.968492407279171e+00 3.916384667845522e+00 4.938823863009977e+00 9.120560085095371e+03 + 280 9.956901322007337e-01 -5.990610420020357e+00 -5.962602141919667e+00 3.753129205829077e+00 4.913957072950271e+00 9.102601708340648e+03 + 300 1.009984603711227e+00 -6.014944223505186e+00 -6.010674471382663e+00 3.587051537885279e+00 4.611569115314808e+00 9.249843677831494e+03 + 320 9.305773490336505e-01 -5.901476652774451e+00 -6.038002596975854e+00 4.176230329941724e+00 4.392277231015683e+00 9.334082842844762e+03 + 340 1.056836316225221e+00 -6.094477310586364e+00 -5.975940734624987e+00 3.221256895122957e+00 4.901912257769030e+00 9.143345371605477e+03 + 360 1.027370901346992e+00 -6.057905193474668e+00 -5.990495882312443e+00 3.382497773809937e+00 4.769572470060623e+00 9.187901604960492e+03 + 380 1.027053843567510e+00 -6.067567333363834e+00 -5.992992123368923e+00 3.352964818195047e+00 4.781187214462276e+00 9.195571631580398e+03 + 400 9.647458413060627e-01 -5.991119322386009e+00 -6.023522809301189e+00 3.756132264420374e+00 4.570066428130018e+00 9.289383729169578e+03 + 420 9.505543699450696e-01 -5.990054663373088e+00 -5.954997797428323e+00 3.796781777281000e+00 4.998083726568312e+00 9.079390028764674e+03 + 440 9.432138789227676e-01 -5.999500661104858e+00 -5.965348596051710e+00 3.749404409954200e+00 4.945510852504365e+00 9.110957857286596e+03 + 460 9.946517677936523e-01 -6.094506023215614e+00 -5.922729347729346e+00 3.244233981455053e+00 5.230602234451828e+00 8.981356715586544e+03 + 480 9.768158811921931e-01 -6.083372216619380e+00 -5.984015465829660e+00 3.255702454543993e+00 4.826224292986060e+00 9.168060189574073e+03 + 500 9.735587401236447e-01 -6.093252792321985e+00 -5.989449928193141e+00 3.225643293190835e+00 4.821695402459973e+00 9.184679322046662e+03 + 520 9.673953565770059e-01 -6.095243147212247e+00 -5.970259243675635e+00 3.254347301876793e+00 4.972024217180586e+00 9.125967781754774e+03 + 540 9.564831427064477e-01 -6.085367390550866e+00 -5.960762164817647e+00 3.252523065566245e+00 4.968025554322751e+00 9.096994293608030e+03 + 560 9.160259766588862e-01 -6.024333603042241e+00 -6.004486973148659e+00 3.561916257252231e+00 4.675878677357225e+00 9.230818152603229e+03 + 580 9.365262885929674e-01 -6.047282384694587e+00 -5.995736849141418e+00 3.467335056536695e+00 4.763317498328839e+00 9.203985250309977e+03 + 600 9.905085824153109e-01 -6.111632605457764e+00 -5.999026265069876e+00 3.120825308203702e+00 4.767428340485811e+00 9.214080648246067e+03 + 620 8.983062544144987e-01 -5.953208418045645e+00 -6.051189931643725e+00 3.902216336689605e+00 4.339591323019206e+00 9.374838861707278e+03 + 640 9.727178632994492e-01 -6.034356553093311e+00 -5.993377567277118e+00 3.544024007704800e+00 4.779331685738934e+00 9.196711017802761e+03 + 660 9.868479743130403e-01 -6.018937110508205e+00 -6.022262145227385e+00 3.646354583354751e+00 4.627261719449758e+00 9.285527836847134e+03 + 680 1.042099410995170e+00 -6.061895338965634e+00 -6.009701595109138e+00 3.448886151723162e+00 4.748590705902920e+00 9.246864122826662e+03 + 700 1.007797621586424e+00 -5.977163022849595e+00 -6.038029591020394e+00 3.793032147707110e+00 4.443526894199397e+00 9.334177552353092e+03 + 720 1.060607296456946e+00 -6.028231877432784e+00 -6.016093863057161e+00 3.583008768087949e+00 4.652707124984429e+00 9.266521722759040e+03 + 740 1.032187279438618e+00 -5.965848703351575e+00 -6.040028547837692e+00 3.860961083724912e+00 4.435008937391792e+00 9.340337375312332e+03 + 760 1.026294810899552e+00 -5.944279252754226e+00 -6.028390103116603e+00 3.971505547814307e+00 4.488528028921509e+00 9.304396431357543e+03 + 780 1.004838448427803e+00 -5.903901342566534e+00 -6.054572355333297e+00 4.234631152466997e+00 4.369454880896369e+00 9.385298252566547e+03 + 800 1.072022975471984e+00 -6.004117677002591e+00 -6.023784574182003e+00 3.645243430038966e+00 4.532313062992278e+00 9.290217112242535e+03 + 820 1.004076334131657e+00 -5.908459509214397e+00 -5.998944780536973e+00 4.207017478915473e+00 4.687437048430760e+00 9.213783936955662e+03 + 840 1.053090926477705e+00 -5.987174315507324e+00 -6.000355723291464e+00 3.703641389302587e+00 4.627951705989791e+00 9.218103864493949e+03 + 860 1.059694538978974e+00 -6.006624645080397e+00 -5.989214936393363e+00 3.625012862867183e+00 4.724982104291838e+00 9.183981890165787e+03 + 880 1.038407762919759e+00 -5.987136018377438e+00 -6.025552832897892e+00 3.794956680037541e+00 4.574361386078261e+00 9.295652878164343e+03 + 900 1.043007690526313e+00 -6.013465419734895e+00 -6.027614020233820e+00 3.606232258595921e+00 4.524988805042247e+00 9.302022765689335e+03 + 920 9.896570453270673e-01 -5.959465041355689e+00 -6.022233802324223e+00 3.876398191027682e+00 4.515970252111998e+00 9.285436808518602e+03 + 940 9.948607795251544e-01 -5.993672588532680e+00 -5.984650909476759e+00 3.701359263747514e+00 4.753163140986936e+00 9.169980614085634e+03 + 960 1.035827229385980e+00 -6.081034553559161e+00 -5.964961535588436e+00 3.249267281501619e+00 4.915776512931000e+00 9.109798757436427e+03 + 980 9.645096834387771e-01 -6.002594103325545e+00 -5.970445825678690e+00 3.712446235988870e+00 4.897046621167003e+00 9.126545101595195e+03 + 1000 1.009701922889595e+00 -6.096480717012984e+00 -5.972865879407933e+00 3.150534106838672e+00 4.860349633701173e+00 9.133926064502963e+03 + 1020 9.503812786142370e-01 -6.034008329652367e+00 -5.988601219595624e+00 3.507987022353116e+00 4.768721675026509e+00 9.182098355151335e+03 + 1040 9.746274789930985e-01 -6.096484341462583e+00 -5.950936231351280e+00 3.210104652802036e+00 5.045864424558385e+00 9.067059029444334e+03 + 1060 9.407431654685644e-01 -6.068377501281406e+00 -5.992631788204981e+00 3.352843024974694e+00 4.787786631070743e+00 9.194434219962888e+03 + 1080 9.091514504280382e-01 -6.043112056004267e+00 -5.973207871722924e+00 3.505526407055114e+00 4.906927050836144e+00 9.134970839495374e+03 + 1100 9.823903220122076e-01 -6.174514117857894e+00 -5.976777098839887e+00 2.740608171405174e+00 4.876044734311370e+00 9.145905655707946e+03 + 1120 8.981855268428002e-01 -6.082432685610340e+00 -6.020568037873874e+00 3.214706017518917e+00 4.569942398345004e+00 9.280315376370809e+03 + 1140 8.612422145608321e-01 -6.067113629744508e+00 -6.009413636339771e+00 3.288232584945134e+00 4.619554876120258e+00 9.245993039824376e+03 + 1160 9.045004881983270e-01 -6.173092798124903e+00 -6.002290480654269e+00 2.775781332075512e+00 4.756554670565095e+00 9.224085597860292e+03 + 1180 8.261610909928941e-01 -6.091231310673821e+00 -5.987711242384705e+00 3.247882000724438e+00 4.842310252519333e+00 9.179374736097656e+03 + 1200 9.282271319004017e-01 -6.262203325647667e+00 -5.975959661581035e+00 2.263150983099611e+00 4.906806398234071e+00 9.143433281056405e+03 + 1220 8.679135131073991e-01 -6.179410432364137e+00 -5.949695464638571e+00 2.752682811237898e+00 5.071741704194469e+00 9.063282970693110e+03 + 1240 8.583254347975858e-01 -6.158990899882398e+00 -5.940456743778165e+00 2.869393831047280e+00 5.124250773449146e+00 9.035165857395938e+03 + 1260 8.392364297846614e-01 -6.108064463514651e+00 -5.991278083147219e+00 3.109662104369866e+00 4.780267573073615e+00 9.190311837705440e+03 + 1280 8.631940855471624e-01 -6.106811334400191e+00 -5.987869258418657e+00 3.096836280393307e+00 4.779820086906047e+00 9.179852510951436e+03 + 1300 9.465910253599886e-01 -6.185941712773322e+00 -5.966243376948754e+00 2.718706219490234e+00 4.980248062002492e+00 9.113715590844284e+03 + 1320 8.939698422180601e-01 -6.062554909492443e+00 -6.022387835720140e+00 3.339322187895670e+00 4.569967741330808e+00 9.285909078300389e+03 + 1340 9.663415310096390e-01 -6.131157347769264e+00 -5.999184745874027e+00 2.998219610823661e+00 4.756026713600249e+00 9.214559738040494e+03 + 1360 9.326348979354570e-01 -6.051960664761741e+00 -6.011566541804979e+00 3.365357240996571e+00 4.597306545984625e+00 9.252606709869695e+03 + 1380 9.838831860561270e-01 -6.102340308996237e+00 -5.979875506911626e+00 3.181681026634277e+00 4.884892871570987e+00 9.155389025363127e+03 + 1400 9.561080585035765e-01 -6.037376222780178e+00 -5.978052697966062e+00 3.543719619114497e+00 4.884364478882951e+00 9.149781487609316e+03 + 1420 9.616152894373232e-01 -6.020403307929190e+00 -5.978725706122892e+00 3.613292863917748e+00 4.852612103077540e+00 9.151829441811955e+03 + 1440 9.231289155307136e-01 -5.934284213675148e+00 -6.028403994703597e+00 4.048890017676614e+00 4.508439670022217e+00 9.304435171640742e+03 + 1460 1.061667021810408e+00 -6.111519345048196e+00 -5.982690110417253e+00 3.113188388223132e+00 4.852945789733632e+00 9.163980881948735e+03 + 1480 1.059560219796085e+00 -6.084363329559978e+00 -5.987728413345155e+00 3.245236537840204e+00 4.800129180950673e+00 9.179438219977714e+03 + 1500 1.012750280838527e+00 -5.994531923159054e+00 -6.015705850948073e+00 3.690030187222798e+00 4.568446217203522e+00 9.265347935357384e+03 + 1520 9.790047711106866e-01 -5.925333053702159e+00 -6.031653821996447e+00 4.150180624103042e+00 4.539670319471520e+00 9.314481840846052e+03 + 1540 1.025220067885404e+00 -5.977965865465314e+00 -6.045639152412221e+00 3.784324604882108e+00 4.395734118825657e+00 9.357694194805334e+03 + 1560 1.053346800561144e+00 -6.007394640953897e+00 -6.035779256370128e+00 3.638965429074724e+00 4.475976574849684e+00 9.327229361837670e+03 + 1580 1.003756286747422e+00 -5.925712214111871e+00 -6.049388789297026e+00 4.111927361262683e+00 4.401757327661366e+00 9.369295883063558e+03 + 1600 1.040645216151974e+00 -5.976765290845121e+00 -6.024478595502995e+00 3.838056328051300e+00 4.564079149095758e+00 9.292350889159208e+03 + 1620 1.030742510336460e+00 -5.963069451146461e+00 -6.055529072612251e+00 3.826054093709232e+00 4.295136639172486e+00 9.388280332857752e+03 + 1640 1.018291214069761e+00 -5.950336595093376e+00 -6.006532544475585e+00 3.985599254086584e+00 4.662913416438871e+00 9.237118285165081e+03 + 1660 1.009859899650586e+00 -5.949038278212260e+00 -6.024847881588862e+00 3.882239073593950e+00 4.446928599507297e+00 9.293477948668717e+03 + 1680 9.780695418336188e-01 -5.917263721192500e+00 -5.984150165550203e+00 4.205923125606110e+00 4.821850811460366e+00 9.168437667864344e+03 + 1700 9.844247949153297e-01 -5.944284099104667e+00 -6.001674975408905e+00 3.981291226819832e+00 4.651743933871494e+00 9.222151852808516e+03 + 1720 1.035204086152618e+00 -6.041765106493767e+00 -5.948400346256865e+00 3.508107768540726e+00 5.044222669970972e+00 9.059309939352459e+03 + 1740 9.735465874127380e-01 -5.973907150827966e+00 -6.006128340233649e+00 3.849236040922400e+00 4.664216985142023e+00 9.235831751128731e+03 + 1760 1.021647547350805e+00 -6.071789444504817e+00 -5.989492696206266e+00 3.322520166070766e+00 4.795080830181685e+00 9.184829491874758e+03 + 1780 9.829912709311043e-01 -6.046511031752197e+00 -6.038580258282047e+00 3.444541353488311e+00 4.490081082037142e+00 9.335858705823826e+03 + 1800 9.067041211651782e-01 -5.967479188311842e+00 -5.998576782562291e+00 3.876458068413311e+00 4.697890869890072e+00 9.212664495094426e+03 + 1820 9.303027555203129e-01 -6.029911981483854e+00 -5.930260731696491e+00 3.557669590060521e+00 5.129882487320623e+00 9.004180678770081e+03 + 1840 9.484660292210128e-01 -6.076645362889215e+00 -5.951701991424679e+00 3.286465790439809e+00 5.003909964313417e+00 9.069351674519061e+03 + 1860 9.637328962958422e-01 -6.110724043144727e+00 -5.953757959079353e+00 3.119542288695860e+00 5.020865833822242e+00 9.075642905854969e+03 + 1880 8.992123982400598e-01 -6.018902590362062e+00 -5.991568529985308e+00 3.591046499455746e+00 4.748002904071240e+00 9.191203718047062e+03 + 1900 9.136576225450348e-01 -6.037676417633506e+00 -5.999434369818164e+00 3.511791468349679e+00 4.731383224843148e+00 9.215333290945684e+03 + 1920 9.375535911212801e-01 -6.062472661411043e+00 -6.047567016027818e+00 3.282000146257340e+00 4.367590668688988e+00 9.363663142520585e+03 + 1940 9.350410412094516e-01 -6.039333226980075e+00 -6.015832450194493e+00 3.452686812962875e+00 4.587631909999144e+00 9.265750484394532e+03 + 1960 9.309914320231641e-01 -6.003514157522395e+00 -6.027302326423196e+00 3.700951024414730e+00 4.564355677379094e+00 9.301039255333508e+03 + 1980 9.786398925214956e-01 -6.028676277651872e+00 -5.957244057744021e+00 3.550445026623316e+00 4.960619887434501e+00 9.086252584614320e+03 + 2000 1.017743470513826e+00 -6.025728074018636e+00 -5.974009382759989e+00 3.526447486996597e+00 4.823424215645353e+00 9.137407848709952e+03 + 2020 9.921831384791643e-01 -5.930579681929451e+00 -6.026583243819555e+00 4.095294307714560e+00 4.544026998838393e+00 9.298780957635769e+03 + 2040 1.034756316252099e+00 -5.953264022547445e+00 -6.024434590300764e+00 3.912884935097801e+00 4.504212521448473e+00 9.292197153295034e+03 + 2060 1.041898878799784e+00 -5.943857455222254e+00 -5.973584742468068e+00 4.009494240136615e+00 4.838795556488317e+00 9.136119215063945e+03 + 2080 1.051587850596250e+00 -5.949092659230135e+00 -6.022106408040662e+00 3.979419693954676e+00 4.560163449443515e+00 9.285027914872551e+03 + 2100 1.020323879461642e+00 -5.900714442462338e+00 -5.972696865701201e+00 4.295087615259903e+00 4.881753401778361e+00 9.133418294755478e+03 + 2120 1.044581017076930e+00 -5.937354763172756e+00 -6.039917373455466e+00 3.978618766764721e+00 4.389688387008756e+00 9.339992016263102e+03 + 2140 1.072055660059346e+00 -5.984065213816709e+00 -6.034809567899721e+00 3.798878619746003e+00 4.507496685937936e+00 9.324209110359001e+03 + 2160 1.031227062578640e+00 -5.938162908297856e+00 -6.008447238754909e+00 4.021517220865634e+00 4.617933718916242e+00 9.243000022398610e+03 + 2180 1.034755143010538e+00 -5.961335305794837e+00 -6.000325005504487e+00 3.915225660617375e+00 4.691340771248034e+00 9.218057646159879e+03 + 2200 1.039001354083559e+00 -5.991444062035432e+00 -5.983379262141549e+00 3.733477616826287e+00 4.779786945840719e+00 9.166106402515536e+03 + 2220 9.498847331017423e-01 -5.885838586722715e+00 -5.984317424434447e+00 4.321695272838102e+00 4.756214547146445e+00 9.168955183721220e+03 + 2240 9.501942141050930e-01 -5.910020863783831e+00 -6.001311713438006e+00 4.156209699406988e+00 4.632003513479384e+00 9.221083876521356e+03 + 2260 1.026549044077855e+00 -6.043911692494221e+00 -5.985909374576475e+00 3.420934742591152e+00 4.753993027904539e+00 9.173858090843971e+03 + 2280 9.873378131784011e-01 -6.005570184901982e+00 -5.966671314414222e+00 3.687934278815697e+00 4.911297612737165e+00 9.115019236940161e+03 + 2300 9.660380825961528e-01 -5.991868163662822e+00 -5.979463994929207e+00 3.732624032155659e+00 4.803850688562990e+00 9.154115146407163e+03 + 2320 9.851804439154875e-01 -6.036748149167285e+00 -6.010997252042185e+00 3.492100692452209e+00 4.639966328682985e+00 9.250817241884635e+03 + 2340 9.482326737821434e-01 -5.997867538123590e+00 -5.986639006873171e+00 3.689368633512774e+00 4.753844597562276e+00 9.176097066986249e+03 + 2360 9.953533969036702e-01 -6.077373108878684e+00 -5.962167911492571e+00 3.280619420808249e+00 4.942145492145984e+00 9.101280340212683e+03 + 2380 9.555158600898254e-01 -6.023581740385814e+00 -6.025046558822569e+00 3.547031133274983e+00 4.538619919131214e+00 9.294088012067339e+03 + 2400 1.010563190649329e+00 -6.108023021694780e+00 -5.991314693986003e+00 3.084174459512837e+00 4.754331737771976e+00 9.190415795063142e+03 + 2420 9.303996037417740e-01 -5.991673144743388e+00 -5.983113311373838e+00 3.810089780922815e+00 4.859241668760707e+00 9.165260814618883e+03 + 2440 9.761594421211988e-01 -6.057620798964248e+00 -5.983689112842983e+00 3.367003247267722e+00 4.791530429867476e+00 9.167047424311824e+03 + 2460 9.762053469145309e-01 -6.045998557885177e+00 -6.012621894164110e+00 3.485410621104526e+00 4.677064589212911e+00 9.255827985432243e+03 + 2480 9.794895189369441e-01 -6.029820602379265e+00 -6.013111971902220e+00 3.568292288370280e+00 4.664235830221678e+00 9.257340610576595e+03 + 2500 9.901602346720159e-01 -6.013416932535310e+00 -5.998316337917947e+00 3.636029655824388e+00 4.722739606926750e+00 9.211864986791772e+03 + 2520 1.006256892986497e+00 -5.994119228495149e+00 -5.995810750660208e+00 3.701285240106636e+00 4.691572258072658e+00 9.204202979425774e+03 + 2540 1.068647567454971e+00 -6.037162225076347e+00 -5.995673923946281e+00 3.526770949061185e+00 4.765003194443874e+00 9.203773043658322e+03 + 2560 9.345765840500163e-01 -5.793252466848898e+00 -6.072559642621477e+00 4.807504092675140e+00 4.203679066743230e+00 9.441133173025577e+03 + 2580 1.060362174286126e+00 -5.945450448550415e+00 -6.032953948211018e+00 3.968270453044044e+00 4.465811816870048e+00 9.318475555371035e+03 + 2600 1.080011758746663e+00 -5.949340082433418e+00 -6.069588002464240e+00 3.908557299120135e+00 4.218075133997671e+00 9.431912568369982e+03 + 2620 1.113381394285127e+00 -5.988674325747065e+00 -6.035308977841042e+00 3.690519788330698e+00 4.422736399317997e+00 9.325775624233764e+03 + 2640 1.023657166333712e+00 -5.857016009885120e+00 -6.048180465356296e+00 4.458707362785388e+00 4.361011476866018e+00 9.365525943049823e+03 + 2660 1.109488090531586e+00 -5.992004849303601e+00 -5.994857830601346e+00 3.790170239168447e+00 4.773787979059367e+00 9.201251093039617e+03 + 2680 1.032737652275809e+00 -5.893406738708014e+00 -6.008598442737576e+00 4.289615871101264e+00 4.628167280704933e+00 9.243453162978010e+03 + 2700 1.051629171914912e+00 -5.942509257626184e+00 -5.993657008849417e+00 4.038403003349119e+00 4.744704700736395e+00 9.197587475794442e+03 + 2720 1.014722340874505e+00 -5.914614315536612e+00 -6.025274163896979e+00 4.224254414766998e+00 4.588828440925579e+00 9.294780369992295e+03 + 2740 1.039197040881143e+00 -5.981558520348850e+00 -5.997250644504337e+00 3.829334480190060e+00 4.739227874940885e+00 9.208629298257638e+03 + 2760 1.070878298826088e+00 -6.057517124960611e+00 -6.008307276540997e+00 3.382791461497443e+00 4.665362026322305e+00 9.242577588477710e+03 + 2780 9.830312757942556e-01 -5.959283988455138e+00 -6.039760881587464e+00 3.921878249313939e+00 4.459767475189163e+00 9.339520863067426e+03 + 2800 9.801307540648010e-01 -5.981790130528015e+00 -6.034934304254086e+00 3.870926889113588e+00 4.565764819544185e+00 9.324605886665495e+03 + 2820 9.462318991246462e-01 -5.953966927629361e+00 -6.041830260968773e+00 3.959424236510390e+00 4.454899379668600e+00 9.345901684382037e+03 + 2840 9.535508840369477e-01 -5.980222082028534e+00 -6.012182687144961e+00 3.876535132139107e+00 4.693012391672928e+00 9.254461951048976e+03 + 2860 9.627648079880218e-01 -6.002855054410181e+00 -6.018572722364612e+00 3.686783491084446e+00 4.596530209388844e+00 9.274130511816469e+03 + 2880 1.005801764967796e+00 -6.071303014685317e+00 -5.990168863171433e+00 3.418057899300059e+00 4.883942752762154e+00 9.186884425309876e+03 + 2900 9.849232294897350e-01 -6.042206903587623e+00 -6.008418887185501e+00 3.453067575227690e+00 4.647083594087311e+00 9.242919697632258e+03 + 2920 9.411968773959798e-01 -5.977984921752276e+00 -6.021323552518306e+00 3.809540561171684e+00 4.560683436681699e+00 9.282625017763461e+03 + 2940 1.000686166239594e+00 -6.063314862394346e+00 -5.976942496972629e+00 3.353806447158134e+00 4.849769935489987e+00 9.146411942290853e+03 + 2960 9.392082554761829e-01 -5.967112888359170e+00 -5.989627792429555e+00 3.840019384867245e+00 4.710735321524949e+00 9.185226185427615e+03 + 2980 9.447304062331515e-01 -5.967848312745796e+00 -5.984103680657841e+00 3.871254031001020e+00 4.777913192940002e+00 9.168298809431211e+03 + 3000 9.606414785527527e-01 -5.981194174221447e+00 -6.002773462745154e+00 3.784288609205670e+00 4.660376995118439e+00 9.225552721251815e+03 + 3020 9.880595790204920e-01 -6.009494716157877e+00 -5.992218641087182e+00 3.654581812368313e+00 4.753783708888221e+00 9.193173636030911e+03 + 3040 1.011180929173924e+00 -6.029525900679877e+00 -5.989745576332014e+00 3.587552084372791e+00 4.815976862763517e+00 9.185596499324651e+03 + 3060 1.011911136187293e+00 -6.016382547528823e+00 -6.012811783938136e+00 3.638614503821353e+00 4.659118380932961e+00 9.256420456776001e+03 + 3080 1.020026774447945e+00 -6.016400564864076e+00 -6.017117826887823e+00 3.558561438341541e+00 4.554442808805248e+00 9.269676226489781e+03 + 3100 1.007971832853203e+00 -5.987149615203221e+00 -6.005785857028267e+00 3.751523937660454e+00 4.644511753151946e+00 9.234815644439706e+03 + 3120 1.011341027154857e+00 -5.981640734874794e+00 -6.027486903465731e+00 3.730749043776597e+00 4.467493249055780e+00 9.301614192902829e+03 + 3140 1.007076862660630e+00 -5.965252156060949e+00 -6.007617148696273e+00 3.882499579681222e+00 4.639233236007769e+00 9.240442889560381e+03 + 3160 1.073632589572695e+00 -6.054031491915745e+00 -5.988175570421679e+00 3.401162761039406e+00 4.779317653429248e+00 9.180779960820466e+03 + 3180 1.030166609526896e+00 -5.978856982193729e+00 -5.985084017109939e+00 3.840710935495786e+00 4.804954337376373e+00 9.171308501639287e+03 + 3200 1.020630683248332e+00 -5.950649446427690e+00 -6.017463492031761e+00 3.957398786018643e+00 4.573742196719922e+00 9.270722729195708e+03 + 3220 9.968101488815060e-01 -5.896947045257455e+00 -6.010164052361333e+00 4.229104054184100e+00 4.578994479118410e+00 9.248266408994359e+03 + 3240 1.042428406148051e+00 -5.940420358450944e+00 -5.975439308105395e+00 4.005601418669922e+00 4.804517190589120e+00 9.141791687066110e+03 + 3260 1.080066598827196e+00 -5.964930572463833e+00 -5.979451273974031e+00 3.903313057861419e+00 4.819932942718562e+00 9.154080881470041e+03 + 3280 1.072746146537266e+00 -5.920567906594299e+00 -6.040384428456953e+00 4.044621794660398e+00 4.356616784578203e+00 9.341431434208342e+03 + 3300 1.085441613190360e+00 -5.913497649224604e+00 -6.040784403647850e+00 4.101471058690484e+00 4.370570817230624e+00 9.342451133263708e+03 + 3320 1.076712344604172e+00 -5.882368602096050e+00 -5.976627399621725e+00 4.320070893900955e+00 4.778822292006757e+00 9.145409093911379e+03 + 3340 1.093623640378408e+00 -5.898439667333133e+00 -5.961261734807988e+00 4.219166263362994e+00 4.858432230238855e+00 9.098490429666879e+03 + 3360 1.072944271299633e+00 -5.868168079823051e+00 -5.983598523840099e+00 4.349648711679153e+00 4.686829239329781e+00 9.166723610562371e+03 + 3380 1.117417028058658e+00 -5.943277023718887e+00 -5.971003119454888e+00 4.000763826108606e+00 4.841556293793033e+00 9.128192779090085e+03 + 3400 1.037683867890879e+00 -5.843876471677682e+00 -5.989427558972986e+00 4.476469135700259e+00 4.640692268492654e+00 9.184581782035362e+03 + 3420 1.021658763572165e+00 -5.847874001331785e+00 -5.995160526740977e+00 4.484251693906921e+00 4.638509672491197e+00 9.202201969602043e+03 + 3440 1.065258345480367e+00 -5.948706834196946e+00 -6.021101835130653e+00 3.944764126475560e+00 4.529060828024026e+00 9.281956137858011e+03 + 3460 1.031966239432393e+00 -5.942066839140922e+00 -6.009466249572204e+00 3.970214508221928e+00 4.583196663500449e+00 9.246135658337891e+03 + 3480 1.054415802962347e+00 -6.017189121400237e+00 -6.039561024296128e+00 3.495311757239141e+00 4.366848828770149e+00 9.338901754216091e+03 + 3500 1.006713120035035e+00 -5.987115225273905e+00 -6.005650854316645e+00 3.790130531512980e+00 4.683696081170244e+00 9.234350064588838e+03 + 3520 9.694265651904677e-01 -5.963306726200607e+00 -5.966162793792082e+00 3.910760246909794e+00 4.894360264824506e+00 9.113468184892854e+03 + 3540 9.523886622156332e-01 -5.958295393871244e+00 -5.951014673946521e+00 3.993914615308931e+00 5.035721635804457e+00 9.067254570836672e+03 + 3560 9.733982647195688e-01 -6.000797567247605e+00 -6.006092547335903e+00 3.677027906655749e+00 4.646623311593222e+00 9.235746258530027e+03 + 3580 9.738608440074300e-01 -6.009589702599920e+00 -5.993259212848380e+00 3.660396982962986e+00 4.754169182251450e+00 9.196369398150540e+03 + 3600 1.008182083410457e+00 -6.067282747934456e+00 -6.008069012592548e+00 3.324726438250809e+00 4.664740869879974e+00 9.241840845024502e+03 + 3620 1.002095068944762e+00 -6.063250784132899e+00 -5.992218881697625e+00 3.310853870743812e+00 4.718730046678532e+00 9.193189633138662e+03 + 3640 9.629683766275819e-01 -6.007373423042736e+00 -5.974138378824420e+00 3.635931648761555e+00 4.826772415769597e+00 9.137832470439938e+03 + 3660 1.007030923033976e+00 -6.072116412557006e+00 -5.975314120209388e+00 3.288734236995075e+00 4.844587979761419e+00 9.141437924786280e+03 + 3680 9.453196857004574e-01 -5.975910717319501e+00 -6.019637357777501e+00 3.779414660700684e+00 4.528329524515105e+00 9.277403897910148e+03 + 3700 9.996765988317244e-01 -6.049604721879160e+00 -5.971170765744680e+00 3.437491838825863e+00 4.887871752565535e+00 9.128743783552945e+03 + 3720 9.465109335752906e-01 -5.960165110712005e+00 -5.993689640179413e+00 3.930219404439828e+00 4.737716368333798e+00 9.197667412311866e+03 + 3740 9.998547044993243e-01 -6.021687768071473e+00 -6.048088367359931e+00 3.526643281450887e+00 4.375046954857030e+00 9.365263468853485e+03 + 3760 1.018426162079519e+00 -6.030903549796617e+00 -5.993436468656391e+00 3.526410892325625e+00 4.741552670244868e+00 9.196891645020381e+03 + 3780 9.919301478058797e-01 -5.968266890542978e+00 -6.022663169456979e+00 3.831763946607261e+00 4.519412095286113e+00 9.286749062207580e+03 + 3800 1.032802765587220e+00 -5.998284844862726e+00 -6.046348762501665e+00 3.615032409709428e+00 4.339041956759424e+00 9.359889654518405e+03 + 3820 1.009259296190237e+00 -5.930434238432996e+00 -6.010049375019904e+00 4.071052486198413e+00 4.613890051513823e+00 9.247921460503227e+03 + 3840 1.126585385853035e+00 -6.070637489612041e+00 -5.931108859694871e+00 3.331552083578798e+00 5.132747068548887e+00 9.006756904059446e+03 + 3860 9.858165235427868e-01 -5.826058291580198e+00 -6.029707170790079e+00 4.595379584086751e+00 4.425996205101403e+00 9.308414534071862e+03 + 3880 9.918746602449459e-01 -5.802990672416779e+00 -5.986998010402254e+00 4.773592382640776e+00 4.716993772884655e+00 9.177142765501709e+03 + 3900 1.071007285801113e+00 -5.890931339508187e+00 -5.970525541733624e+00 4.325594881923820e+00 4.868552655582372e+00 9.126749130409693e+03 + 3920 1.089491711223534e+00 -5.895780558788224e+00 -5.993777207016893e+00 4.223861574889584e+00 4.661149655828264e+00 9.197953925282025e+03 + 3940 1.048658572352398e+00 -5.818089211285449e+00 -6.028886286520174e+00 4.653984790997178e+00 4.443555364257424e+00 9.305927237018384e+03 + 3960 1.101185247847629e+00 -5.892941942773515e+00 -6.024968922271480e+00 4.258372831016914e+00 4.500253483630549e+00 9.293875687543781e+03 + 3980 1.120313400269944e+00 -5.932846968646495e+00 -6.019595212961144e+00 4.023945209774448e+00 4.525823366672314e+00 9.277298240403734e+03 + 4000 1.091829127582950e+00 -5.918734396430521e+00 -5.985734198674102e+00 4.119797275426038e+00 4.735074042757508e+00 9.173313233656256e+03 + 4020 9.721963004624756e-01 -5.783194037174813e+00 -6.021902596844681e+00 4.757020743483064e+00 4.386319253828455e+00 9.284403214650089e+03 + 4040 1.063373464920160e+00 -5.974536434176336e+00 -6.045427591412041e+00 3.769015665640560e+00 4.361947670422014e+00 9.357007046233530e+03 + 4060 1.015293346186780e+00 -5.966548746963285e+00 -6.006285398183890e+00 3.914527435356471e+00 4.686353434820857e+00 9.236338961582338e+03 + 4080 9.993378842786982e-01 -5.991883149289349e+00 -6.004487612620793e+00 3.703123216914080e+00 4.630746437930532e+00 9.230824719355480e+03 + 4100 9.561151538000644e-01 -5.954860014194095e+00 -6.012220272542246e+00 3.885895556850453e+00 4.556524076944077e+00 9.254585714971439e+03 + 4120 9.408987236223856e-01 -5.946937895081044e+00 -6.003477253968585e+00 4.019013748889695e+00 4.694356000719924e+00 9.227706769291255e+03 + 4140 1.004251879573544e+00 -6.047439193456807e+00 -5.999469157020783e+00 3.364161134212510e+00 4.639612506767302e+00 9.215409979388383e+03 + 4160 9.586432653986863e-01 -5.982433031350787e+00 -6.021278538486745e+00 3.859902493038883e+00 4.636845579741412e+00 9.282466826975768e+03 + 4180 1.019596530380820e+00 -6.075200624225912e+00 -5.972003418600652e+00 3.327443469990194e+00 4.920017794406395e+00 9.131319024056338e+03 + 4200 9.086914438199921e-01 -5.912702595721634e+00 -5.999284005381182e+00 4.175701362648018e+00 4.678537509953052e+00 9.214805411939538e+03 + 4220 9.715150786532474e-01 -6.003188042160390e+00 -5.967304306169579e+00 3.636773451115851e+00 4.842823416165289e+00 9.116939352035424e+03 + 4240 1.005305718437036e+00 -6.046592714837915e+00 -5.941203590097428e+00 3.428614800244865e+00 5.033775463419084e+00 9.037429637655890e+03 + 4260 9.257906715417170e-01 -5.915993439442449e+00 -5.988992329070927e+00 4.082651425180469e+00 4.663480504392084e+00 9.183264967211482e+03 + 4280 9.999548309041966e-01 -6.009850818174981e+00 -5.955710736827855e+00 3.620834930803031e+00 4.931715656048740e+00 9.081585542575438e+03 + 4300 1.021830487647197e+00 -6.020985563180852e+00 -6.013836887115412e+00 3.552511010400049e+00 4.593559814621850e+00 9.259590321663001e+03 + 4320 1.039766526261748e+00 -6.028362336867639e+00 -6.003849233477077e+00 3.588097103167032e+00 4.728855136226136e+00 9.228893642098019e+03 + 4340 1.059382561732061e+00 -6.041040928346275e+00 -6.000815225312564e+00 3.448783252554340e+00 4.679765464281340e+00 9.219566237384897e+03 + 4360 9.601960985591919e-01 -5.879358097120233e+00 -6.027806230706406e+00 4.356576068614383e+00 4.504163913288152e+00 9.302583550401443e+03 + 4380 1.058249279172794e+00 -6.011082182682083e+00 -5.960575171682509e+00 3.632558932859346e+00 4.922578005953594e+00 9.096396761605236e+03 + 4400 1.002980986478341e+00 -5.914417481258615e+00 -5.984633972644812e+00 4.191620143915703e+00 4.788426184409230e+00 9.169933636563908e+03 + 4420 1.082068816461707e+00 -6.017436089080619e+00 -5.983053343078428e+00 3.586038757578460e+00 4.783469805835790e+00 9.165116976022857e+03 + 4440 1.061286486232710e+00 -5.974874890749169e+00 -5.996978928286077e+00 3.859710563955086e+00 4.732785759829409e+00 9.207781248806115e+03 + 4460 1.038420575605546e+00 -5.934923792289783e+00 -6.025381434770757e+00 4.053721441706790e+00 4.534299660306106e+00 9.295149503596334e+03 + 4480 1.086746055791167e+00 -6.005858125526991e+00 -6.019440893004091e+00 3.658459955594631e+00 4.580465602814648e+00 9.276847117278245e+03 + 4500 1.004168006580201e+00 -5.891357210668867e+00 -6.049336854842889e+00 4.245339504612212e+00 4.338195940494049e+00 9.369129634674207e+03 + 4520 1.074376045690063e+00 -6.012947987904671e+00 -5.983343029405423e+00 3.589121564058499e+00 4.759117817113709e+00 9.165986080710611e+03 + 4540 1.065658866546122e+00 -6.026136894492219e+00 -5.952077384549630e+00 3.585952781609784e+00 5.011213948372253e+00 9.070509265396831e+03 + 4560 1.014347533226436e+00 -5.983900639677593e+00 -5.973688214772762e+00 3.746795102680053e+00 4.805436426851234e+00 9.136464519241572e+03 + 4580 1.080895178222875e+00 -6.123232706459804e+00 -5.929630186162070e+00 3.120877493665051e+00 5.232573125107832e+00 9.002296828090088e+03 + 4600 1.023694977760492e+00 -6.082546721213627e+00 -5.982998842510562e+00 3.283069243988292e+00 4.854688568485736e+00 9.164920622509109e+03 + 4620 1.015242909288608e+00 -6.108709820259902e+00 -5.941959479201487e+00 3.116497674912809e+00 5.074003937802107e+00 9.039719718175407e+03 + 4640 9.437963938727322e-01 -6.029091791227970e+00 -5.975115874897527e+00 3.564927016150610e+00 4.874865080466072e+00 9.140801596889612e+03 + 4660 1.032349219695345e+00 -6.180017520349998e+00 -5.940668658696694e+00 2.725226651747389e+00 5.099604854477294e+00 9.035833106021235e+03 + 4680 8.751490224849779e-01 -5.956774824522371e+00 -6.014287728499493e+00 3.945624925148114e+00 4.615376930418346e+00 9.260944839503827e+03 + 4700 9.620283301213486e-01 -6.086762233934897e+00 -5.977006653639287e+00 3.266065562869586e+00 4.896299089548140e+00 9.146596388119653e+03 + 4720 9.288832846089641e-01 -6.033565851287475e+00 -6.002306350916044e+00 3.515603056148436e+00 4.695099944673240e+00 9.224126821863805e+03 + 4740 9.171479947665157e-01 -6.007981814752871e+00 -6.003910283841148e+00 3.643230966849780e+00 4.666610327412265e+00 9.229052171876554e+03 + 4760 9.853995364836978e-01 -6.094701962473504e+00 -5.974474254587436e+00 3.213301259810074e+00 4.903667363669545e+00 9.138862427644885e+03 + 4780 9.490384698113096e-01 -6.022070329756303e+00 -6.021428214332465e+00 3.613064220015441e+00 4.616751346146162e+00 9.282950342019618e+03 + 4800 9.856489968670992e-01 -6.056563941714792e+00 -6.018039145783735e+00 3.373470257286558e+00 4.594685597215588e+00 9.272528922026149e+03 + 4820 9.897056684697090e-01 -6.041354017993713e+00 -5.981655802229364e+00 3.518919709495153e+00 4.861716102683078e+00 9.160827436546373e+03 + 4840 9.512275933944374e-01 -5.962423114536703e+00 -6.021382904494739e+00 3.941539698000876e+00 4.602983460063827e+00 9.282779117091648e+03 + 4860 9.974556488948330e-01 -6.008304304574613e+00 -6.002909434507348e+00 3.646830439109826e+00 4.677808617889510e+00 9.225966721877481e+03 + 4880 1.071064655139168e+00 -6.098181338622992e+00 -5.959279019786360e+00 3.203795283419748e+00 5.001393893244066e+00 9.092454621248857e+03 + 4900 9.704409234167937e-01 -5.932937165041182e+00 -5.983341666542739e+00 4.077860999365625e+00 4.788430551672287e+00 9.165969254440059e+03 + 4920 1.059680802063349e+00 -6.052092435826277e+00 -5.984282167934261e+00 3.422153198810520e+00 4.811530250651517e+00 9.168851646029139e+03 + 4940 9.976110119627312e-01 -5.951119446824801e+00 -6.003892209096567e+00 3.957283656833675e+00 4.654254289310630e+00 9.228993446688221e+03 + 4960 9.754515856461196e-01 -5.913513928462592e+00 -6.061746871802318e+00 4.136522580070434e+00 4.285346080439885e+00 9.407573560105668e+03 + 4980 1.045355579062856e+00 -6.016634841863393e+00 -6.025847765746166e+00 3.585903510377515e+00 4.533001475747270e+00 9.296550655221881e+03 + 5000 9.757168464506525e-01 -5.915662370049439e+00 -6.030359452794837e+00 4.165906739320581e+00 4.507298340880316e+00 9.310464913229451e+03 + 5020 1.010924527008094e+00 -5.969366204432081e+00 -6.033809327852344e+00 3.838693448487930e+00 4.468651061267659e+00 9.321137507991523e+03 + 5040 1.048559112424664e+00 -6.028115724924825e+00 -6.066959224545453e+00 3.522977519302258e+00 4.299932133468471e+00 9.423770270936211e+03 + 5060 1.031725061240572e+00 -6.013183814086882e+00 -6.030091869590448e+00 3.616650222322243e+00 4.519561551107633e+00 9.309659051140223e+03 + 5080 1.011490547826237e+00 -5.994397659536984e+00 -5.953966354534775e+00 3.704962329880044e+00 4.937125139926956e+00 9.076275019279554e+03 + 5100 9.998510673257971e-01 -5.984340965627356e+00 -6.012370532233728e+00 3.767643435423025e+00 4.606693326407823e+00 9.255019995855891e+03 + 5120 1.040691574646468e+00 -6.052579169644728e+00 -5.973184896293180e+00 3.433469573468745e+00 4.889363777277431e+00 9.134908320765669e+03 + 5140 9.530941563442179e-01 -5.930871496783237e+00 -5.995256021530674e+00 4.037184739109076e+00 4.667478834536284e+00 9.202436179321334e+03 + 5160 9.466286786653619e-01 -5.927233285920511e+00 -5.980625460928309e+00 4.140470103086515e+00 4.833883971779358e+00 9.157611049099092e+03 + 5180 9.893774345529118e-01 -5.992872163600977e+00 -5.944770423410557e+00 3.734306613896735e+00 5.010514249790365e+00 9.048278794999967e+03 + 5200 9.989122652156947e-01 -6.005983315413761e+00 -5.968075660677441e+00 3.684872344039691e+00 4.902543963726249e+00 9.119299015050627e+03 + 5220 9.894473034498165e-01 -5.989629378670713e+00 -6.000962221885221e+00 3.724927021705166e+00 4.659852082215644e+00 9.220003678964240e+03 + 5240 9.971788648933735e-01 -6.000014969898450e+00 -5.983900634015466e+00 3.678431402795091e+00 4.770962413120600e+00 9.167695104450562e+03 + 5260 9.880383802563765e-01 -5.983578234475841e+00 -5.976172427753403e+00 3.773413384189942e+00 4.815938672435072e+00 9.144055265842986e+03 + 5280 9.783770157190620e-01 -5.963008888068987e+00 -6.022069406001164e+00 3.816855110166231e+00 4.477720476614055e+00 9.284920980034141e+03 + 5300 1.011596818460412e+00 -6.003750172799442e+00 -6.013112214098848e+00 3.689041184912189e+00 4.635282894999793e+00 9.257357248035451e+03 + 5320 1.059997981633053e+00 -6.063093853469650e+00 -5.986919747911196e+00 3.366118812296346e+00 4.803522314317728e+00 9.176942170936964e+03 + 5340 9.783497976824099e-01 -5.929488288641137e+00 -6.004612595881234e+00 4.032702470814444e+00 4.601327073192834e+00 9.231208711471123e+03 + 5360 1.059745567706651e+00 -6.035030404515558e+00 -5.939953243430296e+00 3.505184553017902e+00 5.051132325112606e+00 9.033602607856410e+03 + 5380 1.014863342614668e+00 -5.948550557313336e+00 -5.972325901094496e+00 3.961143881335394e+00 4.824622178121409e+00 9.132249921902299e+03 + 5400 9.897324472720891e-01 -5.889600958850225e+00 -5.969282641716284e+00 4.285840475903901e+00 4.828295922186413e+00 9.122955462689279e+03 + 5420 1.078236172588016e+00 -5.996725122020378e+00 -5.980336283635626e+00 3.736943020808769e+00 4.831050266978560e+00 9.156767541934090e+03 + 5440 1.084004762944947e+00 -5.983275043051478e+00 -5.983366020347341e+00 3.785085016004242e+00 4.784562610292706e+00 9.166043399978666e+03 + 5460 1.084297857704596e+00 -5.966394586005583e+00 -5.984257122921901e+00 3.861706783670842e+00 4.759137332478693e+00 9.168764419851001e+03 + 5480 1.153904884946485e+00 -6.060333254198593e+00 -5.970304437330078e+00 3.386734019519226e+00 4.903693417892619e+00 9.126122759377435e+03 + 5500 1.077808931407963e+00 -5.945935275087555e+00 -6.053847002352839e+00 3.952932861655575e+00 4.333287024412490e+00 9.383088796157850e+03 + 5520 9.786816592634638e-01 -5.809539653554174e+00 -6.056871941087502e+00 4.689344684602474e+00 4.269124415038306e+00 9.392449300654971e+03 + 5540 1.017367441444998e+00 -5.885321262895590e+00 -6.008598816853474e+00 4.282274636371971e+00 4.574395844405982e+00 9.243452929086670e+03 + 5560 1.052711361242152e+00 -5.962151010836577e+00 -5.977904402783764e+00 3.929488732149212e+00 4.839030317758937e+00 9.149332572700278e+03 + 5580 1.035425238393093e+00 -5.967359900927145e+00 -6.011843502482197e+00 3.849322586420446e+00 4.593890862476246e+00 9.253435065589945e+03 + 5600 1.091397696372464e+00 -6.087413463504488e+00 -5.965079262787088e+00 3.221046605321297e+00 4.923508516996986e+00 9.110152942889883e+03 + 5620 9.871344351288274e-01 -5.970114225847386e+00 -6.021471851996687e+00 3.884573163176955e+00 4.589669726260704e+00 9.283066992292188e+03 + 5640 9.356090245220325e-01 -5.929250743872026e+00 -6.057837391421076e+00 4.090679057663870e+00 4.352314628717824e+00 9.395447721744136e+03 + 5660 9.570236131341587e-01 -5.989829397900140e+00 -6.018915008253314e+00 3.729604022280806e+00 4.562589946649220e+00 9.275199671006494e+03 + 5680 1.006769274817507e+00 -6.084954490916584e+00 -5.976089766181515e+00 3.292537107828805e+00 4.917655204019278e+00 9.143804346081633e+03 + 5700 9.772226525496084e-01 -6.054154103207125e+00 -6.027980248427560e+00 3.456600073305338e+00 4.606894397840540e+00 9.303112449557271e+03 + 5720 1.004681132964730e+00 -6.103537996580522e+00 -5.980211002428537e+00 3.178632718504834e+00 4.886795403716198e+00 9.156395588605385e+03 + 5740 9.629537114872642e-01 -6.046293531496374e+00 -5.980301385354695e+00 3.446842608053926e+00 4.825779723451062e+00 9.156683801735328e+03 + 5760 9.432814310657786e-01 -6.017441989022483e+00 -5.997856050936480e+00 3.633029867370203e+00 4.745495354774160e+00 9.210460024984968e+03 + 5780 9.438639880269430e-01 -6.012985460723320e+00 -6.010682504765166e+00 3.638310316890554e+00 4.651534246383560e+00 9.249850660066708e+03 + 5800 1.013396540903074e+00 -6.105633804982491e+00 -5.983017122842493e+00 3.144377758802217e+00 4.848461722520325e+00 9.164985339179280e+03 + 5820 9.924605588213712e-01 -6.061544550307547e+00 -6.009827671759471e+00 3.381161968027473e+00 4.678128287811613e+00 9.247242714295948e+03 + 5840 9.790768567247068e-01 -6.030616117197404e+00 -6.001454508371686e+00 3.519530007935466e+00 4.686980478557122e+00 9.221531719326957e+03 + 5860 9.865267384262718e-01 -6.028707447766974e+00 -5.959296367723541e+00 3.599082791593898e+00 4.997651954533209e+00 9.092500975018178e+03 + 5880 1.004392276508255e+00 -6.038164096856935e+00 -5.945079514525006e+00 3.541938107758773e+00 5.076444184301268e+00 9.049212008805031e+03 + 5900 9.829846021670952e-01 -5.986019833191618e+00 -5.968206618477462e+00 3.764849623064507e+00 4.867135858539259e+00 9.119695262244757e+03 + 5920 9.951404425776585e-01 -5.980630968966068e+00 -5.976137391136598e+00 3.825038142542648e+00 4.850840961818385e+00 9.143936359961393e+03 + 5940 1.079725312220321e+00 -6.080438292526281e+00 -6.001428032402661e+00 3.270317279673002e+00 4.724006420101069e+00 9.221448861266723e+03 + 5960 9.989169253465102e-01 -5.939895171011616e+00 -6.026045393649169e+00 3.982790120490079e+00 4.488102210401383e+00 9.297192983611458e+03 + 5980 9.783374881607838e-01 -5.894432258850787e+00 -6.041486865680836e+00 4.326536967913803e+00 4.482126658868799e+00 9.344817811866129e+03 + 6000 1.041546319877692e+00 -5.974705612601799e+00 -6.030246193470867e+00 3.815614706266918e+00 4.496692096039618e+00 9.310148842452130e+03 + 6020 1.051890912843227e+00 -5.981522930968983e+00 -6.002336230830966e+00 3.783060230215579e+00 4.663547041560326e+00 9.224219931460868e+03 + 6040 1.046437633435792e+00 -5.968561881988920e+00 -6.015282243198760e+00 3.834808140727155e+00 4.566532596707729e+00 9.263972011743794e+03 + 6060 1.039728880833183e+00 -5.959037025820198e+00 -5.985761787054544e+00 3.923250046454887e+00 4.769792331803838e+00 9.173378181370605e+03 + 6080 1.072441332746860e+00 -6.011392160441919e+00 -5.979704768888013e+00 3.655816589118137e+00 4.837770495028661e+00 9.154836299537148e+03 + 6100 1.018684095824418e+00 -5.942301602409385e+00 -6.027019038936158e+00 3.991129394040049e+00 4.504668763522388e+00 9.300178539178612e+03 + 6120 1.077321872357380e+00 -6.059974814004906e+00 -5.975647366246227e+00 3.425897200241240e+00 4.910118454901943e+00 9.142450846910046e+03 + 6140 9.572651025713240e-01 -5.937997217759268e+00 -5.997908292121036e+00 4.018383218728724e+00 4.674364558534656e+00 9.210623585628760e+03 + 6160 9.437428086284227e-01 -5.988614087691234e+00 -5.955238601319259e+00 3.730600081624487e+00 4.922247289212191e+00 9.080152577679510e+03 + 6180 8.993558712645703e-01 -5.976270306171967e+00 -5.999222734867604e+00 3.770686471983723e+00 4.638890074536516e+00 9.214641427904013e+03 + 6200 1.005502516319027e+00 -6.169504426293264e+00 -5.967201584836466e+00 2.783747729842324e+00 4.945401951750798e+00 9.116649054744739e+03 + 6220 9.143645629047400e-01 -6.058259416269181e+00 -6.002396813551449e+00 3.341686704996195e+00 4.662458414511242e+00 9.224431373030429e+03 + 6240 9.180292769616188e-01 -6.077203530032666e+00 -5.985559911995239e+00 3.221198994539089e+00 4.747430831114052e+00 9.172793988607698e+03 + 6260 9.361532244543671e-01 -6.107968807570139e+00 -5.990173959447031e+00 3.082620076662173e+00 4.759016323278898e+00 9.186907079470320e+03 + 6280 9.169244918505576e-01 -6.074123191940696e+00 -5.966673803722117e+00 3.376217162274156e+00 4.993208177164332e+00 9.115018213151356e+03 + 6300 9.535200288440666e-01 -6.116459456911077e+00 -5.927199422062985e+00 3.068950866784288e+00 5.155711274777767e+00 8.994916798676715e+03 + 6320 9.613177290124841e-01 -6.107179281891756e+00 -5.939951531648578e+00 3.144025915637616e+00 5.104273535944655e+00 9.033638602190102e+03 + 6340 9.905306767367399e-01 -6.118940340932075e+00 -5.959466032124624e+00 3.046515843933387e+00 4.962242003675300e+00 9.093027743636927e+03 + 6360 9.195044884619412e-01 -5.980163506165749e+00 -5.980036732237592e+00 3.814250996041184e+00 4.814978951554864e+00 9.155837004888808e+03 + 6380 9.521204022032809e-01 -5.991538099379107e+00 -5.958431056156011e+00 3.728454124059966e+00 4.918559889545360e+00 9.089862513292219e+03 + 6400 1.018707907979674e+00 -6.051242064607791e+00 -6.005404543330376e+00 3.339034732723152e+00 4.602240873231566e+00 9.233654407248681e+03 + 6420 9.407497928423399e-01 -5.903377523223403e+00 -6.012102398420906e+00 4.218246124971374e+00 4.593931066467254e+00 9.254236770651876e+03 + 6440 9.849100299157684e-01 -5.942937704813716e+00 -6.001027607255208e+00 3.995438044806107e+00 4.661876835603707e+00 9.220214442928758e+03 + 6460 1.070865304036714e+00 -6.049532356078034e+00 -5.982479195741548e+00 3.443919028672649e+00 4.828948651767778e+00 9.163348290350565e+03 + 6480 1.014423973452145e+00 -5.950331077809093e+00 -6.025751133993360e+00 3.911801896728462e+00 4.478728262902427e+00 9.296290736484900e+03 + 6500 1.054343883792371e+00 -5.999675146058478e+00 -5.999572581342661e+00 3.747503623170923e+00 4.748092565640983e+00 9.215711877629525e+03 + 6520 9.879580455720320e-01 -5.895831003709989e+00 -6.038218909782963e+00 4.249775297487751e+00 4.432161906359481e+00 9.334588387667487e+03 + 6540 1.014581840022688e+00 -5.931860340293778e+00 -6.009505015628525e+00 4.056919207461520e+00 4.611071466214722e+00 9.246227498630960e+03 + 6560 1.079115691975294e+00 -6.028066490394108e+00 -5.998251774483101e+00 3.575642241626110e+00 4.746842954199489e+00 9.211675794381028e+03 + 6580 9.909498145204441e-01 -5.902362707862014e+00 -6.019247057253169e+00 4.165647699171476e+00 4.494479677172851e+00 9.276229018258397e+03 + 6600 1.019457493218320e+00 -5.952339796802649e+00 -6.028683887305545e+00 3.902525074647001e+00 4.464145492769551e+00 9.305327661986828e+03 + 6620 1.002956082445952e+00 -5.940935398856265e+00 -6.011796296377248e+00 3.973642188543184e+00 4.566747949289244e+00 9.253297834552495e+03 + 6640 1.034010105212105e+00 -6.007113560478710e+00 -5.978018203045727e+00 3.645221974062047e+00 4.812292018934250e+00 9.149671734008138e+03 + 6660 1.042555111690499e+00 -6.043579367778883e+00 -5.948747092379153e+00 3.466944492727897e+00 5.011486093320335e+00 9.060372779149848e+03 + 6680 9.693288206159477e-01 -5.961949408013727e+00 -5.982692661531932e+00 3.958668718980093e+00 4.839557747270447e+00 9.163954578331099e+03 + 6700 9.501652731260414e-01 -5.960583007119434e+00 -5.980855201421551e+00 3.949934740440664e+00 4.833528663645978e+00 9.158366624263243e+03 + 6720 9.614381634009187e-01 -6.007348896448929e+00 -6.034954041181657e+00 3.606748769686718e+00 4.448235756749052e+00 9.324675206323607e+03 + 6740 9.594738253572362e-01 -6.037485453580036e+00 -6.005346620851628e+00 3.505049222578182e+00 4.689595373572989e+00 9.233453985862467e+03 + 6760 9.321625065563082e-01 -6.027681711734496e+00 -5.972774889542199e+00 3.559434499223746e+00 4.874717969055183e+00 9.133655797604904e+03 + 6780 9.306651908960466e-01 -6.051039835764435e+00 -5.958984978297700e+00 3.435087529701439e+00 4.963680766718587e+00 9.091565776765417e+03 + 6800 9.560581300274191e-01 -6.105567320430523e+00 -5.962754882386369e+00 3.140887487294914e+00 4.960938606697807e+00 9.103057208659622e+03 + 6820 9.635113904575634e-01 -6.126711710079060e+00 -5.980657430914196e+00 3.094450715078799e+00 4.933116987870100e+00 9.157778975190929e+03 + 6840 9.552671459692759e-01 -6.119506842035788e+00 -6.004743295302093e+00 3.063842971815524e+00 4.722833016761859e+00 9.231623746788207e+03 + 6860 9.359675835623258e-01 -6.090100319669534e+00 -5.969200215545214e+00 3.249496486328817e+00 4.943723593441313e+00 9.122748151699549e+03 + 6880 9.458027870708864e-01 -6.094799374890442e+00 -5.970994634339798e+00 3.179946235756467e+00 4.890852214719951e+00 9.128237737498437e+03 + 6900 9.787467483347099e-01 -6.119415746310791e+00 -5.962939559257894e+00 3.053818785004969e+00 4.952329265674395e+00 9.103624544687600e+03 + 6920 9.460049950218078e-01 -6.025587554448097e+00 -5.988831650520934e+00 3.563117778874712e+00 4.774175867182231e+00 9.182782964602371e+03 + 6940 1.021217928965151e+00 -6.071136166007149e+00 -6.001921838686365e+00 3.275596348856908e+00 4.673035727215385e+00 9.222946680297211e+03 + 6960 9.711597655806342e-01 -5.931372903462444e+00 -6.010338909250049e+00 4.074539605009772e+00 4.621104579827440e+00 9.248803802053097e+03 + 6980 1.009093481032663e+00 -5.942710393776651e+00 -5.985948690389844e+00 4.016667187713307e+00 4.768386197455581e+00 9.173956482099673e+03 + 7000 1.002498818114505e+00 -5.904126615547081e+00 -6.012079185901725e+00 4.217945072597616e+00 4.598064708014976e+00 9.254163695766718e+03 + 7020 1.016751810462210e+00 -5.908987088291426e+00 -6.025072709027548e+00 4.191146145764518e+00 4.524564547305959e+00 9.294157555685233e+03 + 7040 1.058157127250388e+00 -5.962289730113469e+00 -6.048309407286286e+00 3.917964750046102e+00 4.424026452217767e+00 9.365934220421901e+03 + 7060 1.005613393312745e+00 -5.883807456672683e+00 -6.077354627941743e+00 4.286676826166834e+00 4.175299017411935e+00 9.456039050603660e+03 + 7080 1.040357681132129e+00 -5.942093401398654e+00 -6.038568043287182e+00 4.012966048905793e+00 4.458993725779284e+00 9.335824668304796e+03 + 7100 1.059819816751772e+00 -5.981914872427253e+00 -5.981032296329150e+00 3.881915442300499e+00 4.886983330834017e+00 9.158903997459436e+03 + 7120 9.828580555396533e-01 -5.883793697499620e+00 -6.007696416816798e+00 4.331494242777085e+00 4.620025654574001e+00 9.240644222187477e+03 + 7140 1.047675115471584e+00 -5.998787368223506e+00 -5.983270987184026e+00 3.702820049178855e+00 4.791917510259753e+00 9.165746988381374e+03 + 7160 1.010496594214760e+00 -5.964892183925705e+00 -6.036084626974207e+00 3.836094633946786e+00 4.427296608967334e+00 9.328163257725235e+03 + 7180 9.707332287557553e-01 -5.930439480074009e+00 -6.047032183940592e+00 4.060456330428669e+00 4.390962982164136e+00 9.362003054842835e+03 + 7200 1.042186728921942e+00 -6.063321280149080e+00 -6.019120892526889e+00 3.362305017288850e+00 4.616110483003354e+00 9.275854019193985e+03 + 7220 9.518454721049487e-01 -5.959084528544982e+00 -6.037029401658884e+00 3.914799062200843e+00 4.467227538850685e+00 9.331085176212033e+03 + 7240 9.658894033754571e-01 -6.006365949457385e+00 -6.004706879926307e+00 3.659004899169161e+00 4.668531533156797e+00 9.231500550126371e+03 + 7260 9.716954402136218e-01 -6.038108694709853e+00 -5.971560551391164e+00 3.563530230196384e+00 4.945659967424191e+00 9.129927028319607e+03 + 7280 9.928310444284584e-01 -6.085965576963126e+00 -5.914651409165964e+00 3.258378325816789e+00 5.242090788089879e+00 8.956904465428192e+03 + 7300 1.030853189965956e+00 -6.151616317720324e+00 -5.940735090869970e+00 2.904476264916390e+00 5.115388903255507e+00 9.036002859372953e+03 + 7320 8.948460086534725e-01 -5.953238733848448e+00 -6.015621522892873e+00 3.966544417310241e+00 4.608332788911740e+00 9.265068667525051e+03 + 7340 9.850518947787603e-01 -6.086842017017735e+00 -5.987366223106482e+00 3.222425493806060e+00 4.793630896273829e+00 9.178308255658276e+03 + 7360 1.031034946032220e+00 -6.150871217997465e+00 -5.958575677607955e+00 2.926367630506823e+00 5.030558381062089e+00 9.090325835971507e+03 + 7380 9.504717002872186e-01 -6.023088656915732e+00 -6.003721824965108e+00 3.568364415112937e+00 4.679571761180979e+00 9.228468454529182e+03 + 7400 9.938308519090427e-01 -6.073183359683384e+00 -5.981305278099306e+00 3.311021066985849e+00 4.838599229528795e+00 9.159741986425757e+03 + 7420 1.009930733075871e+00 -6.075081022937376e+00 -5.975396196325661e+00 3.297761401490151e+00 4.870167102071678e+00 9.141678534967246e+03 + 7440 9.736441665213251e-01 -5.985914145022256e+00 -6.042184023734006e+00 3.733210431756945e+00 4.410100080458489e+00 9.347003706598038e+03 + 7460 1.021604312765205e+00 -6.011219764229052e+00 -6.035378513105234e+00 3.642364883347206e+00 4.503641608745864e+00 9.325978970150041e+03 + 7480 1.056100326328717e+00 -6.009974266967321e+00 -5.999370299081802e+00 3.614157879016557e+00 4.675047503573934e+00 9.215126084853311e+03 + 7500 1.007363868772451e+00 -5.891100777309807e+00 -6.016448917065444e+00 4.318373557797262e+00 4.598605141758455e+00 9.267591713939011e+03 + 7520 1.089762806008584e+00 -5.975878374562923e+00 -6.028952829251605e+00 3.839926237342217e+00 4.535164505274484e+00 9.306139788600980e+03 + 7540 1.012973106967515e+00 -5.839768442679252e+00 -6.091018955356993e+00 4.504169032590799e+00 4.061449707904031e+00 9.498574675590999e+03 + 7560 1.083530570431038e+00 -5.936854462398189e+00 -6.030217517688675e+00 4.053218659128030e+00 4.517113547763945e+00 9.310031259661055e+03 + 7580 1.040424103206520e+00 -5.875511075528949e+00 -6.018045958849482e+00 4.344378035800899e+00 4.525920678572489e+00 9.272498836925623e+03 + 7600 1.085288072866474e+00 -5.950388381029457e+00 -5.982576496087789e+00 3.991246935733240e+00 4.806417797973589e+00 9.163622593627686e+03 + 7620 1.039718684520211e+00 -5.894628474113993e+00 -6.002383320555101e+00 4.259731002922820e+00 4.640985999649388e+00 9.224351534858128e+03 + 7640 1.042586071627145e+00 -5.913308914003086e+00 -6.015341545969797e+00 4.141646690074887e+00 4.555759527823267e+00 9.264194484414133e+03 + 7660 1.060215756013953e+00 -5.959312231108781e+00 -5.978305304245007e+00 3.931060220305807e+00 4.821999055189031e+00 9.150551238863622e+03 + 7680 1.035699906496397e+00 -5.942885159873710e+00 -5.989453403000205e+00 4.000620593546664e+00 4.733218535102000e+00 9.184677665008379e+03 + 7700 1.009615980858888e+00 -5.925206686049202e+00 -5.981626868152309e+00 4.149299634042764e+00 4.825326217411757e+00 9.160725942945523e+03 + 7720 1.014416971583102e+00 -5.953040245075697e+00 -6.048013367249411e+00 3.934439010753561e+00 4.389088646188940e+00 9.365027551199744e+03 + 7740 1.036165532408244e+00 -6.008029857557380e+00 -5.993435792469193e+00 3.624339957250140e+00 4.708141337410785e+00 9.196915537169458e+03 + 7760 1.007852010113247e+00 -5.986043688900468e+00 -6.007735272398434e+00 3.712147391468592e+00 4.587590962261575e+00 9.240805933398660e+03 + 7780 9.839871289128796e-01 -5.968386433557097e+00 -5.993093948846074e+00 3.828243494130702e+00 4.686369117865762e+00 9.195868903008117e+03 + 7800 9.474909311650864e-01 -5.927461600954150e+00 -6.016555661281227e+00 4.099349663299221e+00 4.587757781639865e+00 9.267903673305525e+03 + 7820 1.048438605604947e+00 -6.090001700579502e+00 -5.986517734336616e+00 3.228824574131142e+00 4.823045522389819e+00 9.175722368146386e+03 + 7840 9.250487862157670e-01 -5.920761447908625e+00 -6.004156253034242e+00 4.133449777568130e+00 4.654583901232452e+00 9.229806696702333e+03 + 7860 9.911372459967506e-01 -6.026984064454687e+00 -5.953222784163502e+00 3.557936417604497e+00 4.981485103557715e+00 9.073991445926942e+03 + 7880 9.963964198560328e-01 -6.036501706186205e+00 -5.985332421451309e+00 3.515399037007994e+00 4.809220988376991e+00 9.172062006938484e+03 + 7900 9.723406493460053e-01 -6.001713145150640e+00 -5.991532523476794e+00 3.668371596031432e+00 4.726830301128774e+00 9.191079217436498e+03 + 7920 9.540973117277876e-01 -5.972275101541171e+00 -6.102493394343085e+00 3.775421623559645e+00 4.027688035075367e+00 9.534374456191894e+03 + 7940 9.545742692403106e-01 -5.973347400534109e+00 -6.043731721797710e+00 3.835644086878578e+00 4.431486422244467e+00 9.351792332827028e+03 + 7960 9.727847901504699e-01 -5.999150024032616e+00 -6.038977087917916e+00 3.675509200035209e+00 4.446816035987603e+00 9.337090579596483e+03 + 7980 1.004243730969421e+00 -6.042428896492863e+00 -6.052673403056741e+00 3.499015785486462e+00 4.440190243464407e+00 9.379453642422903e+03 + 8000 1.012258477905718e+00 -6.050600711525896e+00 -6.033290362385436e+00 3.450985167503198e+00 4.550383871035589e+00 9.319545251664364e+03 + 8020 1.011728490139650e+00 -6.046531185536313e+00 -6.013019507037622e+00 3.461357197285424e+00 4.653786441140394e+00 9.257058147785403e+03 + 8040 9.989996303790981e-01 -6.021471235911876e+00 -5.994229820905920e+00 3.594940929090994e+00 4.751365349650541e+00 9.199343244838534e+03 + 8060 9.671757815901910e-01 -5.962221602765267e+00 -6.048273664973887e+00 3.886542549926610e+00 4.392418292211124e+00 9.365836321610950e+03 + 8080 1.020208460272742e+00 -6.021752687843501e+00 -5.993926512261591e+00 3.552375039241109e+00 4.712157245519187e+00 9.198399004924366e+03 + 8100 9.981778009397709e-01 -5.963202012463737e+00 -6.006057337822964e+00 3.904677037904562e+00 4.658595127851719e+00 9.235650734648934e+03 + 8120 1.010239074276646e+00 -5.952746820251543e+00 -6.017577925890014e+00 3.985077027537552e+00 4.612806786380281e+00 9.271087901548155e+03 + 8140 1.016607853097346e+00 -5.931072924400683e+00 -6.016938096863252e+00 4.128315259597166e+00 4.635264151724602e+00 9.269099518328889e+03 + 8160 1.067104860706063e+00 -5.977881125270215e+00 -6.010450667575917e+00 3.826209234939313e+00 4.639189882899588e+00 9.249148478038724e+03 + 8180 1.135940642421255e+00 -6.055040912772896e+00 -5.988820545774976e+00 3.415542052813033e+00 4.795789647683765e+00 9.182771421179992e+03 + 8200 1.056452437837062e+00 -5.921225257420688e+00 -6.034457084922640e+00 4.121465547643301e+00 4.471270871558416e+00 9.323137722040676e+03 + 8220 1.113925903885310e+00 -6.001227537762582e+00 -6.007770578862067e+00 3.659877688918144e+00 4.622306534392560e+00 9.240936124752150e+03 + 8240 1.078517856435575e+00 -5.953492060410785e+00 -5.979739464045510e+00 4.014411018966119e+00 4.863694365522947e+00 9.154939833063012e+03 + 8260 1.117979023678269e+00 -6.024286778702543e+00 -5.924328711175165e+00 3.568164280263094e+00 5.142138972466258e+00 8.986198798695363e+03 + 8280 1.074005991034700e+00 -5.976400387895874e+00 -5.938689721345706e+00 3.796105705354512e+00 5.012646188392366e+00 9.029793612563164e+03 + 8300 9.957096687981000e-01 -5.881088433970347e+00 -5.998957125122426e+00 4.294972166640921e+00 4.618151901924676e+00 9.213816586390252e+03 + 8320 1.034447583534329e+00 -5.965264002386957e+00 -5.983745801699573e+00 3.893830370997175e+00 4.787705019294929e+00 9.167201649599223e+03 + 8340 1.065087501604691e+00 -6.039982967083817e+00 -5.976949152702617e+00 3.488004183312982e+00 4.849954099941081e+00 9.146419365586846e+03 + 8360 1.023533593929409e+00 -6.012718844724199e+00 -6.000612967054978e+00 3.651997625837365e+00 4.721511448792545e+00 9.218933870482979e+03 + 8380 1.037764591524573e+00 -6.067531961837249e+00 -5.992949139127081e+00 3.345345102274758e+00 4.773611211931055e+00 9.195432557250488e+03 + 8400 9.315924296284999e-01 -5.941101451286960e+00 -6.080275983165434e+00 3.970844242549128e+00 4.171682543313727e+00 9.465134894678829e+03 + 8420 9.869458991667961e-01 -6.049644479911886e+00 -5.988453883624965e+00 3.413920544463938e+00 4.765286417557608e+00 9.181605423339453e+03 + 8440 1.031746159244917e+00 -6.134009383321497e+00 -5.945235574251138e+00 2.933521659133599e+00 5.017490083468143e+00 9.049702621681867e+03 + 8460 9.925155791175165e-01 -6.087344565089579e+00 -5.973940658432459e+00 3.229359222348116e+00 4.880542003571135e+00 9.137222659243045e+03 + 8480 9.237768194683385e-01 -5.991546763069630e+00 -6.033401622121576e+00 3.665363716644506e+00 4.425026638949729e+00 9.319875561456594e+03 + 8500 9.545704767401293e-01 -6.038784176793393e+00 -6.022056727098937e+00 3.441093622323465e+00 4.537145227033508e+00 9.284864388150525e+03 + 8520 8.946821667548673e-01 -5.946578495147095e+00 -6.025577314051967e+00 3.989333365882552e+00 4.535709922703064e+00 9.295727544682610e+03 + 8540 1.012435379090851e+00 -6.112735435733456e+00 -5.971562509517301e+00 3.107664427329580e+00 4.918301216102473e+00 9.129975654023896e+03 + 8560 9.878992316678229e-01 -6.066119769781031e+00 -5.999986166440178e+00 3.382021219814443e+00 4.761770604339665e+00 9.217026719039186e+03 + 8580 9.685302014723293e-01 -6.025303504759485e+00 -6.021039648427675e+00 3.563902391840724e+00 4.588386114727610e+00 9.281747287368955e+03 + 8600 1.000242614188331e+00 -6.056009789631392e+00 -6.038568998351090e+00 3.397020324847476e+00 4.497168047332694e+00 9.335843070009472e+03 + 8620 1.007101058771196e+00 -6.050233611417831e+00 -6.005275757554238e+00 3.447108382935594e+00 4.705263337025747e+00 9.233263770125368e+03 + 8640 9.926596022982569e-01 -6.013838583410926e+00 -5.994292182793066e+00 3.668987489427153e+00 4.781225946570625e+00 9.199529637350912e+03 + 8660 9.753719531180020e-01 -5.970341701262394e+00 -6.026199379912557e+00 3.874665397293913e+00 4.553921962536844e+00 9.297653741325003e+03 + 8680 1.074782687566805e+00 -6.097853763719905e+00 -6.005590468478255e+00 3.162340638499193e+00 4.692130757475544e+00 9.234229037818019e+03 + 8700 1.005617251882110e+00 -5.975774042276945e+00 -6.026812750602021e+00 3.832730480661595e+00 4.539658319244419e+00 9.299544786628661e+03 + 8720 1.044011047372157e+00 -6.013880676082564e+00 -5.981691876498203e+00 3.653119053086011e+00 4.837952121500044e+00 9.160933500061130e+03 + 8740 1.022785057904126e+00 -5.959982508245668e+00 -6.035537337172879e+00 3.888404776318141e+00 4.454557256546109e+00 9.326457126686359e+03 + 8760 9.943200577505166e-01 -5.888334100278578e+00 -6.017751555893971e+00 4.333362734967881e+00 4.590227677537760e+00 9.271606281803635e+03 + 8780 1.138742319548021e+00 -6.058640258995050e+00 -6.000320403697350e+00 3.389062852957077e+00 4.723944487044911e+00 9.218049422553368e+03 + 8800 1.092052210262641e+00 -5.928935863782261e+00 -6.022838082625175e+00 4.120415667946348e+00 4.581214596028929e+00 9.287289085700158e+03 + 8820 1.135759260363767e+00 -5.929179256068837e+00 -6.026857353661868e+00 4.074362115504423e+00 4.513479363488484e+00 9.299704746779038e+03 + 8840 1.121726572935529e+00 -5.858050607208816e+00 -6.023926331250714e+00 4.490527140047542e+00 4.538043063413627e+00 9.290634859886797e+03 + 8860 1.163799480109180e+00 -5.892244325673274e+00 -6.031779380810762e+00 4.286266736733428e+00 4.485034857153976e+00 9.314815237120803e+03 + 8880 1.077027190688427e+00 -5.755434151183429e+00 -6.029748294397256e+00 5.028167759630656e+00 4.453013499320397e+00 9.308540743248510e+03 + 8900 1.151985678725246e+00 -5.873201815901925e+00 -6.024131652517024e+00 4.317388511511230e+00 4.450726033350599e+00 9.291238655341736e+03 + 8920 1.102875222674269e+00 -5.820417497895305e+00 -6.035332590723200e+00 4.632016860212458e+00 4.397941139191555e+00 9.325839342001213e+03 + 8940 1.170686397959420e+00 -5.954447328692348e+00 -6.011017320190598e+00 4.009260964094552e+00 4.684427318733706e+00 9.250896304040793e+03 + 8960 1.116558299489435e+00 -5.919422204564552e+00 -6.042714856037228e+00 4.177449547321721e+00 4.469484063089461e+00 9.348649054420734e+03 + 8980 1.093782399482975e+00 -5.931278532925495e+00 -5.998020846490425e+00 4.106344091323497e+00 4.723099398494026e+00 9.210978097172128e+03 + 9000 1.029556567396871e+00 -5.871172309562287e+00 -5.987803978739872e+00 4.465967730880854e+00 4.796250637770687e+00 9.179647528037767e+03 + 9020 1.009823406203204e+00 -5.868740297742549e+00 -5.998662590381961e+00 4.431645869733828e+00 4.685611959988513e+00 9.212910075716196e+03 + 9040 1.093660700864974e+00 -6.017124359938343e+00 -5.995152102151873e+00 3.601202565057382e+00 4.727370669463197e+00 9.202165847216464e+03 + 9060 1.002615093840386e+00 -5.905381854008013e+00 -6.011631061226547e+00 4.169629858284694e+00 4.559530468424193e+00 9.252761555959909e+03 + 9080 1.009480890507454e+00 -5.937095512294461e+00 -5.973602416337368e+00 4.083766029288963e+00 4.874137736849455e+00 9.136160787721135e+03 + 9100 9.926992799928857e-01 -5.931691460053030e+00 -5.970308251239895e+00 4.103659474243251e+00 4.881915883319152e+00 9.126092891105462e+03 + 9120 1.001959434151317e+00 -5.963363822316613e+00 -5.970192794759989e+00 3.932436086047084e+00 4.893223069497149e+00 9.125741670749139e+03 + 9140 1.034937632598562e+00 -6.029604865528968e+00 -6.000855379829725e+00 3.597262059793986e+00 4.762346055647578e+00 9.219679282939271e+03 + 9160 9.952568455848112e-01 -5.990218783821075e+00 -6.008576367607411e+00 3.743770375534544e+00 4.638358288606493e+00 9.243409167863103e+03 + 9180 9.677511903913248e-01 -5.967193866894939e+00 -5.976591341531845e+00 3.899252384207249e+00 4.845290630587630e+00 9.145322491866891e+03 + 9200 1.013208125344860e+00 -6.050627079224326e+00 -5.967247939554268e+00 3.481666039052632e+00 4.960441961918269e+00 9.116763466224924e+03 + 9220 9.537951443020047e-01 -5.975982453248433e+00 -6.013292846329843e+00 3.847978332667470e+00 4.633736281829339e+00 9.257891196415771e+03 + 9240 1.026385895331382e+00 -6.097812486661910e+00 -6.012633246948617e+00 3.150686836341297e+00 4.639799212219772e+00 9.255872228387383e+03 + 9260 9.952007877194865e-01 -6.064415678336472e+00 -6.006927355112740e+00 3.366550789752613e+00 4.696657637992549e+00 9.238327677154941e+03 + 9280 9.919618726159793e-01 -6.070707203371811e+00 -5.977251150972430e+00 3.384637773678713e+00 4.921276888833323e+00 9.147342041644095e+03 + 9300 9.701851505152759e-01 -6.046404177253374e+00 -5.986127210159029e+00 3.434451267875929e+00 4.780570940762166e+00 9.174512181139607e+03 + 9320 9.387965154534705e-01 -6.005444480720042e+00 -6.021597823603404e+00 3.670695257546362e+00 4.577940262988365e+00 9.283457133715476e+03 + 9340 9.874783347088840e-01 -6.081507260446741e+00 -6.032617733805425e+00 3.226898566325981e+00 4.507629793930217e+00 9.317431734523572e+03 + 9360 9.190501573570268e-01 -5.982238740304129e+00 -6.012701790913839e+00 3.794206734742646e+00 4.619283183999841e+00 9.256061148029617e+03 + 9380 9.359257066728851e-01 -6.003750631301298e+00 -5.984534162702907e+00 3.653528156946607e+00 4.763872093377469e+00 9.169606749833063e+03 + 9400 9.958722565418563e-01 -6.078551933176087e+00 -5.979442652587870e+00 3.253432192816212e+00 4.822533019065359e+00 9.154052662736565e+03 + 9420 1.024211416476011e+00 -6.096380757797624e+00 -5.988779968626462e+00 3.171930607287572e+00 4.789790989876694e+00 9.182632666514812e+03 + 9440 1.034521700193158e+00 -6.080466065351087e+00 -5.973995331343151e+00 3.225543777112403e+00 4.836915208078809e+00 9.137412029225439e+03 + 9460 1.012379772002706e+00 -6.007641121488699e+00 -5.975894242700327e+00 3.656101760398049e+00 4.838397251214499e+00 9.143205737511398e+03 + 9480 9.879023246181512e-01 -5.929325849524712e+00 -6.025173163178639e+00 4.069944809158377e+00 4.519574701833675e+00 9.294495126289899e+03 + 9500 1.041111812723053e+00 -5.967702435480341e+00 -6.033988733339302e+00 3.831607935866256e+00 4.450981755788658e+00 9.321691025544878e+03 + 9520 1.047484630139405e+00 -5.946215850088573e+00 -6.008834284070519e+00 3.965661614976770e+00 4.606096876881095e+00 9.244159897614883e+03 + 9540 1.091088305830229e+00 -5.989153254415805e+00 -5.996884763651746e+00 3.782878968264118e+00 4.738483445784158e+00 9.207481228538094e+03 + 9560 1.083276511264488e+00 -5.966211101003869e+00 -5.996948602514702e+00 3.867515823525912e+00 4.691016333237722e+00 9.207676218409555e+03 + 9580 1.017169099749810e+00 -5.863540739833284e+00 -6.048047060126060e+00 4.433126799122403e+00 4.373662955740493e+00 9.365109528161367e+03 + 9600 1.061260902706465e+00 -5.932901184899079e+00 -6.015126944076611e+00 3.998319674021628e+00 4.526166640429132e+00 9.263529553180271e+03 + 9620 1.035081741705939e+00 -5.901364742335772e+00 -6.019292494672020e+00 4.218902022634197e+00 4.541742619458765e+00 9.276286999071146e+03 + 9640 1.122426643453385e+00 -6.045621536420263e+00 -5.996546157933918e+00 3.428958124990193e+00 4.710756542649061e+00 9.206468004867227e+03 + 9660 1.043703867218134e+00 -5.952611700164081e+00 -6.015387355635579e+00 3.919769116767270e+00 4.559301588548639e+00 9.264347172696906e+03 + 9680 1.096148164487773e+00 -6.059219452763040e+00 -5.989326599193350e+00 3.413658301263333e+00 4.814993882344628e+00 9.184333620465593e+03 + 9700 9.607280397378312e-01 -5.891773652972197e+00 -6.032280798261480e+00 4.274197985754116e+00 4.467384214092587e+00 9.316433448982527e+03 + 9720 1.045245860543595e+00 -6.050647842315002e+00 -5.998493887302433e+00 3.398734903312541e+00 4.698210983793166e+00 9.212414202317817e+03 + 9740 1.006121016096058e+00 -6.019557538214365e+00 -5.999714365232612e+00 3.577392670580473e+00 4.691335240562796e+00 9.216175522590778e+03 + 9760 9.978789653408975e-01 -6.030361754024232e+00 -5.971847870172142e+00 3.533504008248505e+00 4.869499784321464e+00 9.130840628523909e+03 + 9780 9.823762561452597e-01 -6.022963664555407e+00 -5.950504683563046e+00 3.550612522134862e+00 4.966683203984072e+00 9.065751808457422e+03 + 9800 9.732680572318851e-01 -6.015949388232504e+00 -5.985618556644621e+00 3.622882776264145e+00 4.797047104922790e+00 9.172951361430429e+03 + 9820 1.041025810369076e+00 -6.119644972017258e+00 -5.999368448119620e+00 3.062961648836695e+00 4.753608061788851e+00 9.215118726224522e+03 + 9840 9.294372549399544e-01 -5.956322729176466e+00 -6.017943557495133e+00 3.876312694818813e+00 4.522476362820665e+00 9.272204555654185e+03 + 9860 9.460294108613490e-01 -5.979261739470184e+00 -5.955076404217027e+00 3.841013347910597e+00 4.979889285602760e+00 9.079656598372037e+03 + 9880 1.036756019088814e+00 -6.107252072569871e+00 -6.026037013169002e+00 3.101819027136038e+00 4.568168466205647e+00 9.297152037446082e+03 + 9900 8.878229505896857e-01 -5.881079542378245e+00 -6.055187534881963e+00 4.340246210532168e+00 4.340491174451060e+00 9.387249390762987e+03 + 9920 9.618062732219242e-01 -5.985668341402605e+00 -5.996932366933933e+00 3.801410610814624e+00 4.736730833111421e+00 9.207623663313429e+03 + 9940 1.038836830858150e+00 -6.091515943718913e+00 -5.975562981387544e+00 3.255966426098923e+00 4.921786279468573e+00 9.142185471548897e+03 + 9960 1.016903338849936e+00 -6.049850604794574e+00 -6.015891554530967e+00 3.429849055044154e+00 4.624847176803829e+00 9.265917510458596e+03 + 9980 1.034748402765150e+00 -6.069020288003499e+00 -5.976744892202777e+00 3.371319227566136e+00 4.901178829825232e+00 9.145804547576199e+03 + 10000 9.984994206490150e-01 -6.006600178899083e+00 -5.989647913281131e+00 3.666362392096620e+00 4.763704924629525e+00 9.185308218479915e+03 + 10020 9.851108337492883e-01 -5.974881777532757e+00 -5.980067177661095e+00 3.896879954653299e+00 4.867104584678305e+00 9.155970505793390e+03 + 10040 1.007505633266816e+00 -5.993796855249520e+00 -6.034841277453326e+00 3.700480417625615e+00 4.464796993727552e+00 9.324308634995754e+03 + 10060 1.028693196520807e+00 -6.012507850738915e+00 -6.006098042431858e+00 3.635932532205734e+00 4.672738643419489e+00 9.235778865066719e+03 + 10080 1.059658709662737e+00 -6.046463641895166e+00 -6.004293180309256e+00 3.474485411308702e+00 4.716634727592833e+00 9.230207422946185e+03 + 10100 1.003774229599662e+00 -5.948005022878164e+00 -6.042902663994946e+00 4.005925248061164e+00 4.461008307406104e+00 9.349201993444954e+03 + 10120 1.025789726975146e+00 -5.964124677045945e+00 -6.044093430515735e+00 3.913324618185590e+00 4.454131660637449e+00 9.352891260791657e+03 + 10140 1.010973540578409e+00 -5.923903070213691e+00 -6.019673001505894e+00 4.120007027565063e+00 4.570081261736262e+00 9.277526389840537e+03 + 10160 1.023248098050766e+00 -5.918558372958229e+00 -6.016066434182749e+00 4.202663932814021e+00 4.642757555939119e+00 9.266421208403395e+03 + 10180 1.042219862874707e+00 -5.921611217644643e+00 -6.016734444646033e+00 4.166356050392580e+00 4.620143760678796e+00 9.268494111422720e+03 + 10200 1.118393306770505e+00 -6.007367443615957e+00 -6.019238775247340e+00 3.655882328798441e+00 4.587715305488407e+00 9.276204687869969e+03 + 10220 1.037211644339839e+00 -5.863600721065480e+00 -6.038511368413548e+00 4.443646755948876e+00 4.439282751541072e+00 9.335641174439026e+03 + 10240 1.125540439354577e+00 -5.974979746613246e+00 -5.956887860611890e+00 3.927448589507544e+00 5.031334998637639e+00 9.085151969005985e+03 + 10260 1.117498548008918e+00 -5.950132348349095e+00 -6.002917684786300e+00 3.930202019245598e+00 4.627100448918755e+00 9.226015458222084e+03 + 10280 1.085808626554846e+00 -5.899561036147876e+00 -6.028583959959111e+00 4.221027053309455e+00 4.480157458552413e+00 9.305004575208241e+03 + 10300 1.119415502370355e+00 -5.957820211144199e+00 -6.044403279795012e+00 3.844801835810768e+00 4.347628456931226e+00 9.353864885044042e+03 + 10320 1.062593396092369e+00 -5.898306978047894e+00 -6.050812164929608e+00 4.219155914897834e+00 4.343447531721631e+00 9.373642986475477e+03 + 10340 1.022711378720038e+00 -5.874727217571833e+00 -5.993243637825312e+00 4.335597474503672e+00 4.655057849051433e+00 9.196325960451750e+03 + 10360 1.023037598649729e+00 -5.917175816199303e+00 -6.012477377814767e+00 4.168098783395341e+00 4.620862468730354e+00 9.255361962769231e+03 + 10380 1.008303988680454e+00 -5.940833610345277e+00 -6.023188543271370e+00 4.015532889359511e+00 4.542638120113204e+00 9.288363142607437e+03 + 10400 1.054560645643758e+00 -6.049460900458026e+00 -5.994139217481457e+00 3.404614050194293e+00 4.722279714848531e+00 9.199064018869454e+03 + 10420 9.691922764701637e-01 -5.956838384668929e+00 -6.012122238042028e+00 3.944787735223039e+00 4.627339294006039e+00 9.254289984139477e+03 + 10440 9.931230087591062e-01 -6.017792880356016e+00 -5.931605114781473e+00 3.632769235906584e+00 5.127672723349226e+00 9.008265153997612e+03 + 10460 9.562678635059454e-01 -5.978752782659028e+00 -5.962629194346910e+00 3.783661010205789e+00 4.876245149411203e+00 9.102667321868223e+03 + 10480 9.663112241381656e-01 -6.002303977197318e+00 -5.979517120675430e+00 3.699528945063555e+00 4.830374601466886e+00 9.154266264594085e+03 + 10500 9.981264873125600e-01 -6.053577148945060e+00 -5.975043743856378e+00 3.412923592840193e+00 4.863874557864571e+00 9.140589870069365e+03 + 10520 9.696919377302500e-01 -6.014968254913319e+00 -5.991303911008362e+00 3.597990757708996e+00 4.733875082456636e+00 9.190358226420247e+03 + 10540 9.559557766884813e-01 -5.995502786996037e+00 -5.977419908880790e+00 3.671118744931031e+00 4.774953429385130e+00 9.147841756688696e+03 + 10560 9.197307537856222e-01 -5.937959720388442e+00 -5.962373741798588e+00 4.094607818688843e+00 4.954418729694181e+00 9.101854762735600e+03 + 10580 9.975861726675496e-01 -6.043977724375615e+00 -5.957843123863436e+00 3.490794787350597e+00 4.985392992777881e+00 9.088067093036254e+03 + 10600 1.026819056244318e+00 -6.072506858844783e+00 -5.957374841250497e+00 3.354736343431122e+00 5.015842205079656e+00 9.086665906544347e+03 + 10620 9.214557791007064e-01 -5.898299097817215e+00 -6.061327607717842e+00 4.170981548226254e+00 4.234846615796479e+00 9.406261959693711e+03 + 10640 9.627495565880440e-01 -5.940181065478112e+00 -6.013053913224126e+00 4.013938882552422e+00 4.595491713758067e+00 9.257161203701642e+03 + 10660 1.056126749278196e+00 -6.057449058005408e+00 -5.962385073100544e+00 3.382933846526166e+00 4.928805958954017e+00 9.101951259092571e+03 + 10680 1.029495670252706e+00 -5.994633643461212e+00 -6.005955940385111e+00 3.726074635494272e+00 4.661060254437453e+00 9.235340120936957e+03 + 10700 1.039121460643558e+00 -5.985437606561888e+00 -5.986145317798027e+00 3.759752672247453e+00 4.755688884811583e+00 9.174564263220094e+03 + 10720 1.076830867408513e+00 -6.015848259973812e+00 -5.950336991928004e+00 3.607612852195457e+00 4.983788691150457e+00 9.065212342431018e+03 + 10740 1.016202328145503e+00 -5.898157011859024e+00 -5.987169259733083e+00 4.237898314759217e+00 4.726776212865534e+00 9.177687594081841e+03 + 10760 1.068078512654131e+00 -5.943778356654711e+00 -6.013856118877746e+00 3.977487254523228e+00 4.575089899339902e+00 9.259644478772056e+03 + 10780 1.065462406204430e+00 -5.910458201703106e+00 -6.048994797055880e+00 4.108768354887745e+00 4.313269785903276e+00 9.368029711176088e+03 + 10800 1.124079978813171e+00 -5.971183160612850e+00 -6.005504434004209e+00 3.859667564844583e+00 4.662589501831509e+00 9.233917393201002e+03 + 10820 1.094246965279270e+00 -5.903007153775795e+00 -6.023941640363835e+00 4.217649496503872e+00 4.523224959964034e+00 9.290684940347754e+03 + 10840 1.036831329218040e+00 -5.799877327217703e+00 -6.063788162391363e+00 4.713403407355159e+00 4.197986551718252e+00 9.413891651442000e+03 + 10860 1.044655193573991e+00 -5.800938571010285e+00 -6.051881099261248e+00 4.772274358793347e+00 4.331323528345576e+00 9.376997201183980e+03 + 10880 1.124112862968799e+00 -5.917601014836281e+00 -6.055844385269884e+00 4.106187755911050e+00 4.312372929788868e+00 9.389218797829870e+03 + 10900 1.077387991827628e+00 -5.861645880125255e+00 -6.056176991432302e+00 4.426782155093280e+00 4.309754410376027e+00 9.390315748361112e+03 + 10920 1.169797992334755e+00 -6.034864483419414e+00 -6.000484901182565e+00 3.484207326877281e+00 4.681620208304421e+00 9.218523850506726e+03 + 10940 1.042796849782627e+00 -5.901389506994596e+00 -6.007608007336572e+00 4.241784099971941e+00 4.631861033748509e+00 9.240393082720917e+03 + 10960 1.016270753139657e+00 -5.921829170238494e+00 -5.981686269197214e+00 4.104652558016708e+00 4.760943832939614e+00 9.160922630475716e+03 + 10980 1.020959050938291e+00 -5.975906510316869e+00 -5.991670903589995e+00 3.793817051319277e+00 4.703295465613014e+00 9.191488642756658e+03 + 11000 1.055544433330639e+00 -6.064185316644144e+00 -5.964035730769369e+00 3.411266660628330e+00 4.986341080819615e+00 9.106945257096446e+03 + 11020 9.386633408299155e-01 -5.918852407237668e+00 -5.981313136409038e+00 4.145253259115609e+00 4.786594086447000e+00 9.159762034968173e+03 + 11040 1.003913117468434e+00 -6.035415674516419e+00 -5.961249686162828e+00 3.535016755069509e+00 4.960889337345435e+00 9.098463571331144e+03 + 11060 1.006087125885276e+00 -6.054127815862659e+00 -5.985551353871114e+00 3.347494319971502e+00 4.741270976900150e+00 9.172746772434743e+03 + 11080 9.548088766076680e-01 -5.991024488118587e+00 -5.992929283384212e+00 3.741345946701323e+00 4.730408317519987e+00 9.195372111167528e+03 + 11100 9.605747048778263e-01 -6.009317824307352e+00 -5.977393474483607e+00 3.627952683645830e+00 4.811267240610947e+00 9.147777205772856e+03 + 11120 9.371575242362759e-01 -5.978511463158938e+00 -6.000441342761206e+00 3.807437032587885e+00 4.681512270273758e+00 9.218401112068268e+03 + 11140 1.054586794945487e+00 -6.153420818107269e+00 -5.980397706095547e+00 2.847777999705193e+00 4.841303484116549e+00 9.156997786295657e+03 + 11160 9.644018104064676e-01 -6.019512757497020e+00 -6.015954240864851e+00 3.581406875197081e+00 4.601840428377667e+00 9.266103733200795e+03 + 11180 9.810890694815781e-01 -6.040645909295389e+00 -6.013698312806616e+00 3.474833868656902e+00 4.629571137822516e+00 9.259164509898741e+03 + 11200 9.487046495259399e-01 -5.986721593521511e+00 -5.981879824476934e+00 3.763571624342837e+00 4.791373811458136e+00 9.161518348392448e+03 + 11220 9.859079532350460e-01 -6.032479828763271e+00 -5.970035396144976e+00 3.547010091389429e+00 4.905575686728399e+00 9.125286920763130e+03 + 11240 9.768596978375125e-01 -6.002050746507216e+00 -6.009093916877307e+00 3.684331879434569e+00 4.643888905242408e+00 9.244982775917779e+03 + 11260 1.000431019361460e+00 -6.017516860468419e+00 -6.017820795995877e+00 3.542066395090113e+00 4.540321150257580e+00 9.271841222513038e+03 + 11280 9.661017669476601e-01 -5.944098952712189e+00 -6.014545877349188e+00 3.987855231649211e+00 4.583338088757205e+00 9.261728149348497e+03 + 11300 9.706164279367708e-01 -5.921863814907089e+00 -5.983741477025912e+00 4.106117125345909e+00 4.750806013922356e+00 9.167207428666130e+03 + 11320 1.013985310373838e+00 -5.952034579557037e+00 -6.012188121117321e+00 3.971445448946632e+00 4.626034504577015e+00 9.254497076981568e+03 + 11340 1.050277027360306e+00 -5.973505128679848e+00 -6.036344390230028e+00 3.838136179321394e+00 4.477303415155969e+00 9.328933998630973e+03 + 11360 1.067212651981315e+00 -5.971773862689867e+00 -6.018353652719678e+00 3.856266257445431e+00 4.588797894895046e+00 9.273476522414045e+03 + 11380 1.081779181886474e+00 -5.971111422259604e+00 -6.056435791642803e+00 3.833896705624649e+00 4.343950972722828e+00 9.391122224738248e+03 + 11400 1.097403093526767e+00 -5.981373031483263e+00 -6.053478007646010e+00 3.732294638435476e+00 4.318256707099984e+00 9.381955171022511e+03 + 11420 1.029033935210177e+00 -5.876823839184764e+00 -6.047808775595789e+00 4.388816997860358e+00 4.406995033154857e+00 9.364387828387156e+03 + 11440 1.059217126642086e+00 -5.927703644184177e+00 -5.988665493414898e+00 4.151894670762655e+00 4.801842298664175e+00 9.182268187862921e+03 + 11460 1.028696277919683e+00 -5.896133388195913e+00 -5.978350802918429e+00 4.261896892787568e+00 4.789791774347069e+00 9.150647239846912e+03 + 11480 1.050916689029432e+00 -5.948785306511120e+00 -5.980145800430473e+00 3.951379958420772e+00 4.771303149315096e+00 9.156191465409578e+03 + 11500 1.060655903931912e+00 -5.993846189671455e+00 -5.991169714237948e+00 3.721989933494625e+00 4.737358669617055e+00 9.189911092753464e+03 + 11520 1.009664368787817e+00 -5.961602559262605e+00 -5.971210048487654e+00 3.902429375990025e+00 4.847261686105642e+00 9.128861688595483e+03 + 11540 1.009981993799828e+00 -6.014853923912263e+00 -5.969874505672382e+00 3.648191756590710e+00 4.906470536666584e+00 9.124781548298022e+03 + 11560 9.653157363217941e-01 -6.002311087073635e+00 -6.020526032257248e+00 3.669083539544142e+00 4.564490505546179e+00 9.280184264787636e+03 + 11580 9.827024786170135e-01 -6.073302048756975e+00 -6.022120826929208e+00 3.281020027651540e+00 4.574910523655061e+00 9.285097316141888e+03 + 11600 9.531938091622449e-01 -6.056863872033605e+00 -5.996534954418502e+00 3.422905128952865e+00 4.769323109768619e+00 9.206412537218959e+03 + 11620 9.752829218495953e-01 -6.102706099653068e+00 -5.975714444420897e+00 3.162138491246283e+00 4.891344227484538e+00 9.142658431130356e+03 + 11640 9.259220074579443e-01 -6.033042367536347e+00 -5.991662667582348e+00 3.536632262043902e+00 4.774240902667637e+00 9.191449839013008e+03 + 11660 9.587523444204059e-01 -6.078531104525986e+00 -5.983323876814975e+00 3.273942120753274e+00 4.820636755540773e+00 9.165926621384979e+03 + 11680 9.573196814752961e-01 -6.068884248620989e+00 -6.013927042748625e+00 3.304211671979201e+00 4.619784452698442e+00 9.259860967701119e+03 + 11700 9.016201059758417e-01 -5.975496682964903e+00 -6.000175548166907e+00 3.817124643933108e+00 4.675414780901155e+00 9.217584079303042e+03 + 11720 9.906638503361345e-01 -6.092308948784274e+00 -5.980059235447971e+00 3.154493149449595e+00 4.799048374013648e+00 9.155952914969155e+03 + 11740 9.776391605190644e-01 -6.051225747319669e+00 -5.980727140814255e+00 3.453354005041947e+00 4.858167913220131e+00 9.157993178995952e+03 + 11760 9.745887845529185e-01 -6.023410256967221e+00 -6.017995453713411e+00 3.528159904396655e+00 4.559252542618125e+00 9.272381558265204e+03 + 11780 9.369199809960895e-01 -5.944047179422365e+00 -6.029829131973734e+00 3.943517232460340e+00 4.450943986196127e+00 9.308841946193925e+03 + 11800 9.772189735715376e-01 -5.978606264826636e+00 -6.060631210010444e+00 3.795017903978089e+00 4.324017975413422e+00 9.404101905965301e+03 + 11820 1.018430229912655e+00 -6.017150052048595e+00 -6.024259097919700e+00 3.590994791336468e+00 4.550173549823290e+00 9.291681938554253e+03 + 11840 9.622632429653328e-01 -5.913153099233442e+00 -6.000605277389734e+00 4.182148865023239e+00 4.679984924868983e+00 9.218898694165218e+03 + 11860 1.065063540437112e+00 -6.046399070708226e+00 -5.992611792411036e+00 3.426711501985380e+00 4.735566377522261e+00 9.194382906277740e+03 + 11880 1.002502760808567e+00 -5.938081502795338e+00 -6.015167050488839e+00 4.086942765212848e+00 4.644305621406813e+00 9.263642976598003e+03 + 11900 1.048416567394966e+00 -5.993809541110108e+00 -5.979874734672318e+00 3.757607069452106e+00 4.837622884422226e+00 9.155376533015546e+03 + 11920 1.045314677798976e+00 -5.980027549548176e+00 -6.015840351682799e+00 3.741390712115300e+00 4.535748060245073e+00 9.265722452117601e+03 + 11940 9.879107710303084e-01 -5.889660942584376e+00 -5.988803712985581e+00 4.312216907237365e+00 4.742923777299514e+00 9.182684228239719e+03 + 11960 1.030885496599534e+00 -5.949297188635499e+00 -6.020666668236100e+00 3.939600913374911e+00 4.529786317116989e+00 9.280589144309221e+03 + 11980 1.050274073229787e+00 -5.977785872258659e+00 -5.989794601627848e+00 3.756385867081570e+00 4.687429884698821e+00 9.185747709900292e+03 + 12000 1.020725896371546e+00 -5.939522719490583e+00 -5.999362443031330e+00 4.043259586181069e+00 4.699650633442807e+00 9.215059346518627e+03 + 12020 1.068033529351182e+00 -6.021079976247308e+00 -5.978271592568855e+00 3.587617701140103e+00 4.833430064797746e+00 9.150451931296786e+03 + 12040 1.050892785066724e+00 -6.016796002115467e+00 -6.014501248167917e+00 3.535815017275052e+00 4.548991849553905e+00 9.261622652833232e+03 + 12060 9.658500762597488e-01 -5.925402848315420e+00 -6.028876818442834e+00 4.063100091859031e+00 4.468936542842290e+00 9.305911645168475e+03 + 12080 1.045958879576089e+00 -6.095161631829183e+00 -5.932352547076914e+00 3.252210579925705e+00 5.187085539197672e+00 9.010545616699797e+03 + 12100 9.570018742982238e-01 -6.017819053404588e+00 -6.009151438493580e+00 3.636424460120083e+00 4.686195246248160e+00 9.245169688714950e+03 + 12120 9.433342389461870e-01 -6.044534140975789e+00 -5.994549947606646e+00 3.434649004227996e+00 4.721665977582541e+00 9.200322813828034e+03 + 12140 9.462687305885389e-01 -6.079508454970265e+00 -5.960559199110566e+00 3.283321147599708e+00 4.966346182083953e+00 9.096363772321780e+03 + 12160 8.910896609733795e-01 -6.014494650383254e+00 -5.978704190894199e+00 3.706088487906533e+00 4.911602844848396e+00 9.151781155649049e+03 + 12180 9.568152034725037e-01 -6.118235388188965e+00 -5.995325683641637e+00 3.053174488729216e+00 4.758941032455281e+00 9.202725599076035e+03 + 12200 9.471491390131267e-01 -6.103241373287179e+00 -5.958680539586132e+00 3.164452874415270e+00 4.994543552243394e+00 9.090652684233850e+03 + 12220 9.516127978497880e-01 -6.102284960556728e+00 -5.962069908771221e+00 3.117276333393444e+00 4.922412858954965e+00 9.100994608449209e+03 + 12240 9.895284848741711e-01 -6.143789147630965e+00 -5.986276521334877e+00 2.924220948951471e+00 4.828682824143753e+00 9.174956395488045e+03 + 12260 9.229758221131442e-01 -6.026514993302938e+00 -5.901247746120077e+00 3.662999352274793e+00 5.382303270642637e+00 8.916361558326858e+03 + 12280 8.874285471993554e-01 -5.947033519904397e+00 -5.940755265351851e+00 4.068534731052413e+00 5.104585440249886e+00 9.036042800012468e+03 + 12300 9.122181307090483e-01 -5.948362085166613e+00 -6.019812651288089e+00 3.955232354070918e+00 4.544952146462025e+00 9.277952346029193e+03 + 12320 1.062527964817957e+00 -6.136630469711283e+00 -5.975825483495633e+00 2.987508013985336e+00 4.910875129326797e+00 9.142992737561446e+03 + 12340 9.431794986015637e-01 -5.930461687191942e+00 -6.041480279179327e+00 4.094796845458520e+00 4.457310910195370e+00 9.344804450824277e+03 + 12360 1.019039083746880e+00 -6.020873271870316e+00 -6.038743040939598e+00 3.500822665473204e+00 4.398211686139561e+00 9.336369508485508e+03 + 12380 1.029484715546167e+00 -6.020074457926896e+00 -6.012962149384893e+00 3.590573499164287e+00 4.631413475438657e+00 9.256887430092194e+03 + 12400 9.917700965792271e-01 -5.954213673838062e+00 -5.996921747288610e+00 3.929721039863783e+00 4.684484673057730e+00 9.207614570720825e+03 + 12420 9.481275080566788e-01 -5.882600124019753e+00 -6.002331039849366e+00 4.332414128745494e+00 4.644900681752511e+00 9.224161961006477e+03 + 12440 9.954148179874700e-01 -5.946104601502890e+00 -5.915552605421094e+00 4.020635664595039e+00 5.196069954002829e+00 8.959604254082707e+03 + 12460 1.031638274520333e+00 -5.990231671001813e+00 -5.958309522009293e+00 3.775038626206746e+00 4.958340545658388e+00 9.089490214231828e+03 + 12480 1.014848719406440e+00 -5.958913525150632e+00 -5.992104446820566e+00 3.891686521244034e+00 4.701099112736745e+00 9.192800416655562e+03 + 12500 1.039211560876270e+00 -5.990155825859240e+00 -6.014682230339302e+00 3.736340173533593e+00 4.595505763560249e+00 9.262182369176380e+03 + 12520 1.053907238681274e+00 -6.011484142939248e+00 -6.021205813593180e+00 3.651517404623368e+00 4.595694067304821e+00 9.282257219573410e+03 + 12540 1.043385930323635e+00 -6.001222520270105e+00 -5.992207133922096e+00 3.669556122978664e+00 4.721323866515462e+00 9.193166611119485e+03 + 12560 9.769367992808742e-01 -5.910153679631581e+00 -6.020286059232671e+00 4.244977591917491e+00 4.612580425317373e+00 9.279416093122856e+03 + 12580 1.057912966517759e+00 -6.040181222259123e+00 -6.010493723241304e+00 3.543354753689537e+00 4.713824967175481e+00 9.249291505753310e+03 + 12600 1.088755828363539e+00 -6.102953215321034e+00 -5.973708696503108e+00 3.164460486399427e+00 4.906602513976608e+00 9.136538121852356e+03 + 12620 9.637905850356971e-01 -5.939989389510406e+00 -6.059072054861244e+00 4.001640237853886e+00 4.317849145426468e+00 9.399267929717131e+03 + 12640 9.675735469780228e-01 -5.976124962154703e+00 -6.015711473688024e+00 3.802418082202862e+00 4.575106206985673e+00 9.265352565594218e+03 + 12660 1.008311562812418e+00 -6.075778093532571e+00 -5.985841109101320e+00 3.298275979965813e+00 4.814708062273417e+00 9.173649194710226e+03 + 12680 9.458033468053731e-01 -6.025552491141647e+00 -6.005746408759344e+00 3.580511289155156e+00 4.694240879175680e+00 9.234701566866359e+03 + 12700 9.101565640450048e-01 -6.014176745803566e+00 -6.011677683091690e+00 3.629035723890684e+00 4.643385728710982e+00 9.252960203924962e+03 + 12720 9.592228398963907e-01 -6.125153470692678e+00 -6.018374182914302e+00 2.979158233024656e+00 4.592301427489472e+00 9.273560567887194e+03 + 12740 9.438591170518340e-01 -6.128841875453158e+00 -5.972160474559272e+00 2.992104792356599e+00 4.891793642657721e+00 9.131805035660593e+03 + 12760 9.419367777358212e-01 -6.140634277998831e+00 -5.975297035352732e+00 2.989524806440289e+00 4.938916839569801e+00 9.141381682158626e+03 + 12780 9.335891670554377e-01 -6.130694396654655e+00 -6.009198570861613e+00 2.936271071016743e+00 4.633918904138669e+00 9.245317253865836e+03 + 12800 9.419126867775685e-01 -6.138974700012927e+00 -5.985635995536536e+00 2.918716059536643e+00 4.799210629727907e+00 9.173027877516230e+03 + 12820 9.566068378767565e-01 -6.149185771405964e+00 -5.959923356544177e+00 2.887426481814926e+00 4.974200556215351e+00 9.094439153018089e+03 + 12840 8.680355279830988e-01 -6.001626311814348e+00 -6.015981130584516e+00 3.702985956406570e+00 4.620558365627238e+00 9.266167163014232e+03 + 12860 9.428994932292935e-01 -6.094612678351087e+00 -5.954204522792125e+00 3.275476122501676e+00 5.081721479813085e+00 9.076997626686623e+03 + 12880 1.015114810725502e+00 -6.181403971235684e+00 -5.936081719043171e+00 2.770160375611435e+00 5.178838711196685e+00 9.021882452435035e+03 + 12900 1.004606022822095e+00 -6.143084268414085e+00 -5.990184850986178e+00 2.935562522613102e+00 4.813534638592524e+00 9.186944098233704e+03 + 12920 9.774498352261826e-01 -6.083085136670594e+00 -5.994274546637798e+00 3.253187707011113e+00 4.763151858373815e+00 9.199482130086359e+03 + 12940 9.677009577739466e-01 -6.052411418511741e+00 -5.996468074193715e+00 3.398305914033805e+00 4.719541254312466e+00 9.206210417222328e+03 + 12960 9.811208819242638e-01 -6.055868917520762e+00 -5.950267811594409e+00 3.430667194765073e+00 5.037045086712521e+00 9.065000039446672e+03 + 12980 9.589686764632543e-01 -6.005264969934738e+00 -5.979773494626130e+00 3.653273023617234e+00 4.799649019632321e+00 9.155055630880710e+03 + 13000 9.623158166166383e-01 -5.990330530601011e+00 -6.017560186231721e+00 3.740733259603906e+00 4.584376363196779e+00 9.271015003012189e+03 + 13020 9.918431235434656e-01 -6.015109826902791e+00 -6.014260760592631e+00 3.540996774990364e+00 4.545872245135892e+00 9.260891341939994e+03 + 13040 9.917158285868454e-01 -5.997489820236130e+00 -5.997166970639603e+00 3.721392197053691e+00 4.723246049397758e+00 9.208316168283072e+03 + 13060 9.767074055940901e-01 -5.958053545711565e+00 -5.974615004196152e+00 3.932789392811709e+00 4.837690935315795e+00 9.139251485303535e+03 + 13080 1.010432337925047e+00 -5.990461795565110e+00 -5.941286381767460e+00 3.831706248045781e+00 5.114079083942582e+00 9.037666321513232e+03 + 13100 1.057813457744726e+00 -6.043294400068824e+00 -5.984790923095892e+00 3.423141459924419e+00 4.759077478086800e+00 9.170408111641862e+03 + 13120 1.038732115618878e+00 -6.000893333579627e+00 -5.949316933853328e+00 3.698244283353420e+00 4.994403952003887e+00 9.062104045939413e+03 + 13140 1.039629229077769e+00 -5.988123656960269e+00 -5.945513168532421e+00 3.780853614225959e+00 5.025529632730437e+00 9.050532630419071e+03 + 13160 1.059799711726345e+00 -6.004404446692083e+00 -5.983659883847587e+00 3.616721046464140e+00 4.735839536527962e+00 9.166954915791481e+03 + 13180 1.045101419781784e+00 -5.973384544532364e+00 -6.019490534437324e+00 3.789640873100682e+00 4.524893144187525e+00 9.276976280021188e+03 + 13200 9.828143421093938e-01 -5.876351592211674e+00 -6.002213715254975e+00 4.368260654661329e+00 4.645540867046103e+00 9.223824775866859e+03 + 13220 9.841375046419810e-01 -5.876463427427820e+00 -6.031037423108485e+00 4.305060185616577e+00 4.417472382169676e+00 9.312564426691099e+03 + 13240 1.051963059880574e+00 -5.977049866977263e+00 -6.010805458921764e+00 3.828916359284499e+00 4.635086526678204e+00 9.250244991236163e+03 + 13260 1.085427755060753e+00 -6.033173494298611e+00 -6.000040216215819e+00 3.541654950261243e+00 4.731911360370853e+00 9.217169665582427e+03 + 13280 1.026191272575016e+00 -5.961454789480383e+00 -6.017665294485574e+00 3.903252784300558e+00 4.580483366013217e+00 9.271345818736534e+03 + 13300 9.893545628543342e-01 -5.935939878425217e+00 -6.053837274382641e+00 4.001092184665404e+00 4.324107092514821e+00 9.383023187165973e+03 + 13320 1.017426546816271e+00 -6.019687778656925e+00 -5.982504082209016e+00 3.635182475850031e+00 4.848697015012355e+00 9.163419947266422e+03 + 13340 1.015468177274977e+00 -6.066584345191529e+00 -5.989793488513505e+00 3.312055581363150e+00 4.753000563755031e+00 9.185741806858139e+03 + 13360 9.343203322336090e-01 -5.994203720277369e+00 -6.028203747175231e+00 3.716816492935294e+00 4.521583077000610e+00 9.303843982294393e+03 + 13380 9.517143517019200e-01 -6.059163039507457e+00 -6.002975837537313e+00 3.411000823769389e+00 4.733636432423358e+00 9.226178457838138e+03 + 13400 9.620689462683979e-01 -6.099823452704063e+00 -5.992341471230464e+00 3.148054306200648e+00 4.765232476604931e+00 9.193566226387971e+03 + 13420 9.388801397787644e-01 -6.081197622432939e+00 -5.990144295267878e+00 3.284113464809745e+00 4.806955759848372e+00 9.186825913402536e+03 + 13440 9.202371770225128e-01 -6.060849502548947e+00 -5.991313308709848e+00 3.352909069233559e+00 4.752196654948890e+00 9.190404610828540e+03 + 13460 9.049631624782820e-01 -6.036479062626970e+00 -6.009117321890004e+00 3.481912210390387e+00 4.639027559917743e+00 9.245066000850933e+03 + 13480 9.391703091589585e-01 -6.078301309568737e+00 -5.980263007941661e+00 3.257782202678379e+00 4.820733301999193e+00 9.156584736660247e+03 + 13500 9.330573482551512e-01 -6.054176438359347e+00 -5.979413513803845e+00 3.399852596528873e+00 4.829152878851753e+00 9.153968949925698e+03 + 13520 9.010024151139526e-01 -5.984594346774619e+00 -6.034268487381922e+00 3.796859116695365e+00 4.511622514279818e+00 9.322550923155895e+03 + 13540 9.647321867159638e-01 -6.052556231673164e+00 -5.988344073516386e+00 3.436649314344653e+00 4.805365463280237e+00 9.181301979446038e+03 + 13560 9.944488293876476e-01 -6.069112023876447e+00 -5.951043728724810e+00 3.395725017616723e+00 5.073691439387050e+00 9.067365762513704e+03 + 13580 9.689443368391509e-01 -6.002724699338702e+00 -5.958027657150615e+00 3.721200971512336e+00 4.977858304601257e+00 9.088629516102366e+03 + 13600 1.017768333815674e+00 -6.045204071675910e+00 -5.948173767283750e+00 3.490288637881658e+00 5.047451661092518e+00 9.058629524412479e+03 + 13620 9.951900915305153e-01 -5.984311521089371e+00 -6.020952683926789e+00 3.745544341135308e+00 4.535145113921227e+00 9.281473334067881e+03 + 13640 1.010104472379224e+00 -5.986157579107998e+00 -6.052503241670323e+00 3.700292524648948e+00 4.319325463257979e+00 9.378935722652122e+03 + 13660 9.665759256792122e-01 -5.908079714554942e+00 -6.010465446292135e+00 4.192015697141136e+00 4.604100981365398e+00 9.249199962721705e+03 + 13680 1.019921594570815e+00 -5.977409693616421e+00 -6.018997983797384e+00 3.822614121022965e+00 4.583807723036770e+00 9.275459908730872e+03 + 13700 1.075648729941505e+00 -6.055504712025390e+00 -6.026285508699770e+00 3.361822369394123e+00 4.529603556546935e+00 9.297926924066951e+03 + 13720 1.019071102584764e+00 -5.973068271159070e+00 -6.050181981113328e+00 3.819549818843288e+00 4.376750962977889e+00 9.371727148238519e+03 + 13740 1.004586217260948e+00 -5.955604670964619e+00 -6.031186902816487e+00 3.883483455493209e+00 4.449478583887204e+00 9.313035333132730e+03 + 13760 1.059512337978601e+00 -6.042683548125341e+00 -6.009180491677015e+00 3.444634140129649e+00 4.637013874837166e+00 9.245252786426678e+03 + 13780 9.580622244218194e-01 -5.899697445292140e+00 -5.993841885035435e+00 4.239953733092989e+00 4.699361791282024e+00 9.198151296070644e+03 + 13800 1.037598070071333e+00 -6.025840891061420e+00 -5.986725564028316e+00 3.521566820569805e+00 4.746173081471180e+00 9.176342007764264e+03 + 13820 9.708924135690336e-01 -5.935790996106090e+00 -6.030435423281469e+00 3.989894876808374e+00 4.446431929789576e+00 9.310684550860882e+03 + 13840 9.602819063892584e-01 -5.928319903827726e+00 -5.967220120146290e+00 4.122326894767640e+00 4.898955832877426e+00 9.116673796631043e+03 + 13860 1.025095402485861e+00 -6.031321668245525e+00 -5.971727983622753e+00 3.480211775332939e+00 4.822407934529785e+00 9.130460554499901e+03 + 13880 1.010952403370913e+00 -6.018374363518667e+00 -5.971051848424547e+00 3.627320627850045e+00 4.899053832656030e+00 9.128393882975772e+03 + 13900 9.954852305458934e-01 -6.003466446066224e+00 -5.980928686400139e+00 3.731538741981649e+00 4.860954045691352e+00 9.158576020955768e+03 + 13920 1.016268356203339e+00 -6.040393583269869e+00 -5.981421243530807e+00 3.450737595293037e+00 4.789365896014811e+00 9.160099600531272e+03 + 13940 9.786833210774085e-01 -5.993806793602945e+00 -6.042654092684542e+00 3.701015891320091e+00 4.420527140898462e+00 9.348443506908668e+03 + 13960 9.891011305972971e-01 -6.023162590321609e+00 -5.990267208547309e+00 3.515827538648122e+00 4.704717911340030e+00 9.187209310112599e+03 + 13980 9.442672768223425e-01 -5.973580542903748e+00 -6.031816817120200e+00 3.779916672551878e+00 4.445514973966699e+00 9.314946270218148e+03 + 14000 9.662230875744618e-01 -6.029866675288530e+00 -6.036209942950221e+00 3.548577440083888e+00 4.512153415552960e+00 9.328525980611725e+03 + 14020 9.057001366030705e-01 -5.971819198831652e+00 -6.065881574534823e+00 3.803918754415768e+00 4.263798037022558e+00 9.420405868558724e+03 + 14040 9.301819357908376e-01 -6.042189919170998e+00 -6.026279973313184e+00 3.461961196613779e+00 4.553318567785511e+00 9.297890887721753e+03 + 14060 8.853153103102254e-01 -6.005653860336191e+00 -5.986461143461435e+00 3.714038311477717e+00 4.824245861835905e+00 9.175522205344349e+03 + 14080 9.634333916627276e-01 -6.144536272065914e+00 -5.960215555196624e+00 2.925784099731376e+00 4.984182179533591e+00 9.095330944708730e+03 + 14100 9.146867688940616e-01 -6.087054630302132e+00 -5.995379551379986e+00 3.200206912203148e+00 4.726619402046726e+00 9.202877988891187e+03 + 14120 9.320601300576017e-01 -6.120416620742057e+00 -5.984551569168874e+00 3.032236014892496e+00 4.812394166074492e+00 9.169693796201498e+03 + 14140 9.579624282181181e-01 -6.156442505095035e+00 -5.971433627928624e+00 2.884273812240886e+00 4.946623414961636e+00 9.129577299428871e+03 + 14160 8.326997641141263e-01 -5.960054838466997e+00 -6.033563054381723e+00 3.953368026075111e+00 4.531272474933104e+00 9.320357899573894e+03 + 14180 9.342928401337091e-01 -6.091357131979897e+00 -5.986228416183719e+00 3.259737759445618e+00 4.863403114163461e+00 9.174812310653626e+03 + 14200 9.392304837995251e-01 -6.065838061702508e+00 -6.009689871706525e+00 3.384721608663775e+00 4.707133204525030e+00 9.246814632189415e+03 + 14220 9.353550765957238e-01 -6.021225879618004e+00 -5.991932337424866e+00 3.584200322791232e+00 4.752408375225237e+00 9.192279963690353e+03 + 14240 9.516997093865492e-01 -6.004685039595415e+00 -5.978853743004056e+00 3.738064415579393e+00 4.886391717987205e+00 9.152216323487915e+03 + 14260 9.744973590202504e-01 -6.001012259015856e+00 -5.991118878569472e+00 3.711526796643562e+00 4.768336118162376e+00 9.189799641186473e+03 + 14280 9.750995025775289e-01 -5.969265575310930e+00 -6.051209223073906e+00 3.842915230055302e+00 4.372382123861784e+00 9.374920599762667e+03 + 14300 1.018366323221876e+00 -6.011298827059964e+00 -5.999794814759222e+00 3.651329113011656e+00 4.717386931882663e+00 9.216428120614755e+03 + 14320 9.979290218700698e-01 -5.965919006478767e+00 -6.011467246638254e+00 3.905903568887151e+00 4.644358525323991e+00 9.252276033007809e+03 + 14340 1.052726667664419e+00 -6.037436691027604e+00 -6.002583273323571e+00 3.521525333453916e+00 4.721659051459429e+00 9.224988001035070e+03 + 14360 1.030879212583412e+00 -5.998053751675562e+00 -6.013217845216550e+00 3.683691292169797e+00 4.596616720421551e+00 9.257675920509515e+03 + 14380 1.011231685314199e+00 -5.967098045691603e+00 -5.993112280840384e+00 3.901644853731905e+00 4.752267089817725e+00 9.195921194674658e+03 + 14400 1.064733780866991e+00 -6.045409331912724e+00 -5.997739293580194e+00 3.484811887017156e+00 4.758540624037134e+00 9.210109199271268e+03 + 14420 1.029990037786566e+00 -5.995528438258201e+00 -5.987971467337595e+00 3.758574219667636e+00 4.801967516131228e+00 9.180157716110933e+03 + 14440 1.046846247597656e+00 -6.024125187028860e+00 -5.974091570165323e+00 3.594818602892671e+00 4.882119373600283e+00 9.137688259168341e+03 + 14460 1.001521376197511e+00 -5.961888553046335e+00 -6.005424624489557e+00 3.926026168955821e+00 4.676035309543554e+00 9.233707345828185e+03 + 14480 1.053895832952659e+00 -6.047984239191268e+00 -6.008159553253616e+00 3.429322317435656e+00 4.658001826939883e+00 9.242130150625930e+03 + 14500 9.921460814263839e-01 -5.969313102670810e+00 -6.006104545531834e+00 3.848091808048848e+00 4.636829649683470e+00 9.235801958039723e+03 + 14520 9.943852645897678e-01 -5.987614268106825e+00 -6.041976592007347e+00 3.735686836261388e+00 4.423529959882156e+00 9.346357195075043e+03 + 14540 1.023016709090836e+00 -6.049106863874751e+00 -5.990298674743202e+00 3.462787238011426e+00 4.800472960542640e+00 9.187293631468870e+03 + 14560 9.884333435519419e-01 -6.019921560248269e+00 -5.992157310805880e+00 3.579885737309376e+00 4.739312354111287e+00 9.192986916183747e+03 + 14580 1.049897411424165e+00 -6.139732067402549e+00 -5.983188251073981e+00 2.929159951447253e+00 4.828058769883175e+00 9.165503039540958e+03 + 14600 9.651573841839691e-01 -6.044158789801968e+00 -5.995332456429395e+00 3.453723079967800e+00 4.734091442043784e+00 9.202714395870797e+03 + 14620 9.453523274364023e-01 -6.046054717876401e+00 -5.992371740194324e+00 3.502586541198240e+00 4.810842506462675e+00 9.193658634593347e+03 + 14640 9.853353847441770e-01 -6.136595985130529e+00 -5.988422068601172e+00 2.921387128129163e+00 4.772224686680209e+00 9.181548848121294e+03 + 14660 8.923250831768785e-01 -6.027125297262975e+00 -6.005525625693679e+00 3.552217959068511e+00 4.676246615757786e+00 9.234021551433425e+03 + 14680 9.228874180822773e-01 -6.093024565484999e+00 -5.982354304744548e+00 3.176718975315279e+00 4.812204738654453e+00 9.162980552178109e+03 + 14700 9.572710976781926e-01 -6.157851480222909e+00 -6.004274331361785e+00 2.816443893015322e+00 4.698307647762880e+00 9.230200114807767e+03 + 14720 9.176331832190230e-01 -6.105741058493149e+00 -5.996835784938701e+00 3.134225757831238e+00 4.759576691617497e+00 9.207332262974975e+03 + 14740 8.830362594213180e-01 -6.052974543814891e+00 -5.974715328513976e+00 3.459413437129864e+00 4.908789961962148e+00 9.139584403103012e+03 + 14760 9.091010829605519e-01 -6.076518086052246e+00 -6.027547969791208e+00 3.282443998626163e+00 4.563637984298051e+00 9.301820460729452e+03 + 14780 9.708361502904458e-01 -6.140048433627999e+00 -5.992879852440447e+00 2.947959954202735e+00 4.793024721645994e+00 9.195219942439348e+03 + 14800 9.222220010180092e-01 -6.022285400635354e+00 -6.010178988033177e+00 3.547995178954994e+00 4.617512073577994e+00 9.248322725980086e+03 + 14820 9.332349448915777e-01 -5.979593942277390e+00 -6.018790312403501e+00 3.822117625442727e+00 4.597046002559921e+00 9.274827087037835e+03 + 14840 1.012458235412856e+00 -6.036131265473125e+00 -5.996320833027842e+00 3.552907760980256e+00 4.781505424725577e+00 9.205767767045592e+03 + 14860 1.006789647209557e+00 -5.986823355632439e+00 -6.034798996925952e+00 3.703265347610308e+00 4.427781791096462e+00 9.324175055935153e+03 + 14880 1.019824177045552e+00 -5.981645440070493e+00 -6.022213546705503e+00 3.784020704152293e+00 4.551072357959856e+00 9.285378699247032e+03 + 14900 1.008427924971822e+00 -5.951206752684636e+00 -6.034167513272133e+00 3.898129512916136e+00 4.421755987486515e+00 9.322246493739389e+03 + 14920 1.016067588044179e+00 -5.955080092730041e+00 -6.001980037163976e+00 3.903192632953148e+00 4.633885894270554e+00 9.223090311148435e+03 + 14940 9.943516113113841e-01 -5.918571601138767e+00 -6.033267921724736e+00 4.094807240738207e+00 4.436203218735327e+00 9.319435690527122e+03 + 14960 1.038363945597395e+00 -5.982554952527606e+00 -6.024513467468314e+00 3.771802691415798e+00 4.530870405567057e+00 9.292460141753703e+03 + 14980 1.021125360889804e+00 -5.959952334247435e+00 -6.041158491683223e+00 3.848690013495274e+00 4.382391690886729e+00 9.343815768686029e+03 + 15000 9.832357746842078e-01 -5.910430194942424e+00 -6.001923502476149e+00 4.147872886149311e+00 4.622504155747076e+00 9.222927883713255e+03 + 15020 1.003089927786025e+00 -5.947370401790578e+00 -5.996890339145149e+00 3.930887048308773e+00 4.646535904833288e+00 9.207494463419454e+03 + 15040 1.041801518997001e+00 -6.013870785578861e+00 -6.010821645086613e+00 3.621984011903171e+00 4.639492648462625e+00 9.250301615584005e+03 + 15060 1.006697359125730e+00 -5.975496490226733e+00 -5.996150903307937e+00 3.824521070447352e+00 4.705920234274984e+00 9.205240662727867e+03 + 15080 1.012631413497304e+00 -5.999607206315405e+00 -6.003502616685140e+00 3.706355611479565e+00 4.683987562323743e+00 9.227813430641863e+03 + 15100 1.027255146869554e+00 -6.042384192595095e+00 -5.998238370266910e+00 3.473302656425250e+00 4.726794799777610e+00 9.211644696096027e+03 + 15120 9.894155504952339e-01 -6.008699273450648e+00 -5.980242673304412e+00 3.644298205295747e+00 4.807700406980079e+00 9.156487202256354e+03 + 15140 9.832774122211521e-01 -6.020080304146821e+00 -5.978151429201674e+00 3.583278459744251e+00 4.824040548151716e+00 9.150113982641389e+03 + 15160 1.033127892111074e+00 -6.115063577947739e+00 -5.992888920138225e+00 3.080943117045043e+00 4.782488908654463e+00 9.195248184745780e+03 + 15180 9.982011358099073e-01 -6.084855415484716e+00 -5.981584756380695e+00 3.296452584062660e+00 4.889448689720798e+00 9.160598923735270e+03 + 15200 9.722445357820864e-01 -6.066008956350461e+00 -5.987541368873890e+00 3.331657739749601e+00 4.782230769859993e+00 9.178845260531720e+03 + 15220 9.697117600045936e-01 -6.076980706488086e+00 -5.964637407185260e+00 3.322542062430765e+00 4.967634672096969e+00 9.108814339770330e+03 + 15240 9.832485597782736e-01 -6.109452710834826e+00 -5.974101731613088e+00 3.117294526507890e+00 4.894500794695452e+00 9.137751148142410e+03 + 15260 9.530744039852279e-01 -6.075001847666452e+00 -6.008808987456170e+00 3.291602992817331e+00 4.671692639456783e+00 9.244114475685166e+03 + 15280 9.350713136243083e-01 -6.053466727689420e+00 -5.968473396226428e+00 3.447470623822618e+00 4.935515485758656e+00 9.120521198299575e+03 + 15300 1.018558224795023e+00 -6.175915200941908e+00 -5.956287137417533e+00 2.761827135832458e+00 5.022965463922409e+00 9.083356648807123e+03 + 15320 9.223022270300407e-01 -6.025468412608612e+00 -5.977945831421264e+00 3.584919117801911e+00 4.857801133075331e+00 9.149457418138692e+03 + 15340 9.507897179144256e-01 -6.048682332276661e+00 -5.948228117698299e+00 3.444455850149162e+00 5.021279495497583e+00 9.058799777776147e+03 + 15360 1.001344669912450e+00 -6.086469755467908e+00 -5.985102541136126e+00 3.225468516271051e+00 4.807534747489860e+00 9.171394484469665e+03 + 15380 9.736032232818543e-01 -5.996117397311394e+00 -6.031414157338427e+00 3.717760397190810e+00 4.515080938959631e+00 9.313751795539005e+03 + 15400 9.660825305161991e-01 -5.934922969023227e+00 -6.009910917126087e+00 4.047014936067699e+00 4.616422533713615e+00 9.247514364767621e+03 + 15420 1.051481913102264e+00 -6.017158126143888e+00 -6.012312108276678e+00 3.611131510649913e+00 4.638958095162272e+00 9.254892312865863e+03 + 15440 1.099503085714131e+00 -6.055511174579758e+00 -6.026779592155419e+00 3.361026906408012e+00 4.526008098886575e+00 9.299448593902765e+03 + 15460 1.044939292337747e+00 -5.954397370079508e+00 -6.027894300748307e+00 3.983947054569640e+00 4.561916305056133e+00 9.302886859304908e+03 + 15480 1.111268001139891e+00 -6.042927797800162e+00 -5.990274548919131e+00 3.485485845470278e+00 4.787828948609089e+00 9.187227962608147e+03 + 15500 1.009552530804799e+00 -5.888964164140117e+00 -6.027934097424412e+00 4.311729058516539e+00 4.513742196070448e+00 9.302972745392335e+03 + 15520 1.030246793721443e+00 -5.922429131783099e+00 -5.980888862399471e+00 4.092362270345772e+00 4.756677450532488e+00 9.158440348080954e+03 + 15540 9.975922210702153e-01 -5.878299052398336e+00 -5.983743040819674e+00 4.410757828427396e+00 4.805282129507598e+00 9.167175216530726e+03 + 15560 1.082418671989176e+00 -6.012082066018948e+00 -5.981664419063939e+00 3.661487487040021e+00 4.836150322971342e+00 9.160854457807143e+03 + 15580 1.042842259432051e+00 -5.968012360496712e+00 -6.027916461617234e+00 3.847893442011583e+00 4.503914823247863e+00 9.302954905183999e+03 + 15600 9.653681620221185e-01 -5.872321953026235e+00 -6.051562613523336e+00 4.363348494344606e+00 4.334120884367687e+00 9.376017262160663e+03 + 15620 1.039465066011725e+00 -6.006774385734478e+00 -5.962908953256215e+00 3.685101084428548e+00 4.936983185872472e+00 9.103522105930297e+03 + 15640 9.959993876069543e-01 -5.967575392147994e+00 -5.965987970319528e+00 3.869014656861653e+00 4.878129878653439e+00 9.112918577795066e+03 + 15660 1.039514543615304e+00 -6.058726867450306e+00 -5.971587057383079e+00 3.397063867146809e+00 4.897434141394857e+00 9.130035600839274e+03 + 15680 9.186810047381179e-01 -5.907155615932896e+00 -6.055283683674707e+00 4.160714266887610e+00 4.310139979169731e+00 9.387538328122100e+03 + 15700 9.852933271298693e-01 -6.032771273925749e+00 -6.007576608349518e+00 3.493909053596011e+00 4.638580722196631e+00 9.240318332336854e+03 + 15720 9.958565645542300e-01 -6.071000268390845e+00 -5.976853072587240e+00 3.357048121285746e+00 4.897655888821513e+00 9.146121541915845e+03 + 15740 9.479532805469607e-01 -6.019202457797280e+00 -5.986378713860523e+00 3.649269408000298e+00 4.837748425143114e+00 9.175269743283417e+03 + 15760 9.597754537155575e-01 -6.050471197120063e+00 -6.002816946227338e+00 3.437929066877525e+00 4.711567149975049e+00 9.225698505442859e+03 + 15780 9.587271125857375e-01 -6.060165679976816e+00 -5.977881776449152e+00 3.397055459805893e+00 4.869542367254656e+00 9.149242219198843e+03 + 15800 8.988244408203014e-01 -5.975257475101839e+00 -5.940456213488443e+00 3.817880514506519e+00 5.017714744168469e+00 9.035150109434859e+03 + 15820 9.524300343673753e-01 -6.049913923969113e+00 -5.939527099622970e+00 3.429400536465309e+00 5.063258764166720e+00 9.032333577428828e+03 + 15840 9.387125985957174e-01 -6.015463356773948e+00 -5.986087733911527e+00 3.606963586137629e+00 4.775642958476592e+00 9.174389475113712e+03 + 15860 9.442015499304807e-01 -6.001048429168136e+00 -5.999132947280391e+00 3.690804105165445e+00 4.701803098584736e+00 9.214403304535377e+03 + 15880 1.040460992919469e+00 -6.108541595362967e+00 -6.019497522492548e+00 3.087561493861394e+00 4.598866339809084e+00 9.277014361750218e+03 + 15900 1.006307656520622e+00 -6.005912562994236e+00 -5.990916974180545e+00 3.694756899663111e+00 4.780863891191201e+00 9.189190949267684e+03 + 15920 9.739650855508706e-01 -5.891259265195796e+00 -6.021120702384584e+00 4.242856157162151e+00 4.497171688831672e+00 9.282005751951348e+03 + 15940 1.043529363485901e+00 -5.923286296156697e+00 -6.044643440085450e+00 4.056327576174173e+00 4.359476075777945e+00 9.354618170961621e+03 + 15960 1.032482521468340e+00 -5.863832363752441e+00 -6.021722886296762e+00 4.440108801777649e+00 4.533476987848764e+00 9.283842919130395e+03 + 15980 1.090211966623664e+00 -5.929399980603203e+00 -6.015511943810689e+00 4.071797202943952e+00 4.577328984423326e+00 9.264742121177609e+03 + 16000 1.119917871770703e+00 -5.970547985839363e+00 -6.006814286928043e+00 3.876388679874490e+00 4.668141966831338e+00 9.237978198065348e+03 + 16020 1.038670480226327e+00 -5.856963451948980e+00 -6.035899006772087e+00 4.420738700713010e+00 4.393263054731107e+00 9.327570749707285e+03 + 16040 1.111960006598479e+00 -5.979498946201963e+00 -5.959517961937144e+00 3.791270375491699e+00 4.906004279187609e+00 9.093176530397619e+03 + 16060 1.014578791306964e+00 -5.852527921606540e+00 -6.034214102547810e+00 4.442263699061439e+00 4.398993532251034e+00 9.322328904493563e+03 + 16080 1.070143013802163e+00 -5.958127181542800e+00 -6.045957559482914e+00 3.933772825697144e+00 4.429437203857947e+00 9.358660726208411e+03 + 16100 1.059385820968090e+00 -5.973587218445555e+00 -6.005730123436942e+00 3.871573200981748e+00 4.687003666422731e+00 9.234642397685626e+03 + 16120 1.029147721603271e+00 -5.961962182250252e+00 -6.040404587610968e+00 3.920161692165637e+00 4.469733261661405e+00 9.341479963451662e+03 + 16140 1.084545860741448e+00 -6.079749110082415e+00 -5.965772735817823e+00 3.352040935149971e+00 5.006510913964171e+00 9.112270055112816e+03 + 16160 1.001544712843063e+00 -5.988560144066131e+00 -6.008293208888090e+00 3.735685358272912e+00 4.622375046383311e+00 9.242501135975748e+03 + 16180 1.021610862144649e+00 -6.046708635009876e+00 -5.947599647485053e+00 3.500237023900787e+00 5.069336167334580e+00 9.056884226831984e+03 + 16200 9.996196822025203e-01 -6.035980717875709e+00 -5.963088802893962e+00 3.561561116568659e+00 4.980117772381245e+00 9.104081147135690e+03 + 16220 9.667280948315832e-01 -6.003873912140834e+00 -6.029266740648056e+00 3.676163162286024e+00 4.530353611470045e+00 9.307120620459347e+03 + 16240 1.044814511361942e+00 -6.133482541393508e+00 -5.996537979429706e+00 2.960421670791425e+00 4.746778537690048e+00 9.206449716741608e+03 + 16260 9.828113555857294e-01 -6.055053703745427e+00 -5.997998235710874e+00 3.397160823790285e+00 4.724782150549835e+00 9.210913682184944e+03 + 16280 9.836200616351478e-01 -6.066448569737368e+00 -5.986829781708607e+00 3.329342005862354e+00 4.786525407691126e+00 9.176661220746782e+03 + 16300 9.706816758214837e-01 -6.053160736146162e+00 -6.006920116031742e+00 3.385326521662988e+00 4.650847318072824e+00 9.238294350015800e+03 + 16320 9.386393254113247e-01 -6.007429758212115e+00 -5.955763681525857e+00 3.699919327205507e+00 4.996593934837527e+00 9.081736223915159e+03 + 16340 1.006175033992813e+00 -6.103511373014333e+00 -5.966370993012679e+00 3.124911492572879e+00 4.912392776947598e+00 9.114084855988927e+03 + 16360 9.449112569405301e-01 -6.003778301851324e+00 -6.004391352276248e+00 3.627280468316835e+00 4.623760237907673e+00 9.230528527875267e+03 + 16380 9.963027094050009e-01 -6.064812716379080e+00 -5.965389259077392e+00 3.350432476367847e+00 4.921337353924430e+00 9.111087226040068e+03 + 16400 1.014161861864463e+00 -6.068100585936381e+00 -5.991555765197051e+00 3.340021717886150e+00 4.779553923844110e+00 9.191138998277158e+03 + 16420 9.630807216164625e-01 -5.962556997959725e+00 -5.999339510013300e+00 3.890338466661848e+00 4.679127590374874e+00 9.215008359607682e+03 + 16440 1.042241325292144e+00 -6.044672656004720e+00 -5.976653483744734e+00 3.471736052071346e+00 4.862312665121074e+00 9.145504342133841e+03 + 16460 1.001279370843563e+00 -5.940600374719270e+00 -5.989486927483195e+00 4.008885886377403e+00 4.728171735237356e+00 9.184792441285039e+03 + 16480 1.006910426607016e+00 -5.906953155649825e+00 -5.975235335073020e+00 4.169410384592255e+00 4.777323543711156e+00 9.141146286262157e+03 + 16500 1.111025541553890e+00 -6.022240757674968e+00 -5.966771416757488e+00 3.553932484943734e+00 4.872446024344673e+00 9.115328194534928e+03 + 16520 1.064529453378381e+00 -5.926147619288513e+00 -6.007275850023660e+00 4.077552128599220e+00 4.611701273164875e+00 9.239402807591428e+03 + 16540 1.074024504345767e+00 -5.925433266325845e+00 -6.024506086833570e+00 4.062009574146015e+00 4.493118107321229e+00 9.292438858568908e+03 + 16560 1.102003404249147e+00 -5.963960317218174e+00 -6.058823659801582e+00 3.797482493305224e+00 4.252762500136474e+00 9.398518125555918e+03 + 16580 1.053479012049155e+00 -5.898744507071199e+00 -6.044286845375987e+00 4.189570204657825e+00 4.353843575507670e+00 9.353473808470189e+03 + 16600 1.099383376681937e+00 -5.980586518079263e+00 -5.987018179436031e+00 3.832879653911318e+00 4.795948059104374e+00 9.177215251869593e+03 + 16620 1.057877377693240e+00 -5.934993035161610e+00 -5.975679199285806e+00 4.069402999275983e+00 4.835776748711298e+00 9.142522169908640e+03 + 16640 1.096410518871104e+00 -6.008649279470569e+00 -5.967281847206526e+00 3.678556379607090e+00 4.916094577256681e+00 9.116883957867251e+03 + 16660 1.004496589334081e+00 -5.890957468562389e+00 -6.007502950185087e+00 4.293880951539177e+00 4.624658760706651e+00 9.240084361635689e+03 + 16680 1.019662639971786e+00 -5.931355049517618e+00 -6.012084920449190e+00 4.109406119380905e+00 4.645842707584671e+00 9.254167945428246e+03 + 16700 1.043591898595632e+00 -5.984075066170873e+00 -6.009995685516705e+00 3.729608626620457e+00 4.580768419133815e+00 9.247756112618841e+03 + 16720 9.651169108758548e-01 -5.885026314512714e+00 -6.042297323062252e+00 4.328137530956362e+00 4.425063062254993e+00 9.347343300611061e+03 + 16740 1.025443653125723e+00 -5.993401393192968e+00 -6.056046010240834e+00 3.702573411402036e+00 4.342858326090031e+00 9.389911064706876e+03 + 16760 1.040321625566783e+00 -6.034073341909074e+00 -5.997101654410751e+00 3.542229264351756e+00 4.754526415317273e+00 9.208147637483760e+03 + 16780 9.859775011202554e-01 -5.968991458205546e+00 -5.983237602138166e+00 3.890539593259309e+00 4.808736030214556e+00 9.165634010108388e+03 + 16800 9.884653421519799e-01 -5.984580875168528e+00 -6.021679281104608e+00 3.807460535710798e+00 4.594435747866063e+00 9.283709998166285e+03 + 16820 1.062280055040524e+00 -6.106553201186487e+00 -5.966033022081692e+00 3.125250965947634e+00 4.932139579794802e+00 9.113097466572090e+03 + 16840 1.010264574921863e+00 -6.041056549723880e+00 -5.986331963349495e+00 3.449011581359245e+00 4.763248624923334e+00 9.175142850191049e+03 + 16860 9.734692393836242e-01 -5.994898905507279e+00 -6.025793627473734e+00 3.681624955123896e+00 4.504222680649743e+00 9.296401595530804e+03 + 16880 9.578470383813710e-01 -5.978413189180635e+00 -6.018094246722809e+00 3.814413437190905e+00 4.586558664159933e+00 9.272696678412965e+03 + 16900 9.544746446363546e-01 -5.979279196178286e+00 -6.036303196646175e+00 3.827116398296035e+00 4.499675763173863e+00 9.328824825582569e+03 + 16920 9.790937728005572e-01 -6.019920930596426e+00 -5.963884077374939e+00 3.558784536610578e+00 4.880556819483364e+00 9.106524369040393e+03 + 16940 9.979087284754528e-01 -6.048847328415294e+00 -5.975871213036347e+00 3.473593830425984e+00 4.892633977949255e+00 9.143118078260639e+03 + 16960 1.001372384316250e+00 -6.053325648519742e+00 -5.983008823678847e+00 3.347450299795585e+00 4.751220389525482e+00 9.164970104888862e+03 + 16980 9.495369561054742e-01 -5.972332810885871e+00 -5.988802375661896e+00 3.900722625474983e+00 4.806151835874136e+00 9.182673663902007e+03 + 17000 1.004652804553360e+00 -6.044052056270499e+00 -5.970439510000572e+00 3.468775027194833e+00 4.891469659381471e+00 9.126519084373687e+03 + 17020 9.504618321210833e-01 -5.945855898328440e+00 -6.025813754187435e+00 3.946928114512158e+00 4.487797732731599e+00 9.296471653958220e+03 + 17040 9.983326289373902e-01 -5.987683425417126e+00 -6.033128197146650e+00 3.760844449876864e+00 4.499893538050242e+00 9.319030020133772e+03 + 17060 1.037531948287053e+00 -6.000301804220634e+00 -6.053640672452377e+00 3.678189730507182e+00 4.371909694957332e+00 9.382441504698101e+03 + 17080 1.071576028171232e+00 -5.999175394344467e+00 -6.011137293860008e+00 3.734975150861554e+00 4.666288072745356e+00 9.251286249569876e+03 + 17100 1.081463689206868e+00 -5.962188168661991e+00 -6.001824629087645e+00 3.940893639798026e+00 4.713294950311493e+00 9.222634003107041e+03 + 17120 1.089739097842401e+00 -5.936591719396770e+00 -5.998052803917646e+00 4.015194653830019e+00 4.662275595439056e+00 9.211083623665278e+03 + 17140 1.095062054425581e+00 -5.919251033059413e+00 -5.985926074688694e+00 4.101040800105736e+00 4.718182393141062e+00 9.173885563448477e+03 + 17160 1.071433007647596e+00 -5.872272233969349e+00 -6.016217837204072e+00 4.314569469066353e+00 4.488011539782468e+00 9.266875182613381e+03 + 17180 1.119594979875887e+00 -5.942729821417191e+00 -5.987977119343153e+00 3.984910203084596e+00 4.725093216396998e+00 9.180161367041119e+03 + 17200 1.054708662091585e+00 -5.854703743288421e+00 -6.006614074586382e+00 4.491109658008900e+00 4.618817027648215e+00 9.237323055784636e+03 + 17220 1.066125323894024e+00 -5.888626101234864e+00 -5.963631510740051e+00 4.306677850796348e+00 4.875985182367957e+00 9.105711603604965e+03 + 17240 1.084034748602998e+00 -5.936699012285631e+00 -5.999056755722497e+00 4.045048038894926e+00 4.686980226250829e+00 9.214102177940282e+03 + 17260 1.043937442965128e+00 -5.908788449510177e+00 -6.024302339365368e+00 4.161939004967312e+00 4.498640373702119e+00 9.291776724046724e+03 + 17280 1.038133033742346e+00 -5.934069048245194e+00 -5.998489327863095e+00 4.005530476846223e+00 4.635619262274180e+00 9.212415672608238e+03 + 17300 1.053403595654856e+00 -5.993219027709928e+00 -6.027715446049482e+00 3.746324213218287e+00 4.548240440809083e+00 9.302284131722656e+03 + 17320 9.804201492613073e-01 -5.918520887386850e+00 -6.015699229815652e+00 4.139777174183189e+00 4.581764093657124e+00 9.265295255489031e+03 + 17340 1.009418364913800e+00 -5.988561663032932e+00 -5.989948503175782e+00 3.764276232328435e+00 4.756312781615374e+00 9.186183034808422e+03 + 17360 9.856701866056794e-01 -5.971713635179905e+00 -5.936392196807986e+00 3.914590182061049e+00 5.117411347167529e+00 9.022807187983572e+03 + 17380 9.720941125870967e-01 -5.963082935112788e+00 -5.977274446888640e+00 3.849284019028471e+00 4.767794162282177e+00 9.147428668226667e+03 + 17400 1.024905459126536e+00 -6.048799989359965e+00 -5.995817597246074e+00 3.390803626240889e+00 4.695036720757534e+00 9.204221936015509e+03 + 17420 1.026567097003944e+00 -6.056620477627159e+00 -5.965658930403348e+00 3.386912226582850e+00 4.909227506995913e+00 9.111943347269387e+03 + 17440 1.008675691728021e+00 -6.033161235131350e+00 -6.016006282911424e+00 3.441059898403239e+00 4.539566288770327e+00 9.266269625405585e+03 + 17460 9.080984743903288e-01 -5.887010572457441e+00 -6.085385614325908e+00 4.182494666418110e+00 4.043394477570856e+00 9.481036018013001e+03 + 17480 9.944630232760490e-01 -6.018677164324184e+00 -6.011120618402915e+00 3.610259490708203e+00 4.653650346759831e+00 9.251217081557557e+03 + 17500 9.759776930851446e-01 -5.993427419008173e+00 -5.992912873755718e+00 3.743618696159810e+00 4.746573294625026e+00 9.195312300845768e+03 + 17520 1.010669362886012e+00 -6.044221591353360e+00 -6.000416481077136e+00 3.444882730921969e+00 4.696418452946955e+00 9.218329125910859e+03 + 17540 9.696818064539382e-01 -5.982387257154176e+00 -5.985346195434657e+00 3.772825948990143e+00 4.755835267489407e+00 9.172112083508009e+03 + 17560 9.680526626590338e-01 -5.977833277252081e+00 -6.004938515963047e+00 3.787176163303919e+00 4.631533688103421e+00 9.232217942798026e+03 + 17580 1.014847341131473e+00 -6.041027730257754e+00 -6.002889013966105e+00 3.447511959480200e+00 4.666510370374117e+00 9.225909519957588e+03 + 17600 9.639929781539910e-01 -5.958297852564044e+00 -6.016722680928043e+00 3.886107046858323e+00 4.550622641179274e+00 9.268450157788748e+03 + 17620 1.034196136801247e+00 -6.052735836127812e+00 -6.005093962045483e+00 3.402367666734574e+00 4.675934680271492e+00 9.232696278514597e+03 + 17640 9.664300240503234e-01 -5.938142550798120e+00 -6.025207511888059e+00 4.077629333046271e+00 4.577688853208656e+00 9.294609892481116e+03 + 17660 1.018496691878853e+00 -5.998708777162175e+00 -6.025393291009647e+00 3.687772443624044e+00 4.534545835696692e+00 9.295173734317876e+03 + 17680 1.000893067325556e+00 -5.949594417650285e+00 -6.015691959030227e+00 3.923164327209895e+00 4.543622016044798e+00 9.265292685990989e+03 + 17700 9.875844681225524e-01 -5.901365411726051e+00 -6.051410544350759e+00 4.167749972521387e+00 4.306167601581083e+00 9.375555653763018e+03 + 17720 1.091080435620308e+00 -6.023496503815850e+00 -5.981246069651732e+00 3.538051346224706e+00 4.780659877428628e+00 9.159581426765624e+03 + 17740 1.044076003381774e+00 -5.922805327342090e+00 -6.015064694861939e+00 4.077079855160536e+00 4.547312289770577e+00 9.263340055211049e+03 + 17760 1.049183665095641e+00 -5.901273140642618e+00 -6.004902191024042e+00 4.223927839828479e+00 4.628873795994624e+00 9.232092851863188e+03 + 17780 1.005755360987675e+00 -5.814601715463706e+00 -6.043867885901649e+00 4.662909328192946e+00 4.346427498713062e+00 9.352179170585412e+03 + 17800 1.123798019815680e+00 -5.973260817185960e+00 -5.989676699570317e+00 3.826812094106307e+00 4.732549557105740e+00 9.185376142099378e+03 + 17820 1.098409247446478e+00 -5.927303556103620e+00 -6.036001301245498e+00 4.116500032396906e+00 4.492340758870546e+00 9.327888138208251e+03 + 17840 1.081979724386392e+00 -5.907038809368990e+00 -6.006526392232447e+00 4.202932719003422e+00 4.631659622547763e+00 9.237085743300939e+03 + 17860 1.126965292422963e+00 -5.986932840313537e+00 -6.008254895813187e+00 3.794832492086718e+00 4.672397949830306e+00 9.242401210729473e+03 + 17880 1.044496481306441e+00 -5.892342411053446e+00 -6.063586350752452e+00 4.231022726723773e+00 4.247713525058054e+00 9.413268314620746e+03 + 17900 1.072806564419027e+00 -5.974786835003923e+00 -6.020788033829181e+00 3.827999723056787e+00 4.563853720739644e+00 9.280970728889348e+03 + 17920 1.046715333447897e+00 -5.987292007077288e+00 -6.037255987939306e+00 3.704566270182039e+00 4.417665360171289e+00 9.331776613406993e+03 + 17940 9.871622359596613e-01 -5.948360585014385e+00 -5.992190839105964e+00 3.966349846148713e+00 4.714669744444965e+00 9.193103374892153e+03 + 17960 1.035759543109347e+00 -6.057212635947933e+00 -5.978937516486671e+00 3.414218575338493e+00 4.863686424320649e+00 9.152497791373864e+03 + 17980 9.276315670765530e-01 -5.922255371906326e+00 -6.041109556066617e+00 4.086760594213454e+00 4.404281476139506e+00 9.343664760364230e+03 + 18000 9.994602941231261e-01 -6.044402664126796e+00 -6.008713400103766e+00 3.446190129203910e+00 4.651123406119905e+00 9.243835523090673e+03 + 18020 1.024094209922603e+00 -6.092357347850473e+00 -5.989967330668676e+00 3.184781648302612e+00 4.772720971764443e+00 9.186307080193828e+03 + 18040 9.816932130083108e-01 -6.036685205199944e+00 -6.038198072298032e+00 3.442041014620181e+00 4.433353897627533e+00 9.334672024833904e+03 + 18060 9.977535787655942e-01 -6.065099527563580e+00 -5.989271096559059e+00 3.324435072370272e+00 4.759853657610006e+00 9.184128048579842e+03 + 18080 9.623895290207776e-01 -6.014803089909850e+00 -5.997080714813748e+00 3.635374973102222e+00 4.737139593432719e+00 9.208090313060540e+03 + 18100 9.765507279857853e-01 -6.035197675566198e+00 -5.967303356423883e+00 3.524843539810195e+00 4.914703226937302e+00 9.116943479876903e+03 + 18120 8.971790237430630e-01 -5.911094583522542e+00 -5.987842040163612e+00 4.138079145932101e+00 4.697383373268544e+00 9.179731030369752e+03 + 18140 9.865708333596941e-01 -6.030732792353082e+00 -5.960608388102626e+00 3.523216367340401e+00 4.925881548263009e+00 9.096502323646715e+03 + 18160 1.018304057735848e+00 -6.060007905136610e+00 -5.978821511271845e+00 3.396764996153095e+00 4.862949833278423e+00 9.152140998120156e+03 + 18180 9.924347898217442e-01 -6.003039951609093e+00 -6.044040735654973e+00 3.636484284390367e+00 4.401051437548098e+00 9.352710476723580e+03 + 18200 1.046266652036784e+00 -6.063193289205522e+00 -5.980215979800755e+00 3.364001410870856e+00 4.840469962170157e+00 9.156420428805473e+03 + 18220 9.726369871085755e-01 -5.933046065279984e+00 -5.997515360623295e+00 4.042440923452824e+00 4.672248253000320e+00 9.209419649889160e+03 + 18240 1.000680729655884e+00 -5.952705788170711e+00 -5.984881541696477e+00 3.964530960987230e+00 4.779772805060518e+00 9.170657502295988e+03 + 18260 1.005699594500001e+00 -5.933831727269307e+00 -5.965193077998222e+00 4.031329006744192e+00 4.851247277705419e+00 9.110487394114312e+03 + 18280 1.077118484116914e+00 -6.011938987463949e+00 -5.972701543788044e+00 3.684112583728944e+00 4.909420057290776e+00 9.133430880844697e+03 + 18300 9.990112283295048e-01 -5.869349721883754e+00 -6.063486223444696e+00 4.390070705230780e+00 4.275308870741332e+00 9.412953534466322e+03 + 18320 1.040505685339923e+00 -5.907535782941021e+00 -6.083224876144481e+00 4.192043052185379e+00 4.183209091211805e+00 9.474289646547797e+03 + 18340 1.118563194171285e+00 -6.005459271936644e+00 -6.024560363388957e+00 3.669413871015970e+00 4.559732448012436e+00 9.292612414694271e+03 + 18360 1.099393745030746e+00 -5.968688166288169e+00 -6.017803029209755e+00 3.891664277870881e+00 4.609639134474663e+00 9.271781544877773e+03 + 18380 1.117738317076156e+00 -5.995555976155166e+00 -5.996983086373443e+00 3.770579879062371e+00 4.762385191344435e+00 9.207792792265043e+03 + 18400 1.041770755613395e+00 -5.891764186029680e+00 -6.045957724228440e+00 4.228174764257883e+00 4.342771606547684e+00 9.358681210779096e+03 + 18420 1.027575024167783e+00 -5.896844691165052e+00 -6.006378082023485e+00 4.254539594701370e+00 4.625581914154795e+00 9.236629354358782e+03 + 18440 9.989424698645518e-01 -5.899582655153067e+00 -6.011609444866338e+00 4.285069783216396e+00 4.641794620593111e+00 9.252695105814415e+03 + 18460 9.898219988333975e-01 -5.942674866239423e+00 -6.016005933572570e+00 4.015193117013204e+00 4.594114780440277e+00 9.266239727358099e+03 + 18480 1.026359620543620e+00 -6.057202511932885e+00 -6.004236257917090e+00 3.397831111686383e+00 4.701971538746394e+00 9.230053984421727e+03 + 18500 1.025869181359671e+00 -6.104348736506338e+00 -5.980135102916621e+00 3.149434696908707e+00 4.862688602978540e+00 9.156148937043179e+03 + 18520 9.257468031412428e-01 -5.985508593853569e+00 -5.968532681737250e+00 3.747011174971259e+00 4.844489489357073e+00 9.120690588770034e+03 + 18540 9.340806757226165e-01 -6.013734562159490e+00 -5.958988502605152e+00 3.649352495324135e+00 4.963712841210480e+00 9.091553000402706e+03 + 18560 9.226833792012186e-01 -6.005056593501181e+00 -5.976790663540826e+00 3.632684873062655e+00 4.794992217033538e+00 9.145934760950819e+03 + 18580 9.311594308010234e-01 -6.018663656889939e+00 -6.000516935066948e+00 3.579601491288220e+00 4.683802776191961e+00 9.218636263102730e+03 + 18600 9.607203064403740e-01 -6.057463871834262e+00 -5.955373607285648e+00 3.427018480028718e+00 5.013236577484237e+00 9.080575271012531e+03 + 18620 9.025656325655277e-01 -5.959512809406918e+00 -6.003138478082454e+00 3.913893345316668e+00 4.663388004731328e+00 9.226692349740581e+03 + 18640 9.730086473705979e-01 -6.048463371971904e+00 -6.005550051740422e+00 3.411077202110857e+00 4.657492127694869e+00 9.234092058435956e+03 + 18660 1.002472387886004e+00 -6.072877927236409e+00 -5.982358126008788e+00 3.261899576598261e+00 4.781678283141228e+00 9.162989967540645e+03 + 18680 9.711716833875289e-01 -6.003946690768953e+00 -6.001325737761383e+00 3.652237620909838e+00 4.667287538670473e+00 9.221112953806361e+03 + 18700 9.776417394181699e-01 -5.988458674580767e+00 -5.979462286343042e+00 3.755231075232557e+00 4.806889728680154e+00 9.154073594432006e+03 + 18720 1.039190126550525e+00 -6.052037776888484e+00 -5.957968682897910e+00 3.451047259390530e+00 4.991206554229651e+00 9.088430624222481e+03 + 18740 9.325208894434228e-01 -5.865345146103860e+00 -5.972654384319705e+00 4.448344864899459e+00 4.832158613013132e+00 9.133259869567599e+03 + 18760 1.084241230871755e+00 -6.063466760942323e+00 -5.967047270512539e+00 3.388286944221928e+00 4.941942579137670e+00 9.116138044654517e+03 + 18780 1.034219873855957e+00 -5.963788043205668e+00 -5.997381780233737e+00 3.895170755445824e+00 4.702270318816648e+00 9.209028014885711e+03 + 18800 1.027524200554626e+00 -5.937247518026616e+00 -6.022333489177877e+00 4.047352395997275e+00 4.558775582635252e+00 9.285686377859194e+03 + 18820 1.042606426753261e+00 -5.948458897748116e+00 -5.996695846363409e+00 3.981339670646384e+00 4.704355647053702e+00 9.206885418062458e+03 + 18840 9.846616524895233e-01 -5.855936295245451e+00 -6.007386985369196e+00 4.490771455757740e+00 4.621118156148643e+00 9.239709606457935e+03 + 18860 9.827531597377804e-01 -5.849516640861546e+00 -6.042610475340859e+00 4.474940278318243e+00 4.366165599563711e+00 9.348301574462605e+03 + 18880 1.050487278046361e+00 -5.950384094827135e+00 -6.026505050937897e+00 3.987098763425120e+00 4.550000453757239e+00 9.298600101965494e+03 + 18900 1.074138258592828e+00 -5.994380072357722e+00 -6.042641419571380e+00 3.675249633927108e+00 4.398125509806937e+00 9.348436647143119e+03 + 18920 1.028872113531929e+00 -5.944464597756838e+00 -6.026192001243607e+00 3.999349926340737e+00 4.530058528244892e+00 9.297621926705824e+03 + 18940 9.864816662423845e-01 -5.903289603680446e+00 -6.046110197351942e+00 4.322969185004393e+00 4.502871234727228e+00 9.359127182003991e+03 + 18960 1.017886900590775e+00 -5.980194419187219e+00 -6.017157491682779e+00 3.806612103760398e+00 4.594364421473908e+00 9.269780889266749e+03 + 18980 1.017402625954216e+00 -6.014395730210121e+00 -5.964721089189772e+00 3.658423675158015e+00 4.943663151022712e+00 9.109076160724047e+03 + 19000 1.004287339989931e+00 -6.033159874134210e+00 -5.990131374134492e+00 3.492090827465359e+00 4.739167133102596e+00 9.186774145313242e+03 + 19020 1.012003890115472e+00 -6.086529560837555e+00 -6.003170364216685e+00 3.243757788628426e+00 4.722419195419445e+00 9.226780850812249e+03 + 19040 9.904504368572550e-01 -6.095940836385743e+00 -5.951680686907650e+00 3.234185543242030e+00 5.062549645731217e+00 9.069307441178707e+03 + 19060 9.707812024583312e-01 -6.099050664648521e+00 -5.962276201579887e+00 3.156676833149988e+00 4.942056965869842e+00 9.101615000972597e+03 + 19080 9.139075685781860e-01 -6.033038264457056e+00 -5.998883057777602e+00 3.459541841611653e+00 4.655666323866225e+00 9.213632432227274e+03 + 19100 9.048712739197019e-01 -6.026449745193111e+00 -5.977604799619012e+00 3.612187516897309e+00 4.892662753114683e+00 9.148426105659002e+03 + 19120 9.631546844864886e-01 -6.110122601418831e+00 -5.960133220159843e+00 3.127228955195803e+00 4.988491193166649e+00 9.095063047858830e+03 + 19140 9.236839053940779e-01 -6.044185621452637e+00 -6.008911316341555e+00 3.472067772666047e+00 4.674618291294957e+00 9.244430932171934e+03 + 19160 9.670729016046413e-01 -6.099982789136825e+00 -6.020983681350573e+00 3.135649673010194e+00 4.589274774991274e+00 9.281588487230300e+03 + 19180 9.580095918540483e-01 -6.075635498830700e+00 -6.018922944640721e+00 3.282261854081981e+00 4.607914116480240e+00 9.275251908513370e+03 + 19200 8.922788928148744e-01 -5.965079138059791e+00 -6.049427972223858e+00 3.841842459176597e+00 4.357498400466623e+00 9.369438040271903e+03 + 19220 9.423147495619238e-01 -6.022499256917360e+00 -6.068763917847466e+00 3.549002562262404e+00 4.283343719768598e+00 9.429359298703985e+03 + 19240 9.799665788917042e-01 -6.059909797718247e+00 -6.028200856075808e+00 3.397667228117023e+00 4.579744877970772e+00 9.303863178924732e+03 + 19260 1.015346789799016e+00 -6.092682360552907e+00 -5.994008358836891e+00 3.236361801155677e+00 4.802963188761454e+00 9.198694526828720e+03 + 19280 9.919143538314130e-01 -6.037126368621372e+00 -6.019497042861907e+00 3.544176039753963e+00 4.645406356394156e+00 9.276993348453632e+03 + 19300 9.881370581412801e-01 -6.008714595357652e+00 -6.016175405301644e+00 3.684555706437927e+00 4.641714581182917e+00 9.266780736411991e+03 + 19320 1.018084585246837e+00 -6.029793084329337e+00 -6.041317531518627e+00 3.505960208476635e+00 4.439785049313297e+00 9.344322210806500e+03 + 19340 9.740381644227906e-01 -5.942429014489933e+00 -5.986019521512296e+00 4.065539464440732e+00 4.815236027509159e+00 9.174186360396217e+03 + 19360 1.021906166421283e+00 -5.993270469396553e+00 -6.015263339168603e+00 3.748676750640689e+00 4.622390289023976e+00 9.263963389812870e+03 + 19380 1.027484245533571e+00 -5.981602644101094e+00 -6.050172399655223e+00 3.737291167499331e+00 4.343553019972148e+00 9.371726755284320e+03 + 19400 1.038869437118971e+00 -5.983189176747636e+00 -6.017254154423726e+00 3.777219291736456e+00 4.581612918382094e+00 9.270096488671337e+03 + 19420 1.020331082493819e+00 -5.944418898241981e+00 -6.031883929479714e+00 3.989733550958557e+00 4.487495806421650e+00 9.315176884390854e+03 + 19440 1.028754324950355e+00 -5.948210483208362e+00 -6.035511565467589e+00 3.975187300755447e+00 4.473890976624149e+00 9.326377269375100e+03 + 19460 1.031645237676291e+00 -5.946593043577979e+00 -6.039842305503716e+00 4.007752915246380e+00 4.472301222992156e+00 9.339780355803092e+03 + 19480 1.063097915790032e+00 -5.994061120155066e+00 -6.011542299575819e+00 3.681921458358527e+00 4.581541820920791e+00 9.252521387117764e+03 + 19500 1.044312172277415e+00 -5.972941576951937e+00 -6.017977759897184e+00 3.872961001350828e+00 4.614356269552434e+00 9.272301568102153e+03 + 19520 1.055211755483276e+00 -6.001883753103421e+00 -6.013867367722170e+00 3.729638643268829e+00 4.660826873669602e+00 9.259665643535405e+03 + 19540 1.031960801232421e+00 -5.991310518353628e+00 -5.977074735049409e+00 3.741497848456379e+00 4.823241919169551e+00 9.146797905896567e+03 + 19560 1.029964378920267e+00 -6.023271707986305e+00 -5.983519620786972e+00 3.588845231167448e+00 4.817107867481625e+00 9.166494178496401e+03 + 19580 9.636180115883948e-01 -5.967384758908694e+00 -5.993489410450480e+00 3.889132268773828e+00 4.739235319939125e+00 9.197072548817028e+03 + 19600 9.519328731428395e-01 -5.996270494745978e+00 -5.992429058897695e+00 3.734249817307903e+00 4.756307936409019e+00 9.193805618471592e+03 + 19620 1.003945377929180e+00 -6.114906973677165e+00 -6.001890354696376e+00 3.084460805992188e+00 4.733419721445143e+00 9.222855037388083e+03 + 19640 9.309550556126024e-01 -6.040386395538083e+00 -6.043421327867108e+00 3.450985243713201e+00 4.433558192625682e+00 9.350842482920929e+03 + 19660 9.149862525941476e-01 -6.039778053892229e+00 -5.995330863769185e+00 3.456728344278707e+00 4.711950988145663e+00 9.202727738638236e+03 + 19680 9.417089830562242e-01 -6.090097743919928e+00 -5.933302581640321e+00 3.250094397750714e+00 5.150436483533162e+00 9.013425848713612e+03 + 19700 9.425583203580494e-01 -6.091227855303219e+00 -5.971179488802461e+00 3.162745886576703e+00 4.852082184448731e+00 9.128804691185211e+03 + 19720 9.338559095126143e-01 -6.071924893702485e+00 -6.002960688022274e+00 3.311249037823965e+00 4.707252179016074e+00 9.226141378791503e+03 + 19740 9.896657881631955e-01 -6.143304236475532e+00 -5.973313307851650e+00 2.928959044230785e+00 4.905073262400305e+00 9.135322291705972e+03 + 19760 9.530370160237346e-01 -6.073813637508671e+00 -5.970252018811771e+00 3.356702411662521e+00 4.951369252328821e+00 9.125944990224894e+03 + 19780 9.393735981940707e-01 -6.035263782604650e+00 -5.981417350208623e+00 3.538797291210644e+00 4.847991838737109e+00 9.160083131614023e+03 + 19800 9.369171586216624e-01 -6.007974223559207e+00 -5.987295135985382e+00 3.745405313587274e+00 4.864147834514637e+00 9.178090390901396e+03 + 19820 9.667283728408363e-01 -6.026113953318115e+00 -6.019467790750278e+00 3.567860618582071e+00 4.606023912536920e+00 9.276898613878775e+03 + 19840 9.611870292986935e-01 -5.993533785216806e+00 -6.037232389145746e+00 3.734373640911056e+00 4.483449494813978e+00 9.331709711526455e+03 + 19860 1.046762414261234e+00 -6.100109318212309e+00 -6.013525901441813e+00 3.148051246568854e+00 4.645226624405479e+00 9.258648999658166e+03 + 19880 9.678062274943662e-01 -5.967315502618262e+00 -6.042937379739211e+00 3.889697325490058e+00 4.455464804613905e+00 9.349346239823937e+03 + 19900 1.039716218700582e+00 -6.063884040710181e+00 -5.988872455416274e+00 3.337031087723430e+00 4.767759218486351e+00 9.182940953958598e+03 + 19920 1.004228614601709e+00 -6.002674241545346e+00 -5.993521317203074e+00 3.754962208350164e+00 4.807519716333957e+00 9.197170733169616e+03 + 19940 1.063514127644385e+00 -6.083491000907729e+00 -5.975925569183282e+00 3.237659264177161e+00 4.855316618835698e+00 9.143299688604857e+03 + 19960 9.721350344990661e-01 -5.940961294793323e+00 -6.009243744094235e+00 4.011507354052708e+00 4.619418963491994e+00 9.245439653729172e+03 + 19980 1.074187014857956e+00 -6.087382586660635e+00 -5.986087606112245e+00 3.202703342846972e+00 4.784354796503409e+00 9.174389068442630e+03 + 20000 9.586956696805027e-01 -5.913583827036164e+00 -6.017783122639313e+00 4.180401105070656e+00 4.582072624928488e+00 9.271720245627213e+03 + 20020 9.756039964612050e-01 -5.938223060474987e+00 -6.014121543857206e+00 4.011867522438195e+00 4.576046685605153e+00 9.260448170246575e+03 + 20040 1.024830635088957e+00 -6.011083601480799e+00 -5.963956967611655e+00 3.669974047694331e+00 4.940582472193974e+00 9.106730927556020e+03 + 20060 1.018188185198244e+00 -5.999196044138616e+00 -6.032412392897958e+00 3.684332960720981e+00 4.493599545931479e+00 9.316823066095676e+03 + 20080 1.008828101022529e+00 -5.986381730614814e+00 -6.007381611468565e+00 3.738859135837844e+00 4.618274570254545e+00 9.239744045065223e+03 + 20100 1.003299685049185e+00 -5.981369048667415e+00 -6.005502564494861e+00 3.806933232966970e+00 4.668354850436272e+00 9.233940306012060e+03 + 20120 1.022102642631560e+00 -6.014727227319523e+00 -5.982229948081949e+00 3.584039058050297e+00 4.770643464370156e+00 9.162557847804454e+03 + 20140 1.012819585775307e+00 -6.006347815049013e+00 -5.992605040478459e+00 3.705351617878134e+00 4.784264756149747e+00 9.194342555830035e+03 + 20160 8.721997668502887e-01 -5.804559639797571e+00 -6.011743968543839e+00 4.731787235765315e+00 4.542102758432990e+00 9.253123265222814e+03 + 20180 1.059535973210264e+00 -6.088678107722265e+00 -5.961953522182384e+00 3.196080748060212e+00 4.923752928796441e+00 9.100615883003573e+03 + 20200 1.003960046226445e+00 -6.014397153652652e+00 -6.036276037300642e+00 3.597313985049986e+00 4.471682049396929e+00 9.328723981327856e+03 + 20220 9.419011277147145e-01 -5.936985823250719e+00 -6.015118429815407e+00 4.100721860467189e+00 4.652072342590962e+00 9.263509124530357e+03 + 20240 1.014058596329688e+00 -6.065875002694027e+00 -6.015096131487900e+00 3.309102076176239e+00 4.600682212646743e+00 9.263457950822092e+03 + 20260 9.477983078027976e-01 -5.994893495345016e+00 -6.046683254738086e+00 3.658011871577773e+00 4.360627058703400e+00 9.360915255937643e+03 + 20280 9.581065112073174e-01 -6.040470410067775e+00 -5.979596495529517e+00 3.474472948974026e+00 4.824020386460533e+00 9.154522435342553e+03 + 20300 9.655075211039569e-01 -6.078804069114625e+00 -5.981554191274677e+00 3.288130147198975e+00 4.846553995125915e+00 9.160511877585135e+03 + 20320 9.031511743790760e-01 -6.009761700494803e+00 -5.980599899218661e+00 3.683938323662654e+00 4.851389899364422e+00 9.157583338571396e+03 + 20340 9.741028720809839e-01 -6.131236638392272e+00 -5.967985419300072e+00 3.023511103671520e+00 4.960924866743442e+00 9.119032287623524e+03 + 20360 9.477872715902415e-01 -6.101909667217741e+00 -5.980645917326064e+00 3.178841672367231e+00 4.875156889749888e+00 9.157716852212659e+03 + 20380 9.373815732368236e-01 -6.088527336394848e+00 -5.949180378873124e+00 3.225238405839897e+00 5.025390199801622e+00 9.061714593003970e+03 + 20400 9.386721056251052e-01 -6.083386884752374e+00 -5.959337286331024e+00 3.267072370186400e+00 4.979384360935102e+00 9.092657456738305e+03 + 20420 9.325818861371803e-01 -6.058568025188599e+00 -6.017504144146249e+00 3.321408658786559e+00 4.557203818346787e+00 9.270872752526846e+03 + 20440 1.027756094246380e+00 -6.178193185261197e+00 -5.957337899773229e+00 2.740728844868564e+00 5.008914071385451e+00 9.086560474003487e+03 + 20460 9.359892949609220e-01 -6.013235328454130e+00 -5.981091563811965e+00 3.677683228189272e+00 4.862257698996089e+00 9.159068455995706e+03 + 20480 9.327347354459434e-01 -5.973656117344914e+00 -5.950084192481249e+00 3.850390075043141e+00 4.985743715353894e+00 9.064422611075741e+03 + 20500 9.760494945605893e-01 -5.996437193959518e+00 -5.942126101844713e+00 3.682995683398277e+00 4.994858378935827e+00 9.040223208407604e+03 + 20520 1.064669288018811e+00 -6.088403582552969e+00 -5.943944413774862e+00 3.235894337751839e+00 5.065401239859845e+00 9.045753558106526e+03 + 20540 1.009725622962596e+00 -5.976545498924846e+00 -6.006050935365019e+00 3.866114941922778e+00 4.696690159931772e+00 9.235621627260673e+03 + 20560 1.020798984763025e+00 -5.972371040192424e+00 -6.004248307383287e+00 3.907148847628986e+00 4.724104646427895e+00 9.230093763275461e+03 + 20580 1.014922822370177e+00 -5.949992799170198e+00 -6.060201214859090e+00 3.926516418225993e+00 4.293682640643170e+00 9.402761357281825e+03 + 20600 1.035017376094610e+00 -5.971567829417104e+00 -6.014885569684968e+00 3.818858765598949e+00 4.570121597582232e+00 9.262810752706142e+03 + 20620 9.924369341528846e-01 -5.905762941359292e+00 -6.018472973992654e+00 4.176942399028769e+00 4.529743949826828e+00 9.273840434356111e+03 + 20640 1.004272831117531e+00 -5.924050201231220e+00 -6.041376329475145e+00 4.107810685982058e+00 4.434105901445766e+00 9.344483719382340e+03 + 20660 1.070359738187667e+00 -6.026410415796454e+00 -6.010289110988638e+00 3.527965995096381e+00 4.620537022066714e+00 9.248648496506170e+03 + 20680 1.000825115648316e+00 -5.932211821589053e+00 -6.010017101372076e+00 4.069007760003320e+00 4.622237803161068e+00 9.247787116688058e+03 + 20700 9.784156218282832e-01 -5.909927785735512e+00 -6.008098789581702e+00 4.192575580135307e+00 4.628862484136737e+00 9.241912890781110e+03 + 20720 1.039485448953510e+00 -6.014092252199362e+00 -6.021722885459310e+00 3.616764717950337e+00 4.572948440935031e+00 9.283851138223044e+03 + 20740 1.013762993461398e+00 -5.991488397536363e+00 -6.002718241581963e+00 3.780626821542098e+00 4.716143319219515e+00 9.225383928898778e+03 + 20760 1.036376896970358e+00 -6.045063907797879e+00 -5.959670082530110e+00 3.475712869761939e+00 4.966057429101223e+00 9.093653642481759e+03 + 20780 1.008532386633857e+00 -6.024832133862389e+00 -5.991730606321353e+00 3.545473997403356e+00 4.735548090988816e+00 9.191680694821633e+03 + 20800 9.766464118561824e-01 -5.999505501909324e+00 -6.035131726297457e+00 3.645216668497414e+00 4.440645374920349e+00 9.325224648828233e+03 + 20820 9.446024657198889e-01 -5.979101014292813e+00 -6.007702836761771e+00 3.828887378173619e+00 4.664651287439140e+00 9.240714759292758e+03 + 20840 9.885425562321638e-01 -6.072009022762399e+00 -5.976413150704073e+00 3.331797246600941e+00 4.880723537373238e+00 9.144780038997740e+03 + 20860 9.675983912233611e-01 -6.069147026429859e+00 -5.999250852093621e+00 3.340290374433711e+00 4.741645023870417e+00 9.214751658438629e+03 + 20880 1.007539415987811e+00 -6.159230621788292e+00 -5.990059441077380e+00 2.834137761311104e+00 4.805544860108766e+00 9.186574161792309e+03 + 20900 8.864583481580945e-01 -6.012238019642031e+00 -5.990784656387733e+00 3.604326951909681e+00 4.727515483613091e+00 9.188796655063423e+03 + 20920 9.141891206472920e-01 -6.080614552103516e+00 -5.976176165510761e+00 3.259981731047744e+00 4.859683108651440e+00 9.144051829374790e+03 + 20940 9.069619256446170e-01 -6.091130535634698e+00 -5.980376751131521e+00 3.228218811822532e+00 4.864184181532535e+00 9.156919333980681e+03 + 20960 9.526248411065934e-01 -6.173727628757638e+00 -5.980775418837575e+00 2.789399720139843e+00 4.897361168758833e+00 9.158141587012338e+03 + 20980 9.096096454652371e-01 -6.118938499719637e+00 -6.038931110782706e+00 3.093165923539658e+00 4.552580731918942e+00 9.336952740840952e+03 + 21000 9.365221698226965e-01 -6.166605096059263e+00 -5.965616149211142e+00 2.832983088109319e+00 4.987092723850239e+00 9.111817307814172e+03 + 21020 9.112556346184451e-01 -6.127281989138037e+00 -5.980966953033772e+00 2.993054343407086e+00 4.833217922896434e+00 9.158719775518490e+03 + 21040 9.268235798308070e-01 -6.132785689707513e+00 -5.996859333116735e+00 2.967800132931297e+00 4.748310307011243e+00 9.207412308662158e+03 + 21060 9.244367475843404e-01 -6.093304357783126e+00 -5.981558294458706e+00 3.197356825093093e+00 4.839020013349320e+00 9.160544662434511e+03 + 21080 8.957194235632201e-01 -5.999548611178652e+00 -5.995281077980962e+00 3.704663401607085e+00 4.729168237626849e+00 9.202559323533784e+03 + 21100 9.843736734404599e-01 -6.075922437371969e+00 -5.997632261086396e+00 3.293515621839609e+00 4.743069929436992e+00 9.209783856209737e+03 + 21120 9.081205549317221e-01 -5.913372455935938e+00 -6.001748078532727e+00 4.175738278484628e+00 4.668271777450468e+00 9.222406346748190e+03 + 21140 9.737673673871678e-01 -5.972066505713202e+00 -5.985939544226416e+00 3.894349284933486e+00 4.814688150944840e+00 9.173920528639239e+03 + 21160 1.016562213495425e+00 -6.004467334952213e+00 -6.032226365365413e+00 3.653250336275875e+00 4.493853687947204e+00 9.316256487405703e+03 + 21180 1.029830237359170e+00 -6.000884522002250e+00 -6.050430119233621e+00 3.667181401043314e+00 4.382682914584391e+00 9.372520531395354e+03 + 21200 1.033156538720732e+00 -5.990760422829060e+00 -5.993000899215175e+00 3.787066692664143e+00 4.774201530542470e+00 9.195596300194788e+03 + 21220 1.061892922765096e+00 -6.021939963897680e+00 -5.990187704182897e+00 3.627675232080608e+00 4.810001621009198e+00 9.186942744340467e+03 + 21240 1.045921093388182e+00 -5.990383124417299e+00 -5.974194067069547e+00 3.775227737758645e+00 4.868187810297969e+00 9.138010290881450e+03 + 21260 1.068873558382580e+00 -6.019154586544250e+00 -5.986908808568401e+00 3.625957498919632e+00 4.811117746074974e+00 9.176895525859767e+03 + 21280 1.031638557717918e+00 -5.961335127595028e+00 -6.022029766283485e+00 3.962963709722696e+00 4.614445701908597e+00 9.284780972826964e+03 + 21300 1.011440818498198e+00 -5.932982530892483e+00 -6.046533574497506e+00 4.050427334110070e+00 4.398399669762822e+00 9.360434439791457e+03 + 21320 1.004474598014488e+00 -5.929860919434580e+00 -6.017367660051163e+00 4.079207621346967e+00 4.576730375102199e+00 9.270446925032566e+03 + 21340 1.014423505839948e+00 -5.955968371467351e+00 -6.017158822560202e+00 3.937392677489328e+00 4.586027638122482e+00 9.269786182435941e+03 + 21360 1.010594055482384e+00 -5.963883585107683e+00 -6.070783879634211e+00 3.904902496701473e+00 4.291064462763035e+00 9.435614470467932e+03 + 21380 1.055327599875555e+00 -6.052826924943264e+00 -6.001990462072757e+00 3.419658579153863e+00 4.711569415873518e+00 9.223184820365814e+03 + 21400 9.975408411506242e-01 -5.992208190105005e+00 -6.021850149561996e+00 3.705000970293903e+00 4.534792252013459e+00 9.284260834483148e+03 + 21420 1.025642296858505e+00 -6.062190618954173e+00 -6.018367055593384e+00 3.360055822319629e+00 4.611697504811791e+00 9.273536254476159e+03 + 21440 1.016766395486329e+00 -6.079802132743065e+00 -5.980606199480831e+00 3.315393813540257e+00 4.884992212853070e+00 9.157621278326009e+03 + 21460 9.884973136514468e-01 -6.065133912753671e+00 -5.962649803357463e+00 3.390972160097218e+00 4.979451775614922e+00 9.102755922781651e+03 + 21480 1.010045460136650e+00 -6.119545900930342e+00 -5.958397366361438e+00 3.059819775078156e+00 4.985159598227938e+00 9.089785348669584e+03 + 21500 9.578084942327825e-01 -6.059314701002214e+00 -5.978579715789180e+00 3.348996709232883e+00 4.812589488024709e+00 9.151423119973959e+03 + 21520 9.349516294469200e-01 -6.035245550338884e+00 -6.002073164638952e+00 3.509186141398508e+00 4.699667113497616e+00 9.223424354614353e+03 + 21540 9.485861074112382e-01 -6.061787962923744e+00 -5.994808200048660e+00 3.397018227220127e+00 4.781626390733664e+00 9.201108127693344e+03 + 21560 9.512816409476849e-01 -6.066516277500308e+00 -5.989075768216615e+00 3.302934764173889e+00 4.747610152360936e+00 9.183574236931976e+03 + 21580 9.426794807895247e-01 -6.047964168488923e+00 -6.002976249111178e+00 3.422451600340873e+00 4.680779195265902e+00 9.226193791750682e+03 + 21600 9.449658705086974e-01 -6.038657325959218e+00 -5.977819523435237e+00 3.489491714430772e+00 4.838831791142988e+00 9.149097409079393e+03 + 21620 9.676819121743778e-01 -6.051111354044293e+00 -6.001066440797603e+00 3.372741846150461e+00 4.660107482438255e+00 9.220332183394996e+03 + 21640 9.777314517561777e-01 -6.031447106639646e+00 -6.020783341253719e+00 3.548447118661793e+00 4.609680109720141e+00 9.280978746535984e+03 + 21660 1.009192771368310e+00 -6.032766848594189e+00 -6.000590934896252e+00 3.522246636256921e+00 4.707005711917033e+00 9.218869083287937e+03 + 21680 9.848068732729762e-01 -5.943658805804026e+00 -5.988675122241485e+00 3.992938760823892e+00 4.734448105587548e+00 9.182307674139849e+03 + 21700 9.850759726715091e-01 -5.892786542244903e+00 -6.033034956550161e+00 4.240749148245754e+00 4.435421049932992e+00 9.318730682554666e+03 + 21720 1.069009067469885e+00 -5.977671844398080e+00 -5.978449292470763e+00 3.789812511153447e+00 4.785348284010405e+00 9.150998118247298e+03 + 21740 9.985408225603840e-01 -5.850813519849134e+00 -5.994194924080292e+00 4.506217486924694e+00 4.682899275628788e+00 9.199207884679307e+03 + 21760 1.006665657395554e+00 -5.849959949410122e+00 -6.013709872425877e+00 4.505062700051891e+00 4.564785301876740e+00 9.259178029298280e+03 + 21780 1.075698481524050e+00 -5.948212204628414e+00 -6.020590101010090e+00 3.956502386303996e+00 4.540897304837141e+00 9.280367584291802e+03 + 21800 1.072724877866037e+00 -5.949090381355365e+00 -6.044677002447319e+00 3.955825524782365e+00 4.406952354490558e+00 9.354708236722661e+03 + 21820 1.083362560344358e+00 -5.979752018580949e+00 -6.011245002695928e+00 3.787977412481804e+00 4.607139824170053e+00 9.251589064039325e+03 + 21840 1.008298683611080e+00 -5.885785902874779e+00 -6.005374769194457e+00 4.279631116163903e+00 4.592933339439054e+00 9.233545001151000e+03 + 21860 1.042594847959691e+00 -5.954409882112978e+00 -5.989907250401030e+00 3.943344889009151e+00 4.739513507099168e+00 9.186069773565097e+03 + 21880 1.037313946132831e+00 -5.967067749895882e+00 -6.011126282825774e+00 3.858866275201810e+00 4.605875361082431e+00 9.251238336109820e+03 + 21900 1.013766167698136e+00 -5.955929350455447e+00 -6.026652121017448e+00 3.948403410587580e+00 4.542302317707199e+00 9.299053677199034e+03 + 21920 1.020658019567199e+00 -5.991852672124380e+00 -6.021677855296451e+00 3.742317996111643e+00 4.571057178905432e+00 9.283738749959868e+03 + 21940 9.744100464971485e-01 -5.949939182578109e+00 -6.012624954792670e+00 3.987329325038448e+00 4.627377920390538e+00 9.255840082354114e+03 + 21960 9.675134840772445e-01 -5.964091547591459e+00 -6.031460403349347e+00 3.875148110523191e+00 4.488305715464666e+00 9.313864275290711e+03 + 21980 9.965240078580956e-01 -6.028855341028070e+00 -5.980371027582361e+00 3.577373509105057e+00 4.855777939833571e+00 9.156886667697847e+03 + 22000 9.514271935528292e-01 -5.978725219301328e+00 -6.002184008286664e+00 3.829364883209661e+00 4.694660886619998e+00 9.223739474557260e+03 + 22020 9.940460504694612e-01 -6.053964678985806e+00 -5.986831637509244e+00 3.415995010383648e+00 4.801483323346661e+00 9.176663964427968e+03 + 22040 9.719485391705455e-01 -6.029278208990231e+00 -5.991723920364276e+00 3.545435232982013e+00 4.761077769779633e+00 9.191655688369992e+03 + 22060 9.844209782252207e-01 -6.053751321569300e+00 -5.979806655652412e+00 3.423732491828641e+00 4.848334206423482e+00 9.155156884698168e+03 + 22080 9.592794508616364e-01 -6.016574359548541e+00 -6.020250549548290e+00 3.663958804235392e+00 4.642849552368268e+00 9.279315264681192e+03 + 22100 1.023651492186338e+00 -6.109115730645064e+00 -6.010538965456517e+00 3.139821084557475e+00 4.705864124975221e+00 9.249457870362703e+03 + 22120 1.008033729000489e+00 -6.082937691699531e+00 -6.028868719305971e+00 3.263651504590349e+00 4.574123911220603e+00 9.305888837061453e+03 + 22140 9.824960942319197e-01 -6.041214244588620e+00 -6.000853581009070e+00 3.488894169952543e+00 4.720651346018823e+00 9.219666248041431e+03 + 22160 1.010276049584021e+00 -6.075113036284337e+00 -5.989512184668444e+00 3.258883682275347e+00 4.750417018942787e+00 9.184895881659224e+03 + 22180 9.353748266889038e-01 -5.949551967301566e+00 -6.028225921052252e+00 3.961522276614026e+00 4.509764259422592e+00 9.303903094277826e+03 + 22200 9.996989232830139e-01 -6.020325095745490e+00 -6.009770851143893e+00 3.580917270329521e+00 4.641521376095965e+00 9.247069465388709e+03 + 22220 9.861438845340266e-01 -5.961722502281965e+00 -6.007642542328646e+00 3.957152664314655e+00 4.693472688263383e+00 9.240476624924002e+03 + 22240 1.046043078650233e+00 -5.997881735028341e+00 -5.964315165180904e+00 3.679828328467466e+00 4.872572766941348e+00 9.107825262752171e+03 + 22260 1.053182331913205e+00 -5.949519124357746e+00 -6.010140922069191e+00 3.963550163355416e+00 4.615450419703420e+00 9.248211566984630e+03 + 22280 1.096347242595124e+00 -5.964582630634802e+00 -6.031121718245451e+00 3.855072185912874e+00 4.472994447961998e+00 9.312851940279308e+03 + 22300 1.073406091764057e+00 -5.902286317063940e+00 -6.018406385786178e+00 4.283642576212900e+00 4.616863172087251e+00 9.273639020026389e+03 + 22320 1.082572063366422e+00 -5.901086255333301e+00 -6.010931580131981e+00 4.211076609642139e+00 4.580327756139044e+00 9.250653831293233e+03 + 22340 1.181265590861121e+00 -6.045206200201357e+00 -6.032171183353801e+00 3.452369293262064e+00 4.527218377163067e+00 9.316088359244253e+03 + 22360 1.070377914366425e+00 -5.893945485931649e+00 -6.016880076334583e+00 4.243722153004058e+00 4.537812710844032e+00 9.268955739288724e+03 + 22380 1.014543204043877e+00 -5.829672271678801e+00 -5.981786851422060e+00 4.632704599328211e+00 4.759239142787278e+00 9.161192506153317e+03 + 22400 1.069340436156244e+00 -5.933349382029788e+00 -6.018674882507375e+00 3.992111131769074e+00 4.502158903948240e+00 9.274442725661889e+03 + 22420 1.119155558288320e+00 -6.039960209364453e+00 -5.971688244840399e+00 3.515656067588013e+00 4.907684252937493e+00 9.130348613789605e+03 + 22440 9.734179805720071e-01 -5.856359845697537e+00 -6.014674676508955e+00 4.407584241039862e+00 4.498515983379813e+00 9.262138398825888e+03 + 22460 1.040780816899016e+00 -5.985593721370673e+00 -5.975410562713689e+00 3.767570694760452e+00 4.826043967607568e+00 9.141688790996766e+03 + 22480 1.024306935468777e+00 -5.988592252014897e+00 -5.947910658708029e+00 3.777813271464962e+00 5.011413275689216e+00 9.057835723060265e+03 + 22500 9.840836883913052e-01 -5.951782520760736e+00 -5.962194322211336e+00 3.947054966223592e+00 4.887268791073176e+00 9.101342073097358e+03 + 22520 9.992756851528051e-01 -5.991191696073945e+00 -5.913112153546153e+00 3.756400387987090e+00 5.204745203951831e+00 8.952231025049852e+03 + 22540 9.837775373285002e-01 -5.978395146362014e+00 -5.968802148716978e+00 3.823783034856672e+00 4.878867511846052e+00 9.121517918125746e+03 + 22560 1.019555877357196e+00 -6.040789817867394e+00 -5.991431098364913e+00 3.472009768291402e+00 4.755435173911808e+00 9.190762857809254e+03 + 22580 9.463161607538978e-01 -5.938498921292265e+00 -6.049693568904718e+00 4.011622944475823e+00 4.373126070569007e+00 9.370215388010241e+03 + 22600 9.898006887993822e-01 -6.009656070448387e+00 -6.027632766083134e+00 3.598216233656488e+00 4.494991265437112e+00 9.302064298511470e+03 + 22620 9.703096377169923e-01 -5.987251063387972e+00 -5.972646183852948e+00 3.788208775985933e+00 4.872072254373843e+00 9.133244423999313e+03 + 22640 9.441460560558099e-01 -5.949753448375971e+00 -5.995070278999011e+00 4.006842213288429e+00 4.746625959094063e+00 9.201904599576317e+03 + 22660 1.054618695011741e+00 -6.111589657622789e+00 -5.948460051883800e+00 3.128259562524306e+00 5.064975002902484e+00 9.059509561344194e+03 + 22680 9.582606069399543e-01 -5.966437417074094e+00 -6.008598380471077e+00 3.866905073332547e+00 4.624810297119073e+00 9.243457425567231e+03 + 22700 9.460516819600393e-01 -5.945374419853894e+00 -6.002081388564481e+00 4.042012454108173e+00 4.716392264396932e+00 9.223413993480221e+03 + 22720 1.040581912797539e+00 -6.081430718517721e+00 -5.953596058683428e+00 3.240347787265607e+00 4.974394186383794e+00 9.075149659419869e+03 + 22740 9.535704020508389e-01 -5.943054055505801e+00 -5.991033890392194e+00 4.053058297781253e+00 4.777550661008129e+00 9.189526224982092e+03 + 22760 9.974254094980254e-01 -5.992677587976494e+00 -5.972812250639418e+00 3.762867175099884e+00 4.876937016240396e+00 9.133754013189860e+03 + 22780 1.004783522576845e+00 -5.978358447020567e+00 -6.018810047434065e+00 3.782968263145299e+00 4.550688913706064e+00 9.274863629923353e+03 + 22800 1.080523698017781e+00 -6.054307864097428e+00 -5.962099331798464e+00 3.434685608582307e+00 4.964161270267216e+00 9.101060874423354e+03 + 22820 1.063693743997020e+00 -5.983574287729931e+00 -5.993230009828820e+00 3.744249741259245e+00 4.688805090749262e+00 9.196285771164730e+03 + 22840 1.119112864451027e+00 -6.015462251321929e+00 -5.961193020173469e+00 3.612882258490450e+00 4.924504581881285e+00 9.098295137522528e+03 + 22860 1.063782555745310e+00 -5.890024205836619e+00 -5.987539362433659e+00 4.297581793887479e+00 4.737634674285562e+00 9.178777961110016e+03 + 22880 1.068451338663774e+00 -5.861001028075132e+00 -6.013749277712171e+00 4.448042305103737e+00 4.570938217972621e+00 9.259266197591669e+03 + 22900 1.068906187388771e+00 -5.839502786681755e+00 -6.046575195377505e+00 4.538483471093286e+00 4.349441656010607e+00 9.360536486486935e+03 + 22920 1.111270344287865e+00 -5.896598072330429e+00 -6.028859095114656e+00 4.265777692275742e+00 4.506314432121578e+00 9.305808052386701e+03 + 22940 1.119718320805876e+00 -5.915827619680201e+00 -5.991195709505258e+00 4.154103336072158e+00 4.721328101122471e+00 9.190014538502810e+03 + 22960 1.105020944910178e+00 -5.910177952835169e+00 -5.967183170094396e+00 4.197972649005118e+00 4.870639869973776e+00 9.116555807129311e+03 + 22980 1.021123989721004e+00 -5.807945552474302e+00 -6.032231819232560e+00 4.687579603982824e+00 4.399693152069294e+00 9.316255854639892e+03 + 23000 1.144029870539443e+00 -6.023475325563410e+00 -6.019558874552592e+00 3.563935559727535e+00 4.586424427500488e+00 9.277181656122446e+03 + 23020 1.091103485819771e+00 -5.985391724783264e+00 -6.009059842420667e+00 3.741842292170433e+00 4.605936298067103e+00 9.244894553436716e+03 + 23040 1.023574239504814e+00 -5.923342553679900e+00 -5.982409594774756e+00 4.084761431822979e+00 4.745589341261248e+00 9.163104484241052e+03 + 23060 9.952255141534451e-01 -5.908449471125698e+00 -6.023783446825103e+00 4.158628551360158e+00 4.496363015019118e+00 9.290184483163805e+03 + 23080 1.001403901351069e+00 -5.938150107064108e+00 -6.056905579539535e+00 3.955646867601502e+00 4.273734567297628e+00 9.392542303126103e+03 + 23100 1.027451214775791e+00 -5.994019202958555e+00 -5.988975959549632e+00 3.702739677653376e+00 4.731698761746809e+00 9.183241952688044e+03 + 23120 1.013257738501018e+00 -5.987349157230756e+00 -6.005869350688939e+00 3.746995560980489e+00 4.640649744152931e+00 9.235067754429323e+03 + 23140 1.036110992070139e+00 -6.034287519024865e+00 -5.973202125597413e+00 3.513212437853774e+00 4.863974219848284e+00 9.134968835715928e+03 + 23160 9.360748138517090e-01 -5.896440434896551e+00 -6.004644535775131e+00 4.216635066153907e+00 4.595310374378606e+00 9.231322570716842e+03 + 23180 1.026066821955168e+00 -6.038099086107348e+00 -5.928296953753506e+00 3.504583103006823e+00 5.135083938807652e+00 8.998247400933033e+03 + 23200 9.560960622990720e-01 -5.939639739019891e+00 -5.997572306913449e+00 4.019557574005027e+00 4.686899804124312e+00 9.209599082812059e+03 + 23220 9.820471201951061e-01 -5.982215508457016e+00 -5.998659008715363e+00 3.723330331301858e+00 4.628909208194992e+00 9.212933404207432e+03 + 23240 9.418746555245011e-01 -5.925615721121098e+00 -6.020567219513699e+00 4.084619760982378e+00 4.539393563515178e+00 9.280289579632277e+03 + 23260 1.014601203315200e+00 -6.036707515405468e+00 -5.995162462178644e+00 3.503680193404550e+00 4.742238318109182e+00 9.202196986540424e+03 + 23280 9.388994381726942e-01 -5.928133972456029e+00 -5.976393187828457e+00 4.105271839647507e+00 4.828159956889586e+00 9.144698832051074e+03 + 23300 9.542630305527271e-01 -5.950432322003468e+00 -5.973462127287819e+00 3.947909377253916e+00 4.815668671460324e+00 9.135738502720045e+03 + 23320 9.924028584752060e-01 -6.001282462041309e+00 -6.023426900656155e+00 3.663895990895331e+00 4.536739197528084e+00 9.289116967440455e+03 + 23340 1.004880788203612e+00 -6.013758343791251e+00 -6.031047686738633e+00 3.596504558901734e+00 4.497226476180693e+00 9.312609423010450e+03 + 23360 1.001626532896770e+00 -6.003802855534238e+00 -5.995821690203309e+00 3.719997732066550e+00 4.765826818478092e+00 9.204227877097685e+03 + 23380 1.075079859372530e+00 -6.106255996314603e+00 -5.975570499735172e+00 3.097138628478355e+00 4.847554973352690e+00 9.142202597418596e+03 + 23400 1.080998360726217e+00 -6.105552819587765e+00 -5.975717473836726e+00 3.115059447338586e+00 4.860594094595877e+00 9.142638568486771e+03 + 23420 9.269649245232087e-01 -5.866191048896711e+00 -6.031509639548976e+00 4.459941157371730e+00 4.510656226877201e+00 9.314004663519225e+03 + 23440 1.044080876356171e+00 -6.025678328778124e+00 -6.016087240496591e+00 3.527163211134529e+00 4.582236724263202e+00 9.266496527060257e+03 + 23460 1.007026315920273e+00 -5.955704464726350e+00 -5.985788390553695e+00 3.888176174897633e+00 4.715429617324538e+00 9.173457191378859e+03 + 23480 1.032818932394846e+00 -5.976226719858841e+00 -5.988906246413413e+00 3.810509633646745e+00 4.737701830020002e+00 9.183011841605983e+03 + 23500 1.087663353514909e+00 -6.037608708573009e+00 -6.004531187988261e+00 3.506907679548012e+00 4.696843921475401e+00 9.230964891534377e+03 + 23520 9.849033068221833e-01 -5.867422697183307e+00 -6.059389077016779e+00 4.357319617590001e+00 4.255018957884935e+00 9.400284885803161e+03 + 23540 1.058612545373282e+00 -5.964902548644724e+00 -6.014654950315041e+00 3.904130572765705e+00 4.618444583215465e+00 9.262073840245957e+03 + 23560 1.096445406158602e+00 -6.013747574932844e+00 -5.983950739595115e+00 3.645279096644945e+00 4.816377136199550e+00 9.167835940152110e+03 + 23580 1.021920940851455e+00 -5.900664264312986e+00 -5.994217737140208e+00 4.203482924410968e+00 4.666284406083925e+00 9.199274654210272e+03 + 23600 1.106586320532422e+00 -6.026640714960187e+00 -5.938142022461502e+00 3.573286208726709e+00 5.081459396182565e+00 9.028105304869983e+03 + 23620 1.031811840247262e+00 -5.921324431279090e+00 -6.020982003015754e+00 4.128534598579947e+00 4.556285399708637e+00 9.281550359591085e+03 + 23640 1.021191360886209e+00 -5.920870321020116e+00 -5.998713046809233e+00 4.105838583983660e+00 4.658853606379666e+00 9.213060295173513e+03 + 23660 9.872272921241033e-01 -5.890653174973520e+00 -6.023119448966434e+00 4.265095266583923e+00 4.504453422226962e+00 9.288165939887182e+03 + 23680 1.012687471101928e+00 -5.959179157843993e+00 -6.024480283763479e+00 3.874395108736938e+00 4.499425938390673e+00 9.292364121601302e+03 + 23700 9.934297238211419e-01 -5.962928502233890e+00 -6.001805855219794e+00 3.861556840771734e+00 4.638317063675745e+00 9.222605207181952e+03 + 23720 1.078226194596499e+00 -6.124120487956777e+00 -6.004538780371904e+00 2.995351044577188e+00 4.682007714738971e+00 9.230995142334918e+03 + 23740 9.403619580013592e-01 -5.958193796616512e+00 -6.059036450516951e+00 3.891960369018971e+00 4.312906244972392e+00 9.399166996234069e+03 + 23760 1.012222690981270e+00 -6.099402651171915e+00 -5.976651702140102e+00 3.140908086043059e+00 4.845763031031701e+00 9.145525785806172e+03 + 23780 9.305538574137315e-01 -6.002194836756610e+00 -5.999902237015148e+00 3.695005359351923e+00 4.708169821846062e+00 9.216744952368213e+03 + 23800 9.304659910525171e-01 -6.017635132405653e+00 -5.985174734338973e+00 3.568907173128490e+00 4.755299802057738e+00 9.171601896644212e+03 + 23820 9.663426486823621e-01 -6.077715637619503e+00 -5.987059904476306e+00 3.282620684705434e+00 4.803179933343033e+00 9.177383333311871e+03 + 23840 9.768528292112534e-01 -6.095334867204607e+00 -6.023412476181182e+00 3.148048716204886e+00 4.561038215415431e+00 9.289081452640989e+03 + 23860 9.728887630069939e-01 -6.089337438589326e+00 -5.984068468589230e+00 3.224631306464780e+00 4.829102022525790e+00 9.168225142368639e+03 + 23880 9.388410794631378e-01 -6.033714612426442e+00 -5.986022127306610e+00 3.514474623913572e+00 4.788332253859863e+00 9.174200288748556e+03 + 23900 9.398909621796898e-01 -6.023834787390280e+00 -6.011440829856431e+00 3.565139647439149e+00 4.636307669557240e+00 9.252203423194616e+03 + 23920 9.617276936542071e-01 -6.040298793827024e+00 -6.014503874899810e+00 3.488551622556811e+00 4.636670038787674e+00 9.261629845246161e+03 + 23940 9.982468550161129e-01 -6.075217026117334e+00 -5.996074885780695e+00 3.320448620161547e+00 4.774895037181163e+00 9.205009635862118e+03 + 23960 9.950743358065683e-01 -6.050015329793554e+00 -6.008786555733002e+00 3.444909133640445e+00 4.681651134428307e+00 9.244035468228272e+03 + 23980 9.984518829605556e-01 -6.034363734355538e+00 -6.015387406415675e+00 3.493260527924752e+00 4.602225539532707e+00 9.264340947957600e+03 + 24000 9.901066727809733e-01 -5.999955087889771e+00 -6.002442554528635e+00 3.686744449890698e+00 4.672461031516127e+00 9.224518900457093e+03 + 24020 9.929144194602537e-01 -5.984044373109232e+00 -5.950715316965018e+00 3.786412932251656e+00 4.977793530286505e+00 9.066342661911020e+03 + 24040 1.053449424471868e+00 -6.053023077655664e+00 -5.953513403951625e+00 3.384182363420871e+00 4.955582308901699e+00 9.074876687387617e+03 + 24060 9.935963053243630e-01 -5.944789489477801e+00 -6.008585743944305e+00 3.975164767478685e+00 4.608836801893545e+00 9.243394778199807e+03 + 24080 1.008598837588408e+00 -5.952312361908022e+00 -5.983852095747551e+00 3.948743651748072e+00 4.767637619283461e+00 9.167542194563657e+03 + 24100 1.039617793378025e+00 -5.988883696873023e+00 -6.007373191184286e+00 3.770035663566809e+00 4.663866125991538e+00 9.239687609096258e+03 + 24120 1.032876852952362e+00 -5.976306552788454e+00 -6.023190614570858e+00 3.822725042292434e+00 4.553509504252758e+00 9.288373326818131e+03 + 24140 1.025908166184252e+00 -5.967606891553671e+00 -6.020841763957241e+00 3.852449591463940e+00 4.546766716052756e+00 9.281136792898273e+03 + 24160 1.015692766037965e+00 -5.954689844650210e+00 -6.008156189477858e+00 3.958481694382245e+00 4.651469668491773e+00 9.242101515639601e+03 + 24180 1.006454058534310e+00 -5.945568399362463e+00 -6.017971298147499e+00 3.974610237219224e+00 4.558861588083172e+00 9.272309808642991e+03 + 24200 1.024115924726461e+00 -5.978118008870537e+00 -6.033761538569079e+00 3.789874096924634e+00 4.470360338587216e+00 9.320981050546647e+03 + 24220 1.014009007421846e+00 -5.971649602304685e+00 -6.037922524755314e+00 3.785225670718830e+00 4.404676294305718e+00 9.333851538324097e+03 + 24240 1.030588317741757e+00 -6.006672940371399e+00 -6.011131369064864e+00 3.665240487915033e+00 4.639639500417551e+00 9.251259649248190e+03 + 24260 1.032799083574534e+00 -6.020154086524438e+00 -6.049082870836463e+00 3.580558749123652e+00 4.414445192889101e+00 9.368330949739693e+03 + 24280 8.944599349795245e-01 -5.829340751136027e+00 -6.064005914682426e+00 4.525360427909154e+00 4.177876744509038e+00 9.414576138284774e+03 + 24300 9.984967493431696e-01 -5.998065518296047e+00 -6.012397270671221e+00 3.687733260887534e+00 4.605438120917771e+00 9.255152399831215e+03 + 24320 1.000641457247221e+00 -6.016333819899034e+00 -5.992009949304992e+00 3.607765897294534e+00 4.747437326352333e+00 9.192521933323615e+03 + 24340 9.728665242258239e-01 -5.987664549132372e+00 -5.974382593663725e+00 3.810742786184715e+00 4.887009829861654e+00 9.138570172302190e+03 + 24360 1.049782005888907e+00 -6.113353404207963e+00 -5.998355015900117e+00 3.051074317684598e+00 4.711412859291327e+00 9.211986554953890e+03 + 24380 9.076967398382690e-01 -5.915401481724168e+00 -6.048827615953693e+00 4.073693600363690e+00 4.307540089990217e+00 9.367521527726327e+03 + 24400 9.853708998684139e-01 -6.042337333545764e+00 -5.963533815626914e+00 3.492684247633987e+00 4.945186242329008e+00 9.105453058091221e+03 + 24420 9.779519209529595e-01 -6.039217823812852e+00 -5.982024902690989e+00 3.507927951457429e+00 4.836338555115105e+00 9.161959571779769e+03 + 24440 1.028652883327693e+00 -6.120956960367353e+00 -5.989536879812207e+00 3.008273216642551e+00 4.762907656381937e+00 9.184961740985927e+03 + 24460 9.754193826709597e-01 -6.048594076886068e+00 -5.974945186944693e+00 3.462235479865352e+00 4.885138803037610e+00 9.140287951871136e+03 + 24480 9.656359340516233e-01 -6.038614144376597e+00 -5.979534522678211e+00 3.520536971938327e+00 4.859781302272367e+00 9.154351555935047e+03 + 24500 1.008526626519664e+00 -6.105233611852269e+00 -5.988412824788652e+00 3.131829585097349e+00 4.802632622375015e+00 9.181522130583477e+03 + 24520 9.969122859136935e-01 -6.087314278833569e+00 -5.999540133622036e+00 3.257531189292348e+00 4.761543914102045e+00 9.215644215804412e+03 + 24540 9.181038418559867e-01 -5.964679850640079e+00 -5.994147339615951e+00 3.867771643814020e+00 4.698564762035376e+00 9.199112627833223e+03 + 24560 1.007928009966990e+00 -6.087389977851733e+00 -5.943300740239629e+00 3.249019148156082e+00 5.076401848262242e+00 9.043824272441392e+03 + 24580 9.846035585755484e-01 -6.033939775796517e+00 -5.964125514380301e+00 3.528363626743388e+00 4.929247919517339e+00 9.107247058342849e+03 + 24600 9.619141770738985e-01 -5.975134743821143e+00 -6.025218221592451e+00 3.837838139796431e+00 4.550251060040445e+00 9.294615637178467e+03 + 24620 1.023646910950984e+00 -6.033321914606761e+00 -6.012999052096410e+00 3.476467437844374e+00 4.593164459331623e+00 9.257011041563977e+03 + 24640 9.883181429912322e-01 -5.948330359022422e+00 -6.035392655396787e+00 3.937262828286544e+00 4.437337649658119e+00 9.326028120266761e+03 + 24660 1.008587650953296e+00 -5.947951848998422e+00 -6.033533098607539e+00 3.966342186939557e+00 4.474921408028435e+00 9.320276445989561e+03 + 24680 1.023254873262603e+00 -5.942590734834437e+00 -6.032882377788955e+00 4.014909530314265e+00 4.496440943882837e+00 9.318280958244395e+03 + 24700 1.073539035883313e+00 -5.997036371014651e+00 -6.029657702130103e+00 3.701454470217791e+00 4.514137738818192e+00 9.308328241112104e+03 + 24720 1.038188085381236e+00 -5.931371427502929e+00 -6.004637934558472e+00 4.103791422207566e+00 4.683083800739309e+00 9.231289125006366e+03 + 24740 9.802546081976065e-01 -5.838075729215221e+00 -6.007934658251597e+00 4.509943179440929e+00 4.534586923329742e+00 9.241382657432108e+03 + 24760 9.834801348740070e-01 -5.838179462243146e+00 -6.007101615886058e+00 4.671572517744147e+00 4.701595370907753e+00 9.238757736126970e+03 + 24780 1.046907427566315e+00 -5.931176979289883e+00 -5.999845118449656e+00 4.095330241738809e+00 4.701027160323200e+00 9.216545822879083e+03 + 24800 9.890970830678699e-01 -5.847406693819051e+00 -6.079671023959563e+00 4.558458496441965e+00 4.224760769986217e+00 9.463224662646033e+03 + 24820 1.068559716326653e+00 -5.977219689017462e+00 -5.991263312565978e+00 3.858753823138704e+00 4.778113163479407e+00 9.190247926388634e+03 + 24840 1.050447079513754e+00 -5.973374618087465e+00 -5.972591787885340e+00 3.862101608747089e+00 4.866596740910275e+00 9.133079102457024e+03 + 24860 9.551455620169513e-01 -5.860338322110857e+00 -6.027558197246420e+00 4.496625165197022e+00 4.536422764976572e+00 9.301829675585021e+03 + 24880 1.053568666978196e+00 -6.044066388791570e+00 -6.010510090972565e+00 3.480992978384114e+00 4.673678433281143e+00 9.249292884414992e+03 + 24900 9.934772947553909e-01 -5.998574687659675e+00 -5.994498741814298e+00 3.756579578838002e+00 4.779984290632738e+00 9.200160648668938e+03 + 24920 1.004819662220164e+00 -6.058019066789635e+00 -5.986443841933086e+00 3.429190632730087e+00 4.840186650086642e+00 9.175495814353388e+03 + 24940 9.333766607446183e-01 -5.988007906607703e+00 -6.017201745293049e+00 3.815197354523459e+00 4.647561815060273e+00 9.269945824054810e+03 + 24960 9.953118360004829e-01 -6.106414217729097e+00 -5.977875797227708e+00 3.142405259665446e+00 4.880492761440710e+00 9.149286197136549e+03 + 24980 9.389609694247300e-01 -6.039424169451664e+00 -5.976784515608776e+00 3.524021883344068e+00 4.883708469165033e+00 9.145943940355732e+03 + 25000 1.021298406554060e+00 -6.169012586067874e+00 -6.005738496142936e+00 2.772375931114391e+00 4.709921022047144e+00 9.234681365900948e+03 + 25020 8.970199456774209e-01 -5.986254756516197e+00 -6.006852939454157e+00 3.834418343047697e+00 4.716140389059425e+00 9.238093082762227e+03 + 25040 9.373766569826291e-01 -6.042144058863648e+00 -6.015084473687793e+00 3.511768192894261e+00 4.667148518431291e+00 9.263417427618378e+03 + 25060 9.169179660995167e-01 -6.004177197307262e+00 -6.009543737577303e+00 3.673622376089657e+00 4.642806871389663e+00 9.246359993713751e+03 + 25080 9.661187661701454e-01 -6.066098162929717e+00 -5.983018729953681e+00 3.426768430183138e+00 4.903823390832239e+00 9.164995970482374e+03 + 25100 9.787966407415332e-01 -6.069206545454048e+00 -6.015661738131121e+00 3.267330985244146e+00 4.574793554924549e+00 9.265191817880988e+03 + 25120 9.788892251486335e-01 -6.052718361386717e+00 -5.972015810813353e+00 3.439840900283265e+00 4.903247434354856e+00 9.131336575125084e+03 + 25140 9.681513771096300e-01 -6.019451892538259e+00 -6.012200995749929e+00 3.561702971319687e+00 4.603338742750935e+00 9.254547249860325e+03 + 25160 9.309128777984570e-01 -5.945241626197062e+00 -6.034964567071962e+00 4.004836446876724e+00 4.489633435792817e+00 9.324691503959575e+03 + 25180 1.006058693145230e+00 -6.037194733147822e+00 -6.013894497682836e+00 3.486781731992483e+00 4.620575289732221e+00 9.259776601007243e+03 + 25200 1.025842500807844e+00 -6.050002741782516e+00 -6.049364062988539e+00 3.370287176027751e+00 4.373954568497991e+00 9.369234106279026e+03 + 25220 1.003100500599713e+00 -6.004046036256691e+00 -6.022102157656734e+00 3.671280473242780e+00 4.567599429987973e+00 9.285042397632966e+03 + 25240 1.064166955031397e+00 -6.084783466566471e+00 -5.957651693948488e+00 3.255057353550620e+00 4.985067665501303e+00 9.087522364615419e+03 + 25260 9.605410199502851e-01 -5.922753651440207e+00 -5.984311678693154e+00 4.109312034923668e+00 4.755836316363315e+00 9.168946607970493e+03 + 25280 9.985388851132635e-01 -5.970205750827290e+00 -6.008290648769282e+00 3.763849116695558e+00 4.545159739093733e+00 9.242490050440339e+03 + 25300 1.047080092039443e+00 -6.034292941231458e+00 -5.983875113926064e+00 3.491906902880467e+00 4.781413869401601e+00 9.167628985741661e+03 + 25320 9.853109900055954e-01 -5.937653927073246e+00 -5.980605309004058e+00 3.962205853919735e+00 4.715572372168139e+00 9.157616268602002e+03 + 25340 1.068237803444794e+00 -6.055283309404507e+00 -5.981932244561525e+00 3.436013344269545e+00 4.857206509638541e+00 9.161650185424402e+03 + 25360 1.053245090918012e+00 -6.030587932117379e+00 -5.997507790044111e+00 3.578549359542827e+00 4.768500654462974e+00 9.209412268636599e+03 + 25380 1.000883110446410e+00 -5.955569382117465e+00 -6.006767543427498e+00 3.937236034365120e+00 4.643248269233059e+00 9.237786320672150e+03 + 25400 9.796607520065639e-01 -5.926717606150513e+00 -5.979715818236763e+00 4.094647951054140e+00 4.790324015808074e+00 9.154883116886396e+03 + 25420 1.022745569411853e+00 -5.993347160010311e+00 -5.970526901489540e+00 3.706806234429999e+00 4.837843690279858e+00 9.126786846414907e+03 + 25440 9.657359911946622e-01 -5.910919238806466e+00 -6.043416610128262e+00 4.120342279325468e+00 4.359521869293768e+00 9.350812168407230e+03 + 25460 1.011984361106450e+00 -5.986003988007022e+00 -6.006345261742263e+00 3.761024717618938e+00 4.644221976029246e+00 9.236543570518705e+03 + 25480 9.857075605702293e-01 -5.959595554877169e+00 -6.007945640092950e+00 3.910395727061808e+00 4.632762055601290e+00 9.241456406004072e+03 + 25500 9.831778801967717e-01 -5.980027930507499e+00 -6.025877614856469e+00 3.793361816088093e+00 4.530085833340584e+00 9.296657324173346e+03 + 25520 1.055124152990025e+00 -6.127539720916109e+00 -5.971332605472899e+00 3.009710811563143e+00 4.906676241411049e+00 9.129262379872194e+03 + 25540 9.810731921061823e-01 -6.069521226837232e+00 -6.008061541976624e+00 3.304603464016857e+00 4.657514485341965e+00 9.241827222390451e+03 + 25560 9.519920937852896e-01 -6.077789885639940e+00 -6.021697045750013e+00 3.234517552299371e+00 4.556611319286255e+00 9.283789764785879e+03 + 25580 8.768960614945165e-01 -6.004706354507245e+00 -5.959553025016761e+00 3.745280375644142e+00 5.004557781033663e+00 9.093305529486042e+03 + 25600 9.637267958799459e-01 -6.154754018476939e+00 -5.992003107369703e+00 2.868572962733742e+00 4.803113879933589e+00 9.192528520463044e+03 + 25620 9.412579924039020e-01 -6.135305413494863e+00 -5.985191758526433e+00 2.988924042590679e+00 4.850899879432433e+00 9.171666287015061e+03 + 25640 8.816441052255399e-01 -6.052061764355211e+00 -5.988884361104717e+00 3.402157101877232e+00 4.764931528013127e+00 9.182949553624600e+03 + 25660 9.098324493436031e-01 -6.088357573104333e+00 -5.965169323401383e+00 3.223657992648954e+00 4.931023985763327e+00 9.110417779885996e+03 + 25680 9.333053694194586e-01 -6.107217380538256e+00 -5.949075972227413e+00 3.149983917537468e+00 5.058056356362174e+00 9.061380811155155e+03 + 25700 9.173095378972868e-01 -6.059078401819902e+00 -5.967050998722505e+00 3.362089280585657e+00 4.890524870365516e+00 9.116174143148270e+03 + 25720 9.277209153198580e-01 -6.041038180841880e+00 -5.980080226764808e+00 3.457561031285756e+00 4.807591036809209e+00 9.155981117993555e+03 + 25740 1.010766511069370e+00 -6.123830409409469e+00 -5.984999963907922e+00 2.997928308241534e+00 4.795114210253427e+00 9.171065932910171e+03 + 25760 9.524297891098265e-01 -6.000845269193007e+00 -5.985240609941362e+00 3.664323888926160e+00 4.753928257162312e+00 9.171770017833216e+03 + 25780 9.513611519677030e-01 -5.968092148502381e+00 -5.966523397320382e+00 3.842294207035356e+00 4.851302219085851e+00 9.114554646154780e+03 + 25800 9.657049348805068e-01 -5.958198058103020e+00 -6.020600735205639e+00 3.939634880359980e+00 4.581309051653667e+00 9.280368056927085e+03 + 25820 1.062153445574549e+00 -6.077082829647437e+00 -5.980834767560508e+00 3.275296149889738e+00 4.827967416732353e+00 9.158292758135745e+03 + 25840 1.023396966393312e+00 -6.000750881867030e+00 -5.953293891355035e+00 3.664866821142515e+00 4.937372204607941e+00 9.074214941082610e+03 + 25860 9.802427676578191e-01 -5.920806002543928e+00 -5.961679192928036e+00 4.110524436734681e+00 4.875824252443356e+00 9.099729940713589e+03 + 25880 9.734696895922152e-01 -5.895854092044422e+00 -6.002905937680329e+00 4.259640094827924e+00 4.644931830966972e+00 9.225934760568734e+03 + 25900 1.072830297821731e+00 -6.032110236127459e+00 -5.967093362827668e+00 3.535783191961928e+00 4.909120139777959e+00 9.116302612982314e+03 + 25920 1.008818279729162e+00 -5.930388283115262e+00 -5.996685645082760e+00 4.032023612486922e+00 4.651333900585942e+00 9.206875656452117e+03 + 25940 9.604111280560184e-01 -5.853657955730506e+00 -6.037954659371901e+00 4.435802993303708e+00 4.377542801172098e+00 9.333930315960726e+03 + 25960 1.099384282805530e+00 -6.056658827377374e+00 -5.962668464640556e+00 3.380114390722614e+00 4.919821598519054e+00 9.102806426401146e+03 + 25980 1.027298229393469e+00 -5.950096210713926e+00 -6.014165368949624e+00 3.912156996870025e+00 4.544261975610453e+00 9.260567419084713e+03 + 26000 1.018392523716680e+00 -5.942450653448435e+00 -6.017467465044152e+00 3.986270328016146e+00 4.555512187019464e+00 9.270747203785386e+03 + 26020 9.959283945606101e-01 -5.921600640435349e+00 -5.993817897402833e+00 4.097719968508047e+00 4.683037303416357e+00 9.198052863263672e+03 + 26040 1.004167210311523e+00 -5.950346703214370e+00 -5.978280430691507e+00 3.902267019905094e+00 4.741867234001018e+00 9.150444709874984e+03 + 26060 1.049134079644829e+00 -6.036803106406152e+00 -5.987095445660588e+00 3.468499844318236e+00 4.753928924554909e+00 9.177474585772541e+03 + 26080 1.026218752989698e+00 -6.031171243762435e+00 -5.985677017210115e+00 3.539159160532024e+00 4.800394049604249e+00 9.173100140175191e+03 + 26100 9.392594035445407e-01 -5.934218137850061e+00 -6.014068301371411e+00 4.024291089025573e+00 4.565779093313107e+00 9.260283785425618e+03 + 26120 9.512240467925916e-01 -5.988988916732684e+00 -6.017871171805234e+00 3.779601605137140e+00 4.613755226996023e+00 9.271984703745893e+03 + 26140 9.960809724730890e-01 -6.095122216890608e+00 -5.982575281037149e+00 3.208135286069953e+00 4.854397208322547e+00 9.163658283160163e+03 + 26160 9.160939804689968e-01 -6.012180785413905e+00 -6.026307813584104e+00 3.639273975936193e+00 4.558154394032365e+00 9.297980933105917e+03 + 26180 9.662262067461681e-01 -6.115762818175169e+00 -6.002504197838276e+00 3.061988910826899e+00 4.712337435516188e+00 9.224750518760346e+03 + 26200 9.453695345952386e-01 -6.103662516785826e+00 -5.991061923054637e+00 3.193109869770761e+00 4.839679903860810e+00 9.189621170972330e+03 + 26220 8.861661039222235e-01 -6.025500011322938e+00 -6.040148150534377e+00 3.582542732089503e+00 4.498430849945204e+00 9.340721996992048e+03 + 26240 9.439092256582445e-01 -6.113487567814783e+00 -6.003140713779043e+00 3.149998732403559e+00 4.783627444397252e+00 9.226693327869381e+03 + 26260 9.197241621735672e-01 -6.071964778881519e+00 -6.008336982322382e+00 3.292082558520587e+00 4.657443212732849e+00 9.242667962676733e+03 + 26280 9.435277106252464e-01 -6.096155229261827e+00 -5.996742216988634e+00 3.199087601023340e+00 4.769932501609940e+00 9.207055839041413e+03 + 26300 9.218045740493285e-01 -6.047708821279508e+00 -6.009489639312625e+00 3.441610222400578e+00 4.661070679653712e+00 9.246213493102432e+03 + 26320 9.252040659232807e-01 -6.032608892966441e+00 -5.998961219992685e+00 3.529453666625325e+00 4.722663811801195e+00 9.213857153045321e+03 + 26340 9.902981232272590e-01 -6.106580223681664e+00 -6.001655980827415e+00 3.136309836229737e+00 4.738801075672935e+00 9.222123783446699e+03 + 26360 9.431367099233550e-01 -6.015561196035239e+00 -5.995378360170598e+00 3.635081864821340e+00 4.750974831639862e+00 9.202874318618680e+03 + 26380 9.949114680471377e-01 -6.074777248058229e+00 -5.951019168090145e+00 3.311973224271712e+00 5.022611270949429e+00 9.067306220851191e+03 + 26400 9.899066095904333e-01 -6.050731486826334e+00 -6.005744416313608e+00 3.396625876526365e+00 4.654948597137098e+00 9.234698638076165e+03 + 26420 9.883190757678249e-01 -6.035857592180676e+00 -6.023229999708681e+00 3.490904015411199e+00 4.563413605499015e+00 9.288498216236321e+03 + 26440 9.993556143962278e-01 -6.042389464877455e+00 -5.997491349774313e+00 3.443164545933044e+00 4.700976470816142e+00 9.209355638380161e+03 + 26460 1.009826051505172e+00 -6.050009021346177e+00 -6.011167397187894e+00 3.415670402816726e+00 4.638705019455502e+00 9.251362774203964e+03 + 26480 9.485045981692308e-01 -5.951528491571622e+00 -6.038440028273707e+00 3.923490847805867e+00 4.424431354545663e+00 9.335441527714080e+03 + 26500 9.475692539997201e-01 -5.942597358948994e+00 -6.033366682273623e+00 3.986878348151550e+00 4.465666847114142e+00 9.319766658493700e+03 + 26520 9.683781448299486e-01 -5.965698302467739e+00 -6.009110821059569e+00 3.864477847994406e+00 4.615196448174585e+00 9.245015247814323e+03 + 26540 9.571153784774734e-01 -5.938661398776790e+00 -6.017420438071207e+00 4.019368618536496e+00 4.567122026986012e+00 9.270595672342546e+03 + 26560 9.963700323918843e-01 -5.987266008402548e+00 -6.016442415018030e+00 3.778471790211424e+00 4.610936348390993e+00 9.267584696572065e+03 + 26580 1.014618035535428e+00 -6.004919037984700e+00 -6.004076874488086e+00 3.624048904752096e+00 4.628884737874035e+00 9.229557131398606e+03 + 26600 1.054285166233861e+00 -6.053568123749942e+00 -5.961135674284072e+00 3.385179415656896e+00 4.915940844365252e+00 9.098125928411304e+03 + 26620 1.035384421160120e+00 -6.013681962307880e+00 -6.008862078014003e+00 3.654978203510955e+00 4.682654725001078e+00 9.244243113771221e+03 + 26640 1.018829673976967e+00 -5.979180568012238e+00 -5.999347286184133e+00 3.885319588473103e+00 4.769519171940534e+00 9.215041618229545e+03 + 26660 1.061430348537269e+00 -6.032142779805004e+00 -6.064902160153220e+00 3.540599914669801e+00 4.352490483212619e+00 9.417357377514185e+03 + 26680 9.913657132534580e-01 -5.920956260720130e+00 -6.051146714030268e+00 4.114671702326757e+00 4.367097972512410e+00 9.374724534707220e+03 + 26700 1.040439721194922e+00 -5.990387072684332e+00 -6.031717927883734e+00 3.732116873758050e+00 4.494788707273917e+00 9.314688098969315e+03 + 26720 1.001849163680788e+00 -5.932894647199312e+00 -6.064868365915213e+00 4.037019069263300e+00 4.279205553529630e+00 9.417269803173511e+03 + 26740 9.655843383654731e-01 -5.883765207646092e+00 -6.093842876272586e+00 4.331818868059222e+00 4.125520385391742e+00 9.507353989955931e+03 + 26760 1.045175055068835e+00 -6.014227725931010e+00 -6.005413066204813e+00 3.620610650833521e+00 4.671225791045525e+00 9.233677075569769e+03 + 26780 9.953599414492561e-01 -5.958594356564933e+00 -6.020993260402718e+00 3.938842125619652e+00 4.580537963583931e+00 9.281593795121291e+03 + 26800 9.829828001559450e-01 -5.962483699211297e+00 -6.005825944128868e+00 3.912140194834136e+00 4.663262317326716e+00 9.234939674281130e+03 + 26820 1.035266936602966e+00 -6.069340024950086e+00 -6.027556690046854e+00 3.302497899252490e+00 4.542424274217028e+00 9.301865634970136e+03 + 26840 1.007876330954407e+00 -6.064606813736348e+00 -6.013595367064669e+00 3.301142664408001e+00 4.594058285192643e+00 9.258837165956951e+03 + 26860 9.699348531984305e-01 -6.042845085070240e+00 -6.000851436257970e+00 3.445350527832958e+00 4.686484557809165e+00 9.219668789844749e+03 + 26880 9.634473563485493e-01 -6.061085928946822e+00 -5.998173517769858e+00 3.351124585171625e+00 4.712377385813921e+00 9.211453137806910e+03 + 26900 9.499127806399479e-01 -6.063500963243912e+00 -5.993824002202202e+00 3.331383970088634e+00 4.731479862865003e+00 9.198123525066230e+03 + 26920 9.899795160606156e-01 -6.139012501191987e+00 -5.984251302603741e+00 2.987269645834671e+00 4.875932397346461e+00 9.168784631172943e+03 + 26940 9.701071593392978e-01 -6.121034847466492e+00 -5.970910871083147e+00 3.042603786074674e+00 4.904638890078101e+00 9.127979237816195e+03 + 26960 8.491853202647082e-01 -5.944881097762019e+00 -6.023840335551021e+00 4.004781449475719e+00 4.551385287188713e+00 9.290377004956044e+03 + 26980 9.421397124393567e-01 -6.079498699946559e+00 -5.987801441110460e+00 3.232226280624345e+00 4.758766130966166e+00 9.179660665414938e+03 + 27000 9.744729480255444e-01 -6.116145792772875e+00 -5.982560877711191e+00 3.106261484498423e+00 4.873326738981408e+00 9.163613674252221e+03 + 27020 9.223727352729290e-01 -6.021076397508061e+00 -5.988284880546438e+00 3.578016343419241e+00 4.766310308283730e+00 9.181126167199975e+03 + 27040 9.455831063228392e-01 -6.026887245417519e+00 -5.978433197965661e+00 3.598286903920087e+00 4.876517542628264e+00 9.150955219626328e+03 + 27060 9.689533105277583e-01 -6.025688247526988e+00 -6.025503931106525e+00 3.514748149213525e+00 4.515806522622698e+00 9.295509340748611e+03 + 27080 1.012399636967868e+00 -6.050008456217423e+00 -5.999017193649915e+00 3.412643072630035e+00 4.705442793165047e+00 9.214027251005758e+03 + 27100 9.891940338380578e-01 -5.977650664108701e+00 -5.976215594413667e+00 3.803483184296121e+00 4.811723576561329e+00 9.144184401562585e+03 + 27120 9.687017500544800e-01 -5.916598487889412e+00 -5.988534448480671e+00 4.139800697606367e+00 4.726733279837431e+00 9.181881267819166e+03 + 27140 1.037146436436462e+00 -5.993807494022347e+00 -6.017964017470762e+00 3.715348726106671e+00 4.576638230255953e+00 9.272264987648879e+03 + 27160 1.016934884494603e+00 -5.947880379769530e+00 -6.038643569513634e+00 3.984561533065667e+00 4.463385251996804e+00 9.336055558785029e+03 + 27180 1.034507542746743e+00 -5.967819089135967e+00 -6.035228275935958e+00 3.884340318121123e+00 4.497266335977636e+00 9.325505220584442e+03 + 27200 1.071178492827565e+00 -6.023204575304274e+00 -6.020554920965714e+00 3.542048774279277e+00 4.557263499523975e+00 9.280253901903241e+03 + 27220 9.867644844035480e-01 -5.902529903526671e+00 -6.015385185253888e+00 4.241353637449309e+00 4.593321145473221e+00 9.264317521186465e+03 + 27240 1.059979797456440e+00 -6.016569449353873e+00 -5.960166307226832e+00 3.612473295505697e+00 4.936348865957199e+00 9.095170882167500e+03 + 27260 1.060608216219965e+00 -6.024244994406827e+00 -5.977130014179148e+00 3.552489729559791e+00 4.823031237046751e+00 9.146970897468702e+03 + 27280 9.960753965283066e-01 -5.936047062756765e+00 -6.003107861470136e+00 4.076359438239574e+00 4.691285954402334e+00 9.226526196044453e+03 + 27300 1.042541389049485e+00 -6.013710439778599e+00 -6.037708513043897e+00 3.608611603120279e+00 4.470810952741102e+00 9.333151858054540e+03 + 27320 9.444775768942942e-01 -5.880580310794739e+00 -6.065088673664728e+00 4.306916409866738e+00 4.247440837690388e+00 9.417949748538475e+03 + 27340 1.008534627286023e+00 -5.991846922656856e+00 -6.008688748098925e+00 3.679424533256534e+00 4.582716165304110e+00 9.243739661273345e+03 + 27360 9.630546366672733e-01 -5.940984462555936e+00 -5.989684225866467e+00 4.015297708059070e+00 4.735656130865983e+00 9.185401570380916e+03 + 27380 9.988885380947690e-01 -6.009749248724494e+00 -5.987202522399756e+00 3.591687043220364e+00 4.721153834871629e+00 9.177808010865125e+03 + 27400 9.930793117447083e-01 -6.017143289298067e+00 -5.976048856374288e+00 3.630207531687882e+00 4.866178124879166e+00 9.143678305964455e+03 + 27420 1.030636429210788e+00 -6.087880293211160e+00 -5.948888627407857e+00 3.235744056369835e+00 5.033855710303177e+00 9.060830934950771e+03 + 27440 9.462319624054668e-01 -5.977642549775878e+00 -5.992349407946955e+00 3.805257004151622e+00 4.720807948654352e+00 9.193567063702878e+03 + 27460 9.645352579399442e-01 -6.018538379506525e+00 -5.963629477826064e+00 3.687134074552471e+00 5.002429485126754e+00 9.105727451914574e+03 + 27480 1.002738936303536e+00 -6.089151904983111e+00 -5.991858877217838e+00 3.254760976637729e+00 4.813432598113311e+00 9.192068475447604e+03 + 27500 9.353743570856123e-01 -6.005748106118038e+00 -6.022869736927978e+00 3.679806405605295e+00 4.581491351930812e+00 9.287390104871154e+03 + 27520 9.799217585818061e-01 -6.089366435245411e+00 -5.979941766002367e+00 3.260457932166900e+00 4.888791316373299e+00 9.155580841170713e+03 + 27540 9.283970948727412e-01 -6.033878178272121e+00 -5.991787180755086e+00 3.555020238949807e+00 4.796713260253438e+00 9.191878560445837e+03 + 27560 9.522218752693293e-01 -6.091707939125141e+00 -5.991324388102013e+00 3.247395478249032e+00 4.823813362528147e+00 9.190441020623144e+03 + 27580 9.625618546082225e-01 -6.129966572553270e+00 -5.973605676107027e+00 3.013035905586652e+00 4.910884369751501e+00 9.136215649408119e+03 + 27600 9.472254913757170e-01 -6.126036363920218e+00 -5.991533718444473e+00 2.991903831992664e+00 4.764238836531508e+00 9.191089495114022e+03 + 27620 8.714750487600875e-01 -6.028001610369969e+00 -5.982686609703543e+00 3.533834384544501e+00 4.794040130844811e+00 9.163989097108841e+03 + 27640 8.996218362433056e-01 -6.076111518085125e+00 -5.963663964378407e+00 3.250352449233675e+00 4.896043703820350e+00 9.105841281497531e+03 + 27660 8.884259422073223e-01 -6.055151989915837e+00 -5.949853639156968e+00 3.412411358058467e+00 5.017050782983009e+00 9.063757821715657e+03 + 27680 9.558661347182068e-01 -6.139451230840570e+00 -5.964487393905256e+00 2.923995218435233e+00 4.928664645684069e+00 9.108359546052705e+03 + 27700 9.427480597644755e-01 -6.093510468254363e+00 -5.967946230079281e+00 3.159864819455000e+00 4.880874106059382e+00 9.118928697665700e+03 + 27720 9.608589617458617e-01 -6.083073963087498e+00 -5.987435436768905e+00 3.270083422360786e+00 4.819254640496267e+00 9.178520926841047e+03 + 27740 9.483046541488918e-01 -6.021258818969733e+00 -5.994886706388693e+00 3.564206071180362e+00 4.715638822691925e+00 9.201374288213323e+03 + 27760 9.486324698030321e-01 -5.980383338328356e+00 -5.990702534221319e+00 3.771870386982515e+00 4.712615967274717e+00 9.188549570618308e+03 + 27780 1.043234891490521e+00 -6.084072596070903e+00 -5.989805163573187e+00 3.280550576214043e+00 4.821848761453962e+00 9.185762877391515e+03 + 27800 9.462777331022916e-01 -5.911316177144968e+00 -6.022247478570696e+00 4.254849241028481e+00 4.617864541678540e+00 9.285463190241648e+03 + 27820 1.041778414646208e+00 -6.032876913893089e+00 -5.978612164661120e+00 3.476616344254921e+00 4.788212931787688e+00 9.151518188195550e+03 + 27840 1.039470761840076e+00 -6.014265230341593e+00 -5.978256302392833e+00 3.659957011239747e+00 4.866725847885116e+00 9.150420976034360e+03 + 27860 1.015181200971059e+00 -5.966262020403065e+00 -6.028966695349557e+00 3.863268309063966e+00 4.503208362004117e+00 9.306166085901783e+03 + 27880 1.024841218237219e+00 -5.973730386219399e+00 -6.003883041818700e+00 3.871523022445162e+00 4.698381807885605e+00 9.228937359090134e+03 + 27900 1.011277400152437e+00 -5.948608245003178e+00 -6.021541896239807e+00 3.979148036182251e+00 4.560351724335476e+00 9.283280107952132e+03 + 27920 9.695039402174337e-01 -5.885701219590517e+00 -6.035573877983513e+00 4.324162621374119e+00 4.463570624162602e+00 9.326561815037468e+03 + 27940 1.033810576615482e+00 -5.980572172736323e+00 -5.965801148508310e+00 3.845938570782814e+00 4.930756077708684e+00 9.112362866227797e+03 + 27960 1.049616977200825e+00 -6.005430142597134e+00 -5.982606595612739e+00 3.614999144886190e+00 4.746055483603064e+00 9.163734576042832e+03 + 27980 1.033753319888638e+00 -5.985257730354960e+00 -5.995690880871207e+00 3.789186175277897e+00 4.729277410488785e+00 9.203828087378617e+03 + 28000 1.057505199077214e+00 -6.031099990860334e+00 -5.989260064416386e+00 3.523942069007464e+00 4.764193401356305e+00 9.184103000493253e+03 + 28020 1.048766753519728e+00 -6.033736160918774e+00 -5.970519444527135e+00 3.530205769007253e+00 4.893205937283286e+00 9.126708711083033e+03 + 28040 9.695261096033957e-01 -5.936656690271800e+00 -5.960906876923937e+00 4.002741396690560e+00 4.863493072229734e+00 9.097363369294753e+03 + 28060 9.856662990412596e-01 -5.979387234082172e+00 -5.942331647575939e+00 3.817786579363989e+00 5.030565491416257e+00 9.040853248464282e+03 + 28080 1.059373091536898e+00 -6.111332584964903e+00 -5.994605601387574e+00 3.108023494561577e+00 4.778287897704928e+00 9.200486078063295e+03 + 28100 9.038957662314364e-01 -5.908830343121240e+00 -6.055890621635804e+00 4.153883971179798e+00 4.309441094444620e+00 9.389432379710319e+03 + 28120 1.008060788723283e+00 -6.097835488996002e+00 -5.976912873797956e+00 3.206362921656118e+00 4.900719290837520e+00 9.146312908976432e+03 + 28140 9.583930563362792e-01 -6.059891299820267e+00 -5.979638007578159e+00 3.387611631710931e+00 4.848438454921950e+00 9.154647667282694e+03 + 28160 9.861648629247483e-01 -6.131400760209572e+00 -5.980359086580825e+00 2.991286816328650e+00 4.858591479928367e+00 9.156856998614861e+03 + 28180 9.331741432074954e-01 -6.080274568648893e+00 -6.010906672424127e+00 3.256662056310701e+00 4.654983251080555e+00 9.250575868091884e+03 + 28200 9.487365970115789e-01 -6.124053786821472e+00 -5.980234239423813e+00 3.026249650686636e+00 4.852083747847020e+00 9.156495382343082e+03 + 28220 9.114577634125778e-01 -6.082060719689925e+00 -5.965068694096035e+00 3.267330318008544e+00 4.939116633426106e+00 9.110117421907767e+03 + 28240 9.204217757524628e-01 -6.098852783840079e+00 -5.935993573515242e+00 3.139492347080061e+00 5.074655135146623e+00 9.021597983002457e+03 + 28260 9.655212033004757e-01 -6.158440556204259e+00 -5.963638518525968e+00 2.838817927477874e+00 4.957401373344522e+00 9.105772460240843e+03 + 28280 9.873924749750815e-01 -6.174496784372912e+00 -5.966858916174683e+00 2.763346835914446e+00 4.955635606964932e+00 9.115612627892451e+03 + 28300 9.062975886648298e-01 -6.026802835103730e+00 -5.983901089239057e+00 3.537851694646410e+00 4.784200158425085e+00 9.167693145932984e+03 + 28320 9.240469692638211e-01 -6.009904912254956e+00 -5.996691526747439e+00 3.689365663590512e+00 4.765238967939470e+00 9.206883761337367e+03 + 28340 1.004311492099203e+00 -6.074908507271499e+00 -5.985888975239829e+00 3.345657912128385e+00 4.856821840782293e+00 9.173791333612286e+03 + 28360 1.016706758180717e+00 -6.041796236053391e+00 -6.030985962253030e+00 3.470893581743478e+00 4.532967846789619e+00 9.312434135093177e+03 + 28380 9.874048950994018e-01 -5.964654456240957e+00 -6.022495151868238e+00 3.873952801740150e+00 4.541822576629586e+00 9.286240841701350e+03 + 28400 1.041488541426884e+00 -6.025868643446168e+00 -6.008228877105564e+00 3.550770396740445e+00 4.652060664813215e+00 9.242325953813262e+03 + 28420 1.002885854865181e+00 -5.958381897030820e+00 -5.996224775982426e+00 3.957127022452642e+00 4.739827355345930e+00 9.205477884187449e+03 + 28440 1.049370544181631e+00 -6.022186024690050e+00 -5.973239231574145e+00 3.578594037951742e+00 4.859654098515019e+00 9.135078924877598e+03 + 28460 9.857187145804207e-01 -5.925467128856044e+00 -6.019228836604713e+00 4.084316227801585e+00 4.545921992331354e+00 9.276155748451205e+03 + 28480 1.016912184696090e+00 -5.970975071262721e+00 -6.038946003969629e+00 3.866536090339538e+00 4.476236476268629e+00 9.336997068464581e+03 + 28500 1.028307300006997e+00 -5.990560082016213e+00 -6.027136568431067e+00 3.705765742755110e+00 4.495737897568036e+00 9.300558280627594e+03 + 28520 1.016954212438940e+00 -5.980298001324171e+00 -5.977040781160179e+00 3.865383997349741e+00 4.884087459584578e+00 9.146687088651623e+03 + 28540 1.056024721359412e+00 -6.045516148948617e+00 -5.956156535862871e+00 3.486221098932965e+00 4.999337825626756e+00 9.082947105417434e+03 + 28560 9.839051355476658e-01 -5.948191718973401e+00 -5.993043752948756e+00 3.990724759891959e+00 4.733177439975648e+00 9.195697565700497e+03 + 28580 1.006138102519820e+00 -5.989701164156847e+00 -6.008171374837757e+00 3.772379272464455e+00 4.666320464478808e+00 9.242129777662814e+03 + 28600 1.037766030104577e+00 -6.047661953637897e+00 -6.006616425912386e+00 3.482074364646931e+00 4.717764136621707e+00 9.237361069371234e+03 + 28620 9.659443376312803e-01 -5.955158072010705e+00 -6.009664018831449e+00 3.972361147049752e+00 4.659379565637028e+00 9.246740770913540e+03 + 28640 1.017316284906998e+00 -6.045576804131761e+00 -5.995286608078919e+00 3.449584518786223e+00 4.738358606904329e+00 9.202587117532499e+03 + 28660 9.577804407050799e-01 -5.972745379337040e+00 -6.014008556755306e+00 3.870009954647008e+00 4.633070404455253e+00 9.260101274630691e+03 + 28680 9.474413353539920e-01 -5.973897071055424e+00 -6.002065631535745e+00 3.852656283446636e+00 4.690908050097980e+00 9.223373693040479e+03 + 28700 1.017104471432281e+00 -6.091282034671464e+00 -5.981710620472496e+00 3.222513698750876e+00 4.851689715202898e+00 9.160915217138234e+03 + 28720 1.005345044397297e+00 -6.088815245676647e+00 -5.942833924228069e+00 3.290074517050226e+00 5.128321855344449e+00 9.042400026548798e+03 + 28740 9.813762673374394e-01 -6.066549915314827e+00 -5.957266113139400e+00 3.356101876411747e+00 4.983626380116779e+00 9.086343519063474e+03 + 28760 9.653847697801363e-01 -6.054643177173745e+00 -5.988457378538456e+00 3.365662673375492e+00 4.745711771358559e+00 9.181657630333046e+03 + 28780 9.587590993123012e-01 -6.054058434583946e+00 -5.979365665902244e+00 3.388949683867171e+00 4.817847120306103e+00 9.153831636261464e+03 + 28800 9.040431139686514e-01 -5.979314352604691e+00 -5.993252864811110e+00 3.849403104418126e+00 4.769366010351073e+00 9.196326797466869e+03 + 28820 9.115654142044766e-01 -5.989940615113626e+00 -5.992423743629933e+00 3.762417450336267e+00 4.748158942132736e+00 9.193793244142766e+03 + 28840 9.754058565697546e-01 -6.076886502898839e+00 -5.969441678219704e+00 3.310135214941831e+00 4.927100025282309e+00 9.123482238600380e+03 + 28860 9.587361316427093e-01 -6.034558712246425e+00 -6.002407221117857e+00 3.505872605608647e+00 4.690491443096056e+00 9.224448066894422e+03 + 28880 1.011675087147180e+00 -6.086326826020558e+00 -6.005672971429328e+00 3.200717685995156e+00 4.663844600201662e+00 9.234496103880314e+03 + 28900 9.766675390624291e-01 -6.004355916494490e+00 -5.987623152207387e+00 3.630942804509664e+00 4.727024926433113e+00 9.179083018325524e+03 + 28920 1.049191871161144e+00 -6.076350377546601e+00 -5.950209815476448e+00 3.293840001112845e+00 5.018158628708557e+00 9.064827234880959e+03 + 28940 1.012873183427687e+00 -5.978436158514741e+00 -5.977472307116853e+00 3.795201997156629e+00 4.800736581038823e+00 9.148020884569307e+03 + 28960 1.028732091672302e+00 -5.963321835645610e+00 -6.013958050130856e+00 3.835515301610799e+00 4.544754322107647e+00 9.259941569164273e+03 + 28980 1.021772659444471e+00 -5.923753828854793e+00 -6.032654140884123e+00 4.114243566344634e+00 4.488921122403402e+00 9.317556792062800e+03 + 29000 1.082243177129964e+00 -5.993774074450423e+00 -5.970542686263892e+00 3.805520179121197e+00 4.938918405133962e+00 9.126826970490769e+03 + 29020 1.021588304188529e+00 -5.890514213167553e+00 -6.026716394264996e+00 4.363543487268874e+00 4.581449486187946e+00 9.299245006984265e+03 + 29040 1.058507080087246e+00 -5.940779001325294e+00 -6.060849535106583e+00 4.059049754102874e+00 4.369586168275657e+00 9.404797986556085e+03 + 29060 1.057459784182103e+00 -5.943785254801710e+00 -6.036615025991380e+00 3.988057943463091e+00 4.455015031931338e+00 9.329782234796643e+03 + 29080 1.022219879864499e+00 -5.903059204429085e+00 -6.012451262507249e+00 4.178034987108999e+00 4.549888861257902e+00 9.255313282078598e+03 + 29100 1.083637908939573e+00 -6.011380434521747e+00 -6.020794606531589e+00 3.632432060311167e+00 4.578374427792243e+00 9.280972407843090e+03 + 29120 9.957837155052961e-01 -5.903348281736229e+00 -6.037350414592377e+00 4.245562060164006e+00 4.476101076540965e+00 9.332011422013924e+03 + 29140 9.672713287498631e-01 -5.885866115602342e+00 -5.955195294563532e+00 4.278806776372667e+00 4.880707902121741e+00 9.080000970897076e+03 + 29160 9.927843018394513e-01 -5.945994384435984e+00 -5.997639634403891e+00 4.020529081432159e+00 4.723974064039837e+00 9.209798576411866e+03 + 29180 1.069533995994706e+00 -6.083723542092270e+00 -6.050761140409985e+00 3.207582727474011e+00 4.396857938848859e+00 9.373536178109489e+03 + 29200 9.845417440568524e-01 -5.985811107064321e+00 -6.006454279476295e+00 3.768825195889611e+00 4.650288905379449e+00 9.236881346242813e+03 + 29220 9.647934047677093e-01 -5.980184108831502e+00 -5.970880839224472e+00 3.806001605504369e+00 4.859422419264249e+00 9.127865520067760e+03 + 29240 1.026214752622953e+00 -6.089218700927397e+00 -5.978251701129010e+00 3.148789439563063e+00 4.785979124493122e+00 9.150410489362395e+03 + 29260 9.950024545978784e-01 -6.056184673287427e+00 -5.967407847834280e+00 3.409120036176434e+00 4.918890306097744e+00 9.117264454824444e+03 + 29280 9.976840082535774e-01 -6.068816260444843e+00 -5.982403250709504e+00 3.329374449560904e+00 4.825571323831264e+00 9.163104307796335e+03 + 29300 9.274399326175897e-01 -5.968193313051001e+00 -5.978248299784009e+00 3.860816723012973e+00 4.803079433187877e+00 9.150368344070803e+03 + 29320 9.868006097871423e-01 -6.054855062030459e+00 -5.966588184295469e+00 3.396901175539483e+00 4.903743246748975e+00 9.114754717728470e+03 + 29340 9.899444781062093e-01 -6.055138059269869e+00 -5.967437554726304e+00 3.419775396780256e+00 4.923365265478624e+00 9.117367431745864e+03 + 29360 9.663727155608948e-01 -6.013310413477299e+00 -5.974131730563347e+00 3.648840874536920e+00 4.873810934710417e+00 9.137808363160486e+03 + 29380 9.750770533677555e-01 -6.018640411511455e+00 -5.987806748717642e+00 3.611856037783077e+00 4.788907701039046e+00 9.179653685664820e+03 + 29400 9.748765965418188e-01 -6.012207410241462e+00 -5.995438264592647e+00 3.649146671623696e+00 4.745437700956098e+00 9.203035879862704e+03 + 29420 9.438078754944723e-01 -5.958641768052282e+00 -6.030963389991151e+00 3.867763678269130e+00 4.452481733361319e+00 9.312350037892540e+03 + 29440 1.056461221571512e+00 -6.118561804609593e+00 -5.976282403200306e+00 3.016902514516836e+00 4.833892855075169e+00 9.144396181895105e+03 + 29460 9.109807593599298e-01 -5.893652520520836e+00 -6.035823972869681e+00 4.250997572711173e+00 4.434627092362953e+00 9.327338199520040e+03 + 29480 1.073132083698660e+00 -6.125540645559286e+00 -5.927099584086852e+00 3.029538146102407e+00 5.169017429732140e+00 8.994627736545643e+03 + 29500 9.507761180188994e-01 -5.933684047595972e+00 -6.013722739154598e+00 4.082156803746088e+00 4.622562250868972e+00 9.259209622948030e+03 + 29520 1.070893063264405e+00 -6.100279961877620e+00 -5.994733191897323e+00 3.149417233303650e+00 4.755483119840385e+00 9.200905378148676e+03 + 29540 1.033192584583307e+00 -6.035594357949856e+00 -6.015534286027502e+00 3.504554562004205e+00 4.619742599268458e+00 9.264793066581120e+03 + 29560 9.984235088410777e-01 -5.978632026053406e+00 -5.992818916503188e+00 3.811773593477925e+00 4.730310273101077e+00 9.194980578456067e+03 + 29580 9.782168386658057e-01 -5.941064268115537e+00 -5.981033740331191e+00 4.028280180474235e+00 4.798769285756112e+00 9.158909295133537e+03 + 29600 1.010188133657555e+00 -5.977931663523375e+00 -5.997737042644165e+00 3.748774257593740e+00 4.635048705809655e+00 9.210117436464387e+03 + 29620 1.027322148721312e+00 -5.992813557031439e+00 -5.994670763920011e+00 3.731566906097881e+00 4.720902536741860e+00 9.200677584387106e+03 + 29640 9.659535898942938e-01 -5.891778197022241e+00 -6.014854489953541e+00 4.285876055292825e+00 4.579152935286527e+00 9.262676790536627e+03 + 29660 1.068408927267755e+00 -6.031798237411427e+00 -5.971858562367476e+00 3.461458336456697e+00 4.805641226193798e+00 9.130849865628978e+03 + 29680 9.528229368747220e-01 -5.846588627198785e+00 -5.997008497659730e+00 4.549702832894747e+00 4.685968659308274e+00 9.207807988589573e+03 + 29700 9.778655348391855e-01 -5.866592344020100e+00 -5.979465093578170e+00 4.427079488647842e+00 4.778946693683861e+00 9.154075779230565e+03 + 29720 1.046019026322564e+00 -5.941033829065968e+00 -5.987436754604585e+00 3.994007143952243e+00 4.727554364679986e+00 9.178496655866271e+03 + 29740 1.093017904360123e+00 -5.981286143635683e+00 -5.968445706027685e+00 3.795850897039152e+00 4.869582676835570e+00 9.120400718628467e+03 + 29760 1.081435015660344e+00 -5.937528636263007e+00 -5.960042500858987e+00 4.042979893505347e+00 4.913701798985946e+00 9.094743820373702e+03 + 29780 1.032977594009540e+00 -5.842985650638500e+00 -5.962574875481101e+00 4.529599589561191e+00 4.842899754142242e+00 9.102494569419829e+03 + 29800 1.110155829983875e+00 -5.937079912755975e+00 -5.963508388900301e+00 4.033115698808997e+00 4.881359298994812e+00 9.105338159836523e+03 + 29820 1.069364079718904e+00 -5.862036650250691e+00 -6.034739694386893e+00 4.345039869171149e+00 4.353352264031374e+00 9.323996368686723e+03 + 29840 1.124937716235160e+00 -5.941882666546898e+00 -6.000174210698900e+00 3.968797563006729e+00 4.634078495898632e+00 9.217552726273581e+03 + 29860 1.103010236366959e+00 -5.917815645411634e+00 -6.002372566345578e+00 4.106585964895744e+00 4.621047039751814e+00 9.224283373865937e+03 + 29880 1.082760243061814e+00 -5.908888543703807e+00 -5.961252090247383e+00 4.178931860089552e+00 4.878252272603703e+00 9.098451030699134e+03 + 29900 1.057986508276424e+00 -5.904214241847932e+00 -6.013298785997994e+00 4.198190129393701e+00 4.571809796105394e+00 9.257891858807350e+03 + 29920 9.996815436691404e-01 -5.859184389749883e+00 -6.005210465816346e+00 4.512688882206788e+00 4.674184555970916e+00 9.233049362274414e+03 + 29940 1.049197383888980e+00 -5.979803533765239e+00 -6.006492940301733e+00 3.803678436581749e+00 4.650423734076885e+00 9.236994899481502e+03 + 29960 1.029478396893733e+00 -5.996329089212416e+00 -6.046717811347401e+00 3.635458778889337e+00 4.346118938760705e+00 9.361033313396620e+03 + 29980 1.044480118617374e+00 -6.056243846655912e+00 -5.975131600274828e+00 3.418881713304631e+00 4.884640784104372e+00 9.140868585131188e+03 + 30000 1.016767391866971e+00 -6.041880949276345e+00 -6.008532375668739e+00 3.425265928605920e+00 4.616758598935883e+00 9.243254019607506e+03 + 30020 9.922247197783098e-01 -6.023803263966383e+00 -6.005941781914484e+00 3.514202224383747e+00 4.616765618381163e+00 9.235310858602918e+03 + 30040 1.015084969262159e+00 -6.069619921071927e+00 -6.007898245326070e+00 3.335982280909654e+00 4.690397694440826e+00 9.241326647138807e+03 + 30060 9.882612529099631e-01 -6.040284749510060e+00 -6.023507846472330e+00 3.465731552741875e+00 4.562067126201876e+00 9.289377826918633e+03 + 30080 1.006152782716636e+00 -6.075767938727057e+00 -5.986193350702851e+00 3.285433879225506e+00 4.799785025283194e+00 9.174733880226882e+03 + 30100 9.679814941592997e-01 -6.025131795077628e+00 -6.019920002711325e+00 3.549667806400158e+00 4.579594724689728e+00 9.278290579112328e+03 + 30120 9.311208921328133e-01 -5.973117554157160e+00 -5.982077785981280e+00 3.886328053177712e+00 4.834877015452216e+00 9.162080792690465e+03 + 30140 1.016894008588022e+00 -6.095566240787789e+00 -5.954919582073374e+00 3.187354219830481e+00 4.994969099168746e+00 9.079179160131311e+03 + 30160 1.000528545015609e+00 -6.066061308542642e+00 -6.007830879936967e+00 3.293919819856046e+00 4.628287952039537e+00 9.241075914727677e+03 + 30180 9.956050615235298e-01 -6.050461112666764e+00 -5.965799988060901e+00 3.427096780125436e+00 4.913234058878992e+00 9.112351260889902e+03 + 30200 9.882358765782590e-01 -6.026515988153109e+00 -5.964714821978155e+00 3.557479226850643e+00 4.912351086726785e+00 9.109051797357193e+03 + 30220 1.006934228929713e+00 -6.035253633162323e+00 -5.980793283070424e+00 3.511727090969686e+00 4.824446848909312e+00 9.158179293361896e+03 + 30240 1.004118717215138e+00 -6.008648526824767e+00 -5.962032954551027e+00 3.655754961014896e+00 4.923428790747208e+00 9.100862582232357e+03 + 30260 9.813019668401489e-01 -5.947496886525927e+00 -5.977684413881758e+00 4.003691062380976e+00 4.830349608799037e+00 9.148656976793382e+03 + 30280 1.024481767133316e+00 -5.978499913010214e+00 -5.986694342097683e+00 3.809221359835032e+00 4.762167679930986e+00 9.176251467302583e+03 + 30300 9.372559915964310e-01 -5.812215677039879e+00 -6.071883747463453e+00 4.663143359153668e+00 4.172089115277479e+00 9.439007312162808e+03 + 30320 1.037288373435426e+00 -5.928307902238423e+00 -6.030087311434825e+00 4.050865057736326e+00 4.466431939817912e+00 9.309624715503543e+03 + 30340 1.068069193295996e+00 -5.943532333151957e+00 -5.985089649760610e+00 3.998435209050835e+00 4.759806666109988e+00 9.171338455044290e+03 + 30360 1.088471716750496e+00 -5.950361095175069e+00 -6.038067073983443e+00 3.932682962372284e+00 4.429061659598243e+00 9.334267393989394e+03 + 30380 1.087176090824334e+00 -5.936349256647279e+00 -6.035533122416764e+00 4.048510510878478e+00 4.478981404976475e+00 9.326472522392092e+03 + 30400 1.059111122397142e+00 -5.893360705102793e+00 -6.071651010853246e+00 4.185555474317064e+00 4.161784948362317e+00 9.438313057485690e+03 + 30420 1.070826677341120e+00 -5.918315395300726e+00 -6.008904710307636e+00 4.086356900497336e+00 4.566179035076466e+00 9.244419129936921e+03 + 30440 1.016543629364807e+00 -5.857560330802976e+00 -6.013409112803366e+00 4.455599245142363e+00 4.560691421375054e+00 9.258217533942241e+03 + 30460 9.702987054343737e-01 -5.814606880813549e+00 -6.033768896319408e+00 4.666416210599313e+00 4.407954002352379e+00 9.320931574525333e+03 + 30480 1.082733533589915e+00 -6.016922587497267e+00 -6.006907900640629e+00 3.547957095010784e+00 4.605462976709386e+00 9.238182664729875e+03 + 30500 1.001906763239213e+00 -5.943670747390758e+00 -6.013336663985812e+00 3.990900521965803e+00 4.590868048111253e+00 9.258016240636491e+03 + 30520 9.797690573249267e-01 -5.965765034306995e+00 -6.052580723175923e+00 3.875323223374128e+00 4.376814103204312e+00 9.379168511796996e+03 + 30540 1.053728165387525e+00 -6.130671941847972e+00 -5.974409347140792e+00 2.995504204736305e+00 4.892788205103312e+00 9.138683789743040e+03 + 30560 9.149138820086319e-01 -5.962518195578482e+00 -6.013974570802310e+00 3.900819426229920e+00 4.605348956846370e+00 9.260001380764621e+03 + 30580 9.794553746289623e-01 -6.076446572662526e+00 -5.977868597052700e+00 3.312814132337314e+00 4.878864123181362e+00 9.149207616915081e+03 + 30600 9.793786307577188e-01 -6.081191036216134e+00 -5.999309945015895e+00 3.265622291146604e+00 4.735796187876284e+00 9.214930712703792e+03 + 30620 9.839331633188340e-01 -6.088366487284060e+00 -5.989463688150250e+00 3.230073602719602e+00 4.797988780504639e+00 9.184724500492623e+03 + 30640 9.496629160440291e-01 -6.033569190909154e+00 -6.006531523771501e+00 3.502253657486081e+00 4.657508126255953e+00 9.237121583300195e+03 + 30660 9.980475234917288e-01 -6.096680730751965e+00 -5.998652985178605e+00 3.155440872244674e+00 4.718331357071502e+00 9.212928116577159e+03 + 30680 8.790823870794808e-01 -5.909962481524311e+00 -6.029714861845568e+00 4.178182439655728e+00 4.490545740230115e+00 9.308492611090194e+03 + 30700 1.009297806258212e+00 -6.088813060451855e+00 -5.977629584834364e+00 3.230760801937853e+00 4.869193524520734e+00 9.148528958501074e+03 + 30720 9.647424618486342e-01 -6.003133083901356e+00 -6.027874374965818e+00 3.660157053700603e+00 4.518088731706042e+00 9.302828902110852e+03 + 30740 9.600666106900217e-01 -5.976134918318284e+00 -6.012833302033489e+00 3.789619177423901e+00 4.578891379074669e+00 9.256499692122556e+03 + 30760 1.007209515135164e+00 -6.023076443973832e+00 -5.963509756986515e+00 3.602289666375500e+00 4.944330800971693e+00 9.105374791885750e+03 + 30780 9.835253434531696e-01 -5.962995925613893e+00 -6.014890918717711e+00 3.852615370239854e+00 4.554626289113505e+00 9.262824358974634e+03 + 30800 9.901096090643858e-01 -5.949810021567699e+00 -6.015644753909554e+00 3.992353676019660e+00 4.614320455020824e+00 9.265117359220740e+03 + 30820 1.068298446540637e+00 -6.043063452334981e+00 -5.996360832258252e+00 3.462060193646347e+00 4.730233865334025e+00 9.205877255751644e+03 + 30840 1.009641441733039e+00 -5.936741398002539e+00 -6.017183552823007e+00 3.972366426346770e+00 4.510455124984414e+00 9.269864940620777e+03 + 30860 1.001333536575028e+00 -5.908763650218204e+00 -5.980623464157447e+00 4.195983326084190e+00 4.783353154174789e+00 9.157640802325868e+03 + 30880 1.085065814710660e+00 -6.018338678779311e+00 -5.953923545065096e+00 3.607800033275592e+00 4.977681699272343e+00 9.076147967617149e+03 + 30900 1.011603814605248e+00 -5.899719690816252e+00 -6.013462543619100e+00 4.221226040462660e+00 4.568096978019121e+00 9.258373463897826e+03 + 30920 1.066779677787184e+00 -5.977035359572429e+00 -5.946862693356818e+00 3.870758310224919e+00 5.044014428839958e+00 9.054610640585372e+03 + 30940 1.039123952151273e+00 -5.932544068130576e+00 -5.967119335583754e+00 4.121097257770650e+00 4.922560721549155e+00 9.116361559327639e+03 + 30960 1.030126243359813e+00 -5.918898599943358e+00 -5.982771855073100e+00 4.177914678652430e+00 4.811144563343162e+00 9.164230979907226e+03 + 30980 1.041838106261155e+00 -5.941069203124223e+00 -6.040250910121639e+00 3.963139528041572e+00 4.393622818142854e+00 9.341022992867327e+03 + 31000 1.097328558014269e+00 -6.036532622298008e+00 -5.976050016383020e+00 3.511759002120119e+00 4.859059484936999e+00 9.143660928666943e+03 + 31020 1.006434645681044e+00 -5.926743668792462e+00 -5.999709846357222e+00 4.047484804560873e+00 4.628501721504532e+00 9.216165690815711e+03 + 31040 9.905252794761835e-01 -5.937717825332274e+00 -5.995257706230751e+00 4.033339371263279e+00 4.702936470876431e+00 9.202476411251106e+03 + 31060 1.016987042923998e+00 -6.020824078426609e+00 -5.980650268413588e+00 3.617821430976102e+00 4.848505664947877e+00 9.157729985073440e+03 + 31080 9.383106110221200e-01 -5.948953612527005e+00 -6.031196282731257e+00 3.903632523246659e+00 4.431382383921761e+00 9.313074749745740e+03 + 31100 9.690788583441644e-01 -6.036941636175341e+00 -5.991339430290878e+00 3.483109432521416e+00 4.744964355628549e+00 9.190478033356183e+03 + 31120 9.652855434407017e-01 -6.062619184450023e+00 -5.969069139354080e+00 3.369716354034427e+00 4.906895189798020e+00 9.122341404331593e+03 + 31140 9.237416682692647e-01 -6.019563778864507e+00 -5.986824420386447e+00 3.572364109905785e+00 4.760358572686156e+00 9.176655323694271e+03 + 31160 9.256175182566047e-01 -6.031879444997407e+00 -6.025219372497717e+00 3.534864139694895e+00 4.573107306631002e+00 9.294630936408337e+03 + 31180 9.349901431113254e-01 -6.047606582801631e+00 -6.020628472488992e+00 3.375558650995205e+00 4.530471135259454e+00 9.280511344569504e+03 + 31200 9.844343169412370e-01 -6.118465197851640e+00 -5.991291620025524e+00 3.059765794970863e+00 4.790016158895991e+00 9.190359627360043e+03 + 31220 9.779250394008274e-01 -6.103035818425727e+00 -5.961586384649608e+00 3.181685567927520e+00 4.993910105899131e+00 9.099524142841708e+03 + 31240 8.759283831900172e-01 -5.942396795784949e+00 -6.013894726646763e+00 4.024795946931501e+00 4.614243763653922e+00 9.259738381603776e+03 + 31260 1.003056755248818e+00 -6.113892981814609e+00 -5.947410488959805e+00 3.158705190330195e+00 5.114673427384988e+00 9.056305435744935e+03 + 31280 9.769911168449510e-01 -6.053347453364530e+00 -5.984812822346967e+00 3.443266253142045e+00 4.836802710144763e+00 9.170482865757986e+03 + 31300 1.020752563820373e+00 -6.095664620845620e+00 -5.972416874954117e+00 3.191883713498897e+00 4.899591342934939e+00 9.132566182949346e+03 + 31320 1.022478766241860e+00 -6.074910491468308e+00 -5.951231616356780e+00 3.307908009440895e+00 5.018091249575357e+00 9.067948788001102e+03 + 31340 1.054971990168924e+00 -6.098569456498211e+00 -5.953494755592094e+00 3.170954231169822e+00 5.003995614010156e+00 9.074840432369208e+03 + 31360 9.973704590653775e-01 -5.992901349612234e+00 -6.008411289892942e+00 3.696805355528511e+00 4.607744878281185e+00 9.242890666183901e+03 + 31380 1.035628978166274e+00 -6.035234657909723e+00 -5.959017789900678e+00 3.538157483577374e+00 4.975806534207514e+00 9.091658589163611e+03 + 31400 1.007215446884386e+00 -5.981156457653849e+00 -5.933268956614238e+00 3.854855956008263e+00 5.129833397544546e+00 9.013292065947442e+03 + 31420 9.700833558294085e-01 -5.913391699591791e+00 -6.001616926214121e+00 4.152830836972430e+00 4.646227932897317e+00 9.221955601442796e+03 + 31440 1.062862843593357e+00 -6.042710698824335e+00 -5.976886352318830e+00 3.427057257211922e+00 4.805030841131234e+00 9.146240160481975e+03 + 31460 9.974447708621510e-01 -5.940636885119797e+00 -6.034965496522629e+00 4.006989045379230e+00 4.465339561398729e+00 9.324701673798418e+03 + 31480 1.034264271048248e+00 -5.995907947803619e+00 -6.057014092170522e+00 3.674362031945616e+00 4.323481094845580e+00 9.392922485782594e+03 + 31500 1.020663026102032e+00 -5.979463450604142e+00 -6.043463959910865e+00 3.821253711133585e+00 4.453752882647569e+00 9.350968589700768e+03 + 31520 1.023930684951674e+00 -5.990545388184390e+00 -6.012252731437277e+00 3.769512702140426e+00 4.644865777981839e+00 9.254708195328310e+03 + 31540 1.049660241105234e+00 -6.036748637479337e+00 -5.978966489806875e+00 3.569285429009280e+00 4.901079462703013e+00 9.152580803756582e+03 + 31560 1.029057026142104e+00 -6.012542251167478e+00 -5.983816831933439e+00 3.713630461812929e+00 4.878576264299037e+00 9.167432320713644e+03 + 31580 1.061709728414808e+00 -6.068510000087695e+00 -5.983056710726014e+00 3.385350178848636e+00 4.876036190217199e+00 9.165112362652819e+03 + 31600 1.005963352151126e+00 -5.993701890546827e+00 -6.042791400573085e+00 3.730616879704237e+00 4.448737316556342e+00 9.348883070659540e+03 + 31620 1.010493528781656e+00 -6.009473726344407e+00 -6.010284957607306e+00 3.639767455784868e+00 4.635109240335668e+00 9.248652010803937e+03 + 31640 9.971633125753645e-01 -5.998655478294780e+00 -6.004410674399989e+00 3.739992032045502e+00 4.706944805395673e+00 9.230575939776329e+03 + 31660 9.887207839355799e-01 -5.995155597896978e+00 -5.991574033134789e+00 3.695853234837108e+00 4.716419133946953e+00 9.191215127168460e+03 + 31680 9.703943878744241e-01 -5.976235338269938e+00 -6.029102758110812e+00 3.856033208415129e+00 4.552460302482052e+00 9.306587282107315e+03 + 31700 1.021146141569824e+00 -6.059415821922836e+00 -5.984234799927833e+00 3.390284422167717e+00 4.821985484688577e+00 9.168703142613313e+03 + 31720 9.823584890550099e-01 -6.007388218439872e+00 -5.997969499707191e+00 3.698141858659910e+00 4.752225599164981e+00 9.210818309084396e+03 + 31740 1.010897179502517e+00 -6.054301677109072e+00 -6.011722415749551e+00 3.400609805734097e+00 4.645106513579862e+00 9.253084691950648e+03 + 31760 9.795242658260285e-01 -6.015029940721191e+00 -6.037562228610831e+00 3.603959048689419e+00 4.474575164766823e+00 9.332725988776559e+03 + 31780 1.067038334897512e+00 -6.157119628526302e+00 -5.953987579750482e+00 2.913559449512548e+00 5.079975108166266e+00 9.076343552371096e+03 + 31800 9.195949052916385e-01 -5.953305472037782e+00 -6.010268298126794e+00 3.951982022750168e+00 4.624892660378209e+00 9.248581019164323e+03 + 31820 1.004815422944286e+00 -6.098686739303657e+00 -5.961584522823613e+00 3.164300742848844e+00 4.951562886376689e+00 9.099505832036777e+03 + 31840 9.289304413315859e-01 -6.008640209452857e+00 -6.020085703299594e+00 3.635871880088492e+00 4.570150083236086e+00 9.278822310846777e+03 + 31860 9.585223467802553e-01 -6.078126829287502e+00 -5.980148135985970e+00 3.315237763639118e+00 4.877846582730301e+00 9.156201436281284e+03 + 31880 9.357973841139077e-01 -6.065006489685641e+00 -5.973976723715542e+00 3.385341798201100e+00 4.908048801212166e+00 9.137317683490974e+03 + 31900 9.622485557608046e-01 -6.120735472922959e+00 -5.980038325891370e+00 3.034250056582494e+00 4.842154847651015e+00 9.155871464859647e+03 + 31920 9.254293647485294e-01 -6.077623434944692e+00 -5.997467152567999e+00 3.262871742118818e+00 4.723141519670403e+00 9.209302102219070e+03 + 31940 9.466773570666212e-01 -6.114150059026270e+00 -5.974298839189773e+00 3.108013554573379e+00 4.911060900780869e+00 9.138336748224461e+03 + 31960 8.951138003405223e-01 -6.035203417283264e+00 -6.005904957796069e+00 3.483053505449365e+00 4.651289793746792e+00 9.235191564896037e+03 + 31980 9.674772298737931e-01 -6.131290412923964e+00 -5.985953066114665e+00 2.967152712836285e+00 4.801702249097014e+00 9.173999222842505e+03 + 32000 9.151687308805541e-01 -6.033182285661968e+00 -6.006360537697566e+00 3.533443001796853e+00 4.687457629260535e+00 9.236591218996804e+03 + 32020 9.329394209775618e-01 -6.031322865775140e+00 -6.018396704824514e+00 3.483206505572282e+00 4.557430522067715e+00 9.273620285000563e+03 + 32040 1.014622252942742e+00 -6.116210189421648e+00 -5.970314071633263e+00 3.095209412653582e+00 4.932967498345749e+00 9.126147471483651e+03 + 32060 9.752743607819213e-01 -6.020267915840212e+00 -5.998289426610700e+00 3.608749341467501e+00 4.734953227783574e+00 9.211814682333496e+03 + 32080 1.034853770589371e+00 -6.072876486258344e+00 -5.972414558398592e+00 3.381856196713629e+00 4.958724132917416e+00 9.132557684545227e+03 + 32100 9.636459671481310e-01 -5.935712418042361e+00 -6.044567058566010e+00 4.001724812770362e+00 4.376664621682392e+00 9.354357701737485e+03 + 32120 1.014976934167490e+00 -5.986939133031907e+00 -6.008125509346358e+00 3.748937485352682e+00 4.627282033973968e+00 9.242013618468278e+03 + 32140 1.055877228880048e+00 -6.028586948410262e+00 -6.000318115015489e+00 3.565921846872949e+00 4.728245862813565e+00 9.218013078284330e+03 + 32160 1.020863871416893e+00 -5.964581972725310e+00 -5.962843633470621e+00 3.897480382951808e+00 4.907462195959360e+00 9.103331835043660e+03 + 32180 1.040603962268929e+00 -5.985525144525254e+00 -5.947976311839689e+00 3.807058448993650e+00 5.022669656937245e+00 9.058014658168457e+03 + 32200 1.004225116949734e+00 -5.924670945837244e+00 -5.985152646157317e+00 4.093669765122435e+00 4.746374482371698e+00 9.171491371042935e+03 + 32220 1.034965909824623e+00 -5.965343999346651e+00 -5.956457413216826e+00 3.913427198957867e+00 4.964455351710082e+00 9.083845782765093e+03 + 32240 1.022343541261796e+00 -5.943430668803857e+00 -5.993263761940056e+00 3.939274574789402e+00 4.653125242355109e+00 9.196374564547248e+03 + 32260 1.013315546690252e+00 -5.928522719815480e+00 -5.985698939482600e+00 4.101543275701234e+00 4.773228574381233e+00 9.173175631752434e+03 + 32280 1.059212635853594e+00 -5.999589900997943e+00 -5.987597441084226e+00 3.639100673593213e+00 4.707963234244949e+00 9.179022057591794e+03 + 32300 1.043091902488871e+00 -5.982750498995590e+00 -6.018173349463371e+00 3.753479567076826e+00 4.550076078022437e+00 9.272927611214955e+03 + 32320 9.960002004924462e-01 -5.925539211578099e+00 -6.042532690157208e+00 4.081881931560716e+00 4.410087272877169e+00 9.348070077293960e+03 + 32340 1.012745165168379e+00 -5.969722238636041e+00 -6.013196662310541e+00 3.834423018681704e+00 4.584786150297402e+00 9.257597620543975e+03 + 32360 1.034399184427269e+00 -6.029104578250220e+00 -6.003194690991163e+00 3.495597162416441e+00 4.644375744600048e+00 9.226870929816167e+03 + 32380 9.722915226433857e-01 -5.973151181185625e+00 -6.015041308741568e+00 3.890683037376547e+00 4.650143442474038e+00 9.263283398830101e+03 + 32400 9.976249220341185e-01 -6.055644742241949e+00 -6.033392618281356e+00 3.334059509022716e+00 4.461834648309491e+00 9.319858715298624e+03 + 32420 9.111814549617361e-01 -5.976629688062792e+00 -5.990439677087604e+00 3.772747455875586e+00 4.693448361806219e+00 9.187714106781797e+03 + 32440 9.311821100018742e-01 -6.042972545226986e+00 -5.944346640755546e+00 3.470688353048231e+00 5.037013558832632e+00 9.046983030889913e+03 + 32460 9.457060037709563e-01 -6.086344330307546e+00 -5.992328867173882e+00 3.186631424455464e+00 4.726482762614869e+00 9.193542506170570e+03 + 32480 9.211491694250057e-01 -6.064450023792324e+00 -6.042150210442010e+00 3.278478786011996e+00 4.406527765154468e+00 9.346903274506667e+03 + 32500 9.745196411001332e-01 -6.150703076940249e+00 -5.963161091978562e+00 2.887918676668388e+00 4.964813776346770e+00 9.104315289702728e+03 + 32520 9.420780892600498e-01 -6.100424802990642e+00 -5.972609535054874e+00 3.157631318919244e+00 4.891566366755217e+00 9.133153964215675e+03 + 32540 8.941819844812283e-01 -6.019487301886222e+00 -5.978055719836230e+00 3.610341759746424e+00 4.848248315394082e+00 9.149814335019460e+03 + 32560 9.574705975210956e-01 -6.098156409554119e+00 -5.987089320670942e+00 3.164884122672570e+00 4.802648534616228e+00 9.177476191346832e+03 + 32580 9.669712722388146e-01 -6.096277603991965e+00 -6.020634157460800e+00 3.144200697002606e+00 4.578557072770075e+00 9.280501374446865e+03 + 32600 9.545382031429612e-01 -6.059829377622717e+00 -5.993924334608217e+00 3.326098593156519e+00 4.704535548918223e+00 9.198431825205653e+03 + 32620 8.820136041831191e-01 -5.933395852948081e+00 -6.026720162763350e+00 4.005636103264551e+00 4.469753474415003e+00 9.299267771395173e+03 + 32640 1.026171642786762e+00 -6.128642427057849e+00 -5.973928437745823e+00 3.028899531599942e+00 4.917291200142062e+00 9.137194907120793e+03 + 32660 9.954509267786282e-01 -6.064038713570797e+00 -5.995538215500442e+00 3.367796593050097e+00 4.761137053387893e+00 9.203374657679680e+03 + 32680 9.678378785449161e-01 -6.007236532003341e+00 -5.978573559158003e+00 3.676731681366806e+00 4.841318907025447e+00 9.151382916690802e+03 + 32700 9.850152364537634e-01 -6.017452556249521e+00 -5.993285352770817e+00 3.601573168938829e+00 4.740344991176194e+00 9.196462110044624e+03 + 32720 9.964918219327976e-01 -6.017706837762883e+00 -6.000713296826092e+00 3.586905078304135e+00 4.684484620105146e+00 9.219228997333652e+03 + 32740 1.011855946185646e+00 -6.025644395926242e+00 -6.016697215477672e+00 3.536154189146110e+00 4.587530283853496e+00 9.268371572912933e+03 + 32760 9.884985354163046e-01 -5.978529017573485e+00 -6.054913664882109e+00 3.777202113232237e+00 4.338589647900145e+00 9.386405658224165e+03 + 32780 9.948188638879417e-01 -5.979895339342377e+00 -6.018354499348703e+00 3.818136290426440e+00 4.597297842134339e+00 9.273481399700213e+03 + 32800 1.029707340054262e+00 -6.024715145423071e+00 -5.970652692697107e+00 3.574208886569269e+00 4.884643856259276e+00 9.127189255561274e+03 + 32820 9.631914057895057e-01 -5.920071387288813e+00 -6.027295707935913e+00 4.135747720624055e+00 4.520049078558413e+00 9.301025162060238e+03 + 32840 9.783456506880607e-01 -5.937400524689138e+00 -6.015948257332845e+00 4.069136250911697e+00 4.618103014849190e+00 9.266046956598579e+03 + 32860 1.038951277304072e+00 -6.021898288056663e+00 -5.995082604800057e+00 3.607924270047689e+00 4.761904073020697e+00 9.201973846341320e+03 + 32880 1.043813797743947e+00 -6.025815493722068e+00 -6.046399682376568e+00 3.494188908358649e+00 4.375991311711612e+00 9.360065557711128e+03 + 32900 1.014450505218701e+00 -5.984368728957874e+00 -5.999105407841731e+00 3.780953996978146e+00 4.696333706333353e+00 9.214317201241920e+03 + 32920 1.028516139563638e+00 -6.007656380872955e+00 -6.004599453127692e+00 3.675961427638714e+00 4.693514779810060e+00 9.231167186142182e+03 + 32940 9.737317873205221e-01 -5.932597597294760e+00 -6.040096884031715e+00 4.054263635983120e+00 4.436986096078667e+00 9.340521972617806e+03 + 32960 9.994148775020879e-01 -5.982350240352226e+00 -6.005149866587979e+00 3.745839295837920e+00 4.614920313761472e+00 9.232832568013988e+03 + 32980 9.564987284096131e-01 -5.934418932978470e+00 -5.995897340752041e+00 4.020361028793277e+00 4.667342497604571e+00 9.204451394716863e+03 + 33000 9.902670572660667e-01 -6.005486671036238e+00 -5.990684398218967e+00 3.657242400978359e+00 4.742239342139444e+00 9.188493228831911e+03 + 33020 9.907133215196436e-01 -6.038607925083467e+00 -5.987358459479071e+00 3.551284055420164e+00 4.845566417749779e+00 9.178290377182429e+03 + 33040 8.854605713119302e-01 -5.918846948562457e+00 -6.092399902473762e+00 4.087247126470153e+00 4.090679207878622e+00 9.502859044287876e+03 + 33060 9.457960455472602e-01 -6.047247394991219e+00 -6.000378143630154e+00 3.441238248927672e+00 4.710368743236114e+00 9.218217309403561e+03 + 33080 9.859991420191038e-01 -6.139627417025794e+00 -5.965307863745714e+00 2.960406692265189e+00 4.961376543063098e+00 9.110869825546823e+03 + 33100 9.636644101116570e-01 -6.133387056533358e+00 -5.923291485556746e+00 2.997712384424845e+00 5.204113665157088e+00 8.983074689120373e+03 + 33120 9.061081317673598e-01 -6.063130423941759e+00 -5.948338652419478e+00 3.366255357785959e+00 5.025407473836129e+00 9.059132823214735e+03 + 33140 9.466287232773588e-01 -6.126872310813608e+00 -5.987312439146013e+00 2.964154347887431e+00 4.765528727823108e+00 9.178150159981338e+03 + 33160 9.050497290619023e-01 -6.060662663634652e+00 -5.979566918042548e+00 3.396751554448482e+00 4.862415875164416e+00 9.154436076429969e+03 + 33180 9.038664157680500e-01 -6.045659628302595e+00 -5.999171970821189e+00 3.468704736050266e+00 4.735644059250241e+00 9.214504556108197e+03 + 33200 9.238791783721760e-01 -6.053461084678899e+00 -5.983928537394516e+00 3.395079761194356e+00 4.794346407828198e+00 9.167788342383607e+03 + 33220 9.806740015500254e-01 -6.108082394689459e+00 -5.977235895552507e+00 3.100651738814782e+00 4.851992585289466e+00 9.147301036190685e+03 + 33240 9.757358511039843e-01 -6.065860889355597e+00 -5.994201535957030e+00 3.321375079678545e+00 4.732854176142215e+00 9.199236227932066e+03 + 33260 9.685717906786085e-01 -6.019719067896865e+00 -5.976598719878332e+00 3.533116979536751e+00 4.780720690711457e+00 9.145317391440101e+03 + 33280 9.999457141822766e-01 -6.032472242706670e+00 -5.940084819981209e+00 3.594395205477916e+00 5.124898083674974e+00 9.034011093919691e+03 + 33300 9.682581058867985e-01 -5.954686588667549e+00 -5.958333046365404e+00 3.958585040422841e+00 4.937646516034256e+00 9.089567954343567e+03 + 33320 9.627652606617650e-01 -5.922546378992930e+00 -5.977160609701055e+00 4.116813023551186e+00 4.803209659300248e+00 9.147047369508411e+03 + 33340 1.043648890054688e+00 -6.022699261668340e+00 -5.995823077411917e+00 3.507025042346800e+00 4.661352251423249e+00 9.204231226798081e+03 + 33360 9.886693739577626e-01 -5.927952557155355e+00 -6.017378443456908e+00 4.080391304704123e+00 4.566894026949426e+00 9.270466778988892e+03 + 33380 1.030282999459966e+00 -5.981660312371774e+00 -6.035355102857128e+00 3.739671987435172e+00 4.431348191226296e+00 9.325900947232032e+03 + 33400 9.585724956057314e-01 -5.871961841891172e+00 -6.032728250702713e+00 4.367790537853402e+00 4.444644939936170e+00 9.317801208201563e+03 + 33420 1.034120923856528e+00 -5.984017443491371e+00 -5.996333748474152e+00 3.807829773424403e+00 4.737107644271239e+00 9.205781613905488e+03 + 33440 1.048007602981950e+00 -6.007554681931542e+00 -6.013371390242893e+00 3.651093302038379e+00 4.617692862781897e+00 9.258098194866563e+03 + 33460 1.025281436380503e+00 -5.978968635064622e+00 -6.002326904348418e+00 3.844122890320267e+00 4.709996093412224e+00 9.224184838056346e+03 + 33480 1.008654787141651e+00 -5.963384638301566e+00 -6.005067213296680e+00 3.897725194996888e+00 4.658377399017311e+00 9.232615981018898e+03 + 33500 1.043549703759146e+00 -6.025804723334518e+00 -5.986243697297672e+00 3.565552409970119e+00 4.792717943522684e+00 9.174862120351141e+03 + 33520 1.075019218641920e+00 -6.084548304003254e+00 -5.968598750113390e+00 3.278772079976358e+00 4.944572361547433e+00 9.120894595833415e+03 + 33540 1.037683292042541e+00 -6.044496868251161e+00 -5.981074654604106e+00 3.505966186134025e+00 4.870146351451260e+00 9.159058568947914e+03 + 33560 1.008884288359768e+00 -6.020600259038438e+00 -6.059701446610946e+00 3.558861216442294e+00 4.334336146511729e+00 9.401245468424922e+03 + 33580 1.002496681654785e+00 -6.037512612137221e+00 -6.022207828024466e+00 3.497792563844871e+00 4.585675002628000e+00 9.285348645016293e+03 + 33600 9.003063210291008e-01 -5.915088595965547e+00 -5.997258177359505e+00 4.159418962453176e+00 4.687588510387440e+00 9.208620415825608e+03 + 33620 9.697104833530661e-01 -6.043527114209985e+00 -5.962125637299414e+00 3.501336464766463e+00 4.968756342024806e+00 9.101148429256535e+03 + 33640 1.021172053329951e+00 -6.144996897148092e+00 -5.999371456175157e+00 2.874312266719389e+00 4.710516084250139e+00 9.215132065020665e+03 + 33660 9.771284416283188e-01 -6.106716036551368e+00 -6.024806496347844e+00 3.078629403783051e+00 4.548966659092061e+00 9.293380994813402e+03 + 33680 9.315271765672908e-01 -6.066301656567071e+00 -6.000972406228986e+00 3.370650019655127e+00 4.745780684765231e+00 9.220057357059735e+03 + 33700 9.149799223153399e-01 -6.066740353394578e+00 -6.013032231260791e+00 3.356354697900811e+00 4.664755046498054e+00 9.257119320489650e+03 + 33720 9.536147634243390e-01 -6.147525539825371e+00 -6.008358057578698e+00 2.879041873907398e+00 4.678163093066074e+00 9.242730512117005e+03 + 33740 9.446118323398265e-01 -6.153514848975169e+00 -5.978850437216445e+00 2.856100580957237e+00 4.859050662506196e+00 9.152247342708759e+03 + 33760 8.696873328093571e-01 -6.057066271272640e+00 -5.971236954037765e+00 3.436951970368221e+00 4.929797191974790e+00 9.128973740177265e+03 + 33780 8.977837393781597e-01 -6.106415495590634e+00 -5.959909518491742e+00 3.085434032899455e+00 4.926694025127979e+00 9.094403925857352e+03 + 33800 9.116251180149476e-01 -6.125743879936487e+00 -5.976118104450610e+00 2.990190659644540e+00 4.849365016998377e+00 9.143886989428755e+03 + 33820 9.211915089663100e-01 -6.124514054143138e+00 -5.984381665339884e+00 3.022640958194752e+00 4.827302820120122e+00 9.169186221904138e+03 + 33840 9.395031302416452e-01 -6.117927466480293e+00 -5.971934640042973e+00 3.095378999414376e+00 4.933692401134344e+00 9.131103561563781e+03 + 33860 9.034655108560102e-01 -6.012697689615202e+00 -6.005282405857484e+00 3.629520463345373e+00 4.672100170193644e+00 9.233283970413788e+03 + 33880 9.851841002401279e-01 -6.078857341753924e+00 -5.982518979467227e+00 3.259475779427306e+00 4.812665563990905e+00 9.163471630765747e+03 + 33900 8.782238873563603e-01 -5.872467032486519e+00 -6.041208365799362e+00 4.415039231505569e+00 4.446100382986288e+00 9.343962803711103e+03 + 33920 9.779863953032754e-01 -5.980663550877299e+00 -6.002331812018170e+00 3.900176342578287e+00 4.775753833954832e+00 9.224174385623191e+03 + 33940 1.040438798829637e+00 -6.041803853397737e+00 -6.010403334294034e+00 3.456441559369241e+00 4.636748199277336e+00 9.249029028270581e+03 + 33960 9.835408149031730e-01 -5.936066409183342e+00 -6.001569346676382e+00 4.072840889867244e+00 4.696712886235391e+00 9.221870964931311e+03 + 33980 1.014788617537240e+00 -5.966583857995999e+00 -5.993212599055729e+00 3.814216995239411e+00 4.661310643290077e+00 9.196229426512591e+03 + 34000 1.003541278664898e+00 -5.936855632147974e+00 -5.966113367574051e+00 4.030090754921023e+00 4.862088310484559e+00 9.113296357197898e+03 + 34020 1.028072314518105e+00 -5.960791744969534e+00 -5.977437536984114e+00 3.883540519233895e+00 4.787957805558190e+00 9.147889898825462e+03 + 34040 1.061819882867355e+00 -5.998046280097934e+00 -6.014960555190786e+00 3.692033646922333e+00 4.594909261863565e+00 9.263026702182857e+03 + 34060 1.022651140574749e+00 -5.932908150676687e+00 -6.040076176865240e+00 4.053582233567334e+00 4.438206842994204e+00 9.340466261775489e+03 + 34080 1.111420145564495e+00 -6.065141173406783e+00 -5.974177590792148e+00 3.346271124841783e+00 4.868598092783932e+00 9.137932328151574e+03 + 34100 1.036121711731233e+00 -5.959047584985695e+00 -6.001690150776374e+00 3.904937134704594e+00 4.660076923018786e+00 9.222227923555181e+03 + 34120 1.035080572945139e+00 -5.968321054388600e+00 -5.934920272068526e+00 3.856790055845723e+00 5.048582516681948e+00 9.018344913922654e+03 + 34140 1.011654007292492e+00 -5.943855928000963e+00 -5.963155359968600e+00 3.979161873077312e+00 4.868341548141695e+00 9.104286076322087e+03 + 34160 1.070506873534731e+00 -6.043939017287849e+00 -6.000457130450219e+00 3.465025204762040e+00 4.714704927783958e+00 9.218461717038124e+03 + 34180 1.033578637200572e+00 -6.010704473709740e+00 -6.049631928451516e+00 3.636457171786251e+00 4.412929702654823e+00 9.370028443056621e+03 + 34200 9.422118436028556e-01 -5.902822048980751e+00 -6.053599804684061e+00 4.187253814154459e+00 4.321464608123763e+00 9.382306440626026e+03 + 34220 9.879468739359611e-01 -5.998254656983296e+00 -6.001232808039214e+00 3.716744770228155e+00 4.699643765997685e+00 9.220847239944535e+03 + 34240 1.035007144365113e+00 -6.100040650839254e+00 -6.019046915003993e+00 3.119198367552936e+00 4.584276932459121e+00 9.275636993379732e+03 + 34260 9.599123272526355e-01 -6.020676892064640e+00 -6.001236758301349e+00 3.628835415191777e+00 4.740463671611567e+00 9.220848746519447e+03 + 34280 9.531672029216303e-01 -6.036186390163556e+00 -5.999465335865843e+00 3.486274279870611e+00 4.697132256212874e+00 9.215405185850168e+03 + 34300 9.460053973363286e-01 -6.045139800534158e+00 -5.961124659042118e+00 3.441467052242184e+00 4.923894995990605e+00 9.098092057911896e+03 + 34320 9.467642020436395e-01 -6.058367851961826e+00 -5.962672668723082e+00 3.397712543812279e+00 4.947209094750898e+00 9.102811040860832e+03 + 34340 9.875530224240409e-01 -6.122769906460754e+00 -5.995670872909958e+00 3.000627584067935e+00 4.730449903228486e+00 9.203774174321561e+03 + 34360 1.016842552975050e+00 -6.167084451398407e+00 -5.966458163194686e+00 2.791824093449569e+00 4.943851287133096e+00 9.114388509397248e+03 + 34380 9.500991951002065e-01 -6.063524588314137e+00 -5.988074387875151e+00 3.345575230824916e+00 4.778821957626361e+00 9.180504968218484e+03 + 34400 9.541609385222664e-01 -6.059918210169195e+00 -5.971892686346856e+00 3.370477882390710e+00 4.875934062084365e+00 9.130981668739203e+03 + 34420 9.295401668140288e-01 -6.006476371811631e+00 -5.965955516001371e+00 3.652323896134907e+00 4.885000920779592e+00 9.112819695429993e+03 + 34440 9.491557202683801e-01 -6.008551081570284e+00 -5.949708340200093e+00 3.622696812264180e+00 4.960580939096615e+00 9.063298706040276e+03 + 34460 1.045867078373231e+00 -6.108720667166840e+00 -5.958919802048690e+00 3.096037627634987e+00 4.956217376752363e+00 9.091382082286247e+03 + 34480 1.045331529189962e+00 -6.054547723980393e+00 -5.965294523924631e+00 3.401745971020905e+00 4.914251657629164e+00 9.110834065222925e+03 + 34500 9.970243812991485e-01 -5.930738117481931e+00 -6.043938719440161e+00 4.006973213322732e+00 4.356957839142039e+00 9.352392822743181e+03 + 34520 1.072690766000264e+00 -6.006614468706598e+00 -5.981062664989095e+00 3.690086868829410e+00 4.836809279904155e+00 9.158970347146302e+03 + 34540 1.028827004273694e+00 -5.918487187630155e+00 -5.993562022106553e+00 4.118588661467624e+00 4.687497344111057e+00 9.197270736654580e+03 + 34560 1.035133149389094e+00 -5.917915145239099e+00 -6.003501888968486e+00 4.092227583634710e+00 4.600775256634780e+00 9.227775834018144e+03 + 34580 1.046563789494169e+00 -5.932226064576133e+00 -5.964394147612981e+00 4.063264086406178e+00 4.878549975613834e+00 9.108061610398918e+03 + 34600 1.073921222392445e+00 -5.973354294487048e+00 -6.054758126852446e+00 3.774612176480133e+00 4.307178773835668e+00 9.385919896722267e+03 + 34620 1.139273786773978e+00 -6.080741538785975e+00 -6.021480827818183e+00 3.245146589460724e+00 4.585430762403169e+00 9.283126141863040e+03 + 34640 9.830795713155516e-01 -5.865708587061977e+00 -6.038716012089068e+00 4.433671606879127e+00 4.440236199561071e+00 9.336267907199725e+03 + 34660 1.056088300295727e+00 -5.993500014412904e+00 -5.967586400374310e+00 3.737237079068778e+00 4.886037060997200e+00 9.117809466216771e+03 + 34680 1.080979169432538e+00 -6.050659064459841e+00 -5.977328820178178e+00 3.429964123070661e+00 4.851037733554604e+00 9.147584629435103e+03 + 34700 9.647861202639074e-01 -5.901398173400184e+00 -6.026425284408602e+00 4.226365742343789e+00 4.508440723050556e+00 9.298331961438809e+03 + 34720 1.002491774161328e+00 -5.981309476389429e+00 -5.990443874283450e+00 3.788824406929170e+00 4.736373280678193e+00 9.187733852020370e+03 + 34740 1.028215143929322e+00 -6.041336532383569e+00 -5.981512003165607e+00 3.461796010575603e+00 4.805317715161125e+00 9.160377243653407e+03 + 34760 1.024945236530417e+00 -6.056658160192340e+00 -5.990323557186668e+00 3.396453691492574e+00 4.777357247197777e+00 9.187351197600054e+03 + 34780 9.778080523122809e-01 -6.007417868038531e+00 -6.014388330119592e+00 3.637030127231559e+00 4.597004655286583e+00 9.261271776712116e+03 + 34800 9.870153980013269e-01 -6.038932289599342e+00 -6.001409950269310e+00 3.498300457324050e+00 4.713759536320340e+00 9.221399168198892e+03 + 34820 9.822646507590398e-01 -6.048635314402544e+00 -6.020882931280021e+00 3.398130551352223e+00 4.557489029909158e+00 9.281260881601213e+03 + 34840 9.541668602630072e-01 -6.022126423342334e+00 -5.958285199122209e+00 3.602733137703586e+00 4.969319326573062e+00 9.089419303117369e+03 + 34860 9.533934197269855e-01 -6.029997067900548e+00 -5.951753830867576e+00 3.483248129134522e+00 4.932532904279650e+00 9.069524662387670e+03 + 34880 9.016191299794400e-01 -5.955693137052450e+00 -5.985759678547641e+00 3.922613299836366e+00 4.749966565788714e+00 9.173309883387104e+03 + 34900 9.652271373706185e-01 -6.045518647026376e+00 -6.008762520124411e+00 3.424680983768814e+00 4.635740352432153e+00 9.243945804485833e+03 + 34920 9.547793947232713e-01 -6.020575907734938e+00 -5.986180018727359e+00 3.660107915435105e+00 4.857614432863243e+00 9.174671919549311e+03 + 34940 9.749913305283587e-01 -6.036304230935364e+00 -5.989584926548906e+00 3.550156281066591e+00 4.818425756642624e+00 9.185078519861650e+03 + 34960 9.546761346725343e-01 -5.983881560295552e+00 -5.994222568795648e+00 3.795462467694266e+00 4.736082796620821e+00 9.199299126174928e+03 + 34980 9.985574021780338e-01 -6.012024315056893e+00 -5.956434416284742e+00 3.631514619030748e+00 4.950720420289471e+00 9.083781568875071e+03 + 35000 9.988082222825961e-01 -5.960777959094782e+00 -6.010849833309306e+00 3.930775215378311e+00 4.643254765041016e+00 9.250367123094447e+03 + 35020 1.093889328252382e+00 -6.046204677809361e+00 -5.963415484501124e+00 3.475377873794278e+00 4.950766233356434e+00 9.105082444248012e+03 + 35040 1.070226101709364e+00 -5.964864765251237e+00 -6.011763347822352e+00 3.918819296178552e+00 4.649520377523009e+00 9.253204350737049e+03 + 35060 1.082816269619288e+00 -5.954003379351628e+00 -6.049641192870213e+00 3.918652692430480e+00 4.369485567302958e+00 9.370080652397730e+03 + 35080 1.110402479809612e+00 -5.982927231733442e+00 -6.015308882503428e+00 3.823265490490503e+00 4.637325040724983e+00 9.264108791326318e+03 + 35100 1.023848398765998e+00 -5.854697393463796e+00 -5.999283982164206e+00 4.497967723105257e+00 4.667729156085214e+00 9.214810376362107e+03 + 35120 1.005384635430524e+00 -5.832981740264931e+00 -5.957234304348768e+00 4.650260299178484e+00 4.936782848186942e+00 9.086179064603110e+03 + 35140 9.973079073832217e-01 -5.825353156976501e+00 -6.008574422284925e+00 4.621871654902588e+00 4.569786796102449e+00 9.243346429929967e+03 + 35160 1.092852797509506e+00 -5.976763060783914e+00 -6.054443989162827e+00 3.803020861250594e+00 4.356964949414060e+00 9.384923307537209e+03 + 35180 1.021955619552017e+00 -5.891148315322929e+00 -6.035133238017371e+00 4.227806729368615e+00 4.401023021662355e+00 9.325233559586004e+03 + 35200 1.040730395486057e+00 -5.944950439406575e+00 -5.989443753104648e+00 4.011950720360010e+00 4.756463227787630e+00 9.184658338122434e+03 + 35220 1.037447360488019e+00 -5.967083516299775e+00 -6.016116789818277e+00 3.935919903911590e+00 4.654363259493800e+00 9.266557591171166e+03 + 35240 1.008068172620725e+00 -5.951218651422489e+00 -6.026979189301763e+00 3.937169271172723e+00 4.502140538764592e+00 9.300066020148992e+03 + 35260 1.023713581610329e+00 -6.001678392079574e+00 -6.017192110890970e+00 3.626562343440797e+00 4.537480169285536e+00 9.269920279462262e+03 + 35280 9.938643080704421e-01 -5.981073794241389e+00 -6.013114929805127e+00 3.848640855809534e+00 4.664655697052849e+00 9.257353421061298e+03 + 35300 9.900922845714374e-01 -5.995461556644762e+00 -6.020352991056877e+00 3.683899506821897e+00 4.540969038490505e+00 9.279656574393110e+03 + 35320 9.758663136855893e-01 -5.990696189990635e+00 -6.032666678593924e+00 3.727932668834004e+00 4.486931628361795e+00 9.317548916293830e+03 + 35340 9.935164877530744e-01 -6.028756119420661e+00 -5.997365387476096e+00 3.530477737149707e+00 4.710728177675472e+00 9.208978033808044e+03 + 35360 9.756047356444162e-01 -6.012623072928546e+00 -6.004216194070210e+00 3.657683865625168e+00 4.705957464990031e+00 9.229987073319466e+03 + 35380 1.005650940098622e+00 -6.061699317933312e+00 -5.994809202670155e+00 3.353307767312916e+00 4.737401160365843e+00 9.201137382807687e+03 + 35400 9.586391170097655e-01 -5.995157698975603e+00 -5.982381258341356e+00 3.732526750489974e+00 4.805891049759616e+00 9.163053789174252e+03 + 35420 9.188099276383979e-01 -5.934802435087092e+00 -6.022375582674369e+00 4.059649763754928e+00 4.556791198407995e+00 9.285859586687768e+03 + 35440 9.908600208540848e-01 -6.038121610833671e+00 -6.012820519175404e+00 3.464682098299358e+00 4.609964881932406e+00 9.256450420728979e+03 + 35460 9.922770690366294e-01 -6.035292021115004e+00 -6.013190461670430e+00 3.507201372763333e+00 4.634111947299351e+00 9.257589046879781e+03 + 35480 9.777379584020841e-01 -6.007593769400861e+00 -5.998471964543963e+00 3.692631555409368e+00 4.745010370492413e+00 9.212357099886816e+03 + 35500 1.009252780578784e+00 -6.046806969919109e+00 -5.998349239404622e+00 3.479730066654630e+00 4.757981854078377e+00 9.211977706847252e+03 + 35520 1.010431697190726e+00 -6.040221148019866e+00 -6.004452087732021e+00 3.494636648075242e+00 4.700028127492238e+00 9.230710031393315e+03 + 35540 9.438364935301815e-01 -5.934506260149205e+00 -6.058849012655848e+00 4.028754001023096e+00 4.314758674151189e+00 9.398571628233138e+03 + 35560 9.294016608656782e-01 -5.904428519310151e+00 -6.048591615886669e+00 4.180240984932514e+00 4.352434175223053e+00 9.366823943293635e+03 + 35580 1.011335770825997e+00 -6.015369111187106e+00 -5.987282560450582e+00 3.631380621780798e+00 4.792657942489602e+00 9.178052562356126e+03 + 35600 9.980861755199431e-01 -5.981933871297517e+00 -6.016931662975134e+00 3.743677729864410e+00 4.542714994160773e+00 9.269091117108210e+03 + 35620 9.695335651944508e-01 -5.923970935327216e+00 -6.051400636479813e+00 4.065310741947913e+00 4.333589678247182e+00 9.375486530262351e+03 + 35640 1.030023966513938e+00 -5.993920476658178e+00 -5.975833889646841e+00 3.754048229882517e+00 4.857904211391906e+00 9.142992185890047e+03 + 35660 1.022148219323836e+00 -5.951442049436960e+00 -5.999127518367678e+00 3.897486807814521e+00 4.623669465911872e+00 9.214324380953527e+03 + 35680 1.068572235567830e+00 -5.972301787278510e+00 -5.997218970742480e+00 3.901914605367373e+00 4.758836281995574e+00 9.208487926697177e+03 + 35700 1.079804879426755e+00 -5.929562480344019e+00 -6.013087375398226e+00 4.067415305795455e+00 4.587802432958459e+00 9.257261204844741e+03 + 35720 1.067525271662049e+00 -5.859320548242229e+00 -6.035438449633805e+00 4.461474172101465e+00 4.450177928153878e+00 9.326154630974424e+03 + 35740 1.177503510637374e+00 -5.984665068734431e+00 -6.043894613082071e+00 3.801952236118859e+00 4.461847026732342e+00 9.352298996913183e+03 + 35760 1.118309569938307e+00 -5.880375185136863e+00 -6.084120338250760e+00 4.305019458845960e+00 4.135083260205417e+00 9.477097737193088e+03 + 35780 1.106707304170611e+00 -5.866060543359131e+00 -6.032444014482957e+00 4.448444631825216e+00 4.493044992873263e+00 9.316923134633735e+03 + 35800 1.068902091967284e+00 -5.826761808240421e+00 -6.023717820787718e+00 4.597922916065560e+00 4.466971013174541e+00 9.289987986152630e+03 + 35820 1.083862856527862e+00 -5.874091391688279e+00 -5.994919978513782e+00 4.349360257419209e+00 4.655543813703789e+00 9.201431601807270e+03 + 35840 1.068649323408186e+00 -5.883652568010217e+00 -6.046794360825059e+00 4.288837038791494e+00 4.352051618337827e+00 9.361225666425580e+03 + 35860 1.085515781845037e+00 -5.948161386695497e+00 -5.981122114368732e+00 3.983666145371292e+00 4.794400546415448e+00 9.159180432604824e+03 + 35880 1.076641550915873e+00 -5.973725792494097e+00 -6.023898121351328e+00 3.855675519536123e+00 4.567578243095102e+00 9.290538284774189e+03 + 35900 1.058622201056142e+00 -5.983074072387935e+00 -5.976668827153423e+00 3.849387889474577e+00 4.886167798819644e+00 9.145559844722255e+03 + 35920 1.022983513172441e+00 -5.958132066067666e+00 -5.991815176159588e+00 3.919413890039747e+00 4.726000259447490e+00 9.191916086124827e+03 + 35940 1.005274640612464e+00 -5.954906791318727e+00 -6.017201718273808e+00 3.909705998552495e+00 4.551998887867629e+00 9.269928392497904e+03 + 35960 1.054066062302821e+00 -6.045642796584606e+00 -5.985156374984065e+00 3.438763229858638e+00 4.786085622932436e+00 9.171542375468603e+03 + 35980 1.025043457471736e+00 -6.019027734401497e+00 -6.008253287712654e+00 3.582035328234987e+00 4.643903868462568e+00 9.242405742687421e+03 + 36000 9.469991034959310e-01 -5.919476574356585e+00 -5.994840960114011e+00 4.109638200478257e+00 4.676884234858114e+00 9.201205196885583e+03 + 36020 9.253167407978832e-01 -5.897127740463791e+00 -6.044904431813987e+00 4.210800876065088e+00 4.362244245963181e+00 9.355398986514649e+03 + 36040 1.063760249045922e+00 -6.112985928425925e+00 -6.033252900981109e+00 3.033368710961339e+00 4.491208093195588e+00 9.319423012581918e+03 + 36060 9.462034689100994e-01 -5.950633568170702e+00 -6.020296948253497e+00 3.972077062729199e+00 4.572059153920562e+00 9.279455403174292e+03 + 36080 9.470136707864261e-01 -5.960729780904304e+00 -6.008417590131972e+00 3.906111441349117e+00 4.632280661099214e+00 9.242901866790779e+03 + 36100 9.791260583853553e-01 -6.015853726150142e+00 -6.053505731758884e+00 3.553856463361247e+00 4.337652820526810e+00 9.382042713827763e+03 + 36120 9.673302969599232e-01 -6.004595483781102e+00 -6.005045495999203e+00 3.679774661846302e+00 4.677190622050805e+00 9.232567734226297e+03 + 36140 9.798724806494594e-01 -6.027173705128885e+00 -6.008658635761039e+00 3.525175365148272e+00 4.631491758656162e+00 9.243659648948407e+03 + 36160 1.018013803386338e+00 -6.085957670157833e+00 -5.964368616744677e+00 3.242169624350631e+00 4.940352784894181e+00 9.108003565868870e+03 + 36180 9.199532743914051e-01 -5.941041736975180e+00 -6.027980249835528e+00 4.017590179102506e+00 4.518375784567001e+00 9.303126167440130e+03 + 36200 9.601741506307546e-01 -5.999971097326202e+00 -6.013114359107571e+00 3.670973268399041e+00 4.595502625337230e+00 9.257347009671292e+03 + 36220 9.366900374853713e-01 -5.960777914286508e+00 -5.956055911707092e+00 3.923156631881503e+00 4.950271101420046e+00 9.082647227843940e+03 + 36240 1.003787143392903e+00 -6.047990050449518e+00 -5.955780252293055e+00 3.444134592919373e+00 4.973617523353933e+00 9.081781566208625e+03 + 36260 1.019450408086629e+00 -6.047102869140272e+00 -5.957123624399629e+00 3.473692768053099e+00 4.990367515596989e+00 9.085899026711197e+03 + 36280 1.008912911877061e+00 -5.998030311872552e+00 -6.012495203242449e+00 3.691160456932757e+00 4.608100812252103e+00 9.255455885139176e+03 + 36300 1.027317492513053e+00 -5.987944285557328e+00 -6.027334793690954e+00 3.737410053389686e+00 4.511223660024974e+00 9.301135690259656e+03 + 36320 1.007435322463438e+00 -5.920567447040622e+00 -5.998054819454167e+00 4.148212760228302e+00 4.703268276697606e+00 9.211077846836617e+03 + 36340 1.041384266950475e+00 -5.933937580132779e+00 -6.062005274957086e+00 3.976256692988390e+00 4.240872170895496e+00 9.408368925867284e+03 + 36360 1.038577717447188e+00 -5.900377486332193e+00 -6.035404257134982e+00 4.219379522291034e+00 4.444034909016168e+00 9.326034931082686e+03 + 36380 1.027635165303362e+00 -5.863634365622748e+00 -6.025862959351761e+00 4.425061521440407e+00 4.493519831454673e+00 9.296559049177473e+03 + 36400 1.092694564370800e+00 -5.949512073503636e+00 -5.988629103821109e+00 3.978156454726325e+00 4.753540413302515e+00 9.182165592466978e+03 + 36420 1.076160104373824e+00 -5.922264304392592e+00 -6.017229122564696e+00 4.124820218124340e+00 4.579517536422005e+00 9.269976409040264e+03 + 36440 1.109224902239323e+00 -5.977803382532806e+00 -5.968906491347829e+00 3.835554131584675e+00 4.886641457558278e+00 9.121845467464289e+03 + 36460 1.017153437084077e+00 -5.856978135324383e+00 -6.015118295904209e+00 4.496313372930866e+00 4.588248098770747e+00 9.263497188949465e+03 + 36480 1.001758401936793e+00 -5.855674026375824e+00 -6.000995120798770e+00 4.426884055702711e+00 4.592427843159474e+00 9.220073615351639e+03 + 36500 1.062386585701779e+00 -5.973878016078698e+00 -5.965820626897673e+00 3.827623130856564e+00 4.873889906410950e+00 9.112404176566622e+03 + 36520 1.004158099795873e+00 -5.919934010618213e+00 -5.947810770068170e+00 4.120657108114059e+00 4.960584441437828e+00 9.057532241153369e+03 + 36540 1.031107183840657e+00 -5.996011134608522e+00 -5.976987878942571e+00 3.712772736963243e+00 4.822007214836431e+00 9.146533926389164e+03 + 36560 1.013348783345776e+00 -6.003443618638320e+00 -6.008269299203942e+00 3.646842351355121e+00 4.619132546775666e+00 9.242449444531534e+03 + 36580 1.023637471100517e+00 -6.049752492855310e+00 -6.017964098217170e+00 3.372719740262267e+00 4.555253621512639e+00 9.272299222787258e+03 + 36600 9.911388511893691e-01 -6.026721421228704e+00 -6.019213250518026e+00 3.542759733688976e+00 4.585872811795351e+00 9.276143433966043e+03 + 36620 9.388314073339610e-01 -5.964629249758816e+00 -6.009197800407183e+00 3.846606497388812e+00 4.590686982604968e+00 9.245317115201131e+03 + 36640 9.892410239936932e-01 -6.048452671360239e+00 -5.978088012644291e+00 3.426332954812942e+00 4.830377714055658e+00 9.149891360476031e+03 + 36660 9.685249106772260e-01 -6.020622305766929e+00 -5.985561151803427e+00 3.570822303494526e+00 4.772148875248996e+00 9.172778389622936e+03 + 36680 1.010353768349187e+00 -6.082119423699378e+00 -5.995901731665164e+00 3.265907294524423e+00 4.760982624329603e+00 9.204467501645866e+03 + 36700 9.929369814400122e-01 -6.053529512494370e+00 -6.015814560122999e+00 3.412199257499764e+00 4.628764350386191e+00 9.265652222452618e+03 + 36720 9.815638666629800e-01 -6.033073085586524e+00 -5.995979540281198e+00 3.487108354908332e+00 4.700105232259105e+00 9.204717859078017e+03 + 36740 9.440800440443918e-01 -5.970034662317654e+00 -5.996908629958850e+00 3.843801465649517e+00 4.689486984720718e+00 9.207556366036944e+03 + 36760 1.042745697690803e+00 -6.108024253896744e+00 -5.996209713552274e+00 3.038001574495076e+00 4.680057968397220e+00 9.205418230219049e+03 + 36780 9.957633898124747e-01 -6.028998058252559e+00 -5.992890673738679e+00 3.526084561776713e+00 4.733418751255105e+00 9.195237345973659e+03 + 36800 9.746658153552706e-01 -5.987638721859334e+00 -5.989712741696943e+00 3.801897942680494e+00 4.789988599819409e+00 9.185489115233251e+03 + 36820 1.020120299852784e+00 -6.042216527209265e+00 -5.967292078758437e+00 3.477473330144547e+00 4.907701107670129e+00 9.116936180300239e+03 + 36840 9.325147699167877e-01 -5.895955002356556e+00 -6.025899799294955e+00 4.302367628931503e+00 4.556204496018880e+00 9.296745005431114e+03 + 36860 1.038314005295628e+00 -6.035804754490004e+00 -6.034652057513815e+00 3.529158945641210e+00 4.535777910057773e+00 9.323746122804187e+03 + 36880 1.046709100672617e+00 -6.033562566381995e+00 -6.016583234993028e+00 3.517812280719391e+00 4.615310229097883e+00 9.268026207642506e+03 + 36900 1.029483705925623e+00 -5.994841661598700e+00 -6.004166198928036e+00 3.765119734793994e+00 4.711576798481457e+00 9.229840221867520e+03 + 36920 1.000892761483184e+00 -5.940005277806385e+00 -5.968804680242806e+00 4.015184794198873e+00 4.849814168715826e+00 9.121518784504793e+03 + 36940 9.978779264057396e-01 -5.920723976133440e+00 -5.990405960415092e+00 4.117457285338670e+00 4.717332548341204e+00 9.187605175114420e+03 + 36960 1.060572874129609e+00 -5.991724750528645e+00 -6.004512551407682e+00 3.754044691118648e+00 4.680615159565429e+00 9.230889930264570e+03 + 36980 1.020614804855683e+00 -5.909714037345507e+00 -5.989635579259693e+00 4.188020469763947e+00 4.729098608274051e+00 9.185225639580369e+03 + 37000 1.063498552066033e+00 -5.949812579818318e+00 -6.003780318304017e+00 3.946841380755090e+00 4.636950274889672e+00 9.228659883519969e+03 + 37020 1.066957842906642e+00 -5.928888427101344e+00 -5.984594505591758e+00 4.074957033450456e+00 4.755084110270713e+00 9.169813782441157e+03 + 37040 1.072413198638437e+00 -5.913906183468791e+00 -6.034835963404108e+00 4.137727267792695e+00 4.443329757581143e+00 9.324275381387082e+03 + 37060 9.724346226052142e-01 -5.742198069001293e+00 -6.074394219149722e+00 5.103258153913807e+00 4.195736452573435e+00 9.446792078109931e+03 + 37080 1.069692260980878e+00 -5.867259247505161e+00 -6.007082431435539e+00 4.399701183628770e+00 4.596814823932756e+00 9.238776199108917e+03 + 37100 1.088252642282031e+00 -5.881452157887193e+00 -6.008527939965528e+00 4.315746147463888e+00 4.586057341856367e+00 9.243228808822323e+03 + 37120 1.109945303056370e+00 -5.907641727310518e+00 -6.016955793186842e+00 4.203696253828905e+00 4.575997971270027e+00 9.269151554284925e+03 + 37140 1.137054275681675e+00 -5.954926419337808e+00 -6.044960770961199e+00 3.915441099224659e+00 4.398449919432264e+00 9.355603369901233e+03 + 37160 1.051547686720398e+00 -5.856090338162340e+00 -6.036515131317701e+00 4.504348180325803e+00 4.468321097381212e+00 9.329458748437484e+03 + 37180 1.034558955250509e+00 -5.871421044793450e+00 -6.020612083259469e+00 4.372477598277098e+00 4.515799568166629e+00 9.280427580970521e+03 + 37200 1.010491664666692e+00 -5.887107946680630e+00 -6.004812984198955e+00 4.313859735941955e+00 4.637979195716045e+00 9.231825494993054e+03 + 37220 9.704658273916356e-01 -5.873088239934580e+00 -6.042552021198706e+00 4.354842161437255e+00 4.381754904983251e+00 9.348118965407544e+03 + 37240 1.022308218589861e+00 -5.989818228837242e+00 -6.039677574637363e+00 3.724716502878204e+00 4.438416423585085e+00 9.339264376117020e+03 + 37260 1.053098718035580e+00 -6.069983066944873e+00 -5.995557648618812e+00 3.319123051782488e+00 4.746485321106997e+00 9.203429766987498e+03 + 37280 9.969880832436468e-01 -6.013190561339985e+00 -5.993158573459707e+00 3.616457204207074e+00 4.731483978555735e+00 9.196068974145035e+03 + 37300 9.828007641409754e-01 -6.010822366556760e+00 -6.061077187094754e+00 3.609244404720950e+00 4.320673448283444e+00 9.405482295376447e+03 + 37320 9.453905084779560e-01 -5.971178266507276e+00 -5.997158524569248e+00 3.871593555571557e+00 4.722410893347771e+00 9.208314152556668e+03 + 37340 9.972783680007371e-01 -6.056792504139715e+00 -5.978784547132979e+00 3.371544728436682e+00 4.819478489261696e+00 9.152023755525401e+03 + 37360 9.320211442997482e-01 -5.964609064911281e+00 -5.989849712121273e+00 3.870072501404250e+00 4.725136799146947e+00 9.185925160801025e+03 + 37380 9.970617086268079e-01 -6.063343636534338e+00 -5.991928495204344e+00 3.345650940515512e+00 4.755727733489742e+00 9.192301035579359e+03 + 37400 9.389656802115530e-01 -5.976164547450313e+00 -5.989083637439140e+00 3.870902010164056e+00 4.796718596225501e+00 9.183533861697588e+03 + 37420 1.051182104198060e+00 -6.138117975735532e+00 -5.969607570783782e+00 2.928365249092907e+00 4.895978071226745e+00 9.123977338862898e+03 + 37440 9.683413596366724e-01 -6.007760098167750e+00 -5.996002273624891e+00 3.622886008857348e+00 4.690401256899914e+00 9.204780681441098e+03 + 37460 9.932046459306464e-01 -6.033908678448235e+00 -6.011443900623002e+00 3.499535627408357e+00 4.628531858093980e+00 9.252214093155080e+03 + 37480 9.743788780481250e-01 -5.992348999502587e+00 -6.003606080597162e+00 3.731284827479192e+00 4.666644925806471e+00 9.228098981979878e+03 + 37500 9.463576468022046e-01 -5.932624804534935e+00 -5.976282426980381e+00 4.057481090697625e+00 4.806792266620634e+00 9.144366629073755e+03 + 37520 1.029464676983669e+00 -6.028650531382762e+00 -5.990444888404923e+00 3.571123276093178e+00 4.790505990376070e+00 9.187728206864074e+03 + 37540 1.019760357308256e+00 -5.982669738697906e+00 -6.046715853824923e+00 3.782104191013707e+00 4.414341486850090e+00 9.361017748233226e+03 + 37560 9.637593874931131e-01 -5.869170189281388e+00 -6.025298666438972e+00 4.397104760086986e+00 4.500590883444386e+00 9.294877796674489e+03 + 37580 1.079064817941273e+00 -6.010232843577590e+00 -6.024930575601261e+00 3.597781270856152e+00 4.513384619109553e+00 9.293730582268236e+03 + 37600 1.058624021014357e+00 -5.950566300423072e+00 -6.019848240641515e+00 3.945144316683233e+00 4.547316694603335e+00 9.278094548923518e+03 + 37620 1.049634170596198e+00 -5.914782646044503e+00 -5.986371725007887e+00 4.147406181875004e+00 4.736330612093089e+00 9.175242645655968e+03 + 37640 1.010041906114624e+00 -5.837917573922287e+00 -5.986902468445683e+00 4.575189775363658e+00 4.719695455672406e+00 9.176864296274398e+03 + 37660 1.086785996966676e+00 -5.936666132118446e+00 -6.000872376273508e+00 3.991411897583340e+00 4.622729707760802e+00 9.219703776299279e+03 + 37680 1.072880583592900e+00 -5.904384067424568e+00 -6.008579240036518e+00 4.199561375287123e+00 4.601256569998461e+00 9.243390965748691e+03 + 37700 1.065278444171610e+00 -5.888976332814567e+00 -6.037370294411526e+00 4.253316097391321e+00 4.401215006010246e+00 9.332127133109751e+03 + 37720 1.125131948018061e+00 -5.984476557450947e+00 -5.988939340973119e+00 3.800909835287828e+00 4.775283841689997e+00 9.183150180013432e+03 + 37740 1.038777133608582e+00 -5.879738653523186e+00 -6.052636750324194e+00 4.345037766064917e+00 4.352230138339519e+00 9.379342047683953e+03 + 37760 1.042733524542589e+00 -5.932769680208250e+00 -6.009941109309611e+00 4.016101779184198e+00 4.572971491044128e+00 9.247599875630176e+03 + 37780 9.540272522313293e-01 -5.865695268633773e+00 -6.101312000327191e+00 4.333202806523365e+00 3.980255071568371e+00 9.530646559765943e+03 + 37800 9.993011443796153e-01 -5.994271600356052e+00 -5.996065192090004e+00 3.736500197303624e+00 4.726201116009853e+00 9.204982624290033e+03 + 37820 9.635613495809030e-01 -5.984341516538412e+00 -6.034062855002272e+00 3.802384452614481e+00 4.516876832802735e+00 9.321894724833615e+03 + 37840 1.029337179552017e+00 -6.112869493110333e+00 -5.981459966974206e+00 3.081791557068172e+00 4.836365391700262e+00 9.160218293005433e+03 + 37860 9.585264584072239e-01 -6.028974728047388e+00 -5.956404927849636e+00 3.607913094407523e+00 5.024620117283300e+00 9.083692220656785e+03 + 37880 9.806848068836048e-01 -6.073385225165461e+00 -5.973832082975778e+00 3.312656132813135e+00 4.884305681065261e+00 9.136901817291855e+03 + 37900 9.748138239425553e-01 -6.070853019649356e+00 -5.990679649763575e+00 3.332629997623691e+00 4.792997894296732e+00 9.188463886963862e+03 + 37920 9.354842708286520e-01 -6.013626471806401e+00 -5.994563847219695e+00 3.659879478510688e+00 4.769340018819179e+00 9.200372424410267e+03 + 37940 9.841659141307527e-01 -6.082980297693998e+00 -5.984187268482114e+00 3.245636898626369e+00 4.812921760532866e+00 9.168578151312488e+03 + 37960 9.944604555413064e-01 -6.091281145598497e+00 -5.952564155378687e+00 3.199553737187124e+00 4.996088161414130e+00 9.072014468664474e+03 + 37980 9.795196924185924e-01 -6.057776286314744e+00 -5.971372579378203e+00 3.365406487466867e+00 4.861549943626921e+00 9.129374465926923e+03 + 38000 9.640605116855607e-01 -6.017319287734059e+00 -5.987959543007893e+00 3.570219292637590e+00 4.738807490261050e+00 9.180115701533929e+03 + 38020 1.021835277302069e+00 -6.078693022146584e+00 -5.949697447934095e+00 3.337001647125192e+00 5.077714196253898e+00 9.063274997581557e+03 + 38040 1.006719919383688e+00 -6.028958058208554e+00 -6.019901507967170e+00 3.463734093904660e+00 4.515738206887308e+00 9.278247071175309e+03 + 38060 1.032967704459175e+00 -6.041158991488864e+00 -6.000277954244529e+00 3.406253812837620e+00 4.640999055014658e+00 9.217897283462033e+03 + 38080 1.035288996199639e+00 -6.015776891858948e+00 -6.020922479038632e+00 3.562921244374011e+00 4.533374486511224e+00 9.281406890803950e+03 + 38100 1.056773709946216e+00 -6.025298100808695e+00 -5.979827321864734e+00 3.499243072123046e+00 4.760343321399565e+00 9.155239201545475e+03 + 38120 1.012747089278223e+00 -5.939629921724203e+00 -5.988215603113519e+00 3.991194929358072e+00 4.712208428210725e+00 9.180887063372575e+03 + 38140 9.766899188346450e-01 -5.866645924608112e+00 -6.047683006396601e+00 4.433770308415204e+00 4.394227369387838e+00 9.363990947070948e+03 + 38160 1.035749318856684e+00 -5.940657631699608e+00 -6.047459797644496e+00 3.951717201888584e+00 4.338442637451270e+00 9.363307081800023e+03 + 38180 1.056478292811039e+00 -5.962026565804096e+00 -6.058292884436681e+00 3.874454668919274e+00 4.321678570166306e+00 9.396854727274474e+03 + 38200 1.065328443088989e+00 -5.973440850762021e+00 -6.037432385787684e+00 3.869678440756886e+00 4.502229143981487e+00 9.332327674353362e+03 + 38220 1.095959747578653e+00 -6.027619485815262e+00 -5.974159855170043e+00 3.551839210803622e+00 4.858812682819578e+00 9.137891632020428e+03 + 38240 1.041418799791749e+00 -5.958751931039609e+00 -6.008562606687699e+00 3.882428806307043e+00 4.596408198558567e+00 9.243342336606911e+03 + 38260 9.903460184909346e-01 -5.905075470209611e+00 -6.001906377909831e+00 4.277189744159413e+00 4.721171687610207e+00 9.222865478411999e+03 + 38280 1.049229554007123e+00 -6.025809228222528e+00 -5.991580259089500e+00 3.557219184443029e+00 4.753767222120731e+00 9.191208427737691e+03 + 38300 1.042249188940319e+00 -6.061853478364874e+00 -5.983349518636856e+00 3.375331227340291e+00 4.826113112547078e+00 9.166013951438947e+03 + 38320 9.804692472573904e-01 -6.027373814995372e+00 -6.027852745251966e+00 3.549248913049061e+00 4.546498821401480e+00 9.302765189436655e+03 + 38340 1.020526455475971e+00 -6.142404304572307e+00 -5.966191154982407e+00 2.961979400981443e+00 4.973822574823421e+00 9.113556917435084e+03 + 38360 8.757501530683552e-01 -5.964791220746406e+00 -6.007851908018575e+00 3.921917133021162e+00 4.674656003084547e+00 9.241147267809685e+03 + 38380 1.014386960926706e+00 -6.189994765403801e+00 -5.958512986661701e+00 2.700392092752113e+00 5.029596287978739e+00 9.090130698572895e+03 + 38400 9.741505427094335e-01 -6.139454618133501e+00 -5.995174313531401e+00 2.952384682564291e+00 4.780864518894523e+00 9.202258134155436e+03 + 38420 9.178383663327556e-01 -6.056173297264013e+00 -6.038563935204233e+00 3.370037802389283e+00 4.471153484376508e+00 9.335815873330142e+03 + 38440 9.660798290647075e-01 -6.122746459621165e+00 -5.952624466992464e+00 3.069609241525943e+00 5.046476049493227e+00 9.072213224591220e+03 + 38460 8.941276397175144e-01 -6.004916744229828e+00 -6.038695057446024e+00 3.650026861084997e+00 4.456066559420523e+00 9.336202411511011e+03 + 38480 9.590511972019018e-01 -6.086299134023183e+00 -5.956288567146298e+00 3.233591437276432e+00 4.980132231353709e+00 9.083356525985839e+03 + 38500 9.808137398562464e-01 -6.096300315424232e+00 -6.001436369703134e+00 3.142011176035825e+00 4.686734632514524e+00 9.221481043490152e+03 + 38520 9.470475414890694e-01 -6.022003688315913e+00 -6.008821652154815e+00 3.546714609775174e+00 4.622407901325703e+00 9.244163146861787e+03 + 38540 8.979910490866605e-01 -5.922716639429476e+00 -6.011549965258234e+00 4.124077522866069e+00 4.613982819044597e+00 9.252553429806527e+03 + 38560 9.822519683329478e-01 -6.018221852623853e+00 -6.000393375755474e+00 3.591195714037190e+00 4.693569587163304e+00 9.218248843953228e+03 + 38580 1.020195564083564e+00 -6.048023162650294e+00 -5.982181545445737e+00 3.473581614695710e+00 4.851654369641611e+00 9.162434121071794e+03 + 38600 1.016672190889011e+00 -6.018825818600789e+00 -6.004562180396553e+00 3.560122758417391e+00 4.642026776276994e+00 9.231055685264831e+03 + 38620 9.788637207884947e-01 -5.944082329069713e+00 -5.978546396084853e+00 4.004506388353497e+00 4.806608382255429e+00 9.151272916656440e+03 + 38640 1.022760636824238e+00 -5.991772071073707e+00 -5.999616008160028e+00 3.724188918535313e+00 4.679147817940319e+00 9.215854555616381e+03 + 38660 1.051987784629127e+00 -6.019803839777429e+00 -5.983713429011041e+00 3.554056646826878e+00 4.761293370420498e+00 9.167132894182520e+03 + 38680 9.937590407807773e-01 -5.923200270323641e+00 -6.022900520730115e+00 4.089548593364839e+00 4.517054326966980e+00 9.287485596498309e+03 + 38700 1.105400362223100e+00 -6.081776224412954e+00 -5.949163000213135e+00 3.271911365921864e+00 5.033397021107344e+00 9.061653544182695e+03 + 38720 1.000681729998259e+00 -5.925361087549207e+00 -5.931049430065848e+00 4.098136808460798e+00 5.065473465462088e+00 9.006570703996667e+03 + 38740 1.038303294408498e+00 -5.979743501602742e+00 -5.955649214892404e+00 3.786347936365337e+00 4.924701059234921e+00 9.081380401207272e+03 + 38760 1.025683746007467e+00 -5.960471464374852e+00 -5.979271002583659e+00 3.912005778051594e+00 4.804055920437485e+00 9.153515123909532e+03 + 38780 1.065620323959801e+00 -6.019787144573454e+00 -5.979811917951924e+00 3.603433338758796e+00 4.832977276165947e+00 9.155178913945963e+03 + 38800 1.021998117205142e+00 -5.959712051057958e+00 -5.983490804113859e+00 3.937850150815656e+00 4.801308871018533e+00 9.166429036710661e+03 + 38820 9.848206722736876e-01 -5.914002061146652e+00 -5.968436924350276e+00 4.195079521344034e+00 4.882506113060970e+00 9.120350824833182e+03 + 38840 1.053222969995634e+00 -6.026875800413981e+00 -5.947864776244163e+00 3.592229304457855e+00 5.045922832157421e+00 9.057660653946694e+03 + 38860 9.760454320992497e-01 -5.926862998175616e+00 -5.963997752893302e+00 4.092972224379775e+00 4.879738716206099e+00 9.106841184894385e+03 + 38880 9.970214046606397e-01 -5.980820352998998e+00 -5.948177980541577e+00 3.829248764767611e+00 5.016686318808933e+00 9.058632343142499e+03 + 38900 1.028101329165235e+00 -6.060730868488148e+00 -5.987621425174390e+00 3.349821254424039e+00 4.769626991581431e+00 9.179057525121996e+03 + 38920 9.933189028402222e-01 -6.057663128644664e+00 -5.989232698623153e+00 3.409773734754015e+00 4.802711853512347e+00 9.183993118901477e+03 + 38940 9.588096271084245e-01 -6.058153157581030e+00 -5.960387461251721e+00 3.434713556687515e+00 4.996099314203017e+00 9.095795402896994e+03 + 38960 9.622207800536898e-01 -6.104379207360369e+00 -5.984971986641799e+00 3.097000135368199e+00 4.782654874941910e+00 9.170988203856945e+03 + 38980 9.107191156295875e-01 -6.057175180380285e+00 -6.041293174271008e+00 3.348150916853961e+00 4.439347853665933e+00 9.344268588865301e+03 + 39000 8.843498953653842e-01 -6.036678282372120e+00 -5.994931391873539e+00 3.566137426151975e+00 4.805854531705252e+00 9.201501000642047e+03 + 39020 8.807084329389108e-01 -6.038133376976080e+00 -6.011490990234666e+00 3.491662997138375e+00 4.644647704703596e+00 9.252378846374811e+03 + 39040 9.429141731722245e-01 -6.128645760158147e+00 -6.009835809617963e+00 3.042021793251330e+00 4.724246915033495e+00 9.247287781177822e+03 + 39060 9.232649508707361e-01 -6.091109221204396e+00 -6.032520672218390e+00 3.153835101751679e+00 4.490259616577981e+00 9.317186508548393e+03 + 39080 8.995270084694442e-01 -6.040110882598132e+00 -6.033066697235525e+00 3.499235614277644e+00 4.539684416713894e+00 9.318853334935697e+03 + 39100 9.812587614675191e-01 -6.139782340106682e+00 -6.004653662853449e+00 2.982407114870380e+00 4.758336890753670e+00 9.231368400493760e+03 + 39120 9.185528354805470e-01 -6.019609794505775e+00 -6.014442173115354e+00 3.553545038453187e+00 4.583218320163809e+00 9.261453921138580e+03 + 39140 9.226865778789355e-01 -5.997198600032333e+00 -5.977898979175070e+00 3.701008755732990e+00 4.811830165302070e+00 9.149294475404151e+03 + 39160 9.729352097797668e-01 -6.038208995748999e+00 -5.933578719326255e+00 3.495738552406443e+00 5.096541791108784e+00 9.014279714936392e+03 + 39180 9.311913000134393e-01 -5.943567662140037e+00 -5.987478128353436e+00 3.978626492315045e+00 4.726485800195024e+00 9.178637369580980e+03 + 39200 9.907148236196481e-01 -6.003979989140380e+00 -5.972048431453313e+00 3.648399205885624e+00 4.831755151517351e+00 9.131435198473504e+03 + 39220 1.073350226062492e+00 -6.105369332779104e+00 -5.979074192729880e+00 3.142022819266813e+00 4.867229057539218e+00 9.152931381644012e+03 + 39240 9.944313908150976e-01 -5.972853290450649e+00 -6.041230226496742e+00 3.866258635603583e+00 4.473627687530260e+00 9.344047679163938e+03 + 39260 9.904329105390487e-01 -5.958348392062888e+00 -6.014779984067884e+00 3.957087725630083e+00 4.633048791576758e+00 9.262472514776478e+03 + 39280 9.726268936386264e-01 -5.925647256107871e+00 -6.026544821419950e+00 4.097924999569475e+00 4.518555565699747e+00 9.298708776961350e+03 + 39300 1.002499795071449e+00 -5.966035471560161e+00 -5.992942716339940e+00 3.877471068799497e+00 4.722965505391333e+00 9.195380138970957e+03 + 39320 1.036573720028364e+00 -6.013409302754511e+00 -5.991192969125257e+00 3.609637605461713e+00 4.737207231127410e+00 9.190022879512873e+03 + 39340 9.807419403461997e-01 -5.929754619874904e+00 -6.027393407495659e+00 4.056071853024513e+00 4.495414824952589e+00 9.301317341157703e+03 + 39360 1.023802874458156e+00 -5.995326723078620e+00 -5.988054673493313e+00 3.727169091497216e+00 4.768926325562087e+00 9.180400163338274e+03 + 39380 1.005939640869309e+00 -5.971650634765179e+00 -5.999707214061928e+00 3.861518388047257e+00 4.700413167983712e+00 9.216125383113687e+03 + 39400 9.880525123649185e-01 -5.947962445017727e+00 -6.007943691607447e+00 3.998674439950886e+00 4.654252839964803e+00 9.241431844414092e+03 + 39420 9.907597136753317e-01 -5.956011757610961e+00 -6.033376766251378e+00 3.966265081136532e+00 4.522023229326868e+00 9.319794342463985e+03 + 39440 1.050728315363402e+00 -6.051606731809495e+00 -6.044608136206699e+00 3.416334126721120e+00 4.456521145701544e+00 9.354503072434662e+03 + 39460 1.039847052814568e+00 -6.049125316879459e+00 -6.002058989262358e+00 3.473020773257415e+00 4.743282909925465e+00 9.223390224339159e+03 + 39480 9.758483665069315e-01 -5.972655203185886e+00 -5.986327905328805e+00 3.819961252265296e+00 4.741450480716836e+00 9.175139237556987e+03 + 39500 1.006148368924944e+00 -6.040779400875048e+00 -5.976563242474391e+00 3.511534874945101e+00 4.880273993900071e+00 9.145244485126963e+03 + 39520 9.924570273829869e-01 -6.047919963501973e+00 -5.979960249184792e+00 3.433707854942617e+00 4.823943051283670e+00 9.155620363190474e+03 + 39540 1.017920593940073e+00 -6.116824903692079e+00 -5.942298194355336e+00 3.061031270040167e+00 5.063190642972726e+00 9.040780496116664e+03 + 39560 1.070193654308486e+00 -6.228473099808900e+00 -5.933014514648035e+00 2.515797774728675e+00 5.212366692790646e+00 9.012563585149952e+03 + 39580 9.617222114592462e-01 -6.100606765945614e+00 -5.990311362315667e+00 3.159369866545819e+00 4.792703142347525e+00 9.187327682143981e+03 + 39600 9.163249070380618e-01 -6.062236799919788e+00 -5.981423709077161e+00 3.399492256158327e+00 4.863533529562082e+00 9.160121617322242e+03 + 39620 8.942759924080836e-01 -6.051631448091086e+00 -6.000378450325121e+00 3.366736342289075e+00 4.661038986837019e+00 9.218221912736899e+03 + 39640 9.376053002925989e-01 -6.128918751111820e+00 -5.971695238641911e+00 2.987744492314121e+00 4.890546231176264e+00 9.130374488815794e+03 + 39660 9.348550128163947e-01 -6.129262867731251e+00 -5.943870876034629e+00 3.002734815441156e+00 5.067284321081155e+00 9.045566415151554e+03 + 39680 9.208545632214954e-01 -6.103695827894734e+00 -5.981330555284785e+00 3.144796991399735e+00 4.847437322690800e+00 9.159832003279722e+03 + 39700 9.109708295295589e-01 -6.074507851760340e+00 -5.984811615790004e+00 3.331808293326611e+00 4.846857960715940e+00 9.170471593457387e+03 + 39720 9.399971975630078e-01 -6.090838449451317e+00 -5.985948473354661e+00 3.234504875932525e+00 4.836799350350867e+00 9.173947166776168e+03 + 39740 8.667824729432793e-01 -5.938741049923375e+00 -5.993301069544156e+00 4.059358619593164e+00 4.746066543794891e+00 9.196502541863843e+03 + 39760 9.450618192780360e-01 -5.999623301824166e+00 -6.013575913030403e+00 3.695476470611384e+00 4.615358417905570e+00 9.258790163075570e+03 + 39780 9.701117232041475e-01 -5.984872733836295e+00 -6.012802084586447e+00 3.799756322529606e+00 4.639381668469170e+00 9.256393345509832e+03 + 39800 1.027996640768625e+00 -6.036748202117971e+00 -6.009056265658097e+00 3.482721012168093e+00 4.641732396634005e+00 9.244853437597214e+03 + 39820 9.805686985113743e-01 -5.946467549851589e+00 -6.026038573397098e+00 3.935850633433817e+00 4.478941502659407e+00 9.297165642116028e+03 + 39840 9.965247686932118e-01 -5.957649846374284e+00 -6.031783929496092e+00 3.994718936564067e+00 4.569029559066356e+00 9.314882514982413e+03 + 39860 1.098889613947990e+00 -6.102851323129457e+00 -5.963769867553003e+00 3.133574109342793e+00 4.932201350048484e+00 9.106181351213840e+03 + 39880 9.529349863291990e-01 -5.882496782098813e+00 -6.000865472388631e+00 4.332897595346281e+00 4.653206258206519e+00 9.219692826622490e+03 + 39900 1.014536953384891e+00 -5.970822125283486e+00 -6.011474558318290e+00 3.846900344196487e+00 4.613467782766962e+00 9.252283383154687e+03 + 39920 1.044740501614759e+00 -6.015599992022821e+00 -5.998887836913561e+00 3.581176242849479e+00 4.677140023684499e+00 9.213636216578274e+03 + 39940 1.016780437384348e+00 -5.976464028332214e+00 -5.991437291837746e+00 3.855661462186397e+00 4.769682666032590e+00 9.190776519743937e+03 + 39960 9.574596819710188e-01 -5.890831697210911e+00 -6.051404174262117e+00 4.245960947749993e+00 4.323928936011455e+00 9.375533642191791e+03 + 39980 1.045790408112205e+00 -6.028360175607633e+00 -6.003468576046304e+00 3.551263383793567e+00 4.694194800437302e+00 9.227698632133599e+03 + 40000 9.741345840101885e-01 -5.929992831724750e+00 -6.049799712130667e+00 4.086552795374923e+00 4.398603148029323e+00 9.370550399657091e+03 + 40020 1.040210623896662e+00 -6.039899795855032e+00 -6.018157346159612e+00 3.459097311442175e+00 4.583945822226495e+00 9.272887069653760e+03 + 40040 1.020698200321952e+00 -6.027483894143026e+00 -6.010318605753610e+00 3.531640523771552e+00 4.630206266023372e+00 9.248754061491536e+03 + 40060 9.492470417453232e-01 -5.940453352305340e+00 -5.986882022133473e+00 4.043960873340011e+00 4.777360266373438e+00 9.176750566893264e+03 + 40080 9.785054728284677e-01 -6.001710284796872e+00 -5.963069854243915e+00 3.688991572569921e+00 4.910870904392302e+00 9.104010755658346e+03 + 40100 1.002958422460763e+00 -6.053477042883676e+00 -6.002553232742580e+00 3.377352219779730e+00 4.669764618044061e+00 9.224869170448288e+03 + 40120 9.919787329060643e-01 -6.053080618855446e+00 -6.004503990098579e+00 3.414146918403534e+00 4.693081437934465e+00 9.230894993402258e+03 + 40140 9.116349767803236e-01 -5.951301951433242e+00 -6.026256839113415e+00 3.958120818265929e+00 4.527718253974994e+00 9.297843632149767e+03 + 40160 1.041667690856513e+00 -6.161613604685736e+00 -5.984660692843851e+00 2.811159140626263e+00 4.827250143796979e+00 9.170036754841271e+03 + 40180 9.279449269122680e-01 -6.009872995489977e+00 -5.971121649257267e+00 3.626295052350694e+00 4.848811279170363e+00 9.128622385284772e+03 + 40200 9.027587897634652e-01 -5.986145524972250e+00 -5.977529942617300e+00 3.761031308649730e+00 4.810503315788916e+00 9.148181011384509e+03 + 40220 9.530370159009197e-01 -6.070032142865107e+00 -5.957533864408089e+00 3.314291787812413e+00 4.960274311764938e+00 9.087138817820060e+03 + 40240 9.229133898976317e-01 -6.029878463996480e+00 -5.978700066947503e+00 3.540904936885112e+00 4.834779212571685e+00 9.151763591985769e+03 + 40260 9.290888404222283e-01 -6.037343343263341e+00 -5.956585391000640e+00 3.517195977903119e+00 4.980920637048269e+00 9.084201159144770e+03 + 40280 9.030571820890358e-01 -5.986542495218476e+00 -5.975850353974850e+00 3.742600719745334e+00 4.803996649369749e+00 9.143046678735356e+03 + 40300 1.035596913650094e+00 -6.158250188609495e+00 -5.983623300194167e+00 2.879345310608075e+00 4.882079927312534e+00 9.166846650436422e+03 + 40320 9.166878462214648e-01 -5.946732971150927e+00 -6.040106841815330e+00 3.939066026017316e+00 4.402898811102529e+00 9.340584651796549e+03 + 40340 9.749463824094581e-01 -5.993254330888436e+00 -5.994370851750487e+00 3.747817807406775e+00 4.741406571835835e+00 9.199758576879532e+03 + 40360 9.590584323957710e-01 -5.923992492968304e+00 -6.040065278941563e+00 4.095706403595697e+00 4.429198504331663e+00 9.340438824704721e+03 + 40380 1.028826260755825e+00 -5.986037670006086e+00 -6.025009508595312e+00 3.734797633628695e+00 4.511015305576825e+00 9.293987272241686e+03 + 40400 1.047129429055782e+00 -5.981887222034230e+00 -6.001805844998716e+00 3.864269665144129e+00 4.749893849685111e+00 9.222595492114366e+03 + 40420 1.024936145618428e+00 -5.927712138512521e+00 -6.022413023007136e+00 4.066213960721994e+00 4.522426827039402e+00 9.285985331539670e+03 + 40440 1.040011380881880e+00 -5.937603852945039e+00 -6.058329407771868e+00 4.003730971584696e+00 4.310506153549814e+00 9.396973440386744e+03 + 40460 1.063358061236139e+00 -5.967117911197093e+00 -6.031000258993130e+00 3.874312217890252e+00 4.507489891084035e+00 9.312455323571798e+03 + 40480 1.005765398461269e+00 -5.884196933472519e+00 -6.059689507741084e+00 4.310738974788758e+00 4.303033455950563e+00 9.401185726117097e+03 + 40500 1.077880801348800e+00 -5.999501815647682e+00 -6.044316232218611e+00 3.675912872368227e+00 4.418581557409405e+00 9.353588476160527e+03 + 40520 1.048005738274845e+00 -5.969477682873915e+00 -6.028412384338621e+00 3.881600074645810e+00 4.543187898719896e+00 9.304470720391892e+03 + 40540 1.040046948802218e+00 -5.976548961225775e+00 -6.043524966740740e+00 3.819992556577348e+00 4.435405968407060e+00 9.351132284585299e+03 + 40560 1.032907837436813e+00 -5.991693547359715e+00 -6.008923162108377e+00 3.763638524589354e+00 4.664703410428275e+00 9.244457811689439e+03 + 40580 9.551630611865963e-01 -5.905708251472383e+00 -5.977781200499306e+00 4.251307522045988e+00 4.837453495480580e+00 9.148901838229554e+03 + 40600 9.740242032054918e-01 -5.959106898919769e+00 -5.934513775275332e+00 3.926460861241041e+00 5.067678382980982e+00 9.017063655875021e+03 + 40620 1.034795425159255e+00 -6.067920091621085e+00 -5.949576613294319e+00 3.338043775433361e+00 5.017590341579737e+00 9.062869854771598e+03 + 40640 9.452952832570776e-01 -5.949922055275802e+00 -6.002132531060594e+00 3.973007306802757e+00 4.673206675301466e+00 9.223592368966581e+03 + 40660 9.807646660918888e-01 -6.015319291928376e+00 -5.998109403782946e+00 3.684662071179500e+00 4.783483912132144e+00 9.211230306708607e+03 + 40680 1.020995491726221e+00 -6.086808339611107e+00 -5.941977777821353e+00 3.258864407722225e+00 5.090503905975998e+00 9.039787644926577e+03 + 40700 9.974603408610261e-01 -6.060087627243324e+00 -5.987096006972180e+00 3.352064271882093e+00 4.771193450895733e+00 9.177485960536271e+03 + 40720 9.803795970916349e-01 -6.040944804077452e+00 -5.971389572887560e+00 3.529653894648914e+00 4.929050795778517e+00 9.129418935201054e+03 + 40740 9.118432513813673e-01 -5.941477614153066e+00 -5.980471805111281e+00 3.976294523507797e+00 4.752383844694175e+00 9.157189119726150e+03 + 40760 9.684165603282514e-01 -6.022229123631138e+00 -6.014594327166607e+00 3.537034676219550e+00 4.580874858999822e+00 9.261887647158619e+03 + 40780 9.529141168747349e-01 -5.991649339457775e+00 -6.006614465990598e+00 3.715952256075977e+00 4.630020183678655e+00 9.237367282276446e+03 + 40800 1.013475736724652e+00 -6.069130075709661e+00 -5.963848101039874e+00 3.348157275324611e+00 4.952702666211454e+00 9.106400197517987e+03 + 40820 1.014815605814441e+00 -6.048153060003267e+00 -5.963593174742585e+00 3.434145826276228e+00 4.919701773043020e+00 9.105633707519333e+03 + 40840 9.987394924144332e-01 -5.981814465767969e+00 -5.972370847466655e+00 3.848305452492535e+00 4.902532170173892e+00 9.132412851664709e+03 + 40860 1.033418355161952e+00 -5.966437551467926e+00 -5.991426250749475e+00 3.904516332416921e+00 4.761027354153550e+00 9.190746669302864e+03 + 40880 1.095512368017054e+00 -5.986027509444446e+00 -6.000158936324187e+00 3.742917316303431e+00 4.661772476328718e+00 9.217530116219299e+03 + 40900 1.047969710199426e+00 -5.863556659442547e+00 -6.015840849112379e+00 4.372057594999420e+00 4.497618212013051e+00 9.265710341470240e+03 + 40920 1.115989019117634e+00 -5.934205180036801e+00 -5.994773170810985e+00 4.078884880438856e+00 4.731094104547207e+00 9.201013623195273e+03 + 40940 1.067937835088060e+00 -5.849325196957891e+00 -6.077504209650836e+00 4.487604909055843e+00 4.177365707584858e+00 9.456503970823165e+03 + 40960 1.111302668504833e+00 -5.918498085989634e+00 -6.027721406519253e+00 4.128736504706641e+00 4.501559295971342e+00 9.302325401517686e+03 + 40980 1.004516417483344e+00 -5.773757546618644e+00 -6.033477491413037e+00 4.892918739867220e+00 4.401566625326254e+00 9.320096103543334e+03 + 41000 1.100312739072060e+00 -5.939163186913871e+00 -6.005619031686248e+00 4.065915162142243e+00 4.684315417450513e+00 9.234284639851356e+03 + 41020 1.117781793298070e+00 -5.993022707493547e+00 -6.040572895349359e+00 3.704148939129564e+00 4.431108402093703e+00 9.342030204500930e+03 + 41040 1.043227019909882e+00 -5.922639316386790e+00 -6.012588414784370e+00 4.119456131491478e+00 4.602954488914587e+00 9.255730939667679e+03 + 41060 9.649837032490974e-01 -5.845927083350358e+00 -6.008978190439571e+00 4.570384795957023e+00 4.634120106973490e+00 9.244602924219469e+03 + 41080 9.943917247604555e-01 -5.921690315801159e+00 -5.982755623067029e+00 4.125993871630752e+00 4.775347427484367e+00 9.164182880408296e+03 + 41100 1.087044340047338e+00 -6.086910597388145e+00 -6.028765419625411e+00 3.232790166958651e+00 4.566668775609447e+00 9.305550131344269e+03 + 41120 1.044395312067427e+00 -6.053691666966476e+00 -6.018742012903464e+00 3.382634075055759e+00 4.583320397127064e+00 9.274681219268139e+03 + 41140 1.018081845567299e+00 -6.040563563718770e+00 -5.991918129006105e+00 3.468534372494817e+00 4.747863986471634e+00 9.192248244558763e+03 + 41160 1.048266220355502e+00 -6.105585600521126e+00 -5.974446557198501e+00 3.157505808925461e+00 4.910526489385337e+00 9.138758064643944e+03 + 41180 9.552162332859526e-01 -5.983167812335538e+00 -5.957370601731499e+00 3.845474119907895e+00 4.993605695301726e+00 9.086651671355257e+03 + 41200 9.858948826664378e-01 -6.038456129043190e+00 -6.019115562937681e+00 3.470036018064547e+00 4.581092541585312e+00 9.275826716647505e+03 + 41220 9.751075664419505e-01 -6.031147448972682e+00 -6.046307952822344e+00 3.507362355847183e+00 4.420308396662035e+00 9.359759121565199e+03 + 41240 9.889913671098797e-01 -6.059266512793748e+00 -6.005587318866687e+00 3.356534808027669e+00 4.664769046385268e+00 9.234215192889671e+03 + 41260 9.495010426217806e-01 -6.004977962553616e+00 -6.004030371672636e+00 3.691131073788025e+00 4.696572287265827e+00 9.229421019883268e+03 + 41280 9.754017267026011e-01 -6.045121044590489e+00 -5.961617752682861e+00 3.473153726050506e+00 4.952642550276768e+00 9.099596412348541e+03 + 41300 9.657990250682423e-01 -6.026734062506521e+00 -6.015011430981524e+00 3.520299162466405e+00 4.587612326754305e+00 9.263202156452155e+03 + 41320 1.000056693942888e+00 -6.068124615696912e+00 -6.039374839904057e+00 3.265267140333068e+00 4.430352801949066e+00 9.338316051132173e+03 + 41340 1.026257524849330e+00 -6.096906946763355e+00 -5.975488058171505e+00 3.207823741730236e+00 4.905029789536917e+00 9.141969834784184e+03 + 41360 9.117056277924337e-01 -5.912576534673981e+00 -6.038490653175799e+00 4.163131448524815e+00 4.440113094940513e+00 9.335580537785239e+03 + 41380 1.039570834681165e+00 -6.081010148434698e+00 -5.960364298502459e+00 3.282616321799394e+00 4.975383461995248e+00 9.095782332941602e+03 + 41400 9.792152923796641e-01 -5.959507088669673e+00 -6.015749753028506e+00 3.906248120259810e+00 4.583294037987212e+00 9.265467177160410e+03 + 41420 1.045010525252104e+00 -6.016617454313644e+00 -6.022944478757136e+00 3.628757794896290e+00 4.592427041437890e+00 9.287627206059820e+03 + 41440 1.035319284230467e+00 -5.955816144156109e+00 -6.032974552075830e+00 3.979280038302685e+00 4.536224519802612e+00 9.318524916192082e+03 + 41460 1.002739846870994e+00 -5.867574539141209e+00 -6.024424348198652e+00 4.403094744600180e+00 4.502438868562839e+00 9.292165632195458e+03 + 41480 1.133146311288539e+00 -6.026713620240102e+00 -5.976233488571170e+00 3.583359695974593e+00 4.873224423792731e+00 9.144239542878808e+03 + 41500 1.055425410844994e+00 -5.890145150540625e+00 -6.036974398315731e+00 4.209066061980115e+00 4.365949799502796e+00 9.330878203444596e+03 + 41520 1.071914579040943e+00 -5.901729718952044e+00 -6.016785071296869e+00 4.230198750275984e+00 4.569533112353764e+00 9.268625556088251e+03 + 41540 1.101718045194419e+00 -5.942890612070487e+00 -6.017301622711790e+00 3.977597224690931e+00 4.550317686521887e+00 9.270236831334156e+03 + 41560 1.091812792028701e+00 -5.936039728476040e+00 -6.013671061047997e+00 4.058506690477264e+00 4.612735565439201e+00 9.259040334234722e+03 + 41580 1.013804350401596e+00 -5.835687469809648e+00 -6.068037703713831e+00 4.528396365493213e+00 4.194205366332908e+00 9.427061775130951e+03 + 41600 1.088930951190524e+00 -5.969606064307997e+00 -6.012966105300068e+00 3.866557727423964e+00 4.617577662102833e+00 9.256853153973401e+03 + 41620 1.055907596983285e+00 -5.945779918505039e+00 -6.058243571510969e+00 3.990395252508227e+00 4.344611553254120e+00 9.396709790017991e+03 + 41640 1.130585202435977e+00 -6.087296370255676e+00 -5.970065935047715e+00 3.253076070227216e+00 4.926231370542549e+00 9.125397126853812e+03 + 41660 9.662076617677472e-01 -5.870587949999952e+00 -6.009395870668800e+00 4.470132252157453e+00 4.673075691220625e+00 9.245877477028969e+03 + 41680 1.028475561433104e+00 -5.982003216397621e+00 -5.979001422549295e+00 3.801908285569944e+00 4.819145050373129e+00 9.152683969800424e+03 + 41700 1.000213358230597e+00 -5.954417743728164e+00 -6.014765145919803e+00 3.902761995732969e+00 4.556237873618266e+00 9.262423596151437e+03 + 41720 1.000548981444288e+00 -5.966240073677980e+00 -5.996761068471326e+00 3.887815898055840e+00 4.712559622843770e+00 9.207068669871995e+03 + 41740 1.011328196273304e+00 -5.990699714036409e+00 -6.017713055027428e+00 3.735522480157218e+00 4.580407695885781e+00 9.271452239462220e+03 + 41760 1.034832057223049e+00 -6.032611309280607e+00 -5.975120939821469e+00 3.506016755057652e+00 4.836135353097943e+00 9.140827284065472e+03 + 41780 1.066082669999160e+00 -6.086231166754189e+00 -5.968896139704679e+00 3.217245694032555e+00 4.891001576887595e+00 9.121812240206122e+03 + 41800 1.032989020673128e+00 -6.044707867470353e+00 -5.961509819572236e+00 3.426946832660657e+00 4.904682898547949e+00 9.099233379966327e+03 + 41820 1.040940157787977e+00 -6.063254571647652e+00 -5.952550239754821e+00 3.370590917192535e+00 5.006272322361168e+00 9.071933575824920e+03 + 41840 9.418229621212121e-01 -5.921241743453634e+00 -5.972709266301410e+00 4.128584641076563e+00 4.833050160311212e+00 9.133451174759266e+03 + 41860 1.012986529764073e+00 -6.029947262732189e+00 -5.983810918102788e+00 3.496825261405475e+00 4.761747291843753e+00 9.167411893954642e+03 + 41880 9.720378782548207e-01 -5.971311234500191e+00 -6.006191433597305e+00 3.796466184351464e+00 4.596178683442472e+00 9.236062432185679e+03 + 41900 1.026558840731612e+00 -6.053575082641583e+00 -5.977806799479943e+00 3.390534746492480e+00 4.825607953510541e+00 9.149054646604554e+03 + 41920 9.654337067147909e-01 -5.965393009405540e+00 -5.987596957799651e+00 3.891029926858260e+00 4.763531419129365e+00 9.178991884827015e+03 + 41940 9.325868398049214e-01 -5.918403699422151e+00 -5.974399033375511e+00 4.139143443263261e+00 4.817609570453143e+00 9.138597371021664e+03 + 41960 1.008174323289658e+00 -6.028459495713508e+00 -5.966315012820007e+00 3.504293906654822e+00 4.861137144256952e+00 9.113914225198740e+03 + 41980 1.001244772711308e+00 -6.012105519027181e+00 -5.984741695977820e+00 3.599025458645301e+00 4.756152765132667e+00 9.170258132130752e+03 + 42000 9.883389488254670e-01 -5.982539622029579e+00 -5.970001978367593e+00 3.756972270684452e+00 4.828965360785661e+00 9.125184592889773e+03 + 42020 9.983260186153656e-01 -5.983026992695594e+00 -6.003277310748927e+00 3.794918314332567e+00 4.678637854343740e+00 9.227106708291334e+03 + 42040 1.067569561263460e+00 -6.065726268969217e+00 -6.006416443901234e+00 3.344300253447148e+00 4.684866447153279e+00 9.236763402643672e+03 + 42060 1.009339883809101e+00 -5.957593849092540e+00 -5.953451405034358e+00 3.945983628408355e+00 4.969770183231578e+00 9.074724393585248e+03 + 42080 1.000802634394208e+00 -5.922813886468560e+00 -5.975164705637753e+00 4.164214157644846e+00 4.863607652712255e+00 9.140935764087262e+03 + 42100 1.002523074867508e+00 -5.896890779204693e+00 -5.995157450590504e+00 4.258699492348400e+00 4.694437058532821e+00 9.202171616778922e+03 + 42120 1.029682264227345e+00 -5.907422085881147e+00 -6.042056017871837e+00 4.191834242600210e+00 4.418745370576029e+00 9.346573558115551e+03 + 42140 1.020182821929958e+00 -5.864932287036603e+00 -6.087204242657284e+00 4.383436313477167e+00 4.107116347829243e+00 9.486672198113525e+03 + 42160 1.100710388146992e+00 -5.964492544590880e+00 -6.070355627829341e+00 3.810732098007655e+00 4.202849891793228e+00 9.434318958669412e+03 + 42180 1.050319845308460e+00 -5.882999156922605e+00 -6.017760932183309e+00 4.323070386698666e+00 4.549247418834383e+00 9.271647290820150e+03 + 42200 1.102167238778667e+00 -5.962195864007908e+00 -6.011722205301942e+00 3.835153633303725e+00 4.550765717416835e+00 9.253028569557557e+03 + 42220 9.929007405410472e-01 -5.808459174911580e+00 -6.032858263376204e+00 4.728527089424414e+00 4.439992797813838e+00 9.318167558145306e+03 + 42240 1.067468417507986e+00 -5.935613422723162e+00 -6.019983074366220e+00 4.028051079038299e+00 4.543587483142471e+00 9.278484215337145e+03 + 42260 1.037382823239018e+00 -5.920627699516973e+00 -6.062782093900850e+00 4.126069483963200e+00 4.309796953089541e+00 9.410794406151206e+03 + 42280 1.056018783432308e+00 -5.991481578667956e+00 -6.042755003084171e+00 3.728152384029184e+00 4.433732446494494e+00 9.348747847987999e+03 + 42300 9.749924002192110e-01 -5.918692850061968e+00 -5.955978031972080e+00 4.198607767295293e+00 4.984510482904172e+00 9.082392485504502e+03 + 42320 1.005765985273272e+00 -6.004266176969770e+00 -5.960137059099537e+00 3.658883645490996e+00 4.912279869260791e+00 9.095081183849157e+03 + 42340 1.000488442249874e+00 -6.026860991602560e+00 -6.010444680655715e+00 3.541073160182420e+00 4.635338158055110e+00 9.249124491450788e+03 + 42360 1.021027227119354e+00 -6.080541800545733e+00 -6.000374597068820e+00 3.277191009156674e+00 4.737523497355751e+00 9.218207455062064e+03 + 42380 9.876368553615831e-01 -6.047802632211480e+00 -5.985236081389377e+00 3.394138788698931e+00 4.753405605661900e+00 9.171820014800231e+03 + 42400 9.353238595323677e-01 -5.981028627410359e+00 -6.016236587807597e+00 3.782929493003387e+00 4.580759935988183e+00 9.266943499416178e+03 + 42420 9.277928428763611e-01 -5.973687758162972e+00 -6.003483867664166e+00 3.799381252694099e+00 4.628287381005197e+00 9.227753382121127e+03 + 42440 9.644170927797882e-01 -6.028196062747335e+00 -5.969998298036570e+00 3.574590017560665e+00 4.908770588604860e+00 9.125165510110977e+03 + 42460 9.221063611117847e-01 -5.960968830859374e+00 -5.971395549302516e+00 3.970732915555465e+00 4.910861084725479e+00 9.129441166678169e+03 + 42480 9.685052453610711e-01 -6.020292086542680e+00 -5.997299972266075e+00 3.597251056113297e+00 4.729275334307752e+00 9.208760108634246e+03 + 42500 1.004413820781589e+00 -6.060260573018681e+00 -6.020666047526991e+00 3.331464448953759e+00 4.558822341560059e+00 9.280630624251418e+03 + 42520 9.919404607610979e-01 -6.029843262149455e+00 -6.029369722552115e+00 3.540946551052425e+00 4.543665688700363e+00 9.307444260726128e+03 + 42540 9.816233209824741e-01 -6.002933876441045e+00 -6.000094161100922e+00 3.696964454642380e+00 4.713270539569894e+00 9.217354190864300e+03 + 42560 9.838593388869179e-01 -5.994898297799462e+00 -5.990747505611068e+00 3.765685749943987e+00 4.789520241022768e+00 9.188638480326732e+03 + 42580 9.308198779623225e-01 -5.901170235735740e+00 -6.019585774465984e+00 4.242424581270377e+00 4.562464233135923e+00 9.277237268107887e+03 + 42600 9.680489704144786e-01 -5.937214453171924e+00 -6.007297235752763e+00 3.960535505482295e+00 4.558109322627567e+00 9.239473417881185e+03 + 42620 1.070861566598949e+00 -6.066051233038757e+00 -6.004966358411322e+00 3.342521363849202e+00 4.693280166813735e+00 9.232316527625924e+03 + 42640 9.751189310589308e-01 -5.903285823641355e+00 -6.058034808304072e+00 4.189344304892298e+00 4.300751687630991e+00 9.396050120998671e+03 + 42660 9.731572859055522e-01 -5.880894785199361e+00 -6.023394722516059e+00 4.334938025111613e+00 4.516681333245104e+00 9.288997185851287e+03 + 42680 9.782938119957603e-01 -5.867143239203233e+00 -6.013157469230508e+00 4.383533864449713e+00 4.545097560004027e+00 9.257463858879093e+03 + 42700 1.048427319225294e+00 -5.947651879296277e+00 -5.965585920159571e+00 3.986211016485091e+00 4.883230978564202e+00 9.111649023152080e+03 + 42720 9.856468741301643e-01 -5.821196327792630e+00 -6.019534113005258e+00 4.644726134888419e+00 4.505839879524445e+00 9.277097604837996e+03 + 42740 1.153830078841981e+00 -6.029262413203185e+00 -5.985027926087037e+00 3.560106650630934e+00 4.814107920916611e+00 9.171146172277600e+03 + 42760 1.073076630408098e+00 -5.867082361197090e+00 -6.056436992475969e+00 4.381100798962864e+00 4.293797203625054e+00 9.391121440777741e+03 + 42780 1.129088786796924e+00 -5.911678348988840e+00 -6.033575220626751e+00 4.202310009691208e+00 4.502359309266404e+00 9.320407309509890e+03 + 42800 1.133618811493557e+00 -5.890405725625349e+00 -6.051891020850152e+00 4.259277686276134e+00 4.332004131326644e+00 9.377029157181451e+03 + 42820 1.152280073280757e+00 -5.904357007548787e+00 -6.022328322383362e+00 4.158709114376955e+00 4.481299568594856e+00 9.285713874040412e+03 + 42840 1.147618890673095e+00 -5.898211705899039e+00 -6.018114076043819e+00 4.263214343513316e+00 4.574716379310172e+00 9.272724944820558e+03 + 42860 1.067303376761237e+00 -5.799387852833096e+00 -6.046586687946289e+00 4.734966529333999e+00 4.315512564217942e+00 9.360563680019064e+03 + 42880 1.067451654650052e+00 -5.839018953002554e+00 -6.018131369814994e+00 4.555371209823728e+00 4.526879994929771e+00 9.272729996427064e+03 + 42900 1.017910504028394e+00 -5.821716510644388e+00 -6.002320404447032e+00 4.708163664389866e+00 4.671108157812847e+00 9.224103650735389e+03 + 42920 1.059701455343044e+00 -5.944552881968688e+00 -5.960473458120179e+00 3.990763912046887e+00 4.899345500083827e+00 9.096072481170564e+03 + 42940 9.878290660745270e-01 -5.890321766054291e+00 -6.025692589444443e+00 4.246363683573211e+00 4.469043467099747e+00 9.296097913809414e+03 + 42960 1.027061070576393e+00 -5.984038434391606e+00 -6.013893146383296e+00 3.753446052349330e+00 4.582015676091299e+00 9.259738441109906e+03 + 42980 1.023604291954133e+00 -6.003560703585315e+00 -5.977208996251175e+00 3.696466080291529e+00 4.847781661717693e+00 9.147198560564861e+03 + 43000 1.047040952463689e+00 -6.055402833051120e+00 -5.980630665071473e+00 3.384484174581140e+00 4.813837534075875e+00 9.157698807345088e+03 + 43020 1.031359357778491e+00 -6.046435347242450e+00 -6.012780630280496e+00 3.408662822744633e+00 4.601913415590793e+00 9.256338864382320e+03 + 43040 9.830260499444172e-01 -5.988067240269205e+00 -5.982814246380953e+00 3.729262574316410e+00 4.759426078120931e+00 9.164379421916006e+03 + 43060 9.569613321854348e-01 -5.960327856796565e+00 -5.987772049475552e+00 3.910603628310275e+00 4.753014826972441e+00 9.179554534259036e+03 + 43080 9.519482537088338e-01 -5.961192908361253e+00 -6.022789521857399e+00 3.948548302079721e+00 4.594851015339724e+00 9.287136281129708e+03 + 43100 9.896027148867316e-01 -6.024676819144529e+00 -6.000303924299015e+00 3.604723882677578e+00 4.744676816573810e+00 9.217985859733315e+03 + 43120 9.879506586404259e-01 -6.028341884448516e+00 -6.014971179339854e+00 3.525975931726293e+00 4.602752589570162e+00 9.263064222609757e+03 + 43140 9.495732833904647e-01 -5.976194969212692e+00 -6.003797855310245e+00 3.866972910243681e+00 4.708472866738711e+00 9.228700798946804e+03 + 43160 1.052294047671788e+00 -6.130260035585733e+00 -5.964976843684558e+00 2.999923553162124e+00 4.949005218549958e+00 9.109852532510920e+03 + 43180 1.004007056039291e+00 -6.058699466393047e+00 -5.965696520246928e+00 3.412237926333785e+00 4.946275235264199e+00 9.112035523971606e+03 + 43200 9.877195797013062e-01 -6.033009864470846e+00 -6.013693890129190e+00 3.455901337621872e+00 4.566816651429027e+00 9.259129697802808e+03 + 43220 1.001375449292046e+00 -6.049021769970193e+00 -5.979587618456819e+00 3.439670704625959e+00 4.838372347515977e+00 9.154487545677650e+03 + 43240 1.030573913098022e+00 -6.084572401545989e+00 -5.950678450674758e+00 3.236714533021168e+00 5.005554318945713e+00 9.066281503153792e+03 + 43260 9.545667384524475e-01 -5.959395229467003e+00 -6.017705347906028e+00 3.934684834008945e+00 4.599859110470395e+00 9.271460813538190e+03 + 43280 9.891693043603166e-01 -5.994199556339470e+00 -6.038093552065153e+00 3.713492061646571e+00 4.461445945615814e+00 9.334355562475148e+03 + 43300 9.401744431738801e-01 -5.901517074132211e+00 -6.090647042222202e+00 4.179195409306526e+00 4.093181864765822e+00 9.497395226762759e+03 + 43320 1.018153035613122e+00 -5.995127162374814e+00 -6.000379016673182e+00 3.743163107450942e+00 4.713006147347890e+00 9.218205075773891e+03 + 43340 9.816169751428591e-01 -5.914911309841576e+00 -6.051696240181725e+00 4.115457460039036e+00 4.330017222626345e+00 9.376424858128343e+03 + 43360 1.020514420308772e+00 -5.945623235512811e+00 -6.033851536465662e+00 3.987719437550037e+00 4.481098880193324e+00 9.321256130463647e+03 + 43380 1.049822266731537e+00 -5.960695632164704e+00 -6.037091578949415e+00 3.926830084105465e+00 4.488152735433095e+00 9.331253638021160e+03 + 43400 1.104107613336717e+00 -6.016887823218112e+00 -6.024708934025497e+00 3.608281979367014e+00 4.563371950798023e+00 9.293053166073969e+03 + 43420 1.067105552722048e+00 -5.945784971554009e+00 -5.989292297776403e+00 3.973838242448465e+00 4.724012442542499e+00 9.184223521146152e+03 + 43440 1.039504461383008e+00 -5.892300859036462e+00 -5.980781592914661e+00 4.297725292844597e+00 4.789655226566663e+00 9.158119279815603e+03 + 43460 9.889098167668555e-01 -5.808837432599365e+00 -6.015908798463626e+00 4.690725684546914e+00 4.501689857564020e+00 9.265935309641163e+03 + 43480 1.059854792665280e+00 -5.909766399686471e+00 -6.038949288624625e+00 4.144301925996133e+00 4.402513786725797e+00 9.336993476795287e+03 + 43500 1.039952725895798e+00 -5.885749399748401e+00 -6.037794677884799e+00 4.298058678056440e+00 4.424991162066498e+00 9.333433173026649e+03 + 43520 1.040733332848676e+00 -5.903190915999691e+00 -6.012277253473432e+00 4.282866901354387e+00 4.656476270524004e+00 9.254762410430034e+03 + 43540 1.068855680551549e+00 -5.976838093128382e+00 -6.002856631256365e+00 3.753554276319238e+00 4.604151804032599e+00 9.225814841236908e+03 + 43560 9.797788171985855e-01 -5.890614250718889e+00 -6.018238714491039e+00 4.288197247503880e+00 4.555357826702260e+00 9.273045483309674e+03 + 43580 1.001286688090568e+00 -5.975862330406976e+00 -5.950500158514716e+00 3.799734288735876e+00 4.945367804524652e+00 9.065713627082419e+03 + 43600 9.560588444261650e-01 -5.953729928899411e+00 -5.986631930594523e+00 3.931401694037400e+00 4.742473308735757e+00 9.176027810874892e+03 + 43620 9.516288890263075e-01 -5.980320778267289e+00 -5.997710796959076e+00 3.818842357103101e+00 4.718986178678161e+00 9.210000274863347e+03 + 43640 9.998427215934363e-01 -6.075021626592518e+00 -5.968574425301028e+00 3.314078328112557e+00 4.925314630579457e+00 9.120851155444963e+03 + 43660 9.530353603549442e-01 -6.021464010366691e+00 -6.030679719321651e+00 3.605885756519080e+00 4.552967729573345e+00 9.311461063008839e+03 + 43680 1.053803642179686e+00 -6.182616804528794e+00 -5.971533298191842e+00 2.703202384867893e+00 4.915276543321711e+00 9.129885254296563e+03 + 43700 9.054869488859441e-01 -5.968637804469909e+00 -6.001163842593330e+00 3.854055498321952e+00 4.667285954029135e+00 9.220606076412834e+03 + 43720 9.092715546334610e-01 -5.973510357038468e+00 -5.985528597367561e+00 3.816607850817448e+00 4.747597255031115e+00 9.172666853785340e+03 + 43740 9.648352587776566e-01 -6.049806570887415e+00 -5.936859000696399e+00 3.489169058285245e+00 5.137731484902055e+00 9.024236697275106e+03 + 43760 9.351932432860037e-01 -5.994543260263411e+00 -5.990393249873906e+00 3.764030712744081e+00 4.787860714612650e+00 9.187546694156073e+03 + 43780 1.058085435964107e+00 -6.160511815647474e+00 -5.975691069737474e+00 2.860009745733641e+00 4.921279069666857e+00 9.142586853911111e+03 + 43800 9.944016458290016e-01 -6.048255784435115e+00 -5.970449329038832e+00 3.467001913463403e+00 4.913778620858920e+00 9.126561681242074e+03 + 43820 9.663739136986895e-01 -5.985596461163115e+00 -5.947466913561681e+00 3.822017375038782e+00 5.040963137894641e+00 9.056493813119876e+03 + 43840 9.398389868783787e-01 -5.920740078145464e+00 -6.014947052912079e+00 4.116285885761977e+00 4.575334858169841e+00 9.262990812546112e+03 + 43860 1.029902982519457e+00 -6.024766348263920e+00 -6.025640789411106e+00 3.551235038741337e+00 4.546213862354866e+00 9.295945401530627e+03 + 43880 1.044787154454894e+00 -6.021825703389696e+00 -6.015765836227601e+00 3.577486698003261e+00 4.612283393009424e+00 9.265518173774766e+03 + 43900 1.017347564613833e+00 -5.961616603805984e+00 -6.035368076520879e+00 3.868101699299082e+00 4.444609329966637e+00 9.325947708391857e+03 + 43920 1.051271492095395e+00 -5.997370675638565e+00 -6.006671711673600e+00 3.712290617106905e+00 4.658882628863058e+00 9.237547838150287e+03 + 43940 1.033302111134558e+00 -5.959494352791464e+00 -6.006510046905924e+00 3.925597709834556e+00 4.655626318574174e+00 9.237027029862871e+03 + 43960 1.048268640733096e+00 -5.974074330648794e+00 -5.976280417552674e+00 3.915821076099669e+00 4.903153383706741e+00 9.144335275666786e+03 + 43980 1.031451242621384e+00 -5.946985114871048e+00 -5.994124628599200e+00 4.036432889972897e+00 4.765750507329679e+00 9.198962267471863e+03 + 44000 1.005911871965239e+00 -5.909133496219501e+00 -5.991316815400957e+00 4.196119889308073e+00 4.724210552740611e+00 9.190374653609519e+03 + 44020 1.052890297721638e+00 -5.981142560877849e+00 -5.959662504909911e+00 3.852959582498220e+00 4.976301387894043e+00 9.093643049754877e+03 + 44040 1.054115870502467e+00 -5.989654242170328e+00 -6.004740130812059e+00 3.746198960921911e+00 4.659573453807370e+00 9.231601089645210e+03 + 44060 1.016748787205440e+00 -5.948708956473249e+00 -5.999769051930477e+00 3.945196524408043e+00 4.652001554768402e+00 9.216350940308181e+03 + 44080 1.022358134265070e+00 -5.982029537570616e+00 -5.995223897469996e+00 3.772768066997626e+00 4.697004010634792e+00 9.202374179733488e+03 + 44100 9.976488675684239e-01 -5.987292867359272e+00 -5.985964764555890e+00 3.719787347419050e+00 4.727413519239311e+00 9.174010241602811e+03 + 44120 9.878774389058852e-01 -6.040063392081655e+00 -5.983679505518572e+00 3.468219910826282e+00 4.791984912849749e+00 9.167025834266926e+03 + 44140 9.811445851239732e-01 -6.104276502068400e+00 -5.987234838456873e+00 3.179995924826761e+00 4.852067269423058e+00 9.177893438559246e+03 + 44160 8.879097406772835e-01 -6.015150918813836e+00 -6.035658787842863e+00 3.583303474023029e+00 4.465544116475882e+00 9.326850821694325e+03 + 44180 9.404853277778682e-01 -6.119882529047506e+00 -6.015572614808396e+00 3.020606164163634e+00 4.619569833631665e+00 9.264930568316562e+03 + 44200 8.795486879054911e-01 -6.041899774901146e+00 -6.013802303763943e+00 3.430059136734282e+00 4.591399164073708e+00 9.259471572404133e+03 + 44220 9.174773000436394e-01 -6.098964529761320e+00 -5.984266502332054e+00 3.196861375306876e+00 4.855475198268100e+00 9.168806211460727e+03 + 44240 9.317818896596072e-01 -6.112780917416571e+00 -5.971426605809496e+00 3.101144182710253e+00 4.912822514467104e+00 9.129536224014815e+03 + 44260 9.122884283951161e-01 -6.067554546885442e+00 -6.006219325463735e+00 3.298222649218836e+00 4.650418982217120e+00 9.236152453011944e+03 + 44280 1.041744634801371e+00 -6.235675668622503e+00 -5.960102522178244e+00 2.475474138759287e+00 5.057857790448812e+00 9.095011348718204e+03 + 44300 9.314902462279555e-01 -6.042523426917090e+00 -6.034370859927232e+00 3.450653048652696e+00 4.497466349914127e+00 9.322876189241906e+03 + 44320 9.291402723635239e-01 -6.010500878758293e+00 -5.998930542939956e+00 3.628011065415561e+00 4.694449724188138e+00 9.213757106659979e+03 + 44340 9.826999131182712e-01 -6.056969718286006e+00 -5.958016110862165e+00 3.394572725968288e+00 4.962779652817241e+00 9.088617130600640e+03 + 44360 1.040923764306458e+00 -6.109885461557235e+00 -5.991496003246529e+00 3.124511687228603e+00 4.804322277558141e+00 9.190965877078530e+03 + 44380 9.734744607289658e-01 -5.979492629828739e+00 -6.025367411754219e+00 3.795563620911742e+00 4.532143523996071e+00 9.295080380872345e+03 + 44400 1.031607118497341e+00 -6.040628625650927e+00 -5.996666343504339e+00 3.505024110036007e+00 4.757462337262891e+00 9.206805795223194e+03 + 44420 1.051663108435957e+00 -6.046403150986342e+00 -6.038243165277815e+00 3.466149958797668e+00 4.513005859489738e+00 9.334833238355934e+03 + 44440 1.053086184577943e+00 -6.033286209042171e+00 -6.006317023791751e+00 3.554949301088040e+00 4.709810536263886e+00 9.236466474553114e+03 + 44460 1.028155467526128e+00 -5.984644824941411e+00 -6.044348939398279e+00 3.757708617530137e+00 4.414878353136949e+00 9.353675754734333e+03 + 44480 1.034563528443213e+00 -5.987431675567249e+00 -6.035025246188928e+00 3.766470334318505e+00 4.493180686727575e+00 9.324878048494254e+03 + 44500 1.044640663285337e+00 -6.000013801552655e+00 -6.025526521754809e+00 3.696249239700212e+00 4.549751252218750e+00 9.295560421354163e+03 + 44520 9.741811292179292e-01 -5.896628926601443e+00 -6.036788010655622e+00 4.235086821354985e+00 4.430271671167731e+00 9.330298366875495e+03 + 44540 1.033320293560809e+00 -5.987269973433270e+00 -5.998144892007492e+00 3.729627137886326e+00 4.667181672544933e+00 9.211338064886950e+03 + 44560 1.045010736128547e+00 -6.009568951139081e+00 -6.020845106469034e+00 3.643806840574785e+00 4.579057411690798e+00 9.281143584804753e+03 + 44580 1.108076239821885e+00 -6.114675659714501e+00 -5.973377991734043e+00 3.119603714030966e+00 4.930956789318206e+00 9.135500351817574e+03 + 44600 1.042002301079985e+00 -6.034794129171982e+00 -5.986180055304679e+00 3.531752828594982e+00 4.810902363744654e+00 9.174669074822155e+03 + 44620 9.900339218609060e-01 -5.978559797599485e+00 -5.989106557169039e+00 3.846535478743761e+00 4.785974353189617e+00 9.183635655550199e+03 + 44640 9.521899196989791e-01 -5.948304817607248e+00 -6.020921416943950e+00 4.007809258355389e+00 4.590833507581618e+00 9.281336497677594e+03 + 44660 9.904607532559435e-01 -6.036147852024190e+00 -6.010345874641897e+00 3.527943257919222e+00 4.676102204891444e+00 9.248840833776167e+03 + 44680 9.522527961358813e-01 -6.017244392039335e+00 -5.988771295544299e+00 3.610670954993704e+00 4.774167881265642e+00 9.182607617771590e+03 + 44700 9.778167397004138e-01 -6.093814438957845e+00 -5.967877177249019e+00 3.204150316486027e+00 4.927301561946374e+00 9.118694212763059e+03 + 44720 9.554767568724524e-01 -6.095009815749385e+00 -5.977477560777148e+00 3.194553542025427e+00 4.869441938133692e+00 9.148038085202334e+03 + 44740 9.016631559999805e-01 -6.042712937306354e+00 -5.968430207604885e+00 3.462716877197736e+00 4.889259806358844e+00 9.120390909697662e+03 + 44760 9.110012153255921e-01 -6.071622213824578e+00 -5.949903646555379e+00 3.334140491561252e+00 5.033067340708406e+00 9.063909964984870e+03 + 44780 9.367768111250798e-01 -6.115493813806432e+00 -5.984086680038731e+00 3.068521701282660e+00 4.823081798565030e+00 9.168271988856170e+03 + 44800 9.426598744713789e-01 -6.122598441475942e+00 -6.002267887738543e+00 2.991330638812212e+00 4.682287299465369e+00 9.224008288570460e+03 + 44820 8.982252198973060e-01 -6.048465753693729e+00 -5.998447839062718e+00 3.420677208507584e+00 4.707887814566126e+00 9.212280469748421e+03 + 44840 8.544935896449105e-01 -5.966778415044003e+00 -6.004069057877350e+00 3.811207679674588e+00 4.597079037817181e+00 9.229533123548090e+03 + 44860 9.787651380573306e-01 -6.122548618577605e+00 -5.948751283918413e+00 3.083363526820345e+00 5.081334717484047e+00 9.060397199405674e+03 + 44880 9.574037934031961e-01 -6.053590702113706e+00 -6.012866053212771e+00 3.401654177584300e+00 4.635501413692516e+00 9.256594951927616e+03 + 44900 1.010773908773713e+00 -6.093645653065124e+00 -6.019538160086261e+00 3.178568887398491e+00 4.604105580180599e+00 9.277136948292919e+03 + 44920 9.866902019024648e-01 -6.027109287492773e+00 -5.993707224389452e+00 3.624885235197160e+00 4.816685050488994e+00 9.197733228332030e+03 + 44940 1.020190537638765e+00 -6.056084065275464e+00 -5.966454310857993e+00 3.429076713471332e+00 4.943744633496122e+00 9.114337737008495e+03 + 44960 9.524672643064573e-01 -5.942260627102574e+00 -6.036539327484205e+00 3.986945865660108e+00 4.445582978487053e+00 9.329563686612148e+03 + 44980 9.667314090633224e-01 -5.954274812589973e+00 -6.023374155230139e+00 3.880113668259499e+00 4.483334549730946e+00 9.288943797340771e+03 + 45000 9.770601562059136e-01 -5.962905126795389e+00 -6.009004536656666e+00 3.942252905953867e+00 4.677542960669793e+00 9.244690345391469e+03 + 45020 9.985325647643951e-01 -5.989477147718591e+00 -5.993347920425673e+00 3.736859109477459e+00 4.714632533593255e+00 9.196641503405395e+03 + 45040 1.007504539887335e+00 -5.997817497285838e+00 -6.036125957602049e+00 3.704187491127704e+00 4.484214383776948e+00 9.328292769787153e+03 + 45060 1.003671947602390e+00 -5.988953345815810e+00 -6.027986304006537e+00 3.779557231522706e+00 4.555423945260795e+00 9.303174592776817e+03 + 45080 1.036428248556178e+00 -6.038342595110455e+00 -5.970958927520535e+00 3.515447961795993e+00 4.902375408686169e+00 9.128114309467492e+03 + 45100 9.900730243923580e-01 -5.968974068296387e+00 -5.987657449075325e+00 3.869931752946302e+00 4.762648889269812e+00 9.179186576986322e+03 + 45120 1.019234200729725e+00 -6.010499653940125e+00 -6.030121182620810e+00 3.607073762255418e+00 4.494403908149170e+00 9.309744399296134e+03 + 45140 1.013001905856983e+00 -6.002663701091591e+00 -6.029279456462883e+00 3.662727019838008e+00 4.509895233721217e+00 9.307168895779778e+03 + 45160 9.698363294889166e-01 -5.941237019205436e+00 -6.015921371514668e+00 4.010044526025745e+00 4.581195417699971e+00 9.265990627477371e+03 + 45180 9.744499586576585e-01 -5.951108383129355e+00 -6.046094904230198e+00 3.916006635071441e+00 4.370579331793769e+00 9.359085946889680e+03 + 45200 9.823399088730466e-01 -5.967396025468328e+00 -6.048193530368751e+00 3.781446232798570e+00 4.317494456286868e+00 9.365567517754695e+03 + 45220 1.014884389942635e+00 -6.022639499349491e+00 -6.021834794969820e+00 3.569088695345047e+00 4.573709432420721e+00 9.284167893845650e+03 + 45240 9.609991049530829e-01 -5.951021366942196e+00 -6.047123042655146e+00 3.936934244000892e+00 4.385103550370880e+00 9.362266183393145e+03 + 45260 9.860285264153303e-01 -5.998294014252766e+00 -6.024747874803780e+00 3.705515919166511e+00 4.553613758160898e+00 9.293180745229589e+03 + 45280 1.039500089932220e+00 -6.090752722379923e+00 -5.957914941721507e+00 3.209294620511539e+00 4.972069713632290e+00 9.088329038598336e+03 + 45300 9.914855379572206e-01 -6.031828476144758e+00 -5.969515768864861e+00 3.599695176136700e+00 4.957504384198160e+00 9.123696228189738e+03 + 45320 9.928047573685331e-01 -6.046510541925003e+00 -6.009536543703220e+00 3.455046294074056e+00 4.667356713571265e+00 9.246357374623882e+03 + 45340 9.738279510449656e-01 -6.034074839546645e+00 -6.042779204880069e+00 3.453919054416601e+00 4.403937241675900e+00 9.348831099002326e+03 + 45360 1.034756486499149e+00 -6.141996497742743e+00 -5.962786609980720e+00 2.942248048764549e+00 4.971298956934593e+00 9.103166585679541e+03 + 45380 9.660119205882111e-01 -6.056130103610525e+00 -5.968562744318561e+00 3.419241906807790e+00 4.922067234867301e+00 9.120793767244262e+03 + 45400 8.815184303390018e-01 -5.943744522652819e+00 -6.004943030045705e+00 3.975396723660041e+00 4.623985423771676e+00 9.232230305807490e+03 + 45420 9.150665021736227e-01 -6.001178525575921e+00 -5.993558879859882e+00 3.684605862280283e+00 4.728359047118143e+00 9.197290538511814e+03 + 45440 1.009690982375667e+00 -6.144693766793868e+00 -5.965249730633436e+00 2.969699193625116e+00 5.000094618133167e+00 9.110694326481607e+03 + 45460 9.802079686647477e-01 -6.101061999234433e+00 -5.974148773348036e+00 3.155579172627301e+00 4.884334555425228e+00 9.137872695360151e+03 + 45480 9.064530400004156e-01 -5.987314765332380e+00 -6.011781184309340e+00 3.714891149562635e+00 4.574401185630830e+00 9.253240653380661e+03 + 45500 9.270713427255561e-01 -6.003528696881522e+00 -5.994572577499298e+00 3.689433974206628e+00 4.740861397654359e+00 9.200401916061559e+03 + 45520 9.386765430170138e-01 -5.997613956261170e+00 -5.982842516153095e+00 3.713550293937092e+00 4.798370188910630e+00 9.164458514304373e+03 + 45540 9.907620792352331e-01 -6.042017169531688e+00 -6.033113399816497e+00 3.442580399322137e+00 4.493707222880677e+00 9.318959265289719e+03 + 45560 1.007557366295257e+00 -6.026174034478126e+00 -6.018532694151251e+00 3.590278618088091e+00 4.634156376738604e+00 9.274033728611394e+03 + 45580 1.036602352842762e+00 -6.030962624412669e+00 -6.025782339607796e+00 3.513917359421110e+00 4.543663356417176e+00 9.296380268850406e+03 + 45600 9.825801915476166e-01 -5.917334926316772e+00 -6.059700231234692e+00 4.135638216232778e+00 4.318154604434347e+00 9.401202756799008e+03 + 45620 1.086929699947403e+00 -6.043661484504853e+00 -5.997158206488040e+00 3.498966143830534e+00 4.765995162562092e+00 9.208318320480696e+03 + 45640 1.015784972069015e+00 -5.918560634637530e+00 -6.020037981822809e+00 4.167762136776048e+00 4.585063505669452e+00 9.278644329216979e+03 + 45660 9.905874066106548e-01 -5.867585363371559e+00 -6.085361711668277e+00 4.374961477312450e+00 4.124455984611710e+00 9.480946858428193e+03 + 45680 1.001403069643705e+00 -5.877699934157615e+00 -6.093142471850548e+00 4.274427325679746e+00 4.037322934621963e+00 9.505185810532963e+03 + 45700 1.012208629431235e+00 -5.896062902470717e+00 -6.002874956155948e+00 4.266775583418445e+00 4.653444242045954e+00 9.225873899126333e+03 + 45720 1.028046023958991e+00 -5.924749673863724e+00 -6.011400608525927e+00 4.051852582902914e+00 4.554289506883745e+00 9.252094438410912e+03 + 45740 1.083669740621331e+00 -6.017464256459352e+00 -5.980852146335405e+00 3.608665557306204e+00 4.818897959343641e+00 9.158359251375145e+03 + 45760 9.875412767167220e-01 -5.890034404873836e+00 -6.002074493731762e+00 4.291165326069461e+00 4.647813797699533e+00 9.223429906175650e+03 + 45780 9.582501034354468e-01 -5.864430838773478e+00 -6.017662036957267e+00 4.479894056211259e+00 4.600016803788660e+00 9.271317968838737e+03 + 45800 1.055868437196296e+00 -6.031074750768443e+00 -5.949643473826411e+00 3.558242509748278e+00 5.025833503398810e+00 9.063107851390636e+03 + 45820 1.074399035137153e+00 -6.081707616759515e+00 -5.965470011851463e+00 3.258419426780411e+00 4.925873741873676e+00 9.111354859078245e+03 + 45840 9.816627586646965e-01 -5.973088573349747e+00 -5.970578580690987e+00 3.861642821587270e+00 4.876055587853982e+00 9.126952455130249e+03 + 45860 9.634852339177441e-01 -5.975460845645318e+00 -5.976025838607751e+00 3.884523248003387e+00 4.881278970980717e+00 9.143583779641971e+03 + 45880 9.926686437227590e-01 -6.048308139025887e+00 -5.994277890567073e+00 3.439510682329893e+00 4.749760730134333e+00 9.199458976169082e+03 + 45900 9.828988381451896e-01 -6.062550379604077e+00 -5.975280955308194e+00 3.346555072174505e+00 4.847669611381228e+00 9.141324345445451e+03 + 45920 9.045368836714649e-01 -5.972890214255204e+00 -6.006844827084905e+00 3.825116503358220e+00 4.630143862030728e+00 9.238058438540929e+03 + 45940 9.373422585535576e-01 -6.043753499313156e+00 -6.010579809560938e+00 3.448124252181436e+00 4.638612712350567e+00 9.249514668200247e+03 + 45960 9.523795198154340e-01 -6.086806503256065e+00 -6.005837686214207e+00 3.234086369198321e+00 4.699021846536617e+00 9.234991326998052e+03 + 45980 9.920661511212907e-01 -6.166016779048537e+00 -5.931754102076604e+00 2.845988173321975e+00 5.191160716526914e+00 9.008744292714087e+03 + 46000 9.285306155636552e-01 -6.091379627318396e+00 -5.957951166111413e+00 3.229431358969648e+00 4.995598231207788e+00 9.088421003321448e+03 + 46020 9.076159055086368e-01 -6.081968831540318e+00 -6.022628923921800e+00 3.234696084090612e+00 4.575435016457167e+00 9.286659356591610e+03 + 46040 8.781644010579813e-01 -6.068414701817208e+00 -6.016899669901378e+00 3.307936947077756e+00 4.603744232263873e+00 9.269008610018995e+03 + 46060 8.966261590375787e-01 -6.128674807252696e+00 -5.973697570715760e+00 3.024641586980180e+00 4.914544861825114e+00 9.136493029150446e+03 + 46080 8.589240617693639e-01 -6.101087551653540e+00 -5.955316240345145e+00 3.207046797127908e+00 5.044088224698235e+00 9.080375913452643e+03 + 46100 8.739211096640135e-01 -6.142170080139031e+00 -5.974088292155754e+00 2.944086527498830e+00 4.909238164671434e+00 9.137685941073249e+03 + 46120 8.805460670904588e-01 -6.160615234811071e+00 -5.982884436801590e+00 2.820529283054132e+00 4.841087028976679e+00 9.164582532157927e+03 + 46140 8.966594402874921e-01 -6.180920329450290e+00 -5.947902340217479e+00 2.709265132279674e+00 5.047290485871767e+00 9.057810131478103e+03 + 46160 8.609720846127109e-01 -6.108645153294935e+00 -5.978130023836520e+00 3.107180668181516e+00 4.856618738682744e+00 9.150021582722595e+03 + 46180 8.891309228205539e-01 -6.116043413584434e+00 -5.991305472610404e+00 3.086303092701571e+00 4.802567652908430e+00 9.190390910191671e+03 + 46200 9.512295332094245e-01 -6.163171934526775e+00 -5.986032333532468e+00 2.803072608732340e+00 4.820235609906312e+00 9.174243548359696e+03 + 46220 9.925743823608261e-01 -6.178736376527546e+00 -5.975312734233944e+00 2.811295669833350e+00 4.979385703590121e+00 9.141436108923073e+03 + 46240 9.028499916711410e-01 -6.006682631094439e+00 -6.026581172630292e+00 3.661865108026519e+00 4.547604603238301e+00 9.298832433675374e+03 + 46260 9.905475460665116e-01 -6.103509603428252e+00 -5.959624970721642e+00 3.181219637396503e+00 5.007427464472810e+00 9.093546563359747e+03 + 46280 9.856565008831203e-01 -6.063999974939899e+00 -6.005157860257087e+00 3.380693785963591e+00 4.718574314260112e+00 9.232910146229293e+03 + 46300 9.868317854060463e-01 -6.038878409433588e+00 -6.019843514244683e+00 3.530849008414803e+00 4.640150322230006e+00 9.278060797230195e+03 + 46320 9.808713668706407e-01 -6.007704357707952e+00 -5.995988144271009e+00 3.644334198466209e+00 4.711610509099303e+00 9.204773455926890e+03 + 46340 1.003361535283730e+00 -6.018195638868329e+00 -5.984683405727990e+00 3.634633638184982e+00 4.827066066878128e+00 9.170090852533142e+03 + 46360 9.928029947049347e-01 -5.982335037817466e+00 -6.004405525219875e+00 3.776771579894942e+00 4.650039425833428e+00 9.230580612208647e+03 + 46380 1.029994413635385e+00 -6.017942914438843e+00 -6.004174567319483e+00 3.567804118799927e+00 4.646864098604128e+00 9.229885633001895e+03 + 46400 1.022548020002067e+00 -5.989625462536409e+00 -5.978494174812478e+00 3.774362281942298e+00 4.838279858614319e+00 9.151146239445870e+03 + 46420 1.029245211091858e+00 -5.983867300788291e+00 -6.008134384731347e+00 3.761827335720981e+00 4.622481984400851e+00 9.242017541289739e+03 + 46440 1.020189142121825e+00 -5.956209122181994e+00 -6.022278171022351e+00 4.005384521652338e+00 4.626005819058744e+00 9.285568744160906e+03 + 46460 1.107429562447294e+00 -6.074636432274575e+00 -5.985976654061473e+00 3.308424768755934e+00 4.817522935311906e+00 9.174068702676712e+03 + 46480 1.001615602748194e+00 -5.913793728939163e+00 -6.038915962182665e+00 4.131715843658667e+00 4.413244617771460e+00 9.336889645880470e+03 + 46500 1.056554707018495e+00 -5.993482696537441e+00 -6.006648279040602e+00 3.736268544710905e+00 4.660669732610444e+00 9.237481016985610e+03 + 46520 1.001338730523760e+00 -5.914377498803793e+00 -6.011708438045956e+00 4.171954107810986e+00 4.613064792768315e+00 9.253023626269813e+03 + 46540 1.065616188181594e+00 -6.016908957024450e+00 -5.965520373269309e+00 3.645748315098257e+00 4.940829515377909e+00 9.111497839385747e+03 + 46560 1.007066228262183e+00 -5.941972819988367e+00 -6.011267282829115e+00 4.012864926660507e+00 4.614965397745462e+00 9.251674517835585e+03 + 46580 1.051429956216368e+00 -6.025391080674834e+00 -5.981359892968555e+00 3.580533493281107e+00 4.833367386894833e+00 9.159911312423343e+03 + 46600 1.010591966937790e+00 -5.988500890293908e+00 -5.980291151525179e+00 3.775004230353700e+00 4.822145820816711e+00 9.156637638471004e+03 + 46620 1.056512396752328e+00 -6.085637696104891e+00 -5.988386933105334e+00 3.297786840155432e+00 4.856215770805825e+00 9.181428484707807e+03 + 46640 9.913258287267246e-01 -6.024537634592517e+00 -6.010238953136936e+00 3.564879110879077e+00 4.646984352510826e+00 9.248493622629509e+03 + 46660 9.667712774426389e-01 -6.024009557574392e+00 -6.019808456609887e+00 3.513954223776246e+00 4.538077595632705e+00 9.277978424915716e+03 + 46680 1.012256253770115e+00 -6.125793266929136e+00 -5.966542485779259e+00 3.019974348740370e+00 4.934416978081705e+00 9.114648648979874e+03 + 46700 9.172761110772630e-01 -6.014628533400526e+00 -5.975848957233569e+00 3.600394551189991e+00 4.823072878660673e+00 9.143070037083056e+03 + 46720 9.178267793505699e-01 -6.035434831276690e+00 -5.998852307041420e+00 3.497288784008906e+00 4.707351299295151e+00 9.213532317088946e+03 + 46740 9.396208660924898e-01 -6.079406958720270e+00 -5.975116683298361e+00 3.320357302371268e+00 4.919208202711832e+00 9.140830597019691e+03 + 46760 9.787384622379391e-01 -6.141198095062737e+00 -5.991098629305255e+00 2.951800975846797e+00 4.813695336043512e+00 9.189758366420401e+03 + 46780 9.168946240138081e-01 -6.046733124765542e+00 -6.016430316535546e+00 3.459818734074484e+00 4.633822148275540e+00 9.267566944102247e+03 + 46800 9.644447702023515e-01 -6.107906205149953e+00 -5.960272540301948e+00 3.192351229540711e+00 5.040086579333755e+00 9.095518289198460e+03 + 46820 9.490687349507424e-01 -6.071701976891272e+00 -5.986111073356558e+00 3.294373940005948e+00 4.785850153251788e+00 9.174458209325132e+03 + 46840 9.263478168223128e-01 -6.019260852984536e+00 -5.984050518980050e+00 3.637976176243283e+00 4.840159362878619e+00 9.168146565528912e+03 + 46860 9.549986310541327e-01 -6.035340907834312e+00 -6.044607437009500e+00 3.448815388560492e+00 4.395605544045811e+00 9.354484222306095e+03 + 46880 1.005868168781037e+00 -6.082471317243534e+00 -6.000899150881201e+00 3.231518096616500e+00 4.699918099120959e+00 9.219832570904862e+03 + 46900 9.600253819661831e-01 -5.986677471309874e+00 -6.032424101215349e+00 3.751507243150709e+00 4.488823014965374e+00 9.316858461229618e+03 + 46920 1.026666603563075e+00 -6.062311875074732e+00 -5.972791642643607e+00 3.421493816526797e+00 4.935532844357517e+00 9.133715357537843e+03 + 46940 1.023229501432172e+00 -6.040816482670267e+00 -5.984405881990998e+00 3.498685843795264e+00 4.822604242407865e+00 9.169222661644033e+03 + 46960 1.000453376694894e+00 -5.995795871128336e+00 -5.990133015680362e+00 3.745024210739944e+00 4.777541203046258e+00 9.186762852611764e+03 + 46980 1.018629910254946e+00 -6.016355909648707e+00 -5.988058099690006e+00 3.611816729114151e+00 4.774307132968949e+00 9.180435557939947e+03 + 47000 9.772524410600779e-01 -5.950848143358937e+00 -6.012859336442002e+00 3.899324850903198e+00 4.543246984019121e+00 9.256556364887409e+03 + 47020 1.035298727182403e+00 -6.033973495513307e+00 -5.959045466855176e+00 3.458993313430749e+00 4.889241649060695e+00 9.091764286812964e+03 + 47040 9.589495224925221e-01 -5.916924043268216e+00 -5.992256975144133e+00 4.162150020742001e+00 4.729576668176959e+00 9.193276351291361e+03 + 47060 9.685772226057998e-01 -5.927835970815170e+00 -6.029710357230710e+00 4.076404971447407e+00 4.491426479639027e+00 9.308480011291824e+03 + 47080 1.019468218865350e+00 -6.002177951596217e+00 -5.986616126090959e+00 3.647800686897764e+00 4.737159097133674e+00 9.176025620250395e+03 + 47100 1.022831742634128e+00 -6.006547928676476e+00 -6.035209849739507e+00 3.631897094316886e+00 4.467315908155016e+00 9.325455951549146e+03 + 47120 1.022293272171524e+00 -6.009773222131590e+00 -5.980523234102611e+00 3.624184276536950e+00 4.792142234220367e+00 9.157347779918020e+03 + 47140 9.423056859973550e-01 -5.895374629409778e+00 -5.975315283222015e+00 4.253127990493542e+00 4.794096385527482e+00 9.141399169122735e+03 + 47160 1.027915621663734e+00 -6.022381440948004e+00 -5.969576175829859e+00 3.548734707252225e+00 4.851950711148976e+00 9.123899539004036e+03 + 47180 1.076724790766702e+00 -6.093593003795228e+00 -5.991042620157881e+00 3.182734458585097e+00 4.771594631051325e+00 9.189576801926924e+03 + 47200 9.589907462149174e-01 -5.922185735565795e+00 -6.025500381257070e+00 4.061856262561983e+00 4.468607579112933e+00 9.295484401723021e+03 + 47220 1.037842817744221e+00 -6.042664240200288e+00 -6.017250601881949e+00 3.462159237189799e+00 4.608088281161518e+00 9.270090425741470e+03 + 47240 9.819795796705822e-01 -5.968707834517965e+00 -6.045703747695363e+00 3.779399774251591e+00 4.337277325707919e+00 9.357899071369449e+03 + 47260 1.010013572691110e+00 -6.022275807773817e+00 -5.987891011434825e+00 3.596985989957035e+00 4.794428811565566e+00 9.179907574650379e+03 + 47280 9.740897188651769e-01 -5.980484006628861e+00 -6.006221212009626e+00 3.845637181632835e+00 4.697850165516819e+00 9.236148688021134e+03 + 47300 9.448152764101302e-01 -5.951379869003774e+00 -5.986156980944982e+00 3.986834422173886e+00 4.787138863666788e+00 9.174598966954753e+03 + 47320 9.166005529509663e-01 -5.925688560142874e+00 -6.005115797657377e+00 4.070704348490401e+00 4.614620859356845e+00 9.232775415816768e+03 + 47340 9.851198548545493e-01 -6.044608009255396e+00 -5.988566546802008e+00 3.464987872227755e+00 4.786786622023396e+00 9.182001807310131e+03 + 47360 9.640526246689106e-01 -6.032809718373374e+00 -6.008194608582533e+00 3.540259719871117e+00 4.681603489466055e+00 9.242218240932571e+03 + 47380 9.389829112775817e-01 -6.014410531689600e+00 -5.985379181739933e+00 3.616970998640036e+00 4.783673502637906e+00 9.172219877817934e+03 + 47400 9.644741444950589e-01 -6.067070477756026e+00 -5.956100937489136e+00 3.349159559718594e+00 4.986363832411936e+00 9.082783795652038e+03 + 47420 9.476358226414632e-01 -6.052925710199912e+00 -5.979698778648117e+00 3.448130267936671e+00 4.868610640738117e+00 9.154820543277292e+03 + 47440 9.718178155550132e-01 -6.096780064715259e+00 -5.964356792332919e+00 3.161817782315639e+00 4.922212704770207e+00 9.107973207592200e+03 + 47460 9.342347111835503e-01 -6.045562708798508e+00 -5.961207038148329e+00 3.488518959970464e+00 4.972902274841636e+00 9.098351615872145e+03 + 47480 1.004395621849268e+00 -6.147587553967104e+00 -5.943212678725708e+00 2.858638675722382e+00 5.032190836268208e+00 9.043548940025654e+03 + 47500 9.352932252712870e-01 -6.033432059606342e+00 -5.970244360445858e+00 3.521355553211318e+00 4.884189100055659e+00 9.125933532819468e+03 + 47520 9.035306106016098e-01 -5.964973611041597e+00 -5.998973883521501e+00 3.871765888157765e+00 4.676531062052995e+00 9.213896633884660e+03 + 47540 9.500705343246588e-01 -6.002348667491014e+00 -5.989398977612783e+00 3.653769787706337e+00 4.728128910945173e+00 9.184533536203171e+03 + 47560 1.058680126848192e+00 -6.123864727391484e+00 -5.995591017646378e+00 2.988246940470632e+00 4.724814432119462e+00 9.203520944791037e+03 + 47580 9.933779450102438e-01 -5.986917194238927e+00 -5.973996745601135e+00 3.750046354961777e+00 4.824237570472944e+00 9.137399593099341e+03 + 47600 1.023192411970130e+00 -5.993569485678100e+00 -6.007429054107777e+00 3.737917960088068e+00 4.658334173403581e+00 9.239840714975684e+03 + 47620 9.617353405254992e-01 -5.869418807919121e+00 -6.025352057817954e+00 4.422390340607120e+00 4.526997489095588e+00 9.295033665024937e+03 + 47640 1.017926245968575e+00 -5.928967725688439e+00 -6.037614780982510e+00 4.030753386180224e+00 4.406885181604198e+00 9.332881180529850e+03 + 47660 1.049446135949654e+00 -5.959585038803749e+00 -6.013958604718921e+00 3.898377127259581e+00 4.586155697492531e+00 9.259959594976697e+03 + 47680 1.021850869143050e+00 -5.910955789202574e+00 -6.002424068973411e+00 4.191166347857600e+00 4.665941330742901e+00 9.224487394923333e+03 + 47700 1.035777978435509e+00 -5.929087991497107e+00 -6.014795287901498e+00 4.088724227730848e+00 4.596579668615578e+00 9.262541353551826e+03 + 47720 1.105539913381812e+00 -6.037597280977045e+00 -5.996219240228155e+00 3.463787876417025e+00 4.701386989628266e+00 9.205447208609179e+03 + 47740 9.781290046482486e-01 -5.858802045848045e+00 -6.006292815599252e+00 4.423884103720174e+00 4.576969279685886e+00 9.236368759384113e+03 + 47760 1.021448729452294e+00 -5.934007018234693e+00 -6.031631580577208e+00 4.034546090227980e+00 4.473970745905062e+00 9.314371657272459e+03 + 47780 9.597579824182658e-01 -5.856581177218993e+00 -6.081676067534707e+00 4.438988435860451e+00 4.146458742345918e+00 9.469470215984624e+03 + 47800 1.019281893528648e+00 -5.965087415347896e+00 -6.028633626030746e+00 3.872464444032479e+00 4.507572268547232e+00 9.305130885341976e+03 + 47820 9.688567097848912e-01 -5.911607154527433e+00 -5.998102735314928e+00 4.155959169191423e+00 4.659288159161753e+00 9.211219221217003e+03 + 47840 9.934748098728130e-01 -5.968960846338255e+00 -6.019629765402802e+00 3.876905925107859e+00 4.585957150849348e+00 9.277397188909807e+03 + 47860 1.049716418809813e+00 -6.077479430334300e+00 -6.029167161685926e+00 3.279726577390448e+00 4.557143100268823e+00 9.306810846017066e+03 + 47880 1.015357014804412e+00 -6.052510404720012e+00 -5.986539127733677e+00 3.447926946424655e+00 4.826744227902307e+00 9.175763938551667e+03 + 47900 9.970165991329032e-01 -6.049293773958754e+00 -5.981726647161199e+00 3.472440737612222e+00 4.860421635662862e+00 9.161026303656457e+03 + 47920 9.043362186140707e-01 -5.932254045547368e+00 -6.034620513277404e+00 4.045817465257281e+00 4.458013366391729e+00 9.323634550516099e+03 + 47940 9.715978377178396e-01 -6.048338942087860e+00 -5.982946268651575e+00 3.447704766459533e+00 4.823199616814192e+00 9.164761530882686e+03 + 47960 1.012887801145155e+00 -6.120270485000437e+00 -5.944972051518166e+00 3.073727275642639e+00 5.080318008042747e+00 9.048889284324729e+03 + 47980 9.069349980077585e-01 -5.967976947518326e+00 -6.022850369407328e+00 3.840870058571364e+00 4.525778378450122e+00 9.287325290350896e+03 + 48000 9.802200638679152e-01 -6.075950455434011e+00 -6.014242719884612e+00 3.255269926908890e+00 4.609605293674756e+00 9.260842836446942e+03 + 48020 1.019676289109958e+00 -6.132297044406452e+00 -5.971609034854695e+00 3.003107961493594e+00 4.925803378728896e+00 9.130103317746771e+03 + 48040 9.307626890877065e-01 -5.994544788054818e+00 -6.020081031423273e+00 3.714582714207531e+00 4.567949653064974e+00 9.278781272431908e+03 + 48060 9.591645664943167e-01 -6.025824978099593e+00 -5.970012214878137e+00 3.568981196009621e+00 4.889466719424417e+00 9.125222133666848e+03 + 48080 9.431422338479717e-01 -5.983030416998596e+00 -6.014045653639080e+00 3.759158117633214e+00 4.581063829251197e+00 9.260210410482972e+03 + 48100 1.017949080721878e+00 -6.064317642964275e+00 -5.994840958967280e+00 3.328708989290573e+00 4.727654860283420e+00 9.201238854310041e+03 + 48120 1.042634456966121e+00 -6.052839824573993e+00 -5.976959029646900e+00 3.407243389260697e+00 4.842962656247128e+00 9.146452461065901e+03 + 48140 9.408577083036700e-01 -5.821211183224125e+00 -6.015427341556861e+00 4.660994036821984e+00 4.545774800822046e+00 9.264465815326656e+03 + 48160 1.030585516462605e+00 -5.865872977161039e+00 -6.067777087701285e+00 4.345352679857655e+00 4.185988032575432e+00 9.426256047023180e+03 + 48180 1.139682932914843e+00 -5.970015017531304e+00 -5.978705624017688e+00 3.859416467103258e+00 4.809513659791436e+00 9.151807002856847e+03 + 48200 1.072191356002077e+00 -5.849974812903472e+00 -6.038610066321944e+00 4.393222717932279e+00 4.310049901592288e+00 9.335963103269078e+03 + 48220 1.078872925780270e+00 -5.855936368367009e+00 -6.049032890073923e+00 4.424049260847038e+00 4.315259151615773e+00 9.368169864033069e+03 + 48240 1.114112736498687e+00 -5.916753758017330e+00 -6.008179187767999e+00 4.158532745584832e+00 4.633553779916965e+00 9.242177451092912e+03 + 48260 1.085934645707828e+00 -5.895101522602380e+00 -6.055661290811640e+00 4.213949819014003e+00 4.291990783412603e+00 9.388687871725870e+03 + 48280 1.031792152914885e+00 -5.844732589181486e+00 -6.040697452584264e+00 4.486564227068834e+00 4.361303655945483e+00 9.342397504992032e+03 + 48300 1.103401396094482e+00 -5.989786610906229e+00 -5.987172349438199e+00 3.729813875412410e+00 4.744825369317494e+00 9.177706875608743e+03 + 48320 1.054332432966434e+00 -5.957918381279505e+00 -5.984491430585625e+00 3.939726721907716e+00 4.787140160625885e+00 9.169476899844631e+03 + 48340 1.015535377382261e+00 -5.937572199674421e+00 -5.999900377501064e+00 4.043704359137872e+00 4.685806316802943e+00 9.216723785746890e+03 + 48360 1.002654139582188e+00 -5.954622882505687e+00 -6.031376537613969e+00 3.967780220100761e+00 4.527048854879260e+00 9.313609187953723e+03 + 48380 1.033057655788855e+00 -6.034832171827000e+00 -6.003961349630051e+00 3.512667270907924e+00 4.689932309207103e+00 9.229192032738181e+03 + 48400 9.733471434508630e-01 -5.976870677864805e+00 -5.973167511658129e+00 3.832692291497569e+00 4.853956444919422e+00 9.134844798083617e+03 + 48420 1.026776532070965e+00 -6.078892048606168e+00 -5.988384919938065e+00 3.248973641850832e+00 4.768679580595971e+00 9.181433617400513e+03 + 48440 9.731082347646042e-01 -6.018209502113998e+00 -5.995583100109060e+00 3.651130300761780e+00 4.781054602498525e+00 9.203475374448963e+03 + 48460 9.615964223609431e-01 -6.017108573009856e+00 -6.005932901661578e+00 3.623726818908322e+00 4.687899253219687e+00 9.235267452319675e+03 + 48480 9.631697477898618e-01 -6.032250137615542e+00 -6.004211363280502e+00 3.540877721749003e+00 4.701880702967109e+00 9.229967592925723e+03 + 48500 9.780881068752744e-01 -6.063567858407954e+00 -5.978014048861581e+00 3.358358249730126e+00 4.849621463554641e+00 9.149676515529101e+03 + 48520 9.534173308651359e-01 -6.030556597427357e+00 -6.004455522500621e+00 3.549595406398676e+00 4.699471817756288e+00 9.230734843158583e+03 + 48540 9.487392879841468e-01 -6.023278130289144e+00 -6.005419689715017e+00 3.654067200383567e+00 4.756613129744949e+00 9.233698690948364e+03 + 48560 9.140006243709936e-01 -5.968274703704282e+00 -6.031956717918466e+00 3.892636711452368e+00 4.526964731074670e+00 9.315416861527508e+03 + 48580 1.018747999182326e+00 -6.116064409438147e+00 -5.986152939765185e+00 3.146709469690728e+00 4.892681232287837e+00 9.174608827126467e+03 + 48600 9.692345149179286e-01 -6.029161728581490e+00 -6.020304006172298e+00 3.561992458460034e+00 4.612854871261733e+00 9.279490070758904e+03 + 48620 9.448235242678893e-01 -5.977201698153387e+00 -6.010767026289907e+00 3.833615483895861e+00 4.640878175518219e+00 9.250116336716439e+03 + 48640 9.709584392157622e-01 -5.994070234062184e+00 -5.994748288496804e+00 3.719183715916007e+00 4.715290222423834e+00 9.200925243190643e+03 + 48660 1.011455341634459e+00 -6.024137007239858e+00 -5.972360033007915e+00 3.576366460977876e+00 4.873677859478561e+00 9.132407540970195e+03 + 48680 1.049542287562041e+00 -6.046544659943481e+00 -6.022896800844131e+00 3.438906803799227e+00 4.574696470242065e+00 9.287468639337689e+03 + 48700 1.018097753043231e+00 -5.968165557371307e+00 -5.990618102568760e+00 3.817441808485307e+00 4.688515819441395e+00 9.188270282457133e+03 + 48720 1.005127079261219e+00 -5.918821708936687e+00 -6.002302857493188e+00 4.094454937858867e+00 4.615093264181448e+00 9.224132191875873e+03 + 48740 1.111683962178856e+00 -6.048451344368667e+00 -5.972018029516452e+00 3.468882594903976e+00 4.907774516802645e+00 9.131363705013911e+03 + 48760 1.100551782574782e+00 -6.010621432116328e+00 -6.031499697091800e+00 3.626918876648790e+00 4.507032648258567e+00 9.314015380052400e+03 + 48780 1.024850020859685e+00 -5.885985841417209e+00 -6.053755409938208e+00 4.368394989048728e+00 4.405036164344327e+00 9.382794820766820e+03 + 48800 1.038986612965877e+00 -5.905658645886709e+00 -6.083158880918434e+00 4.134813515321957e+00 4.115579697697194e+00 9.474080432669640e+03 + 48820 1.065642094635793e+00 -5.950639225197349e+00 -6.045418509988269e+00 3.956916960731101e+00 4.412679640414722e+00 9.356960206620961e+03 + 48840 1.088593118493099e+00 -5.995250459161168e+00 -6.030081589277753e+00 3.681708920399130e+00 4.481703181169735e+00 9.309647072265925e+03 + 48860 1.071772352166674e+00 -5.991095504085848e+00 -6.024926264347941e+00 3.786491533309456e+00 4.592230072591290e+00 9.293720155024484e+03 + 48880 1.001595232113722e+00 -5.915372324625001e+00 -6.003595410325644e+00 4.156808974756324e+00 4.650218364184844e+00 9.228094773860739e+03 + 48900 9.522522171856076e-01 -5.875696612227006e+00 -6.020114959600915e+00 4.382311418324385e+00 4.553038919036372e+00 9.278891324245807e+03 + 48920 9.892203865307139e-01 -5.963034533138735e+00 -6.031248344429786e+00 3.892616992295109e+00 4.500922731808715e+00 9.313229801493380e+03 + 48940 1.014970859695119e+00 -6.033679494980607e+00 -6.019187502582506e+00 3.472444007213311e+00 4.555659270191786e+00 9.276062173261718e+03 + 48960 9.523003962799221e-01 -5.969466204279728e+00 -5.994394434848235e+00 3.923392046465469e+00 4.780250288909890e+00 9.199860701688054e+03 + 48980 9.871827717184365e-01 -6.041295292798919e+00 -6.010701557225357e+00 3.439229341836943e+00 4.614903305865623e+00 9.249936703594944e+03 + 49000 1.005408577802902e+00 -6.079704183843540e+00 -6.001204375754503e+00 3.289124286455544e+00 4.739882332308837e+00 9.220755673066991e+03 + 49020 9.646997179670587e-01 -6.024868802079363e+00 -6.013272912165401e+00 3.592445446442863e+00 4.659030840787002e+00 9.257848098872293e+03 + 49040 1.063414115325231e+00 -6.171582997403231e+00 -5.992613837430204e+00 2.737161646098397e+00 4.764830258051518e+00 9.194397139995641e+03 + 49060 9.272678602195490e-01 -5.967719936118869e+00 -6.011031254582509e+00 3.879293731123520e+00 4.630593438100433e+00 9.250943378711341e+03 + 49080 9.768093290486305e-01 -6.037914629294730e+00 -5.983923268993870e+00 3.548875242848396e+00 4.858901988831940e+00 9.167750113379392e+03 + 49100 9.674611881450518e-01 -6.018260586084838e+00 -5.970667012711619e+00 3.594100035824495e+00 4.867389699215193e+00 9.127223885654030e+03 + 49120 9.747882291705945e-01 -6.019686567967014e+00 -5.996577846526719e+00 3.578410102716620e+00 4.711103957289883e+00 9.206563200482971e+03 + 49140 1.021847620355163e+00 -6.076433005376655e+00 -6.007752432520269e+00 3.251920132023790e+00 4.646294609649459e+00 9.240876710196428e+03 + 49160 9.400928245145591e-01 -5.940175489823420e+00 -6.030113493139533e+00 3.967202456377268e+00 4.450764523475116e+00 9.309753345281018e+03 + 49180 9.838042027639273e-01 -5.990040666382249e+00 -6.010533748769880e+00 3.719286966791073e+00 4.601612516427052e+00 9.249445610969804e+03 + 49200 9.882322946811980e-01 -5.982494338435917e+00 -6.010296868804792e+00 3.784337917287297e+00 4.624691485481544e+00 9.248691904699102e+03 + 49220 9.631025896087370e-01 -5.928152732037622e+00 -6.060650908382201e+00 4.025298882660586e+00 4.264473850063490e+00 9.404181969978032e+03 + 49240 1.026215513593853e+00 -6.004541483379546e+00 -6.026062039176782e+00 3.679554182329038e+00 4.555979820646058e+00 9.297242740626350e+03 + 49260 1.030853008640274e+00 -5.995246156069519e+00 -6.032290463483811e+00 3.761312004244114e+00 4.548597858483204e+00 9.316429978721832e+03 + 49280 9.761273331256058e-01 -5.901852527982892e+00 -6.042341252303732e+00 4.182307804325788e+00 4.375599808715698e+00 9.347501731213661e+03 + 49300 1.044738314500833e+00 -5.993198292501122e+00 -5.973005401185380e+00 3.770816816853895e+00 4.886767523628722e+00 9.134347942879691e+03 + 49320 1.019364009519541e+00 -5.946026377045889e+00 -6.008861007014701e+00 3.970872129589444e+00 4.610065960680968e+00 9.244245690602624e+03 + 49340 1.065228019032234e+00 -6.005690111766587e+00 -5.967890204904438e+00 3.672959995219149e+00 4.890012909938289e+00 9.118752441800440e+03 + 49360 1.039341815884592e+00 -5.959783951023377e+00 -5.995329881733830e+00 3.910604444755188e+00 4.706494209900767e+00 9.202719247829560e+03 + 49380 1.063173117837755e+00 -5.989948140148889e+00 -6.041765707599088e+00 3.687429707297512e+00 4.389885216255821e+00 9.345699373890020e+03 + 49400 1.011988625905621e+00 -5.914486105747187e+00 -6.002360311039925e+00 4.161084859835595e+00 4.656497574555375e+00 9.224287694166540e+03 + 49420 1.065170747685042e+00 -5.999039876668198e+00 -5.965824865844365e+00 3.709297137595300e+00 4.900022869752068e+00 9.112432854331237e+03 + 49440 1.051669161450359e+00 -5.989467448667519e+00 -6.002690577040401e+00 3.734014898632972e+00 4.658085649243381e+00 9.225313680776328e+03 + 49460 1.043186952203883e+00 -5.995735806172373e+00 -6.029158904403056e+00 3.651367428821360e+00 4.459446826573044e+00 9.306778235083257e+03 + 49480 9.704208216590099e-01 -5.916310893504618e+00 -6.022696254441475e+00 4.149428478466396e+00 4.538547272885565e+00 9.286863933818331e+03 + 49500 9.846691602425099e-01 -5.972460889498598e+00 -6.006725407232146e+00 3.825144789502567e+00 4.628392626259555e+00 9.237714299610238e+03 + 49520 9.830162561994052e-01 -6.007515617761664e+00 -6.061518076295020e+00 3.560291514611001e+00 4.250201040859021e+00 9.406884618180440e+03 + 49540 9.563193122460731e-01 -6.006102979413655e+00 -5.987977305961195e+00 3.677766958287668e+00 4.781847380190596e+00 9.180199549324425e+03 + 49560 9.496843337182070e-01 -6.027197903720966e+00 -5.975649473910049e+00 3.570315476110371e+00 4.866314537178387e+00 9.142442040141437e+03 + 49580 9.905523653144579e-01 -6.108880474928243e+00 -5.964001413944545e+00 3.142663077733176e+00 4.974581065863802e+00 9.106854807614136e+03 + 49600 9.948488223490037e-01 -6.129629717418061e+00 -5.968804332848658e+00 3.016203035934646e+00 4.939687281779984e+00 9.121534201421306e+03 + 49620 9.824913379715953e-01 -6.119542933140023e+00 -5.987048447909253e+00 3.037605458445725e+00 4.798409296096132e+00 9.177358193547325e+03 + 49640 9.402803569188763e-01 -6.059879871058753e+00 -6.012439454201580e+00 3.345578458356621e+00 4.617988673331291e+00 9.255291549559355e+03 + 49660 9.357193007933300e-01 -6.051918842896614e+00 -5.962520523254814e+00 3.458720741328510e+00 4.972059727056982e+00 9.102359286802923e+03 + 49680 9.869178361013634e-01 -6.117773300507631e+00 -5.994343881559730e+00 3.075588790352731e+00 4.784339614592431e+00 9.199707659316986e+03 + 49700 9.471771613811811e-01 -6.044115934185584e+00 -5.975071660282525e+00 3.543726821932316e+00 4.940189727250530e+00 9.140657798228658e+03 + 49720 8.845688482930033e-01 -5.929610318326787e+00 -5.997010519989712e+00 4.078326032908327e+00 4.691303644812318e+00 9.207847107290261e+03 + 49740 1.034285742870357e+00 -6.120598335403827e+00 -5.933503796486266e+00 3.130836824319832e+00 5.205162619570791e+00 9.014037500406581e+03 + 49760 1.014923792631830e+00 -6.052656543478963e+00 -6.037048587195011e+00 3.414086389622610e+00 4.503709689928494e+00 9.331130138216462e+03 + 49780 1.028580829600424e+00 -6.037546398557192e+00 -6.013982221086176e+00 3.481697487037759e+00 4.617006640621010e+00 9.260035704968246e+03 + 49800 9.918987547662945e-01 -5.951652863996735e+00 -6.025406607469065e+00 3.984074982151195e+00 4.560569573778159e+00 9.295206033565137e+03 + 49820 9.649368419862987e-01 -5.887456547210538e+00 -6.049334921231297e+00 4.312110963005241e+00 4.382580288780630e+00 9.369103993224971e+03 + 49840 1.039319870474989e+00 -5.982552057062671e+00 -6.016575415731664e+00 3.818345183679530e+00 4.622977793104435e+00 9.267984283474150e+03 + 49860 1.019469996128546e+00 -5.946549854149473e+00 -5.996088098929134e+00 3.936241522297452e+00 4.651785254754035e+00 9.205038957284776e+03 + 49880 1.002828677524869e+00 -5.918236362888348e+00 -5.983446595432111e+00 4.158497632741261e+00 4.784050386224103e+00 9.166280693043114e+03 + 49900 1.017580672109399e+00 -5.938879381847934e+00 -5.983775448277921e+00 4.008123497535477e+00 4.750323336450666e+00 9.167285780683491e+03 + 49920 1.043722065121099e+00 -5.978297640544159e+00 -5.977490124566501e+00 3.873178167412284e+00 4.877815049118693e+00 9.148068505029394e+03 + 49940 1.055274561657066e+00 -5.999348038846908e+00 -6.010039087432594e+00 3.669275844117397e+00 4.607886188703972e+00 9.247903131288473e+03 + 49960 1.053223385952575e+00 -6.005283149089586e+00 -5.980163485038802e+00 3.649200437503405e+00 4.793441435738456e+00 9.156250672098911e+03 + 49980 1.036636083373875e+00 -5.990016091464960e+00 -5.968394003875577e+00 3.777478940083470e+00 4.901636313028949e+00 9.120268941147277e+03 + 50000 9.347809848277790e-01 -5.848348956788850e+00 -6.033723907284978e+00 4.481469906841286e+00 4.417018254411643e+00 9.320835921824397e+03 + 50020 1.048042142643880e+00 -6.027074600230936e+00 -5.948231713866965e+00 3.569671727389160e+00 5.022399781788312e+00 9.058796258268056e+03 + 50040 1.010882377579863e+00 -5.981403984413469e+00 -5.978673967917296e+00 3.765968972855084e+00 4.781645150044795e+00 9.151681005690358e+03 + 50060 9.628503024032478e-01 -5.921213832272064e+00 -6.012814447754034e+00 4.088254949554337e+00 4.562270040307435e+00 9.256409066572216e+03 + 50080 1.010223339509348e+00 -6.002484855528738e+00 -5.985398527731820e+00 3.687855869811480e+00 4.785968208122068e+00 9.172254751634498e+03 + 50100 1.001030790155916e+00 -6.001879219812774e+00 -5.979512858175347e+00 3.669126864370451e+00 4.797557974075836e+00 9.154237247691854e+03 + 50120 9.728502085737065e-01 -5.972406445479762e+00 -5.997108210553504e+00 3.814461116433904e+00 4.672619758794681e+00 9.208127962122860e+03 + 50140 9.603116292019739e-01 -5.966482129366100e+00 -5.981868989248910e+00 3.872450464049140e+00 4.784096733493175e+00 9.161468216480474e+03 + 50160 1.029386271117250e+00 -6.080345801056568e+00 -5.975217590065412e+00 3.276575011392812e+00 4.880237467442100e+00 9.141139378609003e+03 + 50180 9.916519387234235e-01 -6.038637136080856e+00 -6.019009158140265e+00 3.460111635805110e+00 4.572818522559757e+00 9.275504784305849e+03 + 50200 9.270338004349133e-01 -5.962580219456789e+00 -6.030402319547695e+00 3.815619853236619e+00 4.426174859078568e+00 9.310618299750673e+03 + 50220 9.772307223112187e-01 -6.061019967596733e+00 -5.998164756649634e+00 3.371590818341882e+00 4.732515166412587e+00 9.211408895894268e+03 + 50240 9.113991201335150e-01 -5.992614515377489e+00 -6.012670097272196e+00 3.705614733838208e+00 4.590452479007527e+00 9.256000499062413e+03 + 50260 9.469536417090276e-01 -6.079117499633528e+00 -5.999036126248356e+00 3.247634500973351e+00 4.707474139503494e+00 9.214091720683818e+03 + 50280 9.947909829129837e-01 -6.182945133191103e+00 -5.960842997103935e+00 2.741104279764050e+00 5.016449115371047e+00 9.097253717556239e+03 + 50300 9.444270115102688e-01 -6.138822663369643e+00 -5.972223501829921e+00 2.963687745957625e+00 4.920325912655633e+00 9.132010053989628e+03 + 50320 9.467215890815247e-01 -6.165152545747036e+00 -5.969149766839883e+00 2.829630942969079e+00 4.955109230785963e+00 9.122606514505844e+03 + 50340 8.884683631481608e-01 -6.093373377640092e+00 -5.960204716384486e+00 3.216048048805449e+00 4.980723109518870e+00 9.095308242407968e+03 + 50360 9.354639546879521e-01 -6.167437301137475e+00 -5.955414411845856e+00 2.823279159329291e+00 5.040747400077841e+00 9.080688717986763e+03 + 50380 9.200394577070150e-01 -6.138712224708702e+00 -5.972950089405519e+00 2.897430002605848e+00 4.849261835124262e+00 9.134207284956599e+03 + 50400 8.877300132711061e-01 -6.073906430188877e+00 -5.996251543417921e+00 3.308574975440318e+00 4.754481352334034e+00 9.205537301505667e+03 + 50420 9.766528264332138e-01 -6.174564377184337e+00 -6.018075687715577e+00 2.697370669110385e+00 4.595952940586443e+00 9.272634128519585e+03 + 50440 9.367383906562713e-01 -6.073439602714039e+00 -6.009370139880023e+00 3.350359741294610e+00 4.718256511604864e+00 9.245839875080566e+03 + 50460 1.016296505323768e+00 -6.144219573501404e+00 -6.004724122993658e+00 2.917777535141496e+00 4.718781998808172e+00 9.231562184673910e+03 + 50480 9.779204020810265e-01 -6.047345913998645e+00 -6.000794821385687e+00 3.465381575437741e+00 4.732685152979649e+00 9.219480161314723e+03 + 50500 9.932387072138371e-01 -6.041047351547241e+00 -5.964855662594410e+00 3.473517260779823e+00 4.911021729372735e+00 9.109465779788108e+03 + 50520 9.598239489220848e-01 -5.967993160364544e+00 -5.993271187034201e+00 3.852080507885196e+00 4.706930166986039e+00 9.196381278041974e+03 + 50540 9.919356155580373e-01 -5.997569545982326e+00 -5.963915070483893e+00 3.742363477393493e+00 4.935612683718741e+00 9.106596916839404e+03 + 50560 9.914927702750076e-01 -5.981534594532715e+00 -6.001302687568809e+00 3.796533506255475e+00 4.683022056939716e+00 9.221018954930403e+03 + 50580 9.982174594185610e-01 -5.979366865785390e+00 -5.986172076819497e+00 3.857482124237686e+00 4.818405549376838e+00 9.174530781267473e+03 + 50600 9.926025508454089e-01 -5.959970561475489e+00 -6.022797143781956e+00 3.849287751892840e+00 4.488527793906915e+00 9.287142927246781e+03 + 50620 9.804371044233543e-01 -5.932814417656726e+00 -5.981051104687015e+00 4.048096536587424e+00 4.771114015056305e+00 9.158954381747775e+03 + 50640 9.855910480561910e-01 -5.931708444238303e+00 -5.997701873332740e+00 4.047750158614251e+00 4.668805676303854e+00 9.209966582243898e+03 + 50660 1.003115410399010e+00 -5.949290560859173e+00 -5.996972927367745e+00 3.963276729286906e+00 4.689477201972318e+00 9.207740965030876e+03 + 50680 1.054054797389577e+00 -6.018796428655352e+00 -5.948621286531692e+00 3.647487548112994e+00 5.050444073755195e+00 9.059995375574263e+03 + 50700 1.024246155194408e+00 -5.969916257774501e+00 -6.008902537671252e+00 3.888918811269142e+00 4.665053558994677e+00 9.244370355984600e+03 + 50720 1.059345644717179e+00 -6.019978664659551e+00 -5.930033198097449e+00 3.666262659011285e+00 5.182743447026842e+00 9.003496197036568e+03 + 50740 1.033285188610389e+00 -5.979641565786328e+00 -6.017426513388751e+00 3.702128324705009e+00 4.485161308370151e+00 9.270621202637658e+03 + 50760 1.026365032062761e+00 -5.969388456763151e+00 -5.993536230824522e+00 3.859696151959576e+00 4.721035896443227e+00 9.197229479995653e+03 + 50780 1.034164795388583e+00 -5.986802164927403e+00 -6.003609126346675e+00 3.758525435160444e+00 4.662017261822109e+00 9.228107331114728e+03 + 50800 9.724304132940095e-01 -5.905810767781840e+00 -5.999597888521965e+00 4.159561518712751e+00 4.621021357912925e+00 9.215807262960543e+03 + 50820 9.742110337787011e-01 -5.923625822752065e+00 -5.993044201855982e+00 4.111304282544733e+00 4.712693207270596e+00 9.195688263539105e+03 + 50840 1.016522934943721e+00 -6.005333403402849e+00 -5.997220702411089e+00 3.669067610973946e+00 4.715651995505054e+00 9.208517474534847e+03 + 50860 9.855986051312848e-01 -5.984671633611327e+00 -6.032489785996475e+00 3.770667263086021e+00 4.496088032255339e+00 9.317032321046712e+03 + 50880 9.818174041362580e-01 -6.009441543384095e+00 -6.028771018671472e+00 3.649519746773015e+00 4.538526908446260e+00 9.305572422411053e+03 + 50900 9.265598581227038e-01 -5.962208828111066e+00 -6.040849443679447e+00 3.860000552682661e+00 4.408433968493095e+00 9.342854572039438e+03 + 50920 9.838843325524833e-01 -6.080871460471497e+00 -5.987458629093135e+00 3.278981636890721e+00 4.815372570254209e+00 9.178593232183581e+03 + 50940 9.329269729867284e-01 -6.034508528755980e+00 -6.037082921968420e+00 3.443293876610036e+00 4.428511312398145e+00 9.331255283737177e+03 + 50960 9.837277722685468e-01 -6.133371526563404e+00 -5.996071267855140e+00 3.000699604108495e+00 4.789098936757714e+00 9.204999426843136e+03 + 50980 8.702854982158668e-01 -5.981775451855867e+00 -6.060146978459880e+00 3.777657461830151e+00 4.327636028115366e+00 9.402614208273910e+03 + 51000 9.303081706730552e-01 -6.081232189657023e+00 -5.989764867404089e+00 3.324619873666510e+00 4.849839392565235e+00 9.185656808821976e+03 + 51020 9.362062832949892e-01 -6.094201533224385e+00 -5.994795858784208e+00 3.142074241480663e+00 4.712877007094562e+00 9.201079260013401e+03 + 51040 8.916724519068148e-01 -6.023573367327862e+00 -5.991655183484181e+00 3.585614088628065e+00 4.768893239581466e+00 9.191451222172351e+03 + 51060 9.496049770041730e-01 -6.095008359988786e+00 -5.991024599229093e+00 3.215032615465062e+00 4.812123461182193e+00 9.189516493543077e+03 + 51080 9.619916911226388e-01 -6.090569294193849e+00 -5.977867331693296e+00 3.173839925741933e+00 4.820992034992443e+00 9.149226195549452e+03 + 51100 9.658689906463416e-01 -6.064901932694718e+00 -5.972304744806273e+00 3.371965645125561e+00 4.903673027349527e+00 9.132206230068714e+03 + 51120 9.046054585225609e-01 -5.931771938116999e+00 -5.991746600862268e+00 4.094039390014879e+00 4.749655595482483e+00 9.191705148152854e+03 + 51140 9.704872552337590e-01 -5.981210451993307e+00 -6.024449021869296e+00 3.843386754803953e+00 4.595104195428959e+00 9.292240537702499e+03 + 51160 1.056813943904141e+00 -6.069305609638939e+00 -5.945723842710056e+00 3.393456172336288e+00 5.103081802258558e+00 9.051173173418034e+03 + 51180 1.000936629768517e+00 -5.958944049570591e+00 -6.013813275098727e+00 3.910008724303332e+00 4.594941140335565e+00 9.259489118274239e+03 + 51200 1.076942797090729e+00 -6.056011617741278e+00 -5.965345796768132e+00 3.422183047183304e+00 4.942800221701567e+00 9.110967684296853e+03 + 51220 1.001952029979790e+00 -5.936437209989361e+00 -6.015231062650301e+00 4.022384837293339e+00 4.569938342004929e+00 9.263845047357210e+03 + 51240 1.009760259942262e+00 -5.944456743464603e+00 -6.004084448473741e+00 4.028100334402474e+00 4.685708824882480e+00 9.229545729503996e+03 + 51260 1.041214657757352e+00 -5.989762400399491e+00 -5.996717450140490e+00 3.789934647964235e+00 4.749997676060953e+00 9.206963830070823e+03 + 51280 9.873780543116208e-01 -5.912741161960450e+00 -5.985079689066913e+00 4.179353597853135e+00 4.763974580856937e+00 9.171288347258091e+03 + 51300 9.458221571843548e-01 -5.853779710132804e+00 -5.997559365352577e+00 4.508777349786932e+00 4.683172319685257e+00 9.209552678828681e+03 + 51320 9.819913962944069e-01 -5.911708223714713e+00 -6.001413967189768e+00 4.182449487543105e+00 4.667345226590403e+00 9.221385642385763e+03 + 51340 1.011379443511577e+00 -5.960385247248838e+00 -5.990296655882952e+00 3.918690910411009e+00 4.746934973258399e+00 9.187284884095849e+03 + 51360 1.072304499396025e+00 -6.059768862924918e+00 -5.973504851488315e+00 3.372341523386148e+00 4.867682826367751e+00 9.135904468082566e+03 + 51380 1.009567364433845e+00 -5.979075618233754e+00 -6.016322092095097e+00 3.810734851105227e+00 4.596859834320194e+00 9.267195268590232e+03 + 51400 9.758340396241678e-01 -5.942925286669498e+00 -5.984994678059278e+00 4.071550838741338e+00 4.829981883163944e+00 9.171026010426125e+03 + 51420 9.995822326524497e-01 -5.993505503160767e+00 -6.003904430537700e+00 3.719813360193166e+00 4.660101109966003e+00 9.229039047119042e+03 + 51440 9.301334440437113e-01 -5.907991783603136e+00 -6.040033829323480e+00 4.174542386200208e+00 4.416336526233454e+00 9.340323695294672e+03 + 51460 9.538107309061349e-01 -5.962955583773232e+00 -6.000556628319814e+00 3.878656771273245e+00 4.662745754743936e+00 9.218689658912770e+03 + 51480 9.471465747023062e-01 -5.970918029893483e+00 -5.959029695731681e+00 3.882079184794659e+00 4.950343839265495e+00 9.091691857314732e+03 + 51500 9.490321868955238e-01 -5.989309161411400e+00 -6.015989186165962e+00 3.791552111155077e+00 4.638351280293898e+00 9.266193508301110e+03 + 51520 9.535641696492776e-01 -6.011809454547708e+00 -6.027959787965264e+00 3.604144974948812e+00 4.511407261209192e+00 9.303107696895384e+03 + 51540 1.005071032913334e+00 -6.105500555478793e+00 -6.032883225040666e+00 3.147533872937250e+00 4.564513821808542e+00 9.318274688095309e+03 + 51560 9.380748835465266e-01 -6.025870830866712e+00 -5.989247335313960e+00 3.537476557505350e+00 4.747774336436866e+00 9.184075832812823e+03 + 51580 9.259592934249862e-01 -6.026089046347916e+00 -6.016283967517524e+00 3.551921430671273e+00 4.608223710646426e+00 9.267093792332176e+03 + 51600 9.147637762751668e-01 -6.026768696214934e+00 -5.988134491832954e+00 3.598123864851806e+00 4.819967445036944e+00 9.180673772076632e+03 + 51620 9.870478551098852e-01 -6.148591727285904e+00 -5.980150487319964e+00 2.899391151860252e+00 4.866606817942323e+00 9.156224908340382e+03 + 51640 8.982848445049423e-01 -6.028480720906710e+00 -6.003435455185428e+00 3.576760548170372e+00 4.720574339684317e+00 9.227592642900363e+03 + 51660 9.743162099801198e-01 -6.147056358201722e+00 -5.967176388004423e+00 2.937969170891938e+00 4.970867796100254e+00 9.116570496834482e+03 + 51680 9.065447238652278e-01 -6.046621842401782e+00 -6.044849384456986e+00 3.482974886166088e+00 4.493152613972086e+00 9.355225788010583e+03 + 51700 9.252719405794706e-01 -6.066727533320868e+00 -6.007182571070153e+00 3.356108654160840e+00 4.698025041957573e+00 9.239126641171921e+03 + 51720 9.154243715009501e-01 -6.035377344101134e+00 -6.044691088574472e+00 3.479945081909376e+00 4.426464119846168e+00 9.354753219253567e+03 + 51740 9.560427940661892e-01 -6.069065215884385e+00 -5.976734227988724e+00 3.336016496016396e+00 4.866195316687483e+00 9.145765978635041e+03 + 51760 9.346537403776455e-01 -5.997849578075826e+00 -6.000120622853693e+00 3.746846751005250e+00 4.733806060447694e+00 9.217406971760780e+03 + 51780 1.008562057280396e+00 -6.064088041047438e+00 -5.949124649880481e+00 3.370607132802836e+00 5.030744715410787e+00 9.061529847140102e+03 + 51800 1.015131164922165e+00 -6.030699638438955e+00 -5.963740228703680e+00 3.518871968992393e+00 4.903363261627513e+00 9.106032651749667e+03 + 51820 1.007063507540216e+00 -5.980932020272008e+00 -5.985570945107920e+00 3.730144171719611e+00 4.703506747440505e+00 9.172800647356073e+03 + 51840 1.027943325767666e+00 -5.982298529524112e+00 -6.005240055729294e+00 3.778483857861036e+00 4.646750064201173e+00 9.233143568023681e+03 + 51860 1.026476534990275e+00 -5.959518428509644e+00 -6.046258826899614e+00 3.874383585628508e+00 4.376306795040033e+00 9.359587227077636e+03 + 51880 1.052284957712779e+00 -5.985500434120616e+00 -5.983253124512844e+00 3.805377306000628e+00 4.818281705538494e+00 9.165712052839463e+03 + 51900 1.045666458477144e+00 -5.968220015717245e+00 -5.999227351851104e+00 3.870046032849890e+00 4.691997110399514e+00 9.214666312535022e+03 + 51920 1.046688056766279e+00 -5.967247812089924e+00 -6.022051925049804e+00 3.890709504236362e+00 4.576015806711657e+00 9.284857125085031e+03 + 51940 9.855932020874038e-01 -5.879925685450293e+00 -6.050061835027734e+00 4.307405859285987e+00 4.330457759928261e+00 9.371369888927360e+03 + 51960 1.110355275138234e+00 -6.071909511313173e+00 -5.987444286967867e+00 3.304976512023054e+00 4.789988901165024e+00 9.178564225228083e+03 + 51980 9.929521519905856e-01 -5.910473081707128e+00 -6.020697101072803e+00 4.160731333014965e+00 4.527807956705388e+00 9.280670102762710e+03 + 52000 1.008408035924027e+00 -5.950135202123340e+00 -6.039454031686636e+00 3.910558942152007e+00 4.397676400755358e+00 9.338521010698263e+03 + 52020 9.650096050577709e-01 -5.906788417566562e+00 -5.997993144246366e+00 4.205739054970559e+00 4.682027400489286e+00 9.210882852758918e+03 + 52040 1.022933414540078e+00 -6.014578286283375e+00 -5.963866836575396e+00 3.612485947212137e+00 4.903678939006832e+00 9.106455099707433e+03 + 52060 1.006202595740163e+00 -6.012249866807991e+00 -6.011214842072961e+00 3.575835348497304e+00 4.581778620695411e+00 9.251525328875889e+03 + 52080 1.052417697164816e+00 -6.107534096237893e+00 -5.996008313858428e+00 3.089946653128287e+00 4.730344954110221e+00 9.204817581149982e+03 + 52100 9.431680840612089e-01 -5.977941204102937e+00 -6.023459131354882e+00 3.823355159989752e+00 4.561984177832610e+00 9.289194471499681e+03 + 52120 9.659619327480997e-01 -6.040284890910605e+00 -5.973514128472051e+00 3.472215774673018e+00 4.855623825337283e+00 9.135919492612627e+03 + 52140 9.308807677781163e-01 -6.011977845369612e+00 -5.970509228467302e+00 3.582762387161297e+00 4.820881602662089e+00 9.126732443230156e+03 + 52160 9.071861400048858e-01 -5.993126500493627e+00 -5.952020985588605e+00 3.735003116506627e+00 4.971037344149133e+00 9.070345152608201e+03 + 52180 9.653304313496931e-01 -6.088875063270415e+00 -5.969421063264388e+00 3.191642640839530e+00 4.877565994320890e+00 9.123404892128525e+03 + 52200 9.164479643663841e-01 -6.020947804289304e+00 -6.026905995779346e+00 3.551747887317327e+00 4.517535029754352e+00 9.299831728682744e+03 + 52220 9.297632623658564e-01 -6.040706533150455e+00 -5.978767466085873e+00 3.483262439655498e+00 4.838926147779983e+00 9.151988193854344e+03 + 52240 9.402843507872609e-01 -6.049955312177967e+00 -5.957535012511811e+00 3.459884846562414e+00 4.990576509240629e+00 9.087133281453420e+03 + 52260 9.295722169973417e-01 -6.013645720742579e+00 -5.990555231031236e+00 3.596533569943698e+00 4.729122735107968e+00 9.188084563107286e+03 + 52280 9.903536822885919e-01 -6.059673795152221e+00 -6.013065422301480e+00 3.325546476652243e+00 4.593178966183586e+00 9.257212874981069e+03 + 52300 1.019880398791717e+00 -6.041306430727134e+00 -5.970509573751407e+00 3.526460617785359e+00 4.932987126318192e+00 9.126733210775525e+03 + 52320 1.007240931584947e+00 -5.955597470598349e+00 -6.010101335371619e+00 3.887351002256649e+00 4.574381376282718e+00 9.248102214581102e+03 + 52340 1.023622438577219e+00 -5.928661719555032e+00 -6.026252365879883e+00 4.048652284205052e+00 4.488271690904042e+00 9.297833266251941e+03 + 52360 1.046798246009373e+00 -5.932724098997346e+00 -6.035898569657915e+00 4.006224157428909e+00 4.413780380698188e+00 9.327588143881630e+03 + 52380 1.106596386733531e+00 -6.005649720883485e+00 -5.981900185259828e+00 3.666676053337945e+00 4.803049562117743e+00 9.161585955208917e+03 + 52400 1.036506603730997e+00 -5.895470860335545e+00 -6.058068686167688e+00 4.199426067612437e+00 4.265764189752043e+00 9.396148971152239e+03 + 52420 1.076991826339070e+00 -5.958568191142979e+00 -5.968495784482372e+00 3.936968372984319e+00 4.879962595739419e+00 9.120600012704457e+03 + 52440 1.062932242835895e+00 -5.946009167806302e+00 -6.006278935124068e+00 3.948052527332568e+00 4.601974196677610e+00 9.236339494235986e+03 + 52460 1.070917419718506e+00 -5.973098800307517e+00 -5.983105168000568e+00 3.848088797899381e+00 4.790630686125487e+00 9.165254845568827e+03 + 52480 9.736384904994325e-01 -5.849949329320849e+00 -6.009789441181217e+00 4.444748850110064e+00 4.526922192630459e+00 9.247105651436716e+03 + 52500 1.063873915301763e+00 -6.007793601078929e+00 -5.956701757883597e+00 3.656532458801290e+00 4.949909728866066e+00 9.084517922688878e+03 + 52520 1.065780977131344e+00 -6.035156426614756e+00 -5.971497263413688e+00 3.496073457040874e+00 4.861614223365068e+00 9.129761107981814e+03 + 52540 9.788905514271805e-01 -5.934515972533159e+00 -6.028120656718690e+00 4.029671650583085e+00 4.492179068711709e+00 9.303583080173354e+03 + 52560 1.017888607173856e+00 -6.019728414652999e+00 -5.992547740530533e+00 3.639922759937061e+00 4.795998396943984e+00 9.194164078348520e+03 + 52580 9.735498260878793e-01 -5.982062076866749e+00 -6.007894704482911e+00 3.714935411829019e+00 4.566600466470815e+00 9.241313485180091e+03 + 52600 1.025871500414417e+00 -6.082466558518600e+00 -5.950172431019364e+00 3.278024905395235e+00 5.037678257945911e+00 9.064718418318713e+03 + 52620 9.754376729899238e-01 -6.025142988036771e+00 -5.993717291120018e+00 3.618541631043576e+00 4.798992845850453e+00 9.197780340024152e+03 + 52640 9.481246097829640e-01 -5.999243319143893e+00 -6.045235297331171e+00 3.672496373965805e+00 4.408403317978836e+00 9.356447485059593e+03 + 52660 1.001975454221739e+00 -6.091639522441146e+00 -5.989956357705017e+00 3.240559257147956e+00 4.824439724481699e+00 9.186247976451472e+03 + 52680 9.329808847849286e-01 -5.997763162984405e+00 -6.036817060109509e+00 3.688638817209709e+00 4.464385296346315e+00 9.330397447026453e+03 + 52700 9.142057337974470e-01 -5.973639329139375e+00 -6.014037663004262e+00 3.826043391418043e+00 4.594069906743899e+00 9.260208075779587e+03 + 52720 9.490040564353914e-01 -6.024229581351186e+00 -6.016592591296121e+00 3.490902002055461e+00 4.534754780772039e+00 9.268070123068326e+03 + 52740 1.001085698040597e+00 -6.095797009360768e+00 -6.000593426606239e+00 3.177299797692559e+00 4.723973502575886e+00 9.218891563568488e+03 + 52760 1.011231922447134e+00 -6.101593962210096e+00 -5.987306713874187e+00 3.160567663288969e+00 4.816822729128283e+00 9.178127830153120e+03 + 52780 9.329168122251138e-01 -5.972932811588024e+00 -5.959177213568859e+00 3.849697371975708e+00 4.928684144473662e+00 9.092163439538352e+03 + 52800 9.833136632247781e-01 -6.024374575036149e+00 -5.993717337286055e+00 3.543040194335394e+00 4.719078797688642e+00 9.197756060186164e+03 + 52820 9.924891576511857e-01 -6.001133170360404e+00 -5.975010092147766e+00 3.717414632300875e+00 4.867417389931134e+00 9.140483081146873e+03 + 52840 1.025028437966833e+00 -5.995004407447468e+00 -5.985953831873790e+00 3.696509464457718e+00 4.748479269973822e+00 9.173971626106906e+03 + 52860 9.786745177733325e-01 -5.866570465648356e+00 -6.029338951070430e+00 4.386956182581171e+00 4.452314350945906e+00 9.307294431352690e+03 + 52880 1.061703689307365e+00 -5.936875268461118e+00 -6.001814782766835e+00 3.990919317750786e+00 4.618026577250000e+00 9.222594596798250e+03 + 52900 1.091442686073946e+00 -5.947022164560953e+00 -5.975296121149489e+00 3.963534227981891e+00 4.801180793869876e+00 9.141360884173373e+03 + 52920 1.018147657110040e+00 -5.821231940709525e+00 -6.023374006980244e+00 4.658747177257646e+00 4.498016151347511e+00 9.288890980931996e+03 + 52940 1.106921234944824e+00 -5.948230501963789e+00 -6.009478674925897e+00 3.992538596182386e+00 4.640842108909830e+00 9.246161800478541e+03 + 52960 1.043850723994171e+00 -5.858517140262991e+00 -6.037421273667280e+00 4.420745381812571e+00 4.393450162479976e+00 9.332254275703262e+03 + 52980 1.146572084146277e+00 -6.024123742386364e+00 -5.992008195267806e+00 3.626360458907028e+00 4.810772900326647e+00 9.192512020501281e+03 + 53000 1.045708768352617e+00 -5.893566419835420e+00 -6.036023925205782e+00 4.263743125401001e+00 4.445730084336671e+00 9.327976687495480e+03 + 53020 1.066139618325122e+00 -5.949931833177454e+00 -6.008253453186554e+00 3.982385348091484e+00 4.647493580757702e+00 9.242388717424526e+03 + 53040 9.717946982252299e-01 -5.841095634475598e+00 -6.042196177504766e+00 4.511556816639685e+00 4.356806378357741e+00 9.347040636933820e+03 + 53060 1.072321437004657e+00 -6.020874172903369e+00 -5.984668312996838e+00 3.631074164424207e+00 4.838973814846221e+00 9.170038597085044e+03 + 53080 9.523846234842458e-01 -5.871321604560748e+00 -6.054842510593891e+00 4.403404172283365e+00 4.349598730072635e+00 9.386175005812172e+03 + 53100 1.018425726091077e+00 -5.996774029250003e+00 -6.015408131640375e+00 3.701582775990699e+00 4.594582876447157e+00 9.264422874205799e+03 + 53120 9.924607349976536e-01 -5.983069244398583e+00 -6.017439609970824e+00 3.753154824659362e+00 4.555794866746666e+00 9.270656866810732e+03 + 53140 9.974854833458909e-01 -6.009885452766574e+00 -6.009867521563295e+00 3.573702770731136e+00 4.573805734475211e+00 9.247368710658689e+03 + 53160 9.940751085819003e-01 -6.021595100052499e+00 -5.987711967347504e+00 3.579831050168595e+00 4.774393241558514e+00 9.179343816160032e+03 + 53180 9.666443054771724e-01 -5.993462840315974e+00 -5.965816521705590e+00 3.696135650678614e+00 4.854885090393418e+00 9.112393798526584e+03 + 53200 9.821699458789496e-01 -6.023249894731318e+00 -5.970367592701577e+00 3.551468191425392e+00 4.855126553189956e+00 9.126312828370314e+03 + 53220 9.272710253604787e-01 -5.944831109699081e+00 -6.030603698023383e+00 3.925040786441650e+00 4.432521311018358e+00 9.311239915970351e+03 + 53240 9.775165789530345e-01 -6.019507539357808e+00 -5.997289550889714e+00 3.587730402354819e+00 4.715309530361220e+00 9.208740338720916e+03 + 53260 1.057424203802684e+00 -6.138467595003966e+00 -5.915235692997455e+00 2.955192362793489e+00 5.237024489140065e+00 8.958678007761646e+03 + 53280 9.729165361109603e-01 -6.009315713517995e+00 -5.936377673937319e+00 3.651878232534388e+00 5.070699742931779e+00 9.022750436479284e+03 + 53300 9.829913345104407e-01 -6.015422455548157e+00 -5.983219005422930e+00 3.595302654250568e+00 4.780219848337429e+00 9.165591694171459e+03 + 53320 1.008794017081309e+00 -6.041954815400758e+00 -5.964851259336182e+00 3.467282428155766e+00 4.910022978815300e+00 9.109458049205927e+03 + 53340 1.005485120102753e+00 -6.020518057739581e+00 -5.977110253813974e+00 3.557920712955947e+00 4.807175040432733e+00 9.146895715578885e+03 + 53360 1.055782348600047e+00 -6.071377907471522e+00 -5.965462634459401e+00 3.309910355384630e+00 4.918092243355754e+00 9.111334947731586e+03 + 53380 1.034449759511274e+00 -6.008561035570028e+00 -6.020860443853002e+00 3.643613660363733e+00 4.572988554675614e+00 9.281195782495422e+03 + 53400 9.651743107645262e-01 -5.872006685577692e+00 -6.043195811315903e+00 4.294690028639466e+00 4.311695577219067e+00 9.350104080379133e+03 + 53420 1.035796442713569e+00 -5.934699347903999e+00 -5.989171246635725e+00 4.065959874381704e+00 4.753173802365050e+00 9.183807317234046e+03 + 53440 1.091746920455752e+00 -5.966754028769856e+00 -6.004497118016895e+00 3.854542728896817e+00 4.637816069716134e+00 9.230853072815878e+03 + 53460 1.131146227325475e+00 -5.978769549799787e+00 -6.008578138872749e+00 3.831975053144749e+00 4.660809521823552e+00 9.243383605451416e+03 + 53480 1.068258819224858e+00 -5.853311307979129e+00 -6.062825444552813e+00 4.498764652528436e+00 4.295702058114491e+00 9.410920501478418e+03 + 53500 1.144473784186664e+00 -5.948350374672767e+00 -6.056046390364228e+00 3.949425658581212e+00 4.331018470576275e+00 9.389924574736506e+03 + 53520 1.094728735030157e+00 -5.876270621218036e+00 -6.011388199900348e+00 4.386411964252725e+00 4.610545918081166e+00 9.252025039117731e+03 + 53540 1.068698498071433e+00 -5.850478698851571e+00 -6.022678006677888e+00 4.469215103502977e+00 4.480420030207506e+00 9.286760560622026e+03 + 53560 1.022025568330448e+00 -5.798739379430535e+00 -5.990213704163977e+00 4.847693102479370e+00 4.748217899303960e+00 9.186988240052389e+03 + 53580 1.080971893856868e+00 -5.908623943052528e+00 -6.017548357678433e+00 4.165044144311972e+00 4.539583299531339e+00 9.270989663307830e+03 + 53600 1.118183833765542e+00 -5.990172635510129e+00 -5.961533455299629e+00 3.761228045880086e+00 4.925678650547590e+00 9.099347281947013e+03 + 53620 1.100736206269385e+00 -5.991340670929203e+00 -5.987486481812516e+00 3.752664713471614e+00 4.774796063813468e+00 9.178655665610202e+03 + 53640 1.058632135947689e+00 -5.953942087571248e+00 -6.032624614549675e+00 3.906532273412553e+00 4.454725027420723e+00 9.317457763580438e+03 + 53660 1.036072524780025e+00 -5.941173994648743e+00 -5.989155437233582e+00 4.007475482415006e+00 4.731958613988618e+00 9.183770979502053e+03 + 53680 1.011098842717600e+00 -5.921279638574397e+00 -6.003511772663831e+00 4.059320044703824e+00 4.587130405380668e+00 9.227808797213391e+03 + 53700 1.042140276238395e+00 -5.982974244087150e+00 -5.962119762222389e+00 3.816153838863448e+00 4.935903500951545e+00 9.101122843343459e+03 + 53720 1.015132616623391e+00 -5.956981855314658e+00 -5.990511364806482e+00 3.961074147459456e+00 4.768542515282583e+00 9.187944782908702e+03 + 53740 9.838176637114679e-01 -5.924379754177998e+00 -6.019223725442540e+00 4.093615606318439e+00 4.549006846260322e+00 9.276162708457075e+03 + 53760 1.053302193298816e+00 -6.041660854400758e+00 -6.026787902909297e+00 3.416274278185297e+00 4.501677067231068e+00 9.299474800658514e+03 + 53780 1.000063208067193e+00 -5.978762919306122e+00 -6.012850090770648e+00 3.806504514058653e+00 4.610770700536607e+00 9.256550002760396e+03 + 53800 9.980375814867323e-01 -5.992572129120801e+00 -6.003969749041622e+00 3.710507271653715e+00 4.645060374292378e+00 9.229241116642581e+03 + 53820 1.042543449439469e+00 -6.075565126382925e+00 -5.975658040444740e+00 3.321594412917892e+00 4.895276360946530e+00 9.142470240619261e+03 + 53840 9.985450816635743e-01 -6.029411096125779e+00 -5.984794791206328e+00 3.566725331049144e+00 4.822919058247507e+00 9.170372290875619e+03 + 53860 1.035715401997662e+00 -6.101182126500418e+00 -5.952485337190494e+00 3.147828763935610e+00 5.001668738906972e+00 9.071762626318081e+03 + 53880 9.870568060008424e-01 -6.043273541372438e+00 -5.973501173485889e+00 3.449701431837473e+00 4.850345165481069e+00 9.135874385736128e+03 + 53900 9.155667710208502e-01 -5.947236788178921e+00 -5.980924681428175e+00 3.954460145815324e+00 4.761019049593475e+00 9.158556841170022e+03 + 53920 9.534139397041693e-01 -6.009258257218812e+00 -5.935998289205425e+00 3.655948475322871e+00 5.076618548599148e+00 9.021595347392269e+03 + 53940 9.831178025735192e-01 -6.053395494736893e+00 -5.912139268709897e+00 3.462595488988847e+00 5.273710598166195e+00 8.949298640865523e+03 + 53960 1.007717841815206e+00 -6.083446510073417e+00 -5.948344141634580e+00 3.234341502631163e+00 5.010120209230912e+00 9.059136750347028e+03 + 53980 9.595405683186373e-01 -6.000367912871468e+00 -6.010790333339369e+00 3.679355622244875e+00 4.619508471053836e+00 9.250182114446752e+03 + 54000 9.770449537282063e-01 -6.008994040440683e+00 -6.024713741685058e+00 3.583692327893432e+00 4.493427370732323e+00 9.293047830086660e+03 + 54020 1.024637848056716e+00 -6.051792812883864e+00 -5.990618076428905e+00 3.436483268815437e+00 4.787758072299678e+00 9.188268443097966e+03 + 54040 9.818594127211741e-01 -5.949050069722733e+00 -6.021403700422540e+00 4.036178662189709e+00 4.620712918023255e+00 9.282857879932666e+03 + 54060 1.091477687510626e+00 -6.066219296214215e+00 -5.992907664473782e+00 3.298016698629028e+00 4.718983433020942e+00 9.195304647267138e+03 + 54080 1.073057900154336e+00 -5.994236350042423e+00 -5.995493973971848e+00 3.764430025319911e+00 4.757208554100484e+00 9.203197592571596e+03 + 54100 1.076770153951080e+00 -5.963734840019113e+00 -5.993359873743739e+00 3.886297044919783e+00 4.716185516813827e+00 9.196658386561119e+03 + 54120 1.086255932639081e+00 -5.949761631920937e+00 -6.005991963039690e+00 4.048906228560317e+00 4.726022965660820e+00 9.235453556036309e+03 + 54140 1.105744408686670e+00 -5.962985047293924e+00 -6.026146170595598e+00 3.898881195026275e+00 4.536200250875821e+00 9.297488992661685e+03 + 54160 1.070487361786937e+00 -5.908335621743166e+00 -6.026832263401276e+00 4.190032313696031e+00 4.509606259999134e+00 9.299588776385383e+03 + 54180 1.098088690069195e+00 -5.955584101182066e+00 -6.026589012631286e+00 3.982595650760899e+00 4.574874461244946e+00 9.298840796003318e+03 + 54200 9.866563593999562e-01 -5.806740737845078e+00 -6.059025010112924e+00 4.639262317332776e+00 4.190606985105847e+00 9.399121816076367e+03 + 54220 1.075717877795899e+00 -5.956746585466376e+00 -5.960290828418375e+00 3.935512086157409e+00 4.915160494657204e+00 9.095557724466327e+03 + 54240 1.035827334390549e+00 -5.921079555687382e+00 -5.996851287655333e+00 4.131266988693183e+00 4.696173978095584e+00 9.207350468619268e+03 + 54260 1.127915649114686e+00 -6.081901170805526e+00 -5.963965435802386e+00 3.276584960001056e+00 4.953790200885093e+00 9.106750144146325e+03 + 54280 1.054877057039187e+00 -5.999697581123558e+00 -5.993456709662678e+00 3.714311651896822e+00 4.750147701596931e+00 9.196975995099487e+03 + 54300 9.628232125924775e-01 -5.889137643868834e+00 -6.031467394488017e+00 4.318038066573212e+00 4.500758613060134e+00 9.313894258397562e+03 + 54320 9.615570204218201e-01 -5.908998779812577e+00 -6.013433636630330e+00 4.197414887755412e+00 4.597733778666011e+00 9.258339195786244e+03 + 54340 9.932746340689625e-01 -5.971692953564488e+00 -6.006559622403910e+00 3.852415662715926e+00 4.652205854640401e+00 9.237190943320966e+03 + 54360 1.012407481702020e+00 -6.010853582313801e+00 -5.998083717318947e+00 3.614637646351827e+00 4.687964187282502e+00 9.211188072684419e+03 + 54380 1.009680495622634e+00 -6.013927312559051e+00 -6.022159601557566e+00 3.667467982864707e+00 4.620196905492634e+00 9.285185285526140e+03 + 54400 9.668698350026017e-01 -5.957758157456656e+00 -6.037198806573427e+00 4.000746172843474e+00 4.544585672214253e+00 9.331582454080000e+03 + 54420 1.007328646271102e+00 -6.023625989749931e+00 -6.026213050498333e+00 3.593274111507349e+00 4.578418808343668e+00 9.297670202081641e+03 + 54440 9.864892413799866e-01 -5.997248970003383e+00 -6.008657168125299e+00 3.714940141429913e+00 4.649432502400920e+00 9.243635272155399e+03 + 54460 9.530134833113747e-01 -5.951006745276899e+00 -6.003029112187733e+00 4.037144712765244e+00 4.738424231527972e+00 9.226351764741863e+03 + 54480 1.036880768159336e+00 -6.076515863439096e+00 -5.994320574596797e+00 3.272804341455232e+00 4.744782409667551e+00 9.199631076640653e+03 + 54500 9.804467287213167e-01 -5.992977294774775e+00 -6.034702610969758e+00 3.725957634589291e+00 4.486364412025885e+00 9.323900751107401e+03 + 54520 9.700098898365177e-01 -5.977938283224316e+00 -6.021186568401783e+00 3.833078935517706e+00 4.584740589378192e+00 9.282220122015045e+03 + 54540 1.030318662881385e+00 -6.068733020322838e+00 -5.988817546510124e+00 3.365933022447825e+00 4.824820039960036e+00 9.182774168443117e+03 + 54560 9.853601595940844e-01 -6.003353594084792e+00 -5.993827554132017e+00 3.748997592232018e+00 4.803697587790767e+00 9.198100040946489e+03 + 54580 9.678204542768577e-01 -5.976283357817767e+00 -6.012164101197142e+00 3.798140800403278e+00 4.592108019391814e+00 9.254424220422532e+03 + 54600 1.001254533071817e+00 -6.021782905553730e+00 -6.011284848679870e+00 3.603615665157530e+00 4.663897132296282e+00 9.251728000235782e+03 + 54620 1.022602942584029e+00 -6.049267499318328e+00 -6.014502819326941e+00 3.433302600118131e+00 4.632926772445522e+00 9.261637785656110e+03 + 54640 9.630289851929216e-01 -5.955535304955922e+00 -6.067957871332143e+00 3.936373644321743e+00 4.290825870853560e+00 9.426843972880242e+03 + 54660 1.000252976011499e+00 -6.004244185197375e+00 -6.030681149653883e+00 3.715586044564397e+00 4.563780903548096e+00 9.311477266155383e+03 + 54680 9.979828450038610e-01 -5.993307335543915e+00 -6.013931419528004e+00 3.711901954800187e+00 4.593475272996868e+00 9.259863635940037e+03 + 54700 9.591074227254339e-01 -5.923855770338760e+00 -6.014125794711280e+00 4.102850299306270e+00 4.584505850118135e+00 9.260461990444615e+03 + 54720 1.055207166018260e+00 -6.048739352345833e+00 -5.989351303155625e+00 3.461943760671218e+00 4.802959129392301e+00 9.184382366949339e+03 + 54740 9.924737107982928e-01 -5.936274616187706e+00 -5.980420481879225e+00 4.090499437447669e+00 4.837007045096330e+00 9.157030414819163e+03 + 54760 1.075457941007258e+00 -6.038962118502762e+00 -5.975611041681628e+00 3.532780727057252e+00 4.896552413711659e+00 9.142312958113214e+03 + 54780 1.054672790977728e+00 -5.985377771005628e+00 -5.998193711112647e+00 3.834376910619855e+00 4.760785799265030e+00 9.211497180719063e+03 + 54800 1.074215523895364e+00 -5.994690195941192e+00 -6.021485014174578e+00 3.710152945234278e+00 4.556292952453455e+00 9.283136347189517e+03 + 54820 1.080545844480252e+00 -5.987897249804607e+00 -6.062171907037995e+00 3.775956898894978e+00 4.349460323094806e+00 9.408910863657862e+03 + 54840 1.001081951092371e+00 -5.863762351121441e+00 -6.025861090346333e+00 4.395614315640981e+00 4.464818270312827e+00 9.296608324225268e+03 + 54860 1.028542998155979e+00 -5.904540204630682e+00 -6.008354808985229e+00 4.253975912284474e+00 4.657856388822563e+00 9.242689775723200e+03 + 54880 1.055990892570608e+00 -5.947236210662278e+00 -6.032069131953977e+00 3.984079513875495e+00 4.496955751966420e+00 9.315746820429342e+03 + 54900 1.071827291445359e+00 -5.981924178496953e+00 -6.016929493945915e+00 3.791467630294655e+00 4.590461691931658e+00 9.269086089453991e+03 + 54920 9.403814438438366e-01 -5.806305905542190e+00 -6.080817893410321e+00 4.643500676526418e+00 4.067210361594777e+00 9.466787177354996e+03 + 54940 1.104005542354030e+00 -6.074634993591562e+00 -6.036930265382416e+00 3.265758140179180e+00 4.482264524343927e+00 9.330771000703622e+03 + 54960 1.001691174846374e+00 -5.959317167654111e+00 -6.054938117242724e+00 3.902075449456775e+00 4.353005159624838e+00 9.386475375247321e+03 + 54980 9.801914539256972e-01 -5.967116892328596e+00 -5.988516449275192e+00 3.897047947315808e+00 4.774168379757721e+00 9.181837126922790e+03 + 55000 1.004584611527497e+00 -6.040049603077405e+00 -5.953927569639819e+00 3.569276778744225e+00 5.063802822084446e+00 9.076146546371046e+03 + 55020 9.854498551933859e-01 -6.040737550071690e+00 -5.994883739547839e+00 3.407945182696316e+00 4.671244858578515e+00 9.201369756381502e+03 + 55040 9.508405235514381e-01 -6.012166725188421e+00 -5.978543388182563e+00 3.633207198583318e+00 4.826277602865542e+00 9.151305541870759e+03 + 55060 9.623122759976038e-01 -6.044469994423334e+00 -5.970754424943978e+00 3.449008169797089e+00 4.872294377195063e+00 9.127487493495057e+03 + 55080 9.480421244285583e-01 -6.031710035309490e+00 -5.979846134314544e+00 3.558848009725099e+00 4.856658555150821e+00 9.155280620111158e+03 + 55100 9.371940237231567e-01 -6.016860921068209e+00 -6.015961310126649e+00 3.570372818196861e+00 4.575538523437638e+00 9.266125965117457e+03 + 55120 9.911777898489990e-01 -6.093483399793873e+00 -5.993346980733392e+00 3.218584797315810e+00 4.793583611621855e+00 9.196638173075327e+03 + 55140 9.537924429572718e-01 -6.032143538905562e+00 -6.016262577214070e+00 3.521890143244586e+00 4.613081082848014e+00 9.267051266410836e+03 + 55160 9.498273437749721e-01 -6.016666198934384e+00 -6.022861591455192e+00 3.608509910675919e+00 4.572935008087548e+00 9.287378034600104e+03 + 55180 9.950888083677079e-01 -6.071822302059814e+00 -6.023477346049612e+00 3.296274313137027e+00 4.573878531905374e+00 9.289272892149336e+03 + 55200 9.549631119442991e-01 -5.999330558394665e+00 -6.014103882207289e+00 3.705269981922795e+00 4.620439270426237e+00 9.260396556938038e+03 + 55220 9.605798548383276e-01 -5.991721214376103e+00 -6.010154927132058e+00 3.733062778820205e+00 4.627213547567679e+00 9.248245134610923e+03 + 55240 9.916325071023556e-01 -6.020759439311673e+00 -5.986897955276588e+00 3.566387603635186e+00 4.760825485012361e+00 9.176849553983015e+03 + 55260 9.691418454834565e-01 -5.964816542694719e+00 -5.997033527366728e+00 3.878993804814602e+00 4.693998893265665e+00 9.207944377336498e+03 + 55280 9.782736770897118e-01 -5.955396204141939e+00 -6.041201106102031e+00 3.905134677473414e+00 4.412429652152903e+00 9.343967689852265e+03 + 55300 1.013556994024557e+00 -5.985182331693085e+00 -6.027659120854840e+00 3.727716060050962e+00 4.483807763422286e+00 9.302157547573366e+03 + 55320 9.440857106319652e-01 -5.863201537063844e+00 -6.037869777253064e+00 4.390469350782919e+00 4.387497285793608e+00 9.333661226244176e+03 + 55340 1.061464906581466e+00 -6.016285056597329e+00 -5.975356206233603e+00 3.639652479510406e+00 4.874672272018048e+00 9.141539591407012e+03 + 55360 1.111809585094297e+00 -6.070076799777863e+00 -5.978798670564735e+00 3.274935623500686e+00 4.799068766687314e+00 9.152088762461864e+03 + 55380 9.962644919933222e-01 -5.883332408019612e+00 -6.010149986098979e+00 4.325798836611804e+00 4.597592678323296e+00 9.248173553235240e+03 + 55400 9.904718916244285e-01 -5.858101200963367e+00 -6.010186904630062e+00 4.414051886010650e+00 4.540752240369906e+00 9.248316835643403e+03 + 55420 1.082247825759530e+00 -5.969851888534757e+00 -5.982744927478870e+00 3.823232671755847e+00 4.749198846947421e+00 9.164133311401360e+03 + 55440 1.103718933420287e+00 -5.963292616620775e+00 -5.968486794633510e+00 3.907025427217947e+00 4.877199653272374e+00 9.120544846574141e+03 + 55460 1.099196214053692e+00 -5.901406465874010e+00 -6.009178099107871e+00 4.253669195069651e+00 4.634827799434482e+00 9.245242706547931e+03 + 55480 1.131073514661555e+00 -5.888831868071505e+00 -6.033040003177653e+00 4.259182946844825e+00 4.431117518928539e+00 9.318735267204067e+03 + 55500 1.140176430949628e+00 -5.857404018669083e+00 -6.012364505833356e+00 4.501862411424236e+00 4.612055314069091e+00 9.255032365682195e+03 + 55520 1.175221974737584e+00 -5.884356079668315e+00 -6.002094877112311e+00 4.320018796563801e+00 4.643944401620352e+00 9.223452729324892e+03 + 55540 1.138997679434158e+00 -5.826261945273386e+00 -6.007118212830075e+00 4.597502634368149e+00 4.558997958640691e+00 9.238905142846359e+03 + 55560 1.094434084126901e+00 -5.771825281159740e+00 -5.997336181104487e+00 4.892465389555270e+00 4.597546904373552e+00 9.208847982577541e+03 + 55580 1.107379697739695e+00 -5.818138275348063e+00 -5.990570959084911e+00 4.648804961063947e+00 4.658669807175399e+00 9.188116160141271e+03 + 55600 1.081705620864433e+00 -5.820654667159614e+00 -6.055349120475372e+00 4.657836584886988e+00 4.310184715098638e+00 9.387690524033884e+03 + 55620 1.041811185859008e+00 -5.810883416253248e+00 -6.057037123362514e+00 4.673498783686807e+00 4.260046105302339e+00 9.392943387747664e+03 + 55640 1.100896416326611e+00 -5.948992200438391e+00 -6.031537319307255e+00 3.997589382200984e+00 4.523602535840107e+00 9.314079194798518e+03 + 55660 1.062231029140101e+00 -5.937998930740423e+00 -5.979857942279100e+00 4.058875853784927e+00 4.818514931868740e+00 9.155302706418655e+03 + 55680 1.012821139753760e+00 -5.901178951698629e+00 -5.976755615339060e+00 4.249571507303352e+00 4.815598609229096e+00 9.145801158605425e+03 + 55700 9.779215065255480e-01 -5.877218372010355e+00 -6.036059451751992e+00 4.317360968633214e+00 4.405270908179086e+00 9.328028120053665e+03 + 55720 1.029095161509971e+00 -5.977435392989284e+00 -5.955343570916724e+00 3.823813034798215e+00 4.950667695837272e+00 9.080456583992438e+03 + 55740 9.933027378525247e-01 -5.942954744816950e+00 -5.981900739790127e+00 3.984125700377021e+00 4.760491770367789e+00 9.161529149668595e+03 + 55760 1.010296222797366e+00 -5.986579434992611e+00 -5.960598608317880e+00 3.802663374187271e+00 4.951849301473509e+00 9.096471407476078e+03 + 55780 9.713903304251943e-01 -5.945717717259810e+00 -5.941064050560882e+00 4.008107680870858e+00 5.034829755208695e+00 9.036985494715853e+03 + 55800 1.048416949187498e+00 -6.072265018161504e+00 -5.970416478500017e+00 3.278444156313515e+00 4.863274232060352e+00 9.126442238773061e+03 + 55820 9.928829601872921e-01 -6.002222927089231e+00 -6.010154035652733e+00 3.698929236856991e+00 4.653387584150278e+00 9.248233641298104e+03 + 55840 9.583111180999919e-01 -5.964857001059129e+00 -6.054917548153746e+00 3.853210862223546e+00 4.336069263981632e+00 9.386394646918869e+03 + 55860 9.514781812610510e-01 -5.969112965419253e+00 -6.028782929209297e+00 3.898242046734633e+00 4.555607880755151e+00 9.305591900159063e+03 + 55880 1.039158557855002e+00 -6.111224522029953e+00 -5.987120121082040e+00 3.129225550402055e+00 4.841852225738952e+00 9.177551789694453e+03 + 55900 9.638277058582696e-01 -6.009999155671554e+00 -6.014167484222057e+00 3.647397979687235e+00 4.623462792103489e+00 9.260601501558012e+03 + 55920 1.016012779676597e+00 -6.099273464983181e+00 -5.956360298540643e+00 3.133121898052023e+00 4.953751415506112e+00 9.083572894966006e+03 + 55940 9.247355447388724e-01 -5.971431960412266e+00 -5.941668381594416e+00 3.875925881875115e+00 5.046832957346151e+00 9.038838180359313e+03 + 55960 9.459038462526007e-01 -6.004186716280334e+00 -5.979442746174939e+00 3.654444364811247e+00 4.796528070273423e+00 9.154066165213551e+03 + 55980 9.988168241166809e-01 -6.079447766358204e+00 -6.007089674059547e+00 3.223866512864781e+00 4.639357876222265e+00 9.238854250840297e+03 + 56000 9.541825627409692e-01 -6.009637511883415e+00 -6.023675056637651e+00 3.584786542170633e+00 4.504180787888782e+00 9.289865404546832e+03 + 56020 9.415009393902448e-01 -5.982863630168257e+00 -5.951771965446629e+00 3.812157902784855e+00 4.990691053036008e+00 9.069561507806642e+03 + 56040 9.854186131503715e-01 -6.030888582830000e+00 -5.931082057806807e+00 3.577582134745762e+00 5.150686646438770e+00 9.006654467091950e+03 + 56060 9.525893747406403e-01 -5.952782225455519e+00 -6.054471222183893e+00 3.881617783092133e+00 4.297703827556423e+00 9.384968017956671e+03 + 56080 1.055919330528610e+00 -6.067679960328285e+00 -5.973898747455350e+00 3.351335923828400e+00 4.889842160740583e+00 9.137104957540247e+03 + 56100 1.012677065006862e+00 -5.962490298406584e+00 -6.017139038341393e+00 3.851494831496397e+00 4.537693309925545e+00 9.269729124765279e+03 + 56120 1.109086415310063e+00 -6.066971328858539e+00 -5.984290073594297e+00 3.349240052859003e+00 4.824008615469189e+00 9.168888689954405e+03 + 56140 1.043746985128696e+00 -5.940487073973911e+00 -5.994830850863329e+00 4.041970344835120e+00 4.729919968263791e+00 9.201141159840747e+03 + 56160 1.053480236927609e+00 -5.933614678523356e+00 -5.964324018357866e+00 4.046436393240709e+00 4.870098611655977e+00 9.107790381480962e+03 + 56180 1.113603375938232e+00 -6.004934336723722e+00 -5.975294718862550e+00 3.608282772142091e+00 4.778478044616984e+00 9.141330526154146e+03 + 56200 1.028644206899561e+00 -5.870522003672527e+00 -5.998366074108910e+00 4.339705539939957e+00 4.605605103688281e+00 9.212003079311035e+03 + 56220 1.033630750327328e+00 -5.876453409689939e+00 -5.990591536444792e+00 4.361511336255752e+00 4.706112549611358e+00 9.188179007827379e+03 + 56240 9.954566925141832e-01 -5.822888081281322e+00 -6.050253303675944e+00 4.604927133043205e+00 4.299360841398829e+00 9.371957459553389e+03 + 56260 1.031175844402633e+00 -5.885867466803091e+00 -6.068160687100173e+00 4.291742048935100e+00 4.244986168204584e+00 9.427436124020882e+03 + 56280 1.120293206176698e+00 -6.038545517569005e+00 -6.006079163239403e+00 3.505921762307090e+00 4.692348593019760e+00 9.235725059757649e+03 + 56300 1.052099671442379e+00 -5.968260229321049e+00 -6.011610422079510e+00 3.852762091914611e+00 4.603838576674880e+00 9.252746597973975e+03 + 56320 9.847671929878378e-01 -5.905827336333842e+00 -6.022919604020021e+00 4.187811819481618e+00 4.515449898457709e+00 9.287510193727046e+03 + 56340 9.626743385624225e-01 -5.909469487153911e+00 -6.007381592311148e+00 4.166545523584544e+00 4.604319063922381e+00 9.239704703796539e+03 + 56360 1.030715940167979e+00 -6.040380728247204e+00 -5.980769653687504e+00 3.438457397633834e+00 4.780753412539608e+00 9.158105055936645e+03 + 56380 9.790271385083111e-01 -5.986585989476599e+00 -5.997328685396431e+00 3.760027434414242e+00 4.698341212015748e+00 9.208860758526149e+03 + 56400 9.933189752516800e-01 -6.023543384424475e+00 -6.020145991158939e+00 3.554712349009919e+00 4.574220706885532e+00 9.279008744357612e+03 + 56420 9.838577626535955e-01 -6.020886190507584e+00 -5.984587635449633e+00 3.578055503148692e+00 4.786487423474690e+00 9.169810687885325e+03 + 56440 9.953290388767712e-01 -6.043809221810512e+00 -5.985808403620138e+00 3.419151084061821e+00 4.752200757708555e+00 9.173520964788280e+03 + 56460 9.621866753620619e-01 -5.995171612504797e+00 -5.968416684706860e+00 3.742124832538082e+00 4.895755768265535e+00 9.120339009166642e+03 + 56480 1.022059081848043e+00 -6.081924634640547e+00 -5.969113798692411e+00 3.250670039231960e+00 4.898447316666602e+00 9.122482786886205e+03 + 56500 9.979482149714280e-01 -6.041625846467564e+00 -5.989482284452763e+00 3.467532162747139e+00 4.766948565026269e+00 9.184800154793762e+03 + 56520 9.552797713004187e-01 -5.974470115458068e+00 -5.951832308380862e+00 3.854261530087014e+00 4.984251321513659e+00 9.069784681626597e+03 + 56540 9.598652374063001e-01 -5.973339948079397e+00 -5.969514402086134e+00 3.872347956098194e+00 4.894314833192841e+00 9.123675788315752e+03 + 56560 1.055429156720691e+00 -6.102229551193080e+00 -5.984992892614327e+00 3.199269802493843e+00 4.872460838367326e+00 9.171035090683912e+03 + 56580 1.001417392060915e+00 -6.009746475331953e+00 -6.060659708207388e+00 3.588339213843066e+00 4.295987551874993e+00 9.404220846683806e+03 + 56600 9.752211629039319e-01 -5.961334123817178e+00 -6.033248481601555e+00 3.933145254152790e+00 4.520201883043993e+00 9.319380187179253e+03 + 56620 1.052876728025028e+00 -6.067817167931534e+00 -5.975873592028023e+00 3.359870111603169e+00 4.887824352663521e+00 9.143124916422981e+03 + 56640 1.020148930437832e+00 -6.008563584042925e+00 -5.972384160303980e+00 3.662151734051142e+00 4.869899583907897e+00 9.132470599327276e+03 + 56660 9.450695930718166e-01 -5.885840347372925e+00 -6.006953403634609e+00 4.326739520312268e+00 4.631289609072798e+00 9.238389834616033e+03 + 56680 1.014317038816941e+00 -5.974109529097629e+00 -5.978330226398517e+00 3.880458512093112e+00 4.856222615040616e+00 9.150636267339936e+03 + 56700 1.028627632487641e+00 -5.979862652534659e+00 -5.984854949909543e+00 3.820577003424158e+00 4.791910459342050e+00 9.170614265771743e+03 + 56720 1.069368575933357e+00 -6.023378051639678e+00 -5.987747914337899e+00 3.592135184119027e+00 4.796728946251763e+00 9.179466040324558e+03 + 56740 1.040692124528165e+00 -5.962908919427649e+00 -6.008668362073653e+00 3.902760277806810e+00 4.640002476882590e+00 9.243672076598288e+03 + 56760 1.061071651849394e+00 -5.975166123791226e+00 -5.978659440837047e+00 3.862468396721510e+00 4.842409229655337e+00 9.151652706380406e+03 + 56780 1.046244079710479e+00 -5.932404566872014e+00 -6.067245348720643e+00 4.061963311643838e+00 4.287686675725458e+00 9.424612878923019e+03 + 56800 1.090587983038526e+00 -5.979216357738387e+00 -6.082365234279841e+00 3.780039521517765e+00 4.187742710179674e+00 9.471607089786830e+03 + 56820 1.017069717936967e+00 -5.857837627507098e+00 -6.063049321827076e+00 4.512042644830719e+00 4.333685339638337e+00 9.411597693501979e+03 + 56840 1.074534840585458e+00 -5.937964292584121e+00 -6.026430218751513e+00 4.022868209340350e+00 4.514883171229353e+00 9.298355453239121e+03 + 56860 1.105629699966827e+00 -5.985307903068275e+00 -6.009531571606672e+00 3.765878610695090e+00 4.626782557347019e+00 9.246323097474140e+03 + 56880 9.365978094482771e-01 -5.744898045909923e+00 -6.059783970533518e+00 5.057032545320546e+00 4.248908837692513e+00 9.401471807284226e+03 + 56900 1.059126566704163e+00 -5.946247482905694e+00 -6.014738660154975e+00 3.939769540265047e+00 4.546482601524247e+00 9.262359511215305e+03 + 56920 1.034009451917799e+00 -5.939885557199513e+00 -6.037292762856680e+00 4.019507716597229e+00 4.460180467997419e+00 9.331874306239702e+03 + 56940 1.025129209339759e+00 -5.966246311000991e+00 -5.991540009711406e+00 3.874451722768945e+00 4.729211390586516e+00 9.191086118622326e+03 + 56960 1.050421294699241e+00 -6.045997413710398e+00 -5.947563400845658e+00 3.500224247207867e+00 5.065447581691472e+00 9.056776142799330e+03 + 56980 1.007163412290015e+00 -6.023911250402898e+00 -5.983686649086141e+00 3.569959820578359e+00 4.800935706076117e+00 9.167034959257613e+03 + 57000 9.309288945719089e-01 -5.945039667994267e+00 -6.000378628168360e+00 3.948789579605922e+00 4.631024706609864e+00 9.218184404654423e+03 + 57020 9.884710892965154e-01 -6.053586995468538e+00 -5.916060656516715e+00 3.422082527318230e+00 5.211780047711770e+00 8.961151492768930e+03 + 57040 8.809970621089549e-01 -5.905985787923622e+00 -5.958383854005830e+00 4.223865119365154e+00 4.922987315346592e+00 9.089707557564196e+03 + 57060 9.959878111939372e-01 -6.080469682398911e+00 -5.967018343882826e+00 3.258690500850638e+00 4.910145643147893e+00 9.116092495548628e+03 + 57080 9.951104246659106e-01 -6.079383148315304e+00 -5.992230507265564e+00 3.297694488620225e+00 4.798138440355446e+00 9.193208252986884e+03 + 57100 9.740927638140553e-01 -6.045504406196317e+00 -6.013516122281800e+00 3.417450269600709e+00 4.601131946008805e+00 9.258576820475606e+03 + 57120 9.280859684191589e-01 -5.973691887965853e+00 -5.999119963096357e+00 3.828794374965326e+00 4.682782432584067e+00 9.214328532624862e+03 + 57140 9.013227941011318e-01 -5.925972063906412e+00 -5.998699397622463e+00 4.066515881551177e+00 4.648904276835089e+00 9.213040556424934e+03 + 57160 1.037557155624623e+00 -6.113118072510668e+00 -5.980432260738726e+00 3.040883582954080e+00 4.802786047211579e+00 9.157059212102398e+03 + 57180 9.961209475269126e-01 -6.033330826081715e+00 -5.967111803431570e+00 3.531499611668199e+00 4.911739487085969e+00 9.116335646804642e+03 + 57200 9.592643393964942e-01 -5.957509723857826e+00 -5.979202556124649e+00 3.871351403686421e+00 4.746787803855381e+00 9.153258241448018e+03 + 57220 1.018595292936397e+00 -6.017991089762433e+00 -5.975110562031761e+00 3.611936877573310e+00 4.858163503543054e+00 9.140800659814173e+03 + 57240 9.698046728212524e-01 -5.914247230286537e+00 -5.992770843062300e+00 4.151822884837062e+00 4.700928148788827e+00 9.194847907793737e+03 + 57260 1.028762057750746e+00 -5.970084071654433e+00 -6.009823614037479e+00 3.836187233242287e+00 4.607996631204529e+00 9.247187412274752e+03 + 57280 1.061177841539753e+00 -5.982157446411677e+00 -6.033874102259278e+00 3.789964141077660e+00 4.492999100074108e+00 9.321313476370518e+03 + 57300 1.061930412776711e+00 -5.953879132270297e+00 -6.010541429223182e+00 3.944164842558918e+00 4.618801164993334e+00 9.249430949817965e+03 + 57320 1.068218235884576e+00 -5.944514999272682e+00 -5.993529754978590e+00 3.952884409418600e+00 4.671434097146344e+00 9.197175793040353e+03 + 57340 1.061407128291408e+00 -5.922963944554405e+00 -5.981815719512783e+00 4.128284738110631e+00 4.790348739016886e+00 9.161290247496561e+03 + 57360 1.070040270354071e+00 -5.931013571653581e+00 -5.978197364927041e+00 4.156343698371375e+00 4.885407055726758e+00 9.150224076257286e+03 + 57380 1.004790300895971e+00 -5.835843686039258e+00 -5.990164057433454e+00 4.662881698832980e+00 4.776750245287215e+00 9.186838912985426e+03 + 57400 1.043477524448684e+00 -5.898555074584457e+00 -6.019245454853479e+00 4.236661382120923e+00 4.543638541840214e+00 9.276205737101965e+03 + 57420 1.037511149702690e+00 -5.902337124123962e+00 -6.067278156085971e+00 4.257996017543566e+00 4.310879087475505e+00 9.424725604419642e+03 + 57440 1.065442054346394e+00 -5.970257373657727e+00 -6.022794202992227e+00 3.859013177318711e+00 4.557338573231948e+00 9.287161258683904e+03 + 57460 1.045608969903219e+00 -5.980438818162919e+00 -6.003951461071262e+00 3.818106406304108e+00 4.683093172154671e+00 9.229179106583289e+03 + 57480 1.019015465158626e+00 -5.994518600338761e+00 -6.007163568076230e+00 3.676282422154918e+00 4.603673060603938e+00 9.239038543115954e+03 + 57500 1.009307658928902e+00 -6.043030934006151e+00 -6.000612274579384e+00 3.477989605258881e+00 4.721564111953717e+00 9.218929287603551e+03 + 57520 8.956016867171760e-01 -5.932699401689880e+00 -6.022545216254093e+00 4.030415420640217e+00 4.514506849817639e+00 9.286395126207286e+03 + 57540 9.468704654063052e-01 -6.041449704027035e+00 -5.974217989977765e+00 3.463693565712345e+00 4.849748471857378e+00 9.138077484829397e+03 + 57560 1.014106161304705e+00 -6.153285866815664e+00 -5.963595157727054e+00 2.914541459786687e+00 5.003774865915846e+00 9.105644704177546e+03 + 57580 9.513942177781685e-01 -6.063408990174259e+00 -6.013737678437217e+00 3.367945316035701e+00 4.653165674640448e+00 9.259278238186578e+03 + 57600 9.656748671639561e-01 -6.083650444755706e+00 -6.005163257040923e+00 3.224561370568370e+00 4.675246948279701e+00 9.232917486372597e+03 + 57620 9.304784974217767e-01 -6.025887177299108e+00 -5.952901386681315e+00 3.598391001708544e+00 5.017486705950505e+00 9.073026728452460e+03 + 57640 8.859354506828339e-01 -5.946445833889057e+00 -6.036150048897182e+00 3.966431129890889e+00 4.451335645631824e+00 9.328342227703326e+03 + 57660 9.570076980988320e-01 -6.032793351667209e+00 -6.000103835749513e+00 3.533879339311802e+00 4.721587598397450e+00 9.217378555925117e+03 + 57680 1.001677146277492e+00 -6.077299728093116e+00 -6.005067161880394e+00 3.266042602281327e+00 4.680813175428279e+00 9.232611469469961e+03 + 57700 9.911236704863889e-01 -6.037547350732281e+00 -5.971953188943321e+00 3.541234466748128e+00 4.917886294404067e+00 9.131147359565119e+03 + 57720 9.924715539741471e-01 -6.013051339140683e+00 -5.989606668862947e+00 3.667591385747819e+00 4.802214310533580e+00 9.185138781506348e+03 + 57740 1.041261966106049e+00 -6.057236816798165e+00 -6.008501504777332e+00 3.402602894433098e+00 4.682448597821882e+00 9.243146640617026e+03 + 57760 9.997328673283132e-01 -5.968598170804616e+00 -6.003635078788765e+00 3.855284704882333e+00 4.654097357293359e+00 9.228214861732822e+03 + 57780 1.006012698705330e+00 -5.954499490274520e+00 -6.040625002992915e+00 3.884844251385740e+00 4.390298229476700e+00 9.342170351535724e+03 + 57800 9.906342650568428e-01 -5.911135844488461e+00 -6.007257422506256e+00 4.216580983364718e+00 4.664636007620414e+00 9.239321618872542e+03 + 57820 1.024725950716412e+00 -5.944581309409092e+00 -5.975890470029317e+00 4.009857811844733e+00 4.830075766486453e+00 9.143158468044978e+03 + 57840 9.714285191591902e-01 -5.850459286090520e+00 -5.994044098524901e+00 4.512669933239190e+00 4.688183720563061e+00 9.198763686468688e+03 + 57860 1.108915742465107e+00 -6.040685254623445e+00 -6.004530164982844e+00 3.487183861968586e+00 4.694791981666953e+00 9.230968436938134e+03 + 57880 1.004881075419804e+00 -5.879198161706875e+00 -6.072491434510811e+00 4.287150481239037e+00 4.177230596761546e+00 9.440949202579535e+03 + 57900 1.037495323852943e+00 -5.929265741863543e+00 -6.005579819214597e+00 4.119766157198249e+00 4.681558915483190e+00 9.234174760361120e+03 + 57920 1.041116311199739e+00 -5.942022505019296e+00 -6.015270436845870e+00 4.036777038720489e+00 4.616176079091487e+00 9.263956537539587e+03 + 57940 1.038724687709235e+00 -5.951408067019543e+00 -6.004812090936297e+00 3.957368035304772e+00 4.650713865728775e+00 9.231818491355192e+03 + 57960 9.960857835417728e-01 -5.908402194838742e+00 -5.993143797819463e+00 4.205299816352214e+00 4.718700418316240e+00 9.195986702476792e+03 + 57980 9.505022823946647e-01 -5.864365338137638e+00 -5.969656838252953e+00 4.408407139164474e+00 4.803807051695355e+00 9.124117949163701e+03 + 58000 1.076399271851330e+00 -6.078863819395770e+00 -5.992710138597121e+00 3.241830763652230e+00 4.736538531037086e+00 9.194700216822339e+03 + 58020 1.005926385888553e+00 -6.011851237586388e+00 -6.053791314904590e+00 3.620608048830939e+00 4.379781634663835e+00 9.382930124333487e+03 + 58040 1.001047283492316e+00 -6.047165357299381e+00 -5.988845901753745e+00 3.426664936398044e+00 4.761544275047667e+00 9.182848236276090e+03 + 58060 9.877652979066205e-01 -6.064892773178935e+00 -5.976702086534846e+00 3.342752573180662e+00 4.849157143355668e+00 9.145651730253752e+03 + 58080 9.032594114331778e-01 -5.968102668849370e+00 -5.997447273638224e+00 3.893645765320454e+00 4.725144503559934e+00 9.209205604693725e+03 + 58100 9.719758118198240e-01 -6.087138936411355e+00 -6.009889207027286e+00 3.196314043357640e+00 4.639893943837951e+00 9.247449423843163e+03 + 58120 9.584839524515807e-01 -6.079078423876790e+00 -5.984573178269248e+00 3.277693193585621e+00 4.820356938503622e+00 9.169760099018644e+03 + 58140 9.249124612389599e-01 -6.034911076230839e+00 -6.009815517748282e+00 3.516061548218623e+00 4.660164128550589e+00 9.247202731252013e+03 + 58160 9.449142267283563e-01 -6.064431931428130e+00 -5.967428704202793e+00 3.363280952283854e+00 4.920288494212641e+00 9.117317251080829e+03 + 58180 9.274836920299137e-01 -6.030610760538377e+00 -5.983889014765071e+00 3.529712510991764e+00 4.797996005388875e+00 9.167642857998491e+03 + 58200 9.179847522105481e-01 -6.002410882060476e+00 -6.005836431349362e+00 3.657444583643790e+00 4.637774549524964e+00 9.234961681864219e+03 + 58220 1.013024510342217e+00 -6.127840334616860e+00 -5.975833273606940e+00 3.000320632112745e+00 4.873168699448367e+00 9.143014218867347e+03 + 58240 1.005828934401468e+00 -6.101336638062905e+00 -5.948972310432037e+00 3.214827741288038e+00 5.089727288847978e+00 9.061071714400152e+03 + 58260 9.429647307340651e-01 -5.993124102747226e+00 -5.984914480817990e+00 3.751553990054798e+00 4.798694909607363e+00 9.170788918249900e+03 + 58280 9.321972471271022e-01 -5.960847654937502e+00 -6.022935180468163e+00 3.889652458985398e+00 4.533136279374812e+00 9.287571802424962e+03 + 58300 9.769737010219337e-01 -6.010114536823198e+00 -6.039959995677941e+00 3.650367881287829e+00 4.478990637974065e+00 9.340123606360659e+03 + 58320 9.837632761399432e-01 -6.005686910283173e+00 -6.025088690490664e+00 3.661722539957373e+00 4.550314515590174e+00 9.294219248176127e+03 + 58340 1.031535756208099e+00 -6.066773138596636e+00 -5.984388804408360e+00 3.341266742763604e+00 4.814330338607197e+00 9.169194838336231e+03 + 58360 9.275573368976099e-01 -5.903232681967690e+00 -6.015579648850107e+00 4.233919067492256e+00 4.588805398016487e+00 9.264930493092646e+03 + 58380 9.423703664844929e-01 -5.916516060035773e+00 -5.987764006355304e+00 4.158453502309025e+00 4.749336768958217e+00 9.179476237853176e+03 + 58400 1.012294573885812e+00 -6.009187329748126e+00 -6.032512728601686e+00 3.625311415479727e+00 4.491373365668780e+00 9.317092798603922e+03 + 58420 9.478431849003378e-01 -5.904895984255397e+00 -6.014835827822780e+00 4.229701858292442e+00 4.598410263392720e+00 9.262631598916216e+03 + 58440 1.011268602765617e+00 -5.991586683027603e+00 -5.995110244970489e+00 3.804726544419702e+00 4.784493706474202e+00 9.201982419056601e+03 + 58460 1.020847556970670e+00 -5.997277145240524e+00 -5.989265180187004e+00 3.698269005411587e+00 4.744274948596479e+00 9.184125379961786e+03 + 58480 1.026788502911057e+00 -6.000007437327396e+00 -5.996438308248305e+00 3.721031208373689e+00 4.741525699866764e+00 9.206134592969856e+03 + 58500 1.002664944759519e+00 -5.961095445427382e+00 -6.017130087499905e+00 3.919868804809270e+00 4.598109218696006e+00 9.269701097159556e+03 + 58520 1.026020172431052e+00 -5.994661329995901e+00 -6.027878741119370e+00 3.733086924051510e+00 4.542347409002794e+00 9.302824315108483e+03 + 58540 1.035676260524936e+00 -6.009911701950544e+00 -6.031362567018034e+00 3.614236426179470e+00 4.491062239451303e+00 9.313560277394936e+03 + 58560 9.733054121939841e-01 -5.921839790706622e+00 -6.006726244997078e+00 4.100383284114454e+00 4.612952127442310e+00 9.237701507447946e+03 + 58580 9.490813248613714e-01 -5.891813830250243e+00 -6.002337620180184e+00 4.277556234582229e+00 4.642911529303288e+00 9.224202853220073e+03 + 58600 9.940430724713530e-01 -5.965772611233597e+00 -6.024494042448991e+00 3.869525040302903e+00 4.532337495151999e+00 9.292373117608293e+03 + 58620 9.644357271642758e-01 -5.933779491584830e+00 -6.023365734221189e+00 4.060051486828431e+00 4.545633418184218e+00 9.288889303695845e+03 + 58640 1.005755334472315e+00 -6.016687819462007e+00 -6.036574522756470e+00 3.529068851291258e+00 4.414876323517062e+00 9.329671227755129e+03 + 58660 9.889224032260400e-01 -6.027169621335694e+00 -6.003891602404538e+00 3.581513854156959e+00 4.715179841121443e+00 9.228985329903071e+03 + 58680 9.410759285468472e-01 -5.997648130566728e+00 -6.006404047169152e+00 3.703081393345271e+00 4.652803565240435e+00 9.236710875206261e+03 + 58700 9.599436148396296e-01 -6.065356826978618e+00 -5.967035910073171e+00 3.369636398414156e+00 4.934210318397954e+00 9.116140910439275e+03 + 58720 9.496534672262221e-01 -6.083900376559034e+00 -5.998477120291343e+00 3.273111838472800e+00 4.763625395168064e+00 9.212369176615082e+03 + 58740 9.645414318118468e-01 -6.132156332036777e+00 -6.012310725550726e+00 2.970614061821262e+00 4.658786080311828e+00 9.254878439454769e+03 + 58760 9.201101517692554e-01 -6.085165991208918e+00 -5.982496841209803e+00 3.205836982351012e+00 4.795379129645545e+00 9.163402412615456e+03 + 58780 9.683386134928132e-01 -6.165054077136232e+00 -5.941152596657636e+00 2.813184027179356e+00 5.098860976729581e+00 9.037295148947767e+03 + 58800 8.944430554896183e-01 -6.054928317182882e+00 -5.942066541737340e+00 3.397226265002083e+00 5.045296044913693e+00 9.040062660688436e+03 + 58820 8.675805357832946e-01 -6.004751785173260e+00 -5.983018935618515e+00 3.632580252008828e+00 4.757373637299779e+00 9.164970468685849e+03 + 58840 9.598704907954412e-01 -6.121242106256878e+00 -5.957341362918162e+00 3.037795595125485e+00 4.978939026934453e+00 9.086523464139314e+03 + 58860 9.641407077146225e-01 -6.096997399929053e+00 -5.991998439987800e+00 3.153677160613374e+00 4.756597437132585e+00 9.192505935701876e+03 + 58880 9.643116264362642e-01 -6.061704028074330e+00 -5.986670350532929e+00 3.314061384081984e+00 4.744916371948785e+00 9.176184745118728e+03 + 58900 9.064691527858670e-01 -5.939735337241417e+00 -5.986646578479452e+00 3.999956246836992e+00 4.730584640157073e+00 9.176099231407568e+03 + 58920 1.034051363937244e+00 -6.094063259796147e+00 -5.985015968351875e+00 3.183912664158048e+00 4.810079086644873e+00 9.171111893869485e+03 + 58940 1.000784109659022e+00 -6.016194749275673e+00 -5.976128577891124e+00 3.651232078686731e+00 4.881298234996799e+00 9.143901083176794e+03 + 58960 1.039400951634418e+00 -6.052267542273590e+00 -6.002353876937832e+00 3.423517956504809e+00 4.710129946977481e+00 9.224272720629713e+03 + 58980 1.056951161040194e+00 -6.063285739511778e+00 -5.990225681168238e+00 3.357321608383203e+00 4.776843769399296e+00 9.187092530375601e+03 + 59000 9.958809855658596e-01 -5.962985394757744e+00 -6.009177729940236e+00 3.912023089404509e+00 4.646779552545870e+00 9.245249112214638e+03 + 59020 9.783177626942990e-01 -5.930291408518323e+00 -6.058598082222668e+00 4.100465045998412e+00 4.363708270194476e+00 9.397797623872819e+03 + 59040 1.015698865069285e+00 -5.982279992042273e+00 -6.026598550735181e+00 3.813574479644443e+00 4.559090457354973e+00 9.298877836689613e+03 + 59060 1.015680384129265e+00 -5.981517031168232e+00 -6.019994412406600e+00 3.785373701788907e+00 4.564430624362694e+00 9.278531303694637e+03 + 59080 1.028755303407844e+00 -6.001524257594443e+00 -6.017051357261577e+00 3.684158967467974e+00 4.594999958368385e+00 9.269475975089128e+03 + 59100 1.059759089702097e+00 -6.049823941142697e+00 -6.011879805595534e+00 3.431338526420405e+00 4.649219624568219e+00 9.253584089159702e+03 + 59120 9.801052347370552e-01 -5.940006957286903e+00 -6.031376359155289e+00 4.029370540019864e+00 4.504713295122344e+00 9.313613743784819e+03 + 59140 9.487465569433818e-01 -5.902336795489122e+00 -6.063024942034184e+00 4.123126014954376e+00 4.200429811082316e+00 9.411537507815916e+03 + 59160 1.008448324921810e+00 -6.001579468786293e+00 -5.998780143773669e+00 3.690835444902571e+00 4.706909602319202e+00 9.213314726614200e+03 + 59180 1.039918628503567e+00 -6.059723622447883e+00 -5.993142399172604e+00 3.423495328145849e+00 4.805815015603500e+00 9.196020660431866e+03 + 59200 9.866708949157019e-01 -5.997824689834903e+00 -6.019836061212965e+00 3.692915389139434e+00 4.566522688437886e+00 9.278071702578080e+03 + 59220 1.008163024596283e+00 -6.050061440522176e+00 -5.989287166151563e+00 3.414301055537558e+00 4.763276343762188e+00 9.184195297528147e+03 + 59240 9.583052444291630e-01 -6.000175453310914e+00 -5.948381623522613e+00 3.741589487945884e+00 5.038997673659564e+00 9.059242582655219e+03 + 59260 1.000496072776032e+00 -6.087291351202121e+00 -5.955398628182101e+00 3.245519831266229e+00 5.002868257180110e+00 9.080629934248949e+03 + 59280 1.000915292778944e+00 -6.117042481996833e+00 -5.961543585930920e+00 3.073653308424175e+00 4.966552033011041e+00 9.099382363421868e+03 + 59300 9.320119720417929e-01 -6.046080898130620e+00 -5.982054901619715e+00 3.464303586474574e+00 4.831950766431131e+00 9.162040872291556e+03 + 59320 8.925925370362344e-01 -6.016641607865853e+00 -5.997131742667202e+00 3.605498076029320e+00 4.717526741141853e+00 9.208256366699141e+03 + 59340 9.822228909330101e-01 -6.174319459293407e+00 -5.980854013052516e+00 2.761477228700336e+00 4.872385759696582e+00 9.158378968688852e+03 + 59360 9.786972168950439e-01 -6.190080887123922e+00 -5.939584071431471e+00 2.679945334147144e+00 5.118336814110144e+00 9.032528756724874e+03 + 59380 8.936717248503367e-01 -6.076724278836729e+00 -5.994237375102617e+00 3.257073754305357e+00 4.730726320353726e+00 9.199368825903453e+03 + 59400 9.509449113142381e-01 -6.166756597434548e+00 -5.967366534341311e+00 2.851787254408953e+00 4.996715852202861e+00 9.117166804145554e+03 + 59420 8.678736947766870e-01 -6.041145366325354e+00 -5.991430583979224e+00 3.453369561742953e+00 4.738839535312135e+00 9.190764945378487e+03 + 59440 9.483802580718994e-01 -6.146504210685661e+00 -5.948552562866452e+00 2.913105127330984e+00 5.049774122027378e+00 9.059804213489115e+03 + 59460 8.792292486754552e-01 -6.011356117168795e+00 -6.014255731852828e+00 3.626322605137725e+00 4.609672568908087e+00 9.260830574572230e+03 + 59480 1.010338792936593e+00 -6.155495850086938e+00 -5.979704361163775e+00 2.897787235423469e+00 4.907209168465262e+00 9.154851290442693e+03 + 59500 9.491484385219364e-01 -6.006471842061510e+00 -6.008886209163663e+00 3.656958016999332e+00 4.643094347476666e+00 9.244344161279045e+03 + 59520 9.499864699059760e-01 -5.960353878910550e+00 -6.046467222800006e+00 3.910953048421840e+00 4.416476901811686e+00 9.360247901990640e+03 + 59540 9.885921332821541e-01 -5.982769937957406e+00 -6.012287250441438e+00 3.807965045500434e+00 4.638472069427778e+00 9.254821807796765e+03 + 59560 9.968823989160316e-01 -5.972316026103670e+00 -6.028909287078861e+00 3.832939596892417e+00 4.507972334594041e+00 9.305999259800807e+03 + 59580 1.085372498665647e+00 -6.089844978811223e+00 -5.957583417299832e+00 3.243002348695980e+00 5.002468702304879e+00 9.087287218151723e+03 + 59600 9.633819806744103e-01 -5.900375027905479e+00 -5.959377441742014e+00 4.223140445345548e+00 4.884339454502132e+00 9.092734102612614e+03 + 59620 9.561697533826122e-01 -5.879174176885371e+00 -6.018247706134918e+00 4.367068984971281e+00 4.568487258461288e+00 9.273069450929030e+03 + 59640 1.019967247191937e+00 -5.963671404926610e+00 -5.981968501476847e+00 3.888312814608924e+00 4.783248054750924e+00 9.161781223086622e+03 + 59660 1.016001185246944e+00 -5.952222357601446e+00 -5.994248049449993e+00 3.962461925505065e+00 4.721143899455911e+00 9.199381675843109e+03 + 59680 1.068377258379176e+00 -6.026000026786372e+00 -5.983006010612563e+00 3.575240021898838e+00 4.822118316071348e+00 9.164946113578577e+03 + 59700 9.654187849492624e-01 -5.873070920104716e+00 -6.046905665485152e+00 4.412499352331275e+00 4.414313343516905e+00 9.361580205625285e+03 + 59720 1.037461749301269e+00 -5.982713172664191e+00 -6.015460497107250e+00 3.776644568395269e+00 4.588604363811148e+00 9.264572222055243e+03 + 59740 1.060344672568465e+00 -6.023079073233118e+00 -5.981475377867469e+00 3.537448852359108e+00 4.776343709299723e+00 9.160281975950631e+03 + 59760 1.047311608676578e+00 -6.016953019439373e+00 -5.980545391057571e+00 3.617910063749931e+00 4.826968299980515e+00 9.157424169788903e+03 + 59780 1.058899856119250e+00 -6.050023798514513e+00 -5.997940966957498e+00 3.444445511713078e+00 4.743513190305594e+00 9.210730023193502e+03 + 59800 9.551154484251290e-01 -5.915810396148823e+00 -6.007076556346243e+00 4.186527192929419e+00 4.662462777683182e+00 9.238773058164890e+03 + 59820 9.930531126987272e-01 -5.993509323791945e+00 -6.002979665279788e+00 3.712104459881503e+00 4.657724293527699e+00 9.226191835371526e+03 + 59840 1.051511610956686e+00 -6.105617806842254e+00 -5.991305923909244e+00 3.128348538133291e+00 4.784745059641347e+00 9.190400502258355e+03 + 59860 9.311161406033018e-01 -5.956971656025754e+00 -6.028132295863152e+00 3.907560905811055e+00 4.498945499791290e+00 9.303617809684900e+03 + 59880 9.712275494533898e-01 -6.046674781510689e+00 -6.015834647246673e+00 3.377516015348504e+00 4.554604838787840e+00 9.265735467609205e+03 + 59900 9.300920790646831e-01 -6.012921684602676e+00 -5.996371773710299e+00 3.604488263361513e+00 4.699520412795977e+00 9.205912250962991e+03 + 59920 9.334936013493887e-01 -6.037594149772793e+00 -6.020764718871918e+00 3.487550706295017e+00 4.584187902873854e+00 9.280915353924094e+03 + 59940 9.561050379509840e-01 -6.087110529347389e+00 -6.045363754813770e+00 3.204277610225582e+00 4.443994049890104e+00 9.356862134396924e+03 + 59960 9.105111103037776e-01 -6.034796244308469e+00 -5.985211485420075e+00 3.547179192066802e+00 4.831902550820593e+00 9.171710393016107e+03 + 59980 9.339628103071459e-01 -6.078452115336090e+00 -5.963848220197885e+00 3.271896649650429e+00 4.929969950429454e+00 9.106394129682360e+03 + 60000 9.326356079547117e-01 -6.076553530357597e+00 -5.986886874080894e+00 3.272636214467297e+00 4.787516030678343e+00 9.176841729716281e+03 + 60020 9.082549899239701e-01 -6.031901949207639e+00 -5.990108052662265e+00 3.487903041157142e+00 4.727890062705267e+00 9.186694923171002e+03 + 60040 9.471039857281653e-01 -6.069789477969184e+00 -5.939908087267364e+00 3.298143850731321e+00 5.043942895221427e+00 9.033496321762917e+03 + 60060 9.589293025517928e-01 -6.048652836483151e+00 -5.956963165129356e+00 3.438804290582639e+00 4.965300572426919e+00 9.085400803977478e+03 + 60080 9.745656886241997e-01 -6.012631037511982e+00 -6.004326161240376e+00 3.568845401770801e+00 4.616533286497807e+00 9.230347568211047e+03 + 60100 1.050111577279047e+00 -6.060391578023852e+00 -5.997750237555873e+00 3.357478786001105e+00 4.717175056684350e+00 9.210149639579291e+03 + 60120 9.991363128129627e-01 -5.936553674139247e+00 -5.993318461114309e+00 4.018024606069495e+00 4.692072414936292e+00 9.196532369842869e+03 + 60140 9.979504858944885e-01 -5.905986526557367e+00 -6.023992392416011e+00 4.096189926494700e+00 4.418581983385641e+00 9.290826281514162e+03 + 60160 1.064208231811221e+00 -5.987754920050626e+00 -5.983601665162109e+00 3.740509965034784e+00 4.764358597318768e+00 9.166777037742200e+03 + 60180 9.847299662027588e-01 -5.861195841722440e+00 -6.012960956763258e+00 4.385205615854266e+00 4.513746839714234e+00 9.256871173795189e+03 + 60200 1.036102566391551e+00 -5.931644602859085e+00 -6.023010252127620e+00 4.037311163437560e+00 4.512675466549100e+00 9.287810531170577e+03 + 60220 1.057810846715224e+00 -5.965013118953214e+00 -6.020828686383574e+00 3.835966967196811e+00 4.515465341580539e+00 9.281094090784252e+03 + 60240 1.013168124050836e+00 -5.904765462436835e+00 -6.041869169084322e+00 4.215987930373879e+00 4.428717230073975e+00 9.346027712285035e+03 + 60260 1.044149145393432e+00 -5.963109428689067e+00 -6.047182331151114e+00 3.895229714719647e+00 4.412470098542963e+00 9.362452628713394e+03 + 60280 1.005106131081343e+00 -5.923896061180303e+00 -6.011837385250484e+00 4.120637204041472e+00 4.615664512354576e+00 9.253417720376956e+03 + 60300 9.984667867805197e-01 -5.936055962849261e+00 -6.035219365889242e+00 4.037269262298496e+00 4.467857656555898e+00 9.325456193625821e+03 + 60320 1.005975232630111e+00 -5.973260544544568e+00 -6.000911432250216e+00 3.869297757990165e+00 4.710522081823290e+00 9.219835165051785e+03 + 60340 1.019077907479947e+00 -6.017982038681300e+00 -5.997533530929275e+00 3.631414929853293e+00 4.748833425761767e+00 9.209479370219547e+03 + 60360 9.805548382832275e-01 -5.988209943574650e+00 -5.998217817850090e+00 3.753674986402316e+00 4.696208223599197e+00 9.211581763027234e+03 + 60380 1.053432836783597e+00 -6.122074121080716e+00 -5.976228940911843e+00 3.101764619911388e+00 4.939230213909742e+00 9.144218562040789e+03 + 60400 9.440806495202885e-01 -5.983200287142159e+00 -5.979633108752109e+00 3.837282619340406e+00 4.857765909675140e+00 9.154624518589120e+03 + 60420 9.111214437473398e-01 -5.951541131968829e+00 -5.994635894705891e+00 3.971889899151186e+00 4.724433102621996e+00 9.200584343955530e+03 + 60440 9.743086191279530e-01 -6.056845491958948e+00 -6.023629971274188e+00 3.329211454325692e+00 4.519940114182799e+00 9.289744532695364e+03 + 60460 9.854420286509262e-01 -6.082981635755663e+00 -5.983396114820446e+00 3.308497841943468e+00 4.880333313963046e+00 9.166144717710977e+03 + 60480 9.606695602149672e-01 -6.051046765172395e+00 -5.949331417438604e+00 3.440266740845565e+00 5.024332007932180e+00 9.062181043051190e+03 + 60500 9.906414297138281e-01 -6.093154316509323e+00 -5.985890004335680e+00 3.234540747303890e+00 4.850469026903609e+00 9.173785513634541e+03 + 60520 9.618420731760928e-01 -6.043599094937499e+00 -6.030361631749406e+00 3.460910255594978e+00 4.536921817711818e+00 9.310498183958738e+03 + 60540 9.710088313828686e-01 -6.046901908271585e+00 -6.007481463843847e+00 3.413746601051358e+00 4.640104893249486e+00 9.240028161186297e+03 + 60560 9.491149361449821e-01 -5.995480493545756e+00 -6.010297906358645e+00 3.686738056804310e+00 4.601654179445483e+00 9.248705737198368e+03 + 60580 1.007394530280685e+00 -6.052227879749315e+00 -5.990911131362481e+00 3.441734517285489e+00 4.793824775258836e+00 9.189171192572167e+03 + 60600 9.611969896720821e-01 -5.941787638136677e+00 -6.025172587094395e+00 4.010703765718648e+00 4.531894485024282e+00 9.294478855984718e+03 + 60620 1.014839505829820e+00 -5.962893584689844e+00 -6.020615291689129e+00 3.885491208898184e+00 4.554044234902998e+00 9.280443654059600e+03 + 60640 1.050016015090035e+00 -5.955686080869675e+00 -6.039069172979191e+00 3.939880009184594e+00 4.461081390799952e+00 9.337368670361599e+03 + 60660 1.072695266133326e+00 -5.946071673111667e+00 -6.046835123419465e+00 3.999697029364278e+00 4.421097704603361e+00 9.361353501720638e+03 + 60680 1.119370355321477e+00 -5.991959901488542e+00 -6.019242229449417e+00 3.751675437779045e+00 4.595016088701094e+00 9.276216987538892e+03 + 60700 1.048458995862748e+00 -5.877990616601041e+00 -6.005188805867933e+00 4.361883449504436e+00 4.631491762877769e+00 9.232971583365386e+03 + 60720 1.007334225519496e+00 -5.815737954414548e+00 -6.030186998645957e+00 4.658594211155034e+00 4.427194613295942e+00 9.309916264591284e+03 + 60740 1.102879853041884e+00 -5.962781395334816e+00 -6.049391315785254e+00 3.870668351516370e+00 4.373340785448081e+00 9.369303129082127e+03 + 60760 1.077549412384116e+00 -5.942368703125942e+00 -6.042217249351811e+00 4.030205621429189e+00 4.456859817487653e+00 9.347082386942226e+03 + 60780 1.038233494629653e+00 -5.907025607581639e+00 -5.968615301830698e+00 4.234634284103359e+00 4.880976728750882e+00 9.120938911205194e+03 + 60800 1.022007782059748e+00 -5.907036662128790e+00 -6.012248048835870e+00 4.168652441859772e+00 4.564512377978245e+00 9.254663859324655e+03 + 60820 1.027832883578764e+00 -5.941293438085149e+00 -5.983747577932228e+00 4.014671042784137e+00 4.770892802025304e+00 9.167199302213297e+03 + 60840 1.062018379781630e+00 -6.016580835731190e+00 -5.967294361530313e+00 3.592389009995081e+00 4.875399571913750e+00 9.116890254416958e+03 + 60860 1.047770365968525e+00 -6.019979317520511e+00 -5.975929378528663e+00 3.609974826155185e+00 4.862916392552401e+00 9.143264077823282e+03 + 60880 9.353579639879310e-01 -5.875026602768679e+00 -6.018833445366045e+00 4.353842608854288e+00 4.528081464623245e+00 9.274941551961023e+03 + 60900 1.015387962721038e+00 -6.012253096118938e+00 -6.016615548037507e+00 3.630285864151996e+00 4.605235990148325e+00 9.268118673429000e+03 + 60920 9.651700581957866e-01 -5.956344342323308e+00 -6.029404086742044e+00 3.908369356666696e+00 4.488848998255405e+00 9.307546852097896e+03 + 60940 1.012878788338464e+00 -6.041850375282624e+00 -5.988854984234290e+00 3.497314655135134e+00 4.801622391544923e+00 9.182882497017346e+03 + 60960 1.031599605384278e+00 -6.082213215242061e+00 -6.010330507723271e+00 3.263549382133250e+00 4.676311012519180e+00 9.248803542966749e+03 + 60980 9.211229854860442e-01 -5.930613383486815e+00 -6.039761037330304e+00 4.050086498507375e+00 4.423343779593218e+00 9.339529111484531e+03 + 61000 9.796881789077424e-01 -6.026141098717870e+00 -5.988437627613825e+00 3.583955715853704e+00 4.800454881526431e+00 9.181584749405672e+03 + 61020 9.219623155876951e-01 -5.944960836244091e+00 -6.013030849323743e+00 3.955332785818956e+00 4.564464236915115e+00 9.257085542856787e+03 + 61040 1.005855475444968e+00 -6.070466029320415e+00 -5.967646796552494e+00 3.304668195234410e+00 4.895072141012659e+00 9.117989627950099e+03 + 61060 1.050138920563730e+00 -6.133105780198076e+00 -5.959852464321712e+00 3.029428840962315e+00 5.024276191588376e+00 9.094227399228574e+03 + 61080 1.027119239866936e+00 -6.096662741385543e+00 -5.964508802335668e+00 3.228242472033446e+00 4.987090840813805e+00 9.108424741209948e+03 + 61100 9.518633792054130e-01 -5.980414565805518e+00 -5.942418264382932e+00 3.859672322553151e+00 5.077852965230279e+00 9.041121064500581e+03 + 61120 9.421724324883870e-01 -5.955593692989001e+00 -6.008108780955716e+00 3.899395503457149e+00 4.597845741668671e+00 9.241931746407401e+03 + 61140 9.476655976629762e-01 -5.946506350874446e+00 -6.002676982233635e+00 3.991336994042750e+00 4.668796536401178e+00 9.225278560682287e+03 + 61160 1.005325117732789e+00 -6.006942755019475e+00 -5.991247613920590e+00 3.650861483241983e+00 4.740985412247013e+00 9.190198726650309e+03 + 61180 1.004977007394602e+00 -5.971896597783632e+00 -6.014559201422663e+00 3.808111362545284e+00 4.563136090433392e+00 9.261789210949803e+03 + 61200 1.073480155052599e+00 -6.022199744548899e+00 -5.993942309697625e+00 3.556087810138170e+00 4.718346373878095e+00 9.198474164826795e+03 + 61220 1.060395678844813e+00 -5.943947422254252e+00 -6.035923209058437e+00 3.943175596275157e+00 4.415036395238518e+00 9.327648628587121e+03 + 61240 1.051605935095988e+00 -5.873421447657885e+00 -6.001009493487530e+00 4.341348237581209e+00 4.608717934241104e+00 9.220122082356038e+03 + 61260 1.014090196215956e+00 -5.774257010686015e+00 -6.024904443819096e+00 4.899574325213547e+00 4.460317976598471e+00 9.293593854143663e+03 + 61280 1.111006791215841e+00 -5.892138778860734e+00 -5.987255059058262e+00 4.251228113563866e+00 4.705055713472867e+00 9.177937828181412e+03 + 61300 1.049066666422557e+00 -5.790393121097853e+00 -6.040587749045264e+00 4.818445559524850e+00 4.381789288357275e+00 9.342050805507297e+03 + 61320 1.182736536710780e+00 -5.992398216171536e+00 -6.004894274336925e+00 3.761471017810316e+00 4.689716718065903e+00 9.232086057682620e+03 + 61340 1.099718567809540e+00 -5.886918439817529e+00 -6.021995747879867e+00 4.316584347614694e+00 4.540949541574883e+00 9.284697445942962e+03 + 61360 1.093641355225546e+00 -5.900146037802878e+00 -6.052134989463049e+00 4.192156910877176e+00 4.319412830230223e+00 9.377773011282976e+03 + 61380 1.119371762376638e+00 -5.965445136945090e+00 -6.019184528309919e+00 3.884432517940150e+00 4.575852616579359e+00 9.276050003366863e+03 + 61400 1.052169609283154e+00 -5.899794667216999e+00 -6.039313376301611e+00 4.248773054912367e+00 4.447635036898071e+00 9.338115449034001e+03 + 61420 1.056596232957568e+00 -5.939574275409563e+00 -6.027572206871184e+00 4.036011384589248e+00 4.530713644500736e+00 9.301896415465875e+03 + 61440 1.092389403068731e+00 -6.026046338241717e+00 -5.993312294811931e+00 3.556683646588066e+00 4.744647589538749e+00 9.196542179243579e+03 + 61460 9.894303426633724e-01 -5.902772627253678e+00 -5.988132039371454e+00 4.275468934533507e+00 4.785321980826902e+00 9.180640023206690e+03 + 61480 1.002117612477918e+00 -5.944865855688568e+00 -6.006744675359065e+00 3.966866734500864e+00 4.611548976236474e+00 9.237739433257440e+03 + 61500 1.042803169699456e+00 -6.024951303766385e+00 -6.020703795289689e+00 3.563964698202195e+00 4.588354549175195e+00 9.280728182909759e+03 + 61520 1.093314720838085e+00 -6.122292683417463e+00 -6.016407329242061e+00 3.003032416193748e+00 4.611042505574506e+00 9.267513486630025e+03 + 61540 1.006645636893841e+00 -6.018573819905805e+00 -6.001021835103591e+00 3.600655049604654e+00 4.701441262499831e+00 9.220177929869897e+03 + 61560 9.345499833352101e-01 -5.932021769529269e+00 -5.981876071710351e+00 4.100433106380009e+00 4.814161988327909e+00 9.161451404017031e+03 + 61580 9.958636017601727e-01 -6.037301876911618e+00 -5.941226312260438e+00 3.501089206077693e+00 5.052769965950349e+00 9.037502310713999e+03 + 61600 9.188438133666438e-01 -5.931217229650757e+00 -5.986651474421728e+00 4.058837686042794e+00 4.740525674146228e+00 9.176121636575939e+03 + 61620 1.001248762200739e+00 -6.057340674030399e+00 -6.020693105126335e+00 3.364077910058467e+00 4.574513921898567e+00 9.280677707862375e+03 + 61640 1.029916542576110e+00 -6.102360149968993e+00 -5.989777302431670e+00 3.162749491517002e+00 4.809217624215659e+00 9.185701853494915e+03 + 61660 9.694615536529152e-01 -6.015846099566195e+00 -6.024713645647333e+00 3.579381329618545e+00 4.528462507772330e+00 9.293064714370934e+03 + 61680 9.864504577856739e-01 -6.043833456124684e+00 -5.976676375501144e+00 3.450534906166751e+00 4.836161255631757e+00 9.145588768237598e+03 + 61700 9.553350790039336e-01 -5.994246771243653e+00 -6.030353901881091e+00 3.699374827054574e+00 4.492042095374002e+00 9.310452051636210e+03 + 61720 9.449258183792295e-01 -5.973296389136583e+00 -6.005891240389476e+00 3.865634207672111e+00 4.678469527741074e+00 9.235115380297195e+03 + 61740 9.803583215159333e-01 -6.015820894218590e+00 -5.974685661520995e+00 3.668371505362269e+00 4.904576377168544e+00 9.139479992816658e+03 + 61760 1.024934585641631e+00 -6.063931966926279e+00 -5.973403013695261e+00 3.365510304919900e+00 4.885341563682637e+00 9.135605054751508e+03 + 61780 1.053036280692463e+00 -6.079157652587177e+00 -5.988275767738372e+00 3.264995424360284e+00 4.786853271088346e+00 9.181075025029904e+03 + 61800 9.829226760819189e-01 -5.942664881518653e+00 -6.009825452759612e+00 4.040203423499570e+00 4.654557030369173e+00 9.247214531297353e+03 + 61820 1.037986424399148e+00 -5.984374079973818e+00 -5.973052088178509e+00 3.781196730579395e+00 4.846209359540625e+00 9.134507745804895e+03 + 61840 1.042104754115736e+00 -5.946503162648386e+00 -6.003751777888934e+00 3.982704725784891e+00 4.653974317879092e+00 9.228569502368411e+03 + 61860 1.067509056410986e+00 -5.945535544555412e+00 -6.019858688216872e+00 3.980187597727642e+00 4.553412605354229e+00 9.278099795764236e+03 + 61880 1.029515798354857e+00 -5.859229579961484e+00 -6.033312674419276e+00 4.444736692685390e+00 4.445124625036949e+00 9.319612701714856e+03 + 61900 1.141344741310598e+00 -6.008034631700263e+00 -6.025522025155319e+00 3.615476182652930e+00 4.515060863268609e+00 9.295562601513226e+03 + 61920 1.065136092349673e+00 -5.888239003200082e+00 -6.040642823780544e+00 4.259268464061610e+00 4.384142141873588e+00 9.342226528817821e+03 + 61940 9.987893751008103e-01 -5.793682152696769e+00 -6.064621280751471e+00 4.800644959236443e+00 4.244870558251788e+00 9.416485359430086e+03 + 61960 1.119082207095418e+00 -5.985123332760330e+00 -6.015514703131416e+00 3.829553899214146e+00 4.655041947494005e+00 9.264736509970477e+03 + 61980 1.033188472321082e+00 -5.882455842158323e+00 -6.030283729440821e+00 4.367927823621811e+00 4.519077218554082e+00 9.310235737964213e+03 + 62000 1.095172582141058e+00 -6.003633994266933e+00 -5.990765851514809e+00 3.695839447578575e+00 4.769730314599928e+00 9.188712661515037e+03 + 62020 1.013766400857933e+00 -5.917169885208084e+00 -5.993055539590889e+00 4.136164032920583e+00 4.700416862187449e+00 9.195745410340076e+03 + 62040 9.833814838985087e-01 -5.901867246834272e+00 -6.033407149413845e+00 4.219066239213107e+00 4.463743762867060e+00 9.319865873810304e+03 + 62060 9.232744067696529e-01 -5.838437632843046e+00 -6.060400526538004e+00 4.520014587246910e+00 4.245469303003675e+00 9.403371456344574e+03 + 62080 1.067800531141307e+00 -6.074083093573461e+00 -5.981436855789848e+00 3.238185270418877e+00 4.770174304731345e+00 9.160154113687877e+03 + 62100 1.001618554581549e+00 -5.990077456146822e+00 -6.045855820604262e+00 3.694427519601059e+00 4.374139519212432e+00 9.358361356606802e+03 + 62120 1.103996603347696e+00 -6.154469137182450e+00 -5.941129333541703e+00 2.901222593434167e+00 5.126252760167253e+00 9.037227004131721e+03 + 62140 1.023491611478847e+00 -6.043240727990319e+00 -6.012460461789459e+00 3.473771621801052e+00 4.650516673557187e+00 9.255335659914041e+03 + 62160 9.778317882328085e-01 -5.983385290082311e+00 -6.038585533450189e+00 3.734599301629169e+00 4.417630962000759e+00 9.335876915553396e+03 + 62180 9.459327274506478e-01 -5.941956817178966e+00 -6.054717552351121e+00 3.955335641063033e+00 4.307846050037145e+00 9.385783345135143e+03 + 62200 9.454884344079292e-01 -5.945126773794835e+00 -6.035196535721229e+00 3.937742168279464e+00 4.420547657047496e+00 9.325426904862139e+03 + 62220 9.872919160739323e-01 -6.010367863494485e+00 -5.976743369628855e+00 3.705395078661452e+00 4.898472125811514e+00 9.145798200440675e+03 + 62240 9.909092868996452e-01 -6.016748356760095e+00 -6.010050107111287e+00 3.608945222706521e+00 4.647407608740762e+00 9.247929211579731e+03 + 62260 1.026008594964891e+00 -6.070386604680373e+00 -6.012162448532495e+00 3.285161895198021e+00 4.619494009958187e+00 9.254430707301744e+03 + 62280 9.769901480224044e-01 -5.999644758640054e+00 -5.991403915490690e+00 3.694120998615567e+00 4.741441195245567e+00 9.190655430735773e+03 + 62300 9.593415937376595e-01 -5.975189677885592e+00 -5.961200601146051e+00 3.852747051972373e+00 4.933074495413448e+00 9.098278769273636e+03 + 62320 9.412831322453625e-01 -5.945806545413086e+00 -5.942014030191040e+00 3.983535099067260e+00 5.005312308362084e+00 9.039849671295615e+03 + 62340 9.463177085193605e-01 -5.943694900369366e+00 -5.916506906109714e+00 4.038086761951024e+00 5.194204432318467e+00 8.962439345227185e+03 + 62360 1.006943557923969e+00 -6.014613893138720e+00 -5.948628483197519e+00 3.592836584618837e+00 4.971735019710403e+00 9.059995175013557e+03 + 62380 9.965566031564339e-01 -5.971208172570700e+00 -5.983382452146556e+00 3.860506050306090e+00 4.790599453017850e+00 9.166096260046679e+03 + 62400 9.944976981697846e-01 -5.936866577848943e+00 -5.994045686986631e+00 4.064745403508277e+00 4.736414110401134e+00 9.198762522456778e+03 + 62420 1.015894981100166e+00 -5.930741561645382e+00 -6.061938010278445e+00 4.002622614803411e+00 4.249272304167552e+00 9.408136840152114e+03 + 62440 1.037669063384203e+00 -5.926688561315016e+00 -6.001284781187461e+00 4.074480065760626e+00 4.646137027525328e+00 9.220963546749343e+03 + 62460 1.035992279573005e+00 -5.890208169940077e+00 -5.976721939414675e+00 4.317094910533779e+00 4.820319458248074e+00 9.145717288913607e+03 + 62480 1.066995588480791e+00 -5.905177099966295e+00 -6.039393681191653e+00 4.221650006811007e+00 4.450957627466185e+00 9.338354277081216e+03 + 62500 1.081294896306551e+00 -5.906622024378319e+00 -6.005496963597978e+00 4.149884853198679e+00 4.582129651352004e+00 9.233929347377287e+03 + 62520 1.106087681364176e+00 -5.932649874268967e+00 -6.005536300181316e+00 4.089968674559200e+00 4.671443537832542e+00 9.234043283701332e+03 + 62540 1.061937596909736e+00 -5.867343849235407e+00 -6.021100268975403e+00 4.405579726002757e+00 4.522686570126646e+00 9.281921140168261e+03 + 62560 1.089823767824810e+00 -5.919165954942680e+00 -6.035854003176727e+00 4.091170316780468e+00 4.421129486403466e+00 9.327421246697058e+03 + 62580 1.089429250016763e+00 -5.940359534443325e+00 -5.988055297367142e+00 3.968202833811559e+00 4.694326382207546e+00 9.180418790171363e+03 + 62600 9.684034447745520e-01 -5.795288751506830e+00 -6.032038383437884e+00 4.760050896083818e+00 4.400597872648574e+00 9.315629622684044e+03 + 62620 1.023458966542059e+00 -5.919625514277941e+00 -5.990997749239352e+00 4.141335005715377e+00 4.731504587749291e+00 9.189416442487882e+03 + 62640 1.025370736275058e+00 -5.969763788243594e+00 -5.981946137106796e+00 3.882837306844079e+00 4.812884374459180e+00 9.161679096948954e+03 + 62660 1.018772072729489e+00 -6.001847704842594e+00 -5.948995227049875e+00 3.749527469746766e+00 5.053014576127062e+00 9.061143529508119e+03 + 62680 9.806772337940259e-01 -5.977032718697505e+00 -6.020839424891445e+00 3.766474570006991e+00 4.514929683975510e+00 9.281124265863398e+03 + 62700 9.413686363415079e-01 -5.936659276371264e+00 -6.013150613264209e+00 4.052481320013379e+00 4.613256226577961e+00 9.257440097904853e+03 + 62720 9.974636241998932e-01 -6.029915719029262e+00 -5.961674628244488e+00 3.564414670123375e+00 4.956265573684218e+00 9.099763099819176e+03 + 62740 9.761842146170331e-01 -6.002310068539187e+00 -5.993186938703166e+00 3.672421069661672e+00 4.724807492979881e+00 9.196088726555505e+03 + 62760 1.007785924344952e+00 -6.050324024961209e+00 -5.954685644649416e+00 3.477515530163222e+00 5.026685909905062e+00 9.078441954889087e+03 + 62780 9.888615018315380e-01 -6.019881209454237e+00 -5.973346598973175e+00 3.560203637828158e+00 4.827412572418112e+00 9.135403517860543e+03 + 62800 9.885952686534178e-01 -6.015196980243180e+00 -5.967416375979278e+00 3.657345739236780e+00 4.931709362944721e+00 9.117270870415578e+03 + 62820 1.036042704347277e+00 -6.079668317300062e+00 -5.989382685570827e+00 3.249897155497055e+00 4.768331224542677e+00 9.184469976219269e+03 + 62840 9.739512620619610e-01 -5.980101306436664e+00 -5.993292704939732e+00 3.780054883084091e+00 4.704307831517152e+00 9.196469608532176e+03 + 62860 9.761988946756960e-01 -5.975482683596345e+00 -6.005286135414658e+00 3.812065900588540e+00 4.640929868178523e+00 9.233283470550436e+03 + 62880 9.819470639997621e-01 -5.973754484528095e+00 -5.991552520217201e+00 3.846532935913688e+00 4.744333860749723e+00 9.191137069803890e+03 + 62900 1.011465636982320e+00 -6.003650993732537e+00 -6.032213412666207e+00 3.643426766675158e+00 4.479416937137976e+00 9.316205611311634e+03 + 62920 9.826653895523108e-01 -5.948538643841617e+00 -6.035554461044709e+00 3.977253483924385e+00 4.477595195890032e+00 9.326510802120034e+03 + 62940 1.024434483149470e+00 -5.999444653233049e+00 -6.029627323946122e+00 3.675526793305200e+00 4.502213227317539e+00 9.308231215691580e+03 + 62960 9.793616201459322e-01 -5.922110440194682e+00 -6.058270554341453e+00 4.120225880952586e+00 4.338373434812262e+00 9.396797822500601e+03 + 62980 1.025464946994930e+00 -5.981982622067201e+00 -6.007011028241269e+00 3.783373333739442e+00 4.639656352354602e+00 9.238591054828727e+03 + 63000 1.008704979515388e+00 -5.948694321433669e+00 -6.013462780682228e+00 3.924918803093109e+00 4.553008287201205e+00 9.258432086525905e+03 + 63020 1.071658360818167e+00 -6.034758728509550e+00 -6.001950532944242e+00 3.516961674531943e+00 4.705351410519799e+00 9.223044690914267e+03 + 63040 1.065330843849768e+00 -6.021043935566416e+00 -6.013970172031030e+00 3.584632876260151e+00 4.625251521141706e+00 9.259993200562163e+03 + 63060 1.042154054848827e+00 -5.988421074965594e+00 -6.006150809281766e+00 3.785569717028937e+00 4.683762838917961e+00 9.235931851231813e+03 + 63080 1.027932012205127e+00 -5.973203619287779e+00 -5.993555469374167e+00 3.803930994392104e+00 4.687067521757445e+00 9.197271565580919e+03 + 63100 1.040804392818381e+00 -6.000528627428446e+00 -5.959961504918008e+00 3.704885459740198e+00 4.937828154937056e+00 9.094527328633521e+03 + 63120 1.006026547289446e+00 -5.961441812629337e+00 -6.005100772564921e+00 3.837467054684912e+00 4.586770550532576e+00 9.232695830482035e+03 + 63140 1.029798153553050e+00 -6.015701122156917e+00 -5.971229081988095e+00 3.603550873036558e+00 4.858916209711913e+00 9.128927766894354e+03 + 63160 1.025771171471559e+00 -6.032670444310147e+00 -5.995400395970617e+00 3.515468600833028e+00 4.729478985919949e+00 9.202932585270699e+03 + 63180 9.631959121895662e-01 -5.968298767765773e+00 -6.053125716361849e+00 3.798990952237086e+00 4.311901486470542e+00 9.380849697869387e+03 + 63200 9.280178366504234e-01 -5.948448896945381e+00 -6.027863168784156e+00 3.948839198385943e+00 4.492830160168849e+00 9.302771923519034e+03 + 63220 9.319794185346946e-01 -5.984337605596137e+00 -5.998924473496148e+00 3.748798756170046e+00 4.665038703377668e+00 9.213736474205949e+03 + 63240 9.045872326390025e-01 -5.968411625001528e+00 -5.970118483353056e+00 3.861914864609539e+00 4.852113819819595e+00 9.125514117740009e+03 + 63260 9.817412893858715e-01 -6.101160895445014e+00 -5.957493812371935e+00 3.124607058050106e+00 4.949565681464982e+00 9.086993279566077e+03 + 63280 9.239800140321087e-01 -6.027297148187717e+00 -5.937447714149652e+00 3.641698043258198e+00 5.157627397659746e+00 9.025999568208203e+03 + 63300 9.587945790927189e-01 -6.084179694153965e+00 -5.951486769153604e+00 3.262669502625198e+00 5.024612812141054e+00 9.068718231598468e+03 + 63320 9.929204061403325e-01 -6.133226564890825e+00 -5.954694171930544e+00 3.018565484415354e+00 5.043726112591811e+00 9.078490832562426e+03 + 63340 9.158846842272510e-01 -6.009697491354939e+00 -5.978004668897957e+00 3.683906611520264e+00 4.865891702516679e+00 9.149655099529435e+03 + 63360 9.769240328269264e-01 -6.083293072091779e+00 -5.962482212853660e+00 3.247818744206460e+00 4.941533393371789e+00 9.102242904366129e+03 + 63380 9.851771204804662e-01 -6.068137785833398e+00 -5.998683576085343e+00 3.324482399906194e+00 4.723299220283748e+00 9.213012867599618e+03 + 63400 9.857459058777780e-01 -6.033315161749473e+00 -5.966134640393195e+00 3.582275385500284e+00 4.968036335280116e+00 9.113358618291519e+03 + 63420 9.457765451220203e-01 -5.929153849514661e+00 -6.027949035388561e+00 4.057355267178825e+00 4.490058021385289e+00 9.303026477564745e+03 + 63440 1.011046782635618e+00 -5.979918734940425e+00 -6.017743377033099e+00 3.777409634826612e+00 4.560214686586030e+00 9.271605805891904e+03 + 63460 1.073777476473059e+00 -6.033809738184863e+00 -6.037141383789757e+00 3.473750663583085e+00 4.454619838949293e+00 9.331423957826351e+03 + 63480 9.819039911558899e-01 -5.871980798014524e+00 -6.051817920064313e+00 4.400587100747927e+00 4.367934516233348e+00 9.376793317788171e+03 + 63500 1.047613982452744e+00 -5.956751278791237e+00 -6.026835973812791e+00 3.912650705663611e+00 4.510213541278342e+00 9.299607483368287e+03 + 63520 1.020193482747235e+00 -5.910659234009197e+00 -6.023471294792973e+00 4.204735791549656e+00 4.556951480919229e+00 9.289254586368488e+03 + 63540 1.026809206204617e+00 -5.922780285837630e+00 -6.025209339138868e+00 4.071935740959562e+00 4.483772266059083e+00 9.294582279403156e+03 + 63560 1.072367806096915e+00 -5.995091235794606e+00 -6.002598139914095e+00 3.730447692980064e+00 4.687341887836299e+00 9.225036809141504e+03 + 63580 1.023623413703573e+00 -5.932818212136196e+00 -5.967785502501092e+00 4.098774556962713e+00 4.897986964516779e+00 9.118429703035059e+03 + 63600 1.039826158804733e+00 -5.967032044540379e+00 -6.012721197569079e+00 3.848738186726391e+00 4.586383999662014e+00 9.256155497611318e+03 + 63620 1.059980028067638e+00 -6.010633786400336e+00 -6.030479902326549e+00 3.603896799359462e+00 4.489937330534634e+00 9.310861336137796e+03 + 63640 1.018402075481751e+00 -5.967625607360969e+00 -6.013423144098168e+00 3.863401313861679e+00 4.600424770770777e+00 9.258313124312017e+03 + 63660 1.014865415896960e+00 -5.982081319574339e+00 -6.004690373316318e+00 3.812218320572083e+00 4.682393635245876e+00 9.231427873521438e+03 + 63680 1.029326664780490e+00 -6.022113502236264e+00 -6.010045958840003e+00 3.572478073761755e+00 4.641771775389397e+00 9.247905893701329e+03 + 63700 9.945723101857432e-01 -5.991524719286261e+00 -6.011213177129822e+00 3.737104012685281e+00 4.624049840968549e+00 9.251496120253165e+03 + 63720 9.607540476939712e-01 -5.961478737663711e+00 -6.008336622907481e+00 3.887676379518982e+00 4.618611151214949e+00 9.242635169873653e+03 + 63740 9.783746425676478e-01 -6.004308596012074e+00 -5.965007652363307e+00 3.713172547854090e+00 4.938844648086685e+00 9.109909511289668e+03 + 63760 9.449029602749898e-01 -5.966172609613625e+00 -6.010216310787241e+00 3.914487546523195e+00 4.661581798643559e+00 9.248420331714735e+03 + 63780 1.022454769871586e+00 -6.088740144391313e+00 -6.016707256769598e+00 3.183836238677741e+00 4.597460226454961e+00 9.268428204484617e+03 + 63800 9.986726902931755e-01 -6.062012549096561e+00 -5.994704007875488e+00 3.387068507689208e+00 4.773564567343702e+00 9.200809872848145e+03 + 63820 9.853202186434556e-01 -6.049656067198745e+00 -6.014650645417757e+00 3.441852746613843e+00 4.642859295551789e+00 9.262070074724750e+03 + 63840 9.368594277782202e-01 -5.984594551161003e+00 -6.008111744861891e+00 3.768852216682431e+00 4.633812851177970e+00 9.241953878926030e+03 + 63860 9.359417309510070e-01 -5.986423546936924e+00 -6.002498577191968e+00 3.750079738703742e+00 4.657774427376387e+00 9.224712057141462e+03 + 63880 9.565154353997274e-01 -6.015495571439857e+00 -6.021318870694260e+00 3.558037629937056e+00 4.524599344465628e+00 9.282590607441360e+03 + 63900 9.850053348524292e-01 -6.052040984054347e+00 -5.992069219454899e+00 3.433565906272784e+00 4.777933059203389e+00 9.192729626105642e+03 + 63920 9.458483358713964e-01 -5.979151653435197e+00 -6.018750673380209e+00 3.760336684327901e+00 4.532952983875109e+00 9.274702202951492e+03 + 63940 9.759726956889762e-01 -5.999800632496981e+00 -5.971499530031152e+00 3.736519191568076e+00 4.899028501508314e+00 9.129744877350651e+03 + 63960 9.961867359843239e-01 -5.994002243660457e+00 -5.997523276928232e+00 3.777537060450894e+00 4.757318742549194e+00 9.209433046250784e+03 + 63980 9.580420443866193e-01 -5.893103256043563e+00 -6.012259011206742e+00 4.274088846628159e+00 4.589878061187673e+00 9.254734545458123e+03 + 64000 1.003310115833148e+00 -5.916475754533387e+00 -6.056885745658179e+00 4.082633857460446e+00 4.276377960045989e+00 9.392507223378614e+03 + 64020 1.066506367378135e+00 -5.973702400335957e+00 -6.024244906270763e+00 3.841766631957318e+00 4.551543741452146e+00 9.291633860607977e+03 + 64040 1.062201548727471e+00 -5.944496783488112e+00 -5.950512817701010e+00 4.032127272992513e+00 4.997582273563767e+00 9.065759480237059e+03 + 64060 9.493812502936735e-01 -5.760103571878942e+00 -6.024456310680781e+00 4.948517045029253e+00 4.430562710374971e+00 9.292243175053169e+03 + 64080 1.008609541770014e+00 -5.834579641034106e+00 -6.008247269762795e+00 4.562814470626127e+00 4.565588071487302e+00 9.242356848805885e+03 + 64100 1.120369648389353e+00 -5.992017513751180e+00 -5.989085971070988e+00 3.759350206018000e+00 4.776183577742424e+00 9.183577556350254e+03 + 64120 1.087862457723697e+00 -5.945877704738129e+00 -6.022932050132463e+00 3.999986057428029e+00 4.557528082052356e+00 9.287576428048858e+03 + 64140 1.036441755032167e+00 -5.881906071942267e+00 -6.038269199036900e+00 4.298663377740539e+00 4.400802104847442e+00 9.334908519438428e+03 + 64160 1.076075733757537e+00 -5.963311356003650e+00 -6.012679270480314e+00 3.890882129491142e+00 4.607403924906061e+00 9.256022193808094e+03 + 64180 1.021680785778537e+00 -5.913679970376115e+00 -6.032592653398145e+00 4.117951660294665e+00 4.435136632703943e+00 9.317332486194706e+03 + 64200 1.042074111458011e+00 -5.979086941150754e+00 -5.942882068673196e+00 3.778011142890716e+00 4.985905123342769e+00 9.042520910674513e+03 + 64220 9.727289736547844e-01 -5.909367978886213e+00 -6.016334251395611e+00 4.176863869999002e+00 4.562646980272867e+00 9.267238479392869e+03 + 64240 1.006589168793295e+00 -5.991991139749508e+00 -6.008777033006195e+00 3.685277615740957e+00 4.588890419052479e+00 9.244030543358342e+03 + 64260 9.883898949615147e-01 -5.994135957505360e+00 -6.004306708544147e+00 3.704907605023625e+00 4.646505578640275e+00 9.230299200775093e+03 + 64280 9.818514898713160e-01 -6.008076183678162e+00 -5.983299378374969e+00 3.680679837414999e+00 4.822952087664163e+00 9.165821403732953e+03 + 64300 9.986243689270662e-01 -6.049662586229292e+00 -5.966510751578223e+00 3.418503864896565e+00 4.895974567167833e+00 9.114520533539397e+03 + 64320 1.000412635844610e+00 -6.063018251625168e+00 -5.969437392314848e+00 3.344255232793161e+00 4.881611008544196e+00 9.123477658999682e+03 + 64340 9.912370828701690e-01 -6.055009199200229e+00 -5.989476717997743e+00 3.342468555276638e+00 4.718766203460008e+00 9.184790248359306e+03 + 64360 1.001545206296879e+00 -6.072522449282598e+00 -6.005947668678487e+00 3.294336497353398e+00 4.676619189996206e+00 9.235319489241065e+03 + 64380 9.552162634110006e-01 -6.004612235815550e+00 -6.014634253896670e+00 3.649711105765573e+00 4.592163127041498e+00 9.262048749773028e+03 + 64400 9.393099083480686e-01 -5.979586268680275e+00 -6.023672135207129e+00 3.797234661722231e+00 4.544086793859234e+00 9.289872583607432e+03 + 64420 1.036677794366756e+00 -6.121168270393387e+00 -5.976337888223911e+00 3.035577102074269e+00 4.867215568920605e+00 9.144572116841262e+03 + 64440 9.844402662131657e-01 -6.038089600081673e+00 -5.996790326013798e+00 3.500788759974591e+00 4.737935582714336e+00 9.207195265151828e+03 + 64460 9.316825937454173e-01 -5.951550955208468e+00 -6.004385148914509e+00 3.949284708684203e+00 4.645902592359064e+00 9.230526854520211e+03 + 64480 1.000985352296279e+00 -6.041112049539642e+00 -5.998907619495845e+00 3.502912004134307e+00 4.745256372560233e+00 9.213696179865237e+03 + 64500 9.373949049163564e-01 -5.931333286508147e+00 -6.049239070099915e+00 4.045413831248596e+00 4.368380576003625e+00 9.368813462582093e+03 + 64520 9.575008668139905e-01 -5.945600161232155e+00 -5.998450472223661e+00 3.971095505017687e+00 4.667620840745260e+00 9.212280398441593e+03 + 64540 1.017930553810809e+00 -6.014739857501250e+00 -6.016665878500361e+00 3.645388598625590e+00 4.634329087997910e+00 9.268266019213524e+03 + 64560 9.695351918443063e-01 -5.915432662417722e+00 -6.020541677920328e+00 4.141328914061977e+00 4.537776681478427e+00 9.280240227077016e+03 + 64580 1.061373159911985e+00 -6.014663881657287e+00 -5.998446922291521e+00 3.613065505709245e+00 4.706185795953824e+00 9.212297799013344e+03 + 64600 9.986079072162235e-01 -5.877030817866021e+00 -5.999323909637960e+00 4.355363239382890e+00 4.653137381633624e+00 9.214979660098450e+03 + 64620 1.106149048371082e+00 -5.982270034458686e+00 -6.031583859581318e+00 3.740845307811537e+00 4.457677692667612e+00 9.314255816572982e+03 + 64640 1.069250763283860e+00 -5.873519047872080e+00 -6.027724685614988e+00 4.419949197854041e+00 4.534476562688941e+00 9.302344721388705e+03 + 64660 1.123901882577953e+00 -5.916153047307929e+00 -6.017978382566520e+00 4.165718148934864e+00 4.581021316460327e+00 9.272270689594527e+03 + 64680 1.136406057644009e+00 -5.913121243580729e+00 -5.978950142837332e+00 4.186841654650135e+00 4.808841928129483e+00 9.152484136235393e+03 + 64700 1.138012434260695e+00 -5.907068729953219e+00 -6.019335641960604e+00 4.200060405812726e+00 4.555406423817841e+00 9.276474892615865e+03 + 64720 1.104236866995707e+00 -5.863501866490108e+00 -6.033812227974245e+00 4.488607642456103e+00 4.510659191370928e+00 9.321128573667462e+03 + 64740 1.099430920613121e+00 -5.873425909071909e+00 -6.040012262603555e+00 4.407347652163072e+00 4.450783031029465e+00 9.340262960279515e+03 + 64760 1.152095315537335e+00 -5.976181694733059e+00 -6.027342515506551e+00 3.869936268086412e+00 4.576162918093593e+00 9.301175720615593e+03 + 64780 1.158894199998673e+00 -6.016368942879380e+00 -5.998416253054008e+00 3.648713172992803e+00 4.751800296139862e+00 9.212176522118505e+03 + 64800 1.079715774013112e+00 -5.925461512820438e+00 -6.032337775372649e+00 4.092982166571727e+00 4.479282127948754e+00 9.316596751587167e+03 + 64820 1.133106650600378e+00 -6.032523636106405e+00 -6.029909490984015e+00 3.517012944992208e+00 4.532023770822621e+00 9.309084340395057e+03 + 64840 1.082422500381488e+00 -5.986153447815374e+00 -5.998303716871964e+00 3.779104382353485e+00 4.709335657182481e+00 9.211851127958296e+03 + 64860 1.041032782256140e+00 -5.951462078125060e+00 -6.003483349262452e+00 3.953246617748094e+00 4.654532428611498e+00 9.227706470636687e+03 + 64880 9.847883316651345e-01 -5.890016994726702e+00 -5.978678723806104e+00 4.285237562374158e+00 4.776128193641999e+00 9.151677108292464e+03 + 64900 9.953025786961780e-01 -5.923202288663068e+00 -5.978033808424744e+00 4.067575072957108e+00 4.752724001335300e+00 9.149729687582239e+03 + 64920 1.075785451914827e+00 -6.060512887410032e+00 -6.000941885754408e+00 3.344356188922957e+00 4.686422099012267e+00 9.219943071734959e+03 + 64940 1.062339713390021e+00 -6.063000938026938e+00 -5.981406319580043e+00 3.406354271415851e+00 4.874883197264317e+00 9.160053213325558e+03 + 64960 9.379199284841601e-01 -5.899339773647284e+00 -6.027364561574146e+00 4.205192820337231e+00 4.470054676289289e+00 9.301228478872579e+03 + 64980 9.542199539357837e-01 -5.942679077992116e+00 -6.035833579894796e+00 3.983555787531351e+00 4.448648221993581e+00 9.327360128897244e+03 + 65000 1.023352552975453e+00 -6.065776975960691e+00 -5.958600661342716e+00 3.354587222609745e+00 4.970010206627236e+00 9.090403643474689e+03 + 65020 9.442547372369401e-01 -5.962862866449044e+00 -5.970513617906954e+00 3.929742968181574e+00 4.885811169360289e+00 9.126744354919916e+03 + 65040 1.011470321414996e+00 -6.074292824329987e+00 -5.998023372115079e+00 3.262887335995571e+00 4.700838333273159e+00 9.211002547648051e+03 + 65060 9.559294447972756e-01 -6.003205997093528e+00 -5.991602263847186e+00 3.647091873063382e+00 4.713722305035792e+00 9.191315971000673e+03 + 65080 9.037393446547465e-01 -5.933161540474356e+00 -6.046732818235311e+00 4.014163290785985e+00 4.362019438784150e+00 9.361062911091753e+03 + 65100 9.452533990217297e-01 -6.000975013167154e+00 -5.989013073904189e+00 3.667724831680471e+00 4.736412138032533e+00 9.183355005123594e+03 + 65120 9.573719671976332e-01 -6.020639833081344e+00 -5.994074865889042e+00 3.562880445208243e+00 4.715420597741832e+00 9.198885088792887e+03 + 65140 9.828026722647268e-01 -6.056604850442708e+00 -5.980545259775145e+00 3.441641017638086e+00 4.878386957434850e+00 9.157407931622623e+03 + 65160 9.458443852636623e-01 -5.994965058188140e+00 -5.946453120322980e+00 3.743709304774989e+00 5.022272359194862e+00 9.053392944545703e+03 + 65180 9.727625115452220e-01 -6.018118691676275e+00 -5.978902347068054e+00 3.555979382185639e+00 4.781165701635755e+00 9.152380209138255e+03 + 65200 9.919763790717426e-01 -6.019586846582705e+00 -5.980360395482942e+00 3.633899011059561e+00 4.859143363548091e+00 9.156816911853342e+03 + 65220 9.663451806014972e-01 -5.944076749504652e+00 -6.012693101983437e+00 4.003150260372657e+00 4.609144546093243e+00 9.256042089820816e+03 + 65240 9.828059917615051e-01 -5.923400170442718e+00 -6.034006432393315e+00 4.093472665689930e+00 4.458354393305885e+00 9.321740999229289e+03 + 65260 1.068708784058185e+00 -6.006035299007579e+00 -5.967475234638855e+00 3.651754615724310e+00 4.873172472480202e+00 9.117442133227445e+03 + 65280 1.048260052767487e+00 -5.937586001803232e+00 -5.982815191630610e+00 4.032769781444872e+00 4.773056774261565e+00 9.164361158139351e+03 + 65300 1.095893455777025e+00 -5.977445913982258e+00 -5.971643729718593e+00 3.858838139565363e+00 4.892155179492442e+00 9.130195593002065e+03 + 65320 1.091811258685477e+00 -5.953577221513087e+00 -6.005024011229192e+00 3.965613473698706e+00 4.670198045783851e+00 9.232475121378935e+03 + 65340 1.044856660943211e+00 -5.879369417727929e+00 -6.060069784827506e+00 4.338845347053343e+00 4.301235875876137e+00 9.402365892068408e+03 + 65360 1.040988447554181e+00 -5.877766639346378e+00 -6.039274046820625e+00 4.316429902727068e+00 4.389029375819409e+00 9.337979788542320e+03 + 65380 9.890419143420222e-01 -5.810874523499997e+00 -5.994544360847625e+00 4.722244312698892e+00 4.667583683833342e+00 9.200261249283900e+03 + 65400 1.029645495067025e+00 -5.881770577377221e+00 -5.970019365867810e+00 4.299323930931474e+00 4.792585730962629e+00 9.125220679148015e+03 + 65420 1.060251928429955e+00 -5.943190310630442e+00 -5.977241757433022e+00 3.982392060640954e+00 4.786863383656175e+00 9.147284485434657e+03 + 65440 1.019121783373137e+00 -5.902872896071439e+00 -5.989657991825597e+00 4.182675965769502e+00 4.684342515998964e+00 9.185249768441236e+03 + 65460 1.076059565470839e+00 -6.010222207037476e+00 -5.977474815639834e+00 3.624031025341535e+00 4.812071614389234e+00 9.148013359297081e+03 + 65480 1.041389009012619e+00 -5.982649870182797e+00 -6.015153317266501e+00 3.770462546719682e+00 4.583822723672872e+00 9.263623206902725e+03 + 65500 1.023206214774157e+00 -5.978897601642629e+00 -6.049028807144020e+00 3.771382030912257e+00 4.368677796154293e+00 9.368174480512404e+03 + 65520 1.029011004227786e+00 -6.011670328717359e+00 -5.986789528717868e+00 3.666618040645287e+00 4.809487444533718e+00 9.176533514124823e+03 + 65540 9.757242701052797e-01 -5.952227277801682e+00 -6.007602611054625e+00 3.968066285287259e+00 4.650092552443732e+00 9.240391237181177e+03 + 65560 9.592383271024414e-01 -5.942755740309119e+00 -6.008595020340802e+00 4.035033222486600e+00 4.656973887949023e+00 9.243462131666261e+03 + 65580 1.048686369348883e+00 -6.086193547446296e+00 -5.994697983444187e+00 3.237716784290276e+00 4.763098471683156e+00 9.200785652437424e+03 + 65600 1.043521806596037e+00 -6.086817224246090e+00 -5.970257211803178e+00 3.216126909491451e+00 4.885432538542287e+00 9.125982505955944e+03 + 65620 9.774593127747844e-01 -5.993763930128718e+00 -6.006734616245240e+00 3.732486018642273e+00 4.658006331754013e+00 9.237745517011745e+03 + 65640 1.067800443726384e+00 -6.130454815211847e+00 -5.972312967283594e+00 3.043397770118092e+00 4.951472733293995e+00 9.132265565921538e+03 + 65660 9.779990340915540e-01 -6.000274350941320e+00 -6.015322439937025e+00 3.676816979950703e+00 4.590408524253119e+00 9.264153681257600e+03 + 65680 9.942739945525823e-01 -6.025660343557830e+00 -6.019763131354469e+00 3.551280938488499e+00 4.585143643550843e+00 9.277824144694348e+03 + 65700 1.018268082458024e+00 -6.061257355204458e+00 -6.047642625957879e+00 3.309673704343852e+00 4.387851586550253e+00 9.363880889079152e+03 + 65720 9.740302764191576e-01 -5.995745562925117e+00 -5.994041957822820e+00 3.763103927531318e+00 4.772886291660739e+00 9.198788797375966e+03 + 65740 1.001709180159406e+00 -6.034230360633322e+00 -6.020099652893245e+00 3.509711720182467e+00 4.590852430745946e+00 9.278870517408950e+03 + 65760 1.003122371744735e+00 -6.033960777155754e+00 -6.023733014152685e+00 3.518696058484299e+00 4.577425456389133e+00 9.290053442333972e+03 + 65780 8.675121503238773e-01 -5.830680943079776e+00 -6.087560878513758e+00 4.623207138312819e+00 4.148162797009355e+00 9.487774426563361e+03 + 65800 1.018284169273967e+00 -6.050379399813544e+00 -5.981361253206936e+00 3.456509982991949e+00 4.852822861330758e+00 9.159932067034502e+03 + 65820 1.006935310881990e+00 -6.026348658322816e+00 -6.016942227185641e+00 3.567659270483361e+00 4.621672453713533e+00 9.269124696013823e+03 + 65840 1.001375901871368e+00 -6.011535001289583e+00 -5.997973394868082e+00 3.643069529323482e+00 4.720942372047551e+00 9.210823779929757e+03 + 65860 9.933607190475716e-01 -5.990143284054682e+00 -6.005721236118526e+00 3.754586246010359e+00 4.665135234579476e+00 9.234613459169012e+03 + 65880 1.050975328644272e+00 -6.060215634934644e+00 -6.032851561535937e+00 3.366854370622662e+00 4.523983114654711e+00 9.318170444084893e+03 + 65900 1.000426726632251e+00 -5.967885195339933e+00 -5.999246724092002e+00 3.887970548068344e+00 4.707887796793072e+00 9.214749291094880e+03 + 65920 9.945489174347665e-01 -5.934554748251072e+00 -6.005314220986109e+00 4.084018682906196e+00 4.677706840468598e+00 9.233334206522451e+03 + 65940 1.040934292749284e+00 -5.970449483929085e+00 -5.983110608696709e+00 3.864144032728552e+00 4.791441895010129e+00 9.165255934690147e+03 + 65960 1.010007596505781e+00 -5.883503160239455e+00 -6.043076126747481e+00 4.301872558081109e+00 4.385579890555264e+00 9.349734518713358e+03 + 65980 1.148759998124574e+00 -6.049989840240140e+00 -5.995076100259435e+00 3.506965891692646e+00 4.822289084535653e+00 9.201942964046744e+03 + 66000 1.069068427566606e+00 -5.899774587346963e+00 -6.040751406298568e+00 4.210693025948485e+00 4.401182315436142e+00 9.342569682200998e+03 + 66020 1.110015934056683e+00 -5.941006994593684e+00 -6.026210987094728e+00 4.004688522328589e+00 4.515434012112366e+00 9.297689396154094e+03 + 66040 1.137733786828064e+00 -5.971045535505499e+00 -6.002397927177398e+00 3.868883572961104e+00 4.688853288214127e+00 9.224416225176748e+03 + 66060 1.080185705932078e+00 -5.888100880736138e+00 -6.010442279093865e+00 4.281865034732646e+00 4.579361793092370e+00 9.249124469756354e+03 + 66080 1.025138619855518e+00 -5.819253726273967e+00 -6.049406185819149e+00 4.640929733902702e+00 4.319358695216261e+00 9.369329481032310e+03 + 66100 1.099763731023909e+00 -5.953627008696292e+00 -6.012343147997401e+00 3.979696741862938e+00 4.642539583702783e+00 9.254970528913214e+03 + 66120 1.078230540742166e+00 -5.957644961621384e+00 -6.005328195069745e+00 3.927668146740602e+00 4.653863641323587e+00 9.233409114616652e+03 + 66140 9.734417008984010e-01 -5.847475606911382e+00 -5.993421256916630e+00 4.482934817003933e+00 4.644892309657454e+00 9.196834409642612e+03 + 66160 9.946284057296013e-01 -5.919114187439185e+00 -5.953497747633780e+00 4.132235019353375e+00 4.934799295877265e+00 9.074788629288998e+03 + 66180 9.708060288520367e-01 -5.914741458450351e+00 -5.978712407678747e+00 4.099973344146216e+00 4.732642254204367e+00 9.151780400217376e+03 + 66200 1.014974916202357e+00 -6.003406217764642e+00 -5.962389044420869e+00 3.670931605203974e+00 4.906458561930979e+00 9.101960553800434e+03 + 66220 1.001470725641395e+00 -6.001704250744334e+00 -6.022009382475545e+00 3.661037202493899e+00 4.544441993884302e+00 9.284755014731491e+03 + 66240 1.006220273569708e+00 -6.023409349163874e+00 -6.033012574132291e+00 3.529956686000107e+00 4.474813482137195e+00 9.318644217789395e+03 + 66260 9.782194972984947e-01 -5.993828707422923e+00 -6.010519544402745e+00 3.802443770477679e+00 4.706602401640858e+00 9.249358307968740e+03 + 66280 9.908869264474311e-01 -6.021106133253910e+00 -6.000019663448696e+00 3.620633136825902e+00 4.741714909568098e+00 9.217084456353577e+03 + 66300 1.020034630824749e+00 -6.069612313244798e+00 -5.974333230136956e+00 3.316782489397749e+00 4.863889728993435e+00 9.138435705446853e+03 + 66320 9.511238625755327e-01 -5.969843112470361e+00 -6.024244811792395e+00 3.837136510022721e+00 4.524753533879844e+00 9.291620482657047e+03 + 66340 9.714898467685636e-01 -5.999626991296810e+00 -6.024954439860316e+00 3.739553887432092e+00 4.594119758370442e+00 9.293802359490637e+03 + 66360 1.012260166776850e+00 -6.058454970693838e+00 -6.019840506657798e+00 3.329194168027486e+00 4.550924396091428e+00 9.278066783564984e+03 + 66380 1.003266121821861e+00 -6.043607882136898e+00 -6.007050391550767e+00 3.464858461837074e+00 4.674777230036023e+00 9.238710590489332e+03 + 66400 1.009456320348018e+00 -6.052328754002001e+00 -5.995214812220588e+00 3.400246325500061e+00 4.728203417562853e+00 9.202380413301162e+03 + 66420 9.343587568984277e-01 -5.937570443638043e+00 -6.006020143457339e+00 4.058297954789406e+00 4.665249185870195e+00 9.235522938064512e+03 + 66440 9.503047965886129e-01 -5.954019841400227e+00 -6.008719079277890e+00 3.913413624213580e+00 4.599322135640333e+00 9.243810371158041e+03 + 66460 9.696280401547355e-01 -5.971193084363878e+00 -5.987982538288606e+00 3.872333169534858e+00 4.775925526939472e+00 9.180153646196977e+03 + 66480 1.015017881851966e+00 -6.019645190588357e+00 -5.983741288297157e+00 3.611241529802151e+00 4.817407292869146e+00 9.167205749664821e+03 + 66500 1.057959754699335e+00 -6.056353373338747e+00 -6.054046300682630e+00 3.362294226967766e+00 4.375541795177531e+00 9.383712643052315e+03 + 66520 1.015807329619139e+00 -5.966431289323056e+00 -6.032950638132866e+00 3.841086570820030e+00 4.459122176118143e+00 9.318492615960706e+03 + 66540 1.050264140571100e+00 -5.989055129274790e+00 -5.953913580462945e+00 3.795045527969934e+00 4.996833739384653e+00 9.076089520825793e+03 + 66560 1.044767038688440e+00 -5.944603287253271e+00 -5.993003016918934e+00 3.948231212471732e+00 4.670312474897536e+00 9.195516605635814e+03 + 66580 1.010060643093009e+00 -5.852527984777908e+00 -6.010600982258619e+00 4.503443298882040e+00 4.595763685630494e+00 9.249591462320503e+03 + 66600 1.037752565804361e+00 -5.852458148558473e+00 -6.039429118137347e+00 4.508000191684914e+00 4.434383950698986e+00 9.338480503750281e+03 + 66620 1.123994865075966e+00 -5.947515713707972e+00 -6.035272928995831e+00 3.944343370695194e+00 4.440427860127131e+00 9.325674889152193e+03 + 66640 1.143493819075815e+00 -5.961661677516529e+00 -6.040189871472986e+00 3.900357772745592e+00 4.449436730848880e+00 9.340815469975352e+03 + 66660 1.021761236767090e+00 -5.780030575021286e+00 -6.106465901764150e+00 4.824541698481449e+00 3.950099536620369e+00 9.546751652521867e+03 + 66680 1.107905585672560e+00 -5.918187947094172e+00 -5.982355728999860e+00 4.137307748152503e+00 4.768846414517886e+00 9.162961173797634e+03 + 66700 1.080402229534054e+00 -5.896520295060216e+00 -5.999686250327597e+00 4.247378524678070e+00 4.654983644652783e+00 9.216069481013285e+03 + 66720 1.150680385491405e+00 -6.029969587925449e+00 -5.981853921307319e+00 3.565594552292289e+00 4.841882155888939e+00 9.161431186674032e+03 + 66740 1.109683714581079e+00 -6.012243185155223e+00 -6.037906409259394e+00 3.602350059206560e+00 4.454987855029316e+00 9.333777658150057e+03 + 66760 1.006496469842205e+00 -5.906699496924787e+00 -6.038371494367388e+00 4.253771519597263e+00 4.497690534106101e+00 9.335173261455562e+03 + 66780 1.045465265520584e+00 -6.003045768580300e+00 -5.990120989896773e+00 3.686029235404559e+00 4.760245314708411e+00 9.186722864119809e+03 + 66800 1.054719598448941e+00 -6.043571059307715e+00 -5.979266488347832e+00 3.496501896055073e+00 4.865748693606916e+00 9.153507356192094e+03 + 66820 1.025158956225415e+00 -6.016898328113887e+00 -6.013144323166510e+00 3.545303080827172e+00 4.566859158165395e+00 9.257445549416649e+03 + 66840 1.030738580282839e+00 -6.037541920680705e+00 -5.945410609800390e+00 3.510160916717602e+00 5.039193161066647e+00 9.050219246155890e+03 + 66860 1.034517081330480e+00 -6.051542967082438e+00 -5.956789523718410e+00 3.422800733753269e+00 4.966889668597492e+00 9.084883670750236e+03 + 66880 9.665251167567536e-01 -5.956030158204709e+00 -6.025983530594360e+00 3.948041447654047e+00 4.546358358143280e+00 9.296993528739964e+03 + 66900 1.027976343959499e+00 -6.053112865744838e+00 -6.021107665827106e+00 3.390966437057970e+00 4.574745247774268e+00 9.281985288512269e+03 + 66920 1.035908543912025e+00 -6.073894743250997e+00 -6.001896689724553e+00 3.262671064128053e+00 4.676095029139670e+00 9.222843074556109e+03 + 66940 9.184844932077428e-01 -5.906300096198942e+00 -6.007171425155247e+00 4.198532076160069e+00 4.619313295505260e+00 9.239066322376630e+03 + 66960 9.675114290761154e-01 -5.982000298177605e+00 -6.016792237999073e+00 3.723831294890430e+00 4.524050592400279e+00 9.268683297402637e+03 + 66980 9.980775021825152e-01 -6.030297149040487e+00 -6.008457281797232e+00 3.443648962466180e+00 4.569056859885483e+00 9.243041059731651e+03 + 67000 1.014661175527209e+00 -6.055450681272718e+00 -5.966535466815431e+00 3.385537139748468e+00 4.896102060747179e+00 9.114601977895209e+03 + 67020 9.809825643129686e-01 -6.005405135644025e+00 -6.004961524821542e+00 3.637496172434896e+00 4.640043454426144e+00 9.232284479602433e+03 + 67040 9.925217427807769e-01 -6.021734291615489e+00 -5.944791279718197e+00 3.626291567703969e+00 5.068110248910834e+00 9.048346806065429e+03 + 67060 1.045045209742671e+00 -6.094310057275067e+00 -5.978581805474740e+00 3.155526304972898e+00 4.820055835699458e+00 9.151416217083724e+03 + 67080 1.029032681680708e+00 -6.064094842698008e+00 -6.013966617507196e+00 3.330647990483311e+00 4.618492016846730e+00 9.259996556025222e+03 + 67100 9.653578352075562e-01 -5.963046874648354e+00 -6.010477459132173e+00 3.878670567549176e+00 4.606316811583858e+00 9.249233190612787e+03 + 67120 9.111914750514458e-01 -5.873954642728507e+00 -6.022400525489984e+00 4.354905471897273e+00 4.502506241154756e+00 9.285924952280346e+03 + 67140 1.012045505514191e+00 -6.008828714844642e+00 -5.973809279154077e+00 3.613094796304594e+00 4.814181815279980e+00 9.136834481195685e+03 + 67160 1.037322284428271e+00 -6.026638936251421e+00 -5.985533258359941e+00 3.501323285335869e+00 4.737358448871848e+00 9.172711505789448e+03 + 67180 9.945356287320889e-01 -5.938925525492723e+00 -6.057603632783982e+00 4.013822091367842e+00 4.332354033923687e+00 9.394716205735773e+03 + 67200 9.902636146576347e-01 -5.908320781601970e+00 -6.023235622178771e+00 4.237351661188532e+00 4.577492863582436e+00 9.288500631202858e+03 + 67220 1.034801977716242e+00 -5.949956350706637e+00 -6.016560708427788e+00 3.983545810567581e+00 4.601093281541691e+00 9.267947429512298e+03 + 67240 1.094741893894295e+00 -6.014162746613278e+00 -5.995825254781174e+00 3.630796090165475e+00 4.736092805983105e+00 9.204248677133743e+03 + 67260 1.063510806201818e+00 -5.947456089102931e+00 -6.018495490023627e+00 3.901420236478869e+00 4.493501003080469e+00 9.273938817471424e+03 + 67280 1.030211633956133e+00 -5.883328455719835e+00 -6.065474181772851e+00 4.275054063603320e+00 4.229145117646891e+00 9.419137096804589e+03 + 67300 1.057266281292817e+00 -5.916045975257955e+00 -6.011039821948060e+00 4.148966133224875e+00 4.603496765280027e+00 9.250960060604291e+03 + 67320 1.084516341467682e+00 -5.955276201353674e+00 -6.038558393428315e+00 3.843905129966247e+00 4.365685895196087e+00 9.335788907830007e+03 + 67340 1.064873261193631e+00 -5.931478498814941e+00 -6.063571001747287e+00 3.979706871203585e+00 4.221211278117284e+00 9.413243571481162e+03 + 67360 1.071087580253549e+00 -5.960422172350937e+00 -6.012114474902051e+00 3.879601789129118e+00 4.582776588522661e+00 9.254283617499683e+03 + 67380 1.036123680590614e+00 -5.942165427495971e+00 -5.990684529577715e+00 3.994366525180706e+00 4.715762332720550e+00 9.188474325612846e+03 + 67400 1.051582813033685e+00 -6.007179909111077e+00 -5.974667923295326e+00 3.665943750785678e+00 4.852632604553268e+00 9.139441977633478e+03 + 67420 9.709975521444160e-01 -5.934680098267561e+00 -6.039860079278758e+00 4.024598995972303e+00 4.420639268456557e+00 9.339836772836907e+03 + 67440 9.800332281181369e-01 -5.993985332204249e+00 -5.988866315888821e+00 3.731680575496282e+00 4.761074759344686e+00 9.182910633965370e+03 + 67460 9.727127352087102e-01 -6.018224159604705e+00 -5.957210256654268e+00 3.610311564970593e+00 4.960662837582968e+00 9.086142919915826e+03 + 67480 9.935865521129884e-01 -6.070808224808062e+00 -5.959274232517251e+00 3.286017356965337e+00 4.926462800528703e+00 9.092457202902164e+03 + 67500 9.659288915365276e-01 -6.041726304730241e+00 -6.006816563893703e+00 3.450681297495695e+00 4.651138431644029e+00 9.238005252809729e+03 + 67520 9.437216959995213e-01 -6.015515335158201e+00 -6.047887810345625e+00 3.559280465827150e+00 4.373392703676624e+00 9.364663274463783e+03 + 67540 1.018805057238960e+00 -6.131038816540118e+00 -6.004966308907223e+00 2.985726003101048e+00 4.709653851586630e+00 9.232318315624198e+03 + 67560 8.890172558509115e-01 -5.939195216749964e+00 -6.039957315440844e+00 4.007184226961141e+00 4.428592663393728e+00 9.340113013731758e+03 + 67580 9.385492618415294e-01 -6.008499065333626e+00 -6.053780067487033e+00 3.663169305417676e+00 4.403158783840382e+00 9.382881059434820e+03 + 67600 9.934606512002037e-01 -6.083047926480554e+00 -5.979991089950689e+00 3.267152315213068e+00 4.858920618561465e+00 9.155746363878472e+03 + 67620 9.773289644904192e-01 -6.047717312240374e+00 -6.038455927117944e+00 3.441805270766634e+00 4.494985577334345e+00 9.335467672049726e+03 + 67640 1.027830989682253e+00 -6.109438640164305e+00 -6.011097873406803e+00 3.091924864168302e+00 4.656612765074353e+00 9.251185531652034e+03 + 67660 1.010139484400637e+00 -6.068628031414050e+00 -6.009766175200919e+00 3.354728549090443e+00 4.692722436309057e+00 9.247057399872681e+03 + 67680 9.231937782787338e-01 -5.922962779643796e+00 -5.997665660922301e+00 4.122098009311824e+00 4.693142504777125e+00 9.209883647192377e+03 + 67700 9.930742251700908e-01 -6.006596237091420e+00 -5.982821254863474e+00 3.680646100554837e+00 4.817165727674313e+00 9.164405008556450e+03 + 67720 1.035096893606238e+00 -6.041593723610310e+00 -6.011939678914450e+00 3.531178869477331e+00 4.701456983069545e+00 9.253735381909983e+03 + 67740 1.037594562815710e+00 -6.019043692451458e+00 -5.984374325189156e+00 3.553101234055458e+00 4.752178105942838e+00 9.169154615161660e+03 + 67760 1.018464434681254e+00 -5.962429806436684e+00 -5.970074553258466e+00 3.929434730663952e+00 4.885537411392530e+00 9.125406249438678e+03 + 67780 1.029906905026654e+00 -5.946865140857094e+00 -6.005602303781080e+00 3.928476362119121e+00 4.591198483063006e+00 9.234257630196680e+03 + 67800 1.090930895736436e+00 -6.004827698174290e+00 -5.981713082960802e+00 3.718667360771149e+00 4.851395058302140e+00 9.161003031029926e+03 + 67820 1.042693508814884e+00 -5.903100599208122e+00 -6.047986962687466e+00 4.173231924455184e+00 4.341272004264509e+00 9.364948878169289e+03 + 67840 1.041026787681816e+00 -5.875924823950196e+00 -6.077563558815307e+00 4.309697206892895e+00 4.151856387804057e+00 9.456682619561718e+03 + 67860 1.066926500110198e+00 -5.896057128221269e+00 -6.007142861860547e+00 4.287039077814943e+00 4.649167604796483e+00 9.238956414163220e+03 + 67880 1.048544337115573e+00 -5.856593712239366e+00 -5.963823007783274e+00 4.480853490475383e+00 4.865126281782409e+00 9.106276317336960e+03 + 67900 1.057837220360690e+00 -5.860167888368156e+00 -5.978237300143055e+00 4.473276300880061e+00 4.795303467286169e+00 9.150342829856920e+03 + 67920 1.100985916644492e+00 -5.914119901500097e+00 -6.054259791430436e+00 4.112022035620860e+00 4.307317101062977e+00 9.384360949461605e+03 + 67940 1.084181408897506e+00 -5.890822860337608e+00 -6.029178191143545e+00 4.305460831529329e+00 4.511003111623395e+00 9.306793842762041e+03 + 67960 1.037499164465762e+00 -5.836590981593044e+00 -6.022496651890181e+00 4.605640155493202e+00 4.538141027837538e+00 9.286206995054910e+03 + 67980 1.094811827774892e+00 -5.953428792748918e+00 -6.018291503908625e+00 3.942457260585613e+00 4.570005535634467e+00 9.273262805702136e+03 + 68000 9.752374519098556e-01 -5.822614335543644e+00 -6.040614554218312e+00 4.617710894650749e+00 4.365919903595996e+00 9.342126112087342e+03 + 68020 1.019904820338775e+00 -5.936154114887150e+00 -6.010225630763998e+00 4.045186075880252e+00 4.619855969185354e+00 9.248454477428140e+03 + 68040 1.072022976081843e+00 -6.059593893396194e+00 -6.009303353015047e+00 3.393943616955830e+00 4.682719682260347e+00 9.245641793019744e+03 + 68060 1.006807607024998e+00 -6.005119202723638e+00 -6.041674279388438e+00 3.648891151952471e+00 4.438986244863361e+00 9.345428499924587e+03 + 68080 9.838454267410869e-01 -6.007810566786055e+00 -6.013181147680291e+00 3.652288758747965e+00 4.621450052158553e+00 9.257568848014051e+03 + 68100 9.267217073018031e-01 -5.951397793842877e+00 -6.025901587052223e+00 3.923982209573860e+00 4.496169899541057e+00 9.296709164082320e+03 + 68120 1.016948422495785e+00 -6.106074971665565e+00 -5.952050261500757e+00 3.146710196696843e+00 5.031143917710041e+00 9.070433997275897e+03 + 68140 9.438753743621873e-01 -6.011776684319846e+00 -5.989250924181849e+00 3.636731400362192e+00 4.766077800924686e+00 9.184073865712693e+03 + 68160 9.672068263374420e-01 -6.054542487150885e+00 -5.978878397635601e+00 3.430953183583238e+00 4.865428094560013e+00 9.152325206316666e+03 + 68180 1.024470142788593e+00 -6.144107759612810e+00 -5.989762546584246e+00 2.921245010258468e+00 4.807519108313004e+00 9.185673058707902e+03 + 68200 9.889891800882168e-01 -6.094343214049258e+00 -6.006144693348371e+00 3.176957151119697e+00 4.683406705661160e+00 9.235933751600342e+03 + 68220 9.382949753058375e-01 -6.017555137692742e+00 -6.016911374372552e+00 3.585723222391469e+00 4.589419810998054e+00 9.269041097361180e+03 + 68240 9.300158836562472e-01 -5.998464279014645e+00 -6.007483362171068e+00 3.673461502304512e+00 4.621672531121726e+00 9.240041860614194e+03 + 68260 9.722081216810353e-01 -6.049364703063667e+00 -6.007315329709964e+00 3.442320213845938e+00 4.683774222762398e+00 9.239511602044133e+03 + 68280 9.895926293987768e-01 -6.058885828631868e+00 -5.990540685045837e+00 3.374172753303237e+00 4.766621144151015e+00 9.188047696539257e+03 + 68300 9.595079793762733e-01 -5.993299896819209e+00 -6.021781009720743e+00 3.686602197293266e+00 4.523059239574678e+00 9.284038609288093e+03 + 68320 9.117840498664789e-01 -5.895743247489367e+00 -6.047526212296312e+00 4.213210689015853e+00 4.341649416756487e+00 9.363526138169025e+03 + 68340 9.723648590457549e-01 -5.955608493344664e+00 -5.989626655477355e+00 3.909247141950867e+00 4.713909590691383e+00 9.185213205174214e+03 + 68360 1.004831480827679e+00 -5.971030057111545e+00 -6.016351155793582e+00 3.801805039375094e+00 4.541564277325484e+00 9.267294025509300e+03 + 68380 1.009877735477846e+00 -5.947299387909505e+00 -5.964624781636716e+00 4.006121920105558e+00 4.906636828227897e+00 9.108751469956236e+03 + 68400 1.011815775503380e+00 -5.923419581669514e+00 -6.004340436200906e+00 4.095236979098734e+00 4.630576909917718e+00 9.230338786585540e+03 + 68420 1.120228201619910e+00 -6.061664055020864e+00 -5.968472436127905e+00 3.383589582169538e+00 4.918710279209325e+00 9.120519681024865e+03 + 68440 1.066519355260748e+00 -5.966600839988372e+00 -6.041889313987196e+00 3.833149815207118e+00 4.400831746652177e+00 9.346058317431158e+03 + 68460 1.015596865508945e+00 -5.883510444586338e+00 -6.017569405595361e+00 4.327173462363793e+00 4.557386162692814e+00 9.271062804701987e+03 + 68480 1.032624497610213e+00 -5.908544652832996e+00 -6.003078241942255e+00 4.188799757873143e+00 4.645973260182141e+00 9.226465394646300e+03 + 68500 1.000131835311615e+00 -5.864180613339229e+00 -6.031145100368463e+00 4.376064402878270e+00 4.417328480685543e+00 9.312891518459719e+03 + 68520 1.051750454197759e+00 -5.949321041045928e+00 -6.067293432294156e+00 3.910675865377326e+00 4.233260138661454e+00 9.424770863506303e+03 + 68540 1.014166407618716e+00 -5.910768561835623e+00 -6.041413276400032e+00 4.121788452559661e+00 4.371606284326586e+00 9.344608960883110e+03 + 68560 1.057700465267585e+00 -5.998238807531517e+00 -5.962281003848353e+00 3.690677158899802e+00 4.897152432100670e+00 9.101639621927749e+03 + 68580 9.479572945866706e-01 -5.860399954653880e+00 -6.051492616957435e+00 4.410307109222020e+00 4.313023470781085e+00 9.375759768944983e+03 + 68600 1.040854465800414e+00 -6.027131530410442e+00 -5.982855122083357e+00 3.506676873794838e+00 4.760918862161009e+00 9.164492351668210e+03 + 68620 1.018729827104335e+00 -6.020429717848271e+00 -5.994052637406304e+00 3.557365304271101e+00 4.708826582008879e+00 9.198796814603245e+03 + 68640 9.913987843793604e-01 -6.006060916982197e+00 -6.009758132482378e+00 3.664173902020241e+00 4.642943918475956e+00 9.247030391660363e+03 + 68660 9.880190789070139e-01 -6.025024877049546e+00 -6.008376032891793e+00 3.531902978341807e+00 4.627503217895931e+00 9.242801125856495e+03 + 68680 9.334084051983137e-01 -5.962791938200769e+00 -6.026978423864458e+00 3.824118631946610e+00 4.455549898439150e+00 9.300061850534506e+03 + 68700 9.384454904219944e-01 -5.981707239873182e+00 -6.024957471246437e+00 3.789711121429558e+00 4.541361599932650e+00 9.293825309770693e+03 + 68720 1.046027374070244e+00 -6.147076055934745e+00 -5.956723668613973e+00 2.906661660707237e+00 4.999694525639846e+00 9.084702966435460e+03 + 68740 9.486992988240669e-01 -6.003841259871783e+00 -5.984041157070878e+00 3.690993563545074e+00 4.804688817883882e+00 9.168117300765291e+03 + 68760 9.704346715714314e-01 -6.034496540326515e+00 -5.978160458135860e+00 3.455102440681337e+00 4.778592942600623e+00 9.150139732523608e+03 + 68780 1.013641136520927e+00 -6.093303350555248e+00 -5.985424035465829e+00 3.186855677682247e+00 4.806315399195742e+00 9.172363262240191e+03 + 68800 9.144277208672775e-01 -5.939495969183015e+00 -5.998812280193453e+00 4.005244914255635e+00 4.664641477264234e+00 9.213382368997900e+03 + 68820 9.333018535754948e-01 -5.957349399693246e+00 -5.998706295160906e+00 3.858222722320409e+00 4.620745028586215e+00 9.213087618516525e+03 + 68840 9.851493928308517e-01 -6.022964685691626e+00 -5.991940493796610e+00 3.543428183211157e+00 4.721573894050517e+00 9.192296960055361e+03 + 68860 9.434938618806449e-01 -5.948748570321367e+00 -5.976543181012717e+00 3.981252549339512e+00 4.821651593547678e+00 9.145135209271961e+03 + 68880 9.588175088911657e-01 -5.956862868603661e+00 -5.974456790028420e+00 3.945544547309466e+00 4.844517527837963e+00 9.138729127529756e+03 + 68900 9.744653219018354e-01 -5.961302800458627e+00 -5.950751095685412e+00 3.997187604453059e+00 5.057777126131899e+00 9.066421458317380e+03 + 68920 1.019564081598813e+00 -6.004924085593796e+00 -5.939319355068856e+00 3.668368257065376e+00 5.045080772038817e+00 9.031693198774226e+03 + 68940 1.010685331362514e+00 -5.967281440994053e+00 -5.983712374111588e+00 3.868008646581639e+00 4.773659685942070e+00 9.167094912838520e+03 + 68960 1.007687392619904e+00 -5.940978697280507e+00 -5.945243335967706e+00 3.983167397613843e+00 4.958679182321246e+00 9.049711154681843e+03 + 68980 1.003447874960950e+00 -5.911796299986793e+00 -5.997671637569777e+00 4.123577252997211e+00 4.630467775430176e+00 9.209878524030568e+03 + 69000 1.075274355662337e+00 -5.999821677522811e+00 -5.989997576300167e+00 3.711464823045240e+00 4.767876332540412e+00 9.186360145784383e+03 + 69020 1.033963165283710e+00 -5.924263675231807e+00 -6.020845880126675e+00 4.155553501225540e+00 4.600963534671305e+00 9.281142080128458e+03 + 69040 1.036928557025325e+00 -5.918743908717836e+00 -6.074646163582215e+00 4.083657522116015e+00 4.188442648888784e+00 9.447615322009495e+03 + 69060 1.044258113618064e+00 -5.928288439834048e+00 -6.034212119469940e+00 4.050693552179355e+00 4.442463392073617e+00 9.322382414205853e+03 + 69080 1.059459326141740e+00 -5.956876464061159e+00 -5.992333109334949e+00 3.985384174683948e+00 4.781786630623724e+00 9.193516196254308e+03 + 69100 9.849047026747783e-01 -5.858670978555253e+00 -6.035611152114821e+00 4.431921160206561e+00 4.415903302224151e+00 9.326662993759661e+03 + 69120 1.024838739143535e+00 -5.938749971706142e+00 -5.962956739661691e+00 4.024851754351905e+00 4.885852746765909e+00 9.103662184019338e+03 + 69140 9.902899932124012e-01 -5.916084141108882e+00 -6.024396648549645e+00 4.112933240847429e+00 4.490986061816215e+00 9.292086527790236e+03 + 69160 1.042306788255892e+00 -6.032453480299648e+00 -6.017440806436720e+00 3.472543153137463e+00 4.558748249662172e+00 9.270650678851845e+03 + 69180 1.019406965107340e+00 -6.045628741387449e+00 -5.987366358873903e+00 3.466370344020468e+00 4.800921960487806e+00 9.178300138240107e+03 + 69200 1.001163520033020e+00 -6.066530941477739e+00 -5.959635080865036e+00 3.341111243362488e+00 4.954923817081598e+00 9.093547020577938e+03 + 69220 9.879991392610417e-01 -6.084108281407361e+00 -5.978134758531469e+00 3.234435285782184e+00 4.842951653485217e+00 9.150053373971095e+03 + 69240 9.382962747098970e-01 -6.036199240633215e+00 -5.996990648252419e+00 3.488028398615518e+00 4.713170203576110e+00 9.207848076099952e+03 + 69260 9.812338724709685e-01 -6.114337566963933e+00 -5.982288504284372e+00 3.108189159378512e+00 4.866435311810963e+00 9.162775909190796e+03 + 69280 9.412562021764928e-01 -6.060525928242287e+00 -6.011634389743836e+00 3.349954371089106e+00 4.630697151088337e+00 9.252806005409180e+03 + 69300 9.408870177361662e-01 -6.059685523835410e+00 -6.012608274065905e+00 3.347290823458287e+00 4.617615676815638e+00 9.255816097367548e+03 + 69320 9.327491733997499e-01 -6.043982291018529e+00 -6.004865386490144e+00 3.482941969963893e+00 4.707557289087290e+00 9.231985545030388e+03 + 69340 9.397431608475214e-01 -6.046387312542032e+00 -6.002593409233991e+00 3.436777978864884e+00 4.688249348744296e+00 9.224993415276283e+03 + 69360 9.495452801287275e-01 -6.046616011437129e+00 -5.996982784684540e+00 3.463918346117792e+00 4.748920014848178e+00 9.207779949359048e+03 + 69380 9.738306559239879e-01 -6.065197717124311e+00 -6.015018409674704e+00 3.368841200344467e+00 4.656978548942845e+00 9.263211394609030e+03 + 69400 9.598789858393282e-01 -6.025569561287480e+00 -6.004689244742758e+00 3.563610834670167e+00 4.683508843488499e+00 9.231444455057152e+03 + 69420 9.941749203489039e-01 -6.055573092542616e+00 -6.026212061176351e+00 3.375886750958415e+00 4.544482336668427e+00 9.297686240339821e+03 + 69440 1.023894670745189e+00 -6.079558468737997e+00 -5.955677943081458e+00 3.327909644687157e+00 5.039250793456395e+00 9.081508353461004e+03 + 69460 1.029093875392457e+00 -6.068602790848482e+00 -5.986471491288456e+00 3.369668386641428e+00 4.841279018492630e+00 9.175554306300777e+03 + 69480 9.792433423116675e-01 -5.977161237868673e+00 -6.013043755135509e+00 3.756438624038982e+00 4.550395657091205e+00 9.257130619256297e+03 + 69500 9.328048157680555e-01 -5.891998114641646e+00 -6.021244179548226e+00 4.314109658841696e+00 4.571958753384207e+00 9.282334467695709e+03 + 69520 1.005794012832830e+00 -5.984705110523979e+00 -6.043924258552813e+00 3.709354710865605e+00 4.369309198750504e+00 9.352372225401237e+03 + 69540 9.688452838350087e-01 -5.916669643774752e+00 -6.028553154558140e+00 4.102551598841625e+00 4.460099166006076e+00 9.304901875777367e+03 + 69560 9.559410113108339e-01 -5.886576701845258e+00 -6.042357416117171e+00 4.278398434982454e+00 4.383881466645509e+00 9.347539454549071e+03 + 69580 1.019217639021093e+00 -5.973984159754081e+00 -5.999073069968986e+00 3.817137604692410e+00 4.673073199742116e+00 9.214186815282666e+03 + 69600 1.025647368555346e+00 -5.979400701225217e+00 -5.966463191915377e+00 3.819364201494218e+00 4.893653382024412e+00 9.114361484806544e+03 + 69620 1.039133762991373e+00 -5.996298860422524e+00 -5.990497612582082e+00 3.678071846078063e+00 4.711383508918080e+00 9.187878708611281e+03 + 69640 9.678250724812770e-01 -5.888550638365031e+00 -6.000707300182396e+00 4.286090753825563e+00 4.642069845482934e+00 9.219196281072789e+03 + 69660 1.108218439596053e+00 -6.097739024837245e+00 -5.967516494641372e+00 3.147898260263040e+00 4.895656180519160e+00 9.117610103866133e+03 + 69680 1.015884218402705e+00 -5.963867987125743e+00 -5.988902125354911e+00 3.950626156858185e+00 4.806876261125934e+00 9.182999205909098e+03 + 69700 1.078750192922928e+00 -6.063362120637528e+00 -5.988016845692251e+00 3.397881257947003e+00 4.830525486326398e+00 9.180299315568545e+03 + 69720 1.023989674573248e+00 -5.991311933360216e+00 -6.006521337817111e+00 3.723773173140301e+00 4.636438419101081e+00 9.237087195545648e+03 + 69740 1.043907612788110e+00 -6.030004272761485e+00 -5.985386223513388e+00 3.485513807592651e+00 4.741717550996032e+00 9.172244110551563e+03 + 69760 9.855258844270411e-01 -5.952326312771618e+00 -5.952862923915262e+00 3.992347048326526e+00 4.989265744099417e+00 9.072894438183102e+03 + 69780 1.008490619358759e+00 -5.991480691777755e+00 -5.924798705146660e+00 3.762463677460752e+00 5.145361963700583e+00 8.987614233113913e+03 + 69800 9.768201722638907e-01 -5.946731322094103e+00 -6.005928448009952e+00 3.898669639089970e+00 4.558750581355541e+00 9.235242404814710e+03 + 69820 9.844026951240963e-01 -5.958194927055757e+00 -6.015660591996427e+00 3.895035637687472e+00 4.565058896815239e+00 9.265181287775671e+03 + 69840 1.010596180323453e+00 -5.997919600672968e+00 -6.005956846925616e+00 3.670386022517257e+00 4.624234910774711e+00 9.235351643668326e+03 + 69860 9.748406791105271e-01 -5.946518880326788e+00 -6.011113623952737e+00 3.997393583499323e+00 4.626480569594856e+00 9.251169231989958e+03 + 69880 1.020277718700095e+00 -6.014887391637299e+00 -5.975131517784170e+00 3.668547576558483e+00 4.896831956424746e+00 9.140846370669844e+03 + 69900 1.029936795111498e+00 -6.030468731246760e+00 -5.972571785788999e+00 3.509648093336735e+00 4.842101313678548e+00 9.133043052821786e+03 + 69920 9.700978727879976e-01 -5.941941053479931e+00 -6.042721825331602e+00 3.949946207774847e+00 4.371247420028505e+00 9.348667494216550e+03 + 69940 9.936440920501012e-01 -5.979255450970929e+00 -6.007803570394982e+00 3.772561237608811e+00 4.608633518068699e+00 9.241016464042998e+03 + 69960 1.003130497428304e+00 -5.996242277028681e+00 -5.969039788753699e+00 3.757648261183772e+00 4.913849158430178e+00 9.122253330851694e+03 + 69980 1.044216552150625e+00 -6.059617274019580e+00 -5.965672748645492e+00 3.363628355778575e+00 4.903072358344904e+00 9.111960383400810e+03 + 70000 9.852857866268403e-01 -5.975417659615371e+00 -5.970595546649576e+00 3.866052625835466e+00 4.893741944704631e+00 9.126910560092116e+03 + 70020 9.521447088454075e-01 -5.927483317338010e+00 -5.952569967525423e+00 4.122190150795339e+00 4.978138723272644e+00 9.071984686956723e+03 + 70040 9.747547741272348e-01 -5.959234848799405e+00 -6.006684639081742e+00 3.898570742372665e+00 4.626106703740174e+00 9.237543811284933e+03 + 70060 1.021498447510868e+00 -6.025454432247567e+00 -6.029011446204793e+00 3.547178596103394e+00 4.526753671514875e+00 9.306316644346169e+03 + 70080 9.842505595894889e-01 -5.968322796902347e+00 -6.040565239801804e+00 3.828337532943981e+00 4.413510246333392e+00 9.342008701067141e+03 + 70100 9.787463834619456e-01 -5.961409855374034e+00 -5.981210801964068e+00 3.931127570188163e+00 4.817427470681613e+00 9.159435500639856e+03 + 70120 1.005660325235447e+00 -5.999992349811070e+00 -5.961977363406611e+00 3.742765598305623e+00 4.961053533040163e+00 9.100660831558309e+03 + 70140 1.075726393744813e+00 -6.101457502694361e+00 -5.912979323039012e+00 3.206323843680755e+00 5.288594718165804e+00 8.951843394956073e+03 + 70160 9.845988129087385e-01 -5.962434327511987e+00 -5.979147109364762e+00 3.899467719727201e+00 4.803500340033934e+00 9.153135457445871e+03 + 70180 9.799969509590278e-01 -5.948930351744463e+00 -5.989827389496398e+00 3.984979019634499e+00 4.750141900066749e+00 9.185828683835414e+03 + 70200 1.037500294428731e+00 -6.025233160214045e+00 -5.994370061893564e+00 3.497477298763991e+00 4.674697985369223e+00 9.199784988112962e+03 + 70220 9.524353245933865e-01 -5.889063724799857e+00 -6.019965267981704e+00 4.295613033114425e+00 4.543956115215919e+00 9.278420973733590e+03 + 70240 1.067401808273573e+00 -6.048512074212003e+00 -5.986156549958411e+00 3.447391860841215e+00 4.805446930591536e+00 9.174620454315991e+03 + 70260 1.046030181995155e+00 -6.005630572946362e+00 -6.026213986680897e+00 3.688382975507184e+00 4.570189828570503e+00 9.297708983252876e+03 + 70280 9.903238708068244e-01 -5.915714231403570e+00 -6.018863352333780e+00 4.193332711376542e+00 4.601034496720406e+00 9.275041767742216e+03 + 70300 1.054368400603872e+00 -6.005602617323390e+00 -5.981921502339052e+00 3.639226892776482e+00 4.775207519657253e+00 9.161634493099718e+03 + 70320 1.011213555644030e+00 -5.937321608885989e+00 -6.023202137758682e+00 4.020843469966564e+00 4.527704183210672e+00 9.288403073807489e+03 + 70340 1.076064964292021e+00 -6.032135154411962e+00 -6.030132772653575e+00 3.481623870196108e+00 4.493121856120338e+00 9.309797944034064e+03 + 70360 1.061282699097143e+00 -6.014762539367547e+00 -6.000263003707929e+00 3.694112843429825e+00 4.777371420983245e+00 9.217846907252660e+03 + 70380 9.274184484191209e-01 -5.825845023373073e+00 -6.021975436273323e+00 4.610739909111313e+00 4.484528727154773e+00 9.284618513366244e+03 + 70400 9.968163766711503e-01 -5.942685970212311e+00 -6.007575058536053e+00 3.950072650814566e+00 4.577469464105680e+00 9.240317648013504e+03 + 70420 9.761201635242843e-01 -5.930428694557924e+00 -5.981747164273491e+00 4.059653450487869e+00 4.764974855873560e+00 9.161078792380131e+03 + 70440 9.713867024820535e-01 -5.942086313575240e+00 -5.988125586064596e+00 3.948170404684166e+00 4.683805777495895e+00 9.180624759127617e+03 + 70460 1.006316693216304e+00 -6.013881445374881e+00 -5.978615344848601e+00 3.627481595938903e+00 4.829985002572228e+00 9.151533585943896e+03 + 70480 9.742213254284857e-01 -5.989170371003017e+00 -6.016548922505499e+00 3.755182416056681e+00 4.597970536512280e+00 9.267925499612702e+03 + 70500 9.826545144732803e-01 -6.026691591154540e+00 -6.024090706430131e+00 3.545288759747112e+00 4.560223442320284e+00 9.291159161167199e+03 + 70520 9.782870695124780e-01 -6.045872841111764e+00 -6.000400319605284e+00 3.435645516539124e+00 4.696755771879292e+00 9.218285934531230e+03 + 70540 9.168055778294389e-01 -5.979603577274032e+00 -6.019506460953115e+00 3.743787636488924e+00 4.514659103452336e+00 9.277024441967735e+03 + 70560 9.389316120792757e-01 -6.031078850665705e+00 -5.997412805144283e+00 3.497552172331292e+00 4.690867815519000e+00 9.209088750918942e+03 + 70580 9.742844868648181e-01 -6.097691873557064e+00 -6.011636152959340e+00 3.173067763463403e+00 4.667213028215262e+00 9.252803378852028e+03 + 70600 9.253321688657712e-01 -6.034674828112920e+00 -6.002645493200635e+00 3.485558753745739e+00 4.669476151335639e+00 9.225185260167767e+03 + 70620 9.638397026808231e-01 -6.097880327193794e+00 -6.014401242159638e+00 3.127516825126767e+00 4.606866649739553e+00 9.261330813197288e+03 + 70640 9.522620139952841e-01 -6.082628860789078e+00 -5.991198387439900e+00 3.270241528856104e+00 4.795249455647108e+00 9.190080458703873e+03 + 70660 9.684716586148416e-01 -6.103273277182125e+00 -5.982686277821319e+00 3.134777701811175e+00 4.827206912918764e+00 9.164002490463175e+03 + 70680 9.171964825713237e-01 -6.015633855824018e+00 -6.016846673568081e+00 3.645728821557715e+00 4.638764634388365e+00 9.268836177777528e+03 + 70700 9.911609315718957e-01 -6.099817159418151e+00 -6.017086254254054e+00 3.165736950888002e+00 4.640790610906448e+00 9.269601532287068e+03 + 70720 9.661113374224485e-01 -6.022847961052972e+00 -6.017463993586402e+00 3.582951994257866e+00 4.613867568617183e+00 9.270753969747608e+03 + 70740 1.015579423875894e+00 -6.046392958132828e+00 -6.007622299553887e+00 3.414422599669069e+00 4.637049720969373e+00 9.240480080510595e+03 + 70760 1.074355378180800e+00 -6.082092272173974e+00 -5.985522041420553e+00 3.272056349904133e+00 4.826577559085191e+00 9.172650288016712e+03 + 70780 1.017195074304929e+00 -5.956383062276692e+00 -5.966740378251631e+00 3.963624358940110e+00 4.904151047822547e+00 9.115194435344187e+03 + 70800 1.101391231856071e+00 -6.048493724259082e+00 -5.956504310747908e+00 3.452222075447216e+00 4.980439523144108e+00 9.083995891575007e+03 + 70820 1.076202380315758e+00 -5.989694510715016e+00 -5.994555745973149e+00 3.767818409275956e+00 4.739904444150034e+00 9.200343781739284e+03 + 70840 1.037920201539905e+00 -5.921749992826493e+00 -6.048647478772059e+00 4.092086695192322e+00 4.363421693570398e+00 9.367006359100198e+03 + 70860 1.079208670518661e+00 -5.981092501605542e+00 -6.033288883422049e+00 3.733859371381083e+00 4.434139669626719e+00 9.319526617272555e+03 + 70880 1.048641041490575e+00 -5.942072683509028e+00 -6.006378112287126e+00 4.030525458075617e+00 4.661273734798833e+00 9.236611420864498e+03 + 70900 1.102799369453900e+00 -6.033091195231801e+00 -5.945244797691348e+00 3.564146134883438e+00 5.068573743746803e+00 9.049696764594084e+03 + 70920 1.008300738029986e+00 -5.906474110435020e+00 -6.023051531940904e+00 4.151850578187029e+00 4.482444983602562e+00 9.287935505941927e+03 + 70940 1.047963690697337e+00 -5.984637984682442e+00 -5.957685353903432e+00 3.779913093828033e+00 4.934679270667241e+00 9.087590216990026e+03 + 70960 1.008306471711980e+00 -5.944218940330399e+00 -5.965502609161605e+00 4.014844160352446e+00 4.892630040286548e+00 9.111416952318772e+03 + 70980 9.844830554343613e-01 -5.927349625248446e+00 -6.047706044847937e+00 4.117153086760546e+00 4.426047900324531e+00 9.364064428847594e+03 + 71000 1.093317831662293e+00 -6.110440455961140e+00 -5.998143462359575e+00 3.136419328069795e+00 4.781246043233581e+00 9.211364543873264e+03 + 71020 1.038069042806743e+00 -6.055952119068007e+00 -5.999544966122630e+00 3.402379814607985e+00 4.726278415799051e+00 9.215670323833736e+03 + 71040 1.025771698772686e+00 -6.065206555135048e+00 -5.993512898087752e+00 3.326689458465902e+00 4.738365531789048e+00 9.197151163681378e+03 + 71060 9.547924300294415e-01 -5.986235781953862e+00 -5.992641994750723e+00 3.804814336268505e+00 4.768028871030708e+00 9.194443923604809e+03 + 71080 9.512512126915852e-01 -6.002195813934761e+00 -5.990430261843304e+00 3.648025364530105e+00 4.715584985352550e+00 9.187682429775406e+03 + 71100 9.651238720003124e-01 -6.035617255876769e+00 -5.995355254643203e+00 3.493611807361433e+00 4.724802448969121e+00 9.202791570511039e+03 + 71120 9.391212134331031e-01 -6.006264927523270e+00 -6.046366543574567e+00 3.625374424039867e+00 4.395104738968298e+00 9.359939621428322e+03 + 71140 9.780995346144636e-01 -6.070067227560605e+00 -5.970070803421549e+00 3.319388716141143e+00 4.893583657944221e+00 9.125410549761558e+03 + 71160 9.422439273216913e-01 -6.018277632392623e+00 -5.971017781226005e+00 3.596251370947818e+00 4.867624749784873e+00 9.128292673623775e+03 + 71180 8.953373227922906e-01 -5.946020470998536e+00 -5.975201594063404e+00 3.981807879385665e+00 4.814245354982994e+00 9.141066389661488e+03 + 71200 9.360093497416029e-01 -5.997496255992095e+00 -5.980727185098404e+00 3.701732116268822e+00 4.798022716345729e+00 9.157964485325909e+03 + 71220 9.595510957103931e-01 -6.017115915163399e+00 -6.014012620058224e+00 3.595762814233475e+00 4.613582414960758e+00 9.260114197716155e+03 + 71240 1.022302189070466e+00 -6.095498445915018e+00 -6.015103342600139e+00 3.138538683845451e+00 4.600179808181517e+00 9.263492158518040e+03 + 71260 9.539600300306490e-01 -5.980707235361757e+00 -6.018253033809237e+00 3.843244400920065e+00 4.627650616041106e+00 9.273164613456660e+03 + 71280 9.739483252419429e-01 -5.998982189843243e+00 -6.003156494943964e+00 3.743211536071267e+00 4.719242030211303e+00 9.226739303074457e+03 + 71300 9.893267733632010e-01 -6.013681210394778e+00 -6.026503647679898e+00 3.589013233293067e+00 4.515384814136151e+00 9.298603268027542e+03 + 71320 1.017717248988810e+00 -6.051447611332551e+00 -5.958475412843285e+00 3.409260828244252e+00 4.943121579370836e+00 9.090024406506074e+03 + 71340 9.027491933194501e-01 -5.875832359433527e+00 -6.013647845202923e+00 4.367336871939717e+00 4.575979025774354e+00 9.258963720507543e+03 + 71360 9.835126301373331e-01 -5.990083740944773e+00 -5.963465901635574e+00 3.749871921717480e+00 4.902715674128228e+00 9.105229265018572e+03 + 71380 1.009951659107425e+00 -6.021849331190434e+00 -5.971680356860030e+00 3.583107187749538e+00 4.871185201978407e+00 9.130293538631422e+03 + 71400 9.660978550681558e-01 -5.948350579057478e+00 -5.993786045792977e+00 3.993130431750898e+00 4.732232950639904e+00 9.197967254355051e+03 + 71420 9.942729105538943e-01 -5.982157256176687e+00 -6.019930944773595e+00 3.763163289123331e+00 4.546260923740464e+00 9.278334019747579e+03 + 71440 1.023346812833159e+00 -6.019275154002194e+00 -5.961517903862942e+00 3.577538064967328e+00 4.909189133172486e+00 9.099311039274462e+03 + 71460 9.785984074370471e-01 -5.947305811079222e+00 -6.008961838180979e+00 3.893727960694233e+00 4.539689511836582e+00 9.244563207524108e+03 + 71480 1.001936663544862e+00 -5.975383712620124e+00 -5.956220974946108e+00 3.841988271537350e+00 4.952023676685622e+00 9.083106487852001e+03 + 71500 9.758448619969763e-01 -5.928267489567518e+00 -6.003519838924873e+00 4.080415439762302e+00 4.648304804488941e+00 9.227851979846764e+03 + 71520 9.605426494497725e-01 -5.895851747017744e+00 -6.033080830948842e+00 4.255397191485234e+00 4.467406555420765e+00 9.318854210038962e+03 + 71540 1.086107132529073e+00 -6.072618791262723e+00 -5.978637413810428e+00 3.334561108831889e+00 4.874216721734129e+00 9.151604360545736e+03 + 71560 1.029487312461365e+00 -5.981881127300630e+00 -6.055172442504591e+00 3.738029171596152e+00 4.317179097900635e+00 9.387207366835322e+03 + 71580 9.889155214991516e-01 -5.917961882898070e+00 -6.038813180282013e+00 4.145515858090084e+00 4.451569006833656e+00 9.336597849567606e+03 + 71600 1.071779992790046e+00 -6.041715881375589e+00 -6.010042222290681e+00 3.422355544638722e+00 4.604230596587167e+00 9.247909183106223e+03 + 71620 1.045387051001033e+00 -6.007750656713964e+00 -5.991513631816355e+00 3.679137699798679e+00 4.772373209432231e+00 9.191013334353796e+03 + 71640 9.976304201425148e-01 -5.945722862013246e+00 -6.044979896073477e+00 3.953607522972456e+00 4.383658273422228e+00 9.355627793013258e+03 + 71660 1.030093144481907e+00 -6.008134872534762e+00 -5.958354142466147e+00 3.640828627041974e+00 4.926677282639041e+00 9.089661195187107e+03 + 71680 9.735890601838096e-01 -5.944521426992388e+00 -5.992746557657135e+00 3.962701487246581e+00 4.685785324154749e+00 9.194766387294718e+03 + 71700 9.718136152909835e-01 -5.968458793532701e+00 -5.947302403517010e+00 3.919440512801529e+00 5.040923778212404e+00 9.055953398534011e+03 + 71720 9.792500838272675e-01 -6.004369400978486e+00 -5.972438802520508e+00 3.630917930505519e+00 4.814268368095367e+00 9.132621416567956e+03 + 71740 1.017132512715343e+00 -6.087041548014650e+00 -5.946915139378068e+00 3.261134059083399e+00 5.065761581966309e+00 9.054791549602849e+03 + 71760 9.555981724742256e-01 -6.021054229370844e+00 -5.920401848356870e+00 3.613861167213172e+00 5.191822714901035e+00 8.974300585536268e+03 + 71780 9.326143455157420e-01 -6.005861366301362e+00 -5.972227275070633e+00 3.653356503763681e+00 4.846488660469321e+00 9.131959975134478e+03 + 71800 9.975761355065270e-01 -6.117550414376658e+00 -6.000454371284926e+00 3.048669700552140e+00 4.721053300538970e+00 9.218466002419173e+03 + 71820 9.578328188394227e-01 -6.073291908825091e+00 -6.005364507636676e+00 3.286102627160187e+00 4.676152276515430e+00 9.233542137315902e+03 + 71840 9.270729084556937e-01 -6.038286802033809e+00 -5.984575005010816e+00 3.530174098905868e+00 4.838595549285622e+00 9.169774523495307e+03 + 71860 8.938653310582083e-01 -5.995159379664235e+00 -6.019055955107147e+00 3.718523844482976e+00 4.581306010306676e+00 9.275655539246645e+03 + 71880 8.885410792384233e-01 -5.987873088774513e+00 -6.022412297676153e+00 3.736625872255009e+00 4.538296389816487e+00 9.285964427022614e+03 + 71900 9.563839895870021e-01 -6.079389394263660e+00 -6.011537465583292e+00 3.310235737837579e+00 4.699852012372279e+00 9.252484777712945e+03 + 71920 9.630348703513819e-01 -6.069517923419712e+00 -6.020844649068945e+00 3.273111089010839e+00 4.552600562497805e+00 9.281178426019344e+03 + 71940 9.739172391723437e-01 -6.056290238992450e+00 -6.003402839964583e+00 3.391715287284835e+00 4.695402916801395e+00 9.227517787445719e+03 + 71960 1.014113125183813e+00 -6.074593328143569e+00 -6.017723051222243e+00 3.292142529767240e+00 4.618700460496411e+00 9.271540432418946e+03 + 71980 9.699793435163528e-01 -5.962405309120965e+00 -6.001887957330549e+00 3.909722251238596e+00 4.683006775299100e+00 9.222843508214788e+03 + 72000 9.965478382267619e-01 -5.955830184798292e+00 -5.987265053858229e+00 3.921532276477161e+00 4.741028393804736e+00 9.177998887989144e+03 + 72020 1.078830008245408e+00 -6.037300092625221e+00 -5.983593211518478e+00 3.534839929774795e+00 4.843233152202703e+00 9.166767228477911e+03 + 72040 1.024939424166102e+00 -5.930672601878696e+00 -5.996544735008255e+00 4.075965573065004e+00 4.697717590955416e+00 9.206422189260182e+03 + 72060 1.102019506506799e+00 -6.030123380995437e+00 -5.956862211376690e+00 3.550052817922530e+00 4.970729791002737e+00 9.085078264463828e+03 + 72080 1.118149395075737e+00 -6.045421837898967e+00 -5.983311416211918e+00 3.412658874124937e+00 4.769306527008667e+00 9.165836409897805e+03 + 72100 1.002070216051627e+00 -5.871989531821907e+00 -6.008740031353540e+00 4.375232544573538e+00 4.589990014191490e+00 9.243889402190953e+03 + 72120 1.105415426892710e+00 -6.028277198756220e+00 -5.993854563758683e+00 3.531847971546880e+00 4.729508068588291e+00 9.198180755602387e+03 + 72140 1.009588243500069e+00 -5.894971833292948e+00 -6.041816542486082e+00 4.275535187323851e+00 4.432330142991575e+00 9.345858563363059e+03 + 72160 1.071683397213957e+00 -6.000744960720912e+00 -5.981885776964592e+00 3.674754665468287e+00 4.783047017046325e+00 9.161540611702623e+03 + 72180 9.946490512149536e-01 -5.902927079986131e+00 -6.090570727767410e+00 4.168632618087143e+00 4.091153754766386e+00 9.497191335466954e+03 + 72200 1.035507107271916e+00 -5.986990137599246e+00 -6.071748818749489e+00 3.756459179495844e+00 4.269761715967634e+00 9.438634855822280e+03 + 72220 9.895302681295302e-01 -5.946568895527877e+00 -6.071431176268351e+00 3.933916525493481e+00 4.216937987106183e+00 9.437658667263580e+03 + 72240 1.006784842984461e+00 -6.002232964994853e+00 -6.043165678976586e+00 3.646251387976828e+00 4.411209409976699e+00 9.350045822141316e+03 + 72260 9.800317915637684e-01 -5.990997667820258e+00 -5.993367971854662e+00 3.747706670204098e+00 4.734096017635187e+00 9.196711542883490e+03 + 72280 9.541611269377547e-01 -5.974495549746352e+00 -6.007631576537778e+00 3.827984914091407e+00 4.637712720471461e+00 9.240485748317889e+03 + 72300 9.703441132470307e-01 -6.014343188160325e+00 -6.007154961405859e+00 3.606793443586267e+00 4.648069353984906e+00 9.239037110084399e+03 + 72320 9.745826216168099e-01 -6.033042940840031e+00 -5.995390535825360e+00 3.553661731551272e+00 4.769867667836362e+00 9.202907563139648e+03 + 72340 9.893766172010181e-01 -6.062682746386683e+00 -5.971765898482897e+00 3.329315320608014e+00 4.851373930608297e+00 9.130588548477490e+03 + 72360 9.878885767452101e-01 -6.063625814109034e+00 -5.973130717294594e+00 3.338390998424539e+00 4.858027848404026e+00 9.134745742633941e+03 + 72380 1.003590090487693e+00 -6.084627335388021e+00 -5.973996400962502e+00 3.218669066042920e+00 4.853929011596021e+00 9.137400143012603e+03 + 72400 9.195761994545517e-01 -5.953605992015820e+00 -6.032573934334579e+00 3.953282218703383e+00 4.499836073659494e+00 9.317319563778892e+03 + 72420 1.007041620130130e+00 -6.077595323448280e+00 -5.986208045547843e+00 3.274393168785463e+00 4.799153060625322e+00 9.174770250881435e+03 + 72440 9.677492330028552e-01 -6.012882846342269e+00 -5.996740833921867e+00 3.629383792598831e+00 4.722073725885132e+00 9.207031490438956e+03 + 72460 9.297533990240068e-01 -5.947561024179301e+00 -6.052522664197780e+00 3.974802111536600e+00 4.372096131789196e+00 9.378981314326251e+03 + 72480 1.063229623977600e+00 -6.137372029978506e+00 -6.005256953442391e+00 2.902032248855926e+00 4.660657463068318e+00 9.233205226432330e+03 + 72500 9.821717840758694e-01 -6.010700947077045e+00 -5.996165548888605e+00 3.683418418385881e+00 4.766882924129504e+00 9.205279165884531e+03 + 72520 9.960538776416079e-01 -6.024524719042795e+00 -5.981954926054741e+00 3.567371546294845e+00 4.811813885286423e+00 9.161718748452320e+03 + 72540 9.633678176032293e-01 -5.966936630652946e+00 -5.993010304996823e+00 3.843526335369314e+00 4.693807262398707e+00 9.195589549789927e+03 + 72560 9.436046650141162e-01 -5.929456081398350e+00 -6.022480457203101e+00 4.061817871340354e+00 4.527657509993846e+00 9.286179719219996e+03 + 72580 9.869399320821113e-01 -5.984915766452129e+00 -5.996407449061546e+00 3.743978240213786e+00 4.677991220338381e+00 9.206039087703763e+03 + 72600 9.894433802598150e-01 -5.981765974398888e+00 -5.959143559923051e+00 3.825207478848676e+00 4.955108883576259e+00 9.092020922724414e+03 + 72620 1.012369969648965e+00 -6.007789460735888e+00 -5.968406337016056e+00 3.659451806762527e+00 4.885595797680506e+00 9.120327299602290e+03 + 72640 1.044833696804149e+00 -6.047548816885360e+00 -6.011591570363553e+00 3.401532642358674e+00 4.608004716252809e+00 9.252668929408239e+03 + 72660 1.042878119919221e+00 -6.041315105648441e+00 -5.967067552800815e+00 3.492665916880504e+00 4.919006855103245e+00 9.116232694050203e+03 + 72680 1.008609856064491e+00 -5.987829635750078e+00 -5.967645505756782e+00 3.792659165324096e+00 4.908559563229623e+00 9.117980949141656e+03 + 72700 9.837594588270533e-01 -5.949459601908766e+00 -5.998439563256382e+00 3.964513392359255e+00 4.683262874676719e+00 9.212240496179531e+03 + 72720 1.017579545891803e+00 -5.996451497709772e+00 -5.975441180260935e+00 3.695138026292372e+00 4.815782520419708e+00 9.141822906846657e+03 + 72740 1.035840642719175e+00 -6.020132138761793e+00 -6.005159753250268e+00 3.530463830540507e+00 4.616437585116852e+00 9.232895592936085e+03 + 72760 1.008928834107873e+00 -5.980747121490047e+00 -6.047023041371335e+00 3.788062050982600e+00 4.407495462858786e+00 9.361943374652943e+03 + 72780 1.059828341742672e+00 -6.060382805099971e+00 -6.013695712495570e+00 3.334679677148328e+00 4.602764187687033e+00 9.259105652548031e+03 + 72800 9.850789975835570e-01 -5.954030867994521e+00 -6.004543221841659e+00 3.935518103732135e+00 4.645468351180375e+00 9.231003177710052e+03 + 72820 9.630241799581404e-01 -5.927236528573200e+00 -6.003756287345747e+00 4.074351982060411e+00 4.634963685794044e+00 9.228568747751471e+03 + 72840 9.581509196072250e-01 -5.926424763739678e+00 -6.047814422295869e+00 4.073210582322220e+00 4.376172377903617e+00 9.364393046675106e+03 + 72860 9.538324350628707e-01 -5.927467671614225e+00 -6.033619713073127e+00 4.085138023159058e+00 4.475596574126718e+00 9.320508817989046e+03 + 72880 9.772919038816135e-01 -5.972255849766232e+00 -5.989933659745402e+00 3.804085942703376e+00 4.702577222170730e+00 9.186126927392355e+03 + 72900 9.385267236917162e-01 -5.928091576125930e+00 -5.977136678490178e+00 4.095129188857376e+00 4.813504621376804e+00 9.146987296195839e+03 + 72920 1.021914793879981e+00 -6.072481960013378e+00 -5.987770565577112e+00 3.298779120805454e+00 4.785205056704415e+00 9.179548916763926e+03 + 72940 9.956241273626569e-01 -6.069942850214470e+00 -5.972962058692605e+00 3.381462542508841e+00 4.938341255156369e+00 9.134227172931334e+03 + 72960 9.427537345327136e-01 -6.035433873158660e+00 -5.951503630991672e+00 3.479841322705057e+00 4.961781761390906e+00 9.068788063262227e+03 + 72980 9.584143174194453e-01 -6.096835711690988e+00 -5.962184387590973e+00 3.202888540254170e+00 4.976077280461521e+00 9.101322917840846e+03 + 73000 8.897433346864606e-01 -6.024582010244712e+00 -6.017266691069381e+00 3.511186317004973e+00 4.553192011751712e+00 9.270148894877773e+03 + 73020 9.420612941723159e-01 -6.122161043361315e+00 -5.988142730234958e+00 3.046100560714555e+00 4.815654453953028e+00 9.180710849400839e+03 + 73040 8.594203884316532e-01 -6.012021370172440e+00 -6.009392384352215e+00 3.653872842319607e+00 4.668968885733579e+00 9.245902218776162e+03 + 73060 9.153951703108179e-01 -6.098295642571225e+00 -5.966823386775557e+00 3.170637024517309e+00 4.925571062561866e+00 9.115492559813993e+03 + 73080 9.349185694147871e-01 -6.120332458214604e+00 -6.001838774433670e+00 3.009713019007640e+00 4.690122088116064e+00 9.222725441704393e+03 + 73100 8.902830525473573e-01 -6.038485246691873e+00 -6.055086490664407e+00 3.461832692944674e+00 4.366505781020178e+00 9.386933520293398e+03 + 73120 9.541177678962579e-01 -6.111302430691705e+00 -5.979619975024582e+00 3.073326582084753e+00 4.829467620319527e+00 9.154612407239043e+03 + 73140 9.446079358073918e-01 -6.066305813332002e+00 -6.000901303808815e+00 3.351472652066009e+00 4.727035467063291e+00 9.219808191803604e+03 + 73160 9.523283277816054e-01 -6.042124963276870e+00 -6.002409310929325e+00 3.424798832755642e+00 4.652852254512582e+00 9.224451131833444e+03 + 73180 9.860677071782967e-01 -6.052937141030777e+00 -6.011844524543125e+00 3.406591736981609e+00 4.642551899915558e+00 9.253454857453789e+03 + 73200 9.696758730040042e-01 -5.994139723843039e+00 -6.025167885409884e+00 3.696605648769986e+00 4.518437143460674e+00 9.294474643759902e+03 + 73220 9.685698567268297e-01 -5.964575540333408e+00 -5.978939121916369e+00 3.886407841529038e+00 4.803929933322610e+00 9.152493213761703e+03 + 73240 1.019949351075725e+00 -6.015005137941038e+00 -5.981924377408824e+00 3.629690850558613e+00 4.819645696765731e+00 9.161627700778021e+03 + 73260 9.802523650212820e-01 -5.933636352721432e+00 -5.996465272586661e+00 4.061399387477482e+00 4.700626006867407e+00 9.206215603778859e+03 + 73280 1.076139918541565e+00 -6.059214805804439e+00 -5.973754177933229e+00 3.418326278007336e+00 4.909054428233251e+00 9.136651810245194e+03 + 73300 9.951623101387671e-01 -5.926586783501308e+00 -6.023392146861017e+00 4.054972388352441e+00 4.499101011359426e+00 9.289000950348618e+03 + 73320 1.055424429054787e+00 -6.008430208280769e+00 -5.978004059442274e+00 3.621902741777660e+00 4.796614396839617e+00 9.149647265445203e+03 + 73340 1.023412207219636e+00 -5.956181948449548e+00 -6.003579218605379e+00 3.938087102240011e+00 4.665924642301377e+00 9.228042560828810e+03 + 73360 1.003807728222969e+00 -5.924937004075042e+00 -6.015707898954442e+00 4.091170215272779e+00 4.569949690124677e+00 9.265330261004359e+03 + 73380 9.559026332572658e-01 -5.855027826825950e+00 -6.055654366462881e+00 4.458932121982870e+00 4.306903484530941e+00 9.388669100465399e+03 + 73400 1.037852592749056e+00 -5.981079648619350e+00 -6.019974027281796e+00 3.847248531387730e+00 4.623910990222319e+00 9.278458618208364e+03 + 73420 1.072692042707207e+00 -6.044203960592385e+00 -5.988698961330708e+00 3.468813445786739e+00 4.787531740918162e+00 9.182385700210083e+03 + 73440 9.999946427266874e-01 -5.949725561931774e+00 -6.010709462947363e+00 3.972585780990825e+00 4.622406784131132e+00 9.249974056372803e+03 + 73460 9.886386741721456e-01 -5.951484561933450e+00 -6.023008183882084e+00 3.996156357327556e+00 4.585456651853772e+00 9.287819923013794e+03 + 73480 9.909420370217351e-01 -5.981962918496282e+00 -6.003082398752563e+00 3.804987889341656e+00 4.683716565481086e+00 9.226526522068676e+03 + 73500 9.735022201765233e-01 -5.987359680096206e+00 -5.998398472885821e+00 3.754767131161684e+00 4.691380674716045e+00 9.212140434787490e+03 + 73520 1.024103750097410e+00 -6.098275858583709e+00 -5.982401838108406e+00 3.174730058843979e+00 4.840096615859887e+00 9.163125262598514e+03 + 73540 9.490113754906571e-01 -6.025421573095553e+00 -6.008590778178114e+00 3.549747662637606e+00 4.646392691610639e+00 9.243450055791789e+03 + 73560 9.691281323624915e-01 -6.092049403394366e+00 -6.008933304298841e+00 3.176295959447998e+00 4.653561462629268e+00 9.244515878588805e+03 + 73580 8.869036170327755e-01 -6.000736475722387e+00 -6.018539277353098e+00 3.655714114911441e+00 4.553487672973247e+00 9.274070909065875e+03 + 73600 8.587375873138998e-01 -5.980523213660408e+00 -6.048936868582329e+00 3.777920883587395e+00 4.385079090046842e+00 9.367880511000523e+03 + 73620 8.887515577539745e-01 -6.036262402152713e+00 -6.025585650016043e+00 3.474824805092692e+00 4.536132368083503e+00 9.295783918509487e+03 + 73640 9.566899483279282e-01 -6.139458744436604e+00 -5.980252060230255e+00 2.980864258747454e+00 4.895053676615069e+00 9.156548221226662e+03 + 73660 9.059638205367911e-01 -6.060451563490118e+00 -5.987297905192203e+00 3.341698514287480e+00 4.761758140726145e+00 9.178105566097443e+03 + 73680 9.885040644887858e-01 -6.170493717751187e+00 -5.947091466689836e+00 2.819292181875123e+00 5.102102478856027e+00 9.055374459334902e+03 + 73700 8.840688143161977e-01 -5.997909589055889e+00 -6.017597169699814e+00 3.711955057981150e+00 4.598905923280478e+00 9.271167702400740e+03 + 73720 9.365566228236535e-01 -6.056835763544740e+00 -5.993285098337915e+00 3.404465325526309e+00 4.769383079577556e+00 9.196441354819448e+03 + 73740 9.751530238993469e-01 -6.092074963164404e+00 -5.967047927530567e+00 3.289551343810193e+00 5.007475930290920e+00 9.116170926077595e+03 + 73760 9.975831492148352e-01 -6.105257473770175e+00 -6.006174425853515e+00 3.116666309592710e+00 4.685616503782285e+00 9.236034698245219e+03 + 73780 9.491981272752904e-01 -6.019022887507274e+00 -6.006799806614746e+00 3.587465015970548e+00 4.657651837971096e+00 9.237945318475575e+03 + 73800 9.216555509806402e-01 -5.965813920687352e+00 -6.003387736334689e+00 3.887301085769727e+00 4.671546421793536e+00 9.227435384514798e+03 + 73820 9.406659277907080e-01 -5.982136118589128e+00 -5.996893245455352e+00 3.769564501857281e+00 4.684826795733422e+00 9.207538606891629e+03 + 73840 9.891430459387738e-01 -6.039551973014363e+00 -5.996521143106872e+00 3.462672563550377e+00 4.709762247878601e+00 9.206382389439392e+03 + 73860 9.641956462911899e-01 -5.988434455456525e+00 -6.022913449543973e+00 3.744670657850876e+00 4.546686938193655e+00 9.287525970883193e+03 + 73880 1.040436998836157e+00 -6.089197740751824e+00 -5.976583468637202e+00 3.209747510178056e+00 4.856396087662505e+00 9.145325511218460e+03 + 73900 9.902134433520842e-01 -6.001736018431164e+00 -5.988534457843059e+00 3.704927291764693e+00 4.780732695596491e+00 9.181887026660757e+03 + 73920 9.750133245832493e-01 -5.967663066883413e+00 -5.984000698922340e+00 3.876406902899693e+00 4.782593691491786e+00 9.168004380084978e+03 + 73940 9.676659038298104e-01 -5.943527519341075e+00 -6.009167331150826e+00 4.003113238752114e+00 4.626199281612475e+00 9.245192341642587e+03 + 73960 1.022926795406777e+00 -6.010827826801174e+00 -5.963057261811311e+00 3.622604812793118e+00 4.896910789435950e+00 9.103971088960068e+03 + 73980 9.936230909444714e-01 -5.950745586237474e+00 -5.970523657728851e+00 4.012275095885297e+00 4.898706348735141e+00 9.126760256883810e+03 + 74000 9.677971904937270e-01 -5.894639047040153e+00 -6.007142541591760e+00 4.309578534251855e+00 4.663566058677013e+00 9.238960846668213e+03 + 74020 1.038021345896250e+00 -5.980809707069948e+00 -6.017287406949886e+00 3.775172775859496e+00 4.565712178243079e+00 9.270201201010348e+03 + 74040 1.049623301639240e+00 -5.984762706398663e+00 -5.981745335087776e+00 3.764489474779817e+00 4.781815687783631e+00 9.161089525729400e+03 + 74060 1.002188666697246e+00 -5.903731468758542e+00 -6.022085452384821e+00 4.179474039450710e+00 4.499867150248843e+00 9.284940314765439e+03 + 74080 1.053302478472394e+00 -5.970006720760422e+00 -5.980070735402563e+00 3.901223859450767e+00 4.843434729974358e+00 9.155948172651344e+03 + 74100 9.993446325774886e-01 -5.881536762101338e+00 -6.051637262444094e+00 4.320948035587771e+00 4.344204639652308e+00 9.376222675169513e+03 + 74120 1.057371373534696e+00 -5.964382717968213e+00 -5.992082708326333e+00 3.875401649070734e+00 4.716344017874761e+00 9.192744929416014e+03 + 74140 1.059100064726554e+00 -5.970089011035608e+00 -5.991851099144516e+00 3.905355264036811e+00 4.780393986443207e+00 9.192004089486787e+03 + 74160 1.012734066428334e+00 -5.909967931623578e+00 -6.000440588299190e+00 4.144806234804341e+00 4.625298239574605e+00 9.218380888102363e+03 + 74180 1.008633872007563e+00 -5.920232898388734e+00 -5.955999617057108e+00 4.206675812570014e+00 5.001297779094386e+00 9.082443468750953e+03 + 74200 9.591600109347872e-01 -5.868373407856528e+00 -6.032826827320543e+00 4.416313621040069e+00 4.471996637393285e+00 9.318083929682352e+03 + 74220 1.095452984239014e+00 -6.103580511714972e+00 -5.996643799287971e+00 3.089170627233890e+00 4.703217778392498e+00 9.206765921389173e+03 + 74240 9.886066303671122e-01 -5.988512526126677e+00 -5.994509048595935e+00 3.766928270991767e+00 4.732495311014439e+00 9.200180359988837e+03 + 74260 9.411223199422218e-01 -5.960400452457267e+00 -5.970375259741683e+00 3.882880109001749e+00 4.825603221978195e+00 9.126319633202982e+03 + 74280 9.529909602980556e-01 -6.011606380794977e+00 -5.958498274012977e+00 3.644466846916080e+00 4.949421814511286e+00 9.090089143758922e+03 + 74300 9.235976668988890e-01 -5.989878319568323e+00 -5.991331221478392e+00 3.763403608490166e+00 4.755060820886709e+00 9.190441240661332e+03 + 74320 9.502289029324132e-01 -6.044833725493511e+00 -5.985216240738840e+00 3.471777046062495e+00 4.814109869299768e+00 9.171738115742695e+03 + 74340 9.652570913703946e-01 -6.076206760035795e+00 -6.011626902902939e+00 3.274773042297301e+00 4.645600575654756e+00 9.252804115994682e+03 + 74360 9.831976872799403e-01 -6.108786456278864e+00 -5.965360665919958e+00 3.131444597894031e+00 4.955017681204195e+00 9.111006700122731e+03 + 74380 9.468762251630668e-01 -6.055160460683966e+00 -5.981432884859819e+00 3.411454123922700e+00 4.834809273610433e+00 9.160119526759952e+03 + 74400 9.711692127968108e-01 -6.084723659965508e+00 -5.974109568396302e+00 3.268680654709732e+00 4.903843885975464e+00 9.137738108864660e+03 + 74420 9.571691205037024e-01 -6.051103259394720e+00 -5.997803782302231e+00 3.392340136575918e+00 4.698393982108413e+00 9.210316074517208e+03 + 74440 9.431146066364593e-01 -6.011444772907545e+00 -6.000585752889872e+00 3.619722061850069e+00 4.682076235219466e+00 9.218831306517093e+03 + 74460 9.894509465667535e-01 -6.053388857474249e+00 -5.980634912109710e+00 3.438883501037140e+00 4.856647913956983e+00 9.157684392197632e+03 + 74480 9.466338595274219e-01 -5.958288926465344e+00 -5.970911898820786e+00 3.957492679641246e+00 4.885009618977638e+00 9.127988633256457e+03 + 74500 1.072644057698383e+00 -6.111003206831461e+00 -5.934422816210002e+00 3.115830994191301e+00 5.129782922866848e+00 9.016853729222163e+03 + 74520 9.600788146021789e-01 -5.907807867108827e+00 -5.967626846587486e+00 4.204741608582630e+00 4.861251771459010e+00 9.117905091596664e+03 + 74540 1.002354400594536e+00 -5.935926997373625e+00 -5.955875563865781e+00 4.000893959997279e+00 4.886346204168629e+00 9.082068068329376e+03 + 74560 1.031669038183964e+00 -5.950385553548172e+00 -5.990021288327481e+00 3.941737550592642e+00 4.714143027879710e+00 9.186440899080435e+03 + 74580 1.119767064394269e+00 -6.062424206716082e+00 -6.006498337256842e+00 3.350412455689892e+00 4.671547452625178e+00 9.237022633588091e+03 + 74600 1.027980859129202e+00 -5.921036440618494e+00 -6.059313969190134e+00 4.088703246316681e+00 4.294692278879936e+00 9.400028553773775e+03 + 74620 9.971038222135958e-01 -5.875922197200731e+00 -5.998062168033779e+00 4.383276683798255e+00 4.681930070175494e+00 9.211064967646806e+03 + 74640 1.013258001856223e+00 -5.902500533533529e+00 -6.016190543704621e+00 4.177963530508841e+00 4.525137898634221e+00 9.266791164605867e+03 + 74660 1.059193675430028e+00 -5.976240775410083e+00 -6.035402595073657e+00 3.725388198118878e+00 4.385671874348631e+00 9.326032035460832e+03 + 74680 1.028157248942786e+00 -5.941259312767286e+00 -6.005303709807145e+00 3.994003166115061e+00 4.626250327473783e+00 9.233298723132541e+03 + 74700 1.014413372245092e+00 -5.934158874136894e+00 -6.013106878784708e+00 3.971760586441834e+00 4.518428926589850e+00 9.257330827541056e+03 + 74720 1.001833892551771e+00 -5.928896048569301e+00 -6.061116476130052e+00 4.042941513524431e+00 4.283711357425559e+00 9.405594345123131e+03 + 74740 1.061532192839292e+00 -6.034599053163236e+00 -6.000426365711791e+00 3.544977641761573e+00 4.741202501314065e+00 9.218346310761026e+03 + 74760 9.902227363604282e-01 -5.945828299383903e+00 -5.996289226839925e+00 4.028104925798226e+00 4.738350471542462e+00 9.205632245778941e+03 + 74780 9.861669758834188e-01 -5.956543563755902e+00 -5.985005868812186e+00 3.965476236022762e+00 4.802041275862109e+00 9.171079723979035e+03 + 74800 1.048940095783802e+00 -6.065132321655853e+00 -6.010596632637689e+00 3.367041636440358e+00 4.680194002153256e+00 9.249612316436929e+03 + 74820 1.015834966429493e+00 -6.034067298275076e+00 -6.015563651510153e+00 3.447482379290489e+00 4.553733182444764e+00 9.264919554420389e+03 + 74840 1.005087561666618e+00 -6.035735410062025e+00 -6.018618063564039e+00 3.460597649048988e+00 4.558888101541232e+00 9.274279876957518e+03 + 74860 9.962693175405798e-01 -6.037874776910914e+00 -6.006042770159165e+00 3.517454826834097e+00 4.700239135589765e+00 9.235615055760793e+03 + 74880 9.838210984550469e-01 -6.035391567341517e+00 -6.024031198393784e+00 3.491072320046960e+00 4.556305316556253e+00 9.290978717553890e+03 + 74900 9.898835861940940e-01 -6.057328591809266e+00 -5.975912018857560e+00 3.497926911986112e+00 4.965433473048749e+00 9.143251803428291e+03 + 74920 1.004909477001958e+00 -6.090743513431176e+00 -5.990829394774128e+00 3.273634725577022e+00 4.847357056565681e+00 9.188942810119861e+03 + 74940 9.013714894836677e-01 -5.947063166425846e+00 -6.067129678785827e+00 3.919276247697617e+00 4.229835753493866e+00 9.424284924996366e+03 + 74960 9.906082050584657e-01 -6.086509472189142e+00 -5.982767825923970e+00 3.230484647502322e+00 4.826185234324818e+00 9.164245384517386e+03 + 74980 9.731575350486679e-01 -6.065009099184050e+00 -5.989783895955930e+00 3.313236137130429e+00 4.745190895128873e+00 9.185734125492649e+03 + 75000 9.031767636327735e-01 -5.964194071152052e+00 -6.034594344179341e+00 3.847100290925394e+00 4.442851028795658e+00 9.323569205250889e+03 + 75020 9.891656218570476e-01 -6.091341204240019e+00 -6.013609404111023e+00 3.263613987255953e+00 4.709962012553845e+00 9.258872094576778e+03 + 75040 9.561902958900501e-01 -6.037082946438109e+00 -6.003341784424343e+00 3.459469436498536e+00 4.653216410209525e+00 9.227293357467415e+03 + 75060 9.581524310898951e-01 -6.025986576067939e+00 -5.989262989277131e+00 3.582128423811049e+00 4.793000942120560e+00 9.184122051767541e+03 + 75080 9.387389412284702e-01 -5.970807685842014e+00 -6.049767478002581e+00 3.806458001259527e+00 4.353058655685205e+00 9.370478257929057e+03 + 75100 1.044418386700193e+00 -6.097579746599338e+00 -6.004396905190619e+00 3.138306937845605e+00 4.673377233212571e+00 9.230566845158684e+03 + 75120 1.018087072607931e+00 -6.027268641292266e+00 -5.983662875710836e+00 3.540156788160131e+00 4.790547842099112e+00 9.166961386994813e+03 + 75140 9.909883097485785e-01 -5.954810891121200e+00 -5.995294338021647e+00 3.977313591988026e+00 4.744851375092496e+00 9.202589508768591e+03 + 75160 1.045909543562959e+00 -6.004171330811315e+00 -6.008944506402410e+00 3.658947651965899e+00 4.631539339075294e+00 9.244518642556346e+03 + 75180 1.054989044812415e+00 -5.991284879842066e+00 -5.987879125589654e+00 3.750026629047960e+00 4.769582997004078e+00 9.179871770258265e+03 + 75200 1.067002661576107e+00 -5.986307099405733e+00 -6.011345862520630e+00 3.769605685167063e+00 4.625829232625257e+00 9.251906644338298e+03 + 75220 1.105922795263517e+00 -6.028050886859274e+00 -6.017253752654459e+00 3.523489917872748e+00 4.585488733327917e+00 9.270110509705943e+03 + 75240 1.066246616021045e+00 -5.962059308394772e+00 -6.022797370135529e+00 3.818319742034890e+00 4.469552392334786e+00 9.287174457689011e+03 + 75260 1.067160928989269e+00 -5.960776474914677e+00 -5.997389461603242e+00 3.996222794054231e+00 4.785985358647114e+00 9.209036466065896e+03 + 75280 1.044739411074072e+00 -5.933220932086551e+00 -6.004514426293211e+00 4.084634762806452e+00 4.675256486439234e+00 9.230875370225827e+03 + 75300 1.010352341456237e+00 -5.894483044046141e+00 -6.006525821265237e+00 4.272884885446588e+00 4.629517920090801e+00 9.237089432280158e+03 + 75320 1.057688127006629e+00 -5.981959759748929e+00 -5.985651972876907e+00 3.824511211462229e+00 4.803309952313250e+00 9.173043169743796e+03 + 75340 1.083425482846253e+00 -6.043483076819438e+00 -6.006912996151572e+00 3.433519005409829e+00 4.643510067806410e+00 9.238295037052616e+03 + 75360 9.995795688748972e-01 -5.950110364480969e+00 -6.079360059960619e+00 3.905626636812446e+00 4.163454884042567e+00 9.462256827859637e+03 + 75380 9.801132111970365e-01 -5.957699646594110e+00 -6.019643513734653e+00 3.918240176567147e+00 4.562548905663687e+00 9.277434126401597e+03 + 75400 9.492582882703273e-01 -5.947366728712081e+00 -5.994264775209764e+00 3.959913947333450e+00 4.690618106894517e+00 9.199404777115471e+03 + 75420 9.892236933165036e-01 -6.036082187835361e+00 -5.975129311222140e+00 3.506518680043181e+00 4.856519529983462e+00 9.140827764862217e+03 + 75440 9.981365269938101e-01 -6.071597767123696e+00 -5.967698078811980e+00 3.324924850573961e+00 4.921532939284633e+00 9.118135088139110e+03 + 75460 9.866187069707827e-01 -6.070671803030987e+00 -5.953334102278861e+00 3.319037862306783e+00 4.992809097975996e+00 9.074333977195169e+03 + 75480 9.334906943703306e-01 -5.999884647112624e+00 -5.977785797213302e+00 3.671864168506138e+00 4.798759184414012e+00 9.148976605514208e+03 + 75500 1.023552451891128e+00 -6.136493766140057e+00 -5.930544394049958e+00 2.989713577526071e+00 5.172306742629749e+00 9.005066546657363e+03 + 75520 1.039443698483504e+00 -6.159465345475929e+00 -5.951838761235138e+00 2.825702610259700e+00 5.017926587080393e+00 9.069789785376292e+03 + 75540 8.903103785785813e-01 -5.933463243448830e+00 -5.984812899822739e+00 4.117314744942707e+00 4.822457071710081e+00 9.170441904241015e+03 + 75560 9.784698811300135e-01 -6.054469740441311e+00 -5.978496184325833e+00 3.402317915518569e+00 4.838569831603455e+00 9.151138456328537e+03 + 75580 9.733704414436345e-01 -6.033475562350262e+00 -6.005629566254975e+00 3.509287982797400e+00 4.669184001530511e+00 9.234321088914077e+03 + 75600 9.574098149151347e-01 -5.995844739760355e+00 -5.966459203382239e+00 3.698554207571252e+00 4.867290504851455e+00 9.114356866955495e+03 + 75620 9.334794682956703e-01 -5.944318230217112e+00 -5.967220120411055e+00 3.997128777686285e+00 4.865622580136614e+00 9.116679492964717e+03 + 75640 1.017813216774222e+00 -6.050475456241590e+00 -5.988513375223678e+00 3.411555454694427e+00 4.767351312500325e+00 9.181792010965863e+03 + 75660 1.018247067036535e+00 -6.033456197337858e+00 -6.007367624479294e+00 3.499831735510538e+00 4.649636358058020e+00 9.239687057587367e+03 + 75680 9.841612210055232e-01 -5.969275112742001e+00 -5.977324694765610e+00 3.838262099970233e+00 4.792040154321882e+00 9.147584227092411e+03 + 75700 1.023086156526466e+00 -6.016973927045079e+00 -6.002793952378700e+00 3.571559721494112e+00 4.652983330372449e+00 9.225626114234668e+03 + 75720 1.044223430331100e+00 -6.041212489930854e+00 -6.007142877061423e+00 3.474701268222751e+00 4.670334257574575e+00 9.238983486353010e+03 + 75740 9.802168433681153e-01 -5.943511748215252e+00 -6.022010906204428e+00 3.946425407635748e+00 4.495671094756464e+00 9.284735706470581e+03 + 75760 1.038954613890368e+00 -6.029881328656793e+00 -5.952945884107309e+00 3.540871849266513e+00 4.982647077591219e+00 9.073172151790774e+03 + 75780 9.993848586369747e-01 -5.970201108789675e+00 -6.023846731486981e+00 3.831640501698355e+00 4.523599034537143e+00 9.290374204570977e+03 + 75800 1.029290720166318e+00 -6.014602965115286e+00 -5.995357952957322e+00 3.606274871449123e+00 4.716782709416160e+00 9.202799288889351e+03 + 75820 9.917700322078955e-01 -5.959765865789294e+00 -6.026380689064617e+00 3.890163113003064e+00 4.507650489145570e+00 9.298211084524097e+03 + 75840 1.042892857361761e+00 -6.038284676672754e+00 -5.991404087365744e+00 3.522401576659979e+00 4.791597175208578e+00 9.190700934275812e+03 + 75860 1.026569282707879e+00 -6.018164703331084e+00 -6.013845163119138e+00 3.625743335696706e+00 4.650546804040385e+00 9.259590123767643e+03 + 75880 1.019310343460502e+00 -6.012670587135110e+00 -6.001861194840267e+00 3.673453076236659e+00 4.735522279541696e+00 9.222747903413472e+03 + 75900 9.996539443294665e-01 -5.991643372108337e+00 -5.966618700324237e+00 3.693974437407740e+00 4.837669975347482e+00 9.114835772791226e+03 + 75920 9.749006909556794e-01 -5.959933933584758e+00 -5.984274830928804e+00 3.885337413815258e+00 4.745568214524056e+00 9.168819951777805e+03 + 75940 1.032945191378279e+00 -6.048987263396410e+00 -6.000415941836204e+00 3.387731501983450e+00 4.666635546769871e+00 9.218341025775851e+03 + 75960 9.730442500072982e-01 -5.966501829892515e+00 -6.011242578217908e+00 3.829347408102279e+00 4.572439107609442e+00 9.251593896570248e+03 + 75980 9.563082526846279e-01 -5.946660088488365e+00 -5.995462278642439e+00 3.967992828326419e+00 4.687763100347206e+00 9.203122695522623e+03 + 76000 1.058997723492553e+00 -6.102536669633796e+00 -5.984321062105490e+00 3.157451226388706e+00 4.836263538622379e+00 9.168991509861893e+03 + 76020 9.805013462076424e-01 -5.993833789140003e+00 -5.998408899395569e+00 3.691087299817792e+00 4.664816308734304e+00 9.212182104184820e+03 + 76040 8.964928755427293e-01 -5.879642025898708e+00 -6.030264511635922e+00 4.272221797885052e+00 4.407324176027634e+00 9.310194074019859e+03 + 76060 1.006614301242289e+00 -6.051929230974168e+00 -5.991137774956438e+00 3.387713568774124e+00 4.736787516675347e+00 9.189878940377828e+03 + 76080 9.666553023282343e-01 -6.003549831001783e+00 -6.009936022633726e+00 3.679526993772567e+00 4.642856493161990e+00 9.247577640962007e+03 + 76100 9.614220741673107e-01 -6.008141877320506e+00 -5.978339355400136e+00 3.670887373936226e+00 4.842018066728354e+00 9.150675254777896e+03 + 76120 1.050500463316089e+00 -6.152801754801598e+00 -5.960273058215344e+00 2.883719295811404e+00 4.989248865329185e+00 9.095510106599324e+03 + 76140 9.346987238936402e-01 -5.996138869001317e+00 -6.001785448946238e+00 3.738170515829923e+00 4.705746979980766e+00 9.222525502074384e+03 + 76160 9.624118833728623e-01 -6.049282951305624e+00 -5.995734564101333e+00 3.458774950666093e+00 4.766258076579273e+00 9.203963132863235e+03 + 76180 9.431754148477602e-01 -6.030602554820272e+00 -6.020957590001691e+00 3.474640771180346e+00 4.530023651722122e+00 9.281502497573641e+03 + 76200 9.610186511686951e-01 -6.063543948994777e+00 -5.974839186615586e+00 3.368646722591369e+00 4.878003195190301e+00 9.139945889255712e+03 + 76220 9.086669644498075e-01 -5.987174244648362e+00 -5.981709122120128e+00 3.788426841995949e+00 4.819808421278049e+00 9.160989287064844e+03 + 76240 9.828826413289135e-01 -6.091437614645936e+00 -5.987485726540633e+00 3.230818062193644e+00 4.827725890196984e+00 9.178683911059974e+03 + 76260 9.713643711485727e-01 -6.062857408670565e+00 -6.012977713258335e+00 3.345658239932754e+00 4.632075169847695e+00 9.256939776110510e+03 + 76280 9.717497689601412e-01 -6.047388616174181e+00 -5.992313679297825e+00 3.456976691083747e+00 4.773225501446716e+00 9.193452782296879e+03 + 76300 9.732700430416599e-01 -6.025984166507838e+00 -5.965058366150467e+00 3.577698014021527e+00 4.927543387910685e+00 9.110106368520201e+03 + 76320 9.393263477521796e-01 -5.942602203717096e+00 -6.065160260035038e+00 4.008285687267376e+00 4.304538362091839e+00 9.418172735395015e+03 + 76340 1.025899129067717e+00 -6.037101081803071e+00 -5.990736718099890e+00 3.533370710060143e+00 4.799602061305902e+00 9.188637865100225e+03 + 76360 9.919463173302240e-01 -5.956023663040701e+00 -6.023207319579790e+00 3.951460898631297e+00 4.565681946146595e+00 9.288417673778627e+03 + 76380 1.074341972016869e+00 -6.048711788087820e+00 -6.004593177984445e+00 3.423100265281648e+00 4.676436151828078e+00 9.231158279894786e+03 + 76400 1.050799163978738e+00 -5.990433181623408e+00 -5.993920747600994e+00 3.780347102606379e+00 4.760320959063991e+00 9.198381864829003e+03 + 76420 9.792960951859160e-01 -5.866313953106109e+00 -6.041130800374077e+00 4.370715456274557e+00 4.366890066442200e+00 9.343735117088994e+03 + 76440 1.051384956401572e+00 -5.959778268615379e+00 -6.066305459797434e+00 3.881959272693226e+00 4.270263655896306e+00 9.421700878732379e+03 + 76460 1.036357685677671e+00 -5.931955912465336e+00 -6.025265234334005e+00 4.101667679746796e+00 4.565871114006007e+00 9.294747850975224e+03 + 76480 1.032009800217366e+00 -5.927388978314423e+00 -5.987017449215912e+00 4.101684063275973e+00 4.759288155883572e+00 9.177214174658451e+03 + 76500 1.027925035859570e+00 -5.926031675911401e+00 -6.018092463977688e+00 4.104122092603991e+00 4.575494801166463e+00 9.272655896554184e+03 + 76520 1.037580419386850e+00 -5.949032323179776e+00 -6.010198246998746e+00 4.024535934602671e+00 4.673311734638030e+00 9.248352565538145e+03 + 76540 1.035843889618901e+00 -5.960264906968655e+00 -6.053228202961442e+00 3.936829012181193e+00 4.403019380567052e+00 9.381166835479979e+03 + 76560 9.850519214102815e-01 -5.909536929257771e+00 -6.057584879157478e+00 4.199545301874537e+00 4.349431063204216e+00 9.394666394615720e+03 + 76580 9.998792076062604e-01 -5.963449729100997e+00 -6.020336461459119e+00 3.880447041390928e+00 4.553794620997207e+00 9.279553199305970e+03 + 76600 9.512210008359980e-01 -5.930078940772505e+00 -6.024702116058537e+00 4.100948196493619e+00 4.557607281112174e+00 9.293013388693058e+03 + 76620 9.226928427989315e-01 -5.930462054213585e+00 -6.035250457730156e+00 4.066645576362719e+00 4.464934347417533e+00 9.325534101334048e+03 + 76640 9.553986471574069e-01 -6.022872648314278e+00 -6.007687329245370e+00 3.553731684802222e+00 4.640928136816425e+00 9.240655830261981e+03 + 76660 9.383121041992821e-01 -6.033672842800294e+00 -5.998979769155121e+00 3.486821575638184e+00 4.686034573244561e+00 9.213910877011687e+03 + 76680 9.708105990326795e-01 -6.106143700013234e+00 -6.003165510453729e+00 3.095578960978561e+00 4.686895661252573e+00 9.226761497758769e+03 + 76700 8.912951718497409e-01 -6.001832657872717e+00 -5.983007315887091e+00 3.701910437137620e+00 4.810008464031336e+00 9.164961761229897e+03 + 76720 9.421990495286363e-01 -6.080301351109673e+00 -5.945697200326824e+00 3.341281492039762e+00 5.114199355759895e+00 9.051086277698612e+03 + 76740 9.432327326156946e-01 -6.077393098316669e+00 -5.982082890038811e+00 3.295132721809369e+00 4.842418686947893e+00 9.162123478709380e+03 + 76760 9.767937287972908e-01 -6.118548008785300e+00 -5.985724566341556e+00 3.061428558737151e+00 4.824121319610417e+00 9.173298336570455e+03 + 76780 9.561903923863774e-01 -6.077181607750971e+00 -6.003353010775188e+00 3.300242689887436e+00 4.724177918660837e+00 9.227345771209897e+03 + 76800 9.558471488326886e-01 -6.064119608469790e+00 -6.026584230859662e+00 3.368143719830464e+00 4.583677666648735e+00 9.298848875920663e+03 + 76820 9.877554494593810e-01 -6.096851290251675e+00 -6.001954716969349e+00 3.169299761614575e+00 4.714210570598948e+00 9.223071498655368e+03 + 76840 1.005662093760999e+00 -6.107363719388782e+00 -6.016023354510056e+00 3.129652788210538e+00 4.654143298219965e+00 9.266324546636293e+03 + 76860 9.629276590705684e-01 -6.028074305305965e+00 -6.010914277840445e+00 3.551764779963115e+00 4.650300313175793e+00 9.250593438980522e+03 + 76880 1.005640017437750e+00 -6.074059817665225e+00 -5.950349520443142e+00 3.360527956479642e+00 5.070891627235463e+00 9.065254930255074e+03 + 76900 9.558007498231788e-01 -5.978732247916508e+00 -6.029972410141292e+00 3.813202752771977e+00 4.518973811887786e+00 9.309281942000423e+03 + 76920 9.635833397830832e-01 -5.967959170085510e+00 -6.041678171327630e+00 3.820041388581217e+00 4.396735475470393e+00 9.345441925865203e+03 + 76940 9.421301427258595e-01 -5.912777915648110e+00 -6.053422211223491e+00 4.179861542793535e+00 4.372260232965303e+00 9.381751527154622e+03 + 76960 9.915752406071684e-01 -5.963930328138336e+00 -6.060114546532394e+00 3.872947542065824e+00 4.320642875587452e+00 9.402506821147526e+03 + 76980 1.046934619054613e+00 -6.030377398822007e+00 -5.997148154381055e+00 3.489395323496897e+00 4.680202787285801e+00 9.208317420400437e+03 + 77000 1.042335079469620e+00 -6.009978117040044e+00 -5.987932821460490e+00 3.600368097258323e+00 4.726955595974588e+00 9.180041326215613e+03 + 77020 1.024535178915475e+00 -5.971476807277279e+00 -5.980277684946483e+00 3.803232739899332e+00 4.752696738391347e+00 9.156605091412457e+03 + 77040 1.019598176556116e+00 -5.953315687064539e+00 -5.976077003144718e+00 4.009009834140306e+00 4.878310834905633e+00 9.143744415178186e+03 + 77060 1.041713831077807e+00 -5.976726548851118e+00 -5.996791784442926e+00 3.843018017423572e+00 4.727800329570239e+00 9.207181835851172e+03 + 77080 1.002934024327031e+00 -5.913750650813284e+00 -5.981341624834481e+00 4.163475944753184e+00 4.775358112254052e+00 9.159831459162140e+03 + 77100 9.982358074409257e-01 -5.902955991983289e+00 -6.016781512694070e+00 4.212760848272399e+00 4.559157093908688e+00 9.268602774832119e+03 + 77120 1.047665876949249e+00 -5.971728448697578e+00 -5.993512477430713e+00 3.821828849272328e+00 4.696741585219117e+00 9.197138565099101e+03 + 77140 1.036375780664809e+00 -5.954992368112570e+00 -6.004017623558129e+00 3.963488125319666e+00 4.681977521917512e+00 9.229384525264504e+03 + 77160 1.083417338499295e+00 -6.033351500097038e+00 -5.996351446041330e+00 3.510460346594006e+00 4.722920382721744e+00 9.205855566115824e+03 + 77180 9.497134417590708e-01 -5.854649528744345e+00 -6.026590805702252e+00 4.449485889100739e+00 4.462172468981819e+00 9.298847342883562e+03 + 77200 9.894655001962721e-01 -5.942531811988326e+00 -5.981341099856079e+00 3.997693021935425e+00 4.774844085280900e+00 9.159873237650569e+03 + 77220 1.010360947542924e+00 -6.012945004811342e+00 -6.006646322910180e+00 3.609005985009591e+00 4.645173991203935e+00 9.237467810396494e+03 + 77240 1.009200263605901e+00 -6.055225077700695e+00 -6.002119266627410e+00 3.393315630480870e+00 4.698257415761375e+00 9.223565661772283e+03 + 77260 9.836360584015219e-01 -6.060451391665072e+00 -5.998732676427379e+00 3.356611243517663e+00 4.711009657352810e+00 9.213168639885615e+03 + 77280 9.685437663568397e-01 -6.071742387060486e+00 -5.980134191056099e+00 3.311472811239249e+00 4.837501249018960e+00 9.156158120998918e+03 + 77300 9.452389807198504e-01 -6.061294159980749e+00 -5.968168502439280e+00 3.381130275701753e+00 4.915872212453797e+00 9.119599846795047e+03 + 77320 8.955472392653632e-01 -6.001762377437462e+00 -5.987818778440642e+00 3.732232254297299e+00 4.812298557502010e+00 9.179678733990897e+03 + 77340 9.683223768458368e-01 -6.115776029469878e+00 -5.966384884551712e+00 3.015040293711091e+00 4.872867366036164e+00 9.114162292673003e+03 + 77360 9.710326237342986e-01 -6.118669132700488e+00 -5.948709757641238e+00 3.058176408492790e+00 5.034109441211292e+00 9.060269773849717e+03 + 77380 8.650356003156162e-01 -5.952971528810299e+00 -6.008998753139428e+00 4.019882699531170e+00 4.698165707248370e+00 9.244682902453351e+03 + 77400 9.131556331120234e-01 -6.008409215535228e+00 -6.033416286288848e+00 3.630685856247787e+00 4.487091386148810e+00 9.319927730441170e+03 + 77420 9.763404064804806e-01 -6.078787770396910e+00 -6.016241409066623e+00 3.275117929098804e+00 4.634268814875448e+00 9.266995746758601e+03 + 77440 9.722340708376678e-01 -6.044122619354061e+00 -6.022693640634591e+00 3.451021339515321e+00 4.574069851446258e+00 9.286869486844340e+03 + 77460 1.017177365850317e+00 -6.082248924880900e+00 -5.981284691907249e+00 3.327329319937198e+00 4.907081569836457e+00 9.159703313212249e+03 + 77480 9.658975788279093e-01 -5.977402502441602e+00 -6.000395282625137e+00 3.795422905219624e+00 4.663394803284532e+00 9.218283139285564e+03 + 77500 9.442353782665713e-01 -5.914206468712625e+00 -6.032329993343484e+00 4.178594818543623e+00 4.500311260556872e+00 9.316545250762139e+03 + 77520 1.049576398605439e+00 -6.042887420064083e+00 -6.016984287363749e+00 3.475965489165315e+00 4.624705285627462e+00 9.269274340549440e+03 + 77540 1.021397397043001e+00 -5.980467997483546e+00 -6.023540739281695e+00 3.829482468465731e+00 4.582152119575504e+00 9.289441571086822e+03 + 77560 1.081718043063313e+00 -6.056658624635601e+00 -5.984961488239033e+00 3.389079210130718e+00 4.800775262415809e+00 9.170940437994550e+03 + 77580 1.051081133994240e+00 -6.002790863731874e+00 -6.002531779993344e+00 3.677989618991821e+00 4.679477317911537e+00 9.224820826580171e+03 + 77600 1.045144838650354e+00 -5.991019784205380e+00 -5.978131754932868e+00 3.774131312633760e+00 4.848136371132615e+00 9.150037938357164e+03 + 77620 9.680182838729169e-01 -5.875749678636447e+00 -6.035411279728108e+00 4.335281813683196e+00 4.418480192661962e+00 9.326070036218438e+03 + 77640 1.018954919826581e+00 -5.953533830460769e+00 -6.011670857923179e+00 3.909833588969740e+00 4.576001780604657e+00 9.252887617546943e+03 + 77660 1.007176929957126e+00 -5.938976396837838e+00 -6.036216775611024e+00 4.013974431109268e+00 4.455605128293656e+00 9.328551083226552e+03 + 77680 9.923511004572109e-01 -5.923442677615512e+00 -6.007661993330843e+00 4.065261397484885e+00 4.581661053750467e+00 9.240564443597070e+03 + 77700 1.039543549697005e+00 -6.001704272572851e+00 -5.960326312842605e+00 3.660259294958065e+00 4.897857942947711e+00 9.095654480658228e+03 + 77720 9.777990251909182e-01 -5.917285478683038e+00 -5.974411061196603e+00 4.206973561374035e+00 4.878949626425817e+00 9.138656956949191e+03 + 77740 1.022082528259537e+00 -5.989813024689306e+00 -5.978510241774536e+00 3.740885041193038e+00 4.805787369789648e+00 9.151175886242883e+03 + 77760 9.886953834658311e-01 -5.946410118122367e+00 -5.969587743105917e+00 3.975347972888523e+00 4.842258463507106e+00 9.123922926439400e+03 + 77780 1.061578330014396e+00 -6.059888056967913e+00 -5.991066218143676e+00 3.375710787152073e+00 4.770896435825980e+00 9.189647861639460e+03 + 77800 9.778484419740191e-01 -5.942984135445919e+00 -6.034167921374210e+00 3.972253946178110e+00 4.448662536732597e+00 9.322236018570735e+03 + 77820 1.034720078141913e+00 -6.036308450085625e+00 -5.980369853044770e+00 3.522590125062709e+00 4.843798205741212e+00 9.156889356561118e+03 + 77840 9.302569749794343e-01 -5.889827459535896e+00 -6.026527443334457e+00 4.260438756138591e+00 4.475486294913128e+00 9.298631571649845e+03 + 77860 9.854076357739538e-01 -5.978832068227005e+00 -5.991086670188578e+00 3.856886925175240e+00 4.786519104318365e+00 9.189660556677058e+03 + 77880 9.771709204725942e-01 -5.971340944069631e+00 -5.979993153965307e+00 3.826373791193700e+00 4.776691463047578e+00 9.155717981676084e+03 + 77900 9.838583252085812e-01 -5.983809071754007e+00 -5.947244266093203e+00 3.815421261565676e+00 5.025382034055401e+00 9.055784828092406e+03 + 77920 1.023374661453120e+00 -6.040827521537453e+00 -5.998995531952848e+00 3.479597086961526e+00 4.719802844635797e+00 9.213964150318579e+03 + 77940 9.753855008387742e-01 -5.970113202504599e+00 -6.051150741753498e+00 3.816902406340703e+00 4.351572315454859e+00 9.374740422117926e+03 + 77960 9.509833467938199e-01 -5.935861221172030e+00 -6.047364674563227e+00 4.004458025930132e+00 4.364187941454230e+00 9.363003209466837e+03 + 77980 1.000501956016721e+00 -6.009152484900175e+00 -5.979040776311124e+00 3.674137609486086e+00 4.847043699976264e+00 9.152795525109021e+03 + 78000 1.035558276446623e+00 -6.059646399185356e+00 -5.992183597233770e+00 3.360187400948170e+00 4.747569249589040e+00 9.193070884090206e+03 + 78020 1.031801518384735e+00 -6.054078037849761e+00 -5.978234881181659e+00 3.360844305816719e+00 4.796347448095525e+00 9.150348501088243e+03 + 78040 9.656222245905778e-01 -5.954411071397783e+00 -5.973511694340407e+00 3.972578943109828e+00 4.862900210361437e+00 9.135923912500321e+03 + 78060 1.011170700379149e+00 -6.020073804435849e+00 -5.979121773776226e+00 3.610937885366757e+00 4.846090782720574e+00 9.153057244485020e+03 + 78080 9.699830484688068e-01 -5.955785044985195e+00 -6.027195256344613e+00 3.907290035032333e+00 4.497241550712058e+00 9.300704756762751e+03 + 78100 9.610813965348000e-01 -5.942013859772642e+00 -5.987966570586007e+00 4.048235447364529e+00 4.784367870715170e+00 9.180139242009309e+03 + 78120 1.025812866564263e+00 -6.036576277231871e+00 -5.944614075377666e+00 3.520874316821975e+00 5.048935510973559e+00 9.047800525774805e+03 + 78140 1.029167987924762e+00 -6.037594329055075e+00 -5.980582677870343e+00 3.501838374707892e+00 4.829208098335134e+00 9.157541919890924e+03 + 78160 9.835237912607578e-01 -5.966550558786542e+00 -5.987165477301216e+00 3.864639646367784e+00 4.746265594108194e+00 9.177683698383820e+03 + 78180 9.561486445934152e-01 -5.920453392326651e+00 -5.983548461030182e+00 4.167595956491040e+00 4.805294308065045e+00 9.166587688297264e+03 + 78200 9.903941374251212e-01 -5.963828557270103e+00 -6.002396686169795e+00 3.894386921306210e+00 4.672922756765524e+00 9.224407529202610e+03 + 78220 1.057876955569207e+00 -6.057179896004997e+00 -5.964932011275994e+00 3.391526269118286e+00 4.921227898546247e+00 9.109667761734130e+03 + 78240 9.630265461838489e-01 -5.911619901225698e+00 -5.934907501226494e+00 4.216078442369825e+00 5.082357439420801e+00 9.018240981451250e+03 + 78260 1.077269212336475e+00 -6.072782749252964e+00 -5.876633914204840e+00 3.341010884937469e+00 5.467327849717924e+00 8.842183324704531e+03 + 78280 9.970598298591326e-01 -5.938080612214741e+00 -6.011349291534779e+00 3.969420566979301e+00 4.548700472032163e+00 9.251906226570100e+03 + 78300 1.061435024299968e+00 -6.014334463287263e+00 -6.009462189894336e+00 3.649028169986043e+00 4.677005517790101e+00 9.246092102465727e+03 + 78320 9.787270709110747e-01 -5.871717681722421e+00 -6.032583403681477e+00 4.360343534504780e+00 4.436627665125861e+00 9.317298261436030e+03 + 78340 1.102678630242116e+00 -6.034447246869417e+00 -5.973227655273385e+00 3.515790822786725e+00 4.867323191432330e+00 9.135048578131275e+03 + 78360 1.057204241775132e+00 -5.946192097353454e+00 -5.988388452768039e+00 3.984615675429995e+00 4.742317672774551e+00 9.181443210237541e+03 + 78380 9.893280282933085e-01 -5.828745090516662e+00 -6.045387884200591e+00 4.587886553160031e+00 4.343890106462939e+00 9.356865321622250e+03 + 78400 1.053306678465758e+00 -5.910026704823762e+00 -6.010779473515328e+00 4.156065726245334e+00 4.577527736977802e+00 9.250150928122406e+03 + 78420 9.868150142513562e-01 -5.800963539042431e+00 -6.049397822676246e+00 4.712709349528486e+00 4.286161247821981e+00 9.369304693532913e+03 + 78440 9.901759031263837e-01 -5.800094036448796e+00 -6.052342573985558e+00 4.756807655012659e+00 4.308357517141542e+00 9.378419942071738e+03 + 78460 1.073739643344300e+00 -5.924865216846635e+00 -6.001921228762137e+00 4.061646669862794e+00 4.619179125064680e+00 9.222943560826216e+03 + 78480 1.143927342387567e+00 -6.038550978516589e+00 -6.011563258982916e+00 3.442869434448245e+00 4.597837096346694e+00 9.252593040444399e+03 + 78500 1.032179657833521e+00 -5.897918239120339e+00 -6.029853108690820e+00 4.236786427244221e+00 4.479195989315442e+00 9.308915026663193e+03 + 78520 1.042215401167458e+00 -5.950578158116070e+00 -5.989930918181021e+00 3.931172340263523e+00 4.705202702150635e+00 9.186129068838927e+03 + 78540 9.970476489870109e-01 -5.926341348062729e+00 -5.944589811448207e+00 4.071803912423094e+00 4.967018411723097e+00 9.047715710282891e+03 + 78560 9.517091121773785e-01 -5.897295666729639e+00 -6.003733757849261e+00 4.217445591714504e+00 4.606261601264264e+00 9.228480719592844e+03 + 78580 1.081789729646000e+00 -6.124980925436486e+00 -5.955077474193791e+00 3.010762435639613e+00 4.986374345149272e+00 9.079666659425113e+03 + 78600 1.014627314971315e+00 -6.055275194414532e+00 -5.983834517690553e+00 3.361596416479979e+00 4.771819837638057e+00 9.167490450124029e+03 + 78620 9.616948928726742e-01 -6.000035195042575e+00 -5.940127530466191e+00 3.714984392001054e+00 5.058983472679778e+00 9.034163809888018e+03 + 78640 9.524373869648703e-01 -6.000872336999088e+00 -6.010610131253565e+00 3.622197142985709e+00 4.566281221457712e+00 9.249621586994937e+03 + 78660 1.028927671274577e+00 -6.124736986929117e+00 -5.940876632743382e+00 3.061046469344237e+00 5.116801075376577e+00 9.036450298520682e+03 + 78680 9.456871941114241e-01 -6.006817994074615e+00 -5.978133941407339e+00 3.685806025051366e+00 4.850514294309672e+00 9.150040581860607e+03 + 78700 9.591998253277820e-01 -6.027926903531983e+00 -5.951362200963295e+00 3.522568575390019e+00 4.962214945888855e+00 9.068332423019394e+03 + 78720 9.285202023313307e-01 -5.976431947831863e+00 -6.013021018716906e+00 3.793411721804943e+00 4.583311614642611e+00 9.257059500192408e+03 + 78740 1.018128245515924e+00 -6.097645963800478e+00 -6.037455264090092e+00 3.138253804227053e+00 4.483878116444762e+00 9.332400033088696e+03 + 78760 9.795047739244352e-01 -6.032619372988026e+00 -6.005281103602453e+00 3.557891298829758e+00 4.714871872225229e+00 9.233247589986886e+03 + 78780 9.797599624029488e-01 -6.022422407558693e+00 -6.018758136649420e+00 3.548159106901778e+00 4.569199917506918e+00 9.274714482911944e+03 + 78800 9.889848552322934e-01 -6.019938375789486e+00 -5.990886136505022e+00 3.606712311864928e+00 4.773534765655818e+00 9.189085688942474e+03 + 78820 1.016181227012294e+00 -6.039945699056154e+00 -6.002442407504644e+00 3.457259117302304e+00 4.672608821006688e+00 9.224544831556430e+03 + 78840 1.020038795584622e+00 -6.022951695514823e+00 -6.007542024771134e+00 3.559278285303629e+00 4.647762999352734e+00 9.240208373979474e+03 + 78860 1.031588973236699e+00 -6.010667460352778e+00 -5.994376011284881e+00 3.662324383711345e+00 4.755872405352804e+00 9.199785395935016e+03 + 78880 1.050418868335119e+00 -6.004578971182838e+00 -5.994522496902715e+00 3.700638146875298e+00 4.758383978426126e+00 9.200236146901805e+03 + 78900 1.057654014429690e+00 -5.977309490504414e+00 -6.044375388860435e+00 3.796956648130540e+00 4.411853881356040e+00 9.353777061147757e+03 + 78920 1.039118074481839e+00 -5.910382592475586e+00 -6.052977517470810e+00 4.229751421488650e+00 4.410949295672747e+00 9.380391232580549e+03 + 78940 1.043392432989924e+00 -5.879519212341009e+00 -6.074252070616045e+00 4.308309312968984e+00 4.190123105941303e+00 9.446401254562359e+03 + 78960 1.078145343636826e+00 -5.899075920199808e+00 -6.011773951239642e+00 4.270903374757216e+00 4.623773840562547e+00 9.253217154549773e+03 + 78980 1.074152668398324e+00 -5.868991093625352e+00 -6.042776177483228e+00 4.390863481301415e+00 4.392962636634677e+00 9.348798996054009e+03 + 79000 1.087119540468721e+00 -5.872479099440164e+00 -6.028040506981574e+00 4.396650785246825e+00 4.503393110094033e+00 9.303313985013136e+03 + 79020 1.045594376917950e+00 -5.806400210036923e+00 -5.978380898053079e+00 4.766158122425988e+00 4.778618397911764e+00 9.150779076462419e+03 + 79040 1.050787461867241e+00 -5.817866658126946e+00 -6.042735076944107e+00 4.609850743621839e+00 4.318621484498357e+00 9.348664290039538e+03 + 79060 1.118529069719522e+00 -5.936477655074926e+00 -6.011877044980094e+00 4.049474259201137e+00 4.616519294347784e+00 9.253541687095676e+03 + 79080 1.037653782897599e+00 -5.861895815075505e+00 -6.048808746908097e+00 4.426638768443851e+00 4.353355789178391e+00 9.367459128955737e+03 + 79100 1.038199487015037e+00 -5.933490529071011e+00 -6.019888840877403e+00 4.037378768024137e+00 4.541266291536290e+00 9.278166779912566e+03 + 79120 1.041007842571978e+00 -6.007252077349941e+00 -6.036054921119177e+00 3.633078153130786e+00 4.467687766982163e+00 9.328078612817981e+03 + 79140 1.025406368535512e+00 -6.041361898140677e+00 -6.041000342870972e+00 3.486120739853750e+00 4.488196846162893e+00 9.343357298072640e+03 + 79160 9.341456859815093e-01 -5.941385867746375e+00 -6.048466434129687e+00 3.994571257516307e+00 4.379698074679232e+00 9.366428492812618e+03 + 79180 9.771608506276181e-01 -6.028575982982802e+00 -5.991812443083738e+00 3.568658433428185e+00 4.779760368668022e+00 9.191926435683650e+03 + 79200 9.921923681853101e-01 -6.066906159128821e+00 -6.019636137038110e+00 3.328163013577709e+00 4.599594795434848e+00 9.277443305901108e+03 + 79220 9.862049653849216e-01 -6.071625437979191e+00 -5.989908855589705e+00 3.341828607592565e+00 4.811057869273252e+00 9.186122238372905e+03 + 79240 9.306235220428800e-01 -5.999125961340726e+00 -6.044789960055729e+00 3.700988318142798e+00 4.438778571040285e+00 9.355053231425367e+03 + 79260 9.589629413367583e-01 -6.046224955906822e+00 -6.019065989180349e+00 3.406947773015941e+00 4.562898762795867e+00 9.275677671331601e+03 + 79280 9.595196581274834e-01 -6.048244259439383e+00 -6.030818493424709e+00 3.413428615115200e+00 4.513490060200033e+00 9.311891654543091e+03 + 79300 8.952387423203870e-01 -5.950500260629876e+00 -6.050300929690748e+00 3.922360906396322e+00 4.349290020545174e+00 9.372099766257763e+03 + 79320 9.956690213581377e-01 -6.093825854364747e+00 -5.989998018352688e+00 3.229345426648499e+00 4.825540928335434e+00 9.186359282861100e+03 + 79340 9.453222731746629e-01 -6.008015081781671e+00 -6.007742814689832e+00 3.694970934431101e+00 4.696534334205639e+00 9.240827163162217e+03 + 79360 9.422612152029742e-01 -5.987268120853800e+00 -6.024558769907834e+00 3.767374432947217e+00 4.553245755369661e+00 9.292586234921657e+03 + 79380 9.705144832288686e-01 -6.007845519056992e+00 -6.044050643127449e+00 3.623239496518131e+00 4.415344071380728e+00 9.352753501102710e+03 + 79400 9.764064812159740e-01 -5.993056183192470e+00 -5.964515679474910e+00 3.770704505345157e+00 4.934588494320066e+00 9.108432166291823e+03 + 79420 9.995662938005271e-01 -6.000435576227896e+00 -5.985457144450022e+00 3.738560421878058e+00 4.824568895051439e+00 9.172421662091130e+03 + 79440 9.774946319946323e-01 -5.936023080946880e+00 -6.059649770402508e+00 3.975415994600592e+00 4.265532412578008e+00 9.401075581334733e+03 + 79460 1.040666700708623e+00 -6.002604690484982e+00 -6.004831082142114e+00 3.673864766461619e+00 4.661080481033374e+00 9.231892682418078e+03 + 79480 9.637832161120380e-01 -5.866068025215973e+00 -6.000650551884299e+00 4.433261003931724e+00 4.660467309223500e+00 9.219057385786535e+03 + 79500 1.077214823249315e+00 -6.013177271419051e+00 -6.028254098450110e+00 3.625312698312519e+00 4.538739224368737e+00 9.303986105161433e+03 + 79520 1.052711047504761e+00 -5.963100550037455e+00 -5.991324134985586e+00 3.921142717210432e+00 4.759078524852609e+00 9.190406266832431e+03 + 79540 1.021354527330367e+00 -5.908605877420546e+00 -6.009051397536357e+00 4.169295232950930e+00 4.592521512551939e+00 9.244836810343091e+03 + 79560 1.096226664016190e+00 -6.015433960272047e+00 -6.002037267466036e+00 3.607595185069786e+00 4.684521068293415e+00 9.223286085006308e+03 + 79580 1.064245855906995e+00 -5.969268792070979e+00 -6.029122077216962e+00 3.827926427958697e+00 4.484239602384521e+00 9.306677768741232e+03 + 79600 1.003499502899127e+00 -5.888123818580556e+00 -6.054317103121496e+00 4.262769895303282e+00 4.308462337141539e+00 9.384546528756066e+03 + 79620 1.064809178017311e+00 -5.999038060160107e+00 -6.001619904533060e+00 3.678894622960706e+00 4.664069273032084e+00 9.222000426559915e+03 + 79640 9.877173187762055e-01 -5.911497761250411e+00 -6.002963567027717e+00 4.155609457668405e+00 4.630398646607413e+00 9.226127831034701e+03 + 79660 9.852382359490183e-01 -5.941360703207859e+00 -6.013246242452160e+00 4.004987737681130e+00 4.592209847089107e+00 9.257749902507167e+03 + 79680 9.939942998932763e-01 -5.999508769907811e+00 -6.024586127723809e+00 3.616648045999105e+00 4.472649976711066e+00 9.292582044842904e+03 + 79700 9.637614969008178e-01 -6.001786483017087e+00 -5.929274555850238e+00 3.734650161543867e+00 5.151024868520377e+00 9.001201648249598e+03 + 79720 9.407338276555868e-01 -6.005320715260617e+00 -5.988953697364212e+00 3.648915111905061e+00 4.742897061454052e+00 9.183164777338403e+03 + 79740 9.709731459904474e-01 -6.079583019285436e+00 -5.984275981036768e+00 3.286585792120399e+00 4.833853554460755e+00 9.168869075737641e+03 + 79760 9.325677434475586e-01 -6.042795988785289e+00 -6.032028380941854e+00 3.467948037595739e+00 4.529777308114667e+00 9.315633429764390e+03 + 79780 9.240363800334991e-01 -6.039962831195194e+00 -5.989540885375548e+00 3.517547077489255e+00 4.807077693156561e+00 9.184974748497798e+03 + 79800 9.076214887800623e-01 -6.017846629183991e+00 -6.015104129449033e+00 3.613188873951509e+00 4.628936731830101e+00 9.263465934474720e+03 + 79820 9.148004830786736e-01 -6.023555502456211e+00 -5.991199799061269e+00 3.536928556284388e+00 4.722720012207068e+00 9.190060882125381e+03 + 79840 1.003276045520737e+00 -6.143483104619577e+00 -5.986359992497601e+00 2.863317542376134e+00 4.765542766903541e+00 9.175236724547416e+03 + 79860 9.311505090750651e-01 -6.024912465883136e+00 -6.006804331693696e+00 3.577492525247938e+00 4.681472233988409e+00 9.237961438708477e+03 + 79880 1.007102443784402e+00 -6.124752048473201e+00 -5.992352891390007e+00 3.023103175949877e+00 4.783359624624916e+00 9.193604061899778e+03 + 79900 9.288749603926837e-01 -5.993582502641173e+00 -6.045098621374047e+00 3.687153003981361e+00 4.391339478123589e+00 9.356009695512674e+03 + 79920 1.013468818583371e+00 -6.103411831721618e+00 -5.971150467325057e+00 3.156237046518667e+00 4.915702268263713e+00 9.128700634827090e+03 + 79940 9.249619277342788e-01 -5.952829499322999e+00 -6.049300172742184e+00 3.921393815847391e+00 4.367444280285968e+00 9.368987612881707e+03 + 79960 1.017806098949270e+00 -6.071529968378758e+00 -5.989422847065706e+00 3.312290670286356e+00 4.783762466901862e+00 9.184615414263824e+03 + 79980 9.726882956039568e-01 -5.987296761532740e+00 -6.021699503801274e+00 3.733345807914835e+00 4.535799938001746e+00 9.283783941442605e+03 + 80000 9.366239342432657e-01 -5.916542959325585e+00 -6.049069225485999e+00 4.104096918150409e+00 4.343110589483905e+00 9.368288602878134e+03 + 80020 1.022562156099422e+00 -6.028402590945284e+00 -5.965334982792205e+00 3.629449698397726e+00 4.991593664093521e+00 9.110930307936145e+03 + 80040 1.073006760161844e+00 -6.085723510921007e+00 -6.010984433782476e+00 3.278500855276069e+00 4.707664202040325e+00 9.250802248721324e+03 + 80060 1.000923032111309e+00 -5.964486778323271e+00 -6.000547876188676e+00 3.922840426039583e+00 4.715772021659564e+00 9.218737482223594e+03 + 80080 1.054789334973315e+00 -6.032466785682548e+00 -6.006878069879154e+00 3.505020528193227e+00 4.651954894177283e+00 9.238210025759370e+03 + 80100 1.079020134353119e+00 -6.061725250931890e+00 -6.018056015711058e+00 3.343909008216640e+00 4.594664514646965e+00 9.272592485769901e+03 + 80120 9.910760768741169e-01 -5.928646802222105e+00 -6.032968242951397e+00 4.015718079355172e+00 4.416688222996799e+00 9.318528387495733e+03 + 80140 1.012729698022931e+00 -5.960248454716059e+00 -5.994495355014786e+00 3.906741370071966e+00 4.710090368865988e+00 9.200151966363617e+03 + 80160 1.017073259977118e+00 -5.968382964472666e+00 -6.002711794354492e+00 3.900394643998811e+00 4.703273190448110e+00 9.225361722372822e+03 + 80180 1.009754466357514e+00 -5.961809005841932e+00 -6.048992414638651e+00 3.882999433049620e+00 4.382378808149952e+00 9.368063603673143e+03 + 80200 9.840641303668226e-01 -5.934551503560703e+00 -6.001546954233500e+00 4.041362868054193e+00 4.656664622778509e+00 9.221806147869038e+03 + 80220 1.020150107437041e+00 -6.005484971021632e+00 -6.012640717247824e+00 3.643883985996792e+00 4.602794583817848e+00 9.255894537591532e+03 + 80240 1.027808346007375e+00 -6.047297739592243e+00 -6.003989339968561e+00 3.452332751028595e+00 4.701016283620962e+00 9.229307477366827e+03 + 80260 9.710938719639687e-01 -6.009794834081909e+00 -6.015303424276796e+00 3.674976165677223e+00 4.643344988326604e+00 9.264102343213766e+03 + 80280 1.005308968292563e+00 -6.113177771759589e+00 -5.972408966459526e+00 3.107568226515959e+00 4.915884490451136e+00 9.132564403632909e+03 + 80300 9.389401309332899e-01 -6.060540564445474e+00 -6.048666000201535e+00 3.363890162958627e+00 4.432075748430205e+00 9.367039241100510e+03 + 80320 9.241062467503227e-01 -6.073454606534898e+00 -6.001425456154335e+00 3.356852032887244e+00 4.770454560847432e+00 9.221446396061525e+03 + 80340 8.833462273966666e-01 -6.035957833763788e+00 -6.034255921889043e+00 3.486456701765138e+00 4.496229343119937e+00 9.322504708063156e+03 + 80360 9.493122671748692e-01 -6.144817403545582e+00 -5.950978995559146e+00 2.949503367647100e+00 5.062553502701908e+00 9.067192449584752e+03 + 80380 9.163274466862645e-01 -6.096696677189597e+00 -5.974461534733840e+00 3.146109329971375e+00 4.848002433779497e+00 9.138816627758773e+03 + 80400 8.501628562375787e-01 -5.989703312936279e+00 -5.994164609337531e+00 3.722680586705049e+00 4.697063132385672e+00 9.199170347053829e+03 + 80420 9.338276758610530e-01 -6.094974390350162e+00 -6.003289512521252e+00 3.164037086336537e+00 4.690505843019126e+00 9.227159029375613e+03 + 80440 9.574498239769434e-01 -6.103702368495416e+00 -5.998833861138986e+00 3.135777019426153e+00 4.737948217015838e+00 9.213484470195814e+03 + 80460 9.855587276769316e-01 -6.116517641838018e+00 -6.003043944517124e+00 3.022594823916026e+00 4.674178353930509e+00 9.226418386047864e+03 + 80480 9.714783139240762e-01 -6.064368621315294e+00 -6.020704893342796e+00 3.325704364288514e+00 4.576428247246664e+00 9.280709651108018e+03 + 80500 9.379706375302218e-01 -5.982795020295552e+00 -5.986756310739745e+00 3.800289455735065e+00 4.777543112996799e+00 9.176440618945833e+03 + 80520 1.009036777861350e+00 -6.058046724237927e+00 -5.980974854070714e+00 3.440361455603704e+00 4.882920060937201e+00 9.158737359902861e+03 + 80540 9.870359009581027e-01 -5.999625329492440e+00 -6.044037125569371e+00 3.706739379193622e+00 4.451719973416652e+00 9.352721527911088e+03 + 80560 9.623530713359646e-01 -5.943040791810138e+00 -6.055129887893505e+00 3.987915303353470e+00 4.344282367911212e+00 9.387069918433835e+03 + 80580 1.031561597103923e+00 -6.032757617342055e+00 -5.993572189343842e+00 3.594056965044876e+00 4.819065756536000e+00 9.197317755113076e+03 + 80600 1.019562032654253e+00 -6.004401316920705e+00 -6.008283534235638e+00 3.669408290920511e+00 4.647115998326985e+00 9.242492430894137e+03 + 80620 9.367886552658038e-01 -5.872710417976832e+00 -6.067768540961339e+00 4.350329380928301e+00 4.230275453604287e+00 9.426266944879830e+03 + 80640 1.076395709720129e+00 -6.073852671880659e+00 -6.000877965558938e+00 3.327555401816166e+00 4.746587458314798e+00 9.219756153192788e+03 + 80660 1.019102983032667e+00 -5.986716026194557e+00 -6.034654751003762e+00 3.752482539298216e+00 4.477210962950069e+00 9.323726966663880e+03 + 80680 9.978764706079299e-01 -5.956785991007037e+00 -6.005859447290690e+00 3.946860320113310e+00 4.665072940039761e+00 9.235047954506415e+03 + 80700 1.013170555733291e+00 -5.980566064884793e+00 -6.013223205259580e+00 3.756964538195416e+00 4.569442184487253e+00 9.257694894995091e+03 + 80720 1.051045572187355e+00 -6.040667787672361e+00 -5.990315620016016e+00 3.526214851666324e+00 4.815344790321822e+00 9.187341179678519e+03 + 80740 1.018723735111449e+00 -5.998373942147798e+00 -6.011348875066314e+00 3.671713562513529e+00 4.597209489831029e+00 9.251907305857234e+03 + 80760 9.388896651013440e-01 -5.888021158640180e+00 -6.025353762316770e+00 4.271214323644519e+00 4.482629261181807e+00 9.295029343700997e+03 + 80780 9.913057477415382e-01 -5.975762338683044e+00 -5.999744266697094e+00 3.819462363494888e+00 4.681754421646844e+00 9.216252403003507e+03 + 80800 9.970842564945607e-01 -5.994862949978187e+00 -5.964498244650276e+00 3.760072319566222e+00 4.934431156482054e+00 9.108407533359547e+03 + 80820 1.066741115716560e+00 -6.111376102653941e+00 -6.001338880983326e+00 3.082363251204188e+00 4.714214006241885e+00 9.221167300849755e+03 + 80840 9.676113626873384e-01 -5.984858071142508e+00 -6.025691290882198e+00 3.812873613105807e+00 4.578402946440170e+00 9.296096041970153e+03 + 80860 9.787856153928439e-01 -6.031312880323497e+00 -6.014127640927860e+00 3.493805978474848e+00 4.592486282491798e+00 9.260482064191039e+03 + 80880 9.418771088223991e-01 -6.014824561717117e+00 -6.012829791467682e+00 3.678012679589869e+00 4.689466959051821e+00 9.256473845489218e+03 + 80900 9.675145015215378e-01 -6.091994146765102e+00 -5.992931133901148e+00 3.233504474453409e+00 4.802339624269928e+00 9.195372933330171e+03 + 80920 9.267750612309956e-01 -6.067490114839657e+00 -6.019000456061543e+00 3.281640202195465e+00 4.560075326649841e+00 9.275465113029946e+03 + 80940 9.481390598626093e-01 -6.126033019168437e+00 -5.988648088079658e+00 3.011374777829801e+00 4.800260312390948e+00 9.182242213242160e+03 + 80960 9.209411551406300e-01 -6.104439181185229e+00 -6.002271980117134e+00 3.133056609421621e+00 4.719716488277889e+00 9.224017543994136e+03 + 80980 8.830569647304123e-01 -6.057829103122396e+00 -5.978194044144404e+00 3.422691191393242e+00 4.879968023530418e+00 9.150233431167460e+03 + 81000 9.355533444389885e-01 -6.135942220504278e+00 -5.957328833224663e+00 3.012808307466556e+00 5.038434017558458e+00 9.086510006066192e+03 + 81020 8.830401509847313e-01 -6.046247691807124e+00 -6.005873854221210e+00 3.476738946050195e+00 4.708571769299687e+00 9.235093668422922e+03 + 81040 9.043462411016543e-01 -6.055312932565846e+00 -6.034717998617226e+00 3.403161973008423e+00 4.521421270797127e+00 9.323955447128938e+03 + 81060 9.015406876028933e-01 -6.023525922276758e+00 -6.038521946276705e+00 3.524879263439936e+00 4.438769773005024e+00 9.335685242561058e+03 + 81080 9.472460703928099e-01 -6.056179177689908e+00 -5.992290763042902e+00 3.420287497938613e+00 4.787144661541939e+00 9.193408703315539e+03 + 81100 9.615995417920067e-01 -6.038896939556994e+00 -6.020151107347472e+00 3.487485889974587e+00 4.595127359429828e+00 9.279021613406852e+03 + 81120 9.293075439340029e-01 -5.956989134386344e+00 -6.025964776540755e+00 3.918083183946968e+00 4.522014372750212e+00 9.296917925207892e+03 + 81140 9.702116481332475e-01 -5.990929138589618e+00 -6.004308464387154e+00 3.751068036875005e+00 4.674241877701573e+00 9.230269139572902e+03 + 81160 1.007811473703813e+00 -6.025182184063778e+00 -5.996242929562227e+00 3.572196869647291e+00 4.738370547330359e+00 9.205527839882789e+03 + 81180 1.016525618284013e+00 -6.024081465605152e+00 -5.987595358589862e+00 3.556329323594932e+00 4.765838196283541e+00 9.179027117547490e+03 + 81200 1.027224228153547e+00 -6.030021502765069e+00 -6.001647629067506e+00 3.572181103424383e+00 4.735108277038559e+00 9.222098694443555e+03 + 81220 9.904447680763622e-01 -5.969102687106306e+00 -5.965844383466072e+00 3.906534432956736e+00 4.925244116679815e+00 9.112456408849332e+03 + 81240 9.742049547334861e-01 -5.937461349674664e+00 -5.988827551493365e+00 4.103811691734906e+00 4.808859011997884e+00 9.182757154064100e+03 + 81260 1.071884573786312e+00 -6.075986600275069e+00 -6.007670413182030e+00 3.261579618508831e+00 4.653861736692846e+00 9.240623969403696e+03 + 81280 1.016163395514787e+00 -5.990331352893845e+00 -6.015608982490580e+00 3.759986444079833e+00 4.614838383234846e+00 9.265038412097279e+03 + 81300 1.012453047292900e+00 -5.984244092607574e+00 -5.973274928839892e+00 3.817309438026586e+00 4.880296073853218e+00 9.135159786269614e+03 + 81320 1.005687875221196e+00 -5.973031969248426e+00 -5.972904147607499e+00 3.849410935330150e+00 4.850144906972689e+00 9.134035825996556e+03 + 81340 1.035224570037387e+00 -6.017764647068367e+00 -5.936167837337880e+00 3.616412371414219e+00 5.084953879952169e+00 9.022114973947471e+03 + 81360 9.889713515010981e-01 -5.949553842469646e+00 -5.957855704024574e+00 4.004322247601471e+00 4.956651673844148e+00 9.088103233937512e+03 + 81380 9.309860811148067e-01 -5.863012355389993e+00 -6.052985259386458e+00 4.361630232409222e+00 4.270776419449641e+00 9.380323661049530e+03 + 81400 1.028914998747282e+00 -6.005683474244733e+00 -5.981550761973759e+00 3.651203239970426e+00 4.789777008355512e+00 9.160493957952887e+03 + 81420 1.048624124233346e+00 -6.034231486290285e+00 -6.010441461514860e+00 3.461536526600151e+00 4.598142530355080e+00 9.249116704159978e+03 + 81440 1.007608228698051e+00 -5.975592474812316e+00 -5.999812456342292e+00 3.800106391773873e+00 4.661031509798724e+00 9.216480597539468e+03 + 81460 9.983733675528411e-01 -5.966721998910436e+00 -6.022753099227367e+00 3.827570964981477e+00 4.505831716176908e+00 9.287035377354134e+03 + 81480 1.030630791774342e+00 -6.024347801108495e+00 -5.994720571365262e+00 3.557630548097550e+00 4.727754686082175e+00 9.200871163892465e+03 + 81500 1.001363231370770e+00 -5.996020514451788e+00 -6.009800782234871e+00 3.694053400859966e+00 4.614924970759960e+00 9.247154770608253e+03 + 81520 9.579853852605930e-01 -5.949480397373034e+00 -5.985283083692940e+00 4.029234590561018e+00 4.823650025264318e+00 9.171895959557856e+03 + 81540 9.947561644170929e-01 -6.022723766632827e+00 -5.986394348645819e+00 3.583941854424206e+00 4.792550994464873e+00 9.175326370471519e+03 + 81560 9.965107360183662e-01 -6.046267418031679e+00 -6.017566459718894e+00 3.439537451260096e+00 4.604342795351055e+00 9.271051745720584e+03 + 81580 9.831745904071457e-01 -6.051996004081508e+00 -5.983544643670847e+00 3.413247534346811e+00 4.806305838638619e+00 9.166622510698429e+03 + 81600 9.378187898646321e-01 -6.008009829871551e+00 -6.008004043138206e+00 3.618604380654046e+00 4.618637608972406e+00 9.241635297444838e+03 + 81620 9.566746583061461e-01 -6.058071026274408e+00 -5.989401261739907e+00 3.353838449095325e+00 4.748150863664147e+00 9.184536235032860e+03 + 81640 9.182911175658350e-01 -6.017413609352020e+00 -5.997249481806551e+00 3.568625621070960e+00 4.684411161825695e+00 9.208604973555040e+03 + 81660 9.482135488956011e-01 -6.072697876831310e+00 -6.001808548844648e+00 3.283748986176788e+00 4.690806477564250e+00 9.222591027499609e+03 + 81680 9.270388970890595e-01 -6.046969583323061e+00 -6.014656294789603e+00 3.366777008425369e+00 4.552324911649727e+00 9.262121170961431e+03 + 81700 9.529880999343767e-01 -6.086426882141552e+00 -6.006155763088550e+00 3.180629289780866e+00 4.641558477298728e+00 9.235980126459752e+03 + 81720 9.829182875102052e-01 -6.126620737043145e+00 -5.967748624530690e+00 3.018150919976269e+00 4.930419175402739e+00 9.118315350430348e+03 + 81740 8.873610894800430e-01 -5.972767014222449e+00 -5.948448888309578e+00 3.878858804969892e+00 5.018497247179424e+00 9.059471656376427e+03 + 81760 8.892950216302022e-01 -5.953234114348783e+00 -5.998947080579775e+00 3.944645398164917e+00 4.682154472007897e+00 9.213770698125241e+03 + 81780 9.511005142952208e-01 -6.007148231213190e+00 -6.006563499052527e+00 3.615658506797077e+00 4.619016129350610e+00 9.237209502101865e+03 + 81800 9.587155141345721e-01 -5.971155968453890e+00 -5.997747791038860e+00 3.849774196874663e+00 4.697079836520522e+00 9.210123401353727e+03 + 81820 1.007624251852019e+00 -6.000168150844220e+00 -5.933322585519431e+00 3.733257215438007e+00 5.117094795850749e+00 9.013501457340248e+03 + 81840 1.095662509292515e+00 -6.091024415814846e+00 -5.991261161366028e+00 3.231285716319813e+00 4.804141761678659e+00 9.190227771114402e+03 + 81860 1.052814539549743e+00 -5.998414813402425e+00 -6.037022804379238e+00 3.695722052437331e+00 4.474028993681173e+00 9.331053317827293e+03 + 81880 1.052743309857432e+00 -5.982577001246544e+00 -6.010557323255792e+00 3.796839215575521e+00 4.636171876657579e+00 9.249491437038587e+03 + 81900 1.044561155409496e+00 -5.964051874848947e+00 -6.006500305000297e+00 3.851432774687825e+00 4.607687319885436e+00 9.237034009173385e+03 + 81920 1.066565011486684e+00 -5.993767076054903e+00 -6.036099554018426e+00 3.729824293801166e+00 4.486744654404826e+00 9.328221083676031e+03 + 81940 9.781942326748866e-01 -5.866975592394632e+00 -6.133369774424001e+00 4.335836703311036e+00 3.806160085731958e+00 9.631017846498356e+03 + 81960 9.546576542302276e-01 -5.844305082616827e+00 -6.055401817482812e+00 4.528576058445224e+00 4.316425939730597e+00 9.387918035656179e+03 + 81980 1.079093288975099e+00 -6.043014852330816e+00 -5.971952922889414e+00 3.439308451456089e+00 4.847357047106664e+00 9.131168989423179e+03 + 82000 9.950364651531486e-01 -5.932668675069110e+00 -6.036720900010192e+00 4.088636854102226e+00 4.491152876460765e+00 9.330103035311287e+03 + 82020 1.010193193755492e+00 -5.973356942231920e+00 -5.996116143394983e+00 3.867959060282742e+00 4.737272205229438e+00 9.205115218153809e+03 + 82040 9.866440015206859e-01 -5.956985377417691e+00 -6.009654359907052e+00 3.912805338963088e+00 4.610371891010480e+00 9.246702599130509e+03 + 82060 1.016461417745936e+00 -6.020970820596495e+00 -5.968079507370866e+00 3.544017347838592e+00 4.847727453284424e+00 9.119331910815017e+03 + 82080 9.781416540235782e-01 -5.982112663385376e+00 -5.982390724539182e+00 3.869048182141401e+00 4.867451511966422e+00 9.163064699742366e+03 + 82100 9.878939093035733e-01 -6.014388191760175e+00 -6.044669063463915e+00 3.574302443036682e+00 4.400424991764059e+00 9.354703286571699e+03 + 82120 1.014146062293742e+00 -6.071829209806236e+00 -5.983782412963150e+00 3.293602895329442e+00 4.799181228000215e+00 9.167339556070028e+03 + 82140 9.613023947546808e-01 -6.010113700107163e+00 -5.993143584751316e+00 3.664382187242785e+00 4.761827215732925e+00 9.196021081876095e+03 + 82160 9.506892056175561e-01 -6.008723150834880e+00 -6.000075526752517e+00 3.624253176100621e+00 4.673909171797054e+00 9.217284560667546e+03 + 82180 9.714550203897128e-01 -6.054518496551383e+00 -5.990367224324778e+00 3.426846660956418e+00 4.795213193458872e+00 9.187493989536340e+03 + 82200 9.195638119569862e-01 -5.991931517434797e+00 -5.986800306063178e+00 3.735324726277692e+00 4.764788936025925e+00 9.176547944154587e+03 + 82220 9.808616445570533e-01 -6.095527050912048e+00 -5.963366444070888e+00 3.169483072006205e+00 4.928369728275955e+00 9.104922583975449e+03 + 82240 1.008723539044255e+00 -6.146959592810569e+00 -5.962097705580422e+00 2.851049932534960e+00 4.912555496295063e+00 9.101072227654904e+03 + 82260 8.946842146449914e-01 -5.986841294087809e+00 -5.988900583564863e+00 3.836284449626482e+00 4.824459690775225e+00 9.182992323663215e+03 + 82280 9.578342911083773e-01 -6.088064487003384e+00 -5.970147784163970e+00 3.227181411287218e+00 4.904277366541924e+00 9.125641748360757e+03 + 82300 9.694911601387092e-01 -6.107636100867752e+00 -5.973575146507881e+00 3.140689931086897e+00 4.910488676886915e+00 9.136129007293137e+03 + 82320 9.658653057589675e-01 -6.098505698190633e+00 -5.989555519356621e+00 3.202140603642655e+00 4.827749390493233e+00 9.185028458005339e+03 + 82340 9.379661457161677e-01 -6.047355213615767e+00 -6.016183252845675e+00 3.425539322666628e+00 4.604533545253837e+00 9.266802020251327e+03 + 82360 9.017394625799171e-01 -5.976424684432196e+00 -6.019947298880256e+00 3.782287142528470e+00 4.532373555264893e+00 9.278386416320462e+03 + 82380 9.730334381823149e-01 -6.056542553334780e+00 -5.995071188036888e+00 3.419568213155279e+00 4.772546305358814e+00 9.201928942361483e+03 + 82400 1.000803295488731e+00 -6.065152113757646e+00 -5.976119617770720e+00 3.398613681745325e+00 4.909852051436485e+00 9.143915153560623e+03 + 82420 9.728550401060606e-01 -5.989238385836188e+00 -6.031617298358183e+00 3.750048760156479e+00 4.506702486339665e+00 9.314368536515045e+03 + 82440 1.022564193625020e+00 -6.031763789987382e+00 -5.972284410436522e+00 3.513185556318443e+00 4.854725358103719e+00 9.132181457348595e+03 + 82460 9.761058637674128e-01 -5.931202883776870e+00 -6.039199807483305e+00 4.105989933415652e+00 4.485854885023369e+00 9.337790161793037e+03 + 82480 1.009789381686426e+00 -5.953810860302744e+00 -6.068442816127712e+00 3.904333014949665e+00 4.246098585364861e+00 9.428365404201744e+03 + 82500 1.028860711868931e+00 -5.962210599404283e+00 -5.997096425277109e+00 3.943631585253610e+00 4.743311774527743e+00 9.208129474730817e+03 + 82520 1.035062679872798e+00 -5.955329562456322e+00 -6.010748773176162e+00 3.954460980636004e+00 4.636235296587543e+00 9.250093249800075e+03 + 82540 1.054238226283539e+00 -5.973149471758526e+00 -6.042461879420514e+00 3.869580135041574e+00 4.471577564186021e+00 9.347872505137933e+03 + 82560 1.076932959179133e+00 -6.004273731519637e+00 -6.014114164871184e+00 3.649967011491726e+00 4.593461720385001e+00 9.260437948949771e+03 + 82580 1.011798123086409e+00 -5.911863027530152e+00 -5.997078553128691e+00 4.178123286961598e+00 4.688802551914814e+00 9.208047998437622e+03 + 82600 9.756076113288988e-01 -5.863513315498023e+00 -6.035408156944672e+00 4.394265203087627e+00 4.407218422860224e+00 9.326021830551015e+03 + 82620 1.048090987492292e+00 -5.979603885986118e+00 -6.001782916867038e+00 3.787018994691517e+00 4.659663567179340e+00 9.222519693155738e+03 + 82640 1.058728748828612e+00 -6.009245492367103e+00 -5.982931731302895e+00 3.698700342018598e+00 4.849798030090643e+00 9.164721432375725e+03 + 82660 1.028783642254434e+00 -5.986736475224807e+00 -5.969056462566000e+00 3.781310377964014e+00 4.882831746623999e+00 9.122288217869169e+03 + 82680 9.740672120237286e-01 -5.933137836329871e+00 -6.006871183667267e+00 4.091950707736221e+00 4.668562417126275e+00 9.238150446249676e+03 + 82700 9.837642372788657e-01 -5.979795352579099e+00 -5.995637825518246e+00 3.877088894846950e+00 4.786118963615603e+00 9.203640011978872e+03 + 82720 1.019370980901442e+00 -6.068002710135505e+00 -5.988050040575091e+00 3.343858308727194e+00 4.802958909978720e+00 9.180406179178553e+03 + 82740 9.582663682090585e-01 -6.012752916012633e+00 -6.015844089146303e+00 3.593990146607807e+00 4.576240152116775e+00 9.265747549733378e+03 + 82760 9.323966239193940e-01 -6.002991409893570e+00 -5.990647109338253e+00 3.728262691408681e+00 4.799145575471653e+00 9.188351693655675e+03 + 82780 9.955522658155039e-01 -6.121325651624503e+00 -5.957553731112955e+00 3.058050951226798e+00 4.998454662426903e+00 9.087193180582461e+03 + 82800 9.184627415617511e-01 -6.023721808391528e+00 -5.986348880995259e+00 3.540733978786725e+00 4.755335111337923e+00 9.175191162482495e+03 + 82820 9.735778803216142e-01 -6.115083982382918e+00 -5.992856563008321e+00 3.065959373345444e+00 4.767808130026401e+00 9.195135965955400e+03 + 82840 9.093557947545571e-01 -6.022330108012725e+00 -6.016110243383233e+00 3.572888913458059e+00 4.608604338681547e+00 9.266564045551109e+03 + 82860 9.277762549416532e-01 -6.046576696491860e+00 -5.989734116681646e+00 3.457447412629272e+00 4.783846302260315e+00 9.185558144933704e+03 + 82880 9.371037680591293e-01 -6.048637096445340e+00 -5.993366607048959e+00 3.458069258560763e+00 4.775440961755375e+00 9.196678154515012e+03 + 82900 1.024665905194715e+00 -6.162332866224692e+00 -5.979690097112136e+00 2.823073911619610e+00 4.871836955741085e+00 9.154828399714999e+03 + 82920 9.539038758915600e-01 -6.039942164867638e+00 -6.013273589437826e+00 3.445978589870300e+00 4.599113676936987e+00 9.257855391061325e+03 + 82940 9.724788231981104e-01 -6.049373574147997e+00 -5.986822971880763e+00 3.507855874368619e+00 4.867031112261494e+00 9.176648997133854e+03 + 82960 9.460939879618978e-01 -5.993999422683074e+00 -6.025080402886542e+00 3.703744923849428e+00 4.525273125754974e+00 9.294205080696967e+03 + 82980 9.887826415764448e-01 -6.043982829180702e+00 -5.995794208641036e+00 3.408352692195487e+00 4.685059208499176e+00 9.204129309972195e+03 + 83000 1.019617483988462e+00 -6.077848124836872e+00 -5.937536188897327e+00 3.304831859209812e+00 5.110524708576593e+00 9.026293008502615e+03 + 83020 9.960061147329781e-01 -6.033566786076968e+00 -6.005142498497038e+00 3.398768636085479e+00 4.561985294013731e+00 9.232842920166499e+03 + 83040 1.016045129092751e+00 -6.055350006717245e+00 -5.961917754303376e+00 3.419162458483446e+00 4.955664910438220e+00 9.100524852823795e+03 + 83060 1.014741293368914e+00 -6.047103051384099e+00 -5.938208355994676e+00 3.463780286346741e+00 5.089070478672456e+00 9.028342901093671e+03 + 83080 9.879491280658900e-01 -6.000787394535168e+00 -5.976730488074433e+00 3.680046697488698e+00 4.818185177180480e+00 9.145749936936871e+03 + 83100 1.000544870522238e+00 -6.011101244864054e+00 -6.013548361954304e+00 3.607549317793009e+00 4.593497592770652e+00 9.258698107162572e+03 + 83120 9.992312217060532e-01 -6.000539426992757e+00 -6.012349950640109e+00 3.687613473385762e+00 4.619795618930039e+00 9.254995429602508e+03 + 83140 9.910500090997214e-01 -5.980178434461548e+00 -5.994835136480335e+00 3.796914728822300e+00 4.712753677713120e+00 9.201194131088181e+03 + 83160 1.020567561879328e+00 -6.016373158321231e+00 -5.987234275614540e+00 3.599940733228034e+00 4.767260706957378e+00 9.177905779294051e+03 + 83180 1.008252736125395e+00 -5.989504670544965e+00 -6.017869197992520e+00 3.723158281029275e+00 4.560284775028980e+00 9.272008464445185e+03 + 83200 1.044702125853623e+00 -6.038003187475111e+00 -5.994002978724806e+00 3.504691436289792e+00 4.757347443944341e+00 9.198649545415356e+03 + 83220 1.014766158826204e+00 -5.989551977536405e+00 -6.003520644516099e+00 3.709282543473920e+00 4.629072296032287e+00 9.227876056548037e+03 + 83240 1.018346792526051e+00 -5.990782142697840e+00 -6.004885192513239e+00 3.750348225475986e+00 4.669366330996064e+00 9.232038947299005e+03 + 83260 1.015571821192288e+00 -5.981933779793769e+00 -5.996906924147795e+00 3.749803079314772e+00 4.663824967347356e+00 9.207568813295635e+03 + 83280 9.943961569784933e-01 -5.945717494592668e+00 -6.052502029840040e+00 3.954573104165176e+00 4.341399777921341e+00 9.378924718400589e+03 + 83300 1.043885155428620e+00 -6.017722407752172e+00 -6.035092894039782e+00 3.594212292435290e+00 4.494468272097770e+00 9.325095841248085e+03 + 83320 1.037014053333739e+00 -6.011075400488394e+00 -6.030515364624465e+00 3.588544718010921e+00 4.476917435616874e+00 9.310965887118535e+03 + 83340 1.029529637881501e+00 -6.009944070411532e+00 -5.997248126161251e+00 3.593564848813588e+00 4.666466925389724e+00 9.208589489633314e+03 + 83360 9.591201553998010e-01 -5.919485944033962e+00 -5.985337865888630e+00 4.087354010232805e+00 4.709222084391331e+00 9.172075084993483e+03 + 83380 9.766581225209140e-01 -5.961946950640565e+00 -5.958339663656905e+00 3.923084955603569e+00 4.943798555689600e+00 9.089565265744966e+03 + 83400 9.050127981097149e-01 -5.871690921835113e+00 -5.967297999309450e+00 4.388641168024956e+00 4.839650534019895e+00 9.116903250644124e+03 + 83420 9.848251829693634e-01 -6.005056569825634e+00 -5.977494642937002e+00 3.680223517531469e+00 4.838488366920391e+00 9.148084583993277e+03 + 83440 1.016800402521320e+00 -6.068936098848679e+00 -6.019120903282239e+00 3.262149330341355e+00 4.548195892160454e+00 9.275859764394107e+03 + 83460 1.019841436712444e+00 -6.093917670016561e+00 -6.012138071065612e+00 3.176889930081356e+00 4.646481042609736e+00 9.254367185931698e+03 + 83480 1.003217383286779e+00 -6.092085435277543e+00 -6.012574432058622e+00 3.213061279453906e+00 4.669625764224936e+00 9.255705666724227e+03 + 83500 9.712140943410815e-01 -6.068724918203396e+00 -5.978783004821642e+00 3.365808941211628e+00 4.882269326315773e+00 9.152035845497425e+03 + 83520 9.351480405057435e-01 -6.034498724117337e+00 -5.942652900435311e+00 3.565565107703276e+00 5.092958040380745e+00 9.041820389784802e+03 + 83540 9.520760133223785e-01 -6.073432005486771e+00 -5.970423468370412e+00 3.313647321633618e+00 4.905138282275351e+00 9.126453974903852e+03 + 83560 9.587634495166762e-01 -6.090437245940383e+00 -5.969542327879497e+00 3.195499162256489e+00 4.889696490190206e+00 9.123805148684696e+03 + 83580 9.453853684187936e-01 -6.072023563847937e+00 -5.973611591882420e+00 3.294349963721530e+00 4.859446735950973e+00 9.136248375061734e+03 + 83600 9.756426668302093e-01 -6.110807216968216e+00 -6.011334169689279e+00 3.092480856488386e+00 4.663670487368362e+00 9.251897575630841e+03 + 83620 9.479774549645172e-01 -6.059176054584704e+00 -6.031703544688195e+00 3.387070582732158e+00 4.544821985915076e+00 9.314648548461924e+03 + 83640 9.558524319208359e-01 -6.054644397050641e+00 -5.990848510322888e+00 3.426127526154075e+00 4.792453380126402e+00 9.188991474480565e+03 + 83660 9.996958752000751e-01 -6.090582422911696e+00 -6.020620179466914e+00 3.223403911124014e+00 4.625137939606135e+00 9.280463089091365e+03 + 83680 9.556055636515890e-01 -5.986225752764834e+00 -6.056544789639936e+00 3.720282393126126e+00 4.316499601553497e+00 9.391437248171100e+03 + 83700 1.004270147491593e+00 -6.015118799122514e+00 -6.008143564792480e+00 3.617013343908596e+00 4.657066218845680e+00 9.242076094225447e+03 + 83720 9.509790594218741e-01 -5.895179902246756e+00 -6.018604063240325e+00 4.245418430554174e+00 4.536697798301915e+00 9.274218715130617e+03 + 83740 9.990221976277095e-01 -5.930881406378872e+00 -5.981191908474198e+00 4.060807542088274e+00 4.771916853531878e+00 9.159365631033959e+03 + 83760 1.084288441071522e+00 -6.027211076451009e+00 -5.979305219404575e+00 3.523837482610969e+00 4.798920327179009e+00 9.153602479009949e+03 + 83780 1.024696249423569e+00 -5.919523380043979e+00 -6.004723155350313e+00 4.144548120656857e+00 4.655317826225271e+00 9.231519564709692e+03 + 83800 1.038327445677467e+00 -5.930470731987985e+00 -5.971570496267838e+00 4.101433989575588e+00 4.865432782912702e+00 9.129965879446505e+03 + 83820 1.058953966306702e+00 -5.956589960259331e+00 -5.948642250851357e+00 3.876615710347072e+00 4.922252687671715e+00 9.060019062186528e+03 + 83840 1.085130281325625e+00 -5.994645971336067e+00 -5.954809060682066e+00 3.710885294797575e+00 4.939635000514853e+00 9.078813900342915e+03 + 83860 9.505496123761860e-01 -5.797725186350079e+00 -6.031124250959805e+00 4.749844011375724e+00 4.409630463998160e+00 9.312811221200598e+03 + 83880 1.072353207199692e+00 -5.985641787520367e+00 -5.960386131782522e+00 3.777966719288048e+00 4.922988602834852e+00 9.095816834907035e+03 + 83900 1.081197750843141e+00 -6.008457305377542e+00 -5.990969671092563e+00 3.662127235831262e+00 4.762543938098270e+00 9.189343607931487e+03 + 83920 1.048181938080227e+00 -5.975639785599963e+00 -6.024377732711780e+00 3.847223285000534e+00 4.567362450511546e+00 9.292036989119279e+03 + 83940 9.974070766158065e-01 -5.921653994890525e+00 -6.028522190460560e+00 4.098904479766022e+00 4.485250763003060e+00 9.304811549187571e+03 + 83960 1.024565318307581e+00 -5.984335895569356e+00 -5.993707275696535e+00 3.793276926435241e+00 4.739465011528592e+00 9.197733120148190e+03 + 83980 1.017865506007781e+00 -5.996211530564809e+00 -6.003502524950385e+00 3.719023011394895e+00 4.677156993355183e+00 9.227815525551292e+03 + 84000 1.063023473089425e+00 -6.085401331103303e+00 -5.967995005351979e+00 3.295559973191711e+00 4.969725264226009e+00 9.119075273742701e+03 + 84020 9.626480567481749e-01 -5.959266524291955e+00 -6.040353312555385e+00 3.900191108186294e+00 4.434578221837750e+00 9.341321532034326e+03 + 84040 9.740875659371052e-01 -5.994988167987064e+00 -5.996930071223980e+00 3.694373973546555e+00 4.683223264651628e+00 9.207625124835218e+03 + 84060 9.859363850000875e-01 -6.028656148211839e+00 -6.001996548011524e+00 3.522713626221400e+00 4.675797176131406e+00 9.223172313891573e+03 + 84080 9.863605046776409e-01 -6.039437475193036e+00 -5.985956899618871e+00 3.464218810156083e+00 4.771312551195267e+00 9.173987158340749e+03 + 84100 1.012004730622638e+00 -6.082300939317780e+00 -5.984241515360643e+00 3.273563994066553e+00 4.836636381075250e+00 9.168744857989273e+03 + 84120 9.441818332748819e-01 -5.983927778044958e+00 -6.020740314371048e+00 3.783207696829967e+00 4.571824416523967e+00 9.280816078285647e+03 + 84140 1.003735579161963e+00 -6.072891129443262e+00 -5.953182250356521e+00 3.286290688466424e+00 4.973677597071654e+00 9.073891964410162e+03 + 84160 1.014102044223502e+00 -6.084287447544094e+00 -5.973728111176798e+00 3.289706781501494e+00 4.924555599924517e+00 9.136554417122343e+03 + 84180 1.030667087450818e+00 -6.104118217255365e+00 -5.957883531159842e+00 3.138287071451464e+00 4.977989268756496e+00 9.088242342759379e+03 + 84200 9.635870860559802e-01 -5.999864047929025e+00 -5.993663154250734e+00 3.716336874339766e+00 4.751943365425710e+00 9.197605645241667e+03 + 84220 9.756476251707782e-01 -6.012079911487096e+00 -5.998769136796401e+00 3.626825188761676e+00 4.703257716871369e+00 9.213281132239492e+03 + 84240 9.311007579445192e-01 -5.939391573686821e+00 -6.052878013655013e+00 3.945568685009747e+00 4.293911984742564e+00 9.380101204330451e+03 + 84260 9.421539869031614e-01 -5.950239057997283e+00 -5.994744204386438e+00 3.985111583828730e+00 4.729556146113056e+00 9.200910452239141e+03 + 84280 1.002659459250448e+00 -6.033340607988116e+00 -5.949710859198843e+00 3.491172989930198e+00 4.971387949140002e+00 9.063313645989736e+03 + 84300 1.028882939297666e+00 -6.061268061824960e+00 -5.973139035199505e+00 3.385702106753686e+00 4.891752615559841e+00 9.134764599736671e+03 + 84320 1.050556841409569e+00 -6.082754158083442e+00 -5.980699056337042e+00 3.267541952101660e+00 4.853558139305442e+00 9.157886728592446e+03 + 84340 9.488794747833637e-01 -5.921530994269777e+00 -6.014419044387854e+00 4.158165408761873e+00 4.624787850604577e+00 9.261351371018713e+03 + 84360 1.038200494760108e+00 -6.044506540190827e+00 -5.982980751004765e+00 3.451289980154667e+00 4.804580582746139e+00 9.164884011670158e+03 + 84380 1.015874987914531e+00 -6.000999761359258e+00 -5.976493103950714e+00 3.694994977470465e+00 4.835715996703296e+00 9.145028074575834e+03 + 84400 1.021455527831266e+00 -5.999277917145500e+00 -6.009530888450911e+00 3.653680194684402e+00 4.594806046806551e+00 9.246336841982358e+03 + 84420 1.011249625420927e+00 -5.974766528531382e+00 -6.009996701026735e+00 3.788172313853365e+00 4.585875211533477e+00 9.247748722970166e+03 + 84440 9.885488638284456e-01 -5.931224966320283e+00 -5.992945245050993e+00 4.102130768448835e+00 4.747723376794828e+00 9.195369814926698e+03 + 84460 1.013868591842864e+00 -5.955685417076170e+00 -6.043720124581638e+00 3.929108447523185e+00 4.423599533699830e+00 9.351738839543588e+03 + 84480 1.023178145254378e+00 -5.958569108421551e+00 -6.003145292313922e+00 3.935349021691608e+00 4.679385675639447e+00 9.226712453284414e+03 + 84500 1.033680571412560e+00 -5.963276928221003e+00 -6.006046923398692e+00 3.897035522606297e+00 4.651443591660639e+00 9.235612491930568e+03 + 84520 1.107613302758993e+00 -6.060227902750468e+00 -5.963274513928152e+00 3.396207309414449e+00 4.952928671520624e+00 9.104644329489218e+03 + 84540 1.115552755307359e+00 -6.059512397370105e+00 -5.978545363924956e+00 3.386308152801442e+00 4.851233388451421e+00 9.151283707217137e+03 + 84560 1.053060369095397e+00 -5.956808412135927e+00 -5.946038283757595e+00 3.945569091247287e+00 5.007412835067652e+00 9.052120651322619e+03 + 84580 9.833364925292210e-01 -5.843588597209396e+00 -5.979623428320504e+00 4.480689307555427e+00 4.699556255993371e+00 9.154530564177525e+03 + 84600 1.046990905042889e+00 -5.927968927179419e+00 -5.955934127636914e+00 4.040980744992873e+00 4.880400236365154e+00 9.082190122393538e+03 + 84620 1.094798652826411e+00 -5.989544201868482e+00 -5.933490700978428e+00 3.792751150030084e+00 5.114619026392004e+00 9.013969341971235e+03 + 84640 1.080848303878804e+00 -5.963795496740542e+00 -6.021003549144867e+00 3.793982961739441e+00 4.465485471916311e+00 9.281608944297730e+03 + 84660 1.047801247677787e+00 -5.917733155158873e+00 -5.996001484514320e+00 4.116194183006462e+00 4.666765323862669e+00 9.204754545772752e+03 + 84680 1.036958011131287e+00 -5.910869812602576e+00 -5.999753469962777e+00 4.155734861590705e+00 4.645351146326908e+00 9.216277133189240e+03 + 84700 1.063312566410562e+00 -5.967176374055030e+00 -6.007163273227895e+00 3.886335985647815e+00 4.656725022644576e+00 9.239031157810254e+03 + 84720 1.078939717618497e+00 -6.015721765907712e+00 -5.977914124883577e+00 3.652475726773897e+00 4.869573052248025e+00 9.149365832682635e+03 + 84740 1.011509517041024e+00 -5.946472969283246e+00 -6.005300594431811e+00 3.989647330601052e+00 4.651850003452417e+00 9.233347507168537e+03 + 84760 1.011400443152279e+00 -5.982921794410605e+00 -6.040714025272359e+00 3.763503146352312e+00 4.431651213425301e+00 9.342470234948243e+03 + 84780 1.003232673078363e+00 -6.007642137740804e+00 -6.031016747453735e+00 3.649779345233395e+00 4.515558719052587e+00 9.312492751827898e+03 + 84800 1.006380634367237e+00 -6.047255009435099e+00 -5.997239780097142e+00 3.432214638175145e+00 4.719409824865417e+00 9.208575871173738e+03 + 84820 9.821203757111072e-01 -6.040239702459711e+00 -5.933706141608698e+00 3.429973256398806e+00 5.041705448820581e+00 9.014652711029765e+03 + 84840 9.076120870306131e-01 -5.947169588226523e+00 -5.983372642556154e+00 3.980835552847954e+00 4.772952012482663e+00 9.166030929046821e+03 + 84860 9.784903389837658e-01 -6.062465844607673e+00 -5.983517674246301e+00 3.355674514538745e+00 4.809007125943626e+00 9.166510163039353e+03 + 84880 8.970553255090351e-01 -5.945773316902605e+00 -6.011071970248167e+00 3.978655721942389e+00 4.603700749498228e+00 9.251070889548220e+03 + 84900 9.327425249704981e-01 -5.998716635399487e+00 -6.001688346147189e+00 3.681252141219871e+00 4.664188118235813e+00 9.222227245503094e+03 + 84920 9.968843820319946e-01 -6.089448113487530e+00 -5.991879211991392e+00 3.183812443781767e+00 4.744068174911293e+00 9.192145826358030e+03 + 84940 9.925325040995808e-01 -6.076997804422980e+00 -5.950960262695428e+00 3.279385423811021e+00 5.003112492657172e+00 9.067109208753658e+03 + 84960 9.247646788477312e-01 -5.964268496852905e+00 -5.980385589722500e+00 3.889856409506395e+00 4.797309568137118e+00 9.156924339451922e+03 + 84980 1.040332951259129e+00 -6.114904153252266e+00 -5.999899764676422e+00 3.100406665970607e+00 4.760779662044722e+00 9.216754805603863e+03 + 85000 9.828995903922781e-01 -6.006652692534014e+00 -6.060176068087305e+00 3.586020387852435e+00 4.278680882709841e+00 9.402711802372669e+03 + 85020 9.825352926294716e-01 -5.981944301955520e+00 -6.019857316036861e+00 3.830406521192918e+00 4.612704127317892e+00 9.278093086625277e+03 + 85040 9.614071608802945e-01 -5.923977434466204e+00 -6.041745807208662e+00 4.046377829079951e+00 4.370133608195974e+00 9.345633764835229e+03 + 85060 1.037002772868444e+00 -6.006578002910302e+00 -5.980730300628804e+00 3.668040689543218e+00 4.816462195962581e+00 9.157979377937500e+03 + 85080 1.064511873617721e+00 -6.015821357766881e+00 -5.966826075840783e+00 3.664517333616874e+00 4.945855824431904e+00 9.115487212727474e+03 + 85100 1.034572992152146e+00 -5.936612261577809e+00 -6.044261201054148e+00 4.016732229111636e+00 4.398595360018950e+00 9.353416605843284e+03 + 85120 1.109621039117556e+00 -6.015152543787456e+00 -6.049337120672351e+00 3.601508771632120e+00 4.405215641112881e+00 9.369152675671798e+03 + 85140 1.044439554948636e+00 -5.894913518180918e+00 -6.022026340336833e+00 4.260747622555732e+00 4.530846127090813e+00 9.284795178680470e+03 + 85160 1.054154000198377e+00 -5.894232927324143e+00 -5.985227189672960e+00 4.268574026671506e+00 4.746070890948004e+00 9.171744921772555e+03 + 85180 1.082415621933125e+00 -5.922360400656340e+00 -6.049933229960412e+00 4.063325439096360e+00 4.330782511400850e+00 9.370991125204522e+03 + 85200 1.062324129292481e+00 -5.889618039057884e+00 -6.094331761158963e+00 4.202756608709528e+00 4.027258737059020e+00 9.508912775431865e+03 + 85220 1.054530618829150e+00 -5.889400060294108e+00 -6.026267504765381e+00 4.291112817969164e+00 4.505198771646532e+00 9.297855174025597e+03 + 85240 1.091453609218204e+00 -5.973861807053139e+00 -5.988717662033776e+00 3.826974347739303e+00 4.741669729504362e+00 9.182444066597107e+03 + 85260 1.030568064822196e+00 -5.940882714685558e+00 -6.042657048255553e+00 3.967956350484019e+00 4.383552377597891e+00 9.348462839314976e+03 + 85280 1.050457991648738e+00 -6.045507416897305e+00 -6.002992154019678e+00 3.500030942467963e+00 4.744160161126965e+00 9.226233380537873e+03 + 85300 9.853197970386394e-01 -6.014915818602343e+00 -6.006875808687411e+00 3.573982386677999e+00 4.620149367797048e+00 9.238170596655258e+03 + 85320 9.347668572239625e-01 -5.979049617427647e+00 -5.994026806740697e+00 3.800757267403786e+00 4.714755928655691e+00 9.198715517263152e+03 + 85340 9.221780353967184e-01 -5.982824224429404e+00 -5.982227095735458e+00 3.820219882876930e+00 4.823648688242936e+00 9.162582927053634e+03 + 85360 9.764486559168234e-01 -6.076717936255564e+00 -5.976330806329412e+00 3.339140783788716e+00 4.915579218682831e+00 9.144552571687462e+03 + 85380 9.401920848170242e-01 -6.032168723991283e+00 -6.027273372986587e+00 3.517207217180409e+00 4.545317080202496e+00 9.300974850680916e+03 + 85400 9.612960574008276e-01 -6.067946528902161e+00 -5.997291199165343e+00 3.342145774911700e+00 4.747859612137448e+00 9.208762989549179e+03 + 85420 9.377866397214502e-01 -6.031852136567582e+00 -6.030997901092457e+00 3.570814742153285e+00 4.575719894443965e+00 9.312452679188582e+03 + 85440 9.799813923517667e-01 -6.089505335114237e+00 -6.011498771067555e+00 3.228574213486147e+00 4.676499975718967e+00 9.252372608952413e+03 + 85460 9.622601828817088e-01 -6.054199967062465e+00 -5.999086638120253e+00 3.432888329967233e+00 4.749357593513507e+00 9.214253698999037e+03 + 85480 9.600289242558570e-01 -6.036745659129167e+00 -5.999232664870951e+00 3.503645190843773e+00 4.719050608991548e+00 9.214681745766729e+03 + 85500 9.844343791866615e-01 -6.053429121091479e+00 -5.989910577674925e+00 3.461235270945828e+00 4.825968576706503e+00 9.186108538637585e+03 + 85520 9.257659381545152e-01 -5.941086115737090e+00 -6.011351189942568e+00 4.009304932778993e+00 4.605832003206044e+00 9.251914021077599e+03 + 85540 1.009506250378244e+00 -6.037926234448069e+00 -5.963980054476973e+00 3.519125789402117e+00 4.943736197930514e+00 9.106807738479763e+03 + 85560 9.859800201403579e-01 -5.972116901362870e+00 -5.981448730430325e+00 3.874708529775036e+00 4.821123723173827e+00 9.160190884891501e+03 + 85580 1.052143637412863e+00 -6.039895898123552e+00 -5.994148644886725e+00 3.497048182492496e+00 4.759735989942915e+00 9.199087099901362e+03 + 85600 1.058768015398657e+00 -6.024244761555505e+00 -6.019642780508754e+00 3.502547912748343e+00 4.528973200073058e+00 9.277440436016745e+03 + 85620 1.009920271100476e+00 -5.931097261715783e+00 -5.994238868221135e+00 4.076340710664077e+00 4.713771834978318e+00 9.199356855586142e+03 + 85640 1.041399862817973e+00 -5.959636945117298e+00 -5.995379939850435e+00 3.871154947261358e+00 4.665913140293130e+00 9.202888310664857e+03 + 85660 1.017829787777435e+00 -5.911510876937125e+00 -6.009357780039622e+00 4.164938250268161e+00 4.603086190894301e+00 9.245784414975436e+03 + 85680 1.094147395880270e+00 -6.019483625254833e+00 -6.009677509785117e+00 3.547576231689391e+00 4.603884464207963e+00 9.246760709267426e+03 + 85700 9.709542438746669e-01 -5.836899025098720e+00 -6.027183605239897e+00 4.562068923454702e+00 4.469425417840454e+00 9.300652415819204e+03 + 85720 1.002961370673075e+00 -5.888890485806784e+00 -5.972440469876924e+00 4.364824887072399e+00 4.885067949223406e+00 9.132606226731294e+03 + 85740 1.044607807165134e+00 -5.956533849061823e+00 -5.949731854778598e+00 3.922973690313882e+00 4.962031794093375e+00 9.063379992253811e+03 + 85760 1.067385769092559e+00 -5.997717218182710e+00 -6.025393095298249e+00 3.674270328182148e+00 4.515351158956582e+00 9.295154675213043e+03 + 85780 1.027066451763875e+00 -5.956551080368008e+00 -6.044368445857954e+00 3.909713481401495e+00 4.405452579064834e+00 9.353756871823278e+03 + 85800 9.967904996587238e-01 -5.943730600551415e+00 -6.032147811274672e+00 3.922231136510339e+00 4.414525830018258e+00 9.316002506691826e+03 + 85820 9.506852219983875e-01 -5.917362100605700e+00 -6.035634187671103e+00 4.140701947867655e+00 4.461565321391787e+00 9.326757759666032e+03 + 85840 9.822477038803291e-01 -6.012738532940872e+00 -5.958785845472708e+00 3.711287230078281e+00 5.021091910671880e+00 9.090951803466263e+03 + 85860 9.792343353101105e-01 -6.053074860897378e+00 -5.967397484349865e+00 3.408768711489549e+00 4.900741466156537e+00 9.117225683190703e+03 + 85880 9.507024694708170e-01 -6.044372398184112e+00 -5.991505215916998e+00 3.455049839506120e+00 4.758621381253905e+00 9.190985941813682e+03 + 85900 9.095976824642882e-01 -6.007440790071660e+00 -6.024269566182666e+00 3.635221256742097e+00 4.538587820068017e+00 9.291714986115618e+03 + 85920 9.403146901392347e-01 -6.066331653738342e+00 -5.982950075719838e+00 3.331471633353629e+00 4.810261557593380e+00 9.164797554351633e+03 + 85940 9.286568894617255e-01 -6.051532697457348e+00 -5.991186291288416e+00 3.419942222206747e+00 4.766460625004931e+00 9.190027284232045e+03 + 85960 9.258456306193770e-01 -6.044875835797646e+00 -6.003934163406067e+00 3.462163400219690e+00 4.697256818795472e+00 9.229149786838512e+03 + 85980 9.233124071239158e-01 -6.034354795058297e+00 -5.993234079993287e+00 3.470445547107038e+00 4.706567056420417e+00 9.196311526134632e+03 + 86000 9.901823890011726e-01 -6.122134951389052e+00 -5.976031571837702e+00 3.047889016994294e+00 4.886837231803066e+00 9.143626868601103e+03 + 86020 9.324193332483318e-01 -6.020814132479530e+00 -6.026343156954042e+00 3.557794720265452e+00 4.526046206119034e+00 9.298113832517398e+03 + 86040 9.811158844857231e-01 -6.075011661955508e+00 -5.990942201501694e+00 3.339388596664093e+00 4.822128448296856e+00 9.189267030954768e+03 + 86060 1.009158927515387e+00 -6.097284072883913e+00 -6.021864191258642e+00 3.169911277606867e+00 4.602983909088141e+00 9.284301325366194e+03 + 86080 9.447266107967174e-01 -5.984345511589408e+00 -6.037150306126332e+00 3.783429547075847e+00 4.480216245329284e+00 9.331463326678228e+03 + 86100 1.001140021333597e+00 -6.052574072969052e+00 -5.976969752714588e+00 3.449967293427956e+00 4.884099000059833e+00 9.146495045813270e+03 + 86120 1.026793659482529e+00 -6.074568575323879e+00 -6.016104030820616e+00 3.272976213695189e+00 4.608688675591947e+00 9.266537635400178e+03 + 86140 1.007712141419936e+00 -6.029472745528380e+00 -6.012213620481358e+00 3.527201169182663e+00 4.626305736043629e+00 9.254587376063651e+03 + 86160 9.970866488795793e-01 -6.000262530249512e+00 -5.985544497986535e+00 3.714730833387569e+00 4.799244052249719e+00 9.172717098246720e+03 + 86180 9.627700827113690e-01 -5.936386784476974e+00 -6.007382149949372e+00 4.018973895589079e+00 4.611307520549269e+00 9.239703685461185e+03 + 86200 9.851736955909310e-01 -5.958245830799830e+00 -5.964980344830656e+00 3.893210393567562e+00 4.854539771839876e+00 9.109865244998557e+03 + 86220 9.838220290279112e-01 -5.944170664992822e+00 -6.015716707328028e+00 3.948634494488279e+00 4.537806047685260e+00 9.265345298441100e+03 + 86240 9.300764776991710e-01 -5.851954469688395e+00 -6.053044317482088e+00 4.466560114740895e+00 4.311871090156131e+00 9.380581578071953e+03 + 86260 1.048231720162885e+00 -6.017516715127877e+00 -6.000770443682439e+00 3.605701636072709e+00 4.701861318189545e+00 9.219386647092133e+03 + 86280 1.025878046960969e+00 -5.978143006356822e+00 -5.992094524925574e+00 3.816578223259520e+00 4.736466444647225e+00 9.192768551323279e+03 + 86300 1.035129427962068e+00 -5.988285753344441e+00 -5.984142314255219e+00 3.786980079155581e+00 4.810772347601024e+00 9.168418848412133e+03 + 86320 1.010418922445231e+00 -5.950414692766503e+00 -6.019689546406857e+00 3.953441180988162e+00 4.555654251136296e+00 9.277570185623292e+03 + 86340 9.794766581585499e-01 -5.905870141531375e+00 -6.021134133528297e+00 4.161771850171155e+00 4.499908171079718e+00 9.282015507754164e+03 + 86360 9.810062605206112e-01 -5.909291926039430e+00 -6.023998440422223e+00 4.161882189894559e+00 4.503219633532829e+00 9.290873613289519e+03 + 86380 1.098105620575937e+00 -6.087882471804434e+00 -6.004815896089561e+00 3.198247032461117e+00 4.675228164726967e+00 9.231853120089714e+03 + 86400 1.048336914352166e+00 -6.029648733284600e+00 -5.953110982188559e+00 3.610260420485484e+00 5.049752031457656e+00 9.073660314263341e+03 + 86420 1.012538946768838e+00 -6.005726585200223e+00 -5.987220150044053e+00 3.690143526610705e+00 4.796410341139020e+00 9.177840139522690e+03 + 86440 1.002621240991645e+00 -6.038224016795718e+00 -5.984332400837464e+00 3.523231084789116e+00 4.832685083322028e+00 9.169013131679436e+03 + 86460 1.000529008602647e+00 -6.093210732685285e+00 -5.981258498451524e+00 3.241281504031420e+00 4.884128557553931e+00 9.159625012400855e+03 + 86480 9.723607039197102e-01 -6.102630023928666e+00 -5.981595957062354e+00 3.128014093070997e+00 4.823010434978672e+00 9.160661845306495e+03 + 86500 9.503430146730145e-01 -6.108577705901904e+00 -5.991581359532315e+00 3.079823719503519e+00 4.751634845483791e+00 9.191249698307061e+03 + 86520 9.441325124027693e-01 -6.125279977027744e+00 -5.973901548502222e+00 3.008451574496290e+00 4.877689936825943e+00 9.137125274417156e+03 + 86540 9.475814530674008e-01 -6.144338066568928e+00 -5.962506936914583e+00 2.903099851485722e+00 4.947202336237345e+00 9.102317201707972e+03 + 86560 8.609993414277525e-01 -6.017393622644499e+00 -5.986321509585845e+00 3.643760247061969e+00 4.822181128638716e+00 9.175083840360357e+03 + 86580 9.341647751689643e-01 -6.117176932288999e+00 -5.971336486534417e+00 3.110781208791667e+00 4.948219617050514e+00 9.129278463691720e+03 + 86600 9.723429390489077e-01 -6.155459086719645e+00 -6.000039669205791e+00 2.856651623784922e+00 4.749093970226604e+00 9.217188414150622e+03 + 86620 9.511157908261799e-01 -6.099726757317611e+00 -5.988051415451066e+00 3.170138635299740e+00 4.811395730000742e+00 9.180425878340931e+03 + 86640 9.563994875475419e-01 -6.080442959965525e+00 -5.980579724334798e+00 3.335560465298761e+00 4.908990618076169e+00 9.157521832691118e+03 + 86660 9.522584205080881e-01 -6.040131731837635e+00 -6.024724880212442e+00 3.481926551774818e+00 4.570395078009260e+00 9.293095459050255e+03 + 86680 9.777711737250201e-01 -6.045006457417828e+00 -5.944640682983342e+00 3.483293884277828e+00 5.059609692634041e+00 9.047886045117921e+03 + 86700 9.507642716965754e-01 -5.972621374764476e+00 -5.969374826022224e+00 3.782822337996854e+00 4.801464523276655e+00 9.123268553680429e+03 + 86720 9.378947495534252e-01 -5.923209118693119e+00 -5.969720308003746e+00 4.093048217980206e+00 4.825973771375308e+00 9.124303108253707e+03 + 86740 9.300525171645357e-01 -5.884558462569068e+00 -5.996670914335820e+00 4.294257700101445e+00 4.650490652710912e+00 9.206809031030540e+03 + 86760 9.948575900907847e-01 -5.957337027373883e+00 -6.024449657060884e+00 3.905224831872771e+00 4.519853726564135e+00 9.292215647006642e+03 + 86780 1.017906282021607e+00 -5.973441698192220e+00 -5.985815188937838e+00 3.801822708018534e+00 4.730772209365686e+00 9.173570849787326e+03 + 86800 1.020585852263640e+00 -5.964153940052054e+00 -5.998443576406018e+00 3.922754277664653e+00 4.725857879416118e+00 9.212276872849114e+03 + 86820 1.051463283449119e+00 -6.002302504671576e+00 -5.964164334119651e+00 3.713836833297539e+00 4.932832110469510e+00 9.107366381470671e+03 + 86840 9.835398451248292e-01 -5.897408799694920e+00 -6.009397412806873e+00 4.242524231830249e+00 4.599468285159546e+00 9.245925698073286e+03 + 86860 1.009201434053627e+00 -5.933143278023069e+00 -6.027530944891758e+00 4.009492030919544e+00 4.467503441315290e+00 9.301765187583274e+03 + 86880 9.930727082850628e-01 -5.911495649528096e+00 -6.040557853625314e+00 4.171624891049028e+00 4.430529742811265e+00 9.341960086467818e+03 + 86900 9.782995908540587e-01 -5.895438113976540e+00 -6.039429351501269e+00 4.287858262558817e+00 4.461038294119832e+00 9.338442240696626e+03 + 86920 1.051454359101160e+00 -6.011244807038396e+00 -5.978079271750777e+00 3.604712341393579e+00 4.795153977365088e+00 9.149887473535518e+03 + 86940 1.035537816964454e+00 -5.997686581281909e+00 -5.982131052929835e+00 3.725045186179885e+00 4.814367437187722e+00 9.162273779951787e+03 + 86960 9.934353907898176e-01 -5.950419205137097e+00 -5.989086585111171e+00 3.974466513127480e+00 4.752432433558630e+00 9.183586032699397e+03 + 86980 1.010843066517213e+00 -5.994079481948472e+00 -5.989448526979586e+00 3.716020308210997e+00 4.742611968280305e+00 9.184701879340662e+03 + 87000 1.028179011090804e+00 -6.044421267517758e+00 -6.002385802602853e+00 3.473452633436020e+00 4.714826777944578e+00 9.224387437240021e+03 + 87020 9.772546124236521e-01 -5.999858301159904e+00 -6.055815168180567e+00 3.655973335012374e+00 4.334660345282541e+00 9.389183810980048e+03 + 87040 9.810912147955352e-01 -6.044940375612524e+00 -6.029157319645355e+00 3.443214727675336e+00 4.533843477458836e+00 9.306796734856734e+03 + 87060 9.336640837498928e-01 -6.015276728937685e+00 -6.046081139140911e+00 3.613855481714273e+00 4.436971791360277e+00 9.359065783129228e+03 + 87080 9.610635011873477e-01 -6.096249005205204e+00 -5.984590775297091e+00 3.148106231488717e+00 4.789265066676332e+00 9.169830326625959e+03 + 87100 9.190918508981027e-01 -6.065445250568673e+00 -5.979417307473307e+00 3.360901242330631e+00 4.854887004365390e+00 9.153969321197232e+03 + 87120 9.590932301035952e-01 -6.143192546092624e+00 -5.981155394668838e+00 2.897835325944201e+00 4.828277724587727e+00 9.159280196509071e+03 + 87140 9.129054277642863e-01 -6.083115279295972e+00 -6.000668811305125e+00 3.218882557446016e+00 4.692302935199143e+00 9.219127426786567e+03 + 87160 9.517076453840643e-01 -6.140760202437679e+00 -5.972469485140557e+00 2.975491332208631e+00 4.941842673833040e+00 9.132742771803876e+03 + 87180 9.083911346789949e-01 -6.069865298816334e+00 -5.996414868670912e+00 3.333957879320586e+00 4.755721615632932e+00 9.206050527195493e+03 + 87200 8.694811121963143e-01 -5.998976877815699e+00 -6.007044219850076e+00 3.675673937988148e+00 4.629350011609607e+00 9.238696623454296e+03 + 87220 9.657907789254421e-01 -6.123697331982244e+00 -5.966564554842357e+00 3.041286939519468e+00 4.943567662075376e+00 9.114684911534630e+03 + 87240 8.659808640343858e-01 -5.955356372344164e+00 -5.974151024037845e+00 3.959485213528181e+00 4.851563415040117e+00 9.137849180848829e+03 + 87260 9.460300507880154e-01 -6.050513645709183e+00 -6.009162930655269e+00 3.447603632698397e+00 4.685045837540443e+00 9.245195680682584e+03 + 87280 9.743365869069814e-01 -6.072164706622786e+00 -5.949231685209868e+00 3.327454701595865e+00 5.033355134372423e+00 9.061856778454079e+03 + 87300 9.421470225058499e-01 -6.007720219230656e+00 -5.961063570639872e+00 3.632177800129543e+00 4.900087496430860e+00 9.097910676633544e+03 + 87320 9.266191138506514e-01 -5.967053306226990e+00 -5.994851069427507e+00 3.880090331351311e+00 4.720471273363994e+00 9.201248249212116e+03 + 87340 9.819886307166142e-01 -6.032745924777306e+00 -6.014429864507569e+00 3.497045871032811e+00 4.602219523502804e+00 9.261374577228895e+03 + 87360 9.355005914293185e-01 -5.947998242835679e+00 -6.014916387193238e+00 3.977699421223885e+00 4.593445080773411e+00 9.262887026383245e+03 + 87380 1.003769362865478e+00 -6.034100921243784e+00 -6.006401730510238e+00 3.481822082536973e+00 4.640875122164910e+00 9.236718786241656e+03 + 87400 1.047856298596177e+00 -6.085101875734653e+00 -5.989471843975928e+00 3.278743308635994e+00 4.827865749694176e+00 9.184779455274718e+03 + 87420 1.015590305461614e+00 -6.025281894808702e+00 -5.969724533323554e+00 3.589120918655451e+00 4.908139885777082e+00 9.124355298365852e+03 + 87440 9.645413660219903e-01 -5.938319286779325e+00 -5.999114385190316e+00 4.054108408066362e+00 4.705013544979380e+00 9.214304790045649e+03 + 87460 1.007431973336879e+00 -5.988595512711586e+00 -5.994441524241253e+00 3.732862539624038e+00 4.699293836753328e+00 9.200014637446189e+03 + 87480 1.060333034128461e+00 -6.053322148294674e+00 -5.993223076495699e+00 3.450486554814337e+00 4.795584725385357e+00 9.196254799086022e+03 + 87500 1.057545037113472e+00 -6.037262292184003e+00 -5.993159564067867e+00 3.539066007991693e+00 4.792310697709670e+00 9.196065558901540e+03 + 87520 1.047278599180063e+00 -6.013321106364791e+00 -5.990323104024559e+00 3.679711026791906e+00 4.811769115158881e+00 9.187381753743681e+03 + 87540 1.088303633761622e+00 -6.067226969868288e+00 -5.992433332978033e+00 3.356099121527001e+00 4.785575758828745e+00 9.193843191334947e+03 + 87560 1.035595061541619e+00 -5.986970224129592e+00 -5.992898921229306e+00 3.792146877850747e+00 4.758103381641280e+00 9.195265562469473e+03 + 87580 9.797519045405076e-01 -5.904666345334410e+00 -6.062482200923472e+00 4.180285809051187e+00 4.274082744334067e+00 9.409836773212881e+03 + 87600 9.774144848170856e-01 -5.903643347603737e+00 -6.030933539186170e+00 4.243811504441731e+00 4.512891526281915e+00 9.312258660018852e+03 + 87620 9.867231566808101e-01 -5.924698131069157e+00 -5.996529359464201e+00 4.145359535332410e+00 4.732893506041398e+00 9.206363597705726e+03 + 87640 1.019477183472570e+00 -5.983553732907146e+00 -6.008282288193833e+00 3.723092486204243e+00 4.581097295016523e+00 9.242488428942981e+03 + 87660 1.019826568155523e+00 -6.001413590389120e+00 -5.970743280038472e+00 3.726996164876529e+00 4.903109833125140e+00 9.127448375816581e+03 + 87680 9.877081879888713e-01 -5.978156311523732e+00 -5.984813288465212e+00 3.765257863533420e+00 4.727032471771590e+00 9.170486849050903e+03 + 87700 1.011649638114211e+00 -6.043869195862638e+00 -5.986859012474381e+00 3.456275970100892e+00 4.783637265413628e+00 9.176724369387690e+03 + 87720 9.716818513192693e-01 -6.019122274954227e+00 -6.000538220162465e+00 3.588956429022489e+00 4.695668947509970e+00 9.218688664364376e+03 + 87740 9.479561206102147e-01 -6.015055336807865e+00 -6.004252959401319e+00 3.626665005214346e+00 4.688693927945237e+00 9.230065131778609e+03 + 87760 8.976716892220502e-01 -5.968456780034160e+00 -6.007302375530991e+00 3.859760309005633e+00 4.636702888326353e+00 9.239480844404150e+03 + 87780 9.379119102661597e-01 -6.049674040422585e+00 -5.971826808497644e+00 3.439340444845787e+00 4.886351297379007e+00 9.130761711466712e+03 + 87800 8.998355324421516e-01 -6.006759100234714e+00 -5.991389624415831e+00 3.662519921909108e+00 4.750773830479835e+00 9.190638278196766e+03 + 87820 9.375292563606198e-01 -6.068956657467351e+00 -5.989896409512418e+00 3.283205541336976e+00 4.737181719628035e+00 9.186058100125234e+03 + 87840 9.164034092509135e-01 -6.036344705777927e+00 -6.032670241999687e+00 3.478898811113268e+00 4.499998150749356e+00 9.317604079653694e+03 + 87860 9.821728884476075e-01 -6.126836046230142e+00 -5.991955461795866e+00 3.037047839383811e+00 4.811553027908404e+00 9.192393674894165e+03 + 87880 9.845279846120530e-01 -6.117218810761668e+00 -5.984651578876313e+00 3.072673683279847e+00 4.833895243478388e+00 9.170009891233740e+03 + 87900 9.680502137562979e-01 -6.072649224996309e+00 -5.991722830860368e+00 3.307570835592183e+00 4.772262714039775e+00 9.191673561325759e+03 + 87920 8.901706883363506e-01 -5.929195483000423e+00 -6.025137652823442e+00 4.039619717269023e+00 4.488704931142447e+00 9.294394070338809e+03 + 87940 1.053627785711828e+00 -6.132224004877521e+00 -6.000858460839430e+00 2.975720905826274e+00 4.730042188445234e+00 9.219714956200476e+03 + 87960 1.063882602942604e+00 -6.104615371265594e+00 -5.995823434548062e+00 3.176910154155445e+00 4.801610290285311e+00 9.204231529961498e+03 + 87980 1.009996573159096e+00 -5.987294857969151e+00 -5.986832462907298e+00 3.804089942703784e+00 4.806745086704349e+00 9.176676959946179e+03 + 88000 1.031208830412600e+00 -5.987289221284250e+00 -6.025258154438593e+00 3.769899513910123e+00 4.551876024064477e+00 9.294764286497431e+03 + 88020 1.020766585640555e+00 -5.949837510193895e+00 -6.059001491794567e+00 3.923552728423933e+00 4.296716253001315e+00 9.399071406785341e+03 + 88040 1.058608729907162e+00 -5.994697730438595e+00 -5.999891741604735e+00 3.733519544084634e+00 4.703694728198033e+00 9.216713203154586e+03 + 88060 1.028486550791528e+00 -5.946233621117347e+00 -5.983732471903285e+00 4.049785802329854e+00 4.834461598188595e+00 9.167139584368921e+03 + 88080 9.941298439024534e-01 -5.893437209518575e+00 -6.028692378972854e+00 4.287243010841905e+00 4.510586897165601e+00 9.305320701406890e+03 + 88100 9.945391307556721e-01 -5.894737386681252e+00 -6.055677896557765e+00 4.255960815445293e+00 4.331815502270943e+00 9.388752843167909e+03 + 88120 1.015625554483936e+00 -5.932713848922593e+00 -6.028569735392219e+00 4.064953247198217e+00 4.514533913439135e+00 9.304953434640212e+03 + 88140 1.004169022836957e+00 -5.924222252371581e+00 -6.012905876679588e+00 4.029332508246375e+00 4.520097413723289e+00 9.256703268950205e+03 + 88160 9.611141392888729e-01 -5.870318562890746e+00 -6.009761029060462e+00 4.394889235246561e+00 4.594189015848154e+00 9.247018801057542e+03 + 88180 1.044675319360136e+00 -6.005210755720507e+00 -5.973507809139254e+00 3.700457341619718e+00 4.882500566904398e+00 9.135908073806027e+03 + 88200 1.048064623908918e+00 -6.022690536288949e+00 -6.007399809147927e+00 3.571932936607478e+00 4.659734658083606e+00 9.239785632571467e+03 + 88220 1.024749269164748e+00 -6.003276617824223e+00 -6.013673590349065e+00 3.636755339696260e+00 4.577054314532316e+00 9.259071198455418e+03 + 88240 1.025859135692201e+00 -6.021346488322578e+00 -5.977225288064906e+00 3.578164721098011e+00 4.831515480711236e+00 9.147274771093316e+03 + 88260 9.620873763051131e-01 -5.943272608912184e+00 -6.021754837854949e+00 3.988317306558572e+00 4.537660202883541e+00 9.283947634053524e+03 + 88280 1.041394302005658e+00 -6.076129339306515e+00 -5.975800522085114e+00 3.309618932283958e+00 4.885722526603532e+00 9.142914976780701e+03 + 88300 1.026357732246263e+00 -6.068704697187347e+00 -5.982752751776253e+00 3.338383838892372e+00 4.831933210463442e+00 9.164183784828743e+03 + 88320 9.786321596486209e-01 -6.013142321670273e+00 -5.986988262763026e+00 3.621804993342937e+00 4.771985646915886e+00 9.177145074339131e+03 + 88340 9.922623331856517e-01 -6.046989333495447e+00 -5.993670777934438e+00 3.389974100496179e+00 4.696137497547305e+00 9.197642137419371e+03 + 88360 9.771858819237923e-01 -6.038530383610703e+00 -6.025640588550237e+00 3.440864440930647e+00 4.514879638857182e+00 9.295947421119197e+03 + 88380 1.023151082816274e+00 -6.121751959096362e+00 -5.963451689859408e+00 3.088794231575835e+00 4.997778874421919e+00 9.105203626402679e+03 + 88400 9.054183207084602e-01 -5.961517981239626e+00 -6.026217933914992e+00 3.935689234093978e+00 4.564172093546709e+00 9.297701534764175e+03 + 88420 9.772573050833140e-01 -6.085723836382913e+00 -6.017019429067936e+00 3.265186423224134e+00 4.659697761999403e+00 9.269349446593335e+03 + 88440 9.330567041886971e-01 -6.042752678567165e+00 -5.996453375367334e+00 3.448117340900954e+00 4.713975104668401e+00 9.206169719018635e+03 + 88460 9.514808916381501e-01 -6.097902067799129e+00 -6.019810649821789e+00 3.129981990597250e+00 4.578394997231013e+00 9.277970578917304e+03 + 88480 9.160147034463306e-01 -6.077015839004092e+00 -6.039868801682477e+00 3.226000555437470e+00 4.439304592223628e+00 9.339851082068279e+03 + 88500 9.092749090985396e-01 -6.097231968760007e+00 -5.996968930809714e+00 3.143501406254739e+00 4.719227285820297e+00 9.207751529639496e+03 + 88520 8.889781440781960e-01 -6.090103941391010e+00 -5.968768174475036e+00 3.263429618068091e+00 4.960158368348857e+00 9.121420725059768e+03 + 88540 9.127909703196988e-01 -6.139016089637335e+00 -5.972914696426336e+00 2.945220696816531e+00 4.899000600741610e+00 9.134103772237313e+03 + 88560 8.877803294197115e-01 -6.105714212880700e+00 -5.973392048410016e+00 3.140640008920569e+00 4.900454354100011e+00 9.135561995166554e+03 + 88580 8.778128455967099e-01 -6.084311967322473e+00 -5.976115550132464e+00 3.201317098549175e+00 4.822597669395659e+00 9.143884457630256e+03 + 88600 8.894518612174224e-01 -6.081637181901126e+00 -5.952349669705846e+00 3.206033111273057e+00 4.948422013476204e+00 9.071370238644886e+03 + 88620 9.249443655129866e-01 -6.099455250478443e+00 -5.979026492555028e+00 3.188281928567509e+00 4.879802492853816e+00 9.152770657170870e+03 + 88640 9.371024781649533e-01 -6.074666712945807e+00 -5.983423212413014e+00 3.298719418318991e+00 4.822653718264363e+00 9.166238394446105e+03 + 88660 1.014841050819118e+00 -6.146913622719190e+00 -5.961094417719136e+00 2.924475650811190e+00 4.991478281350541e+00 9.098017904811479e+03 + 88680 1.001229110470209e+00 -6.088944488939696e+00 -6.007233544446546e+00 3.217549375709646e+00 4.686746263717111e+00 9.239272130973863e+03 + 88700 9.516826087773159e-01 -5.985052613734860e+00 -6.023010564599581e+00 3.738238923376366e+00 4.520278495537227e+00 9.287818673264686e+03 + 88720 9.937741089808717e-01 -6.025150864487736e+00 -5.960353334422396e+00 3.583656608058491e+00 4.955734053079039e+00 9.095733557056474e+03 + 88740 9.913812824392139e-01 -5.999647004335644e+00 -6.005893360106677e+00 3.714316273240482e+00 4.678448731782780e+00 9.235131944843841e+03 + 88760 1.040405816525180e+00 -6.053510133618762e+00 -5.991697439346081e+00 3.413784254468234e+00 4.768722310465493e+00 9.191565905015541e+03 + 88780 9.629324168643597e-01 -5.923142539098103e+00 -6.021838979874664e+00 4.114933912352464e+00 4.548203676188606e+00 9.284202315456612e+03 + 88800 1.022142824396557e+00 -5.998749538606490e+00 -6.026458820647983e+00 3.649289085334886e+00 4.490178099855097e+00 9.298458320946382e+03 + 88820 1.031313743329312e+00 -6.003078925716706e+00 -5.997894933210134e+00 3.678401196746057e+00 4.708168483939042e+00 9.210570553796168e+03 + 88840 1.003528379976617e+00 -5.954265385455339e+00 -5.985452560845258e+00 3.988093114182294e+00 4.809011526893586e+00 9.172441110512602e+03 + 88860 1.008206544153851e+00 -5.953238856503750e+00 -6.008170663998642e+00 3.941463692743266e+00 4.626036753437866e+00 9.242156921619640e+03 + 88880 1.054516573573500e+00 -6.015573791797429e+00 -5.983121525226958e+00 3.623726591424894e+00 4.810072528044563e+00 9.165317842963359e+03 + 88900 1.038006053671899e+00 -5.987407165709443e+00 -5.978935248585669e+00 3.846321430090962e+00 4.894968489240608e+00 9.152504440961218e+03 + 88920 1.014424133005227e+00 -5.953127661645553e+00 -6.028881092982384e+00 3.915208636218025e+00 4.480220710676331e+00 9.305911976705849e+03 + 88940 1.024815199859206e+00 -5.973535711245635e+00 -6.008160100595526e+00 3.852426916831321e+00 4.653608315077312e+00 9.242095554031668e+03 + 88960 1.039900886754309e+00 -6.004101267904953e+00 -5.985875556032923e+00 3.659545170093172e+00 4.764200028082167e+00 9.173727868428194e+03 + 88980 1.003800980513256e+00 -5.962083765805920e+00 -6.014694299478510e+00 3.903476758469875e+00 4.601378932668089e+00 9.262215148076304e+03 + 89000 1.003345627153875e+00 -5.979274120867061e+00 -6.026109007077953e+00 3.735125958982781e+00 4.466192794684616e+00 9.297351369949498e+03 + 89020 9.688185098935996e-01 -5.951269556776326e+00 -6.000233393741544e+00 3.951478051781292e+00 4.670320122797733e+00 9.217759896874761e+03 + 89040 9.858627433054334e-01 -6.004800184789176e+00 -5.982015966008410e+00 3.734374752713193e+00 4.865205262798817e+00 9.161922619308532e+03 + 89060 1.053278082969985e+00 -6.137493658610869e+00 -5.931386152343289e+00 3.043373995373682e+00 5.226875191395640e+00 9.007633853532210e+03 + 89080 9.245791198893709e-01 -5.981890719107919e+00 -6.016649032870578e+00 3.755791004881187e+00 4.556203388424327e+00 9.268225434918069e+03 + 89100 9.586426065516375e-01 -6.063110484670775e+00 -5.979654487937639e+00 3.353486150142232e+00 4.832703398157656e+00 9.154696177705442e+03 + 89120 9.323669825072488e-01 -6.049659178510559e+00 -6.003835970819046e+00 3.386207037094189e+00 4.649330986777330e+00 9.228837280353562e+03 + 89140 9.779359966358703e-01 -6.136857211154803e+00 -5.975069069333118e+00 2.957217006622544e+00 4.886229553596692e+00 9.140693406407850e+03 + 89160 9.070375871776774e-01 -6.044605421481983e+00 -5.993373706498935e+00 3.456784572660287e+00 4.750965008175220e+00 9.196715597235569e+03 + 89180 9.040369073203212e-01 -6.045325342399186e+00 -5.967265482580721e+00 3.413606363085883e+00 4.861838157887775e+00 9.116824913395136e+03 + 89200 9.046321178408135e-01 -6.042126665631038e+00 -5.983273059720310e+00 3.479956052002634e+00 4.817902564708113e+00 9.165745058922925e+03 + 89220 9.363914560012292e-01 -6.076054424723391e+00 -5.979589099655591e+00 3.250763184902861e+00 4.804682009402974e+00 9.154513107776416e+03 + 89240 9.501873216059669e-01 -6.072636565014899e+00 -5.964335804879910e+00 3.278396380907554e+00 4.900276105091125e+00 9.107887968984407e+03 + 89260 9.353052210131921e-01 -6.016189342186157e+00 -5.973941237577979e+00 3.621352720999603e+00 4.863947875532823e+00 9.137225692580265e+03 + 89280 1.043136735133966e+00 -6.131244084949285e+00 -5.972528649804417e+00 2.996561478428053e+00 4.907930068164092e+00 9.132922285489305e+03 + 89300 1.026117704221436e+00 -6.058978793775714e+00 -5.998701344035079e+00 3.362232305567566e+00 4.708354749883493e+00 9.213080908998983e+03 + 89320 1.000640639700927e+00 -5.983694340095309e+00 -6.031027340878283e+00 3.711730660933211e+00 4.439937245679179e+00 9.312552353756560e+03 + 89340 1.048895374045542e+00 -6.030180469916131e+00 -5.988191969683041e+00 3.550310255466541e+00 4.791414721504355e+00 9.180836980985254e+03 + 89360 1.082788746659865e+00 -6.066426774002735e+00 -5.977692054829641e+00 3.365729174899637e+00 4.875257664044950e+00 9.148699706537462e+03 + 89380 9.329928299188820e-01 -5.837461935383454e+00 -6.058745866687050e+00 4.549209634328773e+00 4.278563057205829e+00 9.398258686147925e+03 + 89400 1.031893225816197e+00 -5.982383545865353e+00 -6.016977745442300e+00 3.737770196597678e+00 4.539124949191768e+00 9.269244341092806e+03 + 89420 1.032687114280286e+00 -5.984860194135133e+00 -5.989616202633520e+00 3.750626563198680e+00 4.723316826411008e+00 9.185180463630579e+03 + 89440 9.422909917061277e-01 -5.853690288415820e+00 -6.016945381209421e+00 4.459980587752131e+00 4.522544581287307e+00 9.269113660898307e+03 + 89460 9.431167723206733e-01 -5.858695205018088e+00 -5.999445646274077e+00 4.470761556942512e+00 4.662550742190231e+00 9.215246701455131e+03 + 89480 1.025074646030021e+00 -5.982365408674911e+00 -5.990247771059710e+00 3.804283848083211e+00 4.759022103478058e+00 9.187107972393191e+03 + 89500 1.092961955488760e+00 -6.085600850558023e+00 -6.013283679967551e+00 3.248071790455250e+00 4.663328175031723e+00 9.257869810447197e+03 + 89520 1.005155828348626e+00 -5.964470622237902e+00 -6.019026099872705e+00 3.975265860382148e+00 4.661999865370234e+00 9.275540114348518e+03 + 89540 1.048817420977191e+00 -6.044144117777384e+00 -5.997305265807888e+00 3.465511696764498e+00 4.734467633062259e+00 9.208781872523890e+03 + 89560 9.534510072109293e-01 -5.919603076839124e+00 -6.014181753994586e+00 4.156760449652657e+00 4.613675049423009e+00 9.260615906519390e+03 + 89580 9.513120116736070e-01 -5.933491857578895e+00 -5.985760781948285e+00 4.097696726057238e+00 4.797560473738298e+00 9.173373651032851e+03 + 89600 9.917902819743665e-01 -6.011376550784409e+00 -5.991207983842441e+00 3.637667335024309e+00 4.753478367480735e+00 9.190055212645148e+03 + 89620 9.496585266755952e-01 -5.964940294286245e+00 -6.010330013475879e+00 3.850823646868842e+00 4.590188855245618e+00 9.248778494363796e+03 + 89640 9.719356698005875e-01 -6.014945778701155e+00 -6.005932378190620e+00 3.611548686523224e+00 4.663305027073942e+00 9.235249572994906e+03 + 89660 8.988098423345408e-01 -5.924660415781875e+00 -6.037937799971939e+00 4.086612031577254e+00 4.436155761939356e+00 9.333833971661461e+03 + 89680 1.003717607496102e+00 -6.099177532643650e+00 -5.979413680700002e+00 3.155558781508242e+00 4.843261352764859e+00 9.153945551001132e+03 + 89700 8.995636940872132e-01 -5.960851664092569e+00 -6.000731733233051e+00 3.932075326529547e+00 4.703077798104146e+00 9.219289722748530e+03 + 89720 9.086597555823709e-01 -5.989336516067295e+00 -6.006565640788387e+00 3.709639092029354e+00 4.610706791682411e+00 9.237209021194656e+03 + 89740 9.490173640937255e-01 -6.062223223695243e+00 -5.993328260279084e+00 3.357879413654802e+00 4.753484955051518e+00 9.196597122762994e+03 + 89760 9.971813729213872e-01 -6.144392207718965e+00 -6.004702386102547e+00 2.882662823916294e+00 4.684783396567795e+00 9.231505601116962e+03 + 89780 9.191921395916522e-01 -6.037685177238625e+00 -5.997979936989212e+00 3.542592715892396e+00 4.770586349770596e+00 9.210852702758455e+03 + 89800 9.165309842597930e-01 -6.039851819487186e+00 -6.002447992625497e+00 3.515197233253136e+00 4.729975795316459e+00 9.224565118732260e+03 + 89820 9.256969499510513e-01 -6.053798956146555e+00 -6.001230266130225e+00 3.438426970953917e+00 4.740284524006173e+00 9.220811882724460e+03 + 89840 9.308674471916136e-01 -6.054546422890816e+00 -5.991240627519842e+00 3.408165536278739e+00 4.771677209839046e+00 9.190175167448826e+03 + 89860 9.615269171723647e-01 -6.083549061590590e+00 -5.969740512018785e+00 3.274154072123113e+00 4.927660375580548e+00 9.124375201929375e+03 + 89880 9.551653022277738e-01 -6.045874585781847e+00 -5.978139864506148e+00 3.456983513985499e+00 4.845926765464801e+00 9.150050099248981e+03 + 89900 9.961949579757611e-01 -6.068824456674899e+00 -5.967507194025314e+00 3.292564855290098e+00 4.874344256219734e+00 9.117570583351575e+03 + 89920 9.497438451701601e-01 -5.956790062993470e+00 -6.000862618905698e+00 3.899693907953644e+00 4.646622471699647e+00 9.219684332534054e+03 + 89940 1.043074237688136e+00 -6.055406879998739e+00 -5.987113534589753e+00 3.383780924912854e+00 4.775931882612300e+00 9.177528452870951e+03 + 89960 1.006024217703055e+00 -5.966909629127543e+00 -5.999169016905221e+00 3.879682620192498e+00 4.694444223448945e+00 9.214484416014820e+03 + 89980 9.532048251225204e-01 -5.861673261168003e+00 -6.021763228364946e+00 4.428346630573344e+00 4.509085265086140e+00 9.283966887190381e+03 + 90000 1.015525214675431e+00 -5.933120449331093e+00 -6.022097833437072e+00 4.058635981456383e+00 4.547714072714164e+00 9.284986996214904e+03 + 90020 1.065506994964185e+00 -5.990571560554081e+00 -6.001474453679120e+00 3.780553572110544e+00 4.717947472569316e+00 9.221563422898023e+03 + 90040 1.077246056511955e+00 -5.999827819564325e+00 -6.004678402799932e+00 3.670325876304934e+00 4.642473076740748e+00 9.231404672661036e+03 + 90060 1.022795043666366e+00 -5.917415348876180e+00 -6.021668165241481e+00 4.119190210727448e+00 4.520554406086693e+00 9.283668375711304e+03 + 90080 9.890657067829292e-01 -5.871081991110764e+00 -5.977892282333162e+00 4.414359929144009e+00 4.801038708105854e+00 9.149293187725247e+03 + 90100 1.052280115763825e+00 -5.969734178206576e+00 -5.974393800944616e+00 3.860680194038443e+00 4.833923919202328e+00 9.138597977496993e+03 + 90120 1.001146413408308e+00 -5.902939164348861e+00 -5.971464452095062e+00 4.181787116772119e+00 4.788304310279426e+00 9.129630168462905e+03 + 90140 1.076741436769008e+00 -6.025883012607737e+00 -5.975004412858010e+00 3.544704506095365e+00 4.836857299296160e+00 9.140479167432331e+03 + 90160 1.061229413842794e+00 -6.020742653745723e+00 -6.027526626784756e+00 3.564118653306600e+00 4.525164030300035e+00 9.301753035980490e+03 + 90180 1.014652803214469e+00 -5.978641210677645e+00 -6.018759540962622e+00 3.826851894267096e+00 4.596486233479214e+00 9.274725704479402e+03 + 90200 1.014465856226911e+00 -6.010476439228469e+00 -5.996850408073815e+00 3.682641238215042e+00 4.760884017726572e+00 9.207388880616554e+03 + 90220 9.847153561573705e-01 -6.001700058483343e+00 -6.023762317137913e+00 3.689374621899657e+00 4.562689718581625e+00 9.290149970927794e+03 + 90240 9.920237226796763e-01 -6.050936581156005e+00 -5.979330003931285e+00 3.437721098230750e+00 4.848897145737109e+00 9.153717408745284e+03 + 90260 9.595273559686467e-01 -6.036776639741477e+00 -5.986613812209792e+00 3.512216511030744e+00 4.800259229390153e+00 9.175998860271007e+03 + 90280 8.736860192904680e-01 -5.932951181949848e+00 -6.025646073141882e+00 4.115158454309164e+00 4.582890044596455e+00 9.295939578286481e+03 + 90300 9.857882816538537e-01 -6.114542380219270e+00 -5.975393116728304e+00 3.110230745977143e+00 4.909247350221200e+00 9.141675121913306e+03 + 90320 9.527922218669030e-01 -6.074197900286209e+00 -5.958728272275986e+00 3.337892814566385e+00 5.000937287468272e+00 9.090776964117773e+03 + 90340 9.579817859577995e-01 -6.082283183887720e+00 -5.965824770239896e+00 3.279931255302519e+00 4.948653488349592e+00 9.112410045834142e+03 + 90360 9.585416473781758e-01 -6.077505596686079e+00 -5.981548726862692e+00 3.307412947970064e+00 4.858412143773566e+00 9.160488923283152e+03 + 90380 9.308329610826589e-01 -6.026698221125326e+00 -5.997222421438376e+00 3.540085736868388e+00 4.709340340036114e+00 9.208519428186451e+03 + 90400 1.026443585458951e+00 -6.156223514409019e+00 -5.964560298605078e+00 2.835650205969555e+00 4.936210050902576e+00 9.108577234351773e+03 + 90420 9.611710647378977e-01 -6.046657432469367e+00 -5.952195549456406e+00 3.513843417658106e+00 5.056258167847679e+00 9.070891888661970e+03 + 90440 9.392971724258149e-01 -6.001278958318267e+00 -6.012386908571036e+00 3.675138586512166e+00 4.611355017211015e+00 9.255124360920188e+03 + 90460 1.020014014673853e+00 -6.107166297958133e+00 -5.971189126596940e+00 3.119972736260773e+00 4.900774696616006e+00 9.128826649782726e+03 + 90480 9.430966403029909e-01 -5.980626855315546e+00 -6.024272945130757e+00 3.821521617479445e+00 4.570899015549937e+00 9.291703172447786e+03 + 90500 1.028772738547751e+00 -6.095762519767596e+00 -5.996115313834304e+00 3.137679316413835e+00 4.709868993238081e+00 9.205135031789638e+03 + 90520 9.179205546981368e-01 -5.920137216813536e+00 -6.037783241313399e+00 4.131048959484556e+00 4.455507281142893e+00 9.333385143967314e+03 + 90540 1.049310058879352e+00 -6.102547513615965e+00 -5.943568151166408e+00 3.190151085431167e+00 5.103035186593352e+00 9.044623684787695e+03 + 90560 9.946021899499028e-01 -6.009466288715161e+00 -5.993896115821315e+00 3.694111071237408e+00 4.783517413470339e+00 9.198257794363941e+03 + 90580 9.983051052917969e-01 -6.003098543643557e+00 -5.988019990086439e+00 3.659468697634746e+00 4.746052085558343e+00 9.180310415899106e+03 + 90600 9.981079140423113e-01 -5.990424798692567e+00 -5.997668767441670e+00 3.771690923429568e+00 4.730094933871677e+00 9.209886879363441e+03 + 90620 9.941806559074878e-01 -5.971896903703829e+00 -5.997072143644015e+00 3.858643994282564e+00 4.714083870690225e+00 9.208072583911415e+03 + 90640 1.042657326220928e+00 -6.031071174677218e+00 -5.974204390049662e+00 3.546052014768722e+00 4.872589892206632e+00 9.138045156781183e+03 + 90660 9.709387721744742e-01 -5.913898313215785e+00 -5.996336582019689e+00 4.176554130257375e+00 4.703180833504493e+00 9.205810171692761e+03 + 90680 1.071583179835870e+00 -6.053381367463934e+00 -6.000121800021109e+00 3.390153904181969e+00 4.695978582330097e+00 9.217427775567701e+03 + 90700 9.597901276255719e-01 -5.879345899677598e+00 -6.037270343008111e+00 4.333592216873237e+00 4.426765624540807e+00 9.331790064520241e+03 + 90720 1.044456446144139e+00 -5.997086941036258e+00 -6.000366387005961e+00 3.699006308222609e+00 4.680175221971952e+00 9.218151614315479e+03 + 90740 9.998699175354113e-01 -5.925483352472693e+00 -6.022221744422813e+00 4.068853194744369e+00 4.513366377949006e+00 9.285378044484742e+03 + 90760 9.420959057549776e-01 -5.838141108244647e+00 -6.049475036987692e+00 4.552538121126080e+00 4.339025998463740e+00 9.369526246489157e+03 + 90780 1.007727699188709e+00 -5.934001077838484e+00 -6.042943582518939e+00 3.972537545747542e+00 4.346972825074255e+00 9.349311779552567e+03 + 90800 1.000798645476324e+00 -5.922346605074116e+00 -6.019969358775882e+00 4.099850201925008e+00 4.539285243097160e+00 9.278443805490278e+03 + 90820 9.993253559859417e-01 -5.923466449028192e+00 -6.020865821947615e+00 4.117587633545843e+00 4.558305361738269e+00 9.281208432204452e+03 + 90840 1.007200505664126e+00 -5.945067424257755e+00 -6.026064790190077e+00 3.988253686976418e+00 4.523154277491159e+00 9.297215353960037e+03 + 90860 9.914780448311771e-01 -5.938252796520446e+00 -5.986946129918909e+00 4.003601279588083e+00 4.723996623945117e+00 9.176995334684994e+03 + 90880 9.524931485558684e-01 -5.898748145579706e+00 -6.004750420466019e+00 4.247683031373628e+00 4.639001565177392e+00 9.231612850745720e+03 + 90900 1.013252730892950e+00 -6.008994089787417e+00 -6.009903302911170e+00 3.580265241408291e+00 4.575044398951423e+00 9.247497388515614e+03 + 90920 9.946399199078487e-01 -6.004955218884769e+00 -6.019148096522600e+00 3.635980892143488e+00 4.554483192406343e+00 9.275932949618173e+03 + 90940 9.751633928386126e-01 -6.001217571173766e+00 -5.999305626861283e+00 3.716706328712937e+00 4.727685008827640e+00 9.214917461244038e+03 + 90960 1.051289063961637e+00 -6.139728299919894e+00 -5.956617889276140e+00 2.944622398381418e+00 4.996070712542322e+00 9.084374399774599e+03 + 90980 9.341984508912023e-01 -5.986612100912313e+00 -6.007118911760227e+00 3.752997031375246e+00 4.635243750067806e+00 9.238925635922211e+03 + 91000 9.988888908410025e-01 -6.101424707898858e+00 -5.980281463988439e+00 3.195635407807942e+00 4.891258661197978e+00 9.156617577492556e+03 + 91020 9.040673077035576e-01 -5.976308028414016e+00 -5.975089568045691e+00 3.840074504716747e+00 4.847071092707806e+00 9.140732897506612e+03 + 91040 9.652329394414887e-01 -6.075087871501165e+00 -5.965774702519901e+00 3.302392650726312e+00 4.930085783174956e+00 9.112274042501864e+03 + 91060 9.245722523508927e-01 -6.015947207051626e+00 -5.990750481265810e+00 3.595574607634791e+00 4.740258106277660e+00 9.188660983147169e+03 + 91080 9.639004152992124e-01 -6.070300947819990e+00 -5.979028840193379e+00 3.380527266217551e+00 4.904625832522557e+00 9.152773533411388e+03 + 91100 9.901266641483418e-01 -6.098203766266397e+00 -5.979042302446231e+00 3.180793619443620e+00 4.865037184875943e+00 9.152804232932287e+03 + 91120 9.833430338384906e-01 -6.073216142871380e+00 -5.925634144184750e+00 3.336869185737465e+00 5.184307860436584e+00 8.990164595324690e+03 + 91140 9.033595814883488e-01 -5.930964014915924e+00 -5.973926112824348e+00 4.126542237452760e+00 4.879847222899426e+00 9.137138491514721e+03 + 91160 1.027466038629875e+00 -6.079207285101411e+00 -6.007545332584083e+00 3.231138947887750e+00 4.642632968893556e+00 9.240232093133918e+03 + 91180 9.836530472190592e-01 -5.972534155322508e+00 -6.022821069606733e+00 3.894929365775412e+00 4.606174122080557e+00 9.287244598370815e+03 + 91200 1.034288791734034e+00 -6.011257377083134e+00 -6.010948610649745e+00 3.651577485582313e+00 4.653350470224285e+00 9.250693265141179e+03 + 91220 1.068314274333455e+00 -6.029424317300419e+00 -6.012139820362630e+00 3.608267473016916e+00 4.707517729200960e+00 9.254356046370867e+03 + 91240 1.071033302424923e+00 -6.012603916949923e+00 -5.986126189845902e+00 3.662250771808017e+00 4.814289978254335e+00 9.174509985550818e+03 + 91260 1.031050439297823e+00 -5.940115781522131e+00 -6.015028584332229e+00 3.984610392423695e+00 4.554449485969345e+00 9.263262817257830e+03 + 91280 1.040219872663347e+00 -5.945830660984037e+00 -6.025795036416900e+00 3.992577362354788e+00 4.533409544172184e+00 9.296398596148074e+03 + 91300 1.076369215611291e+00 -5.997051519302405e+00 -5.992566785282205e+00 3.729814863648519e+00 4.755566900402860e+00 9.194254731191864e+03 + 91320 1.057736271696878e+00 -5.973159478260164e+00 -6.068772041323474e+00 3.737676666705704e+00 4.188654533599864e+00 9.429396672016062e+03 + 91340 1.045195912275040e+00 -5.965754081404414e+00 -6.029113985775551e+00 3.856907300472836e+00 4.493084924660256e+00 9.306626585720447e+03 + 91360 9.455357909955038e-01 -5.832110073105351e+00 -6.035774723343862e+00 4.570808761384921e+00 4.401334822712625e+00 9.327174595983230e+03 + 91380 1.020412938546745e+00 -5.956838913800142e+00 -6.034061450335118e+00 3.973845651357209e+00 4.530421896424469e+00 9.321894445039961e+03 + 91400 1.029686078599941e+00 -5.986564161876955e+00 -6.041977184982188e+00 3.742981619589984e+00 4.424791465782124e+00 9.346360338217564e+03 + 91420 9.465624464099498e-01 -5.879473478092417e+00 -6.030081609808972e+00 4.364177914043715e+00 4.499362715194195e+00 9.309599073084468e+03 + 91440 1.059917132916434e+00 -6.061831399008779e+00 -5.944912016461762e+00 3.370389069893799e+00 5.041758257694742e+00 9.048716227758126e+03 + 91460 9.870916646128796e-01 -5.964946856903919e+00 -5.977647597650968e+00 3.882158680276892e+00 4.809229061474054e+00 9.148554506217266e+03 + 91480 1.038402835410739e+00 -6.050207558887988e+00 -6.013842365699590e+00 3.360941664275159e+00 4.569756231058400e+00 9.259580737225218e+03 + 91500 9.554853951441951e-01 -5.935219766991504e+00 -6.067204140165945e+00 3.989754105902203e+00 4.231879410618827e+00 9.424466922437308e+03 + 91520 9.515881094689967e-01 -5.938322911089619e+00 -6.029692446322017e+00 4.014402820305257e+00 4.489744809610951e+00 9.308393894938501e+03 + 91540 9.608428847090277e-01 -5.958781742091363e+00 -5.995957151342961e+00 3.882609018970457e+00 4.669142066171788e+00 9.204598234061119e+03 + 91560 9.972993699317566e-01 -6.013930632949211e+00 -5.974905991261720e+00 3.574285050666326e+00 4.798370582279690e+00 9.140164837365375e+03 + 91580 1.026630686158436e+00 -6.056971238495659e+00 -6.011202823707333e+00 3.391624242362649e+00 4.654433562716511e+00 9.251487030139155e+03 + 91600 9.964634501445047e-01 -6.013020642160168e+00 -6.001032177444396e+00 3.614981885676685e+00 4.683821505283568e+00 9.220235000348785e+03 + 91620 9.423942319649549e-01 -5.933875652776468e+00 -6.046491525690345e+00 3.990226653071538e+00 4.343568883550043e+00 9.360309423217339e+03 + 91640 1.023432725669494e+00 -6.053948776099207e+00 -6.009721836470018e+00 3.389567275299719e+00 4.643525206747317e+00 9.246925886947929e+03 + 91660 9.646856809463791e-01 -5.966503739638371e+00 -6.019736898408741e+00 3.910846536994430e+00 4.605173501530268e+00 9.277740923076328e+03 + 91680 9.653432939404197e-01 -5.968257585369055e+00 -6.019067960131906e+00 3.794670777571624e+00 4.502909742803253e+00 9.275683122122551e+03 + 91700 1.000849178190713e+00 -6.019965202001417e+00 -5.969556077419325e+00 3.576035065000227e+00 4.865492059137421e+00 9.123815632879801e+03 + 91720 1.005731068781705e+00 -6.023517715814787e+00 -5.977079410727914e+00 3.536005487407260e+00 4.802661421520571e+00 9.146816636846450e+03 + 91740 1.002929402526722e+00 -6.016503567640603e+00 -5.947312202648198e+00 3.641823210678309e+00 5.039130735793828e+00 9.056007226934067e+03 + 91760 1.032662447582763e+00 -6.057228252354748e+00 -5.944895456115659e+00 3.431813840423112e+00 5.076846139871998e+00 9.048635123796757e+03 + 91780 9.919792147486702e-01 -5.991036227335263e+00 -5.992058098899449e+00 3.756199554248204e+00 4.750331809592537e+00 9.192656908820063e+03 + 91800 9.953215556737985e-01 -5.989040665034300e+00 -5.981891604049508e+00 3.788823065848969e+00 4.829874080337255e+00 9.161527806065895e+03 + 91820 9.952214618048111e-01 -5.981479731895280e+00 -5.996008707895268e+00 3.791787704549599e+00 4.708360076005902e+00 9.204811339276703e+03 + 91840 1.017839905376232e+00 -6.008517932693572e+00 -6.028735187746029e+00 3.633587440498918e+00 4.517496833377605e+00 9.305471264839402e+03 + 91860 1.003121240471240e+00 -5.982126754990892e+00 -6.032765157520940e+00 3.735679644476415e+00 4.444906100881415e+00 9.317908207917404e+03 + 91880 9.905822744190905e-01 -5.960004364236238e+00 -6.041516072379213e+00 3.839880706214705e+00 4.371827864161677e+00 9.344951927765665e+03 + 91900 9.843627291208699e-01 -5.949567682769651e+00 -6.024125283664455e+00 3.952583554486667e+00 4.524462272397251e+00 9.291240240686842e+03 + 91920 1.030237255426225e+00 -6.016581009149775e+00 -6.024967027097318e+00 3.596609855368648e+00 4.548456042581769e+00 9.293872854634992e+03 + 91940 9.899447253774338e-01 -5.957466035577689e+00 -6.033042290327494e+00 3.927799248354059e+00 4.493828698193060e+00 9.318776036235200e+03 + 91960 9.822926769538427e-01 -5.950124247734498e+00 -6.037007291998162e+00 3.924197203294980e+00 4.425301318025372e+00 9.331011816813696e+03 + 91980 1.006100411387033e+00 -5.994133615713660e+00 -6.049248446324792e+00 3.673910862519874e+00 4.357432976158285e+00 9.368857983203421e+03 + 92000 1.010900588960694e+00 -6.018224344495864e+00 -6.030389514662566e+00 3.553213806441698e+00 4.483359516790494e+00 9.310595421462909e+03 + 92020 9.890027675174210e-01 -6.009139371886627e+00 -5.996361692573205e+00 3.616862010963902e+00 4.690233422921050e+00 9.205885886408954e+03 + 92040 9.688819061044173e-01 -6.002362814238278e+00 -5.999908162812299e+00 3.677172437094205e+00 4.691267425438259e+00 9.216755560957523e+03 + 92060 9.610154434892753e-01 -6.012699842872334e+00 -6.044621746847262e+00 3.606250149992277e+00 4.422949637469567e+00 9.354558255715190e+03 + 92080 9.718109457199213e-01 -6.052735707574848e+00 -6.051701580629252e+00 3.386296006141179e+00 4.392234123093421e+00 9.376448891260490e+03 + 92100 9.520023869840795e-01 -6.046044245681657e+00 -5.989406824574102e+00 3.466765780288617e+00 4.791986616900786e+00 9.184562060961507e+03 + 92120 9.573153541350301e-01 -6.070026933501809e+00 -5.973186995233010e+00 3.328303675179439e+00 4.884373586650896e+00 9.134909045490715e+03 + 92140 9.758073411255317e-01 -6.107010282088451e+00 -5.948589750730035e+00 3.165039951936228e+00 5.074715158494252e+00 9.059909259509808e+03 + 92160 9.504224733908879e-01 -6.072855794682445e+00 -5.965364914217933e+00 3.292794460802797e+00 4.910023730590015e+00 9.111035680602665e+03 + 92180 9.520359810120744e-01 -6.071733785232041e+00 -5.951391871856043e+00 3.339017313247474e+00 5.030039202703362e+00 9.068438010719930e+03 + 92200 9.799392833876657e-01 -6.102227090418967e+00 -5.972641969321316e+00 3.170563407884349e+00 4.914661226459740e+00 9.133262485147472e+03 + 92220 9.842771089681361e-01 -6.092740100275113e+00 -5.974745322916188e+00 3.177091302943135e+00 4.854635574170866e+00 9.139699500680616e+03 + 92240 9.148052632309247e-01 -5.966810246945827e+00 -6.008003268608390e+00 3.933110084695734e+00 4.696573379709797e+00 9.241607385710033e+03 + 92260 1.010786893824097e+00 -6.080650545839234e+00 -5.980462347050146e+00 3.259774119842492e+00 4.835070261363089e+00 9.157174517260582e+03 + 92280 1.023707442867941e+00 -6.064741193049048e+00 -5.992728181286305e+00 3.364650904029827e+00 4.778160761549057e+00 9.194768581798111e+03 + 92300 1.005345829524636e+00 -6.006289757664199e+00 -5.993021874852108e+00 3.665539683457507e+00 4.741725919762763e+00 9.195641220426953e+03 + 92320 9.583461671662269e-01 -5.908432870441562e+00 -6.020362430099569e+00 4.177261616304031e+00 4.534544763704379e+00 9.279661574232032e+03 + 92340 1.068998676091077e+00 -6.046008870878883e+00 -5.989239625254302e+00 3.530141016721070e+00 4.856118810109785e+00 9.184033910560105e+03 + 92360 9.973643390921406e-01 -5.919515726814877e+00 -6.022654269303411e+00 4.126547166869917e+00 4.534309695262889e+00 9.286722242793785e+03 + 92380 1.052305443809838e+00 -5.987844775441395e+00 -5.952254214240100e+00 3.763245480899226e+00 4.967611990938611e+00 9.071059577377260e+03 + 92400 1.009554259056044e+00 -5.913943252087926e+00 -5.964031273672455e+00 4.174518648092534e+00 4.886905477057883e+00 9.106933236623652e+03 + 92420 1.072316633828783e+00 -5.998169937071998e+00 -5.967237905791027e+00 3.688905075094072e+00 4.866521585425774e+00 9.116724645219794e+03 + 92440 1.016409688817053e+00 -5.908841146490147e+00 -6.020991448484965e+00 4.184217408592140e+00 4.540233019334753e+00 9.281581443574525e+03 + 92460 1.049466995741277e+00 -5.956877632736725e+00 -6.022528570356407e+00 3.898134496676197e+00 4.521156653414223e+00 9.286332057409900e+03 + 92480 1.052174318688774e+00 -5.967548639670395e+00 -5.951178702797510e+00 3.851925381788181e+00 4.945924092551834e+00 9.067792886191935e+03 + 92500 1.028430033580563e+00 -5.942234958478628e+00 -5.974972858379205e+00 4.020975696838104e+00 4.832989609435354e+00 9.140365849262849e+03 + 92520 1.072841383558196e+00 -6.021887373217473e+00 -5.982977625964514e+00 3.519833743494744e+00 4.743259533485166e+00 9.164861064747853e+03 + 92540 1.009601918244036e+00 -5.949667480674852e+00 -6.026963241611281e+00 3.943552455004142e+00 4.499708234226815e+00 9.300004974416839e+03 + 92560 1.044910280083122e+00 -6.035539046237331e+00 -5.988501398110229e+00 3.519668431188584e+00 4.789765885786929e+00 9.181798599340558e+03 + 92580 9.806986044500791e-01 -5.985327702000668e+00 -6.050120667516158e+00 3.751488611406585e+00 4.379437376737633e+00 9.371566453109961e+03 + 92600 9.603164027696457e-01 -6.009700548409076e+00 -5.999442070614180e+00 3.644248317867358e+00 4.703154084859959e+00 9.215315244256237e+03 + 92620 9.123608443701907e-01 -5.986033838486925e+00 -5.987058268081388e+00 3.750627731614772e+00 4.744745298353397e+00 9.177349567127952e+03 + 92640 9.693737853768104e-01 -6.104923093038237e+00 -5.954006969068850e+00 3.100337675932058e+00 4.966921413958984e+00 9.076397484315825e+03 + 92660 9.685733721309905e-01 -6.120755932019788e+00 -5.958926505074204e+00 3.060858785842734e+00 4.990108398387167e+00 9.091386793527914e+03 + 92680 9.168913925057434e-01 -6.049984448193428e+00 -6.003098866739107e+00 3.433086989901467e+00 4.702311254132459e+00 9.226568824073742e+03 + 92700 9.372976710721153e-01 -6.080608498443852e+00 -5.995308418909813e+00 3.253266412780978e+00 4.743072669610077e+00 9.202642913534812e+03 + 92720 9.072516097524811e-01 -6.030281472072612e+00 -5.929577406726683e+00 3.532494556298832e+00 5.110752883418902e+00 9.002124000460153e+03 + 92740 9.381256385296273e-01 -6.061906010950734e+00 -5.914725048175066e+00 3.414853921375832e+00 5.259989785814101e+00 8.957112857892402e+03 + 92760 9.238923198867027e-01 -6.021063018691799e+00 -5.994690460673923e+00 3.546011481083911e+00 4.697446790362720e+00 9.200735396330121e+03 + 92780 9.314699270002779e-01 -6.008395597851394e+00 -6.013263293721306e+00 3.631656831397357e+00 4.603705768438823e+00 9.257807142774758e+03 + 92800 1.008599814700428e+00 -6.098809421086679e+00 -5.983243633860296e+00 3.163064862429596e+00 4.826661496431264e+00 9.165694223477316e+03 + 92820 9.436635092028784e-01 -5.977646317949976e+00 -6.021620148734943e+00 3.868400333499715e+00 4.615895792204111e+00 9.283536794473232e+03 + 92840 1.000285077489808e+00 -6.041525929150849e+00 -5.989496545543767e+00 3.406887033774043e+00 4.705647805966997e+00 9.184837871043990e+03 + 92860 9.746140936571742e-01 -5.981735513601664e+00 -5.986848975936510e+00 3.855208482189755e+00 4.825846190157325e+00 9.176719852085424e+03 + 92880 1.001370884465483e+00 -6.000470996872350e+00 -6.025359712217724e+00 3.647185182512474e+00 4.504270327483084e+00 9.295087193826890e+03 + 92900 1.003485485692020e+00 -5.986836750706074e+00 -5.984698139946032e+00 3.786550883896313e+00 4.798831117829424e+00 9.170146129710563e+03 + 92920 1.100011876580059e+00 -6.115727212014576e+00 -5.981732437981941e+00 3.027720184964660e+00 4.797138913084321e+00 9.161073780535517e+03 + 92940 9.572167015410662e-01 -5.893077594681028e+00 -6.040659467748990e+00 4.235536667688436e+00 4.388098714311148e+00 9.342280155333743e+03 + 92960 1.009789899522207e+00 -5.962257477355764e+00 -5.975097131733445e+00 3.982698575299220e+00 4.908971292932479e+00 9.140727692865221e+03 + 92980 1.067642709659546e+00 -6.040837569272728e+00 -5.969667790297125e+00 3.493338430183918e+00 4.902006314549533e+00 9.124151521951764e+03 + 93000 1.028558921899013e+00 -5.978399690839425e+00 -5.982777368743179e+00 3.809598886926332e+00 4.784461582959517e+00 9.164245998684999e+03 + 93020 9.531461529812316e-01 -5.863809187631457e+00 -6.029085262768795e+00 4.382165639256477e+00 4.433124839427912e+00 9.306509102703963e+03 + 93040 1.056890816966651e+00 -6.016462201036746e+00 -5.975154447001737e+00 3.601958929666540e+00 4.839154445689841e+00 9.140937712267722e+03 + 93060 1.005532235416631e+00 -5.941182225295004e+00 -5.972289563444016e+00 4.016455491331429e+00 4.837832341834784e+00 9.132085971952896e+03 + 93080 1.036904757287008e+00 -5.988282518319290e+00 -5.971329906085779e+00 3.822962222915282e+00 4.920306745768372e+00 9.129225853771639e+03 + 93100 1.051015708453725e+00 -6.012767658914488e+00 -5.994719695523393e+00 3.605468237889761e+00 4.709102436594730e+00 9.200845660885005e+03 + 93120 9.337346019269741e-01 -5.848728498635131e+00 -6.060579883014610e+00 4.454543473766731e+00 4.238060040763981e+00 9.403937637403025e+03 + 93140 1.030030902016519e+00 -6.010644994107730e+00 -5.993233923643608e+00 3.620595809453794e+00 4.720572870413229e+00 9.196288424481945e+03 + 93160 1.057837725331392e+00 -6.080219448148757e+00 -5.998663051280260e+00 3.233777672444303e+00 4.702087124074840e+00 9.212960392522851e+03 + 93180 9.376903018963904e-01 -5.941592480450124e+00 -5.996080217189768e+00 4.028088364012851e+00 4.715211347703803e+00 9.205029995547176e+03 + 93200 9.427026289467044e-01 -5.990054823693479e+00 -6.040505709325814e+00 3.724540576251935e+00 4.434843783701755e+00 9.341814705987832e+03 + 93220 1.013233046792462e+00 -6.133190750576562e+00 -5.971300642720000e+00 2.964980511163235e+00 4.894578562888836e+00 9.129165200766976e+03 + 93240 8.934490975349725e-01 -5.985786090220083e+00 -6.029604947259248e+00 3.765765537065746e+00 4.514150879000653e+00 9.308151959767356e+03 + 93260 9.800436514323376e-01 -6.136235032295470e+00 -6.004949668780902e+00 2.946644260122939e+00 4.700505133767937e+00 9.232260046399693e+03 + 93280 9.646697139876947e-01 -6.129735948842610e+00 -5.956938129346762e+00 3.016267168055702e+00 5.008498987977010e+00 9.085344639190527e+03 + 93300 8.874427893340724e-01 -6.021860141531219e+00 -5.969011571954354e+00 3.627305435147085e+00 4.930770099947155e+00 9.122160849220310e+03 + 93320 9.325243612217277e-01 -6.084675755497639e+00 -6.005691156449628e+00 3.178595141044794e+00 4.632136931605668e+00 9.234529004805938e+03 + 93340 9.009092587411992e-01 -6.026556292229439e+00 -6.041442668648252e+00 3.502043067869769e+00 4.416563190813639e+00 9.344711435964631e+03 + 93360 9.841350127735562e-01 -6.132304821524253e+00 -6.021371526099509e+00 2.928113986312415e+00 4.565110135513278e+00 9.282798665816825e+03 + 93380 9.385807246643262e-01 -6.040846738837826e+00 -6.017771740622493e+00 3.440614660971338e+00 4.573114871568214e+00 9.271706770429551e+03 + 93400 8.807208265174612e-01 -5.928660370465323e+00 -6.042809229633868e+00 3.998913786280840e+00 4.343453372456189e+00 9.348938736197631e+03 + 93420 9.896361620414179e-01 -6.055415162761354e+00 -6.023641022959520e+00 3.385651690664246e+00 4.568103718438620e+00 9.289765016505211e+03 + 93440 9.631922047584699e-01 -5.980722577785181e+00 -6.037539971319533e+00 3.771627440855607e+00 4.445373174718121e+00 9.332662714589154e+03 + 93460 1.025763091642005e+00 -6.042275368587633e+00 -6.001923174483368e+00 3.440317578158959e+00 4.672026121187507e+00 9.222950259173882e+03 + 93480 1.033381868659976e+00 -6.029629026776412e+00 -5.972505670976630e+00 3.551988084206076e+00 4.879999233019168e+00 9.132837819902230e+03 + 93500 1.033254172985017e+00 -6.011962924292745e+00 -5.955937589458908e+00 3.642224120604169e+00 4.963930263112609e+00 9.082278032132499e+03 + 93520 9.883646116751856e-01 -5.931981829539673e+00 -5.995598784253384e+00 4.048996119244813e+00 4.683697720586760e+00 9.203524313342221e+03 + 93540 9.784616802303986e-01 -5.907513140549610e+00 -5.974670121582267e+00 4.167534549694230e+00 4.781908772095488e+00 9.139450776037895e+03 + 93560 1.059612153165929e+00 -6.020639695095587e+00 -5.975316585587861e+00 3.569780337745006e+00 4.830032646266899e+00 9.141423591328725e+03 + 93580 1.007376275376154e+00 -5.939974093164111e+00 -6.011284091225516e+00 3.970039643113140e+00 4.560566599058016e+00 9.251729141788226e+03 + 93600 1.000643871863482e+00 -5.930206226105319e+00 -5.995144827990976e+00 4.099197943223079e+00 4.726310441979473e+00 9.202162687384256e+03 + 93620 9.953493980126841e-01 -5.925033375617418e+00 -6.025524359174819e+00 4.080345152288544e+00 4.503310373772504e+00 9.295569534157989e+03 + 93640 1.064913549723367e+00 -6.033609184741526e+00 -5.988718946350775e+00 3.521044207624584e+00 4.778810903206217e+00 9.182442000113155e+03 + 93660 1.032362135473018e+00 -5.992270130790513e+00 -6.005280834051839e+00 3.776962007398535e+00 4.702252535872177e+00 9.233265093100666e+03 + 93680 1.035197740094568e+00 -6.007013599225484e+00 -5.994543831208215e+00 3.645473538910315e+00 4.717076876555839e+00 9.200310070257183e+03 + 93700 1.041214636537405e+00 -6.028716247025527e+00 -5.962467320652049e+00 3.580515858649267e+00 4.960927445874001e+00 9.102174559412397e+03 + 93720 1.016390428986946e+00 -6.005648104028441e+00 -6.015939275518408e+00 3.642109204093400e+00 4.583015704844366e+00 9.266032362528114e+03 + 93740 1.014749278266371e+00 -6.018133577011636e+00 -6.010553929890744e+00 3.546358747120229e+00 4.589882253834997e+00 9.249472384182725e+03 + 93760 1.028734728324503e+00 -6.055495656574205e+00 -5.974276307048829e+00 3.433539964694126e+00 4.899914038322555e+00 9.138262372436948e+03 + 93780 9.957474282021727e-01 -6.023761910627298e+00 -6.011055666967334e+00 3.587377919064549e+00 4.660339136444920e+00 9.251016635038286e+03 + 93800 9.858205063858017e-01 -6.031570827340636e+00 -6.032672336632356e+00 3.536090656421268e+00 4.529765619610206e+00 9.317617167852070e+03 + 93820 9.199329037089282e-01 -5.960695716703579e+00 -6.005406834739899e+00 3.890634452975001e+00 4.633896294187298e+00 9.233667054380230e+03 + 93840 9.644976390140015e-01 -6.057658701609730e+00 -6.009589028063054e+00 3.389296193797505e+00 4.665319698060463e+00 9.246509309950654e+03 + 93860 9.829653713372970e-01 -6.123873470327216e+00 -5.954486821918110e+00 3.084889006408699e+00 5.057533354072914e+00 9.077875470424107e+03 + 93880 9.439727856330419e-01 -6.107292039536254e+00 -5.950507094739788e+00 3.173976287786973e+00 5.074259703200077e+00 9.065756179654887e+03 + 93900 9.255990130050203e-01 -6.120004952747221e+00 -5.966366293613188e+00 3.115038436565535e+00 4.997255392818818e+00 9.114096726750182e+03 + 93920 8.427387754489267e-01 -6.030439350078264e+00 -6.006720922838523e+00 3.517544574739641e+00 4.653739454364988e+00 9.237682555406534e+03 + 93940 9.333399106880507e-01 -6.187177361176544e+00 -5.962807315707908e+00 2.695233188623299e+00 4.983600710856528e+00 9.103251421573483e+03 + 93960 8.352140068879473e-01 -6.053140747454613e+00 -5.994813895620208e+00 3.388712219549476e+00 4.723634028833779e+00 9.201150059149833e+03 + 93980 9.101130088736247e-01 -6.162723313519563e+00 -5.965041074708683e+00 2.856739015593896e+00 4.991861022073561e+00 9.110059835482014e+03 + 94000 9.219878977377274e-01 -6.167262630705228e+00 -5.985524230942518e+00 2.790932690477775e+00 4.834502705841724e+00 9.172676511843023e+03 + 94020 8.565663573115526e-01 -6.047142603868017e+00 -6.005135275976323e+00 3.415494087583965e+00 4.656706664951058e+00 9.232812281880641e+03 + 94040 8.598031356150282e-01 -6.014900012509350e+00 -5.953512326487363e+00 3.626933174413893e+00 4.979430767265848e+00 9.074872313916998e+03 + 94060 9.172644569259599e-01 -6.049049172464232e+00 -6.018633752899497e+00 3.413391824378816e+00 4.588041870290493e+00 9.274331553324901e+03 + 94080 9.603271487720929e-01 -6.063272423156502e+00 -6.026859884214838e+00 3.282939583966269e+00 4.492026017391496e+00 9.299708106562335e+03 + 94100 9.430354987819062e-01 -6.007613077843463e+00 -5.985049150114367e+00 3.654911415896582e+00 4.784476980673579e+00 9.171216064505685e+03 + 94120 9.023835793791308e-01 -5.928068614315489e+00 -5.977805156996920e+00 4.122451954596821e+00 4.836857029814937e+00 9.149048851608704e+03 + 94140 9.903826310028637e-01 -6.041691525536578e+00 -6.034633784495830e+00 3.455083799584075e+00 4.495610440821943e+00 9.323690798623775e+03 + 94160 1.037161583404263e+00 -6.097431691523498e+00 -5.996628794389118e+00 3.237636005108668e+00 4.816461839652193e+00 9.206706980156685e+03 + 94180 9.087868051326436e-01 -5.896479847965462e+00 -6.023124796535016e+00 4.239300154282507e+00 4.512085261353675e+00 9.288170362481120e+03 + 94200 9.812685541587761e-01 -5.991425009643056e+00 -5.996501736995487e+00 3.757128887157152e+00 4.727977533078471e+00 9.206290926002494e+03 + 94220 1.046056204846449e+00 -6.072557312486155e+00 -5.966891005791136e+00 3.304329247869947e+00 4.911081532720861e+00 9.115710373932909e+03 + 94240 1.004982817913677e+00 -5.998294909633646e+00 -6.017509449407452e+00 3.684418894192112e+00 4.574086033370497e+00 9.270862650844600e+03 + 94260 1.014388137485901e+00 -5.996720059006901e+00 -6.010974171384073e+00 3.735037108105575e+00 4.653187789019088e+00 9.250766561353445e+03 + 94280 9.768766593952090e-01 -5.924821712462682e+00 -6.071394423056050e+00 4.032153890739501e+00 4.190510704458720e+00 9.437542281484111e+03 + 94300 1.004143252054956e+00 -5.953855390674719e+00 -6.021302334683414e+00 3.914808501384805e+00 4.527517711506029e+00 9.282570917618468e+03 + 94320 1.000550485074426e+00 -5.938594079016808e+00 -6.020499970528772e+00 3.999140916524417e+00 4.528824612566972e+00 9.280081895976049e+03 + 94340 9.592776640604833e-01 -5.869441056124731e+00 -6.008271547376529e+00 4.364101334244232e+00 4.566915169527320e+00 9.242454586238318e+03 + 94360 1.052893441674532e+00 -6.000969049581993e+00 -5.999817537971719e+00 3.659625600278341e+00 4.666237758140385e+00 9.216475080989228e+03 + 94380 1.024829670564327e+00 -5.953804232535115e+00 -6.011826201391147e+00 3.959026202118567e+00 4.625855078076572e+00 9.253384792886536e+03 + 94400 9.920089842000683e-01 -5.900482816454371e+00 -6.032655444711682e+00 4.279834100127156e+00 4.520878415025558e+00 9.317540344688270e+03 + 94420 1.075654972856715e+00 -6.023679138029183e+00 -6.003467567373416e+00 3.581027523855521e+00 4.697085490291387e+00 9.227700565645491e+03 + 94440 1.028778702351383e+00 -5.960652373320967e+00 -6.001461723376734e+00 3.960992100231613e+00 4.726658496984892e+00 9.221518987812582e+03 + 94460 9.929047660666727e-01 -5.919286553192048e+00 -6.042428276340521e+00 4.078592764715665e+00 4.371493934277065e+00 9.347749097793805e+03 + 94480 1.028594018147993e+00 -5.987768144992869e+00 -6.027802168121504e+00 3.803440951534185e+00 4.573559395484509e+00 9.302592782553376e+03 + 94500 1.025743264731821e+00 -6.006457850783084e+00 -6.010732886393869e+00 3.622093039316844e+00 4.597545123280090e+00 9.250052503505840e+03 + 94520 1.029117393396721e+00 -6.039029105277233e+00 -5.987878407503574e+00 3.490737379837413e+00 4.784452601998665e+00 9.179892558249367e+03 + 94540 9.956185557872157e-01 -6.021378459419370e+00 -6.001063782689154e+00 3.629009175074239e+00 4.745659192545202e+00 9.220324889085827e+03 + 94560 1.038862249820165e+00 -6.119522493183204e+00 -6.001506653971469e+00 3.029934304911610e+00 4.707599516557485e+00 9.221691509625185e+03 + 94580 9.799803280389342e-01 -6.065682244446433e+00 -5.991550894063900e+00 3.367111209370673e+00 4.792784895056569e+00 9.191137641431686e+03 + 94600 8.553292249563450e-01 -5.907024690378362e+00 -6.007771304408273e+00 4.233373065091190e+00 4.654870416843307e+00 9.240898896911791e+03 + 94620 9.737030447344890e-01 -6.100442138544905e+00 -6.023613068605949e+00 3.102745433790073e+00 4.543909842639705e+00 9.289672349176348e+03 + 94640 8.830153988127762e-01 -5.978155213946994e+00 -6.040000821161965e+00 3.807323062244560e+00 4.452196015039407e+00 9.340230683672073e+03 + 94660 9.449169102578151e-01 -6.075460405635059e+00 -5.984669013959854e+00 3.261397388750873e+00 4.782735609672350e+00 9.170070670252057e+03 + 94680 9.769776749157604e-01 -6.121545164846050e+00 -5.974925776658918e+00 3.032676949172019e+00 4.874588165419521e+00 9.140251701021791e+03 + 94700 1.020593881751412e+00 -6.179367541083741e+00 -5.959195963305854e+00 2.758809793936601e+00 5.023069064978773e+00 9.092216920775505e+03 + 94720 9.016373699568452e-01 -5.990038590541530e+00 -6.019008512707730e+00 3.772879824149218e+00 4.606530047989926e+00 9.275479512731046e+03 + 94740 9.911982309132864e-01 -6.102634324396875e+00 -5.990180255977284e+00 3.096953208541824e+00 4.742681871617962e+00 9.186925833370498e+03 + 94760 9.391611655436257e-01 -5.997609801841262e+00 -6.000905137147389e+00 3.760662687139738e+00 4.741740361860462e+00 9.219798494691498e+03 + 94780 1.006109515289531e+00 -6.061500133477270e+00 -5.993461692488776e+00 3.364894499626489e+00 4.755581756697136e+00 9.196986067295953e+03 + 94800 9.806220635953549e-01 -5.984286339786313e+00 -5.973961980171657e+00 3.819397714940515e+00 4.878681785537355e+00 9.137286528433091e+03 + 94820 1.009010188142077e+00 -5.986198299572623e+00 -6.010054451452831e+00 3.802784913637598e+00 4.665799197813867e+00 9.247937182393478e+03 + 94840 1.000346563317788e+00 -5.939097925279751e+00 -6.078003850935052e+00 3.956635270105404e+00 4.159015949370138e+00 9.458068202104883e+03 + 94860 1.037295835669813e+00 -5.974793191453345e+00 -6.010999412910149e+00 3.799254167964006e+00 4.591352441464374e+00 9.250851373565962e+03 + 94880 9.976901085157588e-01 -5.907635665001663e+00 -5.976410450749055e+00 4.178524510897162e+00 4.783609048271933e+00 9.144761753177954e+03 + 94900 9.658175943341680e-01 -5.856044626617686e+00 -5.997065233459568e+00 4.426403967678579e+00 4.616641820324108e+00 9.208045140861503e+03 + 94920 1.017302293185459e+00 -5.931822031227415e+00 -6.042837423141791e+00 4.000953158984965e+00 4.363485599036239e+00 9.349003727203481e+03 + 94940 9.698714727173007e-01 -5.864796531580102e+00 -5.999574293216920e+00 4.437937778134579e+00 4.664023014024764e+00 9.215708367882666e+03 + 94960 1.031119647727532e+00 -5.957468654519881e+00 -5.993078079493547e+00 3.945434652420791e+00 4.740959823681290e+00 9.195785345969052e+03 + 94980 1.008167231964538e+00 -5.928844640327234e+00 -6.034945139944816e+00 4.024505947699401e+00 4.415260459895991e+00 9.324644358123605e+03 + 95000 1.026281809141785e+00 -5.966481919660632e+00 -6.011358895815677e+00 3.854361673504163e+00 4.596671131732280e+00 9.251939846085541e+03 + 95020 9.976630096264398e-01 -5.938526898105757e+00 -5.989972848305277e+00 3.952535585383399e+00 4.657124978102689e+00 9.186323897037637e+03 + 95040 9.903369133529597e-01 -5.943430702737667e+00 -6.011488437257345e+00 3.990800758110267e+00 4.600002714597900e+00 9.252345682824460e+03 + 95060 9.796229377826041e-01 -5.944633734729479e+00 -5.975062532742219e+00 3.982511733488347e+00 4.807784866457920e+00 9.140640857971084e+03 + 95080 1.009045107114247e+00 -6.002984097214718e+00 -5.976443552897360e+00 3.692352739004185e+00 4.844752651610413e+00 9.144883745399362e+03 + 95100 9.935190020486889e-01 -5.995594690980003e+00 -6.077930916697068e+00 3.748467419161414e+00 4.275680069604276e+00 9.457815554912739e+03 + 95120 9.914586622388470e-01 -6.013691383888232e+00 -6.041945818688934e+00 3.588487887946941e+00 4.426246550961658e+00 9.346290245612150e+03 + 95140 9.504231928433325e-01 -5.976270979896865e+00 -6.046552728813741e+00 3.835971506391897e+00 4.432402828045698e+00 9.360498968595060e+03 + 95160 9.804492291455735e-01 -6.041003109393825e+00 -6.011789595042327e+00 3.534996981273852e+00 4.702745501456890e+00 9.253283539784681e+03 + 95180 9.749837239196405e-01 -6.052245292189327e+00 -6.025783206396939e+00 3.392734732058423e+00 4.544684123672854e+00 9.296379721246536e+03 + 95200 9.670109719503991e-01 -6.058039462528069e+00 -6.036465676304895e+00 3.397754260083931e+00 4.521634279110021e+00 9.329341441569139e+03 + 95220 9.624333702289875e-01 -6.069003909504825e+00 -6.049215472039305e+00 3.320805483646473e+00 4.434433753824290e+00 9.368745484397343e+03 + 95240 9.532401056259716e-01 -6.072451209124635e+00 -5.997266352643951e+00 3.306856717970496e+00 4.738579798701519e+00 9.208671955712132e+03 + 95260 9.845016636459654e-01 -6.131391103549574e+00 -5.991735594113335e+00 2.964074731297003e+00 4.765998278100129e+00 9.191711052536000e+03 + 95280 9.060309976500294e-01 -6.025604763648489e+00 -5.980035659241802e+00 3.619174818174552e+00 4.880839667473865e+00 9.155869665853383e+03 + 95300 9.184498066890725e-01 -6.049567906711621e+00 -5.990413903533570e+00 3.455572540954434e+00 4.795243981255208e+00 9.187631802180606e+03 + 95320 9.439745183578174e-01 -6.084785233708757e+00 -5.978830288754804e+00 3.286486891979812e+00 4.894896582380150e+00 9.152178860398391e+03 + 95340 9.736913886241206e-01 -6.114622006594506e+00 -5.949805022255585e+00 3.105697070235057e+00 5.052101699655037e+00 9.063594777855404e+03 + 95360 9.327140110297205e-01 -6.025579816040525e+00 -5.997259096405820e+00 3.569665236158490e+00 4.732287190918169e+00 9.208645450750419e+03 + 95380 9.819898849375112e-01 -6.054560699943782e+00 -6.006133374367264e+00 3.386234199165888e+00 4.664311396730667e+00 9.235903878039448e+03 + 95400 9.910255764459250e-01 -6.018414553026550e+00 -5.990665491505911e+00 3.638492032831150e+00 4.797831438236054e+00 9.188373918597279e+03 + 95420 9.617581531967009e-01 -5.925639279040673e+00 -6.035454875281984e+00 4.085585563049582e+00 4.455007415523375e+00 9.326194637046043e+03 + 95440 1.006226747223286e+00 -5.950396060784550e+00 -6.012316333554942e+00 4.024804565713380e+00 4.669248777334547e+00 9.254897645864330e+03 + 95460 1.030358658649033e+00 -5.956879695268370e+00 -6.026836124467660e+00 3.911538510230798e+00 4.509837868046043e+00 9.299609526484026e+03 + 95480 1.090220490240386e+00 -6.025577030717097e+00 -6.028857324445020e+00 3.546960878949121e+00 4.528124924739571e+00 9.305876621309128e+03 + 95500 1.109192396057043e+00 -6.045395197216797e+00 -6.018795217650608e+00 3.425391213113024e+00 4.578132412115619e+00 9.274859813492150e+03 + 95520 9.928999664002216e-01 -5.873524571906970e+00 -6.023663274108280e+00 4.360446256517251e+00 4.498326594588250e+00 9.289805936482902e+03 + 95540 9.772746411792442e-01 -5.853372364353572e+00 -6.012393094488770e+00 4.538342622374205e+00 4.625220981559445e+00 9.255087647248356e+03 + 95560 1.037652760840065e+00 -5.948507915133175e+00 -5.993255568250525e+00 3.965878046165973e+00 4.708930097289206e+00 9.196267853506561e+03 + 95580 1.002539444629045e+00 -5.904553286470214e+00 -5.997346827205158e+00 4.195967562271685e+00 4.663132691617615e+00 9.208887895525228e+03 + 95600 1.037817796391123e+00 -5.969439863681574e+00 -5.985727672866933e+00 3.870532530728908e+00 4.777005409856254e+00 9.173286770940877e+03 + 95620 9.795420005610300e-01 -5.899849297552656e+00 -6.019774121803854e+00 4.173149100099962e+00 4.484522200943009e+00 9.277864054505111e+03 + 95640 1.048596226270975e+00 -6.024533302159186e+00 -6.007262049212427e+00 3.551202795151471e+00 4.650377002289516e+00 9.239336437401354e+03 + 95660 9.883789046665934e-01 -5.959820705208630e+00 -6.022017355413285e+00 3.860247306125108e+00 4.503104515749471e+00 9.284748387472686e+03 + 95680 1.009438176942720e+00 -6.019519322395571e+00 -5.954823076345161e+00 3.609083993448194e+00 4.980579849981371e+00 9.078865697442307e+03 + 95700 9.648995799909704e-01 -5.979673357366833e+00 -5.964438699092693e+00 3.773944673088690e+00 4.861424438454553e+00 9.108179893096296e+03 + 95720 1.024605163207389e+00 -6.091979333754413e+00 -5.989328556123897e+00 3.189730857850850e+00 4.779167508161772e+00 9.184318720046165e+03 + 95740 8.784424563297207e-01 -5.897543305038710e+00 -6.015444635487267e+00 4.256641266164163e+00 4.579633581556628e+00 9.264521701197833e+03 + 95760 9.143045390577533e-01 -5.968362849737898e+00 -6.010046189614317e+00 3.790975719845538e+00 4.551623531799140e+00 9.247944621003673e+03 + 95780 9.845429105904092e-01 -6.085550277675749e+00 -6.035931054304919e+00 3.230766793167618e+00 4.515688052312917e+00 9.327694022641901e+03 + 95800 9.937207734011191e-01 -6.112012802236822e+00 -5.967429930856783e+00 3.134538933845319e+00 4.964756155436540e+00 9.117344811003271e+03 + 95820 9.435483920180487e-01 -6.047227149090185e+00 -5.984856605591721e+00 3.410719319806712e+00 4.768860632385305e+00 9.170641458952761e+03 + 95840 9.777634868068209e-01 -6.103295440741928e+00 -5.974901378184962e+00 3.181136134293052e+00 4.918394710412120e+00 9.140172245744503e+03 + 95860 8.989120290937723e-01 -5.986949456712046e+00 -6.020063585582036e+00 3.776137270200059e+00 4.585990817833697e+00 9.278740249780389e+03 + 95880 9.216401269819307e-01 -6.015085362737524e+00 -6.027070173197583e+00 3.578924659994488e+00 4.510106023689408e+00 9.300339241951917e+03 + 95900 9.794363088435865e-01 -6.082758463359166e+00 -6.005881063033618e+00 3.239859492638620e+00 4.681301422047168e+00 9.235112007415240e+03 + 95920 9.686400403768717e-01 -6.032955919164269e+00 -6.007553200805039e+00 3.547248867929405e+00 4.693115207806061e+00 9.240264941849331e+03 + 95940 1.027247532129516e+00 -6.073705795616404e+00 -5.999199130446444e+00 3.288243242471132e+00 4.716072043746219e+00 9.214599135256754e+03 + 95960 9.794509031816385e-01 -5.950952689417671e+00 -6.016317760106690e+00 3.989338599997680e+00 4.614002248889332e+00 9.267202159840424e+03 + 95980 1.075930991705041e+00 -6.048247290170844e+00 -5.986767180896875e+00 3.472000988239155e+00 4.825029289706452e+00 9.176482643722396e+03 + 96000 9.782102174421234e-01 -5.867932548088808e+00 -6.067162706839676e+00 4.428237380874463e+00 4.284226978559547e+00 9.424374916441146e+03 + 96020 9.898558604591594e-01 -5.861222214302768e+00 -6.040514115306667e+00 4.419402641284387e+00 4.389880800387986e+00 9.341826562052440e+03 + 96040 1.015395099424125e+00 -5.883911845574032e+00 -5.999223565930539e+00 4.328578390663519e+00 4.666440647945403e+00 9.214651808067498e+03 + 96060 1.046001534240224e+00 -5.919862784751841e+00 -5.986433272547225e+00 4.179822741181201e+00 4.797564698510420e+00 9.175428402704185e+03 + 96080 1.049847677785737e+00 -5.920802446958024e+00 -6.013267025695900e+00 4.100900377140960e+00 4.569954457180761e+00 9.257810063267023e+03 + 96100 1.079204320652980e+00 -5.964165404076594e+00 -6.003779598880807e+00 3.894224041212488e+00 4.666753204369863e+00 9.228642572730489e+03 + 96120 1.068232668514922e+00 -5.956779257561318e+00 -6.032197957562008e+00 3.882234977467997e+00 4.449169131057928e+00 9.316168948695842e+03 + 96140 1.028401940710397e+00 -5.914841821752476e+00 -6.026186419986133e+00 4.188001697932197e+00 4.548643784353647e+00 9.297604586163785e+03 + 96160 1.012301036257794e+00 -5.915251194813584e+00 -6.064600221142466e+00 4.146416093849590e+00 4.288830872982018e+00 9.416430384492265e+03 + 96180 1.040766357610498e+00 -5.990274938888741e+00 -6.026250357103574e+00 3.688941768102832e+00 4.482365349535286e+00 9.297809935780180e+03 + 96200 1.010040172563128e+00 -5.977917893067936e+00 -6.014193743690896e+00 3.780708848334309e+00 4.572407300387527e+00 9.260677542039102e+03 + 96220 9.808320863978355e-01 -5.970148335695297e+00 -6.042251289555839e+00 3.770581092599445e+00 4.356554773636164e+00 9.347212581596996e+03 + 96240 9.305644506224656e-01 -5.927686420207044e+00 -5.976591156734094e+00 4.114829534379347e+00 4.834010969257505e+00 9.145316626682190e+03 + 96260 9.779458583257721e-01 -6.019348837028149e+00 -5.956107315339368e+00 3.557631372951578e+00 4.920773977082412e+00 9.082805591382292e+03 + 96280 9.904350115244523e-01 -6.052647998068558e+00 -5.973897109278077e+00 3.408223428454515e+00 4.860423218550109e+00 9.137091635122370e+03 + 96300 9.061963907376336e-01 -5.936994304888803e+00 -6.022184979575575e+00 4.017967085145298e+00 4.528789047879554e+00 9.285261441457153e+03 + 96320 1.026378895663077e+00 -6.119130067916058e+00 -5.958926351171058e+00 3.046916061830948e+00 4.966830594825778e+00 9.091412141599763e+03 + 96340 9.349912673619580e-01 -5.984056428802109e+00 -6.037651774967523e+00 3.702659373002223e+00 4.394906601467399e+00 9.333007398350066e+03 + 96360 9.796074430731135e-01 -6.049350503235654e+00 -6.015495952100532e+00 3.387720646266563e+00 4.582118717859291e+00 9.264699155245737e+03 + 96380 9.191893129130537e-01 -5.955800893106983e+00 -6.043984528465451e+00 3.916985533991129e+00 4.410621453389338e+00 9.352561406627157e+03 + 96400 9.575730111432178e-01 -6.006038037310796e+00 -5.985777894241363e+00 3.670259340051515e+00 4.786596216803204e+00 9.173446264305772e+03 + 96420 9.776551206045434e-01 -6.025959675715023e+00 -5.993060360306980e+00 3.548082728438794e+00 4.736995688664385e+00 9.195763714108836e+03 + 96440 9.629890897848359e-01 -5.991389528804721e+00 -6.020242317845025e+00 3.739432554802946e+00 4.573755375178850e+00 9.279299728795033e+03 + 96460 9.859374962593189e-01 -6.013060487439079e+00 -5.998276085294908e+00 3.659395790131505e+00 4.744290115122176e+00 9.211755235588287e+03 + 96480 1.024832450077476e+00 -6.057016505233285e+00 -6.026733209427803e+00 3.389051057285843e+00 4.562942428125803e+00 9.299283519239252e+03 + 96500 1.038184253802000e+00 -6.062423073081374e+00 -6.000977877393126e+00 3.357881289648440e+00 4.710709111903661e+00 9.220071888668113e+03 + 96520 1.000239030262752e+00 -5.991106816055823e+00 -6.071051151247307e+00 3.763450779883189e+00 4.304398035867800e+00 9.436453138672317e+03 + 96540 1.024306725317957e+00 -6.013409103837817e+00 -6.028105739733802e+00 3.625244485293641e+00 4.540854127681839e+00 9.303545633380123e+03 + 96560 1.081190828245497e+00 -6.089234989482030e+00 -5.987312138321705e+00 3.245065448765537e+00 4.830322232638366e+00 9.178154186556243e+03 + 96580 1.001965598109065e+00 -5.962530408124425e+00 -6.015313387672569e+00 3.875607062505841e+00 4.572519025800712e+00 9.264140796522373e+03 + 96600 1.056461673834690e+00 -6.034601897315613e+00 -5.988048937002086e+00 3.571582849092704e+00 4.838897151260305e+00 9.180392238048547e+03 + 96620 1.033590145894872e+00 -5.989249374218269e+00 -5.990489087491635e+00 3.732010873578715e+00 4.724892248118040e+00 9.187872078932269e+03 + 96640 9.954887757250682e-01 -5.912756043191632e+00 -5.998425194342862e+00 4.195248228130655e+00 4.703322704961995e+00 9.212194075577394e+03 + 96660 9.856715404617307e-01 -5.865346157334296e+00 -5.998011245083950e+00 4.387220453426883e+00 4.625436989712387e+00 9.210930874749927e+03 + 96680 1.071410035857962e+00 -5.950049388314482e+00 -6.023872834962559e+00 3.949157513348507e+00 4.525251858553802e+00 9.290463034685121e+03 + 96700 1.059035062760754e+00 -5.891393963739584e+00 -6.027771242187386e+00 4.287298511877939e+00 4.504199074715030e+00 9.302500035698960e+03 + 96720 1.082846042599960e+00 -5.895073875414120e+00 -6.044201574824681e+00 4.163620886408799e+00 4.307306558956455e+00 9.353257908962103e+03 + 96740 1.121230195260634e+00 -5.932288509924627e+00 -6.040899378555701e+00 4.023863340263500e+00 4.400202925106272e+00 9.343041060892130e+03 + 96760 1.070346857394463e+00 -5.849683432529357e+00 -6.048404429933732e+00 4.508896310281326e+00 4.367809591210442e+00 9.366237112852627e+03 + 96780 1.102352346258210e+00 -5.903379286086159e+00 -6.035396448207109e+00 4.192583150257438e+00 4.434520175769128e+00 9.325997502514410e+03 + 96800 1.115486174034992e+00 -5.940114461423031e+00 -5.994923447008214e+00 3.998449410339222e+00 4.683727733445992e+00 9.201473968002478e+03 + 96820 1.098304269992147e+00 -5.943684032118396e+00 -6.042337070644308e+00 3.953004744933044e+00 4.386523731208884e+00 9.347481915571343e+03 + 96840 1.072473166323507e+00 -5.945380976591960e+00 -6.006609382962785e+00 3.987583721712886e+00 4.636000737266345e+00 9.237348822832508e+03 + 96860 1.067434157703514e+00 -5.983355766038104e+00 -6.007832761222678e+00 3.769127516169860e+00 4.628576822017269e+00 9.241106798467234e+03 + 96880 1.049772030855263e+00 -5.999607399855426e+00 -5.978209254737830e+00 3.701627673777467e+00 4.824499134394961e+00 9.150290504180217e+03 + 96900 1.011285196760997e+00 -5.980739364573425e+00 -5.977966441105847e+00 3.782209964489039e+00 4.798132520148392e+00 9.149524744298771e+03 + 96920 9.788670986155742e-01 -5.960444370028313e+00 -5.980868243056859e+00 3.943648702970092e+00 4.826371663456039e+00 9.158395714525464e+03 + 96940 1.031552351952172e+00 -6.059330418817584e+00 -5.964836143035809e+00 3.401730789105440e+00 4.944331543586315e+00 9.109431341233359e+03 + 96960 9.734820600316595e-01 -5.990701922455864e+00 -6.002407998815282e+00 3.734592331952483e+00 4.667374229987243e+00 9.224430347819660e+03 + 96980 1.018752333068075e+00 -6.072425857247036e+00 -5.946296674499523e+00 3.336643858836761e+00 5.060897144600927e+00 9.052924790604755e+03 + 97000 9.012727234692852e-01 -5.908987703121392e+00 -5.989089599405458e+00 4.189454433879547e+00 4.729496949688050e+00 9.183561423806304e+03 + 97020 9.892722264648188e-01 -6.043755558580065e+00 -5.967806276271409e+00 3.451349472872462e+00 4.887462005002218e+00 9.118480263758116e+03 + 97040 1.017899293452533e+00 -6.087319559259154e+00 -5.968513512123562e+00 3.270384239220085e+00 4.952586947049031e+00 9.120641496545803e+03 + 97060 9.651246324392031e-01 -6.008319405545039e+00 -5.956930498421503e+00 3.710059397127934e+00 5.005142454238950e+00 9.085281154607854e+03 + 97080 9.736263386275996e-01 -6.016881201493080e+00 -5.929512078253887e+00 3.620490064303216e+00 5.122177090270785e+00 9.001925701758397e+03 + 97100 9.693747566584656e-01 -5.999511371516800e+00 -6.019933481646365e+00 3.732403587873361e+00 4.615136671198074e+00 9.278314271624742e+03 + 97120 9.506363678876203e-01 -5.958548920397047e+00 -6.022644969318065e+00 3.927137440801193e+00 4.559088009065194e+00 9.286693873433840e+03 + 97140 1.002550918984612e+00 -6.019162423972995e+00 -5.988037729696235e+00 3.601548901139066e+00 4.780271712207095e+00 9.180369513158998e+03 + 97160 9.936297308768781e-01 -5.983830899467006e+00 -5.966318118702315e+00 3.831159469459880e+00 4.931720566704801e+00 9.113932161552508e+03 + 97180 1.033904601222158e+00 -6.014458483862352e+00 -6.019759821321122e+00 3.645967045122098e+00 4.615525945054521e+00 9.277787435713240e+03 + 97200 9.866632951878325e-01 -5.912823122369054e+00 -6.090250588211653e+00 4.122388216337010e+00 4.103572250657204e+00 9.496175130241936e+03 + 97220 1.066534366803594e+00 -6.002186255902025e+00 -5.990523654992304e+00 3.731450786241079e+00 4.798419245446360e+00 9.187974205315491e+03 + 97240 9.932357688996131e-01 -5.863443686440395e+00 -6.012640312628903e+00 4.423517340000805e+00 4.566807224323114e+00 9.255866643687274e+03 + 97260 1.099056267910019e+00 -5.990642957554204e+00 -5.993139264454959e+00 3.799166787616824e+00 4.784832607090451e+00 9.195987263248628e+03 + 97280 1.034916394059455e+00 -5.870036261389747e+00 -5.992792568783102e+00 4.395363905635372e+00 4.690478192105549e+00 9.194936991393350e+03 + 97300 1.151310719523483e+00 -6.022905396441576e+00 -6.018166368838057e+00 3.617839670425753e+00 4.645051900287313e+00 9.272880954517443e+03 + 97320 9.967403886471896e-01 -5.781774382565998e+00 -6.095848613460610e+00 4.842390202478471e+00 4.038927365851460e+00 9.513606917020783e+03 + 97340 1.138498546532178e+00 -5.990883737241616e+00 -6.002383819022256e+00 3.722492222056077e+00 4.656456972839735e+00 9.224371462119618e+03 + 97360 1.108466744141072e+00 -5.954835220093056e+00 -6.029126545009205e+00 3.953422842399278e+00 4.526830558185378e+00 9.306674598484891e+03 + 97380 1.066165938469033e+00 -5.918466830374133e+00 -6.019518931416155e+00 4.148930261932064e+00 4.568673459986676e+00 9.277055739782383e+03 + 97400 1.028269905920360e+00 -5.910384079432938e+00 -5.999114613152256e+00 4.235594066093884e+00 4.726089610471845e+00 9.214292495458798e+03 + 97420 1.020910885745876e+00 -5.960985520492295e+00 -6.010843551936127e+00 3.904743354462764e+00 4.618450822406855e+00 9.250358330502588e+03 + 97440 1.003219674570014e+00 -5.998774580850043e+00 -6.025500723762576e+00 3.761502742423359e+00 4.608037093962344e+00 9.295492738205687e+03 + 97460 1.019695765119460e+00 -6.071493083307756e+00 -5.986283394895963e+00 3.357985859802994e+00 4.847273076820176e+00 9.174987434752429e+03 + 97480 9.968901620457375e-01 -6.067366133343240e+00 -5.978507703942025e+00 3.346697159038586e+00 4.856936011457870e+00 9.151164403017727e+03 + 97500 9.515616245085153e-01 -6.017025050408511e+00 -5.977458173508964e+00 3.597195161492405e+00 4.824394291604013e+00 9.147926567595849e+03 + 97520 9.536629250504800e-01 -6.026660850754853e+00 -5.977844005573809e+00 3.499175276566767e+00 4.779489155978698e+00 9.149148769954760e+03 + 97540 9.508420558835518e-01 -6.022486805333151e+00 -5.966792501666234e+00 3.570400736103321e+00 4.890206046424396e+00 9.115382352800085e+03 + 97560 9.771466718457020e-01 -6.056378516066914e+00 -5.982914987229796e+00 3.423503472409176e+00 4.845342423436256e+00 9.164669746784562e+03 + 97580 9.739626463895094e-01 -6.043765123066057e+00 -6.001681667974627e+00 3.458723006372638e+00 4.700372717901257e+00 9.222213269587475e+03 + 97600 9.596766770006505e-01 -6.011793745335624e+00 -6.012201991731238e+00 3.608721760774409e+00 4.606377546794870e+00 9.254545985419149e+03 + 97620 9.711141543929402e-01 -6.015579360946731e+00 -6.014845834938097e+00 3.551981712227445e+00 4.556193732081809e+00 9.262685916693255e+03 + 97640 9.723177367828872e-01 -5.999128269248606e+00 -6.028176634288247e+00 3.629747453601560e+00 4.462947246323980e+00 9.303746644996760e+03 + 97660 1.041240777692210e+00 -6.079721497695693e+00 -6.032433632942888e+00 3.217011857066135e+00 4.488546094250161e+00 9.316879611433764e+03 + 97680 1.050795699171073e+00 -6.074752574352083e+00 -5.965028444530246e+00 3.339392562745019e+00 4.969445495936228e+00 9.110017342581821e+03 + 97700 1.018476819105022e+00 -6.007803104733897e+00 -5.968052451361999e+00 3.643071963280672e+00 4.871326366335838e+00 9.119236365439572e+03 + 97720 1.090912960088806e+00 -6.094330032326338e+00 -5.924363755190130e+00 3.226153227385514e+00 5.202125892898007e+00 8.986319063273862e+03 + 97740 1.030634658597051e+00 -5.981410695390556e+00 -6.003115958438837e+00 3.793123168321940e+00 4.668488189020110e+00 9.226618477018312e+03 + 97760 1.068440179991526e+00 -6.015824731637972e+00 -6.013890139115846e+00 3.625948871064862e+00 4.637057600704132e+00 9.259717470447526e+03 + 97780 1.070785448612070e+00 -6.004099716239545e+00 -5.969302670582555e+00 3.678737721731255e+00 4.878547742719106e+00 9.123050552965768e+03 + 97800 1.064153862480760e+00 -5.979455453922583e+00 -6.003953758577199e+00 3.860788312932967e+00 4.720115256505768e+00 9.229170534316339e+03 + 97820 1.046536518760774e+00 -5.939831587757830e+00 -6.030352915852538e+00 4.019573230637285e+00 4.499785756587221e+00 9.310470001233716e+03 + 97840 1.062856216168492e+00 -5.959650810743873e+00 -6.008750081440034e+00 3.948914026752421e+00 4.666978416327478e+00 9.243868438341202e+03 + 97860 1.009417922243893e+00 -5.880899336583753e+00 -6.028082876680978e+00 4.373045512325685e+00 4.527894848508205e+00 9.303403595750395e+03 + 97880 1.066410623416811e+00 -5.972472773516566e+00 -5.997495266774521e+00 3.845995281001156e+00 4.702312252495658e+00 9.209361839199140e+03 + 97900 1.073040471259626e+00 -5.998107036149563e+00 -6.012313651080237e+00 3.720579197352112e+00 4.639002615953627e+00 9.254888776103387e+03 + 97920 1.016002708924734e+00 -5.944221851262356e+00 -6.012549489644128e+00 3.989679106537038e+00 4.597331233281040e+00 9.255605665877896e+03 + 97940 9.890779385127970e-01 -5.947685043919394e+00 -5.986434899376484e+00 4.020906637592893e+00 4.798398971037531e+00 9.175447579280246e+03 + 97960 9.637488911032882e-01 -5.961245500618162e+00 -5.994857249652021e+00 3.887715157412335e+00 4.694711293058564e+00 9.201257985309605e+03 + 97980 1.018190281979560e+00 -6.088691931634571e+00 -6.008744708785245e+00 3.208316158038675e+00 4.667385483432260e+00 9.243922189998202e+03 + 98000 9.456061505170157e-01 -6.020005544842085e+00 -5.991594422428325e+00 3.556842208651664e+00 4.719983270158452e+00 9.191258113724403e+03 + 98020 9.790583381926249e-01 -6.093260098169450e+00 -5.929314523822483e+00 3.185908246591074e+00 5.127309104986995e+00 9.001327143729490e+03 + 98040 9.653126093580920e-01 -6.087384404687521e+00 -5.967038275232672e+00 3.266095715536868e+00 4.957141814369958e+00 9.116120242440582e+03 + 98060 9.186625878998076e-01 -6.025167757709228e+00 -5.940833441577778e+00 3.564083137267088e+00 5.048343831187117e+00 9.036307150671750e+03 + 98080 9.592318898723974e-01 -6.083001923021514e+00 -5.952457659442945e+00 3.266792604748299e+00 5.016397967875942e+00 9.071658471441275e+03 + 98100 9.653510114086814e-01 -6.082299740633631e+00 -5.960271038234644e+00 3.256783760393797e+00 4.957491453449443e+00 9.095444269836924e+03 + 98120 9.367539629053514e-01 -6.024769313257536e+00 -5.966907520997850e+00 3.557324626663110e+00 4.889575991901641e+00 9.115728540799360e+03 + 98140 8.977329547394215e-01 -5.944715462727112e+00 -6.009532230413763e+00 4.009896047914615e+00 4.637708137495486e+00 9.246342671897331e+03 + 98160 9.575158876715945e-01 -6.007685756473959e+00 -6.018474479242944e+00 3.693177012208797e+00 4.631226496519833e+00 9.273843891590319e+03 + 98180 9.537792234066046e-01 -5.975675584475098e+00 -5.976126994029470e+00 3.861561414021498e+00 4.858969350504887e+00 9.143905739021960e+03 + 98200 1.006110715332192e+00 -6.024997238131742e+00 -5.985112042572241e+00 3.612903636559713e+00 4.841930601676431e+00 9.171388678993835e+03 + 98220 9.859110574751722e-01 -5.969796029794251e+00 -6.013954627995331e+00 3.876661724781145e+00 4.623096220389558e+00 9.259929484462600e+03 + 98240 1.020795827949005e+00 -5.999557862555808e+00 -6.011956560979626e+00 3.685037236101359e+00 4.613841991059419e+00 9.253810651589736e+03 + 98260 1.006767280453908e+00 -5.961218888088555e+00 -6.038984230971925e+00 3.875690644667386e+00 4.429150011683161e+00 9.337120255786482e+03 + 98280 9.961676491791430e-01 -5.935183582131528e+00 -5.998173628103480e+00 4.028462695144126e+00 4.666764103495071e+00 9.211452450807967e+03 + 98300 1.068594830815186e+00 -6.034559721172622e+00 -6.014429179932758e+00 3.487384410910086e+00 4.602977093900569e+00 9.261404996734393e+03 + 98320 1.045344550333632e+00 -5.997580510692358e+00 -6.028953251025173e+00 3.684306059659174e+00 4.504158929752276e+00 9.306159372303751e+03 + 98340 9.253874430854880e-01 -5.824048214950957e+00 -5.995653790796213e+00 4.581083826190456e+00 4.595698053809959e+00 9.203673373988742e+03 + 98360 9.518322540029426e-01 -5.864053980410961e+00 -5.970379139036634e+00 4.427397015172627e+00 4.816861500578888e+00 9.126299016687624e+03 + 98380 1.074418334177479e+00 -6.044981836656286e+00 -5.969723998397030e+00 3.451963228152273e+00 4.884105381549757e+00 9.124352034831898e+03 + 98400 1.016397118215661e+00 -5.961527654022233e+00 -6.051351625338919e+00 3.866246160075988e+00 4.350463016560941e+00 9.375366826727386e+03 + 98420 9.526157379839175e-01 -5.874482682924340e+00 -6.045231273769962e+00 4.367830957353481e+00 4.387366125458885e+00 9.356394633768092e+03 + 98440 1.013358051546990e+00 -5.972015401921674e+00 -5.980061527359134e+00 3.839167215811080e+00 4.792965118415300e+00 9.155938402310388e+03 + 98460 1.079081938964172e+00 -6.076827294555764e+00 -5.963431072462558e+00 3.301847065618189e+00 4.952985720886032e+00 9.105123412529585e+03 + 98480 1.000445652577293e+00 -5.968420419845759e+00 -5.963513817824699e+00 3.885448836222538e+00 4.913623304321669e+00 9.105360282322383e+03 + 98500 1.055991460458535e+00 -6.057883744648123e+00 -5.959264676613879e+00 3.348198749239141e+00 4.914484699143230e+00 9.092420856367102e+03 + 98520 1.007265813766592e+00 -5.992286517175636e+00 -6.007291735530336e+00 3.730278337168364e+00 4.644116051325639e+00 9.239313755772726e+03 + 98540 9.823571272701844e-01 -5.960458258253268e+00 -5.987548101892298e+00 3.862293103094006e+00 4.706739028778944e+00 9.178848039440347e+03 + 98560 9.682857415376852e-01 -5.942567309962636e+00 -6.010570211848000e+00 3.982339507049791e+00 4.591856321008974e+00 9.249498438088993e+03 + 98580 1.020978183956529e+00 -6.022745421039753e+00 -5.978059346561902e+00 3.576219760970429e+00 4.832814115769928e+00 9.149826422143668e+03 + 98600 9.365492806621833e-01 -5.899469137095376e+00 -6.037524266805685e+00 4.217140741339115e+00 4.424406822580247e+00 9.332589271380435e+03 + 98620 1.019565462554853e+00 -6.024265938861051e+00 -6.001736797850881e+00 3.518276458685270e+00 4.647642272738970e+00 9.222381048570824e+03 + 98640 9.618078078923936e-01 -5.940162798699045e+00 -5.997479217718062e+00 3.992719299090200e+00 4.663599551395821e+00 9.209308335290219e+03 + 98660 9.292765957557093e-01 -5.891452592375990e+00 -6.026780621509671e+00 4.246469091389678e+00 4.469394606159256e+00 9.299427862893612e+03 + 98680 9.959691451590806e-01 -5.989550573480208e+00 -5.971019480103821e+00 3.796293223953200e+00 4.902701629797845e+00 9.128296243595130e+03 + 98700 1.032463195418915e+00 -6.041903706218962e+00 -5.991568924680539e+00 3.495977121027370e+00 4.785007225903263e+00 9.191201367531934e+03 + 98720 9.696848431376902e-01 -5.949202099096667e+00 -6.011541528472108e+00 3.947096864492964e+00 4.589134214023664e+00 9.252514824363159e+03 + 98740 1.041345011397321e+00 -6.056753824341979e+00 -5.971489591326963e+00 3.390678850800432e+00 4.880279271370076e+00 9.129736824908408e+03 + 98760 9.875248843169359e-01 -5.976829202612000e+00 -6.034942756310860e+00 3.797988318763041e+00 4.464291300380815e+00 9.324603954745005e+03 + 98780 1.040029377061699e+00 -6.055735417809715e+00 -5.975714599360746e+00 3.424237018932851e+00 4.883728941648466e+00 9.142647154935707e+03 + 98800 9.978785727952371e-01 -5.993344285794173e+00 -5.989836508111287e+00 3.747915632792079e+00 4.768057835074051e+00 9.185881833372807e+03 + 98820 1.059227390345708e+00 -6.084329779056633e+00 -5.993439608931741e+00 3.236858480949510e+00 4.758763903015007e+00 9.196938927594572e+03 + 98840 9.760358544525087e-01 -5.962388131838336e+00 -6.059484166738013e+00 3.881049497616675e+00 4.323509039659891e+00 9.400552777440855e+03 + 98860 1.036528845541447e+00 -6.057726505900732e+00 -5.999413435183365e+00 3.363076934777406e+00 4.697919610755050e+00 9.215231574967545e+03 + 98880 1.009682081245163e+00 -6.022110368367223e+00 -5.982315601558843e+00 3.577616355575064e+00 4.806124064809050e+00 9.162834399190393e+03 + 98900 9.246569659140856e-01 -5.901339138123910e+00 -6.017039800709948e+00 4.198148698422790e+00 4.533777589234092e+00 9.269422591653618e+03 + 98920 9.742243185300661e-01 -5.979922047154438e+00 -6.004896883356059e+00 3.860733207100340e+00 4.717323832787219e+00 9.232051074567265e+03 + 98940 1.032654649582665e+00 -6.070992759923433e+00 -5.995053483782224e+00 3.314270556742737e+00 4.750325631910563e+00 9.201857217923640e+03 + 98960 9.929390720461628e-01 -6.016695884128415e+00 -6.018987324771190e+00 3.552097297672073e+00 4.538939490901967e+00 9.275434473066340e+03 + 98980 9.709092529389053e-01 -5.990961669551081e+00 -5.998130589203472e+00 3.774045680360024e+00 4.732880634329266e+00 9.211326914225698e+03 + 99000 9.365500910194682e-01 -5.950478384528167e+00 -6.034420556297377e+00 3.955126344495008e+00 4.473117404187107e+00 9.323008778537187e+03 + 99020 9.459222852644640e-01 -5.976440394723326e+00 -5.997531043196726e+00 3.849415558121755e+00 4.728309790820193e+00 9.209451664787430e+03 + 99040 9.803909251860337e-01 -6.037105982810894e+00 -5.970798131049840e+00 3.523436514670867e+00 4.904186460589742e+00 9.127621570254016e+03 + 99060 9.809531492270223e-01 -6.045901666502336e+00 -5.974250273436386e+00 3.508414190997686e+00 4.919847577999612e+00 9.138177119009462e+03 + 99080 1.013332227530993e+00 -6.100638011066140e+00 -5.955606291509411e+00 3.198156688226805e+00 5.030951265507611e+00 9.081272181402701e+03 + 99100 9.827982767602627e-01 -6.057907945769045e+00 -5.996359784278547e+00 3.415111728666065e+00 4.768530796491713e+00 9.205864836324616e+03 + 99120 9.518794766546720e-01 -6.013082182970832e+00 -5.973323500447864e+00 3.662719176077185e+00 4.891019683760305e+00 9.135319430321017e+03 + 99140 9.256701233990275e-01 -5.971087422481658e+00 -6.015355093890022e+00 3.810731818740582e+00 4.556539999113751e+00 9.264230509932298e+03 + 99160 1.000469415581789e+00 -6.072916411105292e+00 -5.976433699395782e+00 3.345835814091693e+00 4.899854475379081e+00 9.144849207927373e+03 + 99180 9.645694367827347e-01 -6.005763857184898e+00 -5.992103527061799e+00 3.662502716728523e+00 4.740942446224617e+00 9.192826106575139e+03 + 99200 1.008839558163677e+00 -6.051677555622939e+00 -5.995964218484494e+00 3.387896227878562e+00 4.707810831338572e+00 9.204678286010712e+03 + 99220 1.016656036707396e+00 -6.040469973893788e+00 -5.970824551796322e+00 3.492398872258671e+00 4.892313663536556e+00 9.127705814897497e+03 + 99240 1.027609493237614e+00 -6.031742527370802e+00 -5.963970560683904e+00 3.539221240266667e+00 4.928378360660780e+00 9.106783206470776e+03 + 99260 1.030761522860958e+00 -6.010211126193219e+00 -5.962948233586419e+00 3.676647449494065e+00 4.948038292751305e+00 9.103646846351850e+03 + 99280 1.003800942537356e+00 -5.943964767236245e+00 -5.991111735125897e+00 4.079400519550433e+00 4.808675333958346e+00 9.189738704214476e+03 + 99300 1.017278598363005e+00 -5.939412221164731e+00 -5.991942665144542e+00 3.975688958661057e+00 4.674051020269050e+00 9.192321169780622e+03 + 99320 1.071672435669186e+00 -5.994839663925203e+00 -6.010121982937882e+00 3.709289090181319e+00 4.621535649479286e+00 9.248133282940318e+03 + 99340 1.021781321655529e+00 -5.903686412389189e+00 -5.981118140015836e+00 4.223965665893259e+00 4.779340703339926e+00 9.159162028616201e+03 + 99360 1.014877149644284e+00 -5.880987928594554e+00 -5.993435868354492e+00 4.291947996303518e+00 4.646254524939518e+00 9.196876630587949e+03 + 99380 1.108875138200988e+00 -6.010802387484850e+00 -5.995333946871572e+00 3.593744565926189e+00 4.682566745661083e+00 9.202743501468720e+03 + 99400 1.049942118830350e+00 -5.921021700364034e+00 -6.068694484745020e+00 4.064056651039168e+00 4.216096670834020e+00 9.429137220876717e+03 + 99420 1.077339463585007e+00 -5.969946474623904e+00 -6.013222846713504e+00 3.834677238935047e+00 4.586177613399625e+00 9.257690906878563e+03 + 99440 1.002725670266326e+00 -5.875544093100286e+00 -5.989095307679391e+00 4.376200667399265e+00 4.724172021292380e+00 9.183578404872043e+03 + 99460 1.029516988667473e+00 -5.942020990370630e+00 -5.971686150637525e+00 3.960147444928258e+00 4.789805504007034e+00 9.130296312127672e+03 + 99480 9.679070365275639e-01 -5.882227550341687e+00 -5.979031163153371e+00 4.336255237630254e+00 4.780393912554900e+00 9.152766707296667e+03 + 99500 1.065941767094467e+00 -6.071266198834588e+00 -5.957766628277525e+00 3.357032401563716e+00 5.008764499704149e+00 9.087844845210326e+03 + 99520 1.022811256488946e+00 -6.058380185994737e+00 -5.976271655693859e+00 3.391877690072056e+00 4.863357577313694e+00 9.144359315136237e+03 + 99540 1.058794123017727e+00 -6.159636361861791e+00 -5.981296502980628e+00 2.874425799984172e+00 4.898480867683776e+00 9.159722506619599e+03 + 99560 9.822253284577154e-01 -6.085470398965114e+00 -5.994745342824838e+00 3.228796032211246e+00 4.749753344225775e+00 9.200940203816426e+03 + 99580 9.509492960713234e-01 -6.063082083590608e+00 -5.996327075789321e+00 3.351883183645151e+00 4.735200768744209e+00 9.205772327681318e+03 + 99600 9.225550646667746e-01 -6.032053639471701e+00 -6.011262540082271e+00 3.469860741386978e+00 4.589246451493315e+00 9.251654844020924e+03 + 99620 9.555262564836323e-01 -6.083343758170188e+00 -6.011785462304154e+00 3.250803003095390e+00 4.661701811568657e+00 9.253285879405550e+03 + 99640 8.747339933189782e-01 -5.960029034051134e+00 -6.035060266652488e+00 3.910279677916371e+00 4.479438729273676e+00 9.324999535487863e+03 + 99660 9.140978552864858e-01 -6.011553560159665e+00 -5.986796094725240e+00 3.663509170421389e+00 4.805670368151249e+00 9.176558240515365e+03 + 99680 9.451952833962797e-01 -6.045293498920298e+00 -5.963886067517295e+00 3.470759787612819e+00 4.938213856488158e+00 9.106522991413745e+03 + 99700 8.951558676135717e-01 -5.952641539953055e+00 -6.005778189682211e+00 3.925127348924073e+00 4.620008483309289e+00 9.234782768611209e+03 + 99720 1.018993897734596e+00 -6.116250312379456e+00 -5.962311217516648e+00 3.087636405157611e+00 4.971578509857796e+00 9.101715282390742e+03 + 99740 9.996216697365274e-01 -6.063360504359143e+00 -5.988605391729380e+00 3.352144517893611e+00 4.781399942930001e+00 9.182094096269750e+03 + 99760 9.607605003200517e-01 -5.981921229750936e+00 -5.956452959633287e+00 3.823627993309679e+00 4.969870741527285e+00 9.083838626519924e+03 + 99780 1.010376746870079e+00 -6.031253406050175e+00 -5.975283572151315e+00 3.524421227577470e+00 4.845808675128531e+00 9.141304820451775e+03 + 99800 9.803598248244347e-01 -5.963105616323153e+00 -6.007870934334797e+00 3.870292048076623e+00 4.613242664643193e+00 9.241217147433468e+03 + 99820 9.689118593309668e-01 -5.924117294360082e+00 -6.018012706591394e+00 4.137776924066238e+00 4.598614936765959e+00 9.272392822750337e+03 + 99840 1.026286565318514e+00 -5.991681472423668e+00 -5.980241637296657e+00 3.741017693518206e+00 4.806706997126271e+00 9.156463966561420e+03 + 99860 9.851550759894512e-01 -5.914199180180428e+00 -5.991047780453469e+00 4.178069447166468e+00 4.736792892116210e+00 9.189580859456793e+03 + 99880 1.046499096001062e+00 -5.992393817584341e+00 -6.024136688015793e+00 3.728347748705048e+00 4.546075274494324e+00 9.291298937488946e+03 + 99900 1.068954806511512e+00 -6.018981448854779e+00 -6.028681349010178e+00 3.533137895437664e+00 4.477439567690666e+00 9.305317209912950e+03 + 99920 1.094336014170752e+00 -6.056651201203143e+00 -6.012614343397243e+00 3.336385369392854e+00 4.589251821596051e+00 9.255815818356592e+03 + 99940 9.956681335670017e-01 -5.914800942870066e+00 -6.003531095855219e+00 4.164067363147243e+00 4.654565093759699e+00 9.227896199353645e+03 + 99960 1.003083438737440e+00 -5.930992612643508e+00 -6.070495390739425e+00 4.037344646770880e+00 4.236298106958984e+00 9.434707749602467e+03 + 99980 1.012934465883673e+00 -5.954959992992038e+00 -6.047095663015638e+00 3.924023946415882e+00 4.394966671191520e+00 9.362216377839693e+03 + 100000 1.062972901652005e+00 -6.044390689604734e+00 -5.996657400225641e+00 3.490339401527035e+00 4.764431335844447e+00 9.206787131907888e+03 + 100020 9.780183035487618e-01 -5.935605934935336e+00 -6.032377839627401e+00 4.026339373668633e+00 4.470660121522944e+00 9.316708197645956e+03 + 100040 1.034997992414912e+00 -6.040277127697238e+00 -6.024645020695599e+00 3.431678744360573e+00 4.521440721824728e+00 9.292874662229531e+03 + 100060 1.010365873372486e+00 -6.027716979883165e+00 -6.013081772465735e+00 3.535952067903067e+00 4.619989693684977e+00 9.257263845448655e+03 + 100080 9.492473111768482e-01 -5.965014880085065e+00 -5.990030472170651e+00 3.894482250357007e+00 4.750838849451208e+00 9.186458651363813e+03 + 100100 1.019481043984073e+00 -6.098361323460715e+00 -5.964602926717816e+00 3.162333129848807e+00 4.930394542991534e+00 9.108720997503182e+03 + 100120 9.641101838560518e-01 -6.047695682394565e+00 -6.000150319293153e+00 3.432187001095770e+00 4.705199833645237e+00 9.217536992816005e+03 + 100140 9.806102378523326e-01 -6.112919263920397e+00 -5.996944740338340e+00 3.086537297478054e+00 4.752480958885748e+00 9.207686688025133e+03 + 100160 9.255156940489184e-01 -6.078872407825847e+00 -5.986473118121066e+00 3.257918160499668e+00 4.788489180728395e+00 9.175574592481331e+03 + 100180 8.767278334528232e-01 -6.054073487966105e+00 -6.019906817187721e+00 3.393977756194249e+00 4.590168067078949e+00 9.278262253206571e+03 + 100200 9.442305151794494e-01 -6.199495193704019e+00 -5.964179017143159e+00 2.679077508852492e+00 5.030299409725586e+00 9.107430128307667e+03 + 100220 8.572874875612883e-01 -6.101960972229872e+00 -5.969728726180640e+00 3.182037763367895e+00 4.941335783056526e+00 9.124369594949940e+03 + 100240 8.833285435977111e-01 -6.154377213967479e+00 -5.955329994330199e+00 2.902429677238932e+00 5.045389614853877e+00 9.080434526404186e+03 + 100260 8.532637575387513e-01 -6.107982359714260e+00 -6.020202565859297e+00 3.140012347506718e+00 4.644057507701113e+00 9.279178989210624e+03 + 100280 8.593242923469000e-01 -6.106486250678866e+00 -6.030366878195771e+00 3.110991183301837e+00 4.548080399534595e+00 9.310509240679545e+03 + 100300 8.660085698553831e-01 -6.100373630161558e+00 -5.994550636387740e+00 3.186121646811874e+00 4.793773653116498e+00 9.200333232884090e+03 + 100320 9.069261671425608e-01 -6.140838465205085e+00 -5.989875799562621e+00 2.929218513359653e+00 4.796069500875689e+00 9.186011009382817e+03 + 100340 9.393740320344086e-01 -6.168036928163246e+00 -5.994440320434852e+00 2.815969390177889e+00 4.812787975742550e+00 9.200003785749032e+03 + 100360 9.060580313734133e-01 -6.097772706163690e+00 -5.972869546733383e+00 3.204539782447073e+00 4.921753052597351e+00 9.133970940818375e+03 + 100380 9.377925985262099e-01 -6.120868320687856e+00 -5.954298022639589e+00 3.122445119340713e+00 5.078917547404179e+00 9.077287330549330e+03 + 100400 9.047871351241796e-01 -6.042531150221211e+00 -6.022185711653732e+00 3.456266132801576e+00 4.573092789502486e+00 9.285262171819095e+03 + 100420 9.533624670846478e-01 -6.084174405660979e+00 -6.021888717856658e+00 3.181178394983661e+00 4.538832453035113e+00 9.284375573143105e+03 + 100440 9.789284036689726e-01 -6.090519191535884e+00 -5.993369294251552e+00 3.252356550101631e+00 4.810206294206278e+00 9.196716513911831e+03 + 100460 1.015163842256240e+00 -6.112483658720968e+00 -5.981638299240600e+00 3.110914720033351e+00 4.862249022423564e+00 9.160789803461006e+03 + 100480 9.137136936695620e-01 -5.934028729419394e+00 -6.016839632222270e+00 4.055240436173072e+00 4.579727417333164e+00 9.268801913402584e+03 + 100500 9.984968666909527e-01 -6.032985466422749e+00 -6.002698409689364e+00 3.556257106040528e+00 4.730170072710509e+00 9.225321724169677e+03 + 100520 9.774127467092016e-01 -5.973843070416264e+00 -5.986647613550137e+00 3.837536583709315e+00 4.764010915537969e+00 9.176104014627150e+03 + 100540 9.602483478850309e-01 -5.924929722496405e+00 -6.018961063831163e+00 4.067970473907312e+00 4.528027960660086e+00 9.275331356651404e+03 + 100560 1.049784168371287e+00 -6.034166685358835e+00 -6.025867035968425e+00 3.492710352196414e+00 4.540368223362742e+00 9.296653040245232e+03 + 100580 9.868640247497810e-01 -5.921728186512888e+00 -6.069287058763448e+00 4.115040745624032e+00 4.267734866499628e+00 9.430962482544479e+03 + 100600 1.035881680106078e+00 -5.982818410307177e+00 -6.012639016238605e+00 3.772036075934060e+00 4.600801541951944e+00 9.255887620920523e+03 + 100620 1.015377042959121e+00 -5.943194898282735e+00 -5.976030029100277e+00 4.005427929241881e+00 4.816883526867480e+00 9.143623098295284e+03 + 100640 1.087151555760555e+00 -6.043649554964161e+00 -5.953475612120508e+00 3.509200044145582e+00 5.026992778326393e+00 9.074768238159428e+03 + 100660 9.638277359349815e-01 -5.856825200435729e+00 -6.040086277234727e+00 4.426740967251023e+00 4.374427504711195e+00 9.340492166701464e+03 + 100680 1.006675899751647e+00 -5.918879723934095e+00 -6.031883488116287e+00 4.104550627091498e+00 4.455665525881368e+00 9.315180002178417e+03 + 100700 1.017813001005820e+00 -5.936562656025433e+00 -6.051335375085548e+00 4.012628410105408e+00 4.353585696241354e+00 9.375305535650477e+03 + 100720 1.060193858176878e+00 -6.005479800804906e+00 -5.985352192009938e+00 3.651251330826768e+00 4.766827175264866e+00 9.172145240523674e+03 + 100740 1.055671757827548e+00 -6.013221657023240e+00 -5.995837637289329e+00 3.605689575628191e+00 4.705511307108671e+00 9.204272887399851e+03 + 100760 1.019310288572452e+00 -5.981817723218516e+00 -5.998984582013918e+00 3.783560591378623e+00 4.684985831612606e+00 9.213921836147894e+03 + 100780 9.631077538416098e-01 -5.927197838046984e+00 -5.992615981466082e+00 4.047839303520298e+00 4.672198200582866e+00 9.194368661634262e+03 + 100800 9.857933378945777e-01 -5.991397319528757e+00 -5.973398745472402e+00 3.730535461793361e+00 4.833886059295287e+00 9.135549284454331e+03 + 100820 1.036655997236422e+00 -6.100653719614871e+00 -5.985275835310269e+00 3.190540234238702e+00 4.853057900585622e+00 9.171916299375427e+03 + 100840 9.750349435615300e-01 -6.047714877556496e+00 -6.039618699574707e+00 3.382906902951635e+00 4.429396409802560e+00 9.339093552358841e+03 + 100860 8.839410117889959e-01 -5.949838549771998e+00 -6.048137019762769e+00 3.921831303387532e+00 4.357386277061457e+00 9.365427602448244e+03 + 100880 9.937362187952904e-01 -6.142192353142942e+00 -5.971703613445995e+00 2.933154025055857e+00 4.912126751442930e+00 9.130407200453566e+03 + 100900 9.226994266063544e-01 -6.056721915512626e+00 -5.974467643858817e+00 3.373274291431223e+00 4.845591048074799e+00 9.138843800849829e+03 + 100920 9.093961564665842e-01 -6.046309015530457e+00 -5.953849754721837e+00 3.482541244636556e+00 5.013456628224022e+00 9.075902538380918e+03 + 100940 9.572969621982892e-01 -6.116066491803966e+00 -5.981968076353875e+00 3.043971463168673e+00 4.813985316345826e+00 9.161802198627049e+03 + 100960 9.353459686906812e-01 -6.076186430988813e+00 -6.011161264279182e+00 3.264534682702675e+00 4.637919252561407e+00 9.251362290671912e+03 + 100980 8.945625098448653e-01 -6.002891590562407e+00 -6.040151393749893e+00 3.672352833672827e+00 4.458401277834374e+00 9.340720771391449e+03 + 101000 1.007097240898692e+00 -6.152357210632755e+00 -6.012726023836732e+00 2.865806356562070e+00 4.667590239001153e+00 9.256180843405014e+03 + 101020 9.682424783515066e-01 -6.077427670344536e+00 -6.018653996995497e+00 3.287808420723439e+00 4.625295948290173e+00 9.274421727432837e+03 + 101040 9.109863786029121e-01 -5.975653725391035e+00 -5.999773142860222e+00 3.832656028165771e+00 4.694158600589907e+00 9.216328671461768e+03 + 101060 9.899715085524814e-01 -6.074204104603679e+00 -5.914470629549521e+00 3.326602188468748e+00 5.243816520905099e+00 8.956316983048988e+03 + 101080 9.578817069469188e-01 -6.006899361952392e+00 -5.952292892643311e+00 3.638223517738996e+00 4.951782314835554e+00 9.071157296019177e+03 + 101100 9.816775007827090e-01 -6.023616786181672e+00 -5.936282999614134e+00 3.596558663148980e+00 5.098042780479576e+00 9.022465328503416e+03 + 101120 1.001682557954440e+00 -6.037188853853555e+00 -5.948704492932523e+00 3.549611297527648e+00 5.057702190846816e+00 9.060231266656479e+03 + 101140 1.020975968148115e+00 -6.052483583097100e+00 -5.982212052644795e+00 3.392462880628071e+00 4.795972882969400e+00 9.162522168841808e+03 + 101160 1.036021145125109e+00 -6.065440190988513e+00 -5.967099598892997e+00 3.356176021890783e+00 4.920862919860683e+00 9.116326563810067e+03 + 101180 9.843811456170581e-01 -5.980425150559148e+00 -6.002946509380022e+00 3.762970013326112e+00 4.633648885807637e+00 9.226083492841661e+03 + 101200 1.029258256681424e+00 -6.039303126750229e+00 -5.972034157629869e+00 3.526360417488218e+00 4.912629248016654e+00 9.131398619461372e+03 + 101220 9.774984046485601e-01 -5.955089344204183e+00 -6.045448527475577e+00 3.882181905740665e+00 4.363325492357903e+00 9.357097848228639e+03 + 101240 1.038793997328380e+00 -6.041919734214170e+00 -5.999217687659444e+00 3.489469498378042e+00 4.734671257815627e+00 9.214645990126655e+03 + 101260 1.007121655932749e+00 -5.990703629041919e+00 -6.001748647182947e+00 3.744801907686079e+00 4.681379704309261e+00 9.222398329655942e+03 + 101280 9.891871087673209e-01 -5.961471812782212e+00 -6.004799128948194e+00 3.909244774832827e+00 4.660452620527250e+00 9.231784050477716e+03 + 101300 9.883338423665716e-01 -5.956024934790515e+00 -6.033916880429415e+00 3.884018820873763e+00 4.436751215275569e+00 9.321477534182899e+03 + 101320 9.659041863583564e-01 -5.923058214239525e+00 -6.048243109143741e+00 4.105724543028662e+00 4.386893504188776e+00 9.365734108144170e+03 + 101340 1.029394385414468e+00 -6.017859229235836e+00 -6.011421091882060e+00 3.590142313315520e+00 4.627111094299442e+00 9.252117930160901e+03 + 101360 1.028960242331709e+00 -6.019277947742731e+00 -5.974780977654635e+00 3.587697631218004e+00 4.843206119347720e+00 9.139787842762191e+03 + 101380 9.366773310655057e-01 -5.884536170075807e+00 -6.007117824025785e+00 4.337566156951249e+00 4.633683330520838e+00 9.238902274039394e+03 + 101400 1.057640004402490e+00 -6.067140100820897e+00 -5.997592968108460e+00 3.328631095328262e+00 4.727981493747075e+00 9.209667606592535e+03 + 101420 1.013317151952374e+00 -6.008842044897172e+00 -6.013934024710197e+00 3.677700148198430e+00 4.648461212130706e+00 9.259877071005771e+03 + 101440 9.914279234521434e-01 -5.988450627275144e+00 -5.995839084296926e+00 3.735315486652009e+00 4.692889823072907e+00 9.204262401129097e+03 + 101460 9.604415831123704e-01 -5.956414237933885e+00 -5.981959153946685e+00 3.951436075798327e+00 4.804753214989846e+00 9.161735523205531e+03 + 101480 9.826549488757179e-01 -6.006111446344230e+00 -5.986821967309617e+00 3.686041491640268e+00 4.796804665294244e+00 9.176625794224279e+03 + 101500 9.185605066259660e-01 -5.929891768503246e+00 -6.015573726971649e+00 4.051194913295744e+00 4.559195848529958e+00 9.264917275112177e+03 + 101520 1.007474660754397e+00 -6.082216961590505e+00 -5.968559742223727e+00 3.269491393831699e+00 4.922128735833590e+00 9.120783914220039e+03 + 101540 9.739264263153941e-01 -6.053071761563012e+00 -5.998876716461096e+00 3.369984525086207e+00 4.681180860717532e+00 9.213588547091762e+03 + 101560 9.739561689759898e-01 -6.071857068057283e+00 -5.957182262464443e+00 3.329813896350699e+00 4.988294375933596e+00 9.086044997147723e+03 + 101580 9.082922123164494e-01 -5.988186510096731e+00 -5.975300973175617e+00 3.808612947054959e+00 4.882603694086386e+00 9.141375894465195e+03 + 101600 1.008716079166220e+00 -6.147424834500163e+00 -5.961916549689809e+00 2.918363597304027e+00 4.983580875999381e+00 9.100510643689204e+03 + 101620 9.027510530867555e-01 -5.995214330999248e+00 -6.001572382789266e+00 3.721053530977616e+00 4.684544613694005e+00 9.221867232898334e+03 + 101640 8.990105207723826e-01 -5.988797140061149e+00 -6.001308770140353e+00 3.761231773630077e+00 4.689388057546790e+00 9.221033933816976e+03 + 101660 9.837287594899669e-01 -6.106075708217997e+00 -5.942320551825516e+00 3.140328864400252e+00 5.080636313434434e+00 9.040829735355292e+03 + 101680 9.839964472507730e-01 -6.088501002137917e+00 -5.978564562061680e+00 3.257934814138749e+00 4.889206865665622e+00 9.151346079718078e+03 + 101700 8.998725954594972e-01 -5.937203787927618e+00 -5.991430673143959e+00 4.069256987677687e+00 4.757877821182096e+00 9.190734870959377e+03 + 101720 9.584507620791305e-01 -5.990080991235868e+00 -5.954570580544472e+00 3.776006365622526e+00 4.979912639030818e+00 9.078117233613768e+03 + 101740 1.074195628820944e+00 -6.118345332345856e+00 -5.996834634356460e+00 3.078714597090752e+00 4.776447828665612e+00 9.207346875714929e+03 + 101760 9.975630632982665e-01 -5.964452416696236e+00 -6.040247372924095e+00 3.890156926147666e+00 4.454930558255731e+00 9.341017239616556e+03 + 101780 1.030779053460655e+00 -5.983791771601370e+00 -5.986858405210491e+00 3.768457490131156e+00 4.750848405387567e+00 9.176747171420024e+03 + 101800 9.499203968184334e-01 -5.841046272572973e+00 -5.985796161677404e+00 4.538395155571345e+00 4.707218892360758e+00 9.173453767339599e+03 + 101820 1.022631625010143e+00 -5.930656606035607e+00 -5.956416697547983e+00 4.062287453239673e+00 4.914369021414336e+00 9.083713340291331e+03 + 101840 1.016083768945952e+00 -5.906994849259053e+00 -5.981610031344508e+00 4.164973608576418e+00 4.736521686379625e+00 9.160673332576644e+03 + 101860 1.006727395718670e+00 -5.883027716143106e+00 -6.004768953988706e+00 4.296854180447539e+00 4.597797153342432e+00 9.231657783925808e+03 + 101880 1.030957003240001e+00 -5.913847051863245e+00 -5.994618573319919e+00 4.138600944540732e+00 4.674798368983963e+00 9.200531139687391e+03 + 101900 1.032740515454383e+00 -5.918454485631105e+00 -6.001661671066220e+00 4.120488024336893e+00 4.642699489298129e+00 9.222150836129229e+03 + 101920 1.070990550168926e+00 -5.983130721955577e+00 -5.968813583460571e+00 3.850182094833615e+00 4.932393319641958e+00 9.121539066131550e+03 + 101940 1.082146564324805e+00 -6.010317052770758e+00 -5.995130148973187e+00 3.608595300407372e+00 4.695800852178793e+00 9.202091897591106e+03 + 101960 1.062019055313294e+00 -5.996622225244831e+00 -5.991270737274126e+00 3.672174562862318e+00 4.702903634930191e+00 9.190264297615813e+03 + 101980 1.037675104204773e+00 -5.980894194486095e+00 -5.943421403371779e+00 3.827790640461529e+00 5.042965205935616e+00 9.044171900144223e+03 + 102000 9.290465237472584e-01 -5.840053512714679e+00 -6.006616359799027e+00 4.551564860316942e+00 4.595135216841331e+00 9.237320467764912e+03 + 102020 1.061753800471555e+00 -6.055055527977044e+00 -5.971465632145693e+00 3.385717672055663e+00 4.865703789413850e+00 9.129660443336941e+03 + 102040 1.064687641763740e+00 -6.079261024351871e+00 -6.009796142891894e+00 3.248945291623373e+00 4.647823390622229e+00 9.247159486149183e+03 + 102060 1.003203182573880e+00 -6.008926689862084e+00 -6.014648360948494e+00 3.649211903838844e+00 4.616357183034942e+00 9.262040791635132e+03 + 102080 9.996257237518327e-01 -6.023527863795289e+00 -5.964532853051525e+00 3.627654313613738e+00 4.966412794752839e+00 9.108489154505236e+03 + 102100 9.798604551400375e-01 -6.011074436363378e+00 -5.989878483371088e+00 3.640379767508316e+00 4.762090209653170e+00 9.185996408221976e+03 + 102120 9.522672018460635e-01 -5.981360165408058e+00 -5.986843593093832e+00 3.791993250987612e+00 4.760506560658209e+00 9.176696139788115e+03 + 102140 9.717607147436272e-01 -6.016337879934411e+00 -5.972566483849876e+00 3.624907765051212e+00 4.876249894970261e+00 9.133024192733050e+03 + 102160 1.009680504449233e+00 -6.074812756287566e+00 -5.993002506875195e+00 3.252656963659511e+00 4.722424075880525e+00 9.195572883242698e+03 + 102180 1.002481113852266e+00 -6.065281686392694e+00 -5.954228754074725e+00 3.417386625643457e+00 5.055069748398971e+00 9.077057563568209e+03 + 102200 9.215813065338511e-01 -5.943575197912219e+00 -5.956254010024201e+00 4.029109106870445e+00 4.956305405683612e+00 9.083209035456430e+03 + 102220 9.771102168096590e-01 -6.020247367307710e+00 -5.958946963352268e+00 3.629440653641275e+00 4.981437059360276e+00 9.091424298496071e+03 + 102240 1.020747119838501e+00 -6.076541652954631e+00 -5.939134455750528e+00 3.307561947812924e+00 5.096575337853927e+00 9.031131220798519e+03 + 102260 9.846756968227426e-01 -6.013323537235996e+00 -5.969373371562321e+00 3.637400420244760e+00 4.889769072809155e+00 9.123256252973501e+03 + 102280 9.990269408611224e-01 -6.026534326048061e+00 -5.972729408143976e+00 3.565078151615403e+00 4.874034316504799e+00 9.133518342576930e+03 + 102300 1.036570020436729e+00 -6.073955133974354e+00 -6.012501877448903e+00 3.306316572650746e+00 4.659190681480597e+00 9.255454872840704e+03 + 102320 9.839686789133919e-01 -5.989027157010910e+00 -5.992793681877092e+00 3.742050558858453e+00 4.720422590208995e+00 9.194930273272295e+03 + 102340 9.680634481434230e-01 -5.956919895848667e+00 -6.004657540120808e+00 3.932279630783515e+00 4.658162689996304e+00 9.231358099451512e+03 + 102360 1.088366658990135e+00 -6.124841926596485e+00 -5.998506216919423e+00 3.053616244581426e+00 4.779055439935005e+00 9.212481357386307e+03 + 102380 1.032908287042935e+00 -6.035966268490765e+00 -6.045412888173992e+00 3.454515144187926e+00 4.400271192107166e+00 9.356978666131694e+03 + 102400 9.357164865696359e-01 -5.889202293764789e+00 -6.029845515814766e+00 4.300788055600375e+00 4.493192910121133e+00 9.308872703824496e+03 + 102420 1.023028764472847e+00 -6.014704542647066e+00 -5.956662339171401e+00 3.634723300352436e+00 4.968010614711664e+00 9.084473324300878e+03 + 102440 1.003945452372866e+00 -5.980831755584470e+00 -5.967796581104124e+00 3.856295710452611e+00 4.931145699505488e+00 9.118419724486017e+03 + 102460 1.024351873119819e+00 -6.005668068815700e+00 -5.934463089363012e+00 3.677315445322082e+00 5.086185456274375e+00 9.016924560118925e+03 + 102480 9.140269968461661e-01 -5.833281277050589e+00 -6.004867220162892e+00 4.667580899795203e+00 4.682307861605478e+00 9.231918801334199e+03 + 102500 1.054633486766537e+00 -6.028348643083262e+00 -5.909972155804767e+00 3.613602460233535e+00 5.293338568888855e+00 8.942658855595282e+03 + 102520 9.997339246463391e-01 -5.929253337825822e+00 -6.018585371036846e+00 4.095603998962992e+00 4.582645640177833e+00 9.274166998420587e+03 + 102540 1.097775429290218e+00 -6.055046339492148e+00 -5.960019441773714e+00 3.403347413231200e+00 4.949006565295349e+00 9.094742168597224e+03 + 102560 1.112741281684360e+00 -6.057800960619240e+00 -5.996198015093923e+00 3.393864035957239e+00 4.747597682188616e+00 9.205398330823287e+03 + 102580 1.061709555505745e+00 -5.965108843228836e+00 -6.036267839658858e+00 3.883302704302224e+00 4.474696734981928e+00 9.328721849516653e+03 + 102600 1.098873507068703e+00 -6.005556161104908e+00 -6.036726730587064e+00 3.626812214895079e+00 4.447825981298500e+00 9.330151093638462e+03 + 102620 9.920530420448126e-01 -5.839126066855249e+00 -6.047485832598425e+00 4.558412653959206e+00 4.361978635492346e+00 9.363401680979960e+03 + 102640 9.920273238403482e-01 -5.838073771808532e+00 -6.047597583023024e+00 4.556190885904817e+00 4.353072738206211e+00 9.363708618374740e+03 + 102660 1.018103693611234e+00 -5.880475544292482e+00 -6.004506602709692e+00 4.396015912981693e+00 4.683810381805816e+00 9.230899753263024e+03 + 102680 1.071902468627157e+00 -5.972062061971813e+00 -6.009699895224006e+00 3.830912895717311e+00 4.614790632747346e+00 9.246854180699143e+03 + 102700 1.026794913080226e+00 -5.927015568132211e+00 -6.017950692152267e+00 4.046206279096079e+00 4.524042724807956e+00 9.272227021387875e+03 + 102720 1.011763397166067e+00 -5.934299284154073e+00 -5.998767614455263e+00 4.036934364990429e+00 4.666747235959129e+00 9.213264734411996e+03 + 102740 9.824350501614538e-01 -5.926702612441244e+00 -6.026873056087711e+00 4.110714196794412e+00 4.535520008050344e+00 9.299738722098053e+03 + 102760 9.992873195294190e-01 -5.992536483632530e+00 -6.012667477233349e+00 3.764080629475511e+00 4.648485348958416e+00 9.255982399960631e+03 + 102780 9.819857026703240e-01 -6.004942688058772e+00 -5.985806777702638e+00 3.610113150657936e+00 4.719994509195416e+00 9.173541408721398e+03 + 102800 9.610345361265519e-01 -6.004742328254198e+00 -5.991380376126287e+00 3.674106363585933e+00 4.750832760459810e+00 9.190615366420170e+03 + 102820 9.492874336404654e-01 -6.011611293058272e+00 -5.996050062279035e+00 3.614022299033722e+00 4.703377294260784e+00 9.204934649494277e+03 + 102840 1.002617810658044e+00 -6.106949753631569e+00 -5.974084159706696e+00 3.069057364849980e+00 4.831992166050810e+00 9.137647777169968e+03 + 102860 9.355561186247258e-01 -6.016331266662639e+00 -5.961420089293017e+00 3.633734624933144e+00 4.949043102866746e+00 9.098988838351468e+03 + 102880 1.019758508338917e+00 -6.144669201944036e+00 -5.953745452553227e+00 2.906034753782976e+00 5.002348468139740e+00 9.075611174980882e+03 + 102900 9.108753363314325e-01 -5.981387965494305e+00 -5.942423633110744e+00 3.831800104745987e+00 5.055539331003342e+00 9.041148199279072e+03 + 102920 9.663728422997060e-01 -6.056113851731299e+00 -5.969149638461072e+00 3.405498377183684e+00 4.904860347449833e+00 9.122575083509802e+03 + 102940 9.906237393309343e-01 -6.078362554061020e+00 -5.952531407531639e+00 3.284831254999765e+00 5.007373170678461e+00 9.071895677210907e+03 + 102960 9.945157925458596e-01 -6.065990029626469e+00 -5.981725649415072e+00 3.374635102858494e+00 4.858494213903035e+00 9.161030999877923e+03 + 102980 1.026295831117905e+00 -6.090697291440361e+00 -5.956490743246134e+00 3.241204810944265e+00 5.011839579071735e+00 9.083973775283817e+03 + 103000 9.725499152414500e-01 -5.984571290341727e+00 -6.000072045497295e+00 3.798827103030711e+00 4.709819368193330e+00 9.217256920221454e+03 + 103020 9.719212474724186e-01 -5.955362041961366e+00 -6.033178792224249e+00 3.930545409531466e+00 4.483709587418804e+00 9.319191346672596e+03 + 103040 9.823254318652012e-01 -5.943111402582956e+00 -6.042397053406411e+00 3.991347660433152e+00 4.421234089000065e+00 9.347670937405186e+03 + 103060 1.028346330348965e+00 -5.986690504644678e+00 -6.021985133002151e+00 3.791562792748299e+00 4.588895574893602e+00 9.284664449102378e+03 + 103080 1.023895676385180e+00 -5.960652852573555e+00 -6.002837967186784e+00 3.892799824791755e+00 4.650566368557206e+00 9.225748041606814e+03 + 103100 1.032950664640704e+00 -5.957487946195279e+00 -6.017415591859657e+00 3.872238852464943e+00 4.528125037286890e+00 9.270588533747103e+03 + 103120 1.057721738926984e+00 -5.983731068070418e+00 -6.030700483420237e+00 3.783781742718155e+00 4.514076091285967e+00 9.311525636412061e+03 + 103140 1.028835362629499e+00 -5.936049527757817e+00 -6.008334418033138e+00 4.030634950178421e+00 4.615563924166904e+00 9.242634405186103e+03 + 103160 1.015900552152952e+00 -5.917170938706128e+00 -6.016197680186153e+00 4.105376437943431e+00 4.536749564026407e+00 9.266832514596956e+03 + 103180 9.926504085547385e-01 -5.886041832053923e+00 -6.022261712095927e+00 4.287804280238852e+00 4.505608649079358e+00 9.285534431033706e+03 + 103200 1.008630634025778e+00 -5.918023717264153e+00 -6.026750631333611e+00 4.106793770366767e+00 4.482467004344366e+00 9.299346909653610e+03 + 103220 1.066139281982735e+00 -6.011450254420664e+00 -5.977744912898782e+00 3.630112043417558e+00 4.823653330320951e+00 9.148851754807185e+03 + 103240 9.475554945175878e-01 -5.843118910069766e+00 -6.043158200007391e+00 4.495338456896492e+00 4.346681898094578e+00 9.349937008769350e+03 + 103260 1.014397881365901e+00 -5.947075958592428e+00 -5.990174001472512e+00 3.965204020399889e+00 4.717728388781864e+00 9.186878307713774e+03 + 103280 1.070296927975811e+00 -6.035518493287461e+00 -6.004142027099994e+00 3.515923163619697e+00 4.696091687960584e+00 9.229775031015499e+03 + 103300 1.001717353482652e+00 -5.943041829863142e+00 -6.049862702278404e+00 3.923702867323523e+00 4.310320887438506e+00 9.370763899424686e+03 + 103320 1.098273865990784e+00 -6.098777517768338e+00 -5.986135696074906e+00 3.141952993217807e+00 4.788759764647062e+00 9.174547356471514e+03 + 103340 9.447081691414296e-01 -5.882965400830144e+00 -5.975136925306215e+00 4.397336454963920e+00 4.868073297925008e+00 9.140862902680097e+03 + 103360 1.047841255098890e+00 -6.046568138596911e+00 -5.947440092976795e+00 3.462287352244073e+00 5.031495930210267e+00 9.056396107553719e+03 + 103380 1.023279324565084e+00 -6.020213145244178e+00 -5.934366911459962e+00 3.618633105185036e+00 5.111575464235741e+00 9.016659690898405e+03 + 103400 1.033517203842246e+00 -6.045646142398348e+00 -5.960558960312877e+00 3.464099683471211e+00 4.952683450204860e+00 9.096370496193813e+03 + 103420 9.864800333888757e-01 -5.987108977497422e+00 -6.008095184726175e+00 3.723205348878352e+00 4.602699299365778e+00 9.241900035838566e+03 + 103440 1.005477626004460e+00 -6.025827944013725e+00 -5.936774306163747e+00 3.593034989007278e+00 5.104394758547765e+00 9.023986357976610e+03 + 103460 9.700948607261248e-01 -5.980931548076952e+00 -6.009309666127127e+00 3.754392132193483e+00 4.591440586849806e+00 9.245632445383948e+03 + 103480 9.390563229819970e-01 -5.942461304128074e+00 -5.998000560522383e+00 3.971638764560991e+00 4.652723759672718e+00 9.210909704898704e+03 + 103500 1.013645385668224e+00 -6.060594408548798e+00 -5.976823242092190e+00 3.381153166630103e+00 4.862180167970058e+00 9.146041684533249e+03 + 103520 9.622424202860576e-01 -5.988684777611582e+00 -5.996734085477766e+00 3.750470848226372e+00 4.704250476832377e+00 9.207037231916005e+03 + 103540 9.693710217533541e-01 -6.002952804425790e+00 -6.023650780979890e+00 3.725780156545635e+00 4.606929172170471e+00 9.289788854227263e+03 + 103560 9.862142378748613e-01 -6.030790389171772e+00 -6.037934067100665e+00 3.506099275651178e+00 4.465079171502884e+00 9.333867406358258e+03 + 103580 9.750981345309618e-01 -6.015123344578337e+00 -6.013971334577112e+00 3.614599307248624e+00 4.621214326948630e+00 9.259994408531435e+03 + 103600 9.152849680456570e-01 -5.925379240326100e+00 -6.050650458178660e+00 4.085739528624049e+00 4.366412810056334e+00 9.373212787978413e+03 + 103620 9.633755419430937e-01 -5.997136064695538e+00 -6.006226979673117e+00 3.646732359830492e+00 4.594530919214690e+00 9.236212689404643e+03 + 103640 9.758691552968004e-01 -6.011604520741629e+00 -6.031801865404769e+00 3.570830495480875e+00 4.454854216896138e+00 9.314938601228791e+03 + 103660 9.624439714864539e-01 -5.983379267622171e+00 -6.007822256252192e+00 3.801911042670776e+00 4.661555619416928e+00 9.241075504622131e+03 + 103680 9.636246517979022e-01 -5.974179335409521e+00 -6.008562175633960e+00 3.882749739126072e+00 4.685318149830014e+00 9.243334530132095e+03 + 103700 1.082703717230432e+00 -6.135421518856424e+00 -5.954547093877345e+00 2.993018058568651e+00 5.031626997025326e+00 9.078058459809345e+03 + 103720 9.986899297910585e-01 -5.991822195755709e+00 -6.004331179177130e+00 3.757642283887143e+00 4.685813765322422e+00 9.230357452216220e+03 + 103740 1.041909064262124e+00 -6.034906623045894e+00 -5.987157107300193e+00 3.523395671513477e+00 4.797580780138976e+00 9.177670397223088e+03 + 103760 1.021254534752863e+00 -5.981693531352284e+00 -6.007341864281217e+00 3.754020372675727e+00 4.606743675931103e+00 9.239610973320312e+03 + 103780 1.037759304288606e+00 -5.983002775060128e+00 -6.029859116286691e+00 3.795252080701149e+00 4.526195718382855e+00 9.308939090163671e+03 + 103800 9.920143327540843e-01 -5.897717420232488e+00 -6.042513738984375e+00 4.236674454513137e+00 4.405231585081894e+00 9.348013086083402e+03 + 103820 1.030242372413415e+00 -5.938828834899090e+00 -6.032478920542021e+00 3.998589159147353e+00 4.460835875081733e+00 9.317018424776499e+03 + 103840 1.065639152735993e+00 -5.978327799657965e+00 -6.029824142124843e+00 3.825753320092641e+00 4.530053352614585e+00 9.308829763211987e+03 + 103860 1.065005816092460e+00 -5.971950904828680e+00 -5.997144889356831e+00 3.871706566042491e+00 4.727038808125343e+00 9.208280081579698e+03 + 103880 1.033747478372948e+00 -5.925460133378209e+00 -5.979278398810651e+00 4.113801420433663e+00 4.804768611970920e+00 9.153535157415545e+03 + 103900 1.031937850017791e+00 -5.927566912243503e+00 -5.986257423509677e+00 4.102170966068723e+00 4.765160968051084e+00 9.174876345096254e+03 + 103920 1.028953700003142e+00 -5.931670458948601e+00 -5.994536615399046e+00 4.047164988054305e+00 4.686177789209587e+00 9.200265498185414e+03 + 103940 9.822986061799203e-01 -5.875976325296216e+00 -6.044438232755414e+00 4.372059817196708e+00 4.404725475170063e+00 9.353943972485660e+03 + 103960 1.035013368919372e+00 -5.978680874094852e+00 -5.971532390620062e+00 3.839712239238970e+00 4.880759937575455e+00 9.129851971538166e+03 + 103980 1.000963240260506e+00 -5.960151381703207e+00 -5.991896613358709e+00 3.927845980289018e+00 4.745559947564405e+00 9.192171703084543e+03 + 104000 9.693198711987306e-01 -5.950982262641352e+00 -5.984112209555482e+00 3.954786347698112e+00 4.764549065674465e+00 9.168320658761953e+03 + 104020 9.910175466393640e-01 -6.022406185207772e+00 -5.982658269784457e+00 3.543854783082647e+00 4.772093464413354e+00 9.163904124747945e+03 + 104040 9.321241205351800e-01 -5.972894144082296e+00 -5.998900533178224e+00 3.790865967187886e+00 4.641533256523354e+00 9.213677166199643e+03 + 104060 9.835610255200857e-01 -6.076352638188885e+00 -5.963514737160571e+00 3.249721848383441e+00 4.897654537696774e+00 9.105362065212330e+03 + 104080 9.925166611541496e-01 -6.107614473469750e+00 -5.954581864699094e+00 3.121881070865594e+00 5.000617992146368e+00 9.078151849817394e+03 + 104100 9.655376638433285e-01 -6.079750662511536e+00 -5.954386137839942e+00 3.273301568128511e+00 4.993164068890298e+00 9.077561846506536e+03 + 104120 9.775975905544849e-01 -6.104111539236563e+00 -5.996124499991829e+00 3.094194036918030e+00 4.714272327201609e+00 9.205165471719885e+03 + 104140 9.353675310957967e-01 -6.042014549653300e+00 -5.998522078520279e+00 3.462225770691547e+00 4.711966270375512e+00 9.212507784069674e+03 + 104160 9.397603708757832e-01 -6.044109070382286e+00 -5.974586286802007e+00 3.425715175659484e+00 4.824925757593443e+00 9.139193186313223e+03 + 104180 9.586209805341478e-01 -6.060251136347024e+00 -5.989522995243556e+00 3.352610299709581e+00 4.758742231070160e+00 9.184925412295386e+03 + 104200 9.739897311753875e-01 -6.066040355596651e+00 -6.011849750547012e+00 3.315864667116921e+00 4.627035507280979e+00 9.253476116742144e+03 + 104220 9.807369395464633e-01 -6.056762606875711e+00 -6.021534490084642e+00 3.385007838978316e+00 4.587293137126094e+00 9.283276205606597e+03 + 104240 9.528147464393546e-01 -5.995087068814679e+00 -5.989802205383183e+00 3.720391855401656e+00 4.750738359055280e+00 9.185773172905450e+03 + 104260 9.926872168068060e-01 -6.031462019326611e+00 -5.977620601401347e+00 3.547411542283834e+00 4.856577295943195e+00 9.148478551738992e+03 + 104280 9.502287802096923e-01 -5.945336580724386e+00 -6.020380720619205e+00 3.932970831956793e+00 4.502055767637624e+00 9.279714728057412e+03 + 104300 9.751181068548407e-01 -5.961368585220277e+00 -5.991105909065865e+00 3.919080281764181e+00 4.748323966406820e+00 9.189747617922332e+03 + 104320 9.700454384546505e-01 -5.935057747931977e+00 -6.041112518160244e+00 4.042138667610700e+00 4.433155765037340e+00 9.343661398794542e+03 + 104340 1.003565493837550e+00 -5.971584185300197e+00 -6.012068389937415e+00 3.903561036581533e+00 4.671094468644205e+00 9.254132507489194e+03 + 104360 1.074798503256915e+00 -6.068876104094773e+00 -6.016719673467660e+00 3.322097436165564e+00 4.621587732008004e+00 9.268465952540371e+03 + 104380 9.868414236524773e-01 -5.937339008212841e+00 -6.062303937679824e+00 4.029029408833599e+00 4.311461445573845e+00 9.409306844069464e+03 + 104400 9.701227785632360e-01 -5.913966938762283e+00 -6.051862433404376e+00 4.147025951324292e+00 4.355208681830563e+00 9.376938087555123e+03 + 104420 9.852356516239719e-01 -5.938479950930378e+00 -6.032991740192526e+00 4.032851537148400e+00 4.490150217553029e+00 9.318597267496085e+03 + 104440 1.022252128369149e+00 -5.996899164854052e+00 -5.995451895774616e+00 3.702413021382420e+00 4.710723464400709e+00 9.203079411255898e+03 + 104460 1.029970841244083e+00 -6.012166747149455e+00 -6.019080811819874e+00 3.650401681822279e+00 4.610700052536682e+00 9.275725133893726e+03 + 104480 9.792568353452149e-01 -5.941983240225955e+00 -6.039784583030621e+00 4.043954126050126e+00 4.482363680956849e+00 9.339598107751079e+03 + 104500 1.044383215718332e+00 -6.046719403018159e+00 -6.018773820008676e+00 3.472631048440344e+00 4.633098910645788e+00 9.274767933591618e+03 + 104520 1.021392963953418e+00 -6.021841761341529e+00 -5.994875047574334e+00 3.596567435284445e+00 4.751414478821145e+00 9.201314042456797e+03 + 104540 1.046963928914459e+00 -6.070779587491327e+00 -5.974819993290101e+00 3.313057933597916e+00 4.864072773200562e+00 9.139897198949706e+03 + 104560 9.810945088870343e-01 -5.983760568970198e+00 -5.975577363999019e+00 3.806332712232163e+00 4.853321941523553e+00 9.142211067034239e+03 + 104580 9.616990179464294e-01 -5.965195429351770e+00 -6.006645616170596e+00 3.881843180941408e+00 4.643829793832026e+00 9.237442188400602e+03 + 104600 9.287748760778872e-01 -5.924991392757611e+00 -5.998063643355083e+00 4.178939850842912e+00 4.759347680017994e+00 9.211065207535758e+03 + 104620 9.789373109759779e-01 -6.006535266999374e+00 -6.018429282573143e+00 3.669293089543033e+00 4.600995811525493e+00 9.273725463128090e+03 + 104640 1.010322707866113e+00 -6.058883678364797e+00 -6.019364909226527e+00 3.371556066501091e+00 4.598478954402795e+00 9.276621679061651e+03 + 104660 1.021445768601109e+00 -6.084308979931423e+00 -6.000664628420290e+00 3.190592472257823e+00 4.670891282556314e+00 9.219105555142201e+03 + 104680 1.009091388732120e+00 -6.076980267951046e+00 -5.977936222200965e+00 3.303658535264448e+00 4.872384772977961e+00 9.149438589705616e+03 + 104700 9.499821414513164e-01 -6.000054038113481e+00 -5.950679107842310e+00 3.724302331017220e+00 5.007820821380051e+00 9.066250709186786e+03 + 104720 1.015792497429706e+00 -6.107058968434573e+00 -5.957842087700971e+00 3.090546029598101e+00 4.947372450008109e+00 9.088065485474552e+03 + 104740 9.534742693742431e-01 -6.022535116642287e+00 -5.973343282075408e+00 3.579737042030009e+00 4.862204168524826e+00 9.135361605355185e+03 + 104760 9.403061086538437e-01 -6.007544252203084e+00 -5.949504125120118e+00 3.624511773785113e+00 4.957787165176142e+00 9.062679624505292e+03 + 104780 9.997703511078769e-01 -6.094227485846776e+00 -5.960223082786667e+00 3.191513460777719e+00 4.960987480263219e+00 9.095340590338199e+03 + 104800 9.774692895726741e-01 -6.054946893238378e+00 -5.968868436637535e+00 3.367923564462575e+00 4.862199382862723e+00 9.121722879751947e+03 + 104820 9.438642503826055e-01 -5.992456948273869e+00 -5.980839395923763e+00 3.722046664468513e+00 4.788756447873242e+00 9.158320689525617e+03 + 104840 9.748431818374612e-01 -6.018767334445926e+00 -5.987373945687875e+00 3.672994640577422e+00 4.853260336937362e+00 9.178311974642762e+03 + 104860 1.044363293265304e+00 -6.093615132708488e+00 -5.997202303523409e+00 3.227520393225000e+00 4.781137778242824e+00 9.208463570763561e+03 + 104880 9.929823325170609e-01 -5.987277011486412e+00 -6.024831198219063e+00 3.745810642640010e+00 4.530168690929514e+00 9.293413977018743e+03 + 104900 9.797354792566706e-01 -5.938803602371681e+00 -6.006301036939892e+00 3.982438370393865e+00 4.594857655908957e+00 9.236402750864243e+03 + 104920 1.033044261832993e+00 -5.987904822764600e+00 -6.013294064004409e+00 3.736149124686946e+00 4.590360172515579e+00 9.257899278789913e+03 + 104940 1.044012340447547e+00 -5.976772735838678e+00 -6.027686498918094e+00 3.797092935666332e+00 4.504738229184949e+00 9.302204756283736e+03 + 104960 1.063859420530066e+00 -5.985261836863711e+00 -6.005240846665505e+00 3.771004015686898e+00 4.656281449663227e+00 9.233161781239660e+03 + 104980 1.011704070335151e+00 -5.893897281527964e+00 -6.018614186156508e+00 4.273350479209363e+00 4.557206712953641e+00 9.274267327624992e+03 + 105000 1.048864245622462e+00 -5.938589756453023e+00 -5.983078022421250e+00 3.984686454081249e+00 4.729227946354786e+00 9.165156372352545e+03 + 105020 1.110834173150663e+00 -6.025349093990920e+00 -5.964059634812256e+00 3.537108458262051e+00 4.889042017379098e+00 9.107016357845210e+03 + 105040 1.013165563575753e+00 -5.882555774735239e+00 -5.951256662829303e+00 4.362472737710746e+00 4.967981606846559e+00 9.067999090968746e+03 + 105060 9.836340351433762e-01 -5.842393340791964e+00 -6.027493250587754e+00 4.517207561159660e+00 4.454335234993766e+00 9.301625449274330e+03 + 105080 1.042859748114607e+00 -5.940055705352175e+00 -6.014840545785788e+00 3.988919490678016e+00 4.559493363991554e+00 9.262667100236680e+03 + 105100 1.019831075485643e+00 -5.924553203105154e+00 -6.028440196383031e+00 4.086626658500611e+00 4.490091466638789e+00 9.304540793458014e+03 + 105120 1.059670839523809e+00 -6.013465568542323e+00 -6.005086981298824e+00 3.606968843586419e+00 4.655079988120772e+00 9.232657438489121e+03 + 105140 1.065108617023550e+00 -6.061205855048824e+00 -5.930432326378098e+00 3.455162657974877e+00 5.206084496740347e+00 9.004710771129410e+03 + 105160 9.298066427172599e-01 -5.907562714077069e+00 -5.982992402961173e+00 4.206039306538768e+00 4.772910360259615e+00 9.164857494382257e+03 + 105180 1.019973943121698e+00 -6.085539896170922e+00 -5.943616287648943e+00 3.220874957796443e+00 5.035822280537086e+00 9.044754963536017e+03 + 105200 9.297530551113830e-01 -5.986133310350633e+00 -6.010556010431372e+00 3.752870939814227e+00 4.612632016550003e+00 9.249459464964324e+03 + 105220 9.074132389185702e-01 -5.978322811136857e+00 -5.995599622369889e+00 3.848876093816709e+00 4.749669970138740e+00 9.203526077648481e+03 + 105240 9.799376879572891e-01 -6.100206338110950e+00 -6.010841983405768e+00 3.145417676357328e+00 4.658561630163682e+00 9.250365155175568e+03 + 105260 9.669544943933586e-01 -6.087662715416231e+00 -6.006798931534360e+00 3.234070373398036e+00 4.698402734077852e+00 9.237940421005482e+03 + 105280 9.192073204966349e-01 -6.017596084653801e+00 -6.007220122773769e+00 3.559977937171517e+00 4.619558315961577e+00 9.239236640171917e+03 + 105300 9.742851275868439e-01 -6.095962759954296e+00 -5.980056796140831e+00 3.156571954011118e+00 4.822121934617964e+00 9.155937182330983e+03 + 105320 9.680140484531573e-01 -6.079502827669478e+00 -5.972484914720174e+00 3.281882478721355e+00 4.896395895844764e+00 9.132778722283108e+03 + 105340 9.474206314584649e-01 -6.036293239285905e+00 -5.979657348196294e+00 3.532546634205842e+00 4.857758685218210e+00 9.154720149597306e+03 + 105360 1.010364918527897e+00 -6.113401981456605e+00 -5.966293677400221e+00 3.069155959515674e+00 4.913874606343917e+00 9.113880369302085e+03 + 105380 1.005409619074669e+00 -6.089605375690125e+00 -5.965232546426056e+00 3.301365029800016e+00 5.015533062067428e+00 9.110615594720002e+03 + 105400 9.798278291006770e-01 -6.033734164737925e+00 -5.991441703664841e+00 3.489910756798639e+00 4.732760613017486e+00 9.190805774669545e+03 + 105420 9.617753053257266e-01 -5.989303438813139e+00 -6.031948175571883e+00 3.695710007943805e+00 4.450837330223414e+00 9.315381362144270e+03 + 105440 1.015367725963964e+00 -6.051910221943773e+00 -5.983574025375860e+00 3.400383910891057e+00 4.792780926576251e+00 9.166686221829063e+03 + 105460 1.013602011966773e+00 -6.031717760017447e+00 -5.972681321920987e+00 3.523906139509683e+00 4.862902502918824e+00 9.133373233477387e+03 + 105480 9.520242536433576e-01 -5.923288954276589e+00 -6.073950220808323e+00 4.105446290799744e+00 4.240325983618884e+00 9.445419073435698e+03 + 105500 1.011368636392722e+00 -5.998732276607039e+00 -5.995376515138705e+00 3.698418257216666e+00 4.717687558870249e+00 9.202874897463817e+03 + 105520 1.032363337633741e+00 -6.020459914809817e+00 -5.986850092740839e+00 3.644559512514301e+00 4.837552311937525e+00 9.176729921849239e+03 + 105540 9.736436639915813e-01 -5.926356906650140e+00 -6.026858902453435e+00 4.070250787810322e+00 4.493152775274218e+00 9.299700056959968e+03 + 105560 1.019057514650747e+00 -5.989236094512425e+00 -5.971799251368347e+00 3.725923552176927e+00 4.826048603852979e+00 9.130686160594167e+03 + 105580 9.528947996771479e-01 -5.887293628413572e+00 -6.031752914281413e+00 4.261668706357848e+00 4.432161131902460e+00 9.314752035596786e+03 + 105600 1.041573286604988e+00 -6.015013161384133e+00 -6.005545817022140e+00 3.586824915786775e+00 4.641187872180148e+00 9.234077158035436e+03 + 105620 1.004243397638627e+00 -5.960076232231530e+00 -5.967285994915208e+00 3.947560306160929e+00 4.906160733124082e+00 9.116868366802941e+03 + 105640 1.022506427492142e+00 -5.987636310353323e+00 -5.959792503187007e+00 3.760760680751677e+00 4.920644130315898e+00 9.094009340848997e+03 + 105660 1.029789620121534e+00 -5.998764874033219e+00 -5.970988418962532e+00 3.736787993959781e+00 4.896284697368198e+00 9.128181052485172e+03 + 105680 1.053961725100563e+00 -6.036332877933464e+00 -5.984582756555044e+00 3.504980285539741e+00 4.802137490800030e+00 9.169769832299187e+03 + 105700 1.040685560194637e+00 -6.020739159812908e+00 -6.020400030508256e+00 3.528986061426465e+00 4.530933394373866e+00 9.279772174723888e+03 + 105720 1.022784278373889e+00 -5.999159861589860e+00 -6.032170578400263e+00 3.654431440642054e+00 4.464878796324804e+00 9.316058601885063e+03 + 105740 1.028099779390137e+00 -6.013069780452668e+00 -5.978046398999295e+00 3.643356242157934e+00 4.844465918313966e+00 9.149787863657071e+03 + 105760 9.930703030581690e-01 -5.966160360102219e+00 -5.975788395725336e+00 3.914741022184485e+00 4.859455351702849e+00 9.142876714259646e+03 + 105780 1.053364405619904e+00 -6.058721948758882e+00 -6.010105177678916e+00 3.420135336653936e+00 4.699300359616115e+00 9.248091705910028e+03 + 105800 1.031157656200048e+00 -6.030254643660642e+00 -5.992269885084324e+00 3.577761107061305e+00 4.795875468928918e+00 9.193345141334792e+03 + 105820 1.025626297817375e+00 -6.027665537154200e+00 -5.946009790443187e+00 3.556289426650671e+00 5.025169360451276e+00 9.052022467228582e+03 + 105840 1.023304092883361e+00 -6.025188389317370e+00 -5.962708671899954e+00 3.582976281055838e+00 4.941744487171666e+00 9.102913035612937e+03 + 105860 9.574569616592294e-01 -5.927546851528268e+00 -6.031751263841569e+00 4.115183228322439e+00 4.516825367238773e+00 9.314769091639721e+03 + 105880 1.081952132407776e+00 -6.113561619425293e+00 -5.966749946150235e+00 3.089884511913907e+00 4.932899858892307e+00 9.115281244404265e+03 + 105900 9.768611111532405e-01 -5.959228170911796e+00 -6.012257628730955e+00 3.886217000957104e+00 4.581713647877415e+00 9.254724219544254e+03 + 105920 9.618311540205203e-01 -5.938525812157089e+00 -6.034686816553030e+00 4.026143333926502e+00 4.473971965817667e+00 9.323841805252732e+03 + 105940 1.005256509796268e+00 -6.004771366631494e+00 -6.019425523985012e+00 3.656821798436134e+00 4.572675359188713e+00 9.276784511354979e+03 + 105960 1.051081755164710e+00 -6.075565015369823e+00 -5.953190345340344e+00 3.290048222010037e+00 4.992742514738286e+00 9.073897104723092e+03 + 105980 9.814223398954012e-01 -5.973715040369110e+00 -5.973577324931123e+00 3.811988676928520e+00 4.812779460284839e+00 9.136090233345500e+03 + 106000 9.517403558871805e-01 -5.930215202094815e+00 -6.012074225185203e+00 4.072174067246714e+00 4.602126889018824e+00 9.254147385920167e+03 + 106020 1.036470204866981e+00 -6.055888512823547e+00 -5.953032807909951e+00 3.420022608240283e+00 5.010635982723047e+00 9.073421533368173e+03 + 106040 9.876027144470996e-01 -5.982553759755107e+00 -5.978835585089493e+00 3.797775195741898e+00 4.819125530057525e+00 9.152177449540031e+03 + 106060 1.006627757877112e+00 -6.007602740015203e+00 -6.053254756479192e+00 3.598247305163668e+00 4.336106362000728e+00 9.381197354408683e+03 + 106080 1.014595036208636e+00 -6.015969021415833e+00 -5.968177289904363e+00 3.668455483743803e+00 4.942883001829212e+00 9.119620843721950e+03 + 106100 9.579312377507713e-01 -5.929914078467802e+00 -6.002342488423781e+00 4.023850821317997e+00 4.607955683090549e+00 9.224219886672861e+03 + 106120 9.747630544213577e-01 -5.950493512794709e+00 -5.973425996623621e+00 3.984388825519509e+00 4.852706954583492e+00 9.135648659997283e+03 + 106140 1.034836408158587e+00 -6.028923969260328e+00 -6.018579496811221e+00 3.532515787698647e+00 4.591915349303362e+00 9.274169441533359e+03 + 106160 1.056747373239916e+00 -6.049497760317792e+00 -6.008918461179066e+00 3.416071584252408e+00 4.649084199533220e+00 9.244455084515588e+03 + 106180 9.886513653691075e-01 -5.937770140760671e+00 -6.038664530076505e+00 4.007068974819852e+00 4.427717778012047e+00 9.336132458129940e+03 + 106200 9.805340525909000e-01 -5.914543900655577e+00 -6.009989267012552e+00 4.162686454606213e+00 4.614624390861758e+00 9.247739323264321e+03 + 106220 1.000973508509644e+00 -5.932482165695836e+00 -6.011485134197835e+00 4.061947033389238e+00 4.608299762580892e+00 9.252350543164030e+03 + 106240 1.099477804216275e+00 -6.068344720563396e+00 -5.991392340996491e+00 3.347705589596008e+00 4.789578061411429e+00 9.190653140477709e+03 + 106260 9.817309425238466e-01 -5.886709534572112e+00 -6.010764956554358e+00 4.407729832308563e+00 4.695384401771996e+00 9.250081283683603e+03 + 106280 1.080399480922048e+00 -6.028375517662067e+00 -5.949095556801142e+00 3.578830357159455e+00 5.034068160957180e+00 9.061422531360038e+03 + 106300 1.004495752406809e+00 -5.912349338804317e+00 -5.981316562546132e+00 4.177994123627386e+00 4.781973652258502e+00 9.159740920965627e+03 + 106320 9.574213200212893e-01 -5.841242196946911e+00 -6.012159648823311e+00 4.503141442578856e+00 4.521706984514366e+00 9.254370966423083e+03 + 106340 1.017003814298037e+00 -5.929556249530058e+00 -5.996851214287775e+00 4.045130902045099e+00 4.658712800544150e+00 9.207331225173639e+03 + 106360 1.000323491489600e+00 -5.908035978058246e+00 -6.027880613780974e+00 4.168167066239224e+00 4.480000622021882e+00 9.302830647739671e+03 + 106380 1.099692558107775e+00 -6.064504847833308e+00 -5.995719646847336e+00 3.360620737001310e+00 4.755596005538216e+00 9.203921001261197e+03 + 106400 1.018741810708129e+00 -5.960982782847296e+00 -6.013786411028732e+00 3.903909380340809e+00 4.600702775987948e+00 9.259430955694646e+03 + 106420 9.960929918803061e-01 -5.950914067813625e+00 -6.000998144026840e+00 3.991378023248719e+00 4.703787507146691e+00 9.220086539635999e+03 + 106440 9.951776503857219e-01 -5.976266187861974e+00 -6.004216954543550e+00 3.798745290460036e+00 4.638247662807263e+00 9.229985477600831e+03 + 106460 1.014168006604222e+00 -6.033711733975982e+00 -5.966472571015309e+00 3.500038341202592e+00 4.886136020149615e+00 9.114400641217915e+03 + 106480 9.219378388600086e-01 -5.925156666687804e+00 -6.011488971190176e+00 4.097525919950419e+00 4.601792467616856e+00 9.252319590841102e+03 + 106500 9.315582535002030e-01 -5.964075144604301e+00 -5.962719726808801e+00 3.908816105554686e+00 4.916599124286676e+00 9.102963734672707e+03 + 106520 9.197455744389260e-01 -5.965877622604387e+00 -6.032731833403562e+00 3.906212693366754e+00 4.522325469302208e+00 9.317794242136057e+03 + 106540 9.328777874255200e-01 -6.002134968512064e+00 -6.049540799054512e+00 3.699215549030641e+00 4.427003934027339e+00 9.369756461810823e+03 + 106560 9.816279550814646e-01 -6.089162334927154e+00 -6.019996855209783e+00 3.193440358211693e+00 4.590599246072228e+00 9.278567858523042e+03 + 106580 9.362034553502320e-01 -6.033394628574899e+00 -6.000162951443884e+00 3.542104282948767e+00 4.732925715620471e+00 9.217568579773471e+03 + 106600 9.531663688312749e-01 -6.066506105723457e+00 -5.987454258532392e+00 3.344638904377249e+00 4.798566844182163e+00 9.178583732351199e+03 + 106620 9.085484805453523e-01 -6.001575943053993e+00 -5.974513134056619e+00 3.716007840363719e+00 4.871406677582797e+00 9.138966906179581e+03 + 106640 9.965917805155191e-01 -6.124717185660998e+00 -5.959962687766232e+00 3.020579958356647e+00 4.966625780944543e+00 9.094552638896163e+03 + 106660 9.745666292338361e-01 -6.075727449155544e+00 -5.968355851361495e+00 3.347743966669550e+00 4.964288296904041e+00 9.120164656728615e+03 + 106680 1.005602826952666e+00 -6.093073800298061e+00 -5.982576040883171e+00 3.159489085215513e+00 4.793984319248818e+00 9.163636057383923e+03 + 106700 9.419305913742143e-01 -5.957666432617559e+00 -5.972641662802367e+00 3.921453091918120e+00 4.835463002787572e+00 9.133240316871985e+03 + 106720 9.411250027764670e-01 -5.900519770763479e+00 -5.994196624843613e+00 4.239192450140639e+00 4.701285457566190e+00 9.199251461260015e+03 + 106740 1.017251155313295e+00 -5.956261248836221e+00 -5.997455371046279e+00 3.902653424003169e+00 4.666110399503207e+00 9.209223112377151e+03 + 106760 1.027999396199909e+00 -5.928888995783600e+00 -5.994895914455084e+00 4.074108966804059e+00 4.695087025254746e+00 9.201363900920001e+03 + 106780 1.023671017428234e+00 -5.895389635436733e+00 -5.983821601722628e+00 4.278067941387405e+00 4.770277906171239e+00 9.167389214974275e+03 + 106800 1.063370518251372e+00 -5.938825043595225e+00 -6.040278749157486e+00 3.972831204060830e+00 4.390268326812130e+00 9.341101942116768e+03 + 106820 9.933091850089931e-01 -5.829277294172231e+00 -6.023198833214610e+00 4.674508834132249e+00 4.560981347689729e+00 9.288341931922771e+03 + 106840 1.068695331542206e+00 -5.943643439051375e+00 -6.002213778075681e+00 3.989144409407911e+00 4.652824458999677e+00 9.223810861222531e+03 + 106860 1.080201377918969e+00 -5.966966170665622e+00 -5.999897563112439e+00 3.845396223991817e+00 4.656299072445684e+00 9.216732157873832e+03 + 106880 1.081211612856492e+00 -5.981462397936142e+00 -6.042856418341460e+00 3.796636348544040e+00 4.444102382682753e+00 9.349096640293292e+03 + 106900 1.036519717739681e+00 -5.937700126651976e+00 -6.062592442682446e+00 4.002609824302688e+00 4.285458818632282e+00 9.410187139904428e+03 + 106920 1.063632070211790e+00 -6.005868794207068e+00 -5.998800526891152e+00 3.662995489394131e+00 4.703582574132952e+00 9.213360681057718e+03 + 106940 1.070216467612981e+00 -6.047270722087692e+00 -6.019756986915811e+00 3.390157901351967e+00 4.548146026445662e+00 9.277799402708328e+03 + 106960 9.973279213432032e-01 -5.971636611404179e+00 -5.987792708905163e+00 3.880620965097727e+00 4.787850153099067e+00 9.179607477186981e+03 + 106980 9.960897270013463e-01 -5.996518235592978e+00 -5.990139618307969e+00 3.728431701155718e+00 4.765058708694074e+00 9.186780903054567e+03 + 107000 1.091480078112921e+00 -6.162083420700586e+00 -5.956960727145157e+00 2.875067054914906e+00 5.052913303944422e+00 9.085413326716496e+03 + 107020 9.334176182282091e-01 -5.945262140286588e+00 -6.012381344710564e+00 4.027148112660582e+00 4.641739254194801e+00 9.255090639686185e+03 + 107040 9.893706451769266e-01 -6.041593407988587e+00 -6.030125271801602e+00 3.423369171377276e+00 4.489220984051286e+00 9.309768960803487e+03 + 107060 8.956921923816729e-01 -5.913512302806556e+00 -6.048360564440324e+00 4.115791119793720e+00 4.341471533791571e+00 9.366120273994551e+03 + 107080 1.014568518492241e+00 -6.097222958764431e+00 -5.979854029142997e+00 3.168499691858472e+00 4.842450248527906e+00 9.155313596886732e+03 + 107100 1.035141127832272e+00 -6.131896671699758e+00 -5.965389545165465e+00 2.972565390432282e+00 4.928675077886751e+00 9.111124368627907e+03 + 107120 9.589152452895245e-01 -6.020490507470245e+00 -5.954341039750212e+00 3.597254740272414e+00 4.977095220517889e+00 9.077405064062938e+03 + 107140 9.747869551062297e-01 -6.040281800103179e+00 -5.976856561146040e+00 3.426948047506857e+00 4.791145584622765e+00 9.146131142547514e+03 + 107160 1.022532204744173e+00 -6.102907087728408e+00 -5.944467338938619e+00 3.116679819919016e+00 5.026465375941870e+00 9.047381198894020e+03 + 107180 9.537027249169767e-01 -5.988059938624118e+00 -5.984920694161377e+00 3.748241098497489e+00 4.766267125999058e+00 9.170816522573945e+03 + 107200 9.818286328918161e-01 -6.013145581348835e+00 -5.988471321569333e+00 3.606528282519704e+00 4.748211700502971e+00 9.181662881766486e+03 + 107220 9.638649777582777e-01 -5.963817448158141e+00 -6.025670553031548e+00 3.808551938322428e+00 4.453381838402275e+00 9.296017940819487e+03 + 107240 1.013150429575588e+00 -6.010016926538483e+00 -6.013931742915700e+00 3.595547323006672e+00 4.573067841552815e+00 9.259873057419500e+03 + 107260 9.786341437994822e-01 -5.927788019293728e+00 -6.016337260394074e+00 4.091676025955620e+00 4.583212580606660e+00 9.267247381447047e+03 + 107280 1.003774047609609e+00 -5.924746945056934e+00 -6.026002682326444e+00 4.043936170079983e+00 4.462510057403756e+00 9.297058224356018e+03 + 107300 9.935596803415440e-01 -5.862941368662274e+00 -6.065661293515388e+00 4.335638014455830e+00 4.171588835142269e+00 9.419714195341272e+03 + 107320 1.076936398191485e+00 -5.938185717253442e+00 -6.020544900406197e+00 4.036403039010020e+00 4.563483864304502e+00 9.280205162727721e+03 + 107340 1.060868298485076e+00 -5.866815063145264e+00 -6.016526083599312e+00 4.440844220062749e+00 4.581180372910065e+00 9.267833316892373e+03 + 107360 1.166685637846369e+00 -5.992032980247102e+00 -6.016956968966996e+00 3.741702484481671e+00 4.598585084277255e+00 9.269193262704744e+03 + 107380 1.156070270995346e+00 -5.960463364025639e+00 -6.021807144112628e+00 3.885893229649185e+00 4.533647751470403e+00 9.284143381081256e+03 + 107400 1.120264906308816e+00 -5.910876971573249e+00 -5.975619959055015e+00 4.182429485904760e+00 4.810665232839530e+00 9.142342768991168e+03 + 107420 1.034653795029537e+00 -5.793687247060754e+00 -5.966073427879692e+00 4.800338837396922e+00 4.810470710459315e+00 9.113150843554979e+03 + 107440 1.068404714285877e+00 -5.856486757580247e+00 -6.025649962592572e+00 4.408115919988164e+00 4.436754618886019e+00 9.295925302328633e+03 + 107460 1.083486976078189e+00 -5.896262753495077e+00 -6.028044129831173e+00 4.169189118036603e+00 4.412480062012659e+00 9.303346970973949e+03 + 107480 1.021888401692707e+00 -5.824316013354433e+00 -6.026162880615948e+00 4.620839038332319e+00 4.461803090814946e+00 9.297530265019874e+03 + 107500 1.100250809195455e+00 -5.959937216163540e+00 -6.006227946956358e+00 3.912753394379323e+00 4.646944854699529e+00 9.236175365965028e+03 + 107520 1.083191392924486e+00 -5.956160049319586e+00 -6.074264804668620e+00 3.935188133076827e+00 4.257012351210856e+00 9.446422918603446e+03 + 107540 1.041043070099352e+00 -5.922918507413494e+00 -6.065572923265792e+00 4.056423530159119e+00 4.237279798635718e+00 9.419445632413290e+03 + 107560 9.883915065059991e-01 -5.873877341970246e+00 -6.027240516354921e+00 4.376646542048743e+00 4.496011461857409e+00 9.300857450502635e+03 + 107580 1.094827329378895e+00 -6.059750682019232e+00 -5.989444511014343e+00 3.354783159269712e+00 4.758492073024583e+00 9.184678214461461e+03 + 107600 1.049431088619426e+00 -6.022946953545170e+00 -5.990431556241718e+00 3.555270637405665e+00 4.741979080463560e+00 9.187695727713277e+03 + 107620 1.010406469704170e+00 -5.990631503106416e+00 -5.992126473260774e+00 3.728306325982232e+00 4.719721976010019e+00 9.192892406938281e+03 + 107640 9.646644875437898e-01 -5.946832348674482e+00 -6.014233115661220e+00 3.999784326280516e+00 4.612758692007682e+00 9.260774492159677e+03 + 107660 1.012891262175276e+00 -6.039105592043181e+00 -5.994815045421126e+00 3.465151505747127e+00 4.719474678390903e+00 9.201125923778925e+03 + 107680 9.920191782473126e-01 -6.026392576951298e+00 -5.976879112395320e+00 3.560891559584689e+00 4.845205535248991e+00 9.146204358698034e+03 + 107700 9.629302818179348e-01 -5.998033168646276e+00 -5.960017588711475e+00 3.755612958579468e+00 4.973904301457079e+00 9.094707931627696e+03 + 107720 9.743256926755899e-01 -6.025744743556214e+00 -6.013118838713573e+00 3.531475517022991e+00 4.603975416481900e+00 9.257333676349095e+03 + 107740 9.843536300052306e-01 -6.048045630490732e+00 -6.011877970576766e+00 3.399589115514061e+00 4.607269415667339e+00 9.253558380128936e+03 + 107760 9.870103607214662e-01 -6.058132264531766e+00 -5.979003552872307e+00 3.386105696271062e+00 4.840475003748232e+00 9.152712514640298e+03 + 107780 9.880727976511489e-01 -6.061902980302930e+00 -5.940489865546859e+00 3.474968395945530e+00 5.172141289493676e+00 9.035268490074210e+03 + 107800 9.934363380380949e-01 -6.066221439977816e+00 -5.988436137493715e+00 3.307911193865003e+00 4.754566437965371e+00 9.181592390874392e+03 + 107820 9.941222238259179e-01 -6.061157274982905e+00 -6.005740319051945e+00 3.387191829149858e+00 4.705404565851641e+00 9.234669880036236e+03 + 107840 9.802711755186846e-01 -6.031962661242682e+00 -5.972197194710828e+00 3.528039066123626e+00 4.871221623625584e+00 9.131903074737453e+03 + 107860 9.737836998087152e-01 -6.006532366041084e+00 -5.989109268957429e+00 3.677119096276647e+00 4.777165215946555e+00 9.183645934083359e+03 + 107880 9.990776872213606e-01 -6.021171733993945e+00 -5.972021231595545e+00 3.606952324883891e+00 4.889182115671163e+00 9.131360454948132e+03 + 107900 9.621491648172464e-01 -5.936971328752231e+00 -5.949348013003055e+00 4.038356892697905e+00 4.967288056443978e+00 9.062199076408415e+03 + 107920 1.015021487249577e+00 -5.972331211826770e+00 -5.959059745545060e+00 3.901221194300628e+00 4.977428007442975e+00 9.091787121374791e+03 + 107940 1.084780237755569e+00 -6.024691205974166e+00 -6.010794881635205e+00 3.517763169042444e+00 4.597558013845994e+00 9.250237775283598e+03 + 107960 1.054203414846473e+00 -5.936365887669200e+00 -6.035347090494796e+00 4.010637691369978e+00 4.442272307453769e+00 9.325880074572389e+03 + 107980 1.053521546659673e+00 -5.909954976591237e+00 -5.998799133369886e+00 4.221508023905686e+00 4.711351127093857e+00 9.213320405882903e+03 + 108000 1.039572208917378e+00 -5.871860370726271e+00 -6.023429481683597e+00 4.407605606512296e+00 4.537272316151213e+00 9.289080853752117e+03 + 108020 1.074137242603411e+00 -5.915719881252234e+00 -5.992090244400467e+00 4.182847822553282e+00 4.744317379080624e+00 9.192777612740869e+03 + 108040 1.062737816324989e+00 -5.899433269969242e+00 -6.007586830290133e+00 4.205741372022769e+00 4.584706891950842e+00 9.240325482529890e+03 + 108060 1.075041951887930e+00 -5.925107194838648e+00 -6.002757562852939e+00 4.093953287006163e+00 4.648072857512488e+00 9.225499950036372e+03 + 108080 1.088380250092350e+00 -5.959242808274414e+00 -6.034170674578027e+00 3.999187682688607e+00 4.568940279323428e+00 9.322243954859903e+03 + 108100 1.113715042597850e+00 -6.022971543491155e+00 -6.032311133386394e+00 3.588166938298107e+00 4.534537567822781e+00 9.316507178080856e+03 + 108120 1.023537800871556e+00 -5.920319455141232e+00 -5.993233261800748e+00 4.110506379261539e+00 4.691824018047488e+00 9.196258875854641e+03 + 108140 9.980410773184784e-01 -5.909817993069390e+00 -5.949564029902841e+00 4.209126426803954e+00 4.980898532626957e+00 9.062821895626783e+03 + 108160 1.015613200229184e+00 -5.957734116411175e+00 -5.942365421137865e+00 3.896006588878882e+00 4.984256015436136e+00 9.040936387462518e+03 + 108180 1.012196642450348e+00 -5.967608887570485e+00 -5.978755456825464e+00 3.858217647821433e+00 4.794212322233322e+00 9.151912704568538e+03 + 108200 9.741769502196318e-01 -5.925526691123276e+00 -6.005749391432316e+00 4.044388511053363e+00 4.583737351456106e+00 9.234691966481303e+03 + 108220 9.687114128244643e-01 -5.928724985779531e+00 -5.955326182847923e+00 4.087564662161350e+00 4.934816472072698e+00 9.080395360601287e+03 + 108240 1.005166577086568e+00 -5.990235717786807e+00 -5.986930693100444e+00 3.731780417406966e+00 4.750758380606985e+00 9.176934997796623e+03 + 108260 1.010016370502997e+00 -6.002224998525467e+00 -5.950490652744848e+00 3.757186535442605e+00 5.054253154779056e+00 9.065681509965854e+03 + 108280 1.004404093359719e+00 -5.998232262909251e+00 -6.025325482260378e+00 3.704748655158797e+00 4.549175196982484e+00 9.294920823874812e+03 + 108300 9.915783221759463e-01 -5.983909713209440e+00 -5.981713437636225e+00 3.764436182207665e+00 4.777047536421610e+00 9.160977118090765e+03 + 108320 9.577143021635933e-01 -5.936558417704182e+00 -5.993366096541505e+00 4.055546824183006e+00 4.729348341339207e+00 9.196672309316877e+03 + 108340 9.873057496685874e-01 -5.981530567227935e+00 -5.980196830726648e+00 3.841769016392532e+00 4.849427537777983e+00 9.156309616924682e+03 + 108360 9.820677538233421e-01 -5.971071943175634e+00 -6.041223494110471e+00 3.867204885490600e+00 4.464383824105342e+00 9.344036215726748e+03 + 108380 1.020466553004970e+00 -6.026487393392054e+00 -6.083794476410086e+00 3.506608508790643e+00 4.177542369858671e+00 9.476088023334511e+03 + 108400 9.218425656843257e-01 -5.884336754468325e+00 -6.012802347728387e+00 4.363506307371148e+00 4.625836990885568e+00 9.256384620686618e+03 + 108420 1.019868274710582e+00 -6.035226735395079e+00 -5.961791355007750e+00 3.491491166690344e+00 4.913168484962775e+00 9.100125696866366e+03 + 108440 1.020746629340604e+00 -6.037938765544196e+00 -5.982261369592243e+00 3.480162556982721e+00 4.799870780588009e+00 9.162668931352207e+03 + 108460 9.648008454713850e-01 -5.954432499808748e+00 -6.052043376599707e+00 3.900787227195333e+00 4.340290467427280e+00 9.377491986999563e+03 + 108480 1.012825676977712e+00 -6.026486918168974e+00 -6.017756959880090e+00 3.586680666986021e+00 4.636809438437467e+00 9.271638219440774e+03 + 108500 1.071298070913189e+00 -6.113973966161216e+00 -5.981727338553323e+00 3.139346616554546e+00 4.898727217378555e+00 9.161037725997532e+03 + 108520 9.995398540864457e-01 -6.010742216332344e+00 -5.947270110706411e+00 3.689366296198835e+00 5.053832948979541e+00 9.055878528059937e+03 + 108540 1.014014069238396e+00 -6.034917107261979e+00 -5.966716737985542e+00 3.528944353298466e+00 4.920561427656803e+00 9.115160611939304e+03 + 108560 9.706622251815615e-01 -5.972630998059905e+00 -6.004653953747580e+00 3.801162390696355e+00 4.617281623601352e+00 9.231343927526259e+03 + 108580 9.781396761780351e-01 -5.984972613202496e+00 -6.033337765997054e+00 3.757113997335720e+00 4.479393805506165e+00 9.319647570064051e+03 + 108600 9.810013935294777e-01 -5.989267209276985e+00 -6.030921475823246e+00 3.778244937494896e+00 4.539059693009349e+00 9.312234084753991e+03 + 108620 1.002855736973533e+00 -6.023335464328249e+00 -6.023203149035391e+00 3.549377153009078e+00 4.550136927896395e+00 9.288434224418064e+03 + 108640 9.990366732869943e-01 -6.018726915652055e+00 -6.006344009917990e+00 3.586730299701548e+00 4.657834860675013e+00 9.236552383283415e+03 + 108660 1.026451071462047e+00 -6.059646397951886e+00 -6.002346625028880e+00 3.378859304413723e+00 4.707883467648820e+00 9.224258923522311e+03 + 108680 1.001074936334381e+00 -6.023430415030750e+00 -6.011235416778378e+00 3.602897833062329e+00 4.672923400197327e+00 9.251553194441129e+03 + 108700 9.580907785112820e-01 -5.961588777494660e+00 -5.975053601237232e+00 3.914403615744963e+00 4.837086514140369e+00 9.140603494491470e+03 + 108720 1.035506263936890e+00 -6.073315663746171e+00 -5.952660770082201e+00 3.302388415442210e+00 4.995207486145179e+00 9.072300041338567e+03 + 108740 9.854562550349116e-01 -5.991926143752989e+00 -6.009704792776455e+00 3.793399606537483e+00 4.691311852607696e+00 9.246869274965558e+03 + 108760 1.004531630700905e+00 -6.012857172403439e+00 -6.038390542484620e+00 3.584570280416954e+00 4.437953718134562e+00 9.335312780198099e+03 + 108780 1.052626868421286e+00 -6.080585705118037e+00 -5.971054779385264e+00 3.260442078516939e+00 4.889385603930501e+00 9.128422729464799e+03 + 108800 9.698915026857554e-01 -5.952400338423944e+00 -6.027353940799638e+00 3.933236462440590e+00 4.502841278566873e+00 9.301198058515394e+03 + 108820 1.020770136999852e+00 -6.020657019922772e+00 -6.003899666163582e+00 3.540945124311440e+00 4.637168442788825e+00 9.229024145049407e+03 + 108840 9.829787790242049e-01 -5.956593348644343e+00 -5.999233486724071e+00 3.957575947621837e+00 4.712729676227990e+00 9.214685944414696e+03 + 108860 1.037003982250690e+00 -6.026083889798857e+00 -6.015075292743703e+00 3.551550406269117e+00 4.614763474134696e+00 9.263372575520842e+03 + 108880 9.855407204743436e-01 -5.941130524919171e+00 -6.018564249978476e+00 3.973332656220415e+00 4.528696224099664e+00 9.274125139475673e+03 + 108900 1.040610497486178e+00 -6.014791222215638e+00 -5.973922552138872e+00 3.650996453198965e+00 4.885670681186006e+00 9.137152023481056e+03 + 108920 1.010746571020814e+00 -5.961381718837112e+00 -5.990652967532657e+00 3.848918042167713e+00 4.680838002446795e+00 9.188390678286707e+03 + 108940 9.758234313041554e-01 -5.899670693065586e+00 -6.039865139454703e+00 4.167864100064081e+00 4.362845893877307e+00 9.339844197490111e+03 + 108960 1.025693016310956e+00 -5.963408993778376e+00 -6.017185314277204e+00 3.907753836017132e+00 4.598961881854164e+00 9.269877029171623e+03 + 108980 1.073478006563008e+00 -6.025745906913911e+00 -6.031132448017474e+00 3.510887909824355e+00 4.479957557243154e+00 9.312876685180361e+03 + 109000 1.094042784350798e+00 -6.051414417241750e+00 -6.019309392802377e+00 3.394913413045250e+00 4.579265431612605e+00 9.276425973408888e+03 + 109020 1.067410045668167e+00 -6.013164161234901e+00 -5.999062055389572e+00 3.679624572747204e+00 4.760601046804909e+00 9.214162649406788e+03 + 109040 1.032131989915082e+00 -5.967722225318855e+00 -6.027877485928482e+00 3.890420382456902e+00 4.544999567039929e+00 9.302806872854382e+03 + 109060 1.053278460218680e+00 -6.011306642486284e+00 -6.011138911408402e+00 3.637471914552072e+00 4.638435052357575e+00 9.251268198576317e+03 + 109080 1.002315948589589e+00 -5.954199384352671e+00 -6.005768141362122e+00 3.898643684305822e+00 4.602527901318196e+00 9.234778875689419e+03 + 109100 1.047434391335358e+00 -6.046068223478323e+00 -5.980569840217163e+00 3.484834329135774e+00 4.860936181663405e+00 9.157507983948248e+03 + 109120 1.010799278984670e+00 -6.023459422120209e+00 -6.002643957730511e+00 3.548314728394327e+00 4.667840346102680e+00 9.225111062823362e+03 + 109140 9.805715256154648e-01 -6.012226654669088e+00 -5.991507227372066e+00 3.617714221701695e+00 4.736688379562208e+00 9.190967535203141e+03 + 109160 9.875922910271535e-01 -6.052291155898865e+00 -5.972232210622071e+00 3.490183291096962e+00 4.949894143958057e+00 9.132003573817899e+03 + 109180 1.053384674590968e+00 -6.177809197021253e+00 -6.004534700036508e+00 2.730878974123281e+00 4.725847949951437e+00 9.230992253130638e+03 + 109200 9.594850952680400e-01 -6.063251633257293e+00 -5.985606018303364e+00 3.406150655209129e+00 4.852003791894672e+00 9.172909592258051e+03 + 109220 9.462080787733916e-01 -6.062056116043646e+00 -5.947742680446437e+00 3.427184299767921e+00 5.083589736914085e+00 9.057324271325253e+03 + 109240 8.983851810711755e-01 -6.001502108684121e+00 -5.965501018049855e+00 3.749654956959702e+00 4.956378790532431e+00 9.111411842264019e+03 + 109260 9.887329666025924e-01 -6.136057787683523e+00 -5.961544229656384e+00 2.952766647335732e+00 4.954850503413391e+00 9.099373850484015e+03 + 109280 9.545839564806871e-01 -6.080590225330678e+00 -5.997087634723282e+00 3.258382310457273e+00 4.737867107709075e+00 9.208099018656241e+03 + 109300 9.497865636814274e-01 -6.064317741328719e+00 -5.941156713317082e+00 3.326376470578297e+00 5.033586152528606e+00 9.037291468523226e+03 + 109320 9.242128979765879e-01 -6.007329807587109e+00 -5.966504595207354e+00 3.682670129677166e+00 4.917094816842913e+00 9.114513531278337e+03 + 109340 9.560905510207155e-01 -6.023994489326089e+00 -6.011646464336136e+00 3.550991137135337e+00 4.621895407478339e+00 9.252859154133272e+03 + 109360 9.453624125603036e-01 -5.971995439210477e+00 -6.017399660843208e+00 3.839719793170644e+00 4.579001726274914e+00 9.270535534674005e+03 + 109380 9.921265982129118e-01 -6.001276584062145e+00 -6.013157630058791e+00 3.692343575938161e+00 4.624120771239491e+00 9.257475770663152e+03 + 109400 9.855920953321784e-01 -5.955355158831755e+00 -5.992472306171823e+00 3.907728165879531e+00 4.694595761992874e+00 9.193940908898418e+03 + 109420 1.006969176944831e+00 -5.954240446351060e+00 -5.980729774751390e+00 3.981305994710346e+00 4.829200171825327e+00 9.157981798141069e+03 + 109440 1.090609972369272e+00 -6.055263903709355e+00 -5.982438425814895e+00 3.365229833305907e+00 4.783404997082178e+00 9.163213274275438e+03 + 109460 1.045888505020370e+00 -5.976706491805553e+00 -6.065665267853577e+00 3.746302256822128e+00 4.235487198428276e+00 9.419746065321016e+03 + 109480 1.043687966727833e+00 -5.971868505276107e+00 -6.005442599275773e+00 3.861177013532939e+00 4.668389370212606e+00 9.233744134288718e+03 + 109500 1.005182548833443e+00 -5.917061849015028e+00 -5.972686343594315e+00 4.149105291498605e+00 4.829700835761622e+00 9.133370725142826e+03 + 109520 1.058151051715412e+00 -5.999765998552968e+00 -5.936486920183147e+00 3.720152608150502e+00 5.083510868555745e+00 9.023058845459847e+03 + 109540 1.023670810048727e+00 -5.951868090375650e+00 -5.943152087454159e+00 4.010521711223944e+00 5.060570348796238e+00 9.043328437982134e+03 + 109560 1.026289148690923e+00 -5.959919913487415e+00 -5.997970128487184e+00 3.893643568992297e+00 4.675153346211880e+00 9.210799383746875e+03 + 109580 1.021706887436896e+00 -5.959990971486249e+00 -6.021373046768340e+00 3.890243926731836e+00 4.537778551616618e+00 9.282763987196964e+03 + 109600 1.005062039983134e+00 -5.943651662215859e+00 -6.028956982408861e+00 4.017863396093531e+00 4.528027046589678e+00 9.306128973448767e+03 + 109620 1.051311904639596e+00 -6.024998417287838e+00 -6.022270007133868e+00 3.624432046037923e+00 4.640098999362126e+00 9.285545776747427e+03 + 109640 1.076610182754893e+00 -6.082164605854845e+00 -5.973735919328480e+00 3.293633959735433e+00 4.916248257054836e+00 9.136606002531638e+03 + 109660 9.425324479560375e-01 -5.903888588086559e+00 -6.009153481145221e+00 4.207276130248198e+00 4.602828824615806e+00 9.245157559553678e+03 + 109680 9.744119016378936e-01 -5.972017557252527e+00 -6.021800865689528e+00 3.801527414798057e+00 4.515663953810714e+00 9.284082009987362e+03 + 109700 9.636896458029039e-01 -5.974790334990272e+00 -6.006607206900667e+00 3.856164244583022e+00 4.673466842428519e+00 9.237320253525853e+03 + 109720 1.047523426136800e+00 -6.117518842611685e+00 -5.951418817672415e+00 3.122315203702985e+00 5.076087250800058e+00 9.068523008979058e+03 + 109740 9.529605246415017e-01 -5.994352364456859e+00 -6.042581256069575e+00 3.751051463787598e+00 4.474113704750534e+00 9.348232432907851e+03 + 109760 9.694198998467379e-01 -6.037268639465704e+00 -6.017825698572676e+00 3.552101546049369e+00 4.663745921442512e+00 9.271852996978670e+03 + 109780 1.008503040709809e+00 -6.111797103606383e+00 -6.001612300529800e+00 3.101615147933606e+00 4.734313338242515e+00 9.221999921783801e+03 + 109800 9.234817085578430e-01 -6.002010663599777e+00 -6.021667949230995e+00 3.708473530017098e+00 4.595598353967523e+00 9.283691880754999e+03 + 109820 9.898506289323936e-01 -6.116372974742874e+00 -5.951906603888724e+00 3.113859828214673e+00 5.058251180747837e+00 9.070021367908645e+03 + 109840 9.216813200064577e-01 -6.026820603827560e+00 -6.026751968063200e+00 3.608589486396424e+00 4.608983603576732e+00 9.299346769578786e+03 + 109860 9.683275848286996e-01 -6.108359047928173e+00 -6.001829727779143e+00 3.117727212012201e+00 4.729435053666943e+00 9.222677274755089e+03 + 109880 9.367424382017991e-01 -6.071785973205475e+00 -5.997068543699930e+00 3.274857157402724e+00 4.703896200108409e+00 9.208062457674054e+03 + 109900 8.973868999383569e-01 -6.019377602880527e+00 -6.016016277401363e+00 3.609627186915418e+00 4.628928437980219e+00 9.266282680458475e+03 + 109920 9.390230776667619e-01 -6.082756457915149e+00 -5.984324690630572e+00 3.290308839787277e+00 4.855519279802073e+00 9.168992365183849e+03 + 109940 9.460682861839445e-01 -6.087098144211586e+00 -5.982820916982378e+00 3.249119933426698e+00 4.847895909025569e+00 9.164343363692175e+03 + 109960 9.534160335316748e-01 -6.080411172313257e+00 -5.998459578499917e+00 3.274168402529377e+00 4.744747136173729e+00 9.212309290434358e+03 + 109980 9.561788934174436e-01 -6.056698918893106e+00 -5.992226457542107e+00 3.424260950272141e+00 4.794471800430731e+00 9.193223214912250e+03 + 110000 9.286228454560304e-01 -5.982868574483808e+00 -5.992054166938184e+00 3.824330295094624e+00 4.771585201755761e+00 9.192661058492396e+03 + 110020 9.322600495554356e-01 -5.947871015472542e+00 -6.032271125889105e+00 3.906910716234783e+00 4.422272221348004e+00 9.316389343825336e+03 + 110040 1.051327875793133e+00 -6.083116288863671e+00 -6.000528909917403e+00 3.241680769009303e+00 4.715910279274365e+00 9.218692797862925e+03 + 110060 1.082265875826372e+00 -6.094920791514028e+00 -5.969191874713209e+00 3.142925841119350e+00 4.864880737876646e+00 9.122716612234366e+03 + 110080 9.663780031418719e-01 -5.899122018087247e+00 -5.996054623314863e+00 4.203293158647594e+00 4.646691139158441e+00 9.204909362427068e+03 + 110100 9.835200157609779e-01 -5.902355548099267e+00 -6.000348869649619e+00 4.240806488402336e+00 4.678113671642718e+00 9.218098169790581e+03 + 110120 1.022656946713998e+00 -5.941496786037618e+00 -6.003985564644452e+00 4.057399661709102e+00 4.698579424841423e+00 9.229265719018886e+03 + 110140 1.039873747108141e+00 -5.951128343276463e+00 -6.004630771421411e+00 3.970663874928885e+00 4.663444653046595e+00 9.231255401452736e+03 + 110160 1.018745863519354e+00 -5.909579058191441e+00 -6.037880857949373e+00 4.166770980642767e+00 4.430042191793373e+00 9.333687659382565e+03 + 110180 1.049243293294678e+00 -5.950878442676631e+00 -6.008768075574378e+00 4.029754061019126e+00 4.697342830528524e+00 9.243984340849825e+03 + 110200 1.029631986180195e+00 -5.923064053169250e+00 -6.010838150259236e+00 4.156322943622634e+00 4.652310495134310e+00 9.250339358117104e+03 + 110220 1.033153602173843e+00 -5.934835409290177e+00 -6.031952810793861e+00 4.045539682951310e+00 4.487876534647841e+00 9.315393423306779e+03 + 110240 1.056069413482368e+00 -5.982593501681246e+00 -6.010070693080213e+00 3.759763120745616e+00 4.601984835651120e+00 9.248013958698835e+03 + 110260 1.070226161415560e+00 -6.022733772374420e+00 -6.019580513617202e+00 3.570605503924027e+00 4.588712003673194e+00 9.277244352823955e+03 + 110280 9.779256112615989e-01 -5.913520038861624e+00 -6.023532391387066e+00 4.173184838351547e+00 4.541476885793925e+00 9.289434063652681e+03 + 110300 1.052494966785776e+00 -6.057853140517452e+00 -5.985822661934281e+00 3.438436177178112e+00 4.852046331883218e+00 9.173595293013988e+03 + 110320 1.011529149249278e+00 -6.035933050556491e+00 -6.003930528676086e+00 3.482519192173048e+00 4.666282625184588e+00 9.229137022084225e+03 + 110340 9.708646058262266e-01 -6.010454070040975e+00 -6.004324896129530e+00 3.626798702835793e+00 4.661993367921904e+00 9.230333937859687e+03 + 110360 9.359848173099466e-01 -5.988566648946828e+00 -6.023844906360605e+00 3.755682671183464e+00 4.553109457820868e+00 9.290396756951262e+03 + 110380 9.811049548622823e-01 -6.079921267765222e+00 -5.984130994268012e+00 3.320966150547508e+00 4.871008724465403e+00 9.168407592035644e+03 + 110400 9.212425011848773e-01 -6.006329760718172e+00 -5.998592779699349e+00 3.709766413636288e+00 4.754193355940314e+00 9.212730532387617e+03 + 110420 9.804643084144998e-01 -6.100510625044591e+00 -5.989308772179535e+00 3.131322709596815e+00 4.769860957179084e+00 9.184272782955193e+03 + 110440 9.996785355283355e-01 -6.129438083081175e+00 -5.996362655814160e+00 2.989472003843865e+00 4.753611700566882e+00 9.205904218233467e+03 + 110460 9.875315664849790e-01 -6.108961279276206e+00 -6.010224187743059e+00 3.130711515299299e+00 4.697675174398157e+00 9.248479835216387e+03 + 110480 9.921601085555617e-01 -6.111018579800302e+00 -6.004417747577416e+00 3.097223452041951e+00 4.709341927091238e+00 9.230628253333118e+03 + 110500 9.481593009655233e-01 -6.037550208075061e+00 -5.989511582762105e+00 3.531631314938295e+00 4.807476535438525e+00 9.184894747712648e+03 + 110520 9.300941896809759e-01 -6.000228224003878e+00 -6.031965419298801e+00 3.649506611481406e+00 4.467266724782859e+00 9.315441042377706e+03 + 110540 9.934444835877562e-01 -6.082515418038583e+00 -5.987869629531684e+00 3.228326190341762e+00 4.771796954336819e+00 9.179853757144438e+03 + 110560 9.425088416099272e-01 -5.994087337490480e+00 -5.985640773273747e+00 3.745569360457019e+00 4.794070839291083e+00 9.173012697336795e+03 + 110580 9.474086280856785e-01 -5.987529883502685e+00 -5.994302483408548e+00 3.755411088685092e+00 4.716521771969177e+00 9.199552841547560e+03 + 110600 1.082175460248784e+00 -6.171160756571253e+00 -5.951793723694032e+00 2.779141480616332e+00 5.038780930335964e+00 9.069674820805674e+03 + 110620 1.010730194554325e+00 -6.052143856533896e+00 -6.016529788390564e+00 3.450134600907703e+00 4.654636091445952e+00 9.267869291956948e+03 + 110640 1.031805215598244e+00 -6.073702042617732e+00 -6.014303868935618e+00 3.279095580236304e+00 4.620169085356672e+00 9.261028325589306e+03 + 110660 9.508062475787832e-01 -5.945552094020330e+00 -6.012869623445438e+00 3.992504598386562e+00 4.605956927073581e+00 9.256570918327147e+03 + 110680 9.595026159332820e-01 -5.950488365425490e+00 -5.982368671350679e+00 3.974250735768617e+00 4.791189085684785e+00 9.162982887976223e+03 + 110700 1.001453199827921e+00 -6.003431680378736e+00 -5.977911206622367e+00 3.696113456639870e+00 4.842655966229489e+00 9.149332271111291e+03 + 110720 9.658870745627729e-01 -5.938841010483362e+00 -6.017821883471862e+00 3.970364672112552e+00 4.516844277161992e+00 9.271822413006292e+03 + 110740 1.026436461109748e+00 -6.017586257216919e+00 -5.978952614825177e+00 3.637809720528817e+00 4.859650073679033e+00 9.152540188395787e+03 + 110760 1.017556018721842e+00 -5.996406452838357e+00 -5.981039069259174e+00 3.711546654974805e+00 4.799788549581397e+00 9.158934445275740e+03 + 110780 1.010858827641146e+00 -5.980683619751089e+00 -6.004179946252954e+00 3.759197088463409e+00 4.624277545644926e+00 9.229892446835385e+03 + 110800 9.689372337704188e-01 -5.914200582566381e+00 -5.996430240768480e+00 4.120687660804618e+00 4.648512238409686e+00 9.206088330180100e+03 + 110820 9.771077488855594e-01 -5.922371536386454e+00 -5.973703922731883e+00 4.106522232920517e+00 4.811763726863944e+00 9.136477062482161e+03 + 110840 1.029057318277087e+00 -5.993233153975304e+00 -5.988387808900963e+00 3.683122830784319e+00 4.710945552015909e+00 9.181426665871040e+03 + 110860 1.052856637779002e+00 -6.023680132429977e+00 -5.954420101826750e+00 3.573419414659027e+00 4.971121228337855e+00 9.077629907030780e+03 + 110880 9.935032302785025e-01 -5.932071185884737e+00 -5.977116655254434e+00 4.034640766151276e+00 4.775982710266622e+00 9.146903785714010e+03 + 110900 9.682863018089735e-01 -5.890509370320800e+00 -5.985262086731094e+00 4.319184537153581e+00 4.775099776590200e+00 9.171821508278499e+03 + 110920 1.069878140287784e+00 -6.034404830613564e+00 -5.954406882439587e+00 3.487369180509094e+00 4.946729778566541e+00 9.077608990553976e+03 + 110940 1.049541721033236e+00 -5.994416771630478e+00 -6.012098365047850e+00 3.741638591622209e+00 4.640108146001921e+00 9.254214131886341e+03 + 110960 1.027501671195375e+00 -5.951873905931321e+00 -6.037344404540329e+00 3.933101412312666e+00 4.442316582782825e+00 9.332039106082710e+03 + 110980 1.030918474025120e+00 -5.949436853321159e+00 -5.978218377951757e+00 4.029921225087845e+00 4.864653256732410e+00 9.150296896796699e+03 + 111000 1.045665672962105e+00 -5.963196290822335e+00 -5.983461380501097e+00 3.887093623675416e+00 4.770728342727475e+00 9.166344934087050e+03 + 111020 1.010436152146698e+00 -5.905420479303333e+00 -6.022489283787945e+00 4.173740539306135e+00 4.501513347616547e+00 9.286197488941209e+03 + 111040 1.037631681104065e+00 -5.944642672066583e+00 -6.035530229015361e+00 3.939236095514004e+00 4.417345678710140e+00 9.326445574624624e+03 + 111060 1.009670064137955e+00 -5.908762201580893e+00 -6.031940133792171e+00 4.156371834436221e+00 4.449065085955656e+00 9.315366298207058e+03 + 111080 1.048800838140544e+00 -5.977284388178622e+00 -5.993652855485705e+00 3.820101850431631e+00 4.726111578142228e+00 9.197551724132283e+03 + 111100 1.031191935986498e+00 -5.966493753947737e+00 -6.021743574359066e+00 3.838147327272266e+00 4.520894308588336e+00 9.283895453959811e+03 + 111120 1.004103555314783e+00 -5.945673672358472e+00 -5.998884435648916e+00 4.009127662067989e+00 4.703583224915254e+00 9.213610812065273e+03 + 111140 1.066473776201106e+00 -6.060432615401361e+00 -5.978320714394387e+00 3.373378724253937e+00 4.844877966611593e+00 9.150612090525488e+03 + 111160 9.602690636643264e-01 -5.928424659794904e+00 -6.022453774104839e+00 4.055340083913604e+00 4.515410358587544e+00 9.286091684490717e+03 + 111180 1.016177119751200e+00 -6.036325914314632e+00 -5.985354149752393e+00 3.454128570943415e+00 4.746816330914863e+00 9.172147763521998e+03 + 111200 9.783156488197153e-01 -6.005567932259768e+00 -6.006479107549392e+00 3.666738782607635e+00 4.661506673090692e+00 9.236940913713159e+03 + 111220 9.181222845285862e-01 -5.938101585128927e+00 -5.992923384833532e+00 4.027513437199206e+00 4.712718179649278e+00 9.195342093144875e+03 + 111240 1.055189226094499e+00 -6.160434440854589e+00 -5.938973797666539e+00 2.860750230163276e+00 5.132411514272833e+00 9.030665290268356e+03 + 111260 9.939873840837822e-01 -6.085397504881648e+00 -5.989006037103252e+00 3.198727797964836e+00 4.752222522479816e+00 9.183336323775602e+03 + 111280 9.922302180708334e-01 -6.093578990058133e+00 -5.970659345371847e+00 3.196572662644885e+00 4.902396284187081e+00 9.127215704886079e+03 + 111300 9.975016575991168e-01 -6.110003702093761e+00 -5.997694583738388e+00 3.107178286027738e+00 4.752074623404186e+00 9.209968203572816e+03 + 111320 9.858404488471383e-01 -6.097399325853936e+00 -5.967008522660524e+00 3.172077300258467e+00 4.920801470106625e+00 9.116057831092041e+03 + 111340 8.937047523539449e-01 -5.960955633179434e+00 -5.976103394022425e+00 3.973044841375450e+00 4.886064054506583e+00 9.143841157089402e+03 + 111360 9.345930370709843e-01 -6.014846398485147e+00 -5.993273033293162e+00 3.607468002693266e+00 4.731345604093116e+00 9.196406853469070e+03 + 111380 9.521015634277409e-01 -6.027317244914769e+00 -6.009915940983170e+00 3.526811936776090e+00 4.626732916794415e+00 9.247497130018810e+03 + 111400 9.444295435439848e-01 -5.992360209202766e+00 -6.000844458964826e+00 3.713257459930913e+00 4.664539584863757e+00 9.219664146890742e+03 + 111420 9.643482513485202e-01 -5.988915210575982e+00 -6.023522878623160e+00 3.739510589914594e+00 4.540788004468376e+00 9.289415881345927e+03 + 111440 1.039504716686269e+00 -6.058618273162059e+00 -6.008343730949672e+00 3.371075052139666e+00 4.659759253483458e+00 9.242683781657561e+03 + 111460 1.047896619849942e+00 -6.026840106503495e+00 -5.985610583256140e+00 3.541385660226431e+00 4.778131962960845e+00 9.172944351384149e+03 + 111480 9.701543287210241e-01 -5.872532859233743e+00 -6.006632318932620e+00 4.382733270682891e+00 4.612713421267623e+00 9.237400225784750e+03 + 111500 1.061083407054791e+00 -5.975134273675539e+00 -5.939173958108073e+00 3.872146387863249e+00 5.078636084692489e+00 9.031241801945966e+03 + 111520 1.039485777219276e+00 -5.918606712648376e+00 -6.004185565999315e+00 4.108690990387281e+00 4.617283971161438e+00 9.229894287400131e+03 + 111540 1.107517426780466e+00 -6.005395457177568e+00 -6.006153635084738e+00 3.726917361565975e+00 4.722563786695354e+00 9.235949725726510e+03 + 111560 1.101627473574728e+00 -5.992690650609672e+00 -6.028964406101128e+00 3.720078255896747e+00 4.511788738519282e+00 9.306178288973704e+03 + 111580 9.857659765130373e-01 -5.826106772232249e+00 -6.033497805900936e+00 4.665435346269978e+00 4.474563937285642e+00 9.320169667796639e+03 + 111600 1.111285494103226e+00 -6.020646909397804e+00 -6.030585305953753e+00 3.545150437071742e+00 4.488082626085586e+00 9.311186504551011e+03 + 111620 1.058771636532120e+00 -5.959142631049523e+00 -6.020674490123155e+00 3.935391892792472e+00 4.582066435967256e+00 9.280638493041863e+03 + 111640 1.043434973045050e+00 -5.956501479154894e+00 -5.990665095297387e+00 3.940518058077556e+00 4.744345287384851e+00 9.188429806491069e+03 + 111660 9.984394584470870e-01 -5.909608704296278e+00 -5.996116991726510e+00 4.217111904268965e+00 4.720367930730356e+00 9.205121390904345e+03 + 111680 1.049876049036680e+00 -6.005772721718293e+00 -5.983630090876565e+00 3.706467827976851e+00 4.833614240831100e+00 9.166843227957525e+03 + 111700 9.806974178439940e-01 -5.919821212285073e+00 -5.975595958443669e+00 4.206761238923346e+00 4.886494015366616e+00 9.142260976349111e+03 + 111720 9.813604101523604e-01 -5.933462982325751e+00 -6.006642808129040e+00 4.069848783962958e+00 4.649638899659030e+00 9.237447113889462e+03 + 111740 1.073805007676233e+00 -6.082661015580848e+00 -6.024920013212152e+00 3.174601220463178e+00 4.506158991455472e+00 9.293728383696200e+03 + 111760 9.482265325865137e-01 -5.910512277042267e+00 -6.037083566278443e+00 4.174210310311450e+00 4.447418380673622e+00 9.331248486415872e+03 + 111780 1.023679590095926e+00 -6.036594546643461e+00 -6.002961212197041e+00 3.489621149234639e+00 4.682748960367668e+00 9.226137770676005e+03 + 111800 9.841086484805363e-01 -5.989603784701198e+00 -5.991835231666723e+00 3.736600567026359e+00 4.723787253235010e+00 9.191994836874475e+03 + 111820 9.734878626708389e-01 -5.982285661913116e+00 -5.994231888242911e+00 3.763389458101385e+00 4.694792377843147e+00 9.199337437610056e+03 + 111840 9.770625753244400e-01 -5.992041971495479e+00 -6.012777186406056e+00 3.686582482247180e+00 4.567517669466510e+00 9.256298126508629e+03 + 111860 1.004596017401001e+00 -6.035938785135500e+00 -6.007851569537477e+00 3.458308655396451e+00 4.619589793842865e+00 9.241170037027769e+03 + 111880 9.313120053160255e-01 -5.929876485774042e+00 -6.019447140597779e+00 4.063103671624955e+00 4.548775110613019e+00 9.276866041846290e+03 + 111900 1.017806396240722e+00 -6.058964406949322e+00 -5.982245130403562e+00 3.390398642528663e+00 4.830932600724090e+00 9.162635031916396e+03 + 111920 9.460214591981132e-01 -5.951483996798249e+00 -6.023243205895675e+00 3.897844565494837e+00 4.485792082155703e+00 9.288556302344510e+03 + 111940 1.026796276654055e+00 -6.070120339547088e+00 -5.990444252630297e+00 3.322666753001584e+00 4.780179173912401e+00 9.187739841325780e+03 + 111960 1.019824781738202e+00 -6.057163413659826e+00 -5.975738360776909e+00 3.417599978496777e+00 4.885155232636697e+00 9.142716070591070e+03 + 111980 9.893405509936312e-01 -6.006747445465161e+00 -5.998897254121099e+00 3.640915067087164e+00 4.685992080597957e+00 9.213674527775023e+03 + 112000 1.029801462068605e+00 -6.061093497559658e+00 -6.015887862945173e+00 3.382825426985163e+00 4.642403176490883e+00 9.265882795447988e+03 + 112020 1.013891882605652e+00 -6.031724954082367e+00 -5.987893065030248e+00 3.556809122500562e+00 4.808498612400735e+00 9.179925012016374e+03 + 112040 9.441295887970530e-01 -5.919166393749313e+00 -6.021275230192233e+00 4.133768835502072e+00 4.547444095355455e+00 9.282466717806450e+03 + 112060 9.782307499912646e-01 -5.953573848412131e+00 -5.990341986020471e+00 3.897388923562600e+00 4.686260587564609e+00 9.187405018771748e+03 + 112080 1.021895570391615e+00 -5.988985007037840e+00 -5.955934037736656e+00 3.719641313409356e+00 4.909425093757726e+00 9.082268945251126e+03 + 112100 9.726628506030949e-01 -5.868137315120887e+00 -6.050162744633055e+00 4.376340363230061e+00 4.331122178627012e+00 9.371641703939247e+03 + 112120 1.039983761963153e+00 -5.916553935808989e+00 -6.008074272884080e+00 4.221542218271228e+00 4.696018280059661e+00 9.241797779237866e+03 + 112140 1.093970690365973e+00 -5.950351419042191e+00 -5.992127252901698e+00 4.015033529771657e+00 4.775150226960967e+00 9.192876585663680e+03 + 112160 1.117233274510646e+00 -5.951918136847778e+00 -6.003026156084546e+00 3.927002023609317e+00 4.633531868211378e+00 9.226329642928677e+03 + 112180 1.142221890582489e+00 -5.968804373149219e+00 -6.031058203100200e+00 3.840362138154210e+00 4.482891012826629e+00 9.312638135246281e+03 + 112200 1.012323696306997e+00 -5.771619776094927e+00 -6.017996031419013e+00 4.924452856219661e+00 4.509722271546467e+00 9.272367211949888e+03 + 112220 1.114858153951045e+00 -5.931804759785768e+00 -5.939876290796046e+00 4.096092062384701e+00 5.049744082258299e+00 9.033369823765770e+03 + 112240 1.063264101129018e+00 -5.868562712121157e+00 -5.954957656903862e+00 4.382275459309321e+00 4.886182316792529e+00 9.079272850531905e+03 + 112260 1.072255703587938e+00 -5.902364608679283e+00 -6.016869291164967e+00 4.225234248692203e+00 4.567730642317057e+00 9.268867501101500e+03 + 112280 1.032427631215861e+00 -5.873933553140099e+00 -6.030548519736200e+00 4.342850609960531e+00 4.443543235677963e+00 9.311061316137582e+03 + 112300 1.056795404824008e+00 -5.947507293202518e+00 -6.013471156274208e+00 4.023193881658536e+00 4.644419172026075e+00 9.258443153267175e+03 + 112320 1.047209040150620e+00 -5.975751400031753e+00 -6.016668285107681e+00 3.827873675055265e+00 4.592922589081788e+00 9.268288653349489e+03 + 112340 1.001260321361975e+00 -5.947078366924009e+00 -6.044742148893015e+00 3.945870648550144e+00 4.385070099062698e+00 9.354903095537165e+03 + 112360 9.544192412749180e-01 -5.911314017682950e+00 -6.017588959512472e+00 4.153382069776783e+00 4.543134907797570e+00 9.271121278065202e+03 + 112380 1.032777884651742e+00 -6.051378469205162e+00 -5.978393410059456e+00 3.449191470216566e+00 4.868282974232612e+00 9.150836207474431e+03 + 112400 9.738356801680723e-01 -5.983476856030845e+00 -6.025204058708162e+00 3.760786340528559e+00 4.521182285491656e+00 9.294577660645440e+03 + 112420 9.028365843422189e-01 -5.891615774347817e+00 -6.051507190046572e+00 4.264103848047638e+00 4.345982595988771e+00 9.375840159828111e+03 + 112440 1.022262327714030e+00 -6.078301438381282e+00 -6.022091961421074e+00 3.254489506418229e+00 4.577253021512193e+00 9.285024106604636e+03 + 112460 9.570519654278702e-01 -5.991525568739491e+00 -6.007907464694703e+00 3.732394653439310e+00 4.638327271774273e+00 9.241351728217667e+03 + 112480 9.728793577360111e-01 -6.021165919431777e+00 -5.964217160941988e+00 3.619697788273157e+00 4.946706372313415e+00 9.107500697588519e+03 + 112500 9.472610752983668e-01 -5.983055858056479e+00 -6.011871375680914e+00 3.766298959726162e+00 4.600835798339717e+00 9.253515253510195e+03 + 112520 9.683680695839346e-01 -6.012078326354022e+00 -6.031057450717303e+00 3.608581020153336e+00 4.499599951049372e+00 9.312643181611564e+03 + 112540 9.286410803126433e-01 -5.949956065693167e+00 -6.016884042632134e+00 3.981028016207337e+00 4.596717215552833e+00 9.268906746195840e+03 + 112560 9.880114599969321e-01 -6.031045229374580e+00 -6.004247482297878e+00 3.529544332998773e+00 4.683421143651152e+00 9.230071120742916e+03 + 112580 1.033566902913825e+00 -6.088407727935910e+00 -5.956830823595413e+00 3.241836669694032e+00 4.997371615877306e+00 9.085000863855206e+03 + 112600 1.026499153719529e+00 -6.062625777883843e+00 -5.989264561641019e+00 3.381429494027660e+00 4.802680950305485e+00 9.184135402990934e+03 + 112620 9.787822126333490e-01 -5.972108597185451e+00 -6.033555700576012e+00 3.828184700893133e+00 4.475345924316010e+00 9.320368607133381e+03 + 112640 1.010365009387511e+00 -5.995069760483652e+00 -6.002490933088361e+00 3.706583774803454e+00 4.663970253284464e+00 9.224714699784223e+03 + 112660 1.035760779966444e+00 -6.002250379137616e+00 -5.979033865765347e+00 3.726646934808283e+00 4.859959747335681e+00 9.152797152690471e+03 + 112680 1.060715195483406e+00 -6.003945310973230e+00 -6.008690448792052e+00 3.634917633965542e+00 4.607670318302161e+00 9.243754089977700e+03 + 112700 9.841917910101614e-01 -5.852184329555497e+00 -6.033786659675354e+00 4.467308339587380e+00 4.424519657169401e+00 9.321051771123113e+03 + 112720 1.104639564783796e+00 -5.991269594685749e+00 -6.018015873874688e+00 3.735273613528165e+00 4.581692339451948e+00 9.272435752443089e+03 + 112740 1.039991506425092e+00 -5.863744358161580e+00 -6.063085872271873e+00 4.419863744563146e+00 4.275213922542231e+00 9.411699943425419e+03 + 112760 1.096825801494530e+00 -5.923129536680826e+00 -6.050920629883802e+00 4.138623525554966e+00 4.404827292775722e+00 9.374012398218158e+03 + 112780 1.101991631569371e+00 -5.917355392845526e+00 -6.033706716956830e+00 4.157702282965710e+00 4.489594974609392e+00 9.320784516298112e+03 + 112800 1.073605973412022e+00 -5.874368400455048e+00 -6.009999607655142e+00 4.302588398894682e+00 4.523773018290265e+00 9.247754377911269e+03 + 112820 1.021494132956437e+00 -5.805427312556081e+00 -5.992989607764832e+00 4.766420209984341e+00 4.689408485724316e+00 9.195518420894983e+03 + 112840 1.086270501776049e+00 -5.918723823934997e+00 -5.970107864302296e+00 4.144759026316798e+00 4.849703914873215e+00 9.125507338767253e+03 + 112860 1.102694435851142e+00 -5.972893292202882e+00 -6.017925467336310e+00 3.764997980216253e+00 4.506416261893532e+00 9.272143254730523e+03 + 112880 1.036232309405085e+00 -5.922596337429281e+00 -6.021375478045726e+00 4.145438918103546e+00 4.578233806661314e+00 9.282776690737612e+03 + 112900 1.023503582434142e+00 -5.966807125155170e+00 -6.034573335786801e+00 3.904974035438164e+00 4.515849967204138e+00 9.323483931288612e+03 + 112920 1.011186990960679e+00 -6.011044671223917e+00 -6.006752911633685e+00 3.625282771954137e+00 4.649926719668900e+00 9.237806395953048e+03 + 112940 1.001289053044683e+00 -6.037731418891625e+00 -6.000495492667651e+00 3.462255195442999e+00 4.676069646062018e+00 9.218594676722127e+03 + 112960 1.008775356213988e+00 -6.071726304753554e+00 -5.990345243550217e+00 3.296260999429061e+00 4.763563646537142e+00 9.187442953608745e+03 + 112980 9.526629348352041e-01 -5.998557720422706e+00 -5.997967681879594e+00 3.691455655024016e+00 4.694843747646738e+00 9.210811211060080e+03 + 113000 9.554828700084781e-01 -6.007309760084733e+00 -5.991770217609819e+00 3.675483466219661e+00 4.764713923847049e+00 9.191816672704685e+03 + 113020 9.797326210612155e-01 -6.043784957044888e+00 -5.995665141972500e+00 3.480835332444785e+00 4.757146757107755e+00 9.203761768012422e+03 + 113040 9.520094179280255e-01 -6.000775349012436e+00 -6.056143694416001e+00 3.667632472893179e+00 4.349698865362146e+00 9.390212029247985e+03 + 113060 1.030924653086844e+00 -6.114912249686742e+00 -5.982633037174955e+00 3.084816800435485e+00 4.844384508820145e+00 9.163829477925674e+03 + 113080 9.092384190293057e-01 -5.929686176614419e+00 -6.001626336376643e+00 4.077125215643143e+00 4.664033685584713e+00 9.222028381919681e+03 + 113100 9.662443448407803e-01 -6.006029271160831e+00 -6.004899222190875e+00 3.604461287413153e+00 4.610950203473147e+00 9.232077653661605e+03 + 113120 1.033164169265315e+00 -6.091095419794104e+00 -5.977082070017034e+00 3.211030038660478e+00 4.865712336589267e+00 9.146835676731971e+03 + 113140 9.131351899904186e-01 -5.897298950860867e+00 -6.013893381773849e+00 4.237310525608184e+00 4.567807260375967e+00 9.259751920694109e+03 + 113160 1.013375361729576e+00 -6.029093799889345e+00 -6.004926951447247e+00 3.527146795917496e+00 4.665916579479733e+00 9.232170232674449e+03 + 113180 1.030704204832548e+00 -6.035286287984006e+00 -5.972676845093771e+00 3.506526422305494e+00 4.866039532161200e+00 9.133350279996721e+03 + 113200 9.875932130617632e-01 -5.949753366996313e+00 -5.970101753158358e+00 3.964169563726837e+00 4.847325981481792e+00 9.125454959479053e+03 + 113220 9.510169905781202e-01 -5.871570792428457e+00 -6.019402628725497e+00 4.366759279132028e+00 4.517885998211693e+00 9.276704909503804e+03 + 113240 1.077476891150832e+00 -6.034883298138407e+00 -5.982987886882397e+00 3.525048183102412e+00 4.823039665323355e+00 9.164910266137058e+03 + 113260 1.027897530824558e+00 -5.940250023781255e+00 -5.993106859960003e+00 4.006870058391183e+00 4.703357925483852e+00 9.195922781189589e+03 + 113280 1.076262370081546e+00 -5.994895708950537e+00 -6.000897749981492e+00 3.676421212907137e+00 4.641956564494544e+00 9.219822326479885e+03 + 113300 9.701373657215846e-01 -5.825652122738456e+00 -6.028793601422917e+00 4.650481159842307e+00 4.484011353193900e+00 9.305624317524333e+03 + 113320 1.054669056995143e+00 -5.942618294056290e+00 -6.020552121898811e+00 3.957082457596592e+00 4.509574357903950e+00 9.280224627942498e+03 + 113340 1.016782563212612e+00 -5.882035593971959e+00 -6.000343693030219e+00 4.302713270510464e+00 4.623369857598774e+00 9.218085605935799e+03 + 113360 1.078824021448599e+00 -5.974874840094940e+00 -5.990771558958288e+00 3.855144651496955e+00 4.763863231774318e+00 9.188727764965499e+03 + 113380 1.033719208847871e+00 -5.914977638474406e+00 -6.052290668171545e+00 4.110204723353224e+00 4.321732057709582e+00 9.378265747337004e+03 + 113400 1.045094516395950e+00 -5.950313142057055e+00 -6.009480354958228e+00 3.964492944592078e+00 4.624745652016933e+00 9.246173678746440e+03 + 113420 1.077459782396304e+00 -6.031124883337768e+00 -6.016096399977622e+00 3.504560422417837e+00 4.590856299522082e+00 9.266517289748233e+03 + 113440 1.014573734781699e+00 -5.986643936120537e+00 -5.988716017665541e+00 3.791124906424821e+00 4.779226693539822e+00 9.182449793893447e+03 + 113460 9.699543594450900e-01 -5.972677358844041e+00 -5.967225303644832e+00 3.875052409097890e+00 4.906358953754564e+00 9.116702899989559e+03 + 113480 1.007995918393916e+00 -6.074510348345209e+00 -5.977228052368504e+00 3.321417898756263e+00 4.880027896641145e+00 9.147272906595867e+03 + 113500 9.465936560258704e-01 -6.018046368565143e+00 -5.999683225642820e+00 3.587715546625480e+00 4.693159554972642e+00 9.216072989680511e+03 + 113520 9.765161548561365e-01 -6.083408604135547e+00 -5.969022009393258e+00 3.222409194546709e+00 4.879234722825258e+00 9.122191299702190e+03 + 113540 9.550632445626812e-01 -6.062469186559603e+00 -5.971897173359440e+00 3.383392880745893e+00 4.903471396514970e+00 9.130974209036232e+03 + 113560 9.580071778564068e-01 -6.071084510136440e+00 -5.971197661314061e+00 3.357357348336250e+00 4.930923091714245e+00 9.128843541282820e+03 + 113580 9.585002691973682e-01 -6.070862372648827e+00 -5.968978229651892e+00 3.338004867571080e+00 4.923039383179654e+00 9.122047974077705e+03 + 113600 9.428661625332835e-01 -6.040425483797128e+00 -5.983053672782269e+00 3.516068546360648e+00 4.845506363467027e+00 9.165108545142863e+03 + 113620 9.733918922064689e-01 -6.072677020419745e+00 -5.992175778771664e+00 3.357858280309440e+00 4.820108867379604e+00 9.193033241767318e+03 + 113640 9.732593649783844e-01 -6.057148647421263e+00 -5.987460685311481e+00 3.366971130950846e+00 4.767130193562497e+00 9.178596713166997e+03 + 113660 9.593182499716776e-01 -6.016261732715918e+00 -5.968824471763391e+00 3.602473225265421e+00 4.874865318547243e+00 9.121614053576681e+03 + 113680 9.565719129233565e-01 -5.986905981890414e+00 -5.997695104696803e+00 3.757040475575460e+00 4.695087662809813e+00 9.209963229043891e+03 + 113700 9.974237650737166e-01 -6.020806454879279e+00 -5.985036018362759e+00 3.576888931044472e+00 4.782288312979492e+00 9.171185938372961e+03 + 113720 1.032111779857968e+00 -6.045832960442330e+00 -6.007841131455322e+00 3.374538036229640e+00 4.592692997489573e+00 9.241135564216249e+03 + 113740 9.370960152366516e-01 -5.881807388137046e+00 -6.003767009137555e+00 4.318257517615905e+00 4.617946500640626e+00 9.228636759513505e+03 + 113760 9.987285852893487e-01 -5.952030189254684e+00 -5.991043032303238e+00 3.959702631462265e+00 4.735684849459516e+00 9.189588225068594e+03 + 113780 1.034851077895147e+00 -5.987793492752577e+00 -6.018466162408034e+00 3.759168756987673e+00 4.583041541245755e+00 9.273853988620740e+03 + 113800 1.031402255129489e+00 -5.970781351669201e+00 -6.027566879450599e+00 3.812824822440794e+00 4.486753534387985e+00 9.301888227314988e+03 + 113820 9.912195830760997e-01 -5.907685476749060e+00 -5.990690118964459e+00 4.215173462619264e+00 4.738547962091570e+00 9.188481314124841e+03 + 113840 9.895887901706492e-01 -5.903434694432494e+00 -6.005479618149522e+00 4.260868319500625e+00 4.674910576116546e+00 9.233875152328470e+03 + 113860 1.048966657230630e+00 -5.990749914934770e+00 -6.032066354551847e+00 3.796463011992338e+00 4.559217622012713e+00 9.315745028844925e+03 + 113880 1.062813217444219e+00 -6.016250267686625e+00 -6.013531085179030e+00 3.624901237923049e+00 4.640515204673799e+00 9.258642322234353e+03 + 113900 1.064297881995743e+00 -6.027402136134818e+00 -5.994982802194350e+00 3.564899433865659e+00 4.751056266227535e+00 9.201644420571547e+03 + 113920 9.761201307631696e-01 -5.907371845776227e+00 -5.986126829497518e+00 4.212961810534922e+00 4.760738506712925e+00 9.174492515017480e+03 + 113940 1.039544062081106e+00 -6.009140901023782e+00 -5.942429233748474e+00 3.637408045404457e+00 5.020476762496428e+00 9.041143964566912e+03 + 113960 9.484686145912248e-01 -5.878978124037797e+00 -5.991558331540006e+00 4.336901459456993e+00 4.690448486248504e+00 9.191104857731812e+03 + 113980 1.029676243336075e+00 -6.002540007402444e+00 -5.988748661124262e+00 3.698245865745814e+00 4.777437910279071e+00 9.182548691917405e+03 + 114000 1.066307883086707e+00 -6.061825222391717e+00 -5.998154762467087e+00 3.429188673200099e+00 4.794794307059157e+00 9.211384432175719e+03 + 114020 1.012170639523084e+00 -5.987630761835677e+00 -6.006718790502893e+00 3.785567560416475e+00 4.675961145946433e+00 9.237670007925622e+03 + 114040 1.012237078285955e+00 -5.994303093949665e+00 -5.983109754365438e+00 3.746055180284045e+00 4.810329068340382e+00 9.165258430533475e+03 + 114060 9.350144896449656e-01 -5.886060327460289e+00 -5.977441102339642e+00 4.278759599296638e+00 4.754037048810178e+00 9.147911617177664e+03 + 114080 9.719676908691326e-01 -5.944628647863579e+00 -6.019507937752971e+00 3.979791900302450e+00 4.549823430224899e+00 9.277008756236615e+03 + 114100 1.013583477229469e+00 -6.008344761341019e+00 -6.048638400126632e+00 3.613311324749450e+00 4.381939015422009e+00 9.366962074901199e+03 + 114120 9.901444731932068e-01 -5.977666291252664e+00 -6.016113971587893e+00 3.832718189986429e+00 4.611945659742240e+00 9.266589798265566e+03 + 114140 1.032235740658200e+00 -6.046020510097127e+00 -5.991301816891938e+00 3.428112534107370e+00 4.742315738181970e+00 9.190362936041553e+03 + 114160 9.948893748952021e-01 -5.995203567197650e+00 -6.001309732131205e+00 3.680069525422533e+00 4.645006981448095e+00 9.221067897810097e+03 + 114180 1.019823091815238e+00 -6.037055497355435e+00 -6.003675659067570e+00 3.493200989618420e+00 4.684873186580623e+00 9.228354277821763e+03 + 114200 9.927523472731969e-01 -6.001886555768004e+00 -6.000871301956449e+00 3.699601495269073e+00 4.705431239765042e+00 9.219714799005984e+03 + 114220 9.881518014720707e-01 -5.999105537834663e+00 -6.014353490289971e+00 3.755373017441222e+00 4.667816914829828e+00 9.261144848628839e+03 + 114240 1.016040647686079e+00 -6.046078688703781e+00 -6.008284648340958e+00 3.484530939291102e+00 4.701550167663281e+00 9.242502889609605e+03 + 114260 9.751781568006535e-01 -5.993839546920234e+00 -6.034718446173386e+00 3.723275215074354e+00 4.488542249573539e+00 9.323945008990200e+03 + 114280 9.876600887134892e-01 -6.024058286045167e+00 -5.977606912714770e+00 3.591292811880153e+00 4.858023785870085e+00 9.148434469057462e+03 + 114300 9.279943874681172e-01 -5.949338161157915e+00 -6.033965396574587e+00 3.928322246600904e+00 4.442379564816020e+00 9.321594125027259e+03 + 114320 9.734212108341603e-01 -6.035755212052912e+00 -6.006358676607336e+00 3.479917681203690e+00 4.648717136831348e+00 9.236592121378399e+03 + 114340 9.361629312182546e-01 -6.005357420508593e+00 -6.016701253394597e+00 3.689740859460033e+00 4.624602815576132e+00 9.268381435668309e+03 + 114360 9.984797514065338e-01 -6.127002908136752e+00 -5.967393734568075e+00 3.021427430113635e+00 4.937928004184760e+00 9.117228372103360e+03 + 114380 9.241082874120187e-01 -6.041427376074948e+00 -6.001426924993354e+00 3.478574403426562e+00 4.708263183586870e+00 9.221445869778096e+03 + 114400 9.166734349945528e-01 -6.050490302696779e+00 -6.034686669706339e+00 3.425736104776600e+00 4.516483011012005e+00 9.323852760134369e+03 + 114420 9.540753625386068e-01 -6.121269248603554e+00 -6.024926797350015e+00 3.038316389226277e+00 4.591529653270244e+00 9.293748780272050e+03 + 114440 9.275624211784377e-01 -6.092232810000117e+00 -6.026063710235309e+00 3.190692915351534e+00 4.570646125836160e+00 9.297254529045198e+03 + 114460 9.089872402155654e-01 -6.069989882224721e+00 -6.026233653209098e+00 3.300682754539985e+00 4.551937792802253e+00 9.297745867675678e+03 + 114480 8.986883009650131e-01 -6.053128694530239e+00 -5.976536028998446e+00 3.438382181513641e+00 4.878189119673883e+00 9.145157543924655e+03 + 114500 9.208940798698924e-01 -6.072316822626412e+00 -5.973278380182093e+00 3.327350133968140e+00 4.896044196632853e+00 9.135197785179555e+03 + 114520 8.966062093835646e-01 -6.011746921298261e+00 -6.014028565573266e+00 3.627664831660042e+00 4.614563277149652e+00 9.260167896828483e+03 + 114540 9.608892047363230e-01 -6.074252966389166e+00 -5.964157827691939e+00 3.280149357758829e+00 4.912332681325958e+00 9.107351316924469e+03 + 114560 9.502408319328034e-01 -6.019586317047469e+00 -5.981799294730994e+00 3.571566052818150e+00 4.788544982482157e+00 9.161271532158804e+03 + 114580 9.455923257909551e-01 -5.972871550717184e+00 -6.001773832772233e+00 3.784723636583835e+00 4.618762260410051e+00 9.222476638644670e+03 + 114600 9.563933309029268e-01 -5.954140615221743e+00 -5.963092404350133e+00 3.935051155489298e+00 4.883648597029187e+00 9.104071673938362e+03 + 114620 1.017672937587490e+00 -6.013948626769524e+00 -5.946937230028477e+00 3.593030502860635e+00 4.977820312927859e+00 9.054869654368993e+03 + 114640 1.020235026499452e+00 -5.991650175413183e+00 -5.968294192919729e+00 3.733348544285944e+00 4.867462210089965e+00 9.119963191635075e+03 + 114660 1.053808936372456e+00 -6.022246529393220e+00 -5.983637615854693e+00 3.545676205649335e+00 4.767374561897613e+00 9.166877814024618e+03 + 114680 1.015713838451005e+00 -5.953462432481670e+00 -6.014695285795971e+00 3.876994835515561e+00 4.525386316031418e+00 9.262214763477059e+03 + 114700 1.030059648388689e+00 -5.968048713459213e+00 -5.973874180755219e+00 3.857110172618556e+00 4.823659437916739e+00 9.137015870492929e+03 + 114720 9.793141107051818e-01 -5.887369780889277e+00 -5.985430306145205e+00 4.313098656409311e+00 4.750019945572535e+00 9.172343807741343e+03 + 114740 1.108499395985057e+00 -6.075114843697733e+00 -6.000093925244825e+00 3.241162047854659e+00 4.671943771060866e+00 9.217346836853631e+03 + 114760 1.016146324555306e+00 -5.941145857503872e+00 -5.996700443007210e+00 4.028234058808827e+00 4.709231031804336e+00 9.206909578845509e+03 + 114780 9.826309191595709e-01 -5.896904889810783e+00 -5.986800985240579e+00 4.250689870221032e+00 4.734492578887337e+00 9.176543234676079e+03 + 114800 1.048980383213334e+00 -6.002343103405348e+00 -5.971510380634568e+00 3.656315587054283e+00 4.833361852552533e+00 9.129787268068190e+03 + 114820 1.038078191314808e+00 -5.995695368089716e+00 -5.973904551433509e+00 3.755913319357080e+00 4.881039560715004e+00 9.137103612939394e+03 + 114840 9.527878269645629e-01 -5.883972673083365e+00 -6.061480518915112e+00 4.304650666189980e+00 4.285373146173723e+00 9.406732078788484e+03 + 114860 9.960626330410667e-01 -5.967178513457945e+00 -6.011921673176140e+00 3.896209909328360e+00 4.639287762244897e+00 9.253670673006614e+03 + 114880 1.081120659509301e+00 -6.117591968362975e+00 -6.005213271947661e+00 3.032217089614806e+00 4.677512954978603e+00 9.233065521601533e+03 + 114900 9.787758914184822e-01 -5.997655224115322e+00 -5.980676598491577e+00 3.691303212385530e+00 4.788797108150893e+00 9.157836634988545e+03 + 114920 9.283767101323317e-01 -5.955261289235311e+00 -6.016348124292989e+00 3.918761611169657e+00 4.567991551111302e+00 9.267295803962159e+03 + 114940 1.026345801929841e+00 -6.135135516809947e+00 -5.972802142744204e+00 2.946834584639856e+00 4.878977939533806e+00 9.133763103588177e+03 + 114960 9.400767821929477e-01 -6.040557753068327e+00 -5.997109876116139e+00 3.497528286514969e+00 4.747012719511666e+00 9.208174389404181e+03 + 114980 9.885010925280846e-01 -6.141749569187684e+00 -5.958227129747263e+00 2.988387556371792e+00 5.042201803644407e+00 9.089263192756645e+03 + 115000 8.834215323562676e-01 -6.006872864851879e+00 -6.005780643701705e+00 3.715614382371887e+00 4.721886085236863e+00 9.234809068378914e+03 + 115020 9.549549783641625e-01 -6.127537038855931e+00 -5.982618982135310e+00 2.994285912555485e+00 4.826427820242092e+00 9.163784564085996e+03 + 115040 8.592618916115573e-01 -5.991862065445921e+00 -5.995848805626343e+00 3.793482348338149e+00 4.770589869276118e+00 9.204302220281879e+03 + 115060 9.320080535905721e-01 -6.095908460763058e+00 -6.001881851657872e+00 3.172232490280393e+00 4.712147830333098e+00 9.222841070180863e+03 + 115080 9.567206984977937e-01 -6.120077684817631e+00 -5.957980262893769e+00 3.085914238070239e+00 5.016702719252031e+00 9.088511216839581e+03 + 115100 9.471872311000249e-01 -6.085016008971603e+00 -5.953698216399283e+00 3.297917516958683e+00 5.051964603271676e+00 9.075461551603878e+03 + 115120 9.482362598984952e-01 -6.052592713485577e+00 -5.992649242470472e+00 3.409724154409125e+00 4.753928841200019e+00 9.194495313695998e+03 + 115140 9.743372325427673e-01 -6.043686264906296e+00 -5.983352708417082e+00 3.469170878217244e+00 4.815615496166003e+00 9.166018229652835e+03 + 115160 9.583947730061112e-01 -5.961692337913502e+00 -6.037234255746737e+00 3.918898432801710e+00 4.485125050529268e+00 9.331685233030992e+03 + 115180 1.064147524816131e+00 -6.071077005043684e+00 -5.996073644946865e+00 3.326504991298957e+00 4.757185891707352e+00 9.205021238707595e+03 + 115200 1.014640459285939e+00 -5.969012410925837e+00 -6.055921823832534e+00 3.858692366973360e+00 4.359645068874919e+00 9.389523599801134e+03 + 115220 1.047107614766458e+00 -6.007391141822769e+00 -6.004867718296127e+00 3.642953627330929e+00 4.657443515719432e+00 9.232012587299621e+03 + 115240 9.857833348907560e-01 -5.912062633728815e+00 -6.039547021018042e+00 4.146567079692435e+00 4.414531999732517e+00 9.338830670771045e+03 + 115260 9.591776272920423e-01 -5.870192902755024e+00 -6.056994734140273e+00 4.363384560334058e+00 4.290739537029980e+00 9.392800240077355e+03 + 115280 1.021707102147088e+00 -5.963514348278387e+00 -6.034667604770119e+00 3.914971939090261e+00 4.506398929383883e+00 9.323760258369812e+03 + 115300 1.037676506747221e+00 -5.992867576270299e+00 -5.984848299384214e+00 3.680310804249008e+00 4.726358733107992e+00 9.170580429817463e+03 + 115320 9.438804585287131e-01 -5.860159340862808e+00 -6.010139820088994e+00 4.457289598588893e+00 4.596078477467983e+00 9.248148779375824e+03 + 115340 1.050431760987665e+00 -6.025257773167056e+00 -5.987941719070170e+00 3.553958695176375e+00 4.768233252441403e+00 9.180054852839552e+03 + 115360 1.008541291486394e+00 -5.971656023748833e+00 -5.987165607302178e+00 3.870278953164454e+00 4.781220524300849e+00 9.177697531446167e+03 + 115380 1.015738559087593e+00 -5.993322767808143e+00 -6.022625843679510e+00 3.713344778081967e+00 4.545081981792244e+00 9.286644337549245e+03 + 115400 1.015246062446513e+00 -6.007329937363013e+00 -5.990639000783538e+00 3.695789259446718e+00 4.791631200200152e+00 9.188314129706625e+03 + 115420 9.841562442887188e-01 -5.976137400752878e+00 -5.984919251867787e+00 3.750829832183318e+00 4.700403084094444e+00 9.170801773195339e+03 + 115440 9.880231411850198e-01 -5.996630605481924e+00 -5.976635420343206e+00 3.673838711002735e+00 4.788654158314150e+00 9.145466849722154e+03 + 115460 9.752524880071806e-01 -5.993058197850645e+00 -6.010190639472415e+00 3.738381426797157e+00 4.640004295768178e+00 9.248351295833612e+03 + 115480 9.436185103465057e-01 -5.962555171852312e+00 -6.016121708828805e+00 3.840893553730930e+00 4.533306209017103e+00 9.266604602444208e+03 + 115500 9.804783019172608e-01 -6.031567085509149e+00 -5.956503363857028e+00 3.491328736146496e+00 4.922356241946362e+00 9.084000041968580e+03 + 115520 9.530795407708276e-01 -6.000702609419029e+00 -5.987602615052773e+00 3.672332783482519e+00 4.747554978351141e+00 9.179019315910158e+03 + 115540 9.540717821534227e-01 -6.010568525848295e+00 -5.965844467687583e+00 3.670920331787683e+00 4.927732794772123e+00 9.112465492530175e+03 + 115560 9.949636579114209e-01 -6.075100980480340e+00 -5.940154363781765e+00 3.325671634574419e+00 5.100555990579073e+00 9.034244913495635e+03 + 115580 9.297839995398247e-01 -5.978027671462576e+00 -6.007196339566519e+00 3.792812273463076e+00 4.625321267373435e+00 9.239142776757682e+03 + 115600 9.639335458411719e-01 -6.023247159630619e+00 -5.984988450917092e+00 3.649683618375769e+00 4.869371044324883e+00 9.171008814161987e+03 + 115620 9.480967712461127e-01 -5.988543217298493e+00 -6.022464986277821e+00 3.708166852017379e+00 4.513382805161293e+00 9.286123919874937e+03 + 115640 1.042438018655239e+00 -6.109874242786559e+00 -5.991821774739281e+00 3.144994398002097e+00 4.822869938089960e+00 9.191960403872252e+03 + 115660 1.018887999443309e+00 -6.050610105719376e+00 -5.967598656566055e+00 3.453854449535156e+00 4.930519036553761e+00 9.117823109267441e+03 + 115680 9.487654957513630e-01 -5.917013053151931e+00 -6.007032329143553e+00 4.164626401546617e+00 4.647721788364783e+00 9.238628725889652e+03 + 115700 1.040901516783207e+00 -6.016174830560059e+00 -6.001227972569668e+00 3.655180409127131e+00 4.741007580726753e+00 9.220814342989204e+03 + 115720 9.606821142364232e-01 -5.855274460834777e+00 -6.044010338293592e+00 4.446254864560195e+00 4.362504249409036e+00 9.352634635265116e+03 + 115740 1.029437107508960e+00 -5.925006379131222e+00 -5.987520424766698e+00 4.146357103235551e+00 4.787391779179353e+00 9.178731503562047e+03 + 115760 1.014149354863711e+00 -5.874227885726721e+00 -6.009785167258727e+00 4.366167358575662e+00 4.587776470597362e+00 9.247045896079777e+03 + 115780 1.017116764201322e+00 -5.856876060510993e+00 -6.007404757166368e+00 4.419007075188560e+00 4.554648004752872e+00 9.239777791416844e+03 + 115800 1.012735111060968e+00 -5.835870580121798e+00 -6.012399074623852e+00 4.535660097907845e+00 4.522006164780817e+00 9.255133692615505e+03 + 115820 1.170518950811654e+00 -6.064140041024768e+00 -5.983058672898705e+00 3.378763620691427e+00 4.844345383772446e+00 9.165096517481221e+03 + 115840 1.034656926129742e+00 -5.864922979611455e+00 -6.070061330043547e+00 4.372211779724497e+00 4.194275626486290e+00 9.433375545928182e+03 + 115860 1.095003936590017e+00 -5.969061918365272e+00 -6.030963749230336e+00 3.865432657867212e+00 4.509982765762647e+00 9.312341018041341e+03 + 115880 1.078070748096137e+00 -5.967023903467777e+00 -6.008720893669721e+00 3.866926565920028e+00 4.627495995592089e+00 9.243827286178506e+03 + 115900 1.011272421882629e+00 -5.894759840516242e+00 -6.044648988686859e+00 4.248145875205964e+00 4.387459191139569e+00 9.354632598468424e+03 + 115920 1.043937370141305e+00 -5.974455494652282e+00 -6.004310164289635e+00 3.873747378903924e+00 4.702317245851049e+00 9.230301892447762e+03 + 115940 1.067011174816118e+00 -6.041320566213418e+00 -5.999701838839933e+00 3.458441320306593e+00 4.697422493362390e+00 9.216142520064024e+03 + 115960 9.643450360660034e-01 -5.917743413688360e+00 -6.029097557743211e+00 4.115985746488250e+00 4.476573019327193e+00 9.306582907655260e+03 + 115980 1.088064829723041e+00 -6.123466501493525e+00 -5.991126345086427e+00 3.034643513922958e+00 4.794561171585528e+00 9.189844968956248e+03 + 116000 1.033387675375136e+00 -6.059786536920257e+00 -5.994549048114811e+00 3.328204709877401e+00 4.702808466067040e+00 9.200341580300283e+03 + 116020 9.785946186880802e-01 -5.989097244366237e+00 -5.976450910693567e+00 3.814164029902732e+00 4.886781234865019e+00 9.144887726618370e+03 + 116040 9.514850458164700e-01 -5.953463954575531e+00 -5.976331008370617e+00 4.000089061374666e+00 4.868782899818141e+00 9.144523579477236e+03 + 116060 1.039764590501407e+00 -6.085239567253772e+00 -5.975966672743402e+00 3.239007489959272e+00 4.866469360163590e+00 9.143415497383236e+03 + 116080 9.960802880312504e-01 -6.020254613423849e+00 -5.982006594211126e+00 3.606220298940502e+00 4.825846344121803e+00 9.161896507628362e+03 + 116100 9.714445294071716e-01 -5.982960629040862e+00 -6.018037095958313e+00 3.764085936746340e+00 4.562671435640628e+00 9.272478633490437e+03 + 116120 1.009492528157944e+00 -6.038352479995139e+00 -5.988820358988263e+00 3.523304505141495e+00 4.807725609033933e+00 9.182742282289497e+03 + 116140 9.676618566306859e-01 -5.973027191594312e+00 -6.006269204677215e+00 3.889496322863025e+00 4.698615539556093e+00 9.236290220950219e+03 + 116160 1.008695896085540e+00 -6.029795834669740e+00 -6.040308472037577e+00 3.492444963619524e+00 4.432079773028031e+00 9.341190307462442e+03 + 116180 9.517834145329869e-01 -5.942363835215330e+00 -6.006813196306891e+00 3.986368747846018e+00 4.616290542951878e+00 9.237989739064065e+03 + 116200 1.017708202102336e+00 -6.036094392343434e+00 -5.980887343483572e+00 3.508817440041750e+00 4.825824857858273e+00 9.158447362315630e+03 + 116220 1.028367491090283e+00 -6.043791639845765e+00 -5.970683941349794e+00 3.479553343285197e+00 4.899349061428843e+00 9.127262665324412e+03 + 116240 1.043722768071879e+00 -6.056331016278384e+00 -6.025564856140670e+00 3.365019678567140e+00 4.541683731125787e+00 9.295703571246560e+03 + 116260 1.012807112838662e+00 -6.003091514198823e+00 -5.978276695835172e+00 3.747321122738541e+00 4.889811649863353e+00 9.150460588867063e+03 + 116280 9.942655052574523e-01 -5.967694490598584e+00 -5.989176997226503e+00 3.834617936570754e+00 4.711262059106088e+00 9.183828177359288e+03 + 116300 1.031924077008616e+00 -6.012643917196432e+00 -5.965322626480939e+00 3.655530726104838e+00 4.927256900339271e+00 9.110875830043617e+03 + 116320 1.008041245142796e+00 -5.961067517537677e+00 -5.986786804728370e+00 3.853502691148699e+00 4.705818564052913e+00 9.176523956134368e+03 + 116340 9.409537124398405e-01 -5.841789678070485e+00 -6.006412624391139e+00 4.538914107145677e+00 4.593623674053873e+00 9.236719549013169e+03 + 116360 1.072476661301755e+00 -6.010719768889916e+00 -5.988281293954523e+00 3.605005539921596e+00 4.733850735343401e+00 9.181072713690097e+03 + 116380 1.044022024029085e+00 -5.940270506448853e+00 -6.041101195005786e+00 4.003063979782132e+00 4.424078562589602e+00 9.343629202915774e+03 + 116400 1.049265217517751e+00 -5.921917352007418e+00 -6.039049243625064e+00 4.132116731780901e+00 4.459527284010733e+00 9.337304196021254e+03 + 116420 1.073192888191340e+00 -5.936214248138818e+00 -6.003412514717658e+00 4.038918661175243e+00 4.653055815581404e+00 9.227510205491260e+03 + 116440 1.019625005980592e+00 -5.839386146790162e+00 -6.006789052219171e+00 4.556159924264040e+00 4.594906535774784e+00 9.237890506867518e+03 + 116460 1.103386191196567e+00 -5.950861143794795e+00 -5.982606380164641e+00 3.919127152267765e+00 4.736841092472662e+00 9.163716221106220e+03 + 116480 1.072060002622780e+00 -5.899754782717357e+00 -6.017077005636457e+00 4.188389815437967e+00 4.514707455881173e+00 9.269524702456865e+03 + 116500 1.045461037023100e+00 -5.865693579045712e+00 -5.997981784582144e+00 4.362778816712489e+00 4.603159468988648e+00 9.210850823800354e+03 + 116520 1.053469254254188e+00 -5.892053156929113e+00 -6.043468726457377e+00 4.240671971794660e+00 4.371220340079712e+00 9.350942831996854e+03 + 116540 1.053728489177857e+00 -5.922057817436824e+00 -6.034457593784229e+00 4.012197383312949e+00 4.366780473716976e+00 9.323142037918074e+03 + 116560 1.032456421984583e+00 -5.931264470763884e+00 -5.994003877829137e+00 4.113892781999703e+00 4.753633397739157e+00 9.198637555699508e+03 + 116580 1.039541768468787e+00 -5.988975660631413e+00 -6.001078883795102e+00 3.730651353645138e+00 4.661152773271503e+00 9.220374363680794e+03 + 116600 9.873156677098063e-01 -5.960662256739040e+00 -6.025647405518265e+00 3.958257733925044e+00 4.585102953215459e+00 9.295949957579354e+03 + 116620 9.657077365528421e-01 -5.970051732053412e+00 -6.022912402982556e+00 3.822717793143451e+00 4.519183640505923e+00 9.287532836591818e+03 + 116640 9.933835587044351e-01 -6.040054547296645e+00 -5.956861346036595e+00 3.470432025287518e+00 4.948140261029015e+00 9.085096767830335e+03 + 116660 9.761389564745441e-01 -6.031789821300817e+00 -5.964131132956225e+00 3.526495909376592e+00 4.915002567999422e+00 9.107262551670538e+03 + 116680 9.572114461779270e-01 -6.012079808945248e+00 -5.975894482414008e+00 3.645067506182837e+00 4.852849250786399e+00 9.143201584551931e+03 + 116700 9.944324333378241e-01 -6.070948890846939e+00 -5.968703456808879e+00 3.277534693158460e+00 4.864643797834782e+00 9.121230306062438e+03 + 116720 9.995939724219163e-01 -6.079566992873889e+00 -5.975785148917851e+00 3.254294732511103e+00 4.850226140695121e+00 9.142862943271792e+03 + 116740 8.897255409531052e-01 -5.913516551247483e+00 -5.992532654803013e+00 4.172935632087674e+00 4.719212937769313e+00 9.194131787429304e+03 + 116760 9.972398235502927e-01 -6.066703627336899e+00 -5.967969125921997e+00 3.320589703803895e+00 4.887538490042978e+00 9.118976419451099e+03 + 116780 9.926142643944144e-01 -6.048877030190331e+00 -5.949253770330269e+00 3.473045286096995e+00 5.045097460863105e+00 9.061892486319231e+03 + 116800 9.810225745183545e-01 -6.015669608224197e+00 -5.938028205725429e+00 3.652496752053394e+00 5.098325700169529e+00 9.027737930149335e+03 + 116820 9.987788759341455e-01 -6.020928360764763e+00 -5.951962282530255e+00 3.575056235103392e+00 4.971070128792050e+00 9.070123967211910e+03 + 116840 1.017132390619726e+00 -6.022944509761514e+00 -5.980529269197053e+00 3.579493423145672e+00 4.823048298204074e+00 9.157389247902756e+03 + 116860 1.019093091182523e+00 -6.000061576498825e+00 -6.017640683168911e+00 3.725501839385647e+00 4.624559888528049e+00 9.271290929026731e+03 + 116880 1.040255247646033e+00 -6.009315323031635e+00 -5.992611256473393e+00 3.634449041917962e+00 4.730366377041334e+00 9.194392827096890e+03 + 116900 9.966962228056524e-01 -5.923598459634197e+00 -6.027835830085975e+00 4.129273227301198e+00 4.530726115486141e+00 9.302692716551694e+03 + 116920 1.048492985579146e+00 -5.981457433527139e+00 -6.026763010649043e+00 3.759413446389986e+00 4.499261811540610e+00 9.299406260659001e+03 + 116940 1.060771373283035e+00 -5.984673722303466e+00 -6.027610086071554e+00 3.797513063021247e+00 4.550965817884061e+00 9.302006012155904e+03 + 116960 1.046453271770854e+00 -5.952496011435958e+00 -6.031370198622566e+00 3.922561525182890e+00 4.469653736616363e+00 9.313612025122464e+03 + 116980 9.437828899778862e-01 -5.794223206093804e+00 -6.081873845677235e+00 4.758476319167107e+00 4.106741832886434e+00 9.470076965038646e+03 + 117000 1.064323711925915e+00 -5.971468638942650e+00 -6.006503079820772e+00 3.886332647672225e+00 4.685159466587844e+00 9.237018870591975e+03 + 117020 1.048440641917193e+00 -5.952869544003237e+00 -5.963512550723605e+00 3.992544186514411e+00 4.931430394926092e+00 9.105363386071334e+03 + 117040 1.037307114113973e+00 -5.950139792788513e+00 -5.961962114944413e+00 4.002137849545965e+00 4.934252246228346e+00 9.100626497206735e+03 + 117060 1.075589953794093e+00 -6.031835480687388e+00 -5.975442931186504e+00 3.514171837915462e+00 4.837986583868368e+00 9.141781909330641e+03 + 117080 1.032723977845200e+00 -6.010302590798491e+00 -5.976475099132177e+00 3.639766542094327e+00 4.834009234029722e+00 9.144958778617451e+03 + 117100 1.034516294208371e+00 -6.064843640002308e+00 -5.951161771162434e+00 3.333325957024317e+00 4.986104840115218e+00 9.067734814175739e+03 + 117120 9.389449826201208e-01 -5.970916782393086e+00 -5.950240400431293e+00 3.846638358098454e+00 4.965365342982836e+00 9.064913765668685e+03 + 117140 9.252591261914351e-01 -5.982741604506430e+00 -6.000075621963742e+00 3.798946936802576e+00 4.699412326132157e+00 9.217269213525144e+03 + 117160 9.783289335963294e-01 -6.087680099740122e+00 -6.035780094834145e+00 3.236166318026546e+00 4.534184177696467e+00 9.327230626498222e+03 + 117180 1.006024876656017e+00 -6.149647124956381e+00 -5.989587252934861e+00 2.910120561063373e+00 4.829209115396090e+00 9.185130484999625e+03 + 117200 9.510072191629886e-01 -6.083551184042386e+00 -5.968680047924352e+00 3.286142423982519e+00 4.945750263823132e+00 9.121165927475135e+03 + 117220 9.231876776640099e-01 -6.048800666127390e+00 -5.992309863223957e+00 3.432285947302958e+00 4.756664879497967e+00 9.193455877459695e+03 + 117240 9.306826347135327e-01 -6.059353123097426e+00 -5.963016724789786e+00 3.399058673484963e+00 4.952237180576891e+00 9.103843181156324e+03 + 117260 9.317587411377446e-01 -6.051682800861915e+00 -6.002380698259870e+00 3.392130099304423e+00 4.675230401921088e+00 9.224357902873744e+03 + 117280 9.716585658561268e-01 -6.093542693728925e+00 -6.005205099713335e+00 3.194746344887100e+00 4.701994479923110e+00 9.233043402584408e+03 + 117300 9.386762536310346e-01 -6.022973055408730e+00 -6.018619286218368e+00 3.541843331951211e+00 4.566843348385877e+00 9.274287318385477e+03 + 117320 9.452315975015501e-01 -6.006239178941293e+00 -6.020770465533737e+00 3.685746936664436e+00 4.602306040341293e+00 9.280901784527985e+03 + 117340 1.024442064970245e+00 -6.091657846651398e+00 -6.017060202034472e+00 3.159823407967154e+00 4.588174627305739e+00 9.269513655303006e+03 + 117360 1.016964144511234e+00 -6.047732546082608e+00 -6.004847528206733e+00 3.415386057379463e+00 4.661638466457806e+00 9.231967363334776e+03 + 117380 9.398945371167075e-01 -5.904617860472987e+00 -6.073826141337795e+00 4.174099117258984e+00 4.202478983636420e+00 9.445074916063286e+03 + 117400 1.016754500209377e+00 -5.994719983483062e+00 -5.997076731501375e+00 3.744706726765082e+00 4.731173914938353e+00 9.208086269475451e+03 + 117420 1.018526404776933e+00 -5.978651156659331e+00 -5.972969655283704e+00 3.854130344721075e+00 4.886754404829420e+00 9.134212261129929e+03 + 117440 9.777422815375661e-01 -5.901617076967483e+00 -5.977013528594640e+00 4.234629738442059e+00 4.801691645635746e+00 9.146590919615559e+03 + 117460 1.062373462573286e+00 -6.011946939451743e+00 -5.984909226120572e+00 3.671922619137598e+00 4.827177353157796e+00 9.170748572651444e+03 + 117480 1.028045525452645e+00 -5.952607979437065e+00 -6.036181860466220e+00 3.937572714511551e+00 4.457678556625855e+00 9.328477696994143e+03 + 117500 1.046946236957465e+00 -5.978830262183782e+00 -6.007608523747901e+00 3.774524351042687e+00 4.609275119719928e+00 9.240433098433372e+03 + 117520 1.081616552028150e+00 -6.033559666345199e+00 -5.988393843304515e+00 3.504501441680991e+00 4.763850586969125e+00 9.181450749771073e+03 + 117540 1.023708216985228e+00 -5.954455911899202e+00 -6.008638354901791e+00 3.962900514502889e+00 4.651776542076063e+00 9.243580287689605e+03 + 117560 9.817004510367817e-01 -5.900033705991992e+00 -6.022835605630370e+00 4.223762434397046e+00 4.518614923140926e+00 9.287276762095184e+03 + 117580 1.030530025756691e+00 -5.982368292555132e+00 -6.024442365794817e+00 3.793726953011785e+00 4.552131113527722e+00 9.292225608177207e+03 + 117600 1.021521196859552e+00 -5.980761381499108e+00 -5.953884259549032e+00 3.795842913070880e+00 4.950175506529400e+00 9.076021143810143e+03 + 117620 1.008182969678753e+00 -5.970735068951048e+00 -6.033773024222120e+00 3.820683848396321e+00 4.458710154137771e+00 9.320990385984995e+03 + 117640 1.023934992188604e+00 -6.004661560747802e+00 -6.045549848029722e+00 3.632697947143834e+00 4.397911074129039e+00 9.357415417429695e+03 + 117660 9.906564477966516e-01 -5.967191575835892e+00 -6.025929667172853e+00 3.846294334557137e+00 4.509011124410054e+00 9.296823636274286e+03 + 117680 1.016313157343738e+00 -6.014422600071851e+00 -5.998861282768441e+00 3.659292646319325e+00 4.748648138381570e+00 9.213545904880622e+03 + 117700 1.004825514032385e+00 -6.005360586164500e+00 -6.017813307054229e+00 3.664274783253284e+00 4.592769332852125e+00 9.271847414452574e+03 + 117720 9.848351487743031e-01 -5.984369224012574e+00 -6.015102455928935e+00 3.811956500841412e+00 4.635481527225397e+00 9.263473756097141e+03 + 117740 1.009824820968522e+00 -6.028107975927067e+00 -5.976571283766972e+00 3.550739939129321e+00 4.846671600789921e+00 9.145267668154174e+03 + 117760 9.770503092455800e-01 -5.982573411563711e+00 -5.944771886714035e+00 3.744526744753105e+00 4.961588950207013e+00 9.048293094906574e+03 + 117780 1.022674488990937e+00 -6.050832085431693e+00 -5.981365382693046e+00 3.416860950728271e+00 4.815749507791086e+00 9.159922976172418e+03 + 117800 9.605882420328691e-01 -5.957637749050926e+00 -5.979320860381005e+00 3.954198538658612e+00 4.829690757950667e+00 9.153679054153059e+03 + 117820 9.905880406339654e-01 -6.000154443202830e+00 -5.982308235724791e+00 3.679470821404652e+00 4.781946506435231e+00 9.162812116796073e+03 + 117840 1.023903637669987e+00 -6.045591941369020e+00 -6.025575427372086e+00 3.449435745588645e+00 4.564373666504570e+00 9.295742103776434e+03 + 117860 1.063399245010372e+00 -6.103496711821144e+00 -5.988922211480329e+00 3.161751138354283e+00 4.819655649657872e+00 9.183086599769513e+03 + 117880 9.700071611769269e-01 -5.965011227788874e+00 -6.066753187116138e+00 3.823525542987692e+00 4.239307468013219e+00 9.423107221767648e+03 + 117900 9.891980383558744e-01 -5.994297152182673e+00 -6.043311024116164e+00 3.696339942346094e+00 4.414894704831818e+00 9.350495899902320e+03 + 117920 9.973663288291963e-01 -6.008580709612805e+00 -5.997414744684149e+00 3.718706904855870e+00 4.782823603403701e+00 9.209113906287968e+03 + 117940 1.069098733835710e+00 -6.116149043951585e+00 -5.958959637332848e+00 3.067878792682626e+00 4.970484690469473e+00 9.091499092324408e+03 + 117960 9.946673407547539e-01 -6.005886811375037e+00 -5.990249309115637e+00 3.688001162547017e+00 4.777794120416145e+00 9.187152720206697e+03 + 117980 1.005801962017413e+00 -6.022445290705143e+00 -5.998737730783256e+00 3.618609329902131e+00 4.754741807706642e+00 9.213165806416162e+03 + 118000 9.644869017462095e-01 -5.961993208338587e+00 -6.004837475538467e+00 3.903680560474244e+00 4.657662148083615e+00 9.231877029215009e+03 + 118020 1.053881009480344e+00 -6.092679350248816e+00 -5.962278383260800e+00 3.212584763985268e+00 4.961367295914876e+00 9.101602551952741e+03 + 118040 1.005852498057892e+00 -6.018676798494393e+00 -5.956065678634719e+00 3.582466795855784e+00 4.941989535129517e+00 9.082679794803493e+03 + 118060 9.751281235783067e-01 -5.967767205572165e+00 -5.989321303566666e+00 3.846958153375676e+00 4.723191187205364e+00 9.184271293336313e+03 + 118080 9.974309641935319e-01 -5.990644469980932e+00 -5.973583634292758e+00 3.777706222121703e+00 4.875672180798989e+00 9.136134759009492e+03 + 118100 1.090947504128428e+00 -6.110873337958210e+00 -5.962983735383422e+00 3.130797434489181e+00 4.980002418315646e+00 9.103776634812151e+03 + 118120 9.785537472955326e-01 -5.916149544140516e+00 -6.026480701012447e+00 4.160847733201043e+00 4.527309156751063e+00 9.298524341281332e+03 + 118140 1.043335798399435e+00 -5.974961412902997e+00 -6.011816604206745e+00 3.839614781149243e+00 4.627986569360697e+00 9.253369962259601e+03 + 118160 1.021372262003668e+00 -5.901431797961940e+00 -6.039725734082755e+00 4.157121457636136e+00 4.363016275512964e+00 9.339400139918887e+03 + 118180 1.084980600560377e+00 -5.954112370256652e+00 -6.024837402483422e+00 3.946646835121381e+00 4.540532755411899e+00 9.293445045875289e+03 + 118200 1.053339239431311e+00 -5.874638062457914e+00 -6.023543355459802e+00 4.354923760806028e+00 4.499886525369571e+00 9.289428060904611e+03 + 118220 1.038059513186960e+00 -5.827582260573252e+00 -6.045953188414441e+00 4.634437723044173e+00 4.380518062588197e+00 9.358619119869134e+03 + 118240 1.077868981135081e+00 -5.872531120676185e+00 -6.010202795009147e+00 4.359289471476361e+00 4.568757412833743e+00 9.248383145830470e+03 + 118260 1.082258392370619e+00 -5.876333103027513e+00 -6.027436030939117e+00 4.352149003949836e+00 4.484492608778884e+00 9.301443237223250e+03 + 118280 1.093984639201599e+00 -5.902300365247637e+00 -6.048988156136660e+00 4.199744376029367e+00 4.357440380882321e+00 9.368033513403001e+03 + 118300 1.119420010381261e+00 -5.961197110514972e+00 -6.046084068171831e+00 3.887326543704382e+00 4.399892496624450e+00 9.359065307264975e+03 + 118320 1.035577054050773e+00 -5.872796825887748e+00 -6.029017660401832e+00 4.336859630819101e+00 4.439815423943219e+00 9.306338217944796e+03 + 118340 1.070370816184554e+00 -5.966587115711421e+00 -5.997520761844828e+00 3.840999602950135e+00 4.663373819885845e+00 9.209445644793284e+03 + 118360 1.063043451433431e+00 -5.998952553479958e+00 -5.990675729710825e+00 3.759450553158497e+00 4.806977356075203e+00 9.188435609378637e+03 + 118380 1.082782818579330e+00 -6.066952214046174e+00 -5.971346132868490e+00 3.391836538467955e+00 4.940821451583464e+00 9.129305760935295e+03 + 118400 1.019721695188557e+00 -6.005589098364631e+00 -6.015713678046762e+00 3.637107013308367e+00 4.578970109999929e+00 9.265343824615929e+03 + 118420 9.612278062434214e-01 -5.942906881488238e+00 -5.975698543208297e+00 4.027594541187806e+00 4.839299745097978e+00 9.142564907459300e+03 + 118440 9.500334787377748e-01 -5.939597084485795e+00 -5.960916705114828e+00 4.019560210343140e+00 4.897139649490605e+00 9.097415930998406e+03 + 118460 9.598236961028992e-01 -5.960587487794002e+00 -5.999564925716527e+00 3.895789700073314e+00 4.671975219783153e+00 9.215691713397713e+03 + 118480 9.821689481661605e-01 -5.997146122014480e+00 -6.032593655378914e+00 3.685372518201096e+00 4.481827296134459e+00 9.317372490287435e+03 + 118500 1.017659075833954e+00 -6.053073511285338e+00 -5.974795958249002e+00 3.429495182077789e+00 4.878977005024615e+00 9.139819300789299e+03 + 118520 9.789319162224951e-01 -5.997662107465493e+00 -6.002288997906848e+00 3.676920852716196e+00 4.650352531792956e+00 9.224074075815050e+03 + 118540 9.441252543553389e-01 -5.946898429481081e+00 -6.002763887471695e+00 3.948953551291559e+00 4.628165446357769e+00 9.225546383423358e+03 + 118560 9.444197941896267e-01 -5.946423776776107e+00 -5.998974571402130e+00 3.969351943415451e+00 4.667597148463639e+00 9.213903616156613e+03 + 118580 9.230215215408252e-01 -5.910757139503366e+00 -6.039794504462388e+00 4.120091482064391e+00 4.379138964001992e+00 9.339580513349309e+03 + 118600 9.766415970172142e-01 -5.983461592674682e+00 -6.028858892394627e+00 3.747835802683749e+00 4.487157482482397e+00 9.305843856232210e+03 + 118620 9.618630342645450e-01 -5.953927971748611e+00 -5.996246835478627e+00 3.940855434154698e+00 4.697853969793949e+00 9.205531662701836e+03 + 118640 1.061055517528551e+00 -6.090344130780484e+00 -5.953599499650275e+00 3.205345973524770e+00 4.990554806637707e+00 9.075159765913408e+03 + 118660 9.813143517955251e-01 -5.957609041930416e+00 -6.009066575762202e+00 3.900080340047009e+00 4.604603217757270e+00 9.244890716647775e+03 + 118680 9.774807857140498e-01 -5.933154525523556e+00 -6.056552226957201e+00 4.016989407770036e+00 4.308420710405463e+00 9.391470818362141e+03 + 118700 1.012181975804859e+00 -5.963966904261444e+00 -6.016698532986031e+00 3.928272819949670e+00 4.625479647619916e+00 9.268382255066042e+03 + 118720 1.048467644196004e+00 -5.994792144485714e+00 -5.963919295339781e+00 3.755575098479476e+00 4.932851775833387e+00 9.106607296851336e+03 + 118740 9.621601254253962e-01 -5.838861466673560e+00 -6.054171021996164e+00 4.490167316957418e+00 4.253826531249022e+00 9.384076259229963e+03 + 118760 1.022663345686638e+00 -5.896445365466867e+00 -6.005596897378934e+00 4.219882252454172e+00 4.593117265070108e+00 9.234245405908194e+03 + 118780 1.091905294434476e+00 -5.967450714184237e+00 -5.995667399133255e+00 3.851120005614004e+00 4.689095434118858e+00 9.203753511436422e+03 + 118800 1.105894341726343e+00 -5.960400050441329e+00 -5.973169685580629e+00 3.907455244593421e+00 4.834130023528912e+00 9.134871253778794e+03 + 118820 1.033995382787784e+00 -5.830496278708402e+00 -5.978438603059751e+00 4.624427496552306e+00 4.774919776126156e+00 9.150948894231547e+03 + 118840 1.029531929933350e+00 -5.808015894148141e+00 -5.999381901622986e+00 4.720284037788677e+00 4.621430809074166e+00 9.215057353470878e+03 + 118860 1.022627998416774e+00 -5.787503977981503e+00 -6.034077989898704e+00 4.807406336348601e+00 4.391540202715006e+00 9.321913526674654e+03 + 118880 1.067706350577648e+00 -5.852887367700749e+00 -6.018746855234044e+00 4.474999475595049e+00 4.522608631506126e+00 9.274671329961711e+03 + 118900 1.094482487644117e+00 -5.901829217858737e+00 -6.015619349722012e+00 4.201674656199865e+00 4.548274110074948e+00 9.265063356841934e+03 + 118920 1.046215537030257e+00 -5.855847717068345e+00 -6.057716748548330e+00 4.397715121131274e+00 4.238551903241536e+00 9.395056461226939e+03 + 118940 1.051801485549865e+00 -5.904649308924698e+00 -6.011287973707836e+00 4.270415774627068e+00 4.658080059162250e+00 9.251702457469401e+03 + 118960 1.051537164666735e+00 -5.963079011361590e+00 -6.042911089334742e+00 3.905250347711958e+00 4.446842202015985e+00 9.349236598436273e+03 + 118980 1.101372786360149e+00 -6.099418561863858e+00 -5.993866325046751e+00 3.172384101537966e+00 4.778481379497653e+00 9.198228404359643e+03 + 119000 9.787017947532939e-01 -5.965887984527672e+00 -5.990482330256977e+00 3.890341952053427e+00 4.749117412913054e+00 9.187833930393792e+03 + 119020 9.718739350630375e-01 -5.982878895035639e+00 -5.979455873459942e+00 3.800222155344980e+00 4.819877674943506e+00 9.154094072148553e+03 + 119040 9.959476988947367e-01 -6.035818943180775e+00 -6.015451037576483e+00 3.459914015820754e+00 4.576869681723808e+00 9.264540403101189e+03 + 119060 9.441735486967399e-01 -5.971306339032348e+00 -6.025378192094603e+00 3.867915987191986e+00 4.557427039316297e+00 9.295106667670014e+03 + 119080 9.646111681234880e-01 -6.009348330778705e+00 -5.987410726850596e+00 3.634781436179135e+00 4.760750552767571e+00 9.178429129691185e+03 + 119100 9.687033226158710e-01 -6.018206608228263e+00 -5.986877981631500e+00 3.603441031344647e+00 4.783334853352552e+00 9.176812410284261e+03 + 119120 9.913277437143768e-01 -6.051223456661309e+00 -6.007927435200540e+00 3.381200081635337e+00 4.629812536900740e+00 9.241406151544445e+03 + 119140 9.744375273015720e-01 -6.022566518401194e+00 -5.995028335741658e+00 3.598477582279503e+00 4.756606088630554e+00 9.201787067141842e+03 + 119160 9.672882875773989e-01 -6.004713542761245e+00 -6.069061620250451e+00 3.595588970766932e+00 4.226092351991110e+00 9.430289291387066e+03 + 119180 9.640402228800465e-01 -5.994653019978194e+00 -6.020054534787910e+00 3.743353924420115e+00 4.597494495511011e+00 9.278727963303209e+03 + 119200 9.701028690226848e-01 -5.996103944082622e+00 -5.989743771242654e+00 3.687337672677878e+00 4.723858769358532e+00 9.185604427267479e+03 + 119220 9.071425906576737e-01 -5.889851523297735e+00 -6.011005911236879e+00 4.325688906067585e+00 4.630001661940081e+00 9.250834757771538e+03 + 119240 1.022591914700804e+00 -6.043133774327776e+00 -6.001301171734392e+00 3.503763959907413e+00 4.743973237572956e+00 9.221045736920498e+03 + 119260 1.032606150698166e+00 -6.036364900963767e+00 -6.006401776625513e+00 3.500290232551062e+00 4.672343129279827e+00 9.236707469055640e+03 + 119280 9.653283936596306e-01 -5.916661696388465e+00 -5.979892800663007e+00 4.139057313569285e+00 4.775974527843100e+00 9.155427021797033e+03 + 119300 1.079395425118725e+00 -6.062511429907402e+00 -5.989268986263320e+00 3.355340468590154e+00 4.775909914225998e+00 9.184118259596942e+03 + 119320 9.872464355997044e-01 -5.900069166567526e+00 -6.015759911123266e+00 4.259667613541680e+00 4.595353455217766e+00 9.265493146463197e+03 + 119340 1.084171954331391e+00 -6.017969263118533e+00 -6.024623044167509e+00 3.543096398197562e+00 4.504889357745052e+00 9.292788388176126e+03 + 119360 1.063759262406174e+00 -5.965665670442225e+00 -6.052372244564682e+00 3.881331379319267e+00 4.383448812909137e+00 9.378529729092466e+03 + 119380 1.116788057069645e+00 -6.029946478481005e+00 -6.011552909362325e+00 3.543838389896971e+00 4.649457110172053e+00 9.252560654948011e+03 + 119400 1.037643777673767e+00 -5.906314693853555e+00 -6.003901649512922e+00 4.245359039142414e+00 4.684999638213750e+00 9.228996621882899e+03 + 119420 1.080847764843264e+00 -5.971028339871708e+00 -5.941195269439361e+00 3.858917321078762e+00 5.030223428154029e+00 9.037374208539630e+03 + 119440 9.870118822056915e-01 -5.835357450642802e+00 -6.040259392016525e+00 4.526363709569697e+00 4.349785053728830e+00 9.340962311206427e+03 + 119460 1.042786889570578e+00 -5.927649884700450e+00 -5.953191819831469e+00 4.078196120856106e+00 4.931530376732107e+00 9.073866012150969e+03 + 119480 1.026599424468261e+00 -5.921569780302893e+00 -5.966352484880490e+00 4.091868122139671e+00 4.834718902353975e+00 9.113999893755850e+03 + 119500 9.569837240377982e-01 -5.845010669075805e+00 -5.997797050821444e+00 4.532154286485468e+00 4.654831238885843e+00 9.210260379999998e+03 + 119520 1.071707400843175e+00 -6.055550780890086e+00 -5.971560553930040e+00 3.399392453762259e+00 4.881677334412460e+00 9.129950415869476e+03 + 119540 1.034603326382984e+00 -6.049291676778807e+00 -5.987059917557144e+00 3.426659156265187e+00 4.784003548049594e+00 9.177367625970008e+03 + 119560 1.039435587849333e+00 -6.106904154921867e+00 -5.960764400737176e+00 3.126964338796666e+00 4.966121422379029e+00 9.097010269778570e+03 + 119580 9.186834907786946e-01 -5.966240927256661e+00 -5.971852973273962e+00 3.876351982458772e+00 4.844126745766115e+00 9.130827615999240e+03 + 119600 9.516214678031822e-01 -6.038279226429039e+00 -5.997130331492022e+00 3.454014088978249e+00 4.690297411477514e+00 9.208244337541095e+03 + 119620 9.533282442780864e-01 -6.057677872737974e+00 -5.960033985688069e+00 3.390940233854670e+00 4.951626543637915e+00 9.094773029220714e+03 + 119640 9.340604119670763e-01 -6.037243888588662e+00 -5.972422399122156e+00 3.499364143441820e+00 4.871579167051578e+00 9.132565825170957e+03 + 119660 9.332383659666506e-01 -6.035667349856229e+00 -5.987463463198733e+00 3.450711742121357e+00 4.727505918836049e+00 9.178599435867916e+03 + 119680 9.722574476386580e-01 -6.086674113362768e+00 -5.980255162163377e+00 3.264743921056758e+00 4.875818007123137e+00 9.156527158298239e+03 + 119700 9.644946817263906e-01 -6.065124913494199e+00 -5.976071784950615e+00 3.376708226888579e+00 4.888065071912947e+00 9.143735165190466e+03 + 119720 9.452947300092963e-01 -6.021598185744242e+00 -5.982693143142795e+00 3.653789107845278e+00 4.877187882998673e+00 9.164000847960475e+03 + 119740 9.286865210447891e-01 -5.976130817060755e+00 -5.996158088828032e+00 3.853719109261211e+00 4.738719415563210e+00 9.205259361903290e+03 + 119760 1.026750338458988e+00 -6.094277749377155e+00 -5.991310676564066e+00 3.165593166233076e+00 4.756846032428856e+00 9.190409662160573e+03 + 119780 9.433319473421097e-01 -5.942237948267610e+00 -6.041647633223969e+00 4.002719193368208e+00 4.431893398749760e+00 9.345349016804083e+03 + 119800 1.029553916338080e+00 -6.041010300583704e+00 -5.983886552195558e+00 3.546880524946843e+00 4.874893928063070e+00 9.167655830289208e+03 + 119820 9.998449298000777e-01 -5.973157289684110e+00 -5.988521958518264e+00 3.885599913891675e+00 4.797373607771147e+00 9.181817474249739e+03 + 119840 1.028425037961815e+00 -5.993324172039302e+00 -5.977768631821403e+00 3.729943732554985e+00 4.819266051698227e+00 9.148929023892417e+03 + 119860 1.019681955737980e+00 -5.961956924624882e+00 -6.002070410819171e+00 3.912728599639219e+00 4.682390754369683e+00 9.223402347840543e+03 + 119880 1.019620097589512e+00 -5.946931272631250e+00 -6.072351170601808e+00 3.892132790292442e+00 4.171952327479014e+00 9.440487073573415e+03 + 119900 1.080867481641072e+00 -6.029775973139915e+00 -6.002583958418650e+00 3.506689688077596e+00 4.662830444557780e+00 9.224992495596378e+03 + 119920 1.011930788777754e+00 -5.925552627926635e+00 -6.004644371845103e+00 4.108672806593836e+00 4.654515773606179e+00 9.231290406620314e+03 + 119940 1.010394797919729e+00 -5.924611184613004e+00 -6.013618201254626e+00 4.128742249231935e+00 4.617650185884432e+00 9.258910548292684e+03 + 119960 1.016752479360705e+00 -5.937674379768598e+00 -6.026702602414995e+00 4.044887600454279e+00 4.533673768945743e+00 9.299201963982663e+03 + 119980 1.056418618246733e+00 -6.003380113598146e+00 -6.054733355273852e+00 3.637403057068112e+00 4.342524796477742e+00 9.385836446920352e+03 + 120000 1.061145894286282e+00 -6.021211892256906e+00 -6.027635012716027e+00 3.585706120868671e+00 4.548823569217719e+00 9.302077590636698e+03 + 120020 9.718393941288797e-01 -5.902017132672810e+00 -6.043451100732105e+00 4.233014922892757e+00 4.420879191460470e+00 9.350900271771692e+03 + 120040 1.036681820644818e+00 -6.007624605744282e+00 -5.990226116227096e+00 3.700331506169276e+00 4.800236325384507e+00 9.187078927992241e+03 + 120060 1.032339290511590e+00 -6.012109291993151e+00 -5.986143488851176e+00 3.640292308030857e+00 4.789391967867129e+00 9.174549055176401e+03 + 120080 1.036132689615751e+00 -6.026374651726817e+00 -5.987722085588594e+00 3.596222510037728e+00 4.818171526268689e+00 9.179359358262443e+03 + 120100 9.869082146382139e-01 -5.960130265148583e+00 -5.990832837534317e+00 3.982196673244721e+00 4.805897751398120e+00 9.188925292057307e+03 + 120120 1.054594877165521e+00 -6.064997046378637e+00 -5.996377399131909e+00 3.340638761472694e+00 4.734663394819502e+00 9.205941601275590e+03 + 120140 9.939705249284559e-01 -5.978739269097393e+00 -6.045496233000370e+00 3.764267925670636e+00 4.380939108332967e+00 9.357248629518725e+03 + 120160 1.051619280866423e+00 -6.071165561484470e+00 -5.985613484735180e+00 3.317247612588286e+00 4.808500876423802e+00 9.172937188141990e+03 + 120180 1.022785297569426e+00 -6.034614532986149e+00 -5.989639092064422e+00 3.538784369929821e+00 4.797040311629363e+00 9.185249504432721e+03 + 120200 1.026046010597426e+00 -6.045252186066615e+00 -5.961212658808037e+00 3.451357729693519e+00 4.933925700287087e+00 9.098361917122489e+03 + 120220 1.033142047429315e+00 -6.061417933922354e+00 -5.959271090579731e+00 3.422484172692685e+00 5.009027154338952e+00 9.092439324147072e+03 + 120240 9.907394914430907e-01 -6.003127731790135e+00 -5.946094548031420e+00 3.716982716505523e+00 5.044476083504730e+00 9.052296121669917e+03 + 120260 1.005086672343924e+00 -6.025588326476243e+00 -5.961920006434356e+00 3.543597998848259e+00 4.909191345169461e+00 9.100482086266802e+03 + 120280 1.005916266017044e+00 -6.024530261176513e+00 -5.987684665334061e+00 3.558622969527266e+00 4.770196082692157e+00 9.179265336293727e+03 + 120300 1.032925326401713e+00 -6.062731391629439e+00 -5.967209840283362e+00 3.395176866606157e+00 4.943676396347628e+00 9.116656533851705e+03 + 120320 1.045329971439544e+00 -6.077405176738569e+00 -5.994037571923845e+00 3.312627978546439e+00 4.791337666487740e+00 9.198767268472993e+03 + 120340 1.008724619077021e+00 -6.019273026278289e+00 -5.977101078825129e+00 3.620506355617850e+00 4.862664203981670e+00 9.146892436467066e+03 + 120360 1.040577743219039e+00 -6.061184516084039e+00 -5.988870767815207e+00 3.365539760884878e+00 4.780776493960885e+00 9.182904565377781e+03 + 120380 9.514837188159329e-01 -5.920839628552655e+00 -6.045191872968318e+00 4.114103617693081e+00 4.400053786810714e+00 9.356277683302562e+03 + 120400 1.033629076715754e+00 -6.029704590006063e+00 -6.006301804977585e+00 3.553924035582949e+00 4.688306448785751e+00 9.236401618260170e+03 + 120420 1.023744151782429e+00 -5.998600194098437e+00 -6.019897239415956e+00 3.696743809648427e+00 4.574452879728125e+00 9.278248753999895e+03 + 120440 9.594683760693846e-01 -5.886448313536311e+00 -6.032094100634072e+00 4.294838547829102e+00 4.458517899701048e+00 9.315739227226753e+03 + 120460 9.998187776516587e-01 -5.926600438910474e+00 -5.995722129580439e+00 4.133980178930925e+00 4.737072734556918e+00 9.203903685241985e+03 + 120480 1.037693081960927e+00 -5.959831358402443e+00 -5.992579741750708e+00 3.907660960960592e+00 4.719614675978908e+00 9.194266581095508e+03 + 120500 1.081917433218320e+00 -6.003321572033852e+00 -5.993388153805121e+00 3.667334590002668e+00 4.724373814663544e+00 9.196738583836395e+03 + 120520 1.051614000328919e+00 -5.939662748055732e+00 -6.009430231181861e+00 4.051606812961471e+00 4.650991128368120e+00 9.246004767999859e+03 + 120540 1.105116883185558e+00 -6.004476261017515e+00 -5.997024527843392e+00 3.713193214444964e+00 4.755982219482758e+00 9.207916944080895e+03 + 120560 1.077358422984455e+00 -5.956110987285872e+00 -5.991821206662424e+00 3.983727622302391e+00 4.778674016503640e+00 9.191975663686253e+03 + 120580 1.115459215511916e+00 -6.013783485291789e+00 -6.028457232882693e+00 3.627303601730307e+00 4.543044672308236e+00 9.304625940223772e+03 + 120600 1.010211918349410e+00 -5.868250329081106e+00 -6.038009132607670e+00 4.501798952437506e+00 4.527017632498030e+00 9.334086080443292e+03 + 120620 1.007730303791919e+00 -5.883652510936998e+00 -6.039349599161183e+00 4.327214549127589e+00 4.433177774497789e+00 9.338254099057845e+03 + 120640 1.130012261954703e+00 -6.091511685438985e+00 -5.994148139829725e+00 3.182044610856576e+00 4.741121156704938e+00 9.199111939184178e+03 + 120660 1.019422469496537e+00 -5.967649386822658e+00 -6.018571653925105e+00 3.838230417596816e+00 4.545826879699201e+00 9.274129240625181e+03 + 120680 9.354144984946680e-01 -5.881746230977337e+00 -5.998216467777072e+00 4.297200943836724e+00 4.628410820421752e+00 9.211547528814319e+03 + 120700 9.763545721244279e-01 -5.974598364794389e+00 -6.028424922528604e+00 3.788790452159040e+00 4.479710028016285e+00 9.304517910499917e+03 + 120720 9.423000717290816e-01 -5.952875187263401e+00 -6.031858344754938e+00 3.892567827108499e+00 4.439034314187973e+00 9.315123321282956e+03 + 120740 9.543731635473370e-01 -5.992309196456991e+00 -5.988663131068482e+00 3.776239509446321e+00 4.797175781133934e+00 9.182282695848484e+03 + 120760 8.946358465997292e-01 -5.917471931920558e+00 -6.004546741283720e+00 4.151308620681904e+00 4.651311590535431e+00 9.231001794073816e+03 + 120780 9.900648205824396e-01 -6.067035709972298e+00 -5.992338058013967e+00 3.290315656485183e+00 4.719241133454207e+00 9.193539979184394e+03 + 120800 9.659633638280964e-01 -6.036339442155185e+00 -5.996312604398667e+00 3.516235732668915e+00 4.746076029199968e+00 9.205746949615253e+03 + 120820 9.389255175658887e-01 -5.998654009757570e+00 -6.014177559433469e+00 3.671458695339337e+00 4.582320070838779e+00 9.260649248736241e+03 + 120840 9.632002975658992e-01 -6.033113301793421e+00 -5.990767861190847e+00 3.488593751966532e+00 4.731747824842265e+00 9.188725272604835e+03 + 120860 9.433735494342107e-01 -5.995268878860853e+00 -5.973324718572456e+00 3.694217770093614e+00 4.820224534317422e+00 9.135346034443975e+03 + 120880 1.025533051391349e+00 -6.104954114932750e+00 -5.978976682536636e+00 3.140265930654051e+00 4.863647842417191e+00 9.152646817331228e+03 + 120900 9.547440436534869e-01 -5.986811593762392e+00 -6.053349693473651e+00 3.717925308382485e+00 4.335853243102784e+00 9.381567623065604e+03 + 120920 9.916155010189877e-01 -6.026156822650287e+00 -6.003710847209986e+00 3.537673646083995e+00 4.666561910565676e+00 9.228458836023932e+03 + 120940 9.951828388598919e-01 -6.013567192986904e+00 -5.994371418713266e+00 3.632071027721412e+00 4.742296134137109e+00 9.199779995537183e+03 + 120960 9.564688431380814e-01 -5.935768144825196e+00 -5.993669858661309e+00 4.039829523434801e+00 4.707348922326582e+00 9.197624726804530e+03 + 120980 9.763209551619872e-01 -5.942069414290973e+00 -5.979923844054045e+00 4.036879761891212e+00 4.819513768237581e+00 9.155498440038944e+03 + 121000 1.068843487258577e+00 -6.050278042246346e+00 -5.987688564135468e+00 3.388650347437494e+00 4.748048816440594e+00 9.179299716560481e+03 + 121020 9.978038644293263e-01 -5.913431209358587e+00 -6.006418091451395e+00 4.156666885984088e+00 4.622721819333690e+00 9.236760651239076e+03 + 121040 1.075905436365311e+00 -5.990737806260648e+00 -6.009030916036770e+00 3.764131085558872e+00 4.659089218374790e+00 9.244792689008551e+03 + 121060 1.031789097045825e+00 -5.878690742752047e+00 -6.039830840888150e+00 4.349500641153036e+00 4.424209261305937e+00 9.339713769421787e+03 + 121080 1.056549264160637e+00 -5.865815747851979e+00 -6.031058841740066e+00 4.488919345483805e+00 4.540067929092275e+00 9.312590192290299e+03 + 121100 1.099446348721314e+00 -5.883105670771874e+00 -6.046710455928039e+00 4.325067026593067e+00 4.385623032467689e+00 9.360994838123948e+03 + 121120 1.125176352100889e+00 -5.883579114690234e+00 -6.071853605824058e+00 4.340610619480435e+00 4.259509356006677e+00 9.438929497251514e+03 + 121140 1.150399661885583e+00 -5.899614274545621e+00 -6.036501329376753e+00 4.254894478399377e+00 4.468867826355740e+00 9.329431358692162e+03 + 121160 1.094627502379573e+00 -5.812241793530719e+00 -6.079797683002661e+00 4.678032341184537e+00 4.141685019696560e+00 9.463636421741105e+03 + 121180 1.120493695869488e+00 -5.863369746691971e+00 -6.024683802873893e+00 4.422825966331979e+00 4.496535692465864e+00 9.292965864321717e+03 + 121200 1.078932537300321e+00 -5.829248242008878e+00 -6.029406868750112e+00 4.590237946534479e+00 4.440896137338929e+00 9.307535372475157e+03 + 121220 1.053671150165725e+00 -5.842773504629686e+00 -6.024354195187978e+00 4.564628979805457e+00 4.521964555098689e+00 9.291971292470245e+03 + 121240 1.095780007297987e+00 -5.978556261228650e+00 -6.059116429027206e+00 3.770321451161590e+00 4.307732501016609e+00 9.399424328148361e+03 + 121260 1.064836475815794e+00 -6.003567599247364e+00 -6.027574861584730e+00 3.617605873670985e+00 4.479752458217991e+00 9.301891627366504e+03 + 121280 1.025693199413907e+00 -5.986485537529640e+00 -6.014954981804349e+00 3.788127158041800e+00 4.624651203384158e+00 9.263031489927744e+03 + 121300 1.019127093315375e+00 -5.998177929796270e+00 -6.012769489826296e+00 3.690017024242262e+00 4.606230028513239e+00 9.256304300129823e+03 + 121320 1.041561857094738e+00 -6.046712582364448e+00 -5.988106134759940e+00 3.451229391845482e+00 4.787756683309022e+00 9.180573257910042e+03 + 121340 1.007740438144754e+00 -6.009102092921800e+00 -6.009455447277591e+00 3.675352804253930e+00 4.673323788861565e+00 9.246056790814362e+03 + 121360 9.672171850045752e-01 -5.958135591822367e+00 -5.973946750658824e+00 3.981299286539332e+00 4.890509165731475e+00 9.137244101095916e+03 + 121380 9.935177709587653e-01 -6.003625719893237e+00 -6.007558385870614e+00 3.693922173090204e+00 4.671340196470013e+00 9.240269400726540e+03 + 121400 1.019796810355305e+00 -6.049255658387051e+00 -5.991286319100182e+00 3.457134077138714e+00 4.790002994050177e+00 9.190306073336487e+03 + 121420 1.010719710280107e+00 -6.044395961250208e+00 -5.982601983854225e+00 3.437948609262025e+00 4.792779190056856e+00 9.163750732211613e+03 + 121440 9.888899483569709e-01 -6.020673513261531e+00 -5.994064921985097e+00 3.581278650288157e+00 4.734069299063636e+00 9.198833719768227e+03 + 121460 9.154661088232632e-01 -5.918402366111876e+00 -6.023119914485376e+00 4.118315315924913e+00 4.517010948176037e+00 9.288150566293960e+03 + 121480 9.123147074912249e-01 -5.916755726781715e+00 -6.040932361652200e+00 4.126386194383956e+00 4.413344740685489e+00 9.343091863419644e+03 + 121500 1.025324364226233e+00 -6.084892040294999e+00 -5.983354393085188e+00 3.165314542013964e+00 4.748359425192823e+00 9.166009130292590e+03 + 121520 9.479900331084421e-01 -5.965735647533178e+00 -6.006159181765631e+00 3.880816216158846e+00 4.648698027074393e+00 9.235944666792700e+03 + 121540 9.642270620373837e-01 -5.984513247835343e+00 -6.009960121897665e+00 3.724558795887160e+00 4.578438907130277e+00 9.247632749412625e+03 + 121560 9.820204202450386e-01 -6.002170726972052e+00 -6.025783914741895e+00 3.655022179950450e+00 4.519431601647012e+00 9.296383051797875e+03 + 121580 1.012099742657681e+00 -6.038133519976705e+00 -6.011800472347093e+00 3.533699381453941e+00 4.684907815969126e+00 9.253297203436814e+03 + 121600 9.459961816394682e-01 -5.928506148538029e+00 -6.045892284160914e+00 4.106239609308198e+00 4.432190253115814e+00 9.358455193763601e+03 + 121620 1.011254042159579e+00 -6.011608094643019e+00 -6.014927006704755e+00 3.642821580795439e+00 4.623763874136972e+00 9.262918253044209e+03 + 121640 1.049417125476201e+00 -6.056109084950049e+00 -5.985500283258091e+00 3.406609953425119e+00 4.812056619417095e+00 9.172589099373849e+03 + 121660 9.821493577901522e-01 -5.943743716471760e+00 -5.993081542944143e+00 4.009376265223694e+00 4.726070830615297e+00 9.195802739559394e+03 + 121680 9.092949856173714e-01 -5.820289727640036e+00 -6.067336614048265e+00 4.614269988904027e+00 4.195688536765863e+00 9.424897281504815e+03 + 121700 1.088223544097771e+00 -6.069738517062521e+00 -6.001422410947127e+00 3.277455207086930e+00 4.669736860284781e+00 9.221426182835046e+03 + 121720 1.095232098584737e+00 -6.067775397688449e+00 -5.954997923077664e+00 3.411399348659769e+00 5.058985060132693e+00 9.079415127506092e+03 + 121740 1.088171557917545e+00 -6.048039462062470e+00 -6.009812604712321e+00 3.408046152572408e+00 4.627550683064022e+00 9.247181967418643e+03 + 121760 9.890665961287527e-01 -5.894349279083472e+00 -6.006963770162155e+00 4.209670873089593e+00 4.563021038279619e+00 9.238412279495251e+03 + 121780 1.043499077747611e+00 -5.969481090027255e+00 -6.006002280219752e+00 3.863242026778372e+00 4.653531701057140e+00 9.235455910008011e+03 + 121800 1.076867129777996e+00 -6.016414672052348e+00 -5.959280820558289e+00 3.668270260489963e+00 4.996341677203798e+00 9.092468566783786e+03 + 121820 1.057474341165644e+00 -5.988948125808213e+00 -5.992431544420544e+00 3.731891202173869e+00 4.711888873444578e+00 9.193834295962906e+03 + 121840 1.027915309576489e+00 -5.953514989118382e+00 -5.993266194485868e+00 3.930801891326165e+00 4.702544318626913e+00 9.196340446902817e+03 + 121860 1.009875854874057e+00 -5.938759770501213e+00 -6.004490812529411e+00 4.025813163333832e+00 4.648375348162042e+00 9.230738884117127e+03 + 121880 1.016497426899852e+00 -5.966234422217219e+00 -5.963751885955925e+00 3.917117459695402e+00 4.931372567078994e+00 9.106078178863789e+03 + 121900 1.000589942274414e+00 -5.965506233785544e+00 -5.969112358384749e+00 3.871443422207337e+00 4.850736496712724e+00 9.122485667990690e+03 + 121920 9.535938444465633e-01 -5.925420445477659e+00 -6.035811674618802e+00 4.118881610870888e+00 4.484998090154940e+00 9.327288982876733e+03 + 121940 9.322463967338616e-01 -5.925629085949499e+00 -6.039934065784456e+00 4.054372359528232e+00 4.398015476677448e+00 9.340071961015135e+03 + 121960 1.022388781918760e+00 -6.092936230838693e+00 -5.979221509943984e+00 3.191715986592782e+00 4.844683511266389e+00 9.153385272214708e+03 + 121980 9.885529639368891e-01 -6.074779341790144e+00 -5.971385685169479e+00 3.327317176909301e+00 4.921019553341812e+00 9.129424595716457e+03 + 122000 8.789865750614481e-01 -5.936644668064941e+00 -6.025850421625547e+00 4.064822357709361e+00 4.552589116218614e+00 9.296559074547540e+03 + 122020 9.993187655645374e-01 -6.134858044955732e+00 -5.993246839711056e+00 2.948360358506144e+00 4.761513813284258e+00 9.196342816422035e+03 + 122040 9.285714604828201e-01 -6.044076330868791e+00 -5.986458608790151e+00 3.467205473053854e+00 4.798055349543082e+00 9.175532469238226e+03 + 122060 9.563675928716706e-01 -6.090916806960377e+00 -5.980893888715716e+00 3.236174547420667e+00 4.867943169973081e+00 9.158495255304686e+03 + 122080 9.369846916005025e-01 -6.060008008835741e+00 -6.034665236588676e+00 3.378319800602559e+00 4.523841920626538e+00 9.323774912910743e+03 + 122100 9.477967050858879e-01 -6.070790284130617e+00 -5.992852181595550e+00 3.392537832270329e+00 4.840070477909071e+00 9.195100295555801e+03 + 122120 9.257296775423668e-01 -6.025185159025574e+00 -5.983419544069068e+00 3.568878534279345e+00 4.808703158567631e+00 9.166244662536175e+03 + 122140 9.760501296476184e-01 -6.078009334127781e+00 -5.991592212837741e+00 3.289237763724441e+00 4.785458247178151e+00 9.191278687877682e+03 + 122160 9.567872459337702e-01 -6.020539676678470e+00 -5.996136299000518e+00 3.607133970537719e+00 4.747261941575006e+00 9.205182912274407e+03 + 122180 9.864474940147704e-01 -6.026341704525295e+00 -5.948338285065007e+00 3.614120742287385e+00 5.062028447818511e+00 9.059134334877437e+03 + 122200 1.050021449410696e+00 -6.073426728782909e+00 -5.964971005498520e+00 3.320578272603646e+00 4.943347819171544e+00 9.109833620338715e+03 + 122220 1.046146528182950e+00 -6.020673386594951e+00 -5.987700579004970e+00 3.590861718421248e+00 4.780196682128398e+00 9.179323918134212e+03 + 122240 1.064902876111197e+00 -6.014489230060621e+00 -5.994304293036757e+00 3.607580687830394e+00 4.723485719830331e+00 9.199572666637889e+03 + 122260 1.006412101348283e+00 -5.906369802016615e+00 -6.018335012137827e+00 4.219961900134256e+00 4.577040337057983e+00 9.273421467649914e+03 + 122280 1.072796086810875e+00 -5.995384852291707e+00 -6.009055069129228e+00 3.676983630625643e+00 4.598487130085382e+00 9.244870446363942e+03 + 122300 1.013834400797831e+00 -5.906089866546187e+00 -6.073648307609880e+00 4.158999054909924e+00 4.196852556737242e+00 9.444511600255852e+03 + 122320 1.041107328374048e+00 -5.949731773645686e+00 -6.056821347616345e+00 3.904037180158016e+00 4.289112274360480e+00 9.392330936806820e+03 + 122340 1.065236311669154e+00 -5.996167759441147e+00 -6.010957490231847e+00 3.694041349232836e+00 4.609116426329193e+00 9.250731824508028e+03 + 122360 1.020057341712105e+00 -5.942100012675675e+00 -6.019724939484485e+00 3.969672216491367e+00 4.523937874336578e+00 9.277687804276624e+03 + 122380 1.057449148248190e+00 -6.012512163218804e+00 -5.999920316031853e+00 3.580861605661933e+00 4.653165940791465e+00 9.216801945131599e+03 + 122400 9.640159292561817e-01 -5.890811945568827e+00 -6.049281803302288e+00 4.272849351299104e+00 4.362890905062342e+00 9.368938775786703e+03 + 122420 1.047228523064277e+00 -6.031796336508355e+00 -6.001375727079881e+00 3.508409319993527e+00 4.683089166905921e+00 9.221282731379111e+03 + 122440 9.292806614484829e-01 -5.876548400324518e+00 -6.011423731817072e+00 4.351979606742520e+00 4.577504581422182e+00 9.252157838353352e+03 + 122460 1.030641181438959e+00 -6.045566294908516e+00 -5.994638409740646e+00 3.397598331204608e+00 4.690034128903280e+00 9.200611320380918e+03 + 122480 1.043062705449388e+00 -6.083240835903879e+00 -5.995461186677291e+00 3.271545953001358e+00 4.775590282717238e+00 9.203110728562424e+03 + 122500 9.386936019802217e-01 -5.947894230486130e+00 -6.017160404551564e+00 3.937974113113099e+00 4.540237022723576e+00 9.269822327936567e+03 + 122520 9.938455745909147e-01 -6.045659610206654e+00 -6.012847505573569e+00 3.408464270286371e+00 4.596876452746328e+00 9.256536251314366e+03 + 122540 1.002999121451895e+00 -6.073553655873885e+00 -5.967527520141510e+00 3.339154272316373e+00 4.947972751183146e+00 9.117650774064847e+03 + 122560 1.003447323409266e+00 -6.087766886488987e+00 -5.969923127471836e+00 3.208902422416540e+00 4.885579522955794e+00 9.124946753478966e+03 + 122580 9.416234901122646e-01 -6.008087265455671e+00 -5.984826099902172e+00 3.694697776840285e+00 4.828266989102210e+00 9.170510978068820e+03 + 122600 9.438183265091453e-01 -6.018642472855062e+00 -5.986894841186514e+00 3.617841450915397e+00 4.800141264886329e+00 9.176819798775516e+03 + 122620 9.693643153718524e-01 -6.059404770238755e+00 -5.953936391867413e+00 3.412370506465099e+00 5.017986256252154e+00 9.076179606519388e+03 + 122640 9.623822968381476e-01 -6.046144363167623e+00 -5.996185053453386e+00 3.431317738222189e+00 4.718191825779531e+00 9.205357833475548e+03 + 122660 9.707998563378933e-01 -6.047467129671227e+00 -6.039524471364833e+00 3.455196824431110e+00 4.500804797548827e+00 9.338801813066129e+03 + 122680 9.239780172564870e-01 -5.959171537151987e+00 -6.070983852815636e+00 3.915138580658934e+00 4.273094961218334e+00 9.436245005317005e+03 + 122700 9.709776181501767e-01 -6.002378080635148e+00 -5.996533704498964e+00 3.703867992712310e+00 4.737427304900561e+00 9.206421595513213e+03 + 122720 9.637878965941783e-01 -5.950352699839319e+00 -6.034781994243518e+00 3.987032568024854e+00 4.502226494164859e+00 9.324125651128046e+03 + 122740 1.010815038669133e+00 -5.974854618923963e+00 -6.001809257264895e+00 3.889205416111694e+00 4.734427711541263e+00 9.222583176498343e+03 + 122760 9.811674752021313e-01 -5.885569933318791e+00 -5.999907734011133e+00 4.311805526089220e+00 4.655260180796323e+00 9.216735241809996e+03 + 122780 1.028923565545511e+00 -5.917545752877508e+00 -5.962513254589275e+00 4.218804043908222e+00 4.960593690380851e+00 9.102317117631832e+03 + 122800 1.124335882902598e+00 -6.028333263711251e+00 -5.989460223684716e+00 3.564223088275525e+00 4.787438099691389e+00 9.184722319449800e+03 + 122820 1.062678376278233e+00 -5.920439492733944e+00 -6.005506839431118e+00 4.092288659609190e+00 4.603818790744662e+00 9.233955358010326e+03 + 122840 1.011664316556222e+00 -5.837057124097495e+00 -6.040685362917541e+00 4.571111103293043e+00 4.401846244620217e+00 9.342352864493725e+03 + 122860 1.100272720862411e+00 -5.967639203569795e+00 -5.999069602364922e+00 3.871470200547264e+00 4.690991986827151e+00 9.214193121300263e+03 + 122880 1.037310974871203e+00 -5.884477610944193e+00 -6.025700134142681e+00 4.266424447304944e+00 4.455502864984383e+00 9.296097014997742e+03 + 122900 1.043453196462220e+00 -5.909257329549933e+00 -6.004112736779348e+00 4.189931112426043e+00 4.645256685287914e+00 9.229648557115983e+03 + 122920 1.072511666442063e+00 -5.972924969515268e+00 -5.998693874919379e+00 3.772937404783986e+00 4.624968362228358e+00 9.213033696499117e+03 + 122940 1.041578250255228e+00 -5.953442716446868e+00 -6.007826232290856e+00 3.933337787121249e+00 4.621059223323188e+00 9.241079367586261e+03 + 122960 1.033297963531500e+00 -5.973421855162428e+00 -6.006560463248404e+00 3.844363661290658e+00 4.654076645477955e+00 9.237182633035432e+03 + 122980 9.613929666220137e-01 -5.900179904231156e+00 -6.057847580457410e+00 4.157476883741304e+00 4.252124687856115e+00 9.395474587677409e+03 + 123000 9.847080599178164e-01 -5.966862856084152e+00 -5.992470811934850e+00 3.883768796887022e+00 4.736723951573953e+00 9.193947241787975e+03 + 123020 9.776356536799536e-01 -5.982789663159479e+00 -6.003257517788345e+00 3.739159031673632e+00 4.621629443004416e+00 9.227068805674024e+03 + 123040 9.785738714083889e-01 -6.003878077193728e+00 -6.008864121376529e+00 3.667423610779903e+00 4.638792973494413e+00 9.244262730768147e+03 + 123060 1.017907258637640e+00 -6.075573705076893e+00 -5.959358196499521e+00 3.298000786753659e+00 4.965328221296756e+00 9.092711401310215e+03 + 123080 1.036456515447104e+00 -6.111445778731325e+00 -5.972382433223887e+00 3.051516523692862e+00 4.850039773579736e+00 9.132479679381748e+03 + 123100 9.928683104676677e-01 -6.052443438557395e+00 -5.990079099758160e+00 3.464908937463645e+00 4.823014621699094e+00 9.186616732318967e+03 + 123120 1.001798524840767e+00 -6.068660545413881e+00 -5.982560654056172e+00 3.376023226049152e+00 4.870422126140239e+00 9.163584841375789e+03 + 123140 9.729840391654312e-01 -6.024743067186481e+00 -5.967956238078693e+00 3.590137905676422e+00 4.916216666146748e+00 9.118947649108120e+03 + 123160 9.699555158520093e-01 -6.015830125467891e+00 -6.002255110129755e+00 3.599428443314428e+00 4.677378282112842e+00 9.223969801019390e+03 + 123180 1.038155164871066e+00 -6.111709240193035e+00 -5.996327793623625e+00 3.066139572462734e+00 4.728677693885441e+00 9.205794011301048e+03 + 123200 9.760012579923073e-01 -6.013558558444949e+00 -6.011299979553652e+00 3.631218131134414e+00 4.644187240642193e+00 9.251762776618350e+03 + 123220 9.207028267581148e-01 -5.924249131614145e+00 -6.035112873503418e+00 4.095602992064832e+00 4.459006230028018e+00 9.325138409705105e+03 + 123240 1.030627009676178e+00 -6.078430762639743e+00 -5.945121619683016e+00 3.280833195075152e+00 5.046314923455881e+00 9.049333574872235e+03 + 123260 9.210372379414149e-01 -5.905646078787322e+00 -6.019512090575311e+00 4.222736184421782e+00 4.568899924026774e+00 9.277015761603043e+03 + 123280 9.656366045512024e-01 -5.957355365792517e+00 -6.019626746789593e+00 3.979117214969910e+00 4.621545308819638e+00 9.277384787563704e+03 + 123300 1.035584687366873e+00 -6.047466257792698e+00 -6.000621920078137e+00 3.481184291839897e+00 4.750171728134744e+00 9.218961990807999e+03 + 123320 9.667947220105408e-01 -5.932338305941492e+00 -6.039721934103854e+00 4.046973110914749e+00 4.430359700443717e+00 9.339375723125404e+03 + 123340 1.053474143741022e+00 -6.047524152541055e+00 -5.997338121356494e+00 3.454590746610780e+00 4.742766703935754e+00 9.208863929721190e+03 + 123360 1.032755141387830e+00 -6.003055470922941e+00 -5.996188601741617e+00 3.646696546111243e+00 4.686127171594984e+00 9.205366431411119e+03 + 123380 9.850916802674634e-01 -5.919771410691591e+00 -5.993803015551622e+00 4.118869151947790e+00 4.693768220487663e+00 9.198014975932096e+03 + 123400 1.061505519769170e+00 -6.016784094982769e+00 -5.988375026182153e+00 3.597313723833707e+00 4.760442993176031e+00 9.181400225790967e+03 + 123420 1.053713748020837e+00 -5.981692518932657e+00 -6.010856263866240e+00 3.818096499315776e+00 4.650633762832195e+00 9.250411748314104e+03 + 123440 1.105108042184527e+00 -6.024691613170656e+00 -6.002889930695853e+00 3.583310461453789e+00 4.708499096023569e+00 9.225906116550468e+03 + 123460 1.115359843444440e+00 -5.995300146185701e+00 -5.970179150414416e+00 3.781445029556090e+00 4.925693674736341e+00 9.125739506695949e+03 + 123480 1.083141712636847e+00 -5.900491064085047e+00 -5.997631622844692e+00 4.274078055388006e+00 4.716281934537245e+00 9.209782585400939e+03 + 123500 1.062635314310250e+00 -5.828833597038188e+00 -6.039491816074184e+00 4.602936130105607e+00 4.393304037146877e+00 9.338650392730502e+03 + 123520 1.058350718724940e+00 -5.792240854992991e+00 -6.037893402219527e+00 4.769707583312682e+00 4.359132642529084e+00 9.333730961456478e+03 + 123540 1.074662333811224e+00 -5.797759435643455e+00 -6.040007419031478e+00 4.806112886763899e+00 4.415087478395597e+00 9.340261792830985e+03 + 123560 1.167763510594975e+00 -5.930959759070772e+00 -6.022892428979931e+00 4.089154451717158e+00 4.561262834564073e+00 9.287447590322658e+03 + 123580 1.060144576412683e+00 -5.783664646296696e+00 -6.099110910831912e+00 4.836613656532942e+00 4.025272390420059e+00 9.523783628772289e+03 + 123600 1.115760526321844e+00 -5.896118405742393e+00 -6.041918712270576e+00 4.236605717017573e+00 4.399397794408229e+00 9.346178471965290e+03 + 123620 1.054928746952519e+00 -5.850497076758369e+00 -6.018223233833195e+00 4.550076941549805e+00 4.586967392087234e+00 9.273060480954480e+03 + 123640 1.021969048970661e+00 -5.850105876879089e+00 -6.038021772143650e+00 4.472886454363865e+00 4.393844303863944e+00 9.334119589245322e+03 + 123660 1.137074751487440e+00 -6.066386818101090e+00 -5.945300774525718e+00 3.316300491961921e+00 5.011595292176397e+00 9.049889662178355e+03 + 123680 1.009418480570350e+00 -5.912765165452886e+00 -6.019371465436952e+00 4.104819147731722e+00 4.492669275951612e+00 9.276574698606424e+03 + 123700 1.028215867901988e+00 -5.970773325245623e+00 -5.965563961779009e+00 3.895583721515486e+00 4.925496692687172e+00 9.111631882553560e+03 + 123720 1.046017048533841e+00 -6.020182913405061e+00 -5.950881358160806e+00 3.685103588739236e+00 5.083043843332765e+00 9.066854792936376e+03 + 123740 1.031407942754202e+00 -6.015259962719412e+00 -5.946621394495140e+00 3.661099723150422e+00 5.055233003678297e+00 9.053907587476668e+03 + 123760 9.738106105827206e-01 -5.943652001181007e+00 -6.010957544655556e+00 4.023908261453795e+00 4.637429415323747e+00 9.250705289284273e+03 + 123780 1.039645761215241e+00 -6.053111340940633e+00 -5.991755877196627e+00 3.373893606968829e+00 4.726206174514245e+00 9.191774278954585e+03 + 123800 9.816838821731989e-01 -5.978971074475639e+00 -6.029724840234711e+00 3.828542079668765e+00 4.537106102560306e+00 9.308527470388675e+03 + 123820 1.012446531389368e+00 -6.037003909087220e+00 -6.021445326087385e+00 3.489914935997509e+00 4.579254727265504e+00 9.283008172302119e+03 + 123840 1.000031098220121e+00 -6.030965653205588e+00 -6.038290410758296e+00 3.542550441907426e+00 4.500490550537211e+00 9.334958474964991e+03 + 123860 9.379179404186142e-01 -5.950933035640495e+00 -6.039767481735309e+00 3.959816975622285e+00 4.449715839059758e+00 9.339542177201964e+03 + 123880 9.446563453234521e-01 -5.973134061946038e+00 -6.047473237696754e+00 3.822852925878514e+00 4.395985874767637e+00 9.363374635720598e+03 + 123900 1.041321043596115e+00 -6.127734549216084e+00 -5.987225109953616e+00 2.959166791889249e+00 4.765993735899794e+00 9.177912720709210e+03 + 123920 9.262293368216908e-01 -5.967747952414613e+00 -6.047347910750719e+00 3.837871088300012e+00 4.380795809480350e+00 9.362967010373804e+03 + 123940 9.169329682796719e-01 -5.962653621862809e+00 -5.983689311195718e+00 3.962880713278981e+00 4.842090529867013e+00 9.167038555136227e+03 + 123960 9.889745510432812e-01 -6.073556581322491e+00 -6.011927320838195e+00 3.250653504552226e+00 4.604538255350296e+00 9.253703759454023e+03 + 123980 9.945246789880008e-01 -6.081617711331124e+00 -6.013871674076999e+00 3.285527174586911e+00 4.674535404165481e+00 9.259701423569832e+03 + 124000 9.562471296764359e-01 -6.022954129220868e+00 -6.041099852328090e+00 3.573778611560566e+00 4.469583061437325e+00 9.343678612434031e+03 + 124020 9.716100708362748e-01 -6.042669569400140e+00 -5.977428677352216e+00 3.506953575328114e+00 4.881576873462712e+00 9.147882389895876e+03 + 124040 9.626552110757149e-01 -6.020040653818582e+00 -5.988617326366091e+00 3.540875339647946e+00 4.721312948624357e+00 9.182127896805297e+03 + 124060 9.624521304262400e-01 -6.001194655268712e+00 -5.982934180016793e+00 3.678509351127529e+00 4.783363825823464e+00 9.164725898088418e+03 + 124080 9.500288359511254e-01 -5.955728351379023e+00 -5.997030072407077e+00 3.956991463216989e+00 4.719830589653229e+00 9.207909695073033e+03 + 124100 9.772983013478915e-01 -5.959231590635858e+00 -5.991724278903491e+00 3.918007539342801e+00 4.731429495082795e+00 9.191646373899197e+03 + 124120 1.032863926705671e+00 -6.000035641469773e+00 -6.004665078474539e+00 3.683704984612385e+00 4.657122040927957e+00 9.231339573759096e+03 + 124140 1.053564804590002e+00 -5.990240620582084e+00 -5.993284436603942e+00 3.734686912152797e+00 4.717208849526287e+00 9.196434479635313e+03 + 124160 1.057504395976131e+00 -5.963220734117355e+00 -6.023945591845781e+00 3.950383536026821e+00 4.601692005808838e+00 9.290689663788537e+03 + 124180 1.022085240778716e+00 -5.886984954428578e+00 -6.080072845553905e+00 4.290355491627478e+00 4.181614940531268e+00 9.464493819783940e+03 + 124200 1.076548076516832e+00 -5.955016245757723e+00 -6.053679966415271e+00 3.900082403330526e+00 4.333540051153458e+00 9.382575378427337e+03 + 124220 1.029370404617580e+00 -5.881913828216268e+00 -6.050565781086606e+00 4.350482863069715e+00 4.382057250882879e+00 9.372912553971943e+03 + 124240 1.039013022950192e+00 -5.900541833373640e+00 -6.056967635502517e+00 4.164037900108069e+00 4.265816737469414e+00 9.392753732165689e+03 + 124260 1.102918822015277e+00 -6.009153364812903e+00 -6.022239956276213e+00 3.648813948115818e+00 4.573668714790006e+00 9.285458958440779e+03 + 124280 9.864000050800108e-01 -5.857387699509981e+00 -6.047825150514474e+00 4.430047593679594e+00 4.336526279911493e+00 9.364437405585946e+03 + 124300 9.928670327457007e-01 -5.891777398416153e+00 -6.063893653435580e+00 4.229356225201593e+00 4.241038053975657e+00 9.414214334216662e+03 + 124320 1.019276511129890e+00 -5.959569040717325e+00 -6.030267432267020e+00 3.912225252446661e+00 4.506264147627577e+00 9.310204481655626e+03 + 124340 9.849010707917484e-01 -5.941382740049206e+00 -6.056358684486967e+00 4.020645876009462e+00 4.360436210577942e+00 9.390824761677011e+03 + 124360 9.936119554714553e-01 -5.984295297562930e+00 -5.974644468225821e+00 3.784822409889345e+00 4.840238965404036e+00 9.139366108646251e+03 + 124380 9.521810481744990e-01 -5.948306362913390e+00 -6.004076505764259e+00 3.996279809153776e+00 4.676039018502367e+00 9.229557815562634e+03 + 124400 1.021256627557130e+00 -6.068190661188632e+00 -5.976614672496319e+00 3.323000650880716e+00 4.848844149290434e+00 9.145408802067057e+03 + 124420 9.805285482686998e-01 -6.020497681049144e+00 -5.970286489232691e+00 3.599689504897944e+00 4.888009938464839e+00 9.126068961576357e+03 + 124440 9.953273512825224e-01 -6.049852233740272e+00 -6.001019530504298e+00 3.428155243253404e+00 4.708560182070774e+00 9.220180474962612e+03 + 124460 9.688095877344318e-01 -6.015644063151668e+00 -6.015316986396023e+00 3.541725156329762e+00 4.543603281675638e+00 9.264121302044176e+03 + 124480 9.438574556083021e-01 -5.978675833919882e+00 -5.981737324252702e+00 3.803910988265295e+00 4.786331437010142e+00 9.161076209700852e+03 + 124500 9.934280085304421e-01 -6.048198808280079e+00 -5.968350049268471e+00 3.460971979931236e+00 4.919475910731406e+00 9.120171018833062e+03 + 124520 9.976307312659172e-01 -6.048811378439297e+00 -6.038506186305963e+00 3.461110370082799e+00 4.520284378035738e+00 9.335643067102361e+03 + 124540 9.788165967783727e-01 -6.017343813998051e+00 -6.034900560525130e+00 3.612219161567187e+00 4.511405606110955e+00 9.324501398418859e+03 + 124560 1.010638723084755e+00 -6.059654450993423e+00 -5.996860639041419e+00 3.425964106642052e+00 4.786535892181458e+00 9.207414293517286e+03 + 124580 9.634870621920757e-01 -5.984455212899630e+00 -6.027549985349109e+00 3.750210810603378e+00 4.502753958303988e+00 9.301813936010663e+03 + 124600 9.538691115313704e-01 -5.964246069903154e+00 -5.997330651905732e+00 3.894419943252285e+00 4.704443153570963e+00 9.208848835671608e+03 + 124620 1.026818788854478e+00 -6.063019579441131e+00 -6.004953337282126e+00 3.351038782364345e+00 4.684464130563283e+00 9.232272478052682e+03 + 124640 1.096095045361376e+00 -6.158207896467936e+00 -5.961255987896131e+00 2.819401374502304e+00 4.950329711730960e+00 9.098522202853364e+03 + 124660 1.008056314503567e+00 -6.021767831902137e+00 -5.962881447980240e+00 3.580127673125622e+00 4.918262402243615e+00 9.103446730582746e+03 + 124680 9.487275653392980e-01 -5.925594326924035e+00 -5.990706823366391e+00 4.087331857069260e+00 4.713445826370990e+00 9.188538187575297e+03 + 124700 9.951428767363758e-01 -5.983252157872843e+00 -5.997183576266233e+00 3.729640456209375e+00 4.649644095914504e+00 9.208388306210205e+03 + 124720 9.784908592813066e-01 -5.944913135414964e+00 -5.997383347103162e+00 3.953852466414040e+00 4.652560391161391e+00 9.209029510042026e+03 + 124740 1.029675926912981e+00 -6.005507643623237e+00 -5.971631063871685e+00 3.638911839833348e+00 4.833436403150534e+00 9.130144233065144e+03 + 124760 9.367334679591502e-01 -5.848671581895034e+00 -5.987318856063932e+00 4.525579524670642e+00 4.729445420796495e+00 9.178139656534366e+03 + 124780 1.041453475774045e+00 -5.975885062787889e+00 -5.998669173173054e+00 3.841429287501372e+00 4.710599399840063e+00 9.212944639466390e+03 + 124800 1.080023554068696e+00 -5.989950269649686e+00 -6.009166307011530e+00 3.756326159010453e+00 4.645984698806571e+00 9.245220160558532e+03 + 124820 1.093444291565670e+00 -5.963842640750606e+00 -6.005372343852482e+00 3.915477074972804e+00 4.677007093061050e+00 9.233561864365103e+03 + 124840 1.144222986784974e+00 -5.993090615490336e+00 -6.032008777508986e+00 3.726648653020365e+00 4.503174544143164e+00 9.315590924696884e+03 + 124860 1.086054648260782e+00 -5.871309281117801e+00 -6.051752144148576e+00 4.390728184777807e+00 4.354597341812286e+00 9.376585223465005e+03 + 124880 1.111063630345325e+00 -5.890117472014937e+00 -6.048129808236895e+00 4.210454539681720e+00 4.303123252765234e+00 9.365378271595657e+03 + 124900 1.086259190782446e+00 -5.848091862383444e+00 -6.060743882408267e+00 4.494285342529531e+00 4.273204535753250e+00 9.404333141292780e+03 + 124920 1.040744787486285e+00 -5.786455135856859e+00 -6.030671493801297e+00 4.786369359045255e+00 4.384041239369044e+00 9.311375497384399e+03 + 124940 1.119058657002233e+00 -5.919984455923280e+00 -5.940634054722505e+00 4.166028442968594e+00 5.047455251148356e+00 9.035618821458007e+03 + 124960 1.030004898505803e+00 -5.813848891812586e+00 -6.003171716737191e+00 4.674471294185738e+00 4.587350335856187e+00 9.226779404407313e+03 + 124980 1.096771767746705e+00 -5.955177650824586e+00 -6.045538747509625e+00 3.895855355726771e+00 4.376987955226755e+00 9.357384297104527e+03 + 125000 1.097620584849602e+00 -6.013459245377746e+00 -6.004527696557127e+00 3.634197793186590e+00 4.685484128667295e+00 9.230931249172103e+03 + 125020 1.039406293533638e+00 -5.979604697012762e+00 -6.004949605364288e+00 3.761830627605993e+00 4.616296241739641e+00 9.232230048684118e+03 + 125040 1.008201195709864e+00 -5.974890753548408e+00 -5.974658885247114e+00 3.848400209842324e+00 4.849731633509862e+00 9.139405048828548e+03 + 125060 1.000815264904330e+00 -5.987425798102696e+00 -6.009072635123370e+00 3.778231318187829e+00 4.653931830177918e+00 9.244914709629806e+03 + 125080 1.006195271644541e+00 -6.008918206070846e+00 -6.014514580420512e+00 3.639623872104803e+00 4.607488624552891e+00 9.261656412215254e+03 + 125100 9.919120621177697e-01 -5.996427921826531e+00 -6.008300450176950e+00 3.722721034204212e+00 4.654547139148282e+00 9.242558553017559e+03 + 125120 9.826954138447850e-01 -5.990141725117017e+00 -5.995575814270374e+00 3.797661745630173e+00 4.766458364789017e+00 9.203484803853133e+03 + 125140 1.031927886560280e+00 -6.069778139416736e+00 -5.999982576987956e+00 3.378925764162516e+00 4.779702684456950e+00 9.216993699636265e+03 + 125160 1.011618744821474e+00 -6.045405634582319e+00 -6.053622135845821e+00 3.402944343163574e+00 4.355763921409086e+00 9.382411170141566e+03 + 125180 9.481539069840340e-01 -5.958844562777684e+00 -6.031846432725819e+00 3.920888325027830e+00 4.501700290782779e+00 9.315098268803986e+03 + 125200 9.635801509796912e-01 -5.988930808991017e+00 -6.035262180553665e+00 3.712045848932476e+00 4.446003943663175e+00 9.325612031555751e+03 + 125220 9.740995815790641e-01 -6.009529920105448e+00 -5.965716069113188e+00 3.649102038210805e+00 4.900687950779888e+00 9.112103244027548e+03 + 125240 9.426075064835656e-01 -5.962571198064012e+00 -6.028349249155892e+00 3.861267552103097e+00 4.483559803613016e+00 9.304281985087167e+03 + 125260 1.020135407597811e+00 -6.077616627112765e+00 -5.990570677023661e+00 3.299711864367779e+00 4.799543180096659e+00 9.188134902130823e+03 + 125280 1.017033711444334e+00 -6.072639379242898e+00 -5.997580891331034e+00 3.264485867545605e+00 4.695483320398994e+00 9.209630142787824e+03 + 125300 9.334179511375577e-01 -5.948253042581875e+00 -5.966552341864610e+00 3.963796687509261e+00 4.858719279220384e+00 9.114615330726987e+03 + 125320 9.058860074723356e-01 -5.901348477473810e+00 -5.977346601126740e+00 4.182145793788626e+00 4.745752807101876e+00 9.147620208418193e+03 + 125340 9.969748559260597e-01 -6.023679304978067e+00 -5.972364473337065e+00 3.531610201012202e+00 4.826267905239368e+00 9.132404713016220e+03 + 125360 1.019399090899083e+00 -6.038084402483618e+00 -5.983977605561650e+00 3.478992212776802e+00 4.789681813702503e+00 9.167898524722605e+03 + 125380 1.021204313199955e+00 -6.018694869106962e+00 -5.991709877059316e+00 3.524577285572696e+00 4.679529285824303e+00 9.191592185891910e+03 + 125400 1.020678966138177e+00 -5.992203331433706e+00 -5.985485527456626e+00 3.747795509648807e+00 4.786370179662010e+00 9.172534382346297e+03 + 125420 1.010008783453193e+00 -5.947399276831139e+00 -6.050860947927063e+00 3.932883690286187e+00 4.338790764211532e+00 9.373843300089120e+03 + 125440 1.032819688356014e+00 -5.953591307373817e+00 -6.010377769655819e+00 3.916280243548987e+00 4.590203589449096e+00 9.248935788927951e+03 + 125460 1.074902084524316e+00 -5.990833451741444e+00 -5.957315320917294e+00 3.768398976641438e+00 4.960865270747687e+00 9.086446492988905e+03 + 125480 1.005275171964690e+00 -5.866110938443020e+00 -5.982136296990879e+00 4.420558252208743e+00 4.754322688560730e+00 9.162238996476748e+03 + 125500 1.049949797720821e+00 -5.912236491142219e+00 -5.988790534852830e+00 4.165467891516865e+00 4.725882725830557e+00 9.182613481481767e+03 + 125520 1.104715253590872e+00 -5.978110731707037e+00 -5.963916961902010e+00 3.832359092507432e+00 4.913861915206676e+00 9.106590717220904e+03 + 125540 1.081219951477477e+00 -5.932915861529744e+00 -5.978391310868883e+00 4.033340786985500e+00 4.772213719577123e+00 9.150828536161065e+03 + 125560 1.125449605056190e+00 -5.994371130196797e+00 -5.982512581338344e+00 3.718565944572181e+00 4.786659567221920e+00 9.163442612158698e+03 + 125580 1.186859722586394e+00 -6.090245463854491e+00 -5.972034131094916e+00 3.250605832692587e+00 4.929393598542692e+00 9.131389094805774e+03 + 125600 1.089030982738752e+00 -5.966654218185574e+00 -5.953042013799531e+00 3.870078484751655e+00 4.948241868818132e+00 9.073419893048242e+03 + 125620 1.021760289215146e+00 -5.902926662882873e+00 -5.940733849132510e+00 4.298208269097231e+00 5.081113555008651e+00 9.035945284070145e+03 + 125640 9.814839150866710e-01 -5.890602316239514e+00 -6.006404073144687e+00 4.250573417226613e+00 4.585621808813147e+00 9.236703207687464e+03 + 125660 1.037999285731651e+00 -6.030189571014499e+00 -5.974356348561984e+00 3.495813959226532e+00 4.816416962712123e+00 9.138488249677981e+03 + 125680 9.551825152910183e-01 -5.955910624108537e+00 -6.015787080314421e+00 3.902512084783592e+00 4.558692207397754e+00 9.265557956963570e+03 + 125700 9.726033814613453e-01 -6.016619267354353e+00 -5.985594547207881e+00 3.668126561071123e+00 4.846275305212096e+00 9.172881075348039e+03 + 125720 9.612809916496031e-01 -6.023804764931121e+00 -6.003229598832850e+00 3.588012232139724e+00 4.706158019872658e+00 9.226967665019087e+03 + 125740 1.035401968684546e+00 -6.149883215440727e+00 -5.950738302799014e+00 2.952616301728645e+00 5.096137207693001e+00 9.066455655232156e+03 + 125760 9.649353471912662e-01 -6.053391189519150e+00 -5.973996083018763e+00 3.443889883487218e+00 4.899788871365461e+00 9.137397824933234e+03 + 125780 9.390474983605321e-01 -6.017327882993260e+00 -5.993801342882723e+00 3.585897771034212e+00 4.720990805069230e+00 9.198021575105910e+03 + 125800 9.785108910638471e-01 -6.072959022851851e+00 -5.947337630185425e+00 3.313492744208733e+00 5.034830220747041e+00 9.056090725482029e+03 + 125820 9.436669535441604e-01 -6.013132036656266e+00 -6.003920962435579e+00 3.615909017208641e+00 4.668800430792957e+00 9.229075876438075e+03 + 125840 9.482587096932599e-01 -6.007129100036054e+00 -5.989979227711098e+00 3.662046269045141e+00 4.760523489869206e+00 9.186316354784814e+03 + 125860 9.608120790887555e-01 -6.007309771785031e+00 -6.033845045947523e+00 3.660458576694837e+00 4.508088926133400e+00 9.321250922584622e+03 + 125880 1.018350163597864e+00 -6.073820972137367e+00 -6.006473957740585e+00 3.294557162955924e+00 4.681274141539036e+00 9.236943432412018e+03 + 125900 9.887924360269364e-01 -6.011385898950010e+00 -6.015235858326106e+00 3.622217342662047e+00 4.600110280145216e+00 9.263878179905709e+03 + 125920 9.958588218604185e-01 -6.000045963391152e+00 -6.032538400868099e+00 3.668695314184196e+00 4.482118710003114e+00 9.317214819757693e+03 + 125940 1.065802825809796e+00 -6.081570500397539e+00 -5.979047406536282e+00 3.326508442270408e+00 4.915211912619249e+00 9.152850110536961e+03 + 125960 1.008204571873245e+00 -5.975380145696531e+00 -6.008671419392223e+00 3.833189039726022e+00 4.642025394357403e+00 9.243704173636637e+03 + 125980 1.002355300696404e+00 -5.947749671457522e+00 -6.039418859522347e+00 3.961072296845161e+00 4.434693633215928e+00 9.338442867238595e+03 + 126000 1.070322939067579e+00 -6.031495657248195e+00 -6.032683663250703e+00 3.551750193020037e+00 4.544928478710301e+00 9.317648243762374e+03 + 126020 1.080540821625192e+00 -6.031968710078305e+00 -5.976036830003016e+00 3.538057200359063e+00 4.859226711181842e+00 9.143646342701066e+03 + 126040 1.010352284103060e+00 -5.916394084110444e+00 -6.004248273339613e+00 4.126222750883993e+00 4.621750400938265e+00 9.230102133719836e+03 + 126060 9.936189891005375e-01 -5.883883684128283e+00 -6.048498909692882e+00 4.305395074142660e+00 4.360148974826902e+00 9.366519176931442e+03 + 126080 1.040572889425446e+00 -5.946971350999720e+00 -6.006768369252994e+00 4.006187514753634e+00 4.662823782384669e+00 9.237827222109252e+03 + 126100 1.074011697448616e+00 -5.991784204491791e+00 -5.988283534928775e+00 3.784203114995481e+00 4.804304501353180e+00 9.181104552559425e+03 + 126120 1.043327721086999e+00 -5.945054482126311e+00 -6.012197421405385e+00 3.947580599792178e+00 4.562035452115465e+00 9.254534157933602e+03 + 126140 1.012668938038879e+00 -5.903243631195958e+00 -6.051307201084065e+00 4.162498004475371e+00 4.312294073414475e+00 9.375240182504233e+03 + 126160 1.002049525542144e+00 -5.900897944640656e+00 -6.060419254521289e+00 4.260980819061892e+00 4.344984771884372e+00 9.403451506939511e+03 + 126180 1.016228764659691e+00 -5.949080547754446e+00 -6.027708361957030e+00 3.935181150061737e+00 4.483688073295577e+00 9.302306393301245e+03 + 126200 9.509187055770033e-01 -5.882620165532265e+00 -6.018753728238430e+00 4.357023151209265e+00 4.575323167549727e+00 9.274682676843489e+03 + 126220 9.905810802037659e-01 -5.973778162934403e+00 -6.015128200951174e+00 3.819486748142676e+00 4.582048430952675e+00 9.263531149392687e+03 + 126240 1.005605625605479e+00 -6.028714346709177e+00 -6.026092277101925e+00 3.544752401062634e+00 4.559808730511438e+00 9.297333157722274e+03 + 126260 9.855504242150177e-01 -6.032575286364621e+00 -6.033084407069212e+00 3.501919481936280e+00 4.498996032064346e+00 9.318905572537606e+03 + 126280 9.937509334446325e-01 -6.074649752246600e+00 -5.998001638091472e+00 3.280258171833364e+00 4.720383504569437e+00 9.210915850892492e+03 + 126300 9.537760273899872e-01 -6.039142211896226e+00 -5.981865381401023e+00 3.515696297823333e+00 4.844588722087663e+00 9.161459614690737e+03 + 126320 9.197020517765120e-01 -6.004050984677195e+00 -5.999051742814778e+00 3.702824828180694e+00 4.731531248584871e+00 9.214132796782798e+03 + 126340 1.004366728210673e+00 -6.139408835534846e+00 -5.994898324300915e+00 2.967722293970978e+00 4.797524012405553e+00 9.201403897981107e+03 + 126360 8.977370940620636e-01 -5.986476439726847e+00 -6.023305647426478e+00 3.761502207369202e+00 4.550023197456446e+00 9.288754880927771e+03 + 126380 9.581579661004165e-01 -6.075697823099003e+00 -6.029091458639776e+00 3.253159530306156e+00 4.520780487342630e+00 9.306584482010676e+03 + 126400 9.624464653476996e-01 -6.077063210382438e+00 -6.024113985995219e+00 3.258913968945238e+00 4.562956609242648e+00 9.291237424314984e+03 + 126420 9.666972274368565e-01 -6.075285128439799e+00 -5.979160675062667e+00 3.292234596709955e+00 4.844196083212530e+00 9.153183733083746e+03 + 126440 9.257702313964982e-01 -5.998727766568924e+00 -5.978563604528541e+00 3.729071059227829e+00 4.844856798057696e+00 9.151365055620172e+03 + 126460 9.867738893445132e-01 -6.064142543476539e+00 -5.969523226111564e+00 3.368293054211472e+00 4.911611816813197e+00 9.123740907981231e+03 + 126480 1.014982861392889e+00 -6.073478191542316e+00 -5.992641700760260e+00 3.322167382758571e+00 4.786343022235656e+00 9.194492422247118e+03 + 126500 1.052503233619153e+00 -6.091795075750636e+00 -5.998669845250659e+00 3.268037918551459e+00 4.802777403165171e+00 9.212977867146185e+03 + 126520 9.732106957277720e-01 -5.940699960549144e+00 -6.042203034598334e+00 3.977345471274317e+00 4.394499112533927e+00 9.347064651271494e+03 + 126540 1.027188861095846e+00 -5.990617722013163e+00 -5.999985066710535e+00 3.757638494582419e+00 4.703849751738204e+00 9.217002700837736e+03 + 126560 1.003445895595316e+00 -5.929888103308469e+00 -5.998187642103611e+00 4.050191288272151e+00 4.658004767190979e+00 9.211466667628623e+03 + 126580 1.032442380135101e+00 -5.953391376722640e+00 -5.985992781631492e+00 3.912441165935438e+00 4.725238853897705e+00 9.174108841103156e+03 + 126600 1.041525910018534e+00 -5.951973384666887e+00 -6.047424941596542e+00 3.952105078046879e+00 4.404007467076109e+00 9.363204449572999e+03 + 126620 1.025861650244323e+00 -5.923388752323168e+00 -6.018902158208336e+00 4.053463979988038e+00 4.505011222743612e+00 9.275174320393746e+03 + 126640 1.071931169848964e+00 -5.990147089516754e+00 -6.008489231203121e+00 3.757589748224180e+00 4.652266332223813e+00 9.243124398802214e+03 + 126660 1.012097017604710e+00 -5.905990885039561e+00 -6.047271170209743e+00 4.200350739670460e+00 4.389097479169801e+00 9.362732538907863e+03 + 126680 1.051451057047113e+00 -5.974892065310292e+00 -6.001117808300541e+00 3.816702072754249e+00 4.666109798083628e+00 9.220469066878813e+03 + 126700 1.015475203316565e+00 -5.931852527227987e+00 -6.029616478590155e+00 4.049058814949927e+00 4.487683077305777e+00 9.308169303801764e+03 + 126720 9.985391090683801e-01 -5.918418609230604e+00 -6.067769588855175e+00 4.127167663191647e+00 4.269571226197960e+00 9.426245582270356e+03 + 126740 1.010381504880904e+00 -5.949519893748811e+00 -6.046887099837126e+00 3.974586169876065e+00 4.415488604990516e+00 9.361536864098702e+03 + 126760 9.877567096521568e-01 -5.928734124705440e+00 -6.023807014159334e+00 4.071555057335239e+00 4.525631813608887e+00 9.290273332465742e+03 + 126780 1.048494801770816e+00 -6.032740332262077e+00 -6.003277326571490e+00 3.477461238143713e+00 4.646642376204460e+00 9.227102706975897e+03 + 126800 1.029802673025638e+00 -6.018790550510474e+00 -5.969002894977253e+00 3.611901572839508e+00 4.897789995526057e+00 9.122118753151226e+03 + 126820 1.007661856281030e+00 -5.995929921436116e+00 -5.987858495783819e+00 3.748992844288883e+00 4.795340219433457e+00 9.179790478808596e+03 + 126840 9.994073434041534e-01 -5.991707206086002e+00 -5.990763289598833e+00 3.746613814806365e+00 4.752033929346297e+00 9.188714909451566e+03 + 126860 1.071852687540978e+00 -6.104624386163079e+00 -5.969122690991814e+00 3.125358512342136e+00 4.903430214835099e+00 9.122519369061189e+03 + 126880 1.020774821089471e+00 -6.033737110009005e+00 -6.006603928173111e+00 3.538201828214290e+00 4.694004757162313e+00 9.237309560236492e+03 + 126900 9.597981384505995e-01 -5.947105264013785e+00 -6.030672607714600e+00 3.992597164544192e+00 4.512740545009467e+00 9.311440407292059e+03 + 126920 1.057083226994604e+00 -6.095967897546941e+00 -5.970918347877355e+00 3.204514206793671e+00 4.922568072351704e+00 9.127996632826671e+03 + 126940 9.297765619612924e-01 -5.911640495032261e+00 -6.038843500697634e+00 4.126712680630426e+00 4.396293337498348e+00 9.336670990923150e+03 + 126960 9.852217117654888e-01 -5.997010517103025e+00 -6.012065876898925e+00 3.702565551546328e+00 4.616115345788876e+00 9.254105152751907e+03 + 126980 9.858341561308115e-01 -5.998067400448159e+00 -5.978723185418414e+00 3.676290832699344e+00 4.787368308907743e+00 9.151861772388538e+03 + 127000 9.879359794822126e-01 -5.998797942917931e+00 -6.049483424413829e+00 3.710157472443961e+00 4.419113594141603e+00 9.369552639916028e+03 + 127020 9.526110090733547e-01 -5.945157457546740e+00 -6.018552386325988e+00 4.091347230350085e+00 4.669902191471126e+00 9.274093726943685e+03 + 127040 9.767921039317932e-01 -5.979848179448197e+00 -5.980785234980231e+00 3.802734486050912e+00 4.797353768177099e+00 9.158153924167924e+03 + 127060 1.010681262935819e+00 -6.026158587143191e+00 -5.977507359766596e+00 3.600625769313951e+00 4.879988645663459e+00 9.148128117551991e+03 + 127080 1.007655219694128e+00 -6.015747926938898e+00 -6.003903675471872e+00 3.638861077890150e+00 4.706872602705804e+00 9.229058094347096e+03 + 127100 1.015822739429654e+00 -6.021706263918435e+00 -6.023601327861203e+00 3.581069271526913e+00 4.570187521107338e+00 9.289636362595553e+03 + 127120 1.039947431421970e+00 -6.049271525994542e+00 -5.970759876777067e+00 3.451904333093588e+00 4.902730372538782e+00 9.127501192303063e+03 + 127140 1.029450304533891e+00 -6.020426513565474e+00 -5.993070491502103e+00 3.565370362425317e+00 4.722452874443926e+00 9.195766604225701e+03 + 127160 9.595297056093001e-01 -5.897569930412183e+00 -6.011784697635629e+00 4.204698564292221e+00 4.548859696217086e+00 9.253227425875866e+03 + 127180 1.032471472195369e+00 -5.975520427184144e+00 -5.984893337520771e+00 3.870077576006935e+00 4.816256874400841e+00 9.170719129699613e+03 + 127200 1.027881685995342e+00 -5.930542404970062e+00 -6.019241770645679e+00 4.045388510713384e+00 4.536063026821515e+00 9.276214400387367e+03 + 127220 1.079888643148452e+00 -5.968161008773680e+00 -6.023747493244224e+00 3.835615470816537e+00 4.516429275005997e+00 9.290096495824264e+03 + 127240 1.007006080992803e+00 -5.829570705031059e+00 -6.068442222455127e+00 4.525750167750919e+00 4.154112949454063e+00 9.428330330049228e+03 + 127260 9.857639023709340e-01 -5.777230894464740e+00 -6.048993836220127e+00 4.861893092358580e+00 4.301388225619826e+00 9.368041759356160e+03 + 127280 1.085940612239046e+00 -5.912470231746411e+00 -6.048234340494655e+00 4.085440772268099e+00 4.305862250407753e+00 9.365705710476548e+03 + 127300 1.061257141174926e+00 -5.872014577333476e+00 -5.985480676800453e+00 4.414978259951712e+00 4.763438357990185e+00 9.172538210268684e+03 + 127320 1.100522132757640e+00 -5.934154242610391e+00 -6.028971446816051e+00 4.053640956774854e+00 4.509185897311023e+00 9.306204453506001e+03 + 127340 1.066597477286030e+00 -5.903687977244488e+00 -6.020895317185328e+00 4.187235301993772e+00 4.514212618276232e+00 9.281298674126341e+03 + 127360 1.087694465066298e+00 -5.964211575103045e+00 -5.990184570086203e+00 3.911291143294357e+00 4.762150186793080e+00 9.186907025657551e+03 + 127380 1.049356762687138e+00 -5.943295228145061e+00 -5.988686956621363e+00 3.992225530941398e+00 4.731579201683192e+00 9.182355369031997e+03 + 127400 9.725052840397832e-01 -5.867161045153154e+00 -6.042014372846904e+00 4.421300123752491e+00 4.417265257669968e+00 9.346442416527016e+03 + 127420 1.051022758899312e+00 -6.020963599377749e+00 -6.024090727246411e+00 3.575263977985044e+00 4.557307525841715e+00 9.291146796927440e+03 + 127440 1.007921520592668e+00 -5.990965013958167e+00 -6.026125361283382e+00 3.733654595173410e+00 4.531758439785862e+00 9.297453832424057e+03 + 127460 9.871330663387800e-01 -5.991136612016938e+00 -6.043495566398008e+00 3.692982856533308e+00 4.392329637955199e+00 9.351076381245724e+03 + 127480 1.037162025836960e+00 -6.090363892875780e+00 -5.987196418533715e+00 3.246428597155899e+00 4.838832199943097e+00 9.177794745736765e+03 + 127500 8.865150670664946e-01 -5.883536993723847e+00 -6.009084914183722e+00 4.362707444823544e+00 4.641791857065040e+00 9.244931359400351e+03 + 127520 1.003102155548931e+00 -6.064778683411097e+00 -5.963062459480788e+00 3.344528368702449e+00 4.928598667045066e+00 9.104001853516766e+03 + 127540 9.974974078522862e-01 -6.060364985122694e+00 -5.989770386140426e+00 3.349757030262414e+00 4.755122142097484e+00 9.185681802488753e+03 + 127560 9.545369493599074e-01 -5.999908842649927e+00 -5.975654016704667e+00 3.704504056497043e+00 4.843779020496914e+00 9.142464796739479e+03 + 127580 9.731547490642515e-01 -6.025163416753940e+00 -5.997567275081018e+00 3.543580969361009e+00 4.702042285336050e+00 9.209582768427324e+03 + 127600 1.035800585997533e+00 -6.114078271638102e+00 -5.964431027030997e+00 3.086288590286762e+00 4.945586226657023e+00 9.108190642618472e+03 + 127620 9.536787599374443e-01 -5.987459311570670e+00 -5.989096135218199e+00 3.779227336171892e+00 4.769828441490139e+00 9.183553554581349e+03 + 127640 9.587521051586863e-01 -5.986145643381080e+00 -5.989833155993152e+00 3.794784762527958e+00 4.773610494468714e+00 9.185826914571700e+03 + 127660 9.990134475016830e-01 -6.030932508174542e+00 -5.983635896308229e+00 3.532736784181894e+00 4.804321248645292e+00 9.166863053195304e+03 + 127680 1.011978521356086e+00 -6.032720736916890e+00 -5.952275479381816e+00 3.521235156445239e+00 4.983164274075005e+00 9.071109558019261e+03 + 127700 9.927662620928909e-01 -5.981674781346862e+00 -5.972265092542253e+00 3.809848225388653e+00 4.863880114649350e+00 9.132094187462446e+03 + 127720 1.042692533133877e+00 -6.029769082116383e+00 -5.980523989501355e+00 3.515083357926245e+00 4.797856300375188e+00 9.157355350970132e+03 + 127740 1.025884990650385e+00 -5.974929785046936e+00 -5.990635677287614e+00 3.862333233192249e+00 4.772147569467313e+00 9.188311577644314e+03 + 127760 1.005302005156088e+00 -5.911996567052520e+00 -6.005296968167061e+00 4.198609583528446e+00 4.662864242138345e+00 9.233260945505821e+03 + 127780 1.023770807705223e+00 -5.906453327680439e+00 -6.006862678030421e+00 4.222531347903925e+00 4.645965319897578e+00 9.238111329522006e+03 + 127800 1.082690144564573e+00 -5.959887744261756e+00 -5.980157452104243e+00 3.968822936936748e+00 4.852431137778039e+00 9.156205439297637e+03 + 127820 1.065286821440856e+00 -5.902278781020101e+00 -6.006421553767138e+00 4.206379941902524e+00 4.608376024747037e+00 9.236709429114058e+03 + 127840 1.037986464659272e+00 -5.834088254570290e+00 -6.015941441064063e+00 4.553313773678932e+00 4.509084635142023e+00 9.266011827084203e+03 + 127860 1.052751947384366e+00 -5.832699184527084e+00 -6.053215640459521e+00 4.572934037202550e+00 4.306694422427231e+00 9.381126935088652e+03 + 127880 1.146389685621485e+00 -5.953099524813645e+00 -6.054024597100646e+00 3.949559898478701e+00 4.370032515302280e+00 9.383622937091883e+03 + 127900 1.121928591464230e+00 -5.911772056053179e+00 -6.034429473481056e+00 4.196050506812249e+00 4.491732634767381e+00 9.323037140985296e+03 + 127920 1.109173562730930e+00 -5.905324783393100e+00 -6.016923231155616e+00 4.170321702591446e+00 4.529506145735102e+00 9.269041408721067e+03 + 127940 1.065335256081995e+00 -5.874855302430412e+00 -5.962661185509113e+00 4.313054934713614e+00 4.808859966159223e+00 9.102757922780882e+03 + 127960 1.068344447928427e+00 -5.937152803151026e+00 -5.981005008228821e+00 4.016268955939189e+00 4.764462808275689e+00 9.158780250916772e+03 + 127980 1.018759429566964e+00 -5.934803740719032e+00 -5.995192243726732e+00 4.027103396521558e+00 4.680343267160706e+00 9.202300047932895e+03 + 128000 9.387072094197848e-01 -5.876573989395136e+00 -6.047764247648476e+00 4.347974461675557e+00 4.364973507178033e+00 9.364247071835691e+03 + 128020 1.000451242637367e+00 -6.007812424870898e+00 -5.990631275921212e+00 3.685437974887076e+00 4.784094790930380e+00 9.188292406885394e+03 + 128040 1.032553655181270e+00 -6.083940746947192e+00 -6.005037701599145e+00 3.236978267604957e+00 4.690051764200253e+00 9.232526881566817e+03 + 128060 1.006423967350842e+00 -6.068702389053529e+00 -5.998745738701910e+00 3.291405172896365e+00 4.693107084972020e+00 9.213185230403278e+03 + 128080 9.289077634255066e-01 -5.971379357648027e+00 -5.943475598958027e+00 3.832082901012491e+00 4.992310601503171e+00 9.044313146059681e+03 + 128100 9.463319589579593e-01 -6.004990136312212e+00 -5.894829915301774e+00 3.691906639726086e+00 5.324463676007134e+00 8.897010192367785e+03 + 128120 9.798802837569099e-01 -6.054000389621859e+00 -5.955997861773470e+00 3.394062929827252e+00 4.956808610574867e+00 9.082464277852458e+03 + 128140 1.004070998564655e+00 -6.085740123895430e+00 -5.985691103719994e+00 3.225646955236049e+00 4.800143911619238e+00 9.173151844094180e+03 + 128160 9.925650330039432e-01 -6.062932006962921e+00 -5.943600078308990e+00 3.355262059210232e+00 5.040484460097380e+00 9.044715773936745e+03 + 128180 1.028158427389251e+00 -6.105286494714720e+00 -5.969786130840967e+00 3.126482140723247e+00 4.904546198699881e+00 9.124514958583961e+03 + 128200 9.595227390759470e-01 -5.987249614035392e+00 -6.002469492335815e+00 3.746147410172869e+00 4.658752513703281e+00 9.224619228767000e+03 + 128220 9.682999439818541e-01 -5.981636961125142e+00 -5.960532414900518e+00 3.803546487181629e+00 4.924732057521396e+00 9.096281726946736e+03 + 128240 8.647145057747702e-01 -5.805451555606286e+00 -6.071903273829191e+00 4.668911684370788e+00 4.138904685064735e+00 9.439089824538987e+03 + 128260 1.052106403536501e+00 -6.057350290796379e+00 -6.007578886570073e+00 3.376003633220704e+00 4.661798738388065e+00 9.240308026791652e+03 + 128280 9.954038855501277e-01 -5.948336843958561e+00 -5.988248245125536e+00 3.998431285850210e+00 4.769253844080068e+00 9.181005224641054e+03 + 128300 1.045287568301547e+00 -5.998746049165963e+00 -6.010804880863547e+00 3.681371373690255e+00 4.612127695984556e+00 9.250223248416178e+03 + 128320 1.047977424011754e+00 -5.979793056458488e+00 -6.013319276615354e+00 3.848339925452775e+00 4.655827181146247e+00 9.257980657188600e+03 + 128340 1.050073647864767e+00 -5.965802460527244e+00 -6.023159455791997e+00 3.857681368563514e+00 4.528328625786971e+00 9.288281828705563e+03 + 128360 1.051525452285047e+00 -5.956582164653073e+00 -6.013906338077664e+00 3.888414627054256e+00 4.559250352363084e+00 9.259798917355236e+03 + 128380 1.056110961703002e+00 -5.957188253962125e+00 -6.020845660736772e+00 3.919315357124751e+00 4.553784676472868e+00 9.281154634545570e+03 + 128400 1.045569647423122e+00 -5.940500875818298e+00 -6.001151609421267e+00 4.006312801738305e+00 4.658046903719362e+00 9.220570108375496e+03 + 128420 9.832475297539028e-01 -5.853449167501552e+00 -5.976994019070416e+00 4.522621067826034e+00 4.813207411613623e+00 9.146520316509967e+03 + 128440 1.097252497085282e+00 -6.031253649927362e+00 -5.990953372154626e+00 3.527456484757242e+00 4.758866916176120e+00 9.189276031103309e+03 + 128460 9.975150703572050e-01 -5.899287254841412e+00 -6.055128630205241e+00 4.225299938637596e+00 4.330434644923597e+00 9.387039326713433e+03 + 128480 1.068793385743430e+00 -6.035038015236009e+00 -6.011855602791601e+00 3.463604640439933e+00 4.596721640162452e+00 9.253471641181304e+03 + 128500 1.023290096933179e+00 -6.012896584697229e+00 -5.968015394406229e+00 3.640587989385077e+00 4.898302729377752e+00 9.119121095380660e+03 + 128520 9.439574297988668e-01 -5.947390848902583e+00 -6.003578142947180e+00 4.014217686441378e+00 4.691581549081646e+00 9.228024226228026e+03 + 128540 9.554439910681820e-01 -6.012856206422853e+00 -5.973999208016886e+00 3.654479685419697e+00 4.877602583367828e+00 9.137379718878901e+03 + 128560 9.475195204901365e-01 -6.035507830840991e+00 -5.958071488832198e+00 3.530763039655073e+00 4.975414498704756e+00 9.088771086038116e+03 + 128580 9.455431384238935e-01 -6.053308580034300e+00 -5.951835703882524e+00 3.478782508293704e+00 5.061455466034039e+00 9.069770334124851e+03 + 128600 9.656796039485217e-01 -6.093955981370375e+00 -5.976153046703790e+00 3.199370542212150e+00 4.875813223012907e+00 9.143998462795233e+03 + 128620 8.505157921866495e-01 -5.924542686665331e+00 -6.022015459557739e+00 4.099069739885319e+00 4.539365994074259e+00 9.284766717530827e+03 + 128640 9.698506302999883e-01 -6.096824070366317e+00 -5.992162803712375e+00 3.151378121021208e+00 4.752359310426812e+00 9.193013020229248e+03 + 128660 9.604679393152528e-01 -6.074121629584546e+00 -5.998404164414745e+00 3.307386846400697e+00 4.742168248645562e+00 9.212169762923990e+03 + 128680 9.879656359653279e-01 -6.102296028933983e+00 -5.979575573255415e+00 3.186310212308688e+00 4.890990059744163e+00 9.154467768829905e+03 + 128700 9.202843401766456e-01 -5.985519874063225e+00 -5.987468245535381e+00 3.799003659936934e+00 4.787815809434305e+00 9.178623681600811e+03 + 128720 9.851702106098040e-01 -6.061180316987536e+00 -5.999900703624086e+00 3.336730233537585e+00 4.688607256460033e+00 9.216758858808484e+03 + 128740 9.663434045177725e-01 -6.010018647814018e+00 -6.008139109325924e+00 3.667138418519277e+00 4.677931019375550e+00 9.242051055287788e+03 + 128760 1.015568734502812e+00 -6.060139969355067e+00 -5.975042096299700e+00 3.343338637162192e+00 4.831983793099406e+00 9.140587174674181e+03 + 128780 1.028875969339291e+00 -6.055912219203117e+00 -5.962299449734457e+00 3.402281514686474e+00 4.939820523504777e+00 9.101680644472521e+03 + 128800 9.757179717818161e-01 -5.955764500472258e+00 -6.002445331639901e+00 3.934223835951568e+00 4.666175279551684e+00 9.224551750772871e+03 + 128820 1.034385775352941e+00 -6.024761355050257e+00 -5.978302506480723e+00 3.569346660804829e+00 4.836120558774677e+00 9.150551930815616e+03 + 128840 1.060909702100942e+00 -6.048502449440511e+00 -5.993207740114505e+00 3.489202828814317e+00 4.806713606592860e+00 9.196198157205057e+03 + 128860 1.051692460075836e+00 -6.023960057677946e+00 -5.999768479243894e+00 3.581777562768899e+00 4.720689349771888e+00 9.216344939062039e+03 + 128880 1.033252329188637e+00 -5.990825881819732e+00 -6.004901333175344e+00 3.749818843053057e+00 4.668995423200078e+00 9.232108956426706e+03 + 128900 1.016075023949411e+00 -5.964010508843751e+00 -5.989342786176423e+00 3.904147360761310e+00 4.758685504159859e+00 9.184364900553275e+03 + 128920 1.058581716127306e+00 -6.027517033939924e+00 -5.968801569234006e+00 3.566802144033834e+00 4.903955428564015e+00 9.121493742782790e+03 + 128940 9.759260074279310e-01 -5.906978997447178e+00 -6.023036620597526e+00 4.211758278561425e+00 4.545337446572987e+00 9.287886643799811e+03 + 128960 1.002313103294546e+00 -5.949324937377976e+00 -6.010868823610426e+00 3.969503554832230e+00 4.616109036199888e+00 9.250437437293522e+03 + 128980 1.044345472213966e+00 -6.015296303033006e+00 -6.002338487918886e+00 3.605939565102536e+00 4.680345344703222e+00 9.224248971286674e+03 + 129000 1.048738092576143e+00 -6.029642180566197e+00 -6.003983459012173e+00 3.560149878972292e+00 4.707486228809825e+00 9.229286111759126e+03 + 129020 9.727673165620796e-01 -5.924350637877566e+00 -6.033033343283979e+00 4.136018309537236e+00 4.511945396499310e+00 9.318708532168152e+03 + 129040 9.502613736836092e-01 -5.897493625092650e+00 -6.014201873221145e+00 4.295142476440171e+00 4.624985655143328e+00 9.260673677525067e+03 + 129060 1.020526873253962e+00 -6.005610557264253e+00 -5.974632776850246e+00 3.695651274405251e+00 4.873530483338506e+00 9.139337899452343e+03 + 129080 1.055514338312259e+00 -6.062792128115350e+00 -5.977677433964948e+00 3.363235836459920e+00 4.851977581727880e+00 9.148658774957310e+03 + 129100 9.229781647320041e-01 -5.870502255378035e+00 -6.043581041663495e+00 4.345521513944307e+00 4.351676339237576e+00 9.351321695135710e+03 + 129120 1.079864516932587e+00 -6.106398734894460e+00 -5.960961931063164e+00 3.137425685932840e+00 4.972546319804795e+00 9.097611756743001e+03 + 129140 1.004987044183094e+00 -6.000315949639446e+00 -5.989135098041931e+00 3.689807385292234e+00 4.754009565396357e+00 9.183728962679308e+03 + 129160 9.770102792761569e-01 -5.964690788915311e+00 -5.986999528636860e+00 3.812539558485320e+00 4.684439322737872e+00 9.177173003940377e+03 + 129180 9.325572406222066e-01 -5.901570630066749e+00 -5.963911306831359e+00 4.203371107119482e+00 4.845401293948544e+00 9.106568023171707e+03 + 129200 9.545276732589868e-01 -5.932505892076356e+00 -6.005431489696488e+00 4.027427861623725e+00 4.608677794889163e+00 9.233709569360031e+03 + 129220 1.006893725446736e+00 -6.006635350703687e+00 -5.982182605496312e+00 3.666738613436068e+00 4.807150060466909e+00 9.162418746545918e+03 + 129240 1.015208461534815e+00 -6.016495962379730e+00 -5.986557432272103e+00 3.565955615928415e+00 4.737867288778974e+00 9.175823231988918e+03 + 129260 1.046717135637673e+00 -6.060911551639271e+00 -5.982163393657437e+00 3.335702222990688e+00 4.787886332360441e+00 9.162365551202738e+03 + 129280 1.010383501473100e+00 -6.006489009792996e+00 -6.007219433767167e+00 3.630877457038610e+00 4.626683249546176e+00 9.239207278051275e+03 + 129300 9.922836962293752e-01 -5.980550126982769e+00 -5.999212704896792e+00 3.799934805598405e+00 4.692771395191484e+00 9.214613255065758e+03 + 129320 9.694310687226775e-01 -5.944275016358281e+00 -6.005203863464919e+00 3.940275300135311e+00 4.590412431340381e+00 9.233049580482906e+03 + 129340 9.936257037949381e-01 -5.979255205618803e+00 -6.023645928117546e+00 3.775598105289140e+00 4.520699707259258e+00 9.289789670069071e+03 + 129360 1.020403333289133e+00 -6.020397623111294e+00 -6.004299511015038e+00 3.611446642070187e+00 4.703884492901686e+00 9.230240800264670e+03 + 129380 9.907142361799818e-01 -5.976940386754113e+00 -5.993869769594108e+00 3.910117175668594e+00 4.812906039587819e+00 9.198224491073790e+03 + 129400 9.946641828799671e-01 -5.982129936549329e+00 -6.015764973751194e+00 3.828466067948489e+00 4.635328479330197e+00 9.265514493055351e+03 + 129420 1.076064266214556e+00 -6.104942850561373e+00 -5.974908955661144e+00 3.130300397024480e+00 4.876975144221795e+00 9.140197338899059e+03 + 129440 9.823927067437052e-01 -5.969617214907251e+00 -6.056125175198895e+00 3.841662923628983e+00 4.344920828570769e+00 9.390141258505906e+03 + 129460 1.017941905181488e+00 -6.032328517798633e+00 -6.009777050574376e+00 3.551141436801058e+00 4.680635451431013e+00 9.247097204924296e+03 + 129480 9.959151026773121e-01 -6.017031689896564e+00 -5.965013669014875e+00 3.657591933963023e+00 4.956287459628402e+00 9.109952269142183e+03 + 129500 9.731663921552207e-01 -6.005612391473320e+00 -5.959352128450965e+00 3.766084916384413e+00 5.031718505411341e+00 9.092660077333405e+03 + 129520 9.029051394701073e-01 -5.921803349507596e+00 -5.987880792580370e+00 4.104547826342279e+00 4.725120922767144e+00 9.179875883815697e+03 + 129540 9.482890567362423e-01 -6.007096064932270e+00 -5.997172603792926e+00 3.629739434826967e+00 4.686721484339730e+00 9.208376762257290e+03 + 129560 9.600456959124766e-01 -6.040016487476182e+00 -5.998349599527732e+00 3.532384700877478e+00 4.771642419407552e+00 9.211972781171287e+03 + 129580 9.776220570354500e-01 -6.078498325142204e+00 -6.017523136257008e+00 3.353626463205465e+00 4.703755433664247e+00 9.270918140923710e+03 + 129600 9.034900101022930e-01 -5.978232854312960e+00 -6.023802624344478e+00 3.839109305385481e+00 4.577440633965381e+00 9.290248271526114e+03 + 129620 9.562344850865300e-01 -6.061728257677846e+00 -5.939708780447196e+00 3.421550797603354e+00 5.122205518314823e+00 9.032907197370518e+03 + 129640 9.033621199933575e-01 -5.979869879511972e+00 -6.000276395162891e+00 3.872268246494183e+00 4.755090875728511e+00 9.217881766406143e+03 + 129660 1.052373973756105e+00 -6.191384891903369e+00 -5.959566991643456e+00 2.730620287546738e+00 5.061754544543286e+00 9.093358300320138e+03 + 129680 9.616629357566057e-01 -6.045040165367610e+00 -5.981283359414459e+00 3.456166720132436e+00 4.822268166249258e+00 9.159676365739697e+03 + 129700 9.695868950169850e-01 -6.039252332060416e+00 -5.969990815929365e+00 3.506734683317018e+00 4.904445027126493e+00 9.125157130010992e+03 + 129720 1.009120616043809e+00 -6.072515418737348e+00 -5.991060227056860e+00 3.331208982160830e+00 4.798937297940367e+00 9.189630841143100e+03 + 129740 1.006173006029847e+00 -6.040854511393437e+00 -6.020959441523466e+00 3.400343853638968e+00 4.514584423584457e+00 9.281498872566202e+03 + 129760 1.046404590331147e+00 -6.070650586562063e+00 -5.998378947755061e+00 3.283852827703206e+00 4.698847761732974e+00 9.212086736764017e+03 + 129780 9.883877901615780e-01 -5.957045006032190e+00 -6.032444945101710e+00 3.905387073796957e+00 4.472428955556914e+00 9.316908322713509e+03 + 129800 1.003533052271296e+00 -5.955618091562554e+00 -6.000273726777280e+00 3.881459348858640e+00 4.625039781018470e+00 9.217897549190282e+03 + 129820 9.832070289474178e-01 -5.903764182484596e+00 -5.971649966342071e+00 4.242272837326565e+00 4.852462161125843e+00 9.130213332301517e+03 + 129840 1.010187188159006e+00 -5.923893870619227e+00 -5.971393107398547e+00 4.135025048305565e+00 4.862277080235575e+00 9.129419611066607e+03 + 129860 1.013614863634049e+00 -5.910417592514338e+00 -5.991697745171674e+00 4.254859324924979e+00 4.788136110303586e+00 9.191565130420984e+03 + 129880 1.067925335110951e+00 -5.976313005616007e+00 -6.075367340785015e+00 3.760066930175666e+00 4.191281609026396e+00 9.449857056188530e+03 + 129900 1.117967033321007e+00 -6.046554551978498e+00 -5.983880714234401e+00 3.414203909916396e+00 4.774086784988046e+00 9.167642150304247e+03 + 129920 1.005401900635174e+00 -5.882831416601722e+00 -5.978893197357828e+00 4.393403178479215e+00 4.841801567865128e+00 9.152331031994041e+03 + 129940 1.010753057391384e+00 -5.895054613244981e+00 -6.015282077484189e+00 4.228494083010274e+00 4.538129378208779e+00 9.263995717515687e+03 + 129960 1.093399613155166e+00 -6.025124407169180e+00 -6.023069244013273e+00 3.538907412855640e+00 4.550708477732329e+00 9.287986099360787e+03 + 129980 1.009150668472008e+00 -5.919702858404034e+00 -5.998578261076164e+00 4.166678067422347e+00 4.713763299349867e+00 9.212680768841359e+03 + 130000 1.037751547993773e+00 -5.992110109889762e+00 -6.009552526758010e+00 3.770345127426452e+00 4.670188070563684e+00 9.246374161426193e+03 + 130020 9.908145180159973e-01 -5.963389106192283e+00 -5.970904010438749e+00 3.949870438530954e+00 4.906718695420067e+00 9.127933531448667e+03 + 130040 9.280155673539134e-01 -5.917251256727734e+00 -5.992916074230699e+00 4.137286513966719e+00 4.702807422772028e+00 9.195297499187283e+03 + 130060 9.595524704139696e-01 -6.010133675779773e+00 -6.010161600911466e+00 3.614478586075526e+00 4.614318235647945e+00 9.248201819458518e+03 + 130080 9.314203886347654e-01 -6.005599831183238e+00 -6.041816938093032e+00 3.600835918355036e+00 4.392871685899816e+00 9.345861501453346e+03 + 130100 9.517344424367696e-01 -6.062809667729904e+00 -5.973967359265375e+00 3.355062546495795e+00 4.865208830001926e+00 9.137330379887740e+03 + 130120 8.813290888018622e-01 -5.972700300468483e+00 -6.024697729710567e+00 3.817509323701857e+00 4.518932038417640e+00 9.293006708426925e+03 + 130140 1.033412690909530e+00 -6.204167456474518e+00 -5.937667491788797e+00 2.639062937546925e+00 5.169346975508583e+00 9.026710583435230e+03 + 130160 9.582197545886285e-01 -6.091905911710287e+00 -5.967676985779068e+00 3.157458047688994e+00 4.870799764750204e+00 9.118103773112454e+03 + 130180 8.632549572159915e-01 -5.943696291556827e+00 -5.999447959981097e+00 3.968616885561908e+00 4.648482177926941e+00 9.215338450618285e+03 + 130200 1.013752135444461e+00 -6.153646426214869e+00 -5.967040219925130e+00 2.878883730670323e+00 4.950405444403106e+00 9.116154243543957e+03 + 130220 9.612794038489771e-01 -6.061639873288725e+00 -5.963935317415885e+00 3.371638577316571e+00 4.932673256869575e+00 9.106645607708262e+03 + 130240 9.239330646508690e-01 -5.988488246858412e+00 -5.973162002563834e+00 3.723997271473501e+00 4.812002937941611e+00 9.134840893456889e+03 + 130260 9.710014946844866e-01 -6.036736936302495e+00 -6.000051202350139e+00 3.468767235512081e+00 4.679422396965490e+00 9.217213491892917e+03 + 130280 9.743768838340293e-01 -6.020368948625114e+00 -6.036476538172151e+00 3.531478065859158e+00 4.438985794038647e+00 9.329391992365876e+03 + 130300 9.279046530605765e-01 -5.933439282487546e+00 -6.017622512484666e+00 4.046722058525956e+00 4.563328924569759e+00 9.271217885321294e+03 + 130320 1.018396314722176e+00 -6.048873719129234e+00 -5.988657926507931e+00 3.379420993875897e+00 4.725189393471213e+00 9.182280662231853e+03 + 130340 1.047347152683664e+00 -6.074403459039202e+00 -5.940334266318025e+00 3.313904845048186e+00 5.083750896793706e+00 9.034791519423512e+03 + 130360 9.485508560498295e-01 -5.910397020820428e+00 -6.051217172546302e+00 4.158477263490039e+00 4.349866160432021e+00 9.374933608940177e+03 + 130380 1.069775604446337e+00 -6.075299827264171e+00 -5.985059801567441e+00 3.355384050684886e+00 4.873556242834353e+00 9.171247966702915e+03 + 130400 9.606198868153359e-01 -5.902847464718493e+00 -6.015385317223734e+00 4.185904485691843e+00 4.539694721430360e+00 9.264336105971588e+03 + 130420 1.002803889277898e+00 -5.958516965497759e+00 -5.966661317655273e+00 3.885574351828278e+00 4.838808221405405e+00 9.114995915702782e+03 + 130440 9.822701979978311e-01 -5.921607600915568e+00 -5.993168748091777e+00 4.144306707036171e+00 4.733391525898644e+00 9.196001144659876e+03 + 130460 9.891693959316625e-01 -5.924901303532156e+00 -5.981960606810342e+00 4.146202828905038e+00 4.818559479583048e+00 9.161704090523775e+03 + 130480 9.808002622514090e-01 -5.906011284052338e+00 -5.979751610289825e+00 4.161662736705834e+00 4.738234372171575e+00 9.154967991838661e+03 + 130500 9.892647259064381e-01 -5.911841127004600e+00 -6.003225121047725e+00 4.156213417315598e+00 4.631472381892598e+00 9.226961854874482e+03 + 130520 1.142076245454957e+00 -6.134164498241263e+00 -6.006113986570374e+00 2.959248364311468e+00 4.694534218078349e+00 9.235848541561476e+03 + 130540 1.007313198739957e+00 -5.938236094929297e+00 -6.020044121234127e+00 3.999470327844580e+00 4.529715981051088e+00 9.278698740380993e+03 + 130560 9.857476702324003e-01 -5.916242687883362e+00 -6.003884296458702e+00 4.119824482261775e+00 4.616572803327076e+00 9.228953761291472e+03 + 130580 1.069192919484169e+00 -6.054065597455280e+00 -5.942416334624140e+00 3.441551813059276e+00 5.082659157903265e+00 9.041101041490014e+03 + 130600 1.040974700502877e+00 -6.034759215719706e+00 -5.962142455425467e+00 3.526301293488378e+00 4.943277968505236e+00 9.101201862531399e+03 + 130620 1.045799231330264e+00 -6.081023764086412e+00 -5.977143752890905e+00 3.226442500187407e+00 4.822937599851789e+00 9.147024541023015e+03 + 130640 9.304060353517893e-01 -5.966932838631656e+00 -6.028648823922307e+00 3.865453756780490e+00 4.511071018723718e+00 9.305173647295003e+03 + 130660 8.550211192301715e-01 -5.909412888423455e+00 -6.010028320260917e+00 4.163961333099687e+00 4.586211953301222e+00 9.247785990933997e+03 + 130680 9.262755517295742e-01 -6.053803198453267e+00 -5.926903075509967e+00 3.428762114986681e+00 5.157442258657669e+00 8.994004034778938e+03 + 130700 9.354913654966395e-01 -6.089392531243090e+00 -5.931575679845718e+00 3.251121289560703e+00 5.157330072363235e+00 9.008192084560962e+03 + 130720 9.722619306150498e-01 -6.154287362840794e+00 -5.940171820469064e+00 2.887360183935924e+00 5.116844762507495e+00 9.034306822792556e+03 + 130740 9.423412200013547e-01 -6.111743270916906e+00 -5.992542425097653e+00 3.059791105448741e+00 4.744260808414170e+00 9.194186470369792e+03 + 130760 9.659805696672976e-01 -6.142265180158485e+00 -5.952509813387426e+00 2.927528771105917e+00 5.017133451653443e+00 9.071830954138479e+03 + 130780 9.121436220960939e-01 -6.050412802404012e+00 -5.976736273749574e+00 3.453742208852684e+00 4.876804237792429e+00 9.145751706947749e+03 + 130800 9.414142955578697e-01 -6.072396093511701e+00 -6.007273627473042e+00 3.290954133774420e+00 4.664897411437448e+00 9.239401964831506e+03 + 130820 9.889452751547436e-01 -6.115165001573543e+00 -6.012108747558173e+00 3.047350127117402e+00 4.639115085577424e+00 9.254261314994992e+03 + 130840 9.766422297006558e-01 -6.067513788862502e+00 -5.950258765151728e+00 3.424944083845583e+00 5.098240575149127e+00 9.064961659876841e+03 + 130860 9.667361955223737e-01 -6.021008990835047e+00 -5.946726516335534e+00 3.592644043008533e+00 5.019185506760513e+00 9.054215409885062e+03 + 130880 9.688117497582549e-01 -5.989193093281153e+00 -6.022877994566516e+00 3.712402473748630e+00 4.518978557846452e+00 9.287405288106858e+03 + 130900 1.046459896835408e+00 -6.076140588835923e+00 -5.987113254923373e+00 3.247110466957905e+00 4.758319195219165e+00 9.177543766486402e+03 + 130920 1.001241489815685e+00 -5.989045455665241e+00 -5.968776205861732e+00 3.770247258697248e+00 4.886636427725263e+00 9.121412079303464e+03 + 130940 1.015102110166460e+00 -5.992534699109218e+00 -5.949756933957074e+00 3.769193566819293e+00 5.014830114160667e+00 9.063413737140219e+03 + 130960 9.895406944753474e-01 -5.938949854768244e+00 -6.001256413191301e+00 3.982812723351691e+00 4.625038822977740e+00 9.220875819324372e+03 + 130980 1.024924967857476e+00 -5.980513514908746e+00 -5.999532966668895e+00 3.824700254427073e+00 4.715487619169647e+00 9.215604102110889e+03 + 131000 9.929163763065123e-01 -5.926794761807104e+00 -5.997169610423101e+00 4.098320438248973e+00 4.694217167023292e+00 9.208328024754333e+03 + 131020 9.863343497304644e-01 -5.912742605038970e+00 -5.978251132230994e+00 4.157213581423814e+00 4.781053480875389e+00 9.150373700035954e+03 + 131040 1.026502958096067e+00 -5.967305256129757e+00 -6.027907334722565e+00 3.836388092233951e+00 4.488401578812697e+00 9.302917269914193e+03 + 131060 1.048728847154973e+00 -6.001265657101656e+00 -6.024028623973661e+00 3.697615969164134e+00 4.566907490827341e+00 9.290940025232332e+03 + 131080 9.889393355206663e-01 -5.916955856332093e+00 -6.027425685694053e+00 4.106189286219957e+00 4.471854430872741e+00 9.301412968914718e+03 + 131100 1.037865634614798e+00 -5.996542675796617e+00 -5.980228381991186e+00 3.702519611123512e+00 4.796198810783103e+00 9.156423992949243e+03 + 131120 1.011618693635208e+00 -5.967221218051940e+00 -5.974245703828467e+00 3.924061195994286e+00 4.883725511629811e+00 9.138087361382166e+03 + 131140 1.017253049302407e+00 -5.986517651424045e+00 -5.948268421049749e+00 3.777779408601776e+00 4.997412408460251e+00 9.058924788909679e+03 + 131160 9.906888968076047e-01 -5.959679220404807e+00 -5.983547071829328e+00 3.897478719481563e+00 4.760425823063891e+00 9.166615315697958e+03 + 131180 9.861525112325507e-01 -5.968643110620259e+00 -6.001685332156196e+00 3.822142440107700e+00 4.632408890781095e+00 9.222200612043398e+03 + 131200 1.010150883399419e+00 -6.025241010784542e+00 -5.978735826122769e+00 3.572012249211560e+00 4.839052216193533e+00 9.151898345215264e+03 + 131220 9.634617858393478e-01 -5.984821763032730e+00 -6.017442792059971e+00 3.728999726099529e+00 4.541684729337179e+00 9.270669775951050e+03 + 131240 9.320903174748767e-01 -5.974629355676563e+00 -6.000781176958316e+00 3.879240122827778e+00 4.729072318046684e+00 9.219415154012926e+03 + 131260 9.596288892019618e-01 -6.059521589906135e+00 -5.986798750884664e+00 3.336896738437006e+00 4.754482533921259e+00 9.176571474889493e+03 + 131280 9.294171967612899e-01 -6.057506572535013e+00 -5.957698384004682e+00 3.422803160593937e+00 4.995917224402358e+00 9.087648543448455e+03 + 131300 9.368816737505392e-01 -6.101624095436714e+00 -5.958225120938673e+00 3.197086444157960e+00 5.020505546645293e+00 9.089262942157644e+03 + 131320 9.081809979090329e-01 -6.083203468796682e+00 -5.978506973984281e+00 3.252938344002955e+00 4.854121818945969e+00 9.151208929746004e+03 + 131340 9.140272377536326e-01 -6.105442739682275e+00 -5.952867864457081e+00 3.153928646885507e+00 5.030037191314197e+00 9.072929480964880e+03 + 131360 9.299782707210749e-01 -6.130074877849971e+00 -5.991326764342759e+00 2.939790434936322e+00 4.736503573895909e+00 9.190430008882078e+03 + 131380 9.292113359768130e-01 -6.120717577154668e+00 -5.951982823932367e+00 3.062532384021016e+00 5.031433448642144e+00 9.070246205063650e+03 + 131400 9.349050247908286e-01 -6.113052788629876e+00 -5.950550616089913e+00 3.103484355982219e+00 5.036596977836615e+00 9.065877646211531e+03 + 131420 8.944669324281120e-01 -6.029789336002717e+00 -5.991800640952964e+00 3.466551196806023e+00 4.684688162513266e+00 9.191871498008848e+03 + 131440 9.490785488211793e-01 -6.081372453595723e+00 -6.006901960210344e+00 3.254568527731753e+00 4.682189625022205e+00 9.238238950854175e+03 + 131460 9.441050074310288e-01 -6.040035811745318e+00 -5.988798056465310e+00 3.503967332268256e+00 4.798182452103064e+00 9.182710197619665e+03 + 131480 9.749943669524669e-01 -6.057908060253988e+00 -5.993426248170112e+00 3.376102544417253e+00 4.746367087931038e+00 9.196863186049690e+03 + 131500 9.480390910346277e-01 -5.994460582188390e+00 -6.043368852780913e+00 3.668339467528291e+00 4.387500609255614e+00 9.350630778454890e+03 + 131520 9.936554483390485e-01 -6.046281577999659e+00 -5.975775925999860e+00 3.455411305914447e+00 4.860265670411684e+00 9.142843783513661e+03 + 131540 9.974825880941089e-01 -6.038992918219156e+00 -5.986541282890313e+00 3.499324859726110e+00 4.800510266648666e+00 9.175788028419514e+03 + 131560 9.650634451688612e-01 -5.980158139206812e+00 -6.006599884049781e+00 3.826482366919605e+00 4.674649776184486e+00 9.237336502890559e+03 + 131580 9.844847597104974e-01 -5.998758182610353e+00 -6.020253187343963e+00 3.733795230133574e+00 4.610367586611955e+00 9.279309162893407e+03 + 131600 9.799845160853959e-01 -5.982355256986222e+00 -5.992591675016119e+00 3.816435554686437e+00 4.757656458278200e+00 9.194285020398986e+03 + 131620 1.074841989902992e+00 -6.111719734982337e+00 -5.990156589158974e+00 3.058032333011454e+00 4.756066728165226e+00 9.186841134894026e+03 + 131640 1.021566653898261e+00 -6.023496184101069e+00 -5.993923254252505e+00 3.577783793828215e+00 4.747596133414774e+00 9.198411150782498e+03 + 131660 9.988572878305120e-01 -5.982151115710368e+00 -6.021800198779461e+00 3.881532872872973e+00 4.653861702214468e+00 9.284075450314220e+03 + 131680 9.542998200077226e-01 -5.909095586032468e+00 -6.033044022740478e+00 4.195608689986646e+00 4.483877585450658e+00 9.318768752115076e+03 + 131700 9.948097351992861e-01 -5.963174628537422e+00 -6.008388483880959e+00 3.897634048252030e+00 4.638009094047936e+00 9.242816096675942e+03 + 131720 1.075774746962939e+00 -6.075864832384100e+00 -5.988895039556573e+00 3.294036738213971e+00 4.793430747161572e+00 9.182982886669404e+03 + 131740 1.026925605605125e+00 -5.998468945904522e+00 -5.987007033044060e+00 3.690584499054940e+00 4.756400576424991e+00 9.177231476320199e+03 + 131760 9.645541551530786e-01 -5.902902799090524e+00 -6.024738732508280e+00 4.184743427848777e+00 4.485142644114258e+00 9.293142928399158e+03 + 131780 1.037863459748161e+00 -6.008605433160512e+00 -6.008056798237897e+00 3.598390864015848e+00 4.601541210642486e+00 9.241789888565552e+03 + 131800 1.011416269782353e+00 -5.967293489743165e+00 -6.059025524296016e+00 3.822058748004886e+00 4.295319210115950e+00 9.399148034215455e+03 + 131820 1.045796583306019e+00 -6.020139756320925e+00 -6.039961113370834e+00 3.601762412770950e+00 4.487945113245279e+00 9.340151835226810e+03 + 131840 1.051363344620901e+00 -6.039196307859006e+00 -5.990917538023098e+00 3.460445651992833e+00 4.737669819506110e+00 9.189210823942260e+03 + 131860 9.516715597445816e-01 -5.904967216667557e+00 -6.065313356850689e+00 4.130147895400962e+00 4.209415544984414e+00 9.418622800076517e+03 + 131880 9.902121535581838e-01 -5.980996661991100e+00 -6.050556673666457e+00 3.764238278315116e+00 4.364813926898200e+00 9.372906231824405e+03 + 131900 9.992305102776153e-01 -6.021816236990613e+00 -5.988479971077663e+00 3.600440377003318e+00 4.791862374645959e+00 9.181737095208926e+03 + 131920 9.327371018627784e-01 -5.952708545753907e+00 -6.005590371468488e+00 3.971055616467836e+00 4.667399989778635e+00 9.234191892896813e+03 + 131940 1.032300505622860e+00 -6.128504056250518e+00 -5.946579398961126e+00 3.000283671674647e+00 5.044923206580066e+00 9.053791157802332e+03 + 131960 9.374364038543318e-01 -6.014774148843005e+00 -6.009737451162145e+00 3.609257693002378e+00 4.638179190512319e+00 9.246970149427940e+03 + 131980 9.129694426202657e-01 -6.000902233426792e+00 -6.005901240877793e+00 3.709424754795825e+00 4.680719680418271e+00 9.235175153588976e+03 + 132000 9.347293138641727e-01 -6.049746180086279e+00 -5.997036926212532e+00 3.437882529116709e+00 4.740547221590439e+00 9.207964693286849e+03 + 132020 1.007661819316109e+00 -6.170508154556785e+00 -5.956316367553574e+00 2.804409132700806e+00 5.034331519745159e+00 9.083459269847934e+03 + 132040 9.039688068028412e-01 -6.023529920764026e+00 -5.962135497007073e+00 3.599759514843564e+00 4.952295796812361e+00 9.101189557782816e+03 + 132060 9.400815177663824e-01 -6.074949342272023e+00 -5.972214207283267e+00 3.300029016741138e+00 4.889950060057336e+00 9.131939973745764e+03 + 132080 9.231809280595583e-01 -6.040181642798435e+00 -5.972836175167368e+00 3.444837087314707e+00 4.831545184129729e+00 9.133849333610633e+03 + 132100 9.695647251093127e-01 -6.089113839505469e+00 -5.952054161621563e+00 3.300871198579139e+00 5.087889078905132e+00 9.070430979363424e+03 + 132120 9.525130223641367e-01 -6.033570486809437e+00 -5.965448935213486e+00 3.522655227181482e+00 4.913819718221480e+00 9.111273689621772e+03 + 132140 9.771733932976668e-01 -6.027928095293650e+00 -6.002414123585487e+00 3.543863643345686e+00 4.690368817168316e+00 9.224442063120772e+03 + 132160 1.003578404677515e+00 -6.018580521538330e+00 -5.999421722668743e+00 3.570508556747712e+00 4.680521344671424e+00 9.215274792354157e+03 + 132180 1.011293119525269e+00 -5.986060594329639e+00 -6.021136768733252e+00 3.812304777450680e+00 4.610891956004686e+00 9.282042377343676e+03 + 132200 1.018135932628273e+00 -5.964094403222354e+00 -6.008527813606719e+00 3.863956697252700e+00 4.608813178777639e+00 9.243244327161114e+03 + 132220 1.063043309216911e+00 -6.011348753054513e+00 -5.988758609997705e+00 3.617856279972256e+00 4.747572377217785e+00 9.182575410881669e+03 + 132240 9.898005315034716e-01 -5.892438065206695e+00 -6.005795544835182e+00 4.265478755394578e+00 4.614562565354528e+00 9.234846334763384e+03 + 132260 1.044542916627904e+00 -5.968052329680044e+00 -5.970768013412160e+00 3.916196396641733e+00 4.900602520401227e+00 9.127497522490574e+03 + 132280 1.031013434802440e+00 -5.945085978811416e+00 -5.997198483695152e+00 3.985447837981947e+00 4.686209770555469e+00 9.208462015954326e+03 + 132300 1.093292219793546e+00 -6.039578747751402e+00 -5.971120346051375e+00 3.501366907392073e+00 4.894465643857054e+00 9.128611770211861e+03 + 132320 1.046878657813880e+00 -5.975744318052128e+00 -6.047352546606565e+00 3.831975036690973e+00 4.420789506993841e+00 9.362977908327457e+03 + 132340 1.017586913122717e+00 -5.944015916946937e+00 -6.089664932376402e+00 3.949621473696559e+00 4.113282287988282e+00 9.494357606616781e+03 + 132360 1.077201681012495e+00 -6.051323862438799e+00 -6.038255942188954e+00 3.393033173111758e+00 4.468071193440498e+00 9.334867023567695e+03 + 132380 9.798402200486902e-01 -5.930065130377508e+00 -6.014772151093011e+00 4.081213180798415e+00 4.594812359480906e+00 9.262440318157855e+03 + 132400 9.264576628612249e-01 -5.872373371951564e+00 -6.019868955074758e+00 4.374576035414259e+00 4.527633572253163e+00 9.278114457341262e+03 + 132420 1.017043944967979e+00 -6.026827155223682e+00 -6.020814255898976e+00 3.534211269140794e+00 4.568738267556419e+00 9.281069693823008e+03 + 132440 9.744611570973639e-01 -5.986325542135468e+00 -6.019297335435391e+00 3.771415403647459e+00 4.582086264150774e+00 9.276389218091392e+03 + 132460 9.682602421343692e-01 -5.996289221156561e+00 -5.968907980358157e+00 3.694306785428529e+00 4.851534107326282e+00 9.121853924028270e+03 + 132480 9.290149427906982e-01 -5.951414015927163e+00 -5.989759699909190e+00 3.971470330390357e+00 4.751283478990146e+00 9.185618583848838e+03 + 132500 9.888872647459694e-01 -6.051015779978992e+00 -5.984123752859995e+00 3.409912001318687e+00 4.794016372543711e+00 9.168368044482755e+03 + 132520 9.509488262933156e-01 -6.002694231811184e+00 -6.026368524944291e+00 3.636586312049884e+00 4.500644857294562e+00 9.298153432449239e+03 + 132540 9.560836947895920e-01 -6.014968944158200e+00 -5.990599159592692e+00 3.591779910691897e+00 4.731714984879019e+00 9.188226574017381e+03 + 132560 9.528414488255458e-01 -6.012013598426408e+00 -6.007363953044258e+00 3.661434986962404e+00 4.688133970277003e+00 9.239653722245464e+03 + 132580 9.358202002294473e-01 -5.985933302024173e+00 -6.017846781099994e+00 3.751494129074389e+00 4.568241993626100e+00 9.271917645942476e+03 + 132600 1.035282204292405e+00 -6.126375735626592e+00 -6.012820510653172e+00 3.005837121236166e+00 4.657888795647819e+00 9.256465769006414e+03 + 132620 9.897186654287189e-01 -6.046423895200101e+00 -5.965635748422404e+00 3.471295682838554e+00 4.935193723561401e+00 9.111860235476490e+03 + 132640 9.460957873826957e-01 -5.959603211254621e+00 -5.931301408366930e+00 3.926473541534465e+00 5.088986873405432e+00 9.007311335197883e+03 + 132660 9.550922147091240e-01 -5.932103677076007e+00 -5.990916435454871e+00 4.073721288275228e+00 4.736009328418851e+00 9.189105119089043e+03 + 132680 1.057332381040988e+00 -6.029300428746118e+00 -5.984547270704942e+00 3.523129168061642e+00 4.780108727062897e+00 9.169670575962644e+03 + 132700 1.067428882361025e+00 -5.994401644400253e+00 -6.009808063705728e+00 3.681934031867175e+00 4.593467988079456e+00 9.247193871405367e+03 + 132720 9.690843264902743e-01 -5.812274099455540e+00 -6.073705480512018e+00 4.661964521319256e+00 4.160785074917491e+00 9.444662645450529e+03 + 132740 1.087629623995797e+00 -5.962921465309778e+00 -5.986631454330087e+00 3.884913297521206e+00 4.748766871457644e+00 9.176051633925643e+03 + 132760 1.111538498502393e+00 -5.980405898243865e+00 -5.962965163390331e+00 3.786848249351743e+00 4.886995647825734e+00 9.103704079814637e+03 + 132780 1.012368286894607e+00 -5.826084043493803e+00 -6.029442503510468e+00 4.646848129988535e+00 4.479132382952860e+00 9.307593175990376e+03 + 132800 1.052117824663129e+00 -5.884539865298575e+00 -5.985633371522004e+00 4.380535862563187e+00 4.800041305658727e+00 9.172969541470107e+03 + 132820 1.058025069890496e+00 -5.900839605791115e+00 -6.046345869225844e+00 4.218263317521907e+00 4.382743835858201e+00 9.359831194970886e+03 + 132840 9.892617036796453e-01 -5.813619731926292e+00 -5.998418422667670e+00 4.687533571612733e+00 4.626390891870774e+00 9.212176087127535e+03 + 132860 1.103436888433949e+00 -6.003410801104486e+00 -5.963770713611007e+00 3.704209041982881e+00 4.931828558654155e+00 9.106161718214880e+03 + 132880 1.118458240786627e+00 -6.054642404660227e+00 -5.991659992332066e+00 3.406247629641486e+00 4.767902387726595e+00 9.191452565926047e+03 + 132900 9.894167809493012e-01 -5.900801601354317e+00 -6.021441810523565e+00 4.190516615528435e+00 4.497781865466579e+00 9.282994868843331e+03 + 132920 1.049373904602768e+00 -6.027960370963112e+00 -5.964758024942666e+00 3.557667827239699e+00 4.920585478620536e+00 9.109185617933894e+03 + 132940 9.554385372963414e-01 -5.922091721842826e+00 -6.033322747839472e+00 4.094484021717309e+00 4.455778257498928e+00 9.319614787961344e+03 + 132960 1.077661555616522e+00 -6.131846920219488e+00 -5.958249256305716e+00 3.014499532697393e+00 5.011324183041943e+00 9.089317663578186e+03 + 132980 9.032096803725701e-01 -5.893377712875572e+00 -6.019602455183914e+00 4.231566065247208e+00 4.506764061696967e+00 9.277318867958178e+03 + 133000 1.018892730904459e+00 -6.079021070755577e+00 -5.976073160414867e+00 3.236919611671228e+00 4.828062443985228e+00 9.143736615169895e+03 + 133020 9.597095045426429e-01 -6.000794092692508e+00 -5.995301196991814e+00 3.673304065847680e+00 4.704845122983922e+00 9.202628259018546e+03 + 133040 9.738906187119155e-01 -6.027153946256729e+00 -5.978893243453346e+00 3.512246334748288e+00 4.789366758564937e+00 9.152381075279800e+03 + 133060 1.002556346841729e+00 -6.072158383461296e+00 -5.950634553252388e+00 3.305325113692537e+00 5.003133752504032e+00 9.066137791965641e+03 + 133080 1.000041676689338e+00 -6.065314641759104e+00 -5.963903348016336e+00 3.327900964473084e+00 4.910220306491047e+00 9.106561519253615e+03 + 133100 1.090713838932731e+00 -6.194364986364813e+00 -5.931575797561210e+00 2.666807409457852e+00 5.175783598063682e+00 9.008194823380709e+03 + 133120 9.894103553529071e-01 -6.036763091375734e+00 -5.960185308646391e+00 3.542301977233442e+00 4.982023456038911e+00 9.095236418709199e+03 + 133140 9.747643500189752e-01 -6.005973686253450e+00 -5.987524954686227e+00 3.618204486905385e+00 4.724139958496363e+00 9.178783347563502e+03 + 133160 9.756533189193919e-01 -5.995550093188819e+00 -5.923846182138532e+00 3.753103932865281e+00 5.164838886260405e+00 8.984731778435911e+03 + 133180 9.830597773318667e-01 -5.989973418089081e+00 -5.931307020934613e+00 3.744170210964956e+00 5.081041742021528e+00 9.007358721633655e+03 + 133200 1.020882264567463e+00 -6.023157302598637e+00 -5.983698011808997e+00 3.556070673824130e+00 4.782652027843763e+00 9.167049438819036e+03 + 133220 1.018840358724251e+00 -5.995022374989894e+00 -6.002661172309677e+00 3.737345724281863e+00 4.693482567971600e+00 9.225219361749476e+03 + 133240 1.019953059269000e+00 -5.971954873944162e+00 -6.014655122285640e+00 3.834352128210367e+00 4.589160694391526e+00 9.262068309474518e+03 + 133260 1.050031712446987e+00 -5.992328494898086e+00 -6.018848304826233e+00 3.747927606435564e+00 4.595646753900819e+00 9.275002485990664e+03 + 133280 1.082523498300699e+00 -6.014728070150849e+00 -6.012944681860009e+00 3.644031139957632e+00 4.654271631502080e+00 9.256839952121694e+03 + 133300 1.021617946640478e+00 -5.902474790596842e+00 -6.002666822004547e+00 4.204325719357309e+00 4.629007570347518e+00 9.225224429346159e+03 + 133320 1.027829483666674e+00 -5.890476437140644e+00 -6.013130640090641e+00 4.255172363272292e+00 4.550872949256845e+00 9.257348356487049e+03 + 133340 1.038007465712548e+00 -5.875393809000679e+00 -6.033049371113693e+00 4.345564259375092e+00 4.440281624602778e+00 9.318708502186004e+03 + 133360 1.018145030398882e+00 -5.806954696024283e+00 -6.083378120205639e+00 4.732888678985878e+00 4.145622600949888e+00 9.474738648012293e+03 + 133380 1.089380217846973e+00 -5.867019713100437e+00 -6.050405472579200e+00 4.390074757579108e+00 4.337045347797489e+00 9.372441855684629e+03 + 133400 1.130175408386272e+00 -5.883112654987854e+00 -6.016006332549606e+00 4.287984715839110e+00 4.524888654049389e+00 9.266247318962127e+03 + 133420 1.106340526512883e+00 -5.811623075504751e+00 -6.028000348893598e+00 4.667863345565354e+00 4.425391557491754e+00 9.303162950999373e+03 + 133440 1.137486322389834e+00 -5.834447867959518e+00 -6.009287650849941e+00 4.554012965081299e+00 4.550055875355533e+00 9.245568702034776e+03 + 133460 1.114654053237710e+00 -5.791522652539895e+00 -6.032313537602834e+00 4.778117757891700e+00 4.395459233591267e+00 9.316475405446266e+03 + 133480 1.144189770740905e+00 -5.842287138593331e+00 -6.033416826775372e+00 4.521639637876286e+00 4.424143391111354e+00 9.319905825721064e+03 + 133500 1.155186948778318e+00 -5.888772764506853e+00 -6.030058061747318e+00 4.276844427277136e+00 4.465562386693297e+00 9.309549172544648e+03 + 133520 1.101386974645630e+00 -5.859717523752370e+00 -5.997402999074414e+00 4.415065750163376e+00 4.624454444105752e+00 9.209053852424204e+03 + 133540 1.116841468459481e+00 -5.942084074690961e+00 -5.947169633274848e+00 4.026563504979896e+00 4.997361440603570e+00 9.055573861794684e+03 + 133560 1.076079905993702e+00 -5.935630134230188e+00 -6.026322214354354e+00 4.015968814039235e+00 4.495200855412231e+00 9.298017696062920e+03 + 133580 1.002963331690393e+00 -5.868172263751732e+00 -6.024693365084151e+00 4.369971008269935e+00 4.471202622857039e+00 9.293006735491605e+03 + 133600 1.039726531454948e+00 -5.952286399327838e+00 -6.005198546699418e+00 3.935667059516359e+00 4.631837321180402e+00 9.232989799353061e+03 + 133620 9.766356947567814e-01 -5.881931788684558e+00 -5.998675436908354e+00 4.381583786801539e+00 4.711223692679327e+00 9.212973140630240e+03 + 133640 1.096352567750887e+00 -6.080260206907969e+00 -6.013103189859272e+00 3.228966663781072e+00 4.614592648189491e+00 9.257325101462086e+03 + 133660 1.036073533383709e+00 -6.013224178648735e+00 -6.005455385910909e+00 3.651971064293993e+00 4.696580674411380e+00 9.233813247605463e+03 + 133680 9.734803857278230e-01 -5.942349096318710e+00 -6.013327865513344e+00 4.014766824324896e+00 4.607195747680271e+00 9.257987636114505e+03 + 133700 9.589553834113960e-01 -5.940386244156954e+00 -6.024599219874849e+00 3.994531697502196e+00 4.510967759014167e+00 9.292697571453800e+03 + 133720 1.004064488869004e+00 -6.024857434018790e+00 -6.002785347497909e+00 3.573511614142422e+00 4.700252950589670e+00 9.225598678366552e+03 + 133740 9.811425078790368e-01 -6.009275403273760e+00 -5.999766029815087e+00 3.703254248697334e+00 4.757858542667821e+00 9.216318739736784e+03 + 133760 9.666935284375827e-01 -6.002849758035861e+00 -6.018725692054337e+00 3.646431374846782e+00 4.555269304919843e+00 9.274629198278590e+03 + 133780 1.009402742003225e+00 -6.081525466970535e+00 -5.983964423878405e+00 3.271059490987016e+00 4.831270097944657e+00 9.167889073779115e+03 + 133800 9.296551303803440e-01 -5.974436684601466e+00 -5.986899731640028e+00 3.812327106717365e+00 4.740762361971649e+00 9.176874430628342e+03 + 133820 9.776313371392075e-01 -6.051303798383044e+00 -5.960791954033628e+00 3.471226281600511e+00 4.990959298517502e+00 9.097060783479068e+03 + 133840 9.279583110519684e-01 -5.979851179327287e+00 -6.008840303640524e+00 3.783534088513053e+00 4.617074050653962e+00 9.244211802893366e+03 + 133860 9.596130567028447e-01 -6.025848982398222e+00 -5.976552107252985e+00 3.586454708911353e+00 4.869524994662079e+00 9.145197551020789e+03 + 133880 9.259735342370835e-01 -5.969451801294080e+00 -6.015005776667810e+00 3.822284698009367e+00 4.560706721958508e+00 9.263174167815238e+03 + 133900 9.493164582818275e-01 -5.991982407044678e+00 -5.998561939176538e+00 3.779294562092747e+00 4.741513870412302e+00 9.212664139394186e+03 + 133920 1.068871581583520e+00 -6.149951221251842e+00 -5.988653406904929e+00 2.893984448276026e+00 4.820181459012106e+00 9.182259874323596e+03 + 133940 9.730930166466757e-01 -5.985776028781488e+00 -6.007283298682657e+00 3.806039178537932e+00 4.682541106526156e+00 9.239412492177731e+03 + 133960 1.009437225467250e+00 -6.012918805102241e+00 -5.974152390772919e+00 3.594125330400421e+00 4.816728080562619e+00 9.137859616569109e+03 + 133980 1.023182298001809e+00 -5.999359300667509e+00 -5.982477622856862e+00 3.667758624823749e+00 4.764695831243682e+00 9.163342591304678e+03 + 134000 9.858613721122188e-01 -5.904692852366039e+00 -6.039863812682755e+00 4.184921274400962e+00 4.408748702623872e+00 9.339835985653064e+03 + 134020 1.059135222310033e+00 -5.977033857344186e+00 -6.050606485402792e+00 3.812294897210398e+00 4.389829481570487e+00 9.373067140275338e+03 + 134040 1.003699869380266e+00 -5.866974560970858e+00 -6.091546285036553e+00 4.364556703005432e+00 4.075031111058228e+00 9.500227589418802e+03 + 134060 1.050772380389617e+00 -5.920305773221518e+00 -6.002669550542830e+00 4.144134529201153e+00 4.671188974068832e+00 9.225218501478043e+03 + 134080 1.039656832784916e+00 -5.893157927906180e+00 -6.003464918060904e+00 4.287508261596047e+00 4.654108454176064e+00 9.227657390697055e+03 + 134100 1.074410205847596e+00 -5.941969376072200e+00 -6.032663565970035e+00 3.976877288918897e+00 4.456097215645006e+00 9.317573276509796e+03 + 134120 1.005631767362321e+00 -5.843803181197550e+00 -6.040637757037181e+00 4.525392402445797e+00 4.395137807922468e+00 9.342210232379295e+03 + 134140 9.831284532961762e-01 -5.822838552744112e+00 -6.012119532486430e+00 4.642383785316948e+00 4.555503108499606e+00 9.254268555568557e+03 + 134160 1.025937099383842e+00 -5.903575896722969e+00 -5.974493758678848e+00 4.170678988789269e+00 4.763457650934941e+00 9.138882182506488e+03 + 134180 9.598349098303757e-01 -5.824814714184150e+00 -6.037243599351265e+00 4.576812978489613e+00 4.357013446596302e+00 9.331721278486990e+03 + 134200 1.080390570313716e+00 -6.031055948577317e+00 -6.002947279640057e+00 3.502819564233627e+00 4.664223891073837e+00 9.226099978569964e+03 + 134220 9.995059480570477e-01 -5.948959734476075e+00 -5.999968799803662e+00 4.047120295886062e+00 4.754218349147708e+00 9.216949207325337e+03 + 134240 1.019884770919002e+00 -6.021236791535046e+00 -5.958120754469650e+00 3.620430904737307e+00 4.982852956741978e+00 9.088922550363783e+03 + 134260 9.419472642201560e-01 -5.947038963739085e+00 -5.987305567016255e+00 3.951981121353943e+00 4.720764054099710e+00 9.178121845575417e+03 + 134280 9.772040641981496e-01 -6.035772607272571e+00 -5.977543816455685e+00 3.488097953097186e+00 4.822456680844003e+00 9.148261464361985e+03 + 134300 9.294882160528173e-01 -5.990756075603794e+00 -6.022513597279155e+00 3.731587788724782e+00 4.549231184804260e+00 9.286290936500187e+03 + 134320 9.470032720241938e-01 -6.029682379517280e+00 -5.995097946025600e+00 3.588400241566733e+00 4.786989410599748e+00 9.202015870044845e+03 + 134340 1.011866836606955e+00 -6.129789676969929e+00 -5.986900867596871e+00 3.012733280982367e+00 4.833222936374254e+00 9.176891467381527e+03 + 134360 9.449088369218303e-01 -6.030401569631795e+00 -6.018721066851030e+00 3.531358755229423e+00 4.598430009748544e+00 9.274627630719429e+03 + 134380 9.459389797747382e-01 -6.028703189378939e+00 -6.001899896015249e+00 3.605292130094433e+00 4.759200788384987e+00 9.222884445393336e+03 + 134400 9.816914304627492e-01 -6.075212222020898e+00 -5.958918248046218e+00 3.320616896426916e+00 4.988394891423839e+00 9.091400039982460e+03 + 134420 9.869428240175663e-01 -6.074045433585310e+00 -5.990078351298068e+00 3.314624948975847e+00 4.796776929333179e+00 9.186606032774233e+03 + 134440 9.823566449570301e-01 -6.054830340416393e+00 -5.977129367847033e+00 3.438247856248839e+00 4.884418864928745e+00 9.146971834037709e+03 + 134460 9.263728658960075e-01 -5.954627162100530e+00 -6.073725057595644e+00 3.961751879988959e+00 4.277873333716248e+00 9.444746382053394e+03 + 134480 1.003597198866873e+00 -6.050356466045384e+00 -6.023783875264179e+00 3.467543625730574e+00 4.620127554091390e+00 9.290235224142132e+03 + 134500 9.746741752540558e-01 -5.989409602138267e+00 -6.048825193756155e+00 3.777628246196014e+00 4.436454724593010e+00 9.367545440838903e+03 + 134520 1.027266492072433e+00 -6.051040140865791e+00 -6.001194401365625e+00 3.467012276142820e+00 4.753234225956034e+00 9.220732358601666e+03 + 134540 9.856461148531146e-01 -5.971095197139918e+00 -5.978678927903553e+00 3.926763667398380e+00 4.883216711775046e+00 9.151718415385507e+03 + 134560 9.644411399860825e-01 -5.919993881431087e+00 -6.056412166047499e+00 4.138975114164350e+00 4.355640213235591e+00 9.391013527944002e+03 + 134580 1.063278490524800e+00 -6.047461541711574e+00 -5.989160427081453e+00 3.547736565481578e+00 4.882510587756066e+00 9.183795717818281e+03 + 134600 1.050006779686611e+00 -6.009555340407124e+00 -6.047899342178744e+00 3.695286548185112e+00 4.475109356297374e+00 9.364686559243783e+03 + 134620 1.024874560416465e+00 -5.958827134572831e+00 -6.007924108516463e+00 3.910725776709358e+00 4.628803354592863e+00 9.241403028489849e+03 + 134640 1.052903185703804e+00 -5.989633720334964e+00 -6.035147690707177e+00 3.799409347974955e+00 4.538061086833552e+00 9.325251997223955e+03 + 134660 1.038716377003139e+00 -5.962062966824954e+00 -6.040965777540663e+00 3.914523394687461e+00 4.461451245387361e+00 9.343231833136182e+03 + 134680 1.040635491292013e+00 -5.965529693640684e+00 -6.001743234602738e+00 3.827178688274536e+00 4.619234932043069e+00 9.222371656542789e+03 + 134700 1.023084418980424e+00 -5.942235028512269e+00 -5.980426840149466e+00 3.999023790172495e+00 4.779720497587961e+00 9.157024907008054e+03 + 134720 1.019878902839303e+00 -5.943436111654466e+00 -5.955663229673636e+00 4.045067778231846e+00 4.974857774425379e+00 9.081423134153125e+03 + 134740 1.042956392240052e+00 -5.987651062761967e+00 -6.001914340262939e+00 3.743655956668146e+00 4.661754010022506e+00 9.222916287120424e+03 + 134760 1.064262272716257e+00 -6.036356135917834e+00 -5.957079542037752e+00 3.558616165423888e+00 5.013834635496576e+00 9.085763632132401e+03 + 134780 9.989695854654153e-01 -5.969287150084233e+00 -6.010871260520834e+00 3.882743360226338e+00 4.643960962979086e+00 9.250432892743096e+03 + 134800 9.333295579881140e-01 -5.908220355122953e+00 -6.007630430428890e+00 4.256314528304178e+00 4.685486492238055e+00 9.240447542802114e+03 + 134820 9.417151948783967e-01 -5.958032533276013e+00 -6.022957742814737e+00 3.883431515851653e+00 4.510620915536597e+00 9.287591200896701e+03 + 134840 1.013126947813049e+00 -6.101189279972104e+00 -5.995551870020187e+00 3.134843770972060e+00 4.741430126252325e+00 9.203413217321078e+03 + 134860 9.133624247616636e-01 -5.986115498535090e+00 -6.051478236185190e+00 3.678681536060306e+00 4.303358581622472e+00 9.375757915477987e+03 + 134880 9.196273216162918e-01 -6.021815845417403e+00 -6.031232661928714e+00 3.558542558272500e+00 4.504469740616911e+00 9.313165721490719e+03 + 134900 9.318965656920375e-01 -6.057815660767115e+00 -6.009628816812649e+00 3.337179968251744e+00 4.613876283128288e+00 9.246633772495341e+03 + 134920 9.141198839606671e-01 -6.040755920928273e+00 -5.983049678686143e+00 3.478834505930171e+00 4.810192678896606e+00 9.165096802360849e+03 + 134940 9.528913364269224e-01 -6.099428825131133e+00 -5.977414141014231e+00 3.180487816519425e+00 4.881115014430022e+00 9.147848531204858e+03 + 134960 1.002235110654620e+00 -6.167602373082999e+00 -5.996149630326142e+00 2.766578928912667e+00 4.751087110048730e+00 9.205228616499482e+03 + 134980 9.466319279021105e-01 -6.073495096556471e+00 -6.003153426493285e+00 3.330364365477528e+00 4.734277120318602e+00 9.226741622647623e+03 + 135000 9.571762784994100e-01 -6.074549670120779e+00 -5.984863161784038e+00 3.273725405807897e+00 4.788719215619770e+00 9.170649047737881e+03 + 135020 9.130235229373171e-01 -5.985818953357634e+00 -6.027586716471056e+00 3.778318826863310e+00 4.538481867525589e+00 9.301920584586709e+03 + 135040 9.605890036763339e-01 -6.026152210061887e+00 -6.014011195667989e+00 3.524714000837212e+00 4.594429584302878e+00 9.260108841478599e+03 + 135060 9.883069197164831e-01 -6.035362702794888e+00 -5.959212146365365e+00 3.566879552724979e+00 5.004147832003822e+00 9.092251669796151e+03 + 135080 9.801874220534152e-01 -5.988093148975336e+00 -6.000551520357858e+00 3.734153542650177e+00 4.662615646244995e+00 9.218724601916478e+03 + 135100 1.000552636577304e+00 -5.987579873907001e+00 -5.952393499315027e+00 3.766861728405494e+00 4.968907336386477e+00 9.071481782815363e+03 + 135120 9.463795194433802e-01 -5.878713330403205e+00 -6.026174648628905e+00 4.258006280103482e+00 4.411260571286264e+00 9.297557673837387e+03 + 135140 9.597082898267109e-01 -5.880184719122284e+00 -5.983806296260662e+00 4.372405465882292e+00 4.777394334566488e+00 9.167401650529273e+03 + 135160 1.040194334521365e+00 -5.988011341470250e+00 -5.991647422922926e+00 3.814330408514854e+00 4.793451466131803e+00 9.191406903692447e+03 + 135180 9.984503345131772e-01 -5.920686269929726e+00 -6.056765749108756e+00 4.072299491082410e+00 4.290910063405076e+00 9.392120975528063e+03 + 135200 1.059088676214036e+00 -6.011579206389208e+00 -5.995994328421039e+00 3.618305633428323e+00 4.707796414473623e+00 9.204766605283934e+03 + 135220 9.790047459842667e-01 -5.896093238448845e+00 -6.027078879273479e+00 4.290173560091363e+00 4.538033740513908e+00 9.300336811601697e+03 + 135240 9.853905519353029e-01 -5.911085646066945e+00 -6.013701581103376e+00 4.135502550598698e+00 4.546265971854885e+00 9.259152174922649e+03 + 135260 1.058157138969695e+00 -6.026369488659261e+00 -5.989014553646052e+00 3.534940552540305e+00 4.749438370043668e+00 9.183351103431303e+03 + 135280 9.441446008150856e-01 -5.867048779426600e+00 -6.008262551533792e+00 4.382419904767675e+00 4.571548572567571e+00 9.242399513778761e+03 + 135300 9.732259314481506e-01 -5.918801855566161e+00 -5.996205862394802e+00 4.092514160117722e+00 4.648048374676324e+00 9.205384881114183e+03 + 135320 1.052526715944636e+00 -6.044191344572246e+00 -5.979654234675381e+00 3.478488288241250e+00 4.849070360354526e+00 9.154702696511533e+03 + 135340 1.033851448917769e+00 -6.027699492130966e+00 -5.996396984661200e+00 3.536584123927170e+00 4.716327965865942e+00 9.206000631716646e+03 + 135360 9.848716899682420e-01 -5.968533166636531e+00 -5.980852009971139e+00 3.868189831456749e+00 4.797453126694585e+00 9.158369840399526e+03 + 135380 9.735000558391735e-01 -5.966350176019034e+00 -5.995701311963382e+00 3.895985918202272e+00 4.727447153536223e+00 9.203852500055136e+03 + 135400 9.956195234311751e-01 -6.013279396591430e+00 -5.998556173453064e+00 3.629614468969003e+00 4.714157494640913e+00 9.212596747525455e+03 + 135420 9.119275232026064e-01 -5.903356334710947e+00 -6.049446597769656e+00 4.218500456575013e+00 4.379627558696768e+00 9.369440611026392e+03 + 135440 9.631719147840894e-01 -5.994624002603187e+00 -5.993231085175509e+00 3.712852765983250e+00 4.720851113406249e+00 9.196278479216529e+03 + 135460 9.672594038354716e-01 -6.015910564363018e+00 -5.988944957780524e+00 3.624445253305839e+00 4.779285939216648e+00 9.183152241676135e+03 + 135480 9.500803181278987e-01 -6.006679146504524e+00 -6.057275935641376e+00 3.612012996891015e+00 4.321478403839399e+00 9.393713608936747e+03 + 135500 9.250496499750086e-01 -5.988808450447669e+00 -6.011463015994167e+00 3.761966531095441e+00 4.631880509944761e+00 9.252270977996519e+03 + 135520 9.787499883316908e-01 -6.090600807551785e+00 -5.991138329156836e+00 3.195487905980785e+00 4.766616848693370e+00 9.189864939828922e+03 + 135540 9.383503652217786e-01 -6.054250109136849e+00 -5.984461643148334e+00 3.379474275058590e+00 4.780210446494846e+00 9.169421256586862e+03 + 135560 9.512744765817412e-01 -6.094545685920740e+00 -5.988851627548462e+00 3.181679700390669e+00 4.788591339666965e+00 9.182858526889202e+03 + 135580 9.478256192321670e-01 -6.107861062970107e+00 -5.954856373654694e+00 3.145878309031883e+00 5.024454912480132e+00 9.079003650594013e+03 + 135600 9.395283946517236e-01 -6.109932630363132e+00 -5.996348312832080e+00 3.067705317207674e+00 4.719924045587309e+00 9.205859466044169e+03 + 135620 9.274733863802501e-01 -6.100494375679824e+00 -5.999318330467783e+00 3.152577777199450e+00 4.733546285749389e+00 9.214973927439351e+03 + 135640 8.934158376964244e-01 -6.051551952656523e+00 -6.037714506170492e+00 3.436360902598644e+00 4.515817661659365e+00 9.333216449193396e+03 + 135660 9.055227518385351e-01 -6.064336691344595e+00 -6.042805511603471e+00 3.339619713741479e+00 4.463255079754306e+00 9.348938754823754e+03 + 135680 9.466900547130490e-01 -6.110470583098967e+00 -6.014822500974977e+00 3.111890832217205e+00 4.661116921266028e+00 9.262611848665494e+03 + 135700 9.495219156427653e-01 -6.089406726365332e+00 -5.983190616712649e+00 3.250727173113972e+00 4.860636511629521e+00 9.165522073679958e+03 + 135720 9.363870616317906e-01 -6.034203682810155e+00 -6.011381700295392e+00 3.534447524090897e+00 4.665494879381050e+00 9.252007890957046e+03 + 135740 1.028989964342726e+00 -6.126255988161900e+00 -5.954364518462497e+00 3.001462206440264e+00 4.988489625573207e+00 9.077496192701356e+03 + 135760 1.005495650099243e+00 -6.046498093973088e+00 -5.958559369550157e+00 3.473383897213222e+00 4.978341661323313e+00 9.090258298507910e+03 + 135780 9.325872095524308e-01 -5.900015800884305e+00 -5.978940398310254e+00 4.236007978864603e+00 4.782810726902829e+00 9.152510755678974e+03 + 135800 1.037863821759400e+00 -6.024325500024887e+00 -5.971064930560333e+00 3.564128210475352e+00 4.869958642387314e+00 9.128436738805845e+03 + 135820 1.071859642277600e+00 -6.050436016601926e+00 -6.008121845806842e+00 3.419075513964524e+00 4.662050030766663e+00 9.242002167084340e+03 + 135840 1.016588112159255e+00 -5.954941401437411e+00 -6.001521174631887e+00 3.974780906830415e+00 4.707312640951129e+00 9.221734200245020e+03 + 135860 1.093033897928049e+00 -6.058203787195690e+00 -6.005832593885587e+00 3.439704134266367e+00 4.740427630668950e+00 9.234963548421763e+03 + 135880 1.009898768516946e+00 -5.932448289128472e+00 -6.016623148064784e+00 4.014222333513546e+00 4.530877267483924e+00 9.268150610136328e+03 + 135900 9.962408376908223e-01 -5.913096941790967e+00 -5.988001688723744e+00 4.167691975014372e+00 4.737577326654240e+00 9.180242722220735e+03 + 135920 1.028831140878599e+00 -5.963207927191141e+00 -6.013086619592904e+00 3.867710513650030e+00 4.581299343176404e+00 9.257269458026789e+03 + 135940 1.031007472934491e+00 -5.971296922714788e+00 -6.036711443883789e+00 3.854594666353730e+00 4.478974362936890e+00 9.330080233562498e+03 + 135960 1.039675392635592e+00 -5.995700506959935e+00 -6.012312276047803e+00 3.661527709678475e+00 4.566140360912976e+00 9.254858473422364e+03 + 135980 9.897255825049621e-01 -5.935153845434289e+00 -5.976504992147627e+00 4.037328742137434e+00 4.799884058640180e+00 9.145053116929234e+03 + 136000 1.037593879499317e+00 -6.020722705865604e+00 -6.001775463633496e+00 3.594135114842759e+00 4.702933111815781e+00 9.222463586667754e+03 + 136020 1.013357998073092e+00 -6.004289198812436e+00 -6.019221339265800e+00 3.620705553695097e+00 4.534962892470610e+00 9.276134372020048e+03 + 136040 1.023734106303207e+00 -6.045878702918042e+00 -5.958941965308181e+00 3.466564713095694e+00 4.965768913868184e+00 9.091440353228556e+03 + 136060 9.840547811084670e-01 -6.012171789587595e+00 -6.000469601326169e+00 3.629330488162919e+00 4.696526264067808e+00 9.218485174213669e+03 + 136080 1.042666060877388e+00 -6.126040949756003e+00 -5.966447118494462e+00 3.022771262410380e+00 4.939183738579722e+00 9.114356361761173e+03 + 136100 9.359937928866793e-01 -5.996427824265233e+00 -6.006664133687508e+00 3.704932866624054e+00 4.646154393857584e+00 9.237524440655254e+03 + 136120 9.583398103203221e-01 -6.057002087321176e+00 -6.004641528268717e+00 3.398316822216874e+00 4.698979255066422e+00 9.231300667792219e+03 + 136140 9.564943876536821e-01 -6.080473127589936e+00 -5.985157636379267e+00 3.265627530454709e+00 4.812943831010966e+00 9.171570305450896e+03 + 136160 9.305603169477679e-01 -6.064628017570847e+00 -5.991842680477818e+00 3.378301239291124e+00 4.796245908373809e+00 9.192002942056777e+03 + 136180 9.062794151335378e-01 -6.045335220490970e+00 -5.975230323223969e+00 3.395349400907540e+00 4.797902569712450e+00 9.141174620540722e+03 + 136200 9.791972021243399e-01 -6.162918217034816e+00 -5.962885522731370e+00 2.766767423033085e+00 4.915386108682876e+00 9.103470344354115e+03 + 136220 9.200713799160744e-01 -6.078810247777878e+00 -5.968796318786429e+00 3.201682176183832e+00 4.833399181053224e+00 9.121500342979256e+03 + 136240 9.632787726130622e-01 -6.138244426437604e+00 -5.957259900353699e+00 2.982972545102170e+00 5.022213701140849e+00 9.086330467775440e+03 + 136260 9.743121592146419e-01 -6.136486500872513e+00 -5.989046440064151e+00 2.942151658828287e+00 4.788775304265570e+00 9.183473749902290e+03 + 136280 9.772346707865833e-01 -6.104651322978453e+00 -5.961400758386205e+00 3.120986120084920e+00 4.943553029926841e+00 9.098933225694200e+03 + 136300 9.456871402539769e-01 -6.002527207992213e+00 -5.941724615545806e+00 3.703931969166291e+00 5.053069864164335e+00 9.039009001227012e+03 + 136320 9.631114554221329e-01 -5.964401463733210e+00 -5.947139716691353e+00 3.889763731235079e+00 4.988883353996138e+00 9.055478716987793e+03 + 136340 9.494281114387692e-01 -5.890296848271961e+00 -5.981022792656803e+00 4.317219266902637e+00 4.796256854450360e+00 9.158863682057834e+03 + 136360 1.025171969900139e+00 -5.965587678324015e+00 -5.998068741368490e+00 3.864698681199001e+00 4.678187390769363e+00 9.211124308572527e+03 + 136380 1.039687806370140e+00 -5.963412417080840e+00 -6.039949303090938e+00 3.898618362200356e+00 4.459131718685539e+00 9.340097885093426e+03 + 136400 1.021534443805195e+00 -5.922638002597600e+00 -6.026203438834006e+00 4.123849461906191e+00 4.529160700337282e+00 9.297659894337326e+03 + 136420 9.966405985792444e-01 -5.876540300281909e+00 -6.065270727170967e+00 4.369426968996668e+00 4.285707651860524e+00 9.418504701582702e+03 + 136440 1.024858116833225e+00 -5.916596684763168e+00 -6.032716038729217e+00 4.172438445358093e+00 4.505663145473088e+00 9.317753501669669e+03 + 136460 1.104220351269706e+00 -6.040580163139600e+00 -5.987727025504983e+00 3.455899223447061e+00 4.759390118741646e+00 9.179447815500971e+03 + 136480 1.078806205450137e+00 -6.013409171425020e+00 -5.982141067338023e+00 3.646107604866684e+00 4.825653897257695e+00 9.162292272530303e+03 + 136500 1.019440311000324e+00 -5.941601979632280e+00 -6.017162800310581e+00 4.008342985307594e+00 4.574461059973578e+00 9.269807521264231e+03 + 136520 1.017556397456032e+00 -5.959716913590314e+00 -5.944739843724784e+00 3.996701248088452e+00 5.082701900950399e+00 9.048174016933684e+03 + 136540 9.967468604856634e-01 -5.950123328306790e+00 -5.943064230426839e+00 3.971617897221062e+00 5.012152329639610e+00 9.043051140664264e+03 + 136560 1.022074785604144e+00 -6.008394473236206e+00 -5.950954024335338e+00 3.634637023876509e+00 4.964468970346031e+00 9.067105181661862e+03 + 136580 1.031871782525669e+00 -6.045796563989980e+00 -5.993689984651320e+00 3.513679544749860e+00 4.812883586779535e+00 9.197669783738178e+03 + 136600 1.010782552117179e+00 -6.037584750662904e+00 -6.001081811778616e+00 3.584130203217148e+00 4.793735727102266e+00 9.220366584570658e+03 + 136620 1.023526691377179e+00 -6.078551619028613e+00 -5.966475159690832e+00 3.301074312050217e+00 4.944634685343788e+00 9.114434928535151e+03 + 136640 9.804759043246185e-01 -6.034774518424010e+00 -6.006785677868463e+00 3.536257538738072e+00 4.696973792467098e+00 9.237908316113222e+03 + 136660 9.656780558263287e-01 -6.034386018140115e+00 -6.019980730474765e+00 3.555524407802929e+00 4.638241798788428e+00 9.278482247052432e+03 + 136680 8.995686325015138e-01 -5.954335537446400e+00 -6.002346583972857e+00 3.968496679637064e+00 4.692809820796708e+00 9.224239160377849e+03 + 136700 9.487318370343446e-01 -6.038905503902854e+00 -5.961506516412198e+00 3.564106526629049e+00 5.008543490255003e+00 9.099242111902953e+03 + 136720 9.594075628803598e-01 -6.060085070502563e+00 -5.991461252048939e+00 3.361613631329182e+00 4.755662216391471e+00 9.190848025412299e+03 + 136740 9.480186597101476e-01 -6.043617454323411e+00 -5.980052834778506e+00 3.494520793464525e+00 4.859518675484452e+00 9.155906716183315e+03 + 136760 9.829127929005205e-01 -6.090805137297817e+00 -5.995254363269053e+00 3.211381114380755e+00 4.760048445288410e+00 9.202478329634318e+03 + 136780 9.744118672214118e-01 -6.068578207436629e+00 -5.967995278713599e+00 3.310638060272464e+00 4.888200802158019e+00 9.119063985702685e+03 + 136800 9.102091559313986e-01 -5.954516976103472e+00 -5.988105699718813e+00 3.946581503209697e+00 4.753709854372230e+00 9.180558842180810e+03 + 136820 9.613855083737486e-01 -5.995098923215774e+00 -6.048125814200313e+00 3.682148463335854e+00 4.377659849417772e+00 9.365354910513019e+03 + 136840 1.002793060607315e+00 -6.006083685879660e+00 -6.050528419454475e+00 3.610693845456199e+00 4.355485307469321e+00 9.372809310830013e+03 + 136860 1.050149271004926e+00 -6.021197756338491e+00 -6.009789161078379e+00 3.613404944066690e+00 4.678914863524665e+00 9.247112598838261e+03 + 136880 1.000143671864594e+00 -5.900627031167239e+00 -6.004907924518540e+00 4.230053385463376e+00 4.631256358424110e+00 9.232117213628118e+03 + 136900 1.072524514663445e+00 -5.973856783421995e+00 -6.017467082991518e+00 3.816292669421231e+00 4.565875580620985e+00 9.270734871770921e+03 + 136920 9.982038497653651e-01 -5.842135949013566e+00 -6.020019768194419e+00 4.537089524222160e+00 4.515653107053651e+00 9.278625258448612e+03 + 136940 1.057353088718384e+00 -5.919800417112991e+00 -6.023598220850578e+00 4.127718831327956e+00 4.531695779608516e+00 9.289642880848245e+03 + 136960 1.078141716191301e+00 -5.948976458350585e+00 -6.030538709391260e+00 3.885721000578256e+00 4.417377933385144e+00 9.311052840290515e+03 + 136980 1.023901902430471e+00 -5.875872616531152e+00 -6.034659270288973e+00 4.333088174618467e+00 4.421310636585799e+00 9.323741953429444e+03 + 137000 1.012464989779936e+00 -5.870186886037450e+00 -6.038856282108121e+00 4.373743489224471e+00 4.405217715481995e+00 9.336718840399153e+03 + 137020 1.063233037058750e+00 -5.963575421541605e+00 -5.998769684666682e+00 3.876112203737310e+00 4.674021298578500e+00 9.213269520683902e+03 + 137040 1.018139297257336e+00 -5.918345418320995e+00 -6.009782499102691e+00 4.106289700378225e+00 4.581243832687207e+00 9.247092025872435e+03 + 137060 1.009901425670117e+00 -5.930186805122561e+00 -6.011510660237845e+00 4.067393113736728e+00 4.600418952838862e+00 9.252386221644068e+03 + 137080 9.945417868107201e-01 -5.932127500347875e+00 -6.002307777187433e+00 4.045896139301417e+00 4.642910129325934e+00 9.224129479369358e+03 + 137100 1.001641387357770e+00 -5.967131899508441e+00 -5.994247674311263e+00 3.888489330857972e+00 4.732786355787576e+00 9.199382241523155e+03 + 137120 1.016921907045996e+00 -6.012316404410054e+00 -6.000320560687909e+00 3.604368994133819e+00 4.673250985137194e+00 9.218024824928276e+03 + 137140 1.036813967019353e+00 -6.060963240735469e+00 -5.972160042037775e+00 3.360982757946812e+00 4.870904467119556e+00 9.131798220544419e+03 + 137160 1.015402059963044e+00 -6.046368935208895e+00 -5.973658644859833e+00 3.464226658547091e+00 4.881740397612479e+00 9.136351979056830e+03 + 137180 9.416316643378648e-01 -5.950409761369603e+00 -5.992932050776025e+00 3.928067441202085e+00 4.683897875127387e+00 9.195353826195955e+03 + 137200 9.239137920658220e-01 -5.932842643915375e+00 -5.973105977207839e+00 4.080598036930838e+00 4.849399746434821e+00 9.134657723104914e+03 + 137220 9.901819193354732e-01 -6.033870990867659e+00 -5.997671510436552e+00 3.514219722412338e+00 4.722082740899252e+00 9.209894129616423e+03 + 137240 9.072669168653890e-01 -5.911022975695995e+00 -6.034259712236657e+00 4.143254942633204e+00 4.435610530593380e+00 9.322520853569693e+03 + 137260 9.843444578718793e-01 -6.023421346863490e+00 -6.013568796219347e+00 3.557511620961704e+00 4.614086491437660e+00 9.258760790326067e+03 + 137280 1.011833394538406e+00 -6.061760001221346e+00 -6.000108153926498e+00 3.368836805173542e+00 4.722851252933095e+00 9.217394111215721e+03 + 137300 9.346715402732279e-01 -5.943912467580183e+00 -6.013163898901597e+00 4.000094557169736e+00 4.602442121897814e+00 9.257484174379770e+03 + 137320 1.021444253557838e+00 -6.068201739233340e+00 -6.002866494844940e+00 3.343143223308961e+00 4.718308307183547e+00 9.225832504952754e+03 + 137340 1.022330791956295e+00 -6.064942748172038e+00 -5.987505372293434e+00 3.371672576355269e+00 4.816329972045406e+00 9.178754262880318e+03 + 137360 9.927736277090350e-01 -6.016535275306505e+00 -5.987334925322633e+00 3.625104574566155e+00 4.792777502913104e+00 9.178202346747526e+03 + 137380 9.829766713082625e-01 -5.997009231707835e+00 -6.007858150866774e+00 3.747344787479722e+00 4.685048614804284e+00 9.241183182391707e+03 + 137400 9.664729873516762e-01 -5.967461873395636e+00 -6.036847621264778e+00 3.852535819800640e+00 4.454112118126246e+00 9.330500687642450e+03 + 137420 1.015431317475433e+00 -6.034928475547911e+00 -5.996915946234536e+00 3.561842632854277e+00 4.780116458591577e+00 9.207595413670348e+03 + 137440 1.040029224792005e+00 -6.068493496020699e+00 -6.006042588706274e+00 3.360664796484613e+00 4.719267570530718e+00 9.235612568980470e+03 + 137460 1.056352028402261e+00 -6.092259731492568e+00 -5.948620214227113e+00 3.232373159408168e+00 5.057173495689868e+00 9.060000627055006e+03 + 137480 9.718833846259068e-01 -5.965922747828423e+00 -5.964694440702376e+00 3.881704092956981e+00 4.888757222554658e+00 9.108971206878403e+03 + 137500 9.732864154060633e-01 -5.964184880186464e+00 -5.997087520200697e+00 3.850602532663809e+00 4.661670482034991e+00 9.208102205090587e+03 + 137520 1.005050407038914e+00 -6.007724730201320e+00 -5.979868098057105e+00 3.642194969207489e+00 4.802152061779465e+00 9.155341309937538e+03 + 137540 9.729329612104511e-01 -5.956340974721136e+00 -5.976255613641362e+00 3.914742968961170e+00 4.800390030500819e+00 9.144303511307975e+03 + 137560 9.088841126187257e-01 -5.858725555057402e+00 -5.986882543872690e+00 4.441194107280273e+00 4.705296845272964e+00 9.176788698748816e+03 + 137580 1.005288915296697e+00 -5.994176605217332e+00 -5.992919689690481e+00 3.747138376270349e+00 4.754355779732573e+00 9.195304219752141e+03 + 137600 1.037718533838830e+00 -6.035833942007568e+00 -5.994528340810444e+00 3.506340168345965e+00 4.743523322440982e+00 9.200245436122106e+03 + 137620 9.005030220426302e-01 -5.828392665303555e+00 -6.007021775572426e+00 4.628910033170536e+00 4.603194039241203e+00 9.238603118565177e+03 + 137640 1.128921927234210e+00 -6.162945823685927e+00 -5.948321719358416e+00 2.803548010082690e+00 5.035952830104060e+00 9.059082386659058e+03 + 137660 1.024274626564225e+00 -6.004043870053597e+00 -6.025156706217859e+00 3.648600670787803e+00 4.527367498331774e+00 9.294440781171341e+03 + 137680 9.604806318576965e-01 -5.910046351082734e+00 -6.052151448175001e+00 4.192338543529126e+00 4.376349085332621e+00 9.377824253162884e+03 + 137700 9.743683639582091e-01 -5.931607784303832e+00 -6.012664863558120e+00 4.092939031651140e+00 4.627496739030544e+00 9.255961720701143e+03 + 137720 1.053120377330919e+00 -6.049710251510602e+00 -5.998831698885812e+00 3.409940384551474e+00 4.702092907153590e+00 9.213454860283660e+03 + 137740 1.064817583341400e+00 -6.072068511807633e+00 -5.952525961045242e+00 3.376638331797884e+00 5.063070157425475e+00 9.071901287894614e+03 + 137760 9.998552542153553e-01 -5.984975966133562e+00 -6.004075880521907e+00 3.770697303669575e+00 4.661022639549497e+00 9.229568104810882e+03 + 137780 9.802487484360189e-01 -5.968702545624265e+00 -5.991102256901586e+00 3.913521571851728e+00 4.784898963353236e+00 9.189746295177629e+03 + 137800 1.036311151176444e+00 -6.070645399734217e+00 -5.997717372294908e+00 3.320027410917262e+00 4.738791430049544e+00 9.210047184407716e+03 + 137820 9.641708182851719e-01 -5.990103128503461e+00 -5.979598095668065e+00 3.812652825214563e+00 4.872974349403988e+00 9.154505319531165e+03 + 137840 9.310043674974007e-01 -5.972431932526561e+00 -6.054066581620352e+00 3.782940321213935e+00 4.314181533196265e+00 9.383752777786643e+03 + 137860 9.193048711964390e-01 -5.990771075850223e+00 -6.010298838015057e+00 3.748927894733416e+00 4.636796462471507e+00 9.248679575574708e+03 + 137880 8.832901870793762e-01 -5.969122970284520e+00 -5.950049148035757e+00 3.943404052981692e+00 5.052928891998545e+00 9.064297629114137e+03 + 137900 9.081768740775518e-01 -6.026723238091853e+00 -5.947608560300200e+00 3.559607673610210e+00 5.013896396446704e+00 9.056912781994908e+03 + 137920 9.530276042743180e-01 -6.105634275268501e+00 -5.955022901651839e+00 3.172658571882572e+00 5.037492386224184e+00 9.079494514646725e+03 + 137940 9.475362142088493e-01 -6.103746634435463e+00 -5.973909413035321e+00 3.123916549714733e+00 4.869461967239423e+00 9.137138021475577e+03 + 137960 9.612121926278543e-01 -6.122904521071193e+00 -5.978297801355075e+00 3.054229962843313e+00 4.884584125270820e+00 9.150561676202604e+03 + 137980 9.776101300215735e-01 -6.138650166094560e+00 -5.972080286408425e+00 2.954122459710894e+00 4.910592485474254e+00 9.131544548664338e+03 + 138000 9.311050732304994e-01 -6.052429536699198e+00 -6.025522972335062e+00 3.381475130807234e+00 4.535976787163484e+00 9.295568786884993e+03 + 138020 9.458412505721069e-01 -6.049141014638208e+00 -6.013962463343455e+00 3.470918558191820e+00 4.672919243589505e+00 9.259971385580349e+03 + 138040 9.839732395685518e-01 -6.072233300890555e+00 -6.008709779018644e+00 3.297854689544401e+00 4.662616582366153e+00 9.243818672499519e+03 + 138060 9.401260747078265e-01 -5.969225116179367e+00 -6.067026326390403e+00 3.850283381075027e+00 4.288693697354896e+00 9.423940899709633e+03 + 138080 1.012675653633621e+00 -6.037711801045720e+00 -5.995891879656672e+00 3.489688190526982e+00 4.729824650754816e+00 9.204450652575866e+03 + 138100 1.009723915116968e+00 -5.999912724609985e+00 -5.982855058450173e+00 3.713432365456412e+00 4.811380124211358e+00 9.164484156162120e+03 + 138120 1.001652559290768e+00 -5.961310910378699e+00 -6.010712933410170e+00 3.917882616122391e+00 4.634208554937322e+00 9.249953645892225e+03 + 138140 1.021453429615588e+00 -5.969887375883316e+00 -6.035113952625506e+00 3.855254580299941e+00 4.480713482866151e+00 9.325156074075612e+03 + 138160 9.978008333155075e-01 -5.921883753861304e+00 -6.033260410758280e+00 4.096135807912260e+00 4.456593808527874e+00 9.319430331119065e+03 + 138180 1.084012724153102e+00 -6.043768413143900e+00 -6.008200803346152e+00 3.498911002706261e+00 4.703145722234762e+00 9.242242436248598e+03 + 138200 9.763137644583971e-01 -5.883488414021358e+00 -6.046098285085146e+00 4.363670835795411e+00 4.429939792350919e+00 9.359110563267754e+03 + 138220 1.057944847918731e+00 -6.008719380621995e+00 -6.013113521562035e+00 3.623293724491831e+00 4.598061887223007e+00 9.257354997530818e+03 + 138240 1.070484441034636e+00 -6.034112232996077e+00 -5.971442511316504e+00 3.550435832764941e+00 4.910295072757132e+00 9.129600498942722e+03 + 138260 1.003367435529426e+00 -5.942585584388345e+00 -6.013374205297838e+00 3.984471266572675e+00 4.577992050806683e+00 9.258152993514532e+03 + 138280 1.013681612976540e+00 -5.968344154450977e+00 -6.022030659160606e+00 3.866380066746948e+00 4.558103848744500e+00 9.284806954441658e+03 + 138300 1.011111520848505e+00 -5.978014566632917e+00 -6.026755876365678e+00 3.786799168692537e+00 4.506919025513720e+00 9.299366080758293e+03 + 138320 1.010358865564650e+00 -5.992656637004787e+00 -5.995333969130792e+00 3.731587179469600e+00 4.716213524086269e+00 9.202699603147863e+03 + 138340 9.787234622026656e-01 -5.959244918562565e+00 -5.967448525198367e+00 3.941009208730470e+00 4.893902829923670e+00 9.117388156340994e+03 + 138360 9.898723746300674e-01 -5.988526765234776e+00 -6.031168256870761e+00 3.686386852856220e+00 4.441532809132891e+00 9.313002354188873e+03 + 138380 9.913384223114879e-01 -6.006646645816000e+00 -5.994408548928288e+00 3.621434520074277e+00 4.691707566242890e+00 9.199890473465146e+03 + 138400 1.001400783618390e+00 -6.037301885215082e+00 -5.977325973125797e+00 3.457739298910469e+00 4.802130267369543e+00 9.147534300780628e+03 + 138420 9.271068839744653e-01 -5.939446671071265e+00 -5.975204807239305e+00 4.023634855477032e+00 4.818306104046459e+00 9.141054227871369e+03 + 138440 1.024359487447462e+00 -6.094159037710236e+00 -5.997006602104019e+00 3.182364806644818e+00 4.740229126186536e+00 9.207858474628529e+03 + 138460 9.570423884503114e-01 -6.006970476392199e+00 -6.024913795483031e+00 3.601785975923878e+00 4.498752660984668e+00 9.293694257064564e+03 + 138480 9.477992067006203e-01 -6.009919301686984e+00 -5.998396205252693e+00 3.656627862186565e+00 4.722795265105677e+00 9.212125676769278e+03 + 138500 9.847944978787669e-01 -6.084457530274685e+00 -5.972066331959811e+00 3.261497699397572e+00 4.906865352603311e+00 9.131496043330131e+03 + 138520 9.706689309525659e-01 -6.089414159612098e+00 -5.997079702304273e+00 3.172973291747465e+00 4.703172034320086e+00 9.208109871698032e+03 + 138540 8.938144564929298e-01 -6.005612339595828e+00 -6.011202737475839e+00 3.664377379878792e+00 4.632276450140488e+00 9.251462144846168e+03 + 138560 9.119655749123964e-01 -6.064119683939368e+00 -6.003506476429036e+00 3.340054700219241e+00 4.688105117607115e+00 9.227807308772251e+03 + 138580 8.937422036937729e-01 -6.062987145285517e+00 -5.943941323257175e+00 3.376663567818189e+00 5.060243100186351e+00 9.045763265215894e+03 + 138600 8.313419859652454e-01 -5.987656279770697e+00 -5.953720289148482e+00 3.799763859140054e+00 4.994629568870387e+00 9.075488171624080e+03 + 138620 9.029140772367072e-01 -6.098272604662832e+00 -5.936631395453849e+00 3.211791485439436e+00 5.139960322613700e+00 9.023521357787975e+03 + 138640 9.730555829965329e-01 -6.194811958089947e+00 -5.940155122101740e+00 2.671943879747125e+00 5.134222840009414e+00 9.034265793398821e+03 + 138660 8.746798797859010e-01 -6.031661142059957e+00 -5.979773431522378e+00 3.515035657215149e+00 4.812982920719188e+00 9.155082731482853e+03 + 138680 9.796938129378228e-01 -6.161162249209812e+00 -5.940604163377152e+00 2.853953781698894e+00 5.120432441803500e+00 9.035620267273667e+03 + 138700 9.045036566280092e-01 -6.013263132043956e+00 -6.017470897686593e+00 3.558275164828187e+00 4.534113523358537e+00 9.270744269792729e+03 + 138720 1.006830518744168e+00 -6.121876672244494e+00 -5.972784108165799e+00 3.063673703331085e+00 4.919786278270679e+00 9.133698113601124e+03 + 138740 9.790964646284650e-01 -6.039315208767661e+00 -6.011564202844463e+00 3.490754559639826e+00 4.650105130105119e+00 9.252584203801976e+03 + 138760 8.906121762309963e-01 -5.874770544707589e+00 -6.019695018487620e+00 4.386423057323400e+00 4.554244301888629e+00 9.277569626473067e+03 + 138780 9.614649442157768e-01 -5.952858059194433e+00 -5.979390957273729e+00 3.941394314206933e+00 4.789038307482912e+00 9.153872958751237e+03 + 138800 9.980756984231722e-01 -5.984796938510010e+00 -5.988536752814010e+00 3.758549820069069e+00 4.737075227601110e+00 9.181894098136705e+03 + 138820 1.027205926728344e+00 -6.010223842825346e+00 -6.011589903290423e+00 3.641459349710522e+00 4.633615219122875e+00 9.252649237311534e+03 + 138840 1.042484912732457e+00 -6.020561223567104e+00 -5.999928791509024e+00 3.581207917847162e+00 4.699682535583198e+00 9.216817898297608e+03 + 138860 1.016864113563817e+00 -5.974845092630594e+00 -5.983979586573733e+00 3.764725872209722e+00 4.712274194429849e+00 9.167943752748713e+03 + 138880 1.010135971637415e+00 -5.959868827931151e+00 -5.994756100853274e+00 3.920790849782156e+00 4.720462729875290e+00 9.200933952388423e+03 + 138900 1.046664558950832e+00 -6.009333570595302e+00 -5.993723074146880e+00 3.634660251886134e+00 4.724298138209494e+00 9.197781767003269e+03 + 138920 1.010993530080897e+00 -5.954210104764313e+00 -5.966946009634162e+00 3.928174925303499e+00 4.855043388665912e+00 9.115833593962880e+03 + 138940 9.924294145143523e-01 -5.924753252347107e+00 -6.009918080958659e+00 4.126874071128037e+00 4.637844446025869e+00 9.247486684687939e+03 + 138960 1.054138938999807e+00 -6.014249152744109e+00 -5.988070277360423e+00 3.622333318559379e+00 4.772656472180376e+00 9.180457210945651e+03 + 138980 1.091916021523929e+00 -6.074589206648665e+00 -5.961398194291441e+00 3.260680337913804e+00 4.910640647121539e+00 9.098944956723913e+03 + 139000 9.784731303560069e-01 -5.914442185343897e+00 -5.972922490871821e+00 4.152886318348943e+00 4.817083354209569e+00 9.134106246987569e+03 + 139020 9.877251518939310e-01 -5.938213579487480e+00 -5.972416239482725e+00 4.000482681700767e+00 4.804085715163541e+00 9.132549204234649e+03 + 139040 1.022014123677860e+00 -5.999948599535696e+00 -5.959530374757204e+00 3.732623744062813e+00 4.964711445440985e+00 9.093231784024492e+03 + 139060 1.000159910573599e+00 -5.983600987090513e+00 -5.992974599411858e+00 3.769956745570819e+00 4.716132013059839e+00 9.195479892922767e+03 + 139080 9.718675324572668e-01 -5.963132596865949e+00 -5.992689981694489e+00 3.869925465537261e+00 4.700202387861263e+00 9.194611207981799e+03 + 139100 1.019755124935249e+00 -6.060015870725190e+00 -5.977046769048123e+00 3.322927223159451e+00 4.799348644416161e+00 9.146731589559658e+03 + 139120 9.975895886273581e-01 -6.057867091841376e+00 -5.972819376990802e+00 3.411723799607203e+00 4.900080939370534e+00 9.133774644911986e+03 + 139140 9.328465403205430e-01 -5.993961533544408e+00 -5.976571004889374e+00 3.725073636619342e+00 4.824932743332162e+00 9.145276035299072e+03 + 139160 9.479897595675055e-01 -6.047344966767739e+00 -6.017129249202492e+00 3.389763177648953e+00 4.563266503775776e+00 9.269718227110969e+03 + 139180 1.011959880373875e+00 -6.169819555886181e+00 -6.000175261480236e+00 2.783675629356377e+00 4.757799420205028e+00 9.217604753683912e+03 + 139200 9.154892308229345e-01 -6.051123462354822e+00 -5.988442786417762e+00 3.428768653972667e+00 4.788690795006516e+00 9.181619986936554e+03 + 139220 8.922454826453519e-01 -6.031170711024370e+00 -6.001831110391138e+00 3.522219522644110e+00 4.690692049768650e+00 9.222678329229055e+03 + 139240 8.761362034777506e-01 -6.012964409818143e+00 -6.057610958259385e+00 3.629318271694795e+00 4.372950881514144e+00 9.394753229811638e+03 + 139260 9.594046775456335e-01 -6.137721500636301e+00 -5.988636955762511e+00 2.947788135238627e+00 4.803854662662687e+00 9.182206038913773e+03 + 139280 9.512584835125947e-01 -6.117988402011913e+00 -5.976983797866439e+00 3.101210667359676e+00 4.910880924754958e+00 9.146532761520442e+03 + 139300 8.990495077398326e-01 -6.022390777149372e+00 -6.008914647597315e+00 3.574351727661690e+00 4.651733748973908e+00 9.244459523094181e+03 + 139320 1.001069693714184e+00 -6.146611205067710e+00 -5.957999026501625e+00 2.953656473913619e+00 5.036696790880383e+00 9.088559262280169e+03 + 139340 9.223555717611884e-01 -5.987872893432346e+00 -5.978999947615875e+00 3.746316338116642e+00 4.797266166078749e+00 9.152683710566191e+03 + 139360 9.443143130353924e-01 -5.970937566588930e+00 -5.932034676334697e+00 3.892854247663522e+00 5.116240663706135e+00 9.009569879566690e+03 + 139380 1.008871858860810e+00 -6.013370731109384e+00 -5.983046980701359e+00 3.636001715780814e+00 4.810125383208904e+00 9.165046057288451e+03 + 139400 1.041565271945755e+00 -6.022235653032827e+00 -5.981015604693980e+00 3.566330359703636e+00 4.803022256047164e+00 9.158866378015169e+03 + 139420 1.027836273921348e+00 -5.978122205441046e+00 -5.998472019214912e+00 3.797965562478400e+00 4.681113782665360e+00 9.212353343914412e+03 + 139440 1.009466535640037e+00 -5.939831146571914e+00 -5.997292424834126e+00 4.033332030045790e+00 4.703380478160099e+00 9.208709353659535e+03 + 139460 1.041206282675019e+00 -5.981756719168831e+00 -5.951782619529029e+00 3.826414964552618e+00 4.998530883161290e+00 9.069620015771638e+03 + 139480 1.007287025848718e+00 -5.928424013532305e+00 -5.989067162805219e+00 4.108610171889035e+00 4.760387824266940e+00 9.183520895470047e+03 + 139500 1.008982270719107e+00 -5.930587308172487e+00 -6.023111579792949e+00 4.075124124379039e+00 4.543835438649588e+00 9.288120030085545e+03 + 139520 1.031816982894506e+00 -5.968671314911522e+00 -6.024701023844102e+00 3.848204136739869e+00 4.526472877479562e+00 9.293002679199097e+03 + 139540 9.816026197301152e-01 -5.900843334584536e+00 -6.012302312500795e+00 4.176162858369779e+00 4.536148158953533e+00 9.254810638877512e+03 + 139560 1.048676741247871e+00 -6.008026713053574e+00 -5.993070832944642e+00 3.632758557624120e+00 4.718637535624570e+00 9.195775267534515e+03 + 139580 9.540366376147698e-01 -5.879824188056143e+00 -6.001984753459471e+00 4.326754787408502e+00 4.625289916576196e+00 9.223119296224577e+03 + 139600 1.021101261734541e+00 -5.992667410212600e+00 -5.987560975834699e+00 3.712305633727105e+00 4.741627570143175e+00 9.178889341040549e+03 + 139620 1.052432659058221e+00 -6.055037096053687e+00 -5.981180530722419e+00 3.425616248053733e+00 4.849712075452422e+00 9.159357667261595e+03 + 139640 9.177540726698735e-01 -5.874716062550161e+00 -5.995246444173249e+00 4.421752296396759e+00 4.729648193100710e+00 9.202432119519841e+03 + 139660 9.674341688513884e-01 -5.966576439080006e+00 -5.967237545243836e+00 3.914160822781624e+00 4.910364648883067e+00 9.116729422325068e+03 + 139680 9.996974498008849e-01 -6.030181140432274e+00 -5.955385577729390e+00 3.550095392135828e+00 4.979583087751705e+00 9.080572489813530e+03 + 139700 9.778611582283996e-01 -6.011700437458074e+00 -5.980357068776532e+00 3.624717050856529e+00 4.804695524196572e+00 9.156843599254829e+03 + 139720 1.002968606691855e+00 -6.065780958974684e+00 -6.015774281764803e+00 3.398710455775635e+00 4.685856534823062e+00 9.265502554859284e+03 + 139740 9.475353577337424e-01 -6.000399377827796e+00 -6.010992099680951e+00 3.694355543584535e+00 4.633530495485306e+00 9.250814456954708e+03 + 139760 9.837034200351007e-01 -6.069921041974932e+00 -5.969699151886783e+00 3.388004031820512e+00 4.963493633994035e+00 9.124266621802150e+03 + 139780 9.397638419537712e-01 -6.019850032637533e+00 -6.011249418515288e+00 3.603289536974414e+00 4.652675594205081e+00 9.251601560560146e+03 + 139800 9.274986035560753e-01 -6.016718879275818e+00 -5.947497587597029e+00 3.683777025818660e+00 5.081256394598535e+00 9.056567374901910e+03 + 139820 9.942138806225652e-01 -6.125556420011560e+00 -5.936118982336342e+00 3.034252557610459e+00 5.122031640090299e+00 9.021986265636609e+03 + 139840 9.154067809120243e-01 -6.013345097197727e+00 -5.975374112415577e+00 3.639276348400105e+00 4.857311619010117e+00 9.141610350291263e+03 + 139860 9.999805687638214e-01 -6.136773617034367e+00 -5.961041968042384e+00 2.980832779579394e+00 4.989911102476155e+00 9.097848958390865e+03 + 139880 1.000504414837675e+00 -6.130935729492550e+00 -5.964480283818151e+00 3.007665998046823e+00 4.963478926006188e+00 9.108355186333056e+03 + 139900 9.493958496280287e-01 -6.042435087515318e+00 -5.970253135352642e+00 3.495162447633007e+00 4.909642387072088e+00 9.125950512318645e+03 + 139920 9.335646826355021e-01 -5.995164987091253e+00 -5.973433861323950e+00 3.706809623257722e+00 4.831593110294422e+00 9.135660059288541e+03 + 139940 9.190353143275196e-01 -5.937343831768461e+00 -5.992490034522826e+00 4.029856009682089e+00 4.713197979619236e+00 9.193993017132780e+03 + 139960 1.082281947355622e+00 -6.134826964421048e+00 -5.933610321381832e+00 3.022688759555270e+00 5.178105862061328e+00 9.014360291081459e+03 + 139980 9.607710634993710e-01 -5.910898796417311e+00 -5.987669740174283e+00 4.267497327304602e+00 4.826666687986915e+00 9.179178896137977e+03 + 140000 1.039271965810176e+00 -5.990710146032883e+00 -5.996522244560563e+00 3.763777603042372e+00 4.730403633877088e+00 9.206359845461311e+03 + 140020 1.050559443552058e+00 -5.977212919504155e+00 -6.040764329919098e+00 3.790417362747454e+00 4.425495329595874e+00 9.342611193030794e+03 + 140040 1.088665831452289e+00 -6.014886321571232e+00 -6.011952008518938e+00 3.640558896634439e+00 4.657408176264182e+00 9.253787904044530e+03 + 140060 1.016833262413255e+00 -5.900447118288691e+00 -5.999870601960446e+00 4.303629088926229e+00 4.732724059948636e+00 9.216639227786196e+03 + 140080 1.042974697905954e+00 -5.936622368270984e+00 -6.030484976617540e+00 4.070735021349927e+00 4.531761399032308e+00 9.310860346156245e+03 + 140100 1.050948497478095e+00 -5.951160413499231e+00 -6.025755202745302e+00 3.969569609527926e+00 4.541234786170661e+00 9.296283753095908e+03 + 140120 1.103570541716088e+00 -6.038646247068137e+00 -5.989689614034788e+00 3.506304328699291e+00 4.787420891591265e+00 9.185447317129157e+03 + 140140 1.036414773888680e+00 -5.951695983547252e+00 -6.035146456058167e+00 3.950805779606819e+00 4.471620252530254e+00 9.325270139484175e+03 + 140160 1.065552503557105e+00 -6.017221693290765e+00 -6.004486137491869e+00 3.621384923377552e+00 4.694514455595706e+00 9.230841398119057e+03 + 140180 9.687431013003498e-01 -5.902566215031082e+00 -6.043851134160708e+00 4.272038335444653e+00 4.460758466031765e+00 9.352117257182197e+03 + 140200 9.835881766359523e-01 -5.953926016081099e+00 -5.990469940593682e+00 3.930318063609425e+00 4.720477193904134e+00 9.187797485481271e+03 + 140220 9.603287170207961e-01 -5.946275185406952e+00 -6.008753273525434e+00 3.916866430187317e+00 4.558107579758105e+00 9.243928213124656e+03 + 140240 1.003279568124133e+00 -6.034308122364427e+00 -5.964936208195249e+00 3.510232558347034e+00 4.908576824775479e+00 9.109720194156564e+03 + 140260 9.654094690770644e-01 -5.997810758409150e+00 -6.004888233020129e+00 3.731925060856548e+00 4.691285106404652e+00 9.232059913991478e+03 + 140280 9.945089940865300e-01 -6.057118329348220e+00 -6.000379423198772e+00 3.367487847439791e+00 4.693291426867273e+00 9.218212511212603e+03 + 140300 9.251676508640740e-01 -5.965904902066947e+00 -6.022868002305589e+00 3.835610842946036e+00 4.508519906364480e+00 9.287401483356078e+03 + 140320 9.751119130746871e-01 -6.050655435415186e+00 -5.988249141639406e+00 3.399652354974614e+00 4.757998951177893e+00 9.180993673788742e+03 + 140340 9.986779791683572e-01 -6.091131293055185e+00 -5.936310432326446e+00 3.219694444772151e+00 5.108699785527341e+00 9.022579318837066e+03 + 140360 9.248158492794594e-01 -5.980708733131189e+00 -6.014214151950415e+00 3.825642983887902e+00 4.633249684081097e+00 9.260726872562387e+03 + 140380 1.023852726813619e+00 -6.122196323624539e+00 -6.019284575389955e+00 2.971623172948092e+00 4.562558356852646e+00 9.276363442569453e+03 + 140400 9.603081427770820e-01 -6.022374272200974e+00 -6.033550464560696e+00 3.569588617318943e+00 4.505413191279241e+00 9.320345597233534e+03 + 140420 9.480806730104098e-01 -5.996902238293199e+00 -5.979127329620321e+00 3.750669414885718e+00 4.852735691143608e+00 9.153089297135541e+03 + 140440 9.750510415190047e-01 -6.025343950116312e+00 -5.946650333616828e+00 3.590734068160008e+00 5.042604991897842e+00 9.053988195520804e+03 + 140460 9.438519032522503e-01 -5.957673317462424e+00 -5.967326379361531e+00 3.919875540138139e+00 4.864446164906967e+00 9.117007614822234e+03 + 140480 1.039784637261428e+00 -6.061322307816333e+00 -5.983191125700571e+00 3.387552695303959e+00 4.836194033774019e+00 9.165518718433950e+03 + 140500 1.048946611528068e+00 -6.009537320196844e+00 -5.984471385867566e+00 3.680132734536541e+00 4.824065208396055e+00 9.169443472033599e+03 + 140520 1.047635065637033e+00 -5.931385968990310e+00 -6.019541016808548e+00 4.033297373389896e+00 4.527097446868012e+00 9.277138402448652e+03 + 140540 1.020421937679271e+00 -5.830507622662965e+00 -6.021171748973224e+00 4.666819675216939e+00 4.571996756765239e+00 9.282120037589350e+03 + 140560 1.036145561350414e+00 -5.820174278765174e+00 -6.030994495583753e+00 4.694113185317637e+00 4.483550876022242e+00 9.312403948056164e+03 + 140580 1.075222011742712e+00 -5.863212395232648e+00 -6.048042740088586e+00 4.421119613070854e+00 4.359795170504634e+00 9.365119382631123e+03 + 140600 1.117282991803117e+00 -5.927082821840458e+00 -6.047661570229141e+00 4.067252996236016e+00 4.374871163487192e+00 9.363918182723160e+03 + 140620 1.088775179302568e+00 -5.899455398355466e+00 -6.024868738480991e+00 4.238433739506362e+00 4.518290932853937e+00 9.293545241013813e+03 + 140640 1.051443054233381e+00 -5.865510618605229e+00 -6.026949572688205e+00 4.418455413955881e+00 4.491447957014031e+00 9.299968417289820e+03 + 140660 9.927627461601770e-01 -5.805080722834630e+00 -6.056344060210467e+00 4.738100044713173e+00 4.295307078625318e+00 9.390831867119829e+03 + 140680 1.130830834163895e+00 -6.042527462371108e+00 -6.022082596857853e+00 3.472898471174906e+00 4.590296052784730e+00 9.284951355406463e+03 + 140700 1.045421639331238e+00 -5.952905769220010e+00 -6.038482680384203e+00 3.942574423934081e+00 4.451178557045077e+00 9.335551615186174e+03 + 140720 1.052078873074801e+00 -6.003243100488001e+00 -5.996044786792337e+00 3.663328206599048e+00 4.704662037774996e+00 9.204904624115301e+03 + 140740 1.048075509295191e+00 -6.031359900790230e+00 -5.974147891400796e+00 3.514369792499370e+00 4.842890003943341e+00 9.137860574434528e+03 + 140760 9.866897509253569e-01 -5.969592081996824e+00 -6.021258229078704e+00 3.800718276947499e+00 4.504043265092923e+00 9.282400746387151e+03 + 140780 9.842859778632015e-01 -5.989258528342103e+00 -5.981360346766499e+00 3.780808746034306e+00 4.826161326881074e+00 9.159915684125603e+03 + 140800 1.025039625987521e+00 -6.068719006269219e+00 -5.952209507431798e+00 3.342413404122515e+00 5.011428976233660e+00 9.070929044921024e+03 + 140820 9.800267404338564e-01 -6.017324942433372e+00 -5.977325459509522e+00 3.574218876220778e+00 4.803902097069500e+00 9.147572645808463e+03 + 140840 9.649826952395790e-01 -6.006996154666909e+00 -5.983724091113316e+00 3.655614214026764e+00 4.789246004291693e+00 9.167141658103334e+03 + 140860 9.586687342000558e-01 -6.005604909571713e+00 -5.995785872904458e+00 3.671700691725548e+00 4.728083119759940e+00 9.204107862761723e+03 + 140880 1.010833751928174e+00 -6.087827565430208e+00 -5.956197721032634e+00 3.269319888157667e+00 5.025158824341126e+00 9.083077539047641e+03 + 140900 9.892234714487406e-01 -6.058046448985337e+00 -5.967098168846404e+00 3.408770980865002e+00 4.931010079623622e+00 9.116307242753910e+03 + 140920 9.229159332792360e-01 -5.958224400455188e+00 -5.964593114577438e+00 3.885299025836769e+00 4.848728883791480e+00 9.108657174966978e+03 + 140940 9.573584397267666e-01 -6.001651767664145e+00 -5.965607146938478e+00 3.644294143014509e+00 4.851267933108323e+00 9.111766693966527e+03 + 140960 9.499912818698969e-01 -5.976967541193374e+00 -5.983729341684115e+00 3.864423201486798e+00 4.825595896683719e+00 9.167152992677680e+03 + 140980 9.922585286993028e-01 -6.018920827465959e+00 -5.985631540579971e+00 3.556686798719530e+00 4.747839035519375e+00 9.173008227980257e+03 + 141000 1.016913080694127e+00 -6.027524622042455e+00 -6.006347799438236e+00 3.543745743904143e+00 4.665346336400278e+00 9.236558632446387e+03 + 141020 1.013757276565669e+00 -5.991294657543470e+00 -6.014316740519579e+00 3.717202544883464e+00 4.585006181778823e+00 9.261057411848966e+03 + 141040 1.036306636860578e+00 -5.990995461232297e+00 -6.004677484120759e+00 3.745810070954739e+00 4.667245778242993e+00 9.231406779728941e+03 + 141060 9.906825620558238e-01 -5.888731793953895e+00 -6.035655961202778e+00 4.269866885806182e+00 4.426205581021697e+00 9.326812336287958e+03 + 141080 1.047029676374936e+00 -5.940746316214888e+00 -6.012024556094582e+00 4.054878905138589e+00 4.645588221477409e+00 9.253966315788433e+03 + 141100 1.056556062184258e+00 -5.926210914889553e+00 -6.042121443779635e+00 4.060554069940636e+00 4.394977875957411e+00 9.346817524220820e+03 + 141120 1.069469150772407e+00 -5.926204044216679e+00 -6.034721077503134e+00 4.116279487443436e+00 4.493157889355987e+00 9.323934844436917e+03 + 141140 1.076978439284562e+00 -5.926763677401696e+00 -6.036924690747941e+00 4.090830640684237e+00 4.458269054688375e+00 9.330746633977484e+03 + 141160 1.113610639852611e+00 -5.979865021248573e+00 -6.032270212766877e+00 3.786546290298159e+00 4.485627570922877e+00 9.316383650121212e+03 + 141180 1.052430801443373e+00 -5.899444033338169e+00 -6.037422598073735e+00 4.201724928437632e+00 4.409430657612124e+00 9.332285454490506e+03 + 141200 1.001018954341893e+00 -5.843125103742261e+00 -6.001884713109192e+00 4.527133307993854e+00 4.615511063038791e+00 9.222830438803330e+03 + 141220 1.053441738936672e+00 -5.948775767670416e+00 -6.015071550364129e+00 4.013842541996681e+00 4.633161898530165e+00 9.263350203692316e+03 + 141240 1.018067213021564e+00 -5.941343355380109e+00 -6.019307989400730e+00 4.018124200323829e+00 4.570439206789301e+00 9.276415008488106e+03 + 141260 1.027009139694642e+00 -6.017865138168945e+00 -5.995497183275175e+00 3.559955656297009e+00 4.688395914726870e+00 9.203241187698095e+03 + 141280 9.897616396595379e-01 -6.023688523504218e+00 -5.980294227882100e+00 3.564800203792193e+00 4.813976964499939e+00 9.156654980107143e+03 + 141300 9.086248656873380e-01 -5.945568484552505e+00 -5.968699793542388e+00 4.010778748767713e+00 4.877955192989306e+00 9.121214103500190e+03 + 141320 9.679540741507150e-01 -6.053025479046577e+00 -5.949100488347890e+00 3.435367851875107e+00 5.032121230807300e+00 9.061446992055955e+03 + 141340 9.348910010922554e-01 -6.010019018875368e+00 -5.939561502359917e+00 3.690238511309681e+00 5.094816474406848e+00 9.032403370057227e+03 + 141360 9.896239785717778e-01 -6.089382365685028e+00 -5.957394265423803e+00 3.241510053754324e+00 4.999406150546781e+00 9.086712245697947e+03 + 141380 1.008036501142923e+00 -6.110628783072852e+00 -5.984542928817083e+00 3.069688259274591e+00 4.793692746134103e+00 9.169673717245327e+03 + 141400 9.713977190107396e-01 -6.050072347018994e+00 -6.014102599784207e+00 3.422552385997402e+00 4.629096240919940e+00 9.260383458849070e+03 + 141420 9.550728498929767e-01 -6.018318488867928e+00 -5.981082948293168e+00 3.606385052543970e+00 4.820197288705525e+00 9.159075791338442e+03 + 141440 9.449788370344295e-01 -5.989714602602669e+00 -6.011731015708292e+00 3.715226743915180e+00 4.588805092833777e+00 9.253072291942075e+03 + 141460 9.805588996264102e-01 -6.024033979299195e+00 -5.986754415650509e+00 3.582636339948993e+00 4.796701363413580e+00 9.176424509320697e+03 + 141480 1.013886731163816e+00 -6.052787804913662e+00 -5.970695542554855e+00 3.472948580001892e+00 4.944335054202704e+00 9.127294189133056e+03 + 141500 9.933681814621980e-01 -5.999144250062352e+00 -5.975103919385933e+00 3.701878434970018e+00 4.839921733943164e+00 9.140787526593922e+03 + 141520 9.925299714279370e-01 -5.974395686371683e+00 -6.002522419891299e+00 3.856125508978948e+00 4.694617452511373e+00 9.224798201875723e+03 + 141540 1.036909269935660e+00 -6.017075671685485e+00 -5.990634680904791e+00 3.645260771323949e+00 4.797089032116792e+00 9.188284979091130e+03 + 141560 1.030690774940583e+00 -5.984831026700464e+00 -6.000340183297270e+00 3.800659174723563e+00 4.711603197510472e+00 9.218086075113455e+03 + 141580 1.059356054481615e+00 -6.005358697595692e+00 -5.991209588195392e+00 3.678898142549591e+00 4.760144518293718e+00 9.190098571916709e+03 + 141600 1.025645813404789e+00 -5.939074375925124e+00 -5.990193097014016e+00 4.038262241441797e+00 4.744730634352856e+00 9.186959093315003e+03 + 141620 1.039102411569125e+00 -5.946573621461797e+00 -5.988061105249170e+00 4.005040078059525e+00 4.766812525985059e+00 9.180421855936946e+03 + 141640 1.015120950508631e+00 -5.902396342089075e+00 -6.043802599857450e+00 4.240662777741850e+00 4.428686163088174e+00 9.351966418212562e+03 + 141660 1.066289876538435e+00 -5.972924596185608e+00 -6.000622338383415e+00 3.881830891392726e+00 4.722786169481166e+00 9.218947278669320e+03 + 141680 1.050162373513105e+00 -5.948633817778926e+00 -6.063978554700931e+00 3.925769166493604e+00 4.263441837547104e+00 9.414496899009284e+03 + 141700 1.097744846988975e+00 -6.027959018068579e+00 -6.007425223298219e+00 3.542778947865839e+00 4.660687175031722e+00 9.239859753243667e+03 + 141720 1.015237205472077e+00 -5.922859089579497e+00 -6.040794875845186e+00 4.088652850800382e+00 4.411447315558855e+00 9.342692385535702e+03 + 141740 9.992999645226122e-01 -5.928450082214295e+00 -6.029938383530901e+00 4.031843490703297e+00 4.449081959279472e+00 9.309193244153425e+03 + 141760 1.005131453707304e+00 -5.979713273610386e+00 -5.997301665373799e+00 3.840827532112661e+00 4.739832264812318e+00 9.208772083242846e+03 + 141780 9.709160760615200e-01 -5.977794776201065e+00 -5.997990144347645e+00 3.866348730574209e+00 4.750383801453431e+00 9.210864588474331e+03 + 141800 9.803282639840547e-01 -6.039401266714443e+00 -6.000514034924663e+00 3.468238955243815e+00 4.691535457960405e+00 9.218606743545753e+03 + 141820 9.594156893267792e-01 -6.044415806484250e+00 -5.990626035941355e+00 3.434116237046788e+00 4.742985423444180e+00 9.188280744423204e+03 + 141840 9.647820290851310e-01 -6.076293939486161e+00 -6.023714161085698e+00 3.254644597503205e+00 4.556565821773074e+00 9.290003512394658e+03 + 141860 9.799331312897980e-01 -6.113530485927313e+00 -5.998207400971348e+00 3.088131490808723e+00 4.750334490815597e+00 9.211573102008309e+03 + 141880 9.791081092658948e-01 -6.121076411869053e+00 -5.994893726920822e+00 3.036269424687936e+00 4.760829928368070e+00 9.201404690172802e+03 + 141900 9.515235828014684e-01 -6.082358922162840e+00 -5.947038450224087e+00 3.279275326583140e+00 5.056306417230809e+00 9.055182317099874e+03 + 141920 8.836008570368252e-01 -5.975894933191378e+00 -5.945254142544695e+00 3.880072658151716e+00 5.056016819692001e+00 9.049754751835062e+03 + 141940 9.887244418249830e-01 -6.118377479073247e+00 -5.980695602983013e+00 3.049275634380639e+00 4.839866273092227e+00 9.157897631382149e+03 + 141960 9.668707091460165e-01 -6.068474017846654e+00 -6.011750519622595e+00 3.290458534623567e+00 4.616173639359096e+00 9.253170962469703e+03 + 141980 9.566425949516885e-01 -6.034813768600785e+00 -6.033036487519474e+00 3.507626369121915e+00 4.517831792124163e+00 9.318721682580426e+03 + 142000 1.004038576293480e+00 -6.084854991872959e+00 -5.981932706317867e+00 3.290092941929614e+00 4.881088632759166e+00 9.161660138357083e+03 + 142020 9.704113181751642e-01 -6.014270128656978e+00 -6.018011265880400e+00 3.621785149464350e+00 4.600302960588347e+00 9.272436866332000e+03 + 142040 1.020891498542913e+00 -6.068189293192276e+00 -6.030928457284438e+00 3.323109819221826e+00 4.537067305100354e+00 9.312258064387395e+03 + 142060 9.313846037419831e-01 -5.917956828884531e+00 -6.046468392225896e+00 4.170614632911557e+00 4.432681349105282e+00 9.360255764750656e+03 + 142080 9.876974470414244e-01 -5.986451151550558e+00 -6.010089991112716e+00 3.797085042413510e+00 4.661347167549000e+00 9.248058941784357e+03 + 142100 9.865588666130629e-01 -5.970843521640624e+00 -6.025893716498795e+00 3.836442290607359e+00 4.520335552741619e+00 9.296695781538567e+03 + 142120 9.978659225860754e-01 -5.975398535187557e+00 -5.993845507911345e+00 3.846927948965512e+00 4.741002576925712e+00 9.198139236066301e+03 + 142140 1.037418055071861e+00 -6.023656846879240e+00 -6.000921870730969e+00 3.587292319357650e+00 4.717840070627207e+00 9.219872018843118e+03 + 142160 9.814662358905988e-01 -5.933682733356086e+00 -5.955855410199995e+00 4.116290267641162e+00 4.988971325992786e+00 9.081998819400756e+03 + 142180 1.006290156889981e+00 -5.963976383038128e+00 -5.965372446521361e+00 3.852855995398918e+00 4.844839582838071e+00 9.111046410698093e+03 + 142200 1.047481148587131e+00 -6.018159330222583e+00 -5.962094939593655e+00 3.637263022041024e+00 4.959193428968744e+00 9.101048206122257e+03 + 142220 1.002273604933187e+00 -5.945937719405025e+00 -6.025765521854280e+00 3.954513594072913e+00 4.496129999096786e+00 9.296307185705766e+03 + 142240 1.045227449738763e+00 -6.008909018792191e+00 -6.004701200417505e+00 3.628634441373239e+00 4.652796385638479e+00 9.231487180750861e+03 + 142260 9.651797363616643e-01 -5.890481511811447e+00 -6.014161941286962e+00 4.267500682853779e+00 4.557308517320767e+00 9.260567480552654e+03 + 142280 1.043674373017887e+00 -6.009105819122472e+00 -5.988451812499212e+00 3.657056096916740e+00 4.775654599144696e+00 9.181623133001667e+03 + 142300 9.957376999981321e-01 -5.942344122685166e+00 -6.012914112802759e+00 3.960694666338446e+00 4.555470862412552e+00 9.256749772207137e+03 + 142320 1.040491920658572e+00 -6.015825299354069e+00 -5.983017559727877e+00 3.605839949018201e+00 4.794227066933098e+00 9.165010587232664e+03 + 142340 9.994088039570280e-01 -5.962430628539248e+00 -6.047037654014417e+00 3.837915649477888e+00 4.352089016304587e+00 9.361996244329765e+03 + 142360 1.026048782868298e+00 -6.010174758766356e+00 -6.040371211065406e+00 3.588133209479083e+00 4.414740507492050e+00 9.341385467273240e+03 + 142380 9.797001662907349e-01 -5.950474383779784e+00 -5.990698910418029e+00 3.943832485948611e+00 4.712857029266427e+00 9.188494684421121e+03 + 142400 9.590207729503555e-01 -5.924647544477073e+00 -5.961541643643755e+00 4.053980227020626e+00 4.842128600262144e+00 9.099355827855039e+03 + 142420 9.804165291732100e-01 -5.956797828481124e+00 -5.980226154222117e+00 3.888945055677298e+00 4.754415983750826e+00 9.156426823061702e+03 + 142440 1.061792405652693e+00 -6.078118683002723e+00 -5.984927216068314e+00 3.249408647038246e+00 4.784528471508521e+00 9.170844225918227e+03 + 142460 1.008319781043202e+00 -6.001355686136633e+00 -6.009803490822836e+00 3.672198483593791e+00 4.623689881792062e+00 9.247148198485729e+03 + 142480 9.943110195989456e-01 -5.983349514416791e+00 -6.014296597215626e+00 3.786024132945642e+00 4.608321194469145e+00 9.260987927078939e+03 + 142500 9.871588584594029e-01 -5.975868273140073e+00 -6.004761059490677e+00 3.801850301914451e+00 4.635943451545051e+00 9.231650570621630e+03 + 142520 1.003939292353814e+00 -6.004674630457796e+00 -5.948635115724188e+00 3.676227253136757e+00 4.998014818824013e+00 9.060025585643347e+03 + 142540 9.551728641951208e-01 -5.931695374645167e+00 -5.993754856400939e+00 4.041825165960039e+00 4.685470018044630e+00 9.197875852471430e+03 + 142560 1.044411162991910e+00 -6.060757482765778e+00 -5.996595092300579e+00 3.360660391295902e+00 4.729090766444914e+00 9.206593631515339e+03 + 142580 1.013720237661714e+00 -6.014316315733987e+00 -5.994531397870748e+00 3.596867370783127e+00 4.710475430859991e+00 9.200244459893176e+03 + 142600 1.001867699947043e+00 -5.997203436262343e+00 -5.979732260188305e+00 3.704597714830002e+00 4.804919911502883e+00 9.154906089212809e+03 + 142620 9.524291568218852e-01 -5.924121288090693e+00 -5.971248287314713e+00 4.088085772487668e+00 4.817475250063779e+00 9.128951718890730e+03 + 142640 1.001735671513476e+00 -5.992777140860269e+00 -5.996487365217235e+00 3.725273223232161e+00 4.703968540819094e+00 9.206226443449201e+03 + 142660 9.613129495625525e-01 -5.925723920730281e+00 -6.020572125854264e+00 4.036914292293101e+00 4.492281220758882e+00 9.280289681546901e+03 + 142680 1.009609205265977e+00 -5.988913008827472e+00 -6.023403619024745e+00 3.756742228633366e+00 4.558691807475943e+00 9.289043965302762e+03 + 142700 1.029077512995640e+00 -6.010423685659596e+00 -6.003596085243901e+00 3.671636605832519e+00 4.710841743987193e+00 9.228088647114182e+03 + 142720 1.004498501131532e+00 -5.967054148859640e+00 -6.015950838642973e+00 3.859726852844140e+00 4.578954493369956e+00 9.266086482446683e+03 + 142740 1.016610058950480e+00 -5.978257286552350e+00 -5.984141750258368e+00 3.842952519795537e+00 4.809163018577767e+00 9.168401728827126e+03 + 142760 1.037010198897318e+00 -6.001106810445228e+00 -5.968040059890471e+00 3.729046914678434e+00 4.918921313426964e+00 9.119195411609782e+03 + 142780 1.043765490488644e+00 -6.001162120896964e+00 -5.999453320286821e+00 3.705922684995933e+00 4.715734882535417e+00 9.215359763799423e+03 + 142800 9.882945898864103e-01 -5.909028491285439e+00 -6.024177939603366e+00 4.200667557591085e+00 4.539461606030017e+00 9.291367650636803e+03 + 142820 1.042999778384037e+00 -5.982229274275739e+00 -6.014147336379139e+00 3.769029742196590e+00 4.585751290294722e+00 9.260513115487433e+03 + 142840 1.066330962877568e+00 -6.009682383830716e+00 -6.003407601451631e+00 3.604155857142057e+00 4.640186628582198e+00 9.227512182618684e+03 + 142860 1.074253757207893e+00 -6.017738210820341e+00 -5.961116739952267e+00 3.641291150711384e+00 4.966420398580166e+00 9.098062390963509e+03 + 142880 1.028458141666634e+00 -5.949073714007098e+00 -5.975618328637364e+00 3.971923759503286e+00 4.819500474530461e+00 9.142324029034984e+03 + 142900 9.962642227907526e-01 -5.904574686352394e+00 -6.032973496647770e+00 4.164658618159294e+00 4.427372779791568e+00 9.318530525606498e+03 + 142920 9.964125332380310e-01 -5.912081855520427e+00 -6.071961561969874e+00 4.139308120854674e+00 4.221254105117334e+00 9.439260689183357e+03 + 142940 9.782090630188435e-01 -5.897955346686912e+00 -6.034694719962548e+00 4.208027255902010e+00 4.422848614203676e+00 9.323851000463592e+03 + 142960 1.067403364824678e+00 -6.049200262546028e+00 -5.974986924073215e+00 3.422810958373380e+00 4.848955432361290e+00 9.140420884608367e+03 + 142980 9.927893057555371e-01 -5.962137003073414e+00 -5.956742057992380e+00 3.961090968765237e+00 4.992069578285587e+00 9.084720758714664e+03 + 143000 1.026019119867684e+00 -6.036055376448913e+00 -5.984680309537648e+00 3.450881712408640e+00 4.745885296879035e+00 9.170053386416050e+03 + 143020 9.647712210801486e-01 -5.971458341798068e+00 -6.004646947453050e+00 3.824764251827710e+00 4.634190142236677e+00 9.231317846897882e+03 + 143040 1.006043025003857e+00 -6.059548405177569e+00 -5.941751397893956e+00 3.385705542192978e+00 5.062114187043447e+00 9.039108052576381e+03 + 143060 9.834685013277533e-01 -6.048593253328431e+00 -5.958410427582512e+00 3.475043717105672e+00 4.992887458285916e+00 9.089821783521229e+03 + 143080 9.604258565669499e-01 -6.033373924363105e+00 -5.988692217645143e+00 3.500531396540684e+00 4.757100670986988e+00 9.182370460024833e+03 + 143100 9.767269123638138e-01 -6.073175703477518e+00 -6.021280549218176e+00 3.251190550799609e+00 4.549180557305919e+00 9.282503418707242e+03 + 143120 9.152276782151394e-01 -5.995081453708726e+00 -6.008599762588126e+00 3.714549007671534e+00 4.636924786134485e+00 9.243458511449135e+03 + 143140 9.913225686978538e-01 -6.114720242008745e+00 -5.959014249576824e+00 3.079549464007989e+00 4.973637367976536e+00 9.091670229858397e+03 + 143160 9.374464509799327e-01 -6.037297109677590e+00 -5.972196253806087e+00 3.543735693500602e+00 4.917554882239661e+00 9.131895939282223e+03 + 143180 1.015866879835405e+00 -6.150003579389574e+00 -5.961317527452905e+00 2.914545137766831e+00 4.998009647059360e+00 9.098690308320665e+03 + 143200 9.365780732945125e-01 -6.023435982530565e+00 -6.018803742586784e+00 3.522245175699686e+00 4.548844214293695e+00 9.274883101747489e+03 + 143220 9.300010627794899e-01 -5.994624371691734e+00 -6.006834158626491e+00 3.711770903991634e+00 4.641660417953839e+00 9.238066943241354e+03 + 143240 1.023246466176175e+00 -6.104002153902939e+00 -5.982219445089179e+00 3.117698160170527e+00 4.816993319992414e+00 9.162559474250294e+03 + 143260 9.721329519116175e-01 -5.985086341775935e+00 -6.009694401454455e+00 3.724921226537425e+00 4.583617939778431e+00 9.246854407973240e+03 + 143280 1.063641854297031e+00 -6.070495532818321e+00 -6.008954012090708e+00 3.314509536508950e+00 4.667890472046462e+00 9.244531757791163e+03 + 143300 1.010493805931066e+00 -5.941367724443690e+00 -6.026303035632594e+00 4.009641400944105e+00 4.521929700400486e+00 9.297981836653473e+03 + 143320 1.012729496248912e+00 -5.907177984936294e+00 -6.053822504389078e+00 4.132693106388690e+00 4.290637582524757e+00 9.383016451438394e+03 + 143340 1.061221067572097e+00 -5.952310669914858e+00 -6.028576148133952e+00 3.945692539033772e+00 4.507764361055123e+00 9.304996156273090e+03 + 143360 1.036282915545778e+00 -5.902754131994434e+00 -6.021870667020902e+00 4.255642052529083e+00 4.571656475182881e+00 9.284306240018786e+03 + 143380 9.879113787359696e-01 -5.826809187271335e+00 -6.041115557823209e+00 4.624213277181127e+00 4.393632933668609e+00 9.343672724734479e+03 + 143400 1.061538224418216e+00 -5.939497605841168e+00 -6.026822538860154e+00 4.047741778883918e+00 4.546308499999190e+00 9.299561292291912e+03 + 143420 1.001514964040311e+00 -5.858371172065785e+00 -6.073463418108338e+00 4.372124418156257e+00 4.137031455962418e+00 9.443942625760783e+03 + 143440 1.040184095872913e+00 -5.929083185951812e+00 -6.046890442153262e+00 4.016947331906178e+00 4.340479836183476e+00 9.361547554591014e+03 + 143460 1.058521401880514e+00 -5.975006626132298e+00 -5.980661051339097e+00 3.814182501465948e+00 4.781713916909037e+00 9.157769035170137e+03 + 143480 1.028226576102049e+00 -5.951336712703938e+00 -6.021527621822290e+00 3.901224011419464e+00 4.498176949253809e+00 9.283253846583002e+03 + 143500 1.048556297179285e+00 -6.006838180929597e+00 -5.983995968153402e+00 3.697261402318385e+00 4.828424922900298e+00 9.167979203645467e+03 + 143520 1.029890065906846e+00 -6.004892522430193e+00 -5.985943869576150e+00 3.659879668707164e+00 4.768685765689637e+00 9.173934523554297e+03 + 143540 9.538036474451987e-01 -5.913590389762581e+00 -6.009969469341366e+00 4.178104796631958e+00 4.624681207076218e+00 9.247675061024946e+03 + 143560 1.012715031401895e+00 -6.019034233876248e+00 -6.009694086543540e+00 3.594488709198890e+00 4.648121280566425e+00 9.246826513885047e+03 + 143580 9.733735499732030e-01 -5.979023600973283e+00 -6.008251802150051e+00 3.772054306763055e+00 4.604221452556541e+00 9.242371086229577e+03 + 143600 9.880315513425267e-01 -6.014021739554329e+00 -5.986260927109575e+00 3.620331079507977e+00 4.779737960537590e+00 9.174924635878944e+03 + 143620 9.313600886086034e-01 -5.938372174170290e+00 -6.026278103158965e+00 4.045760165831454e+00 4.540990718179937e+00 9.297887214277560e+03 + 143640 9.989173021684992e-01 -6.044704776968807e+00 -6.018079413397022e+00 3.457695797793874e+00 4.610582755684765e+00 9.272629529830709e+03 + 143660 9.641524096041182e-01 -5.997654430137785e+00 -6.015448881368094e+00 3.719616232865168e+00 4.617437740218303e+00 9.264533872674030e+03 + 143680 9.560633477564715e-01 -5.986498786776670e+00 -6.025915561312735e+00 3.762388360020151e+00 4.536051140907918e+00 9.296750133693036e+03 + 143700 9.895806141636594e-01 -6.036024120975520e+00 -5.999281280832203e+00 3.453368192570767e+00 4.664351266609829e+00 9.214860307347501e+03 + 143720 9.305391670892742e-01 -5.945524119680344e+00 -6.043139935169205e+00 3.970055040170172e+00 4.409529921634503e+00 9.349946439629472e+03 + 143740 1.061353110054638e+00 -6.136144326259783e+00 -5.991201493636836e+00 2.965842738445165e+00 4.798126913196986e+00 9.190073329597906e+03 + 143760 9.746022096756571e-01 -6.004583114890686e+00 -6.001638010846513e+00 3.670341449131880e+00 4.687252692306902e+00 9.222084502237043e+03 + 143780 9.617814547405216e-01 -5.979820307019961e+00 -6.033599877516112e+00 3.821633890556231e+00 4.512823274405692e+00 9.320476972602357e+03 + 143800 9.940299595643953e-01 -6.024105812233958e+00 -6.053652579246680e+00 3.541088593013546e+00 4.371426484479080e+00 9.382486029371168e+03 + 143820 9.934220929545590e-01 -6.020856150979756e+00 -5.986429219386841e+00 3.634865626452483e+00 4.832550395209445e+00 9.175447582747558e+03 + 143840 9.336235936238786e-01 -5.928569950435494e+00 -5.997170815986062e+00 4.089482899643536e+00 4.695566113702541e+00 9.208366924125321e+03 + 143860 9.579732958412619e-01 -5.958442086043971e+00 -6.020991249061446e+00 3.951048559317218e+00 4.591881585819186e+00 9.281606577962350e+03 + 143880 1.025746830866926e+00 -6.053502674050260e+00 -6.004290854731942e+00 3.361537535396411e+00 4.644119417426618e+00 9.230249752549575e+03 + 143900 1.012618008160733e+00 -6.030879602627622e+00 -6.005019792830430e+00 3.583605066745339e+00 4.732096096393448e+00 9.232454361630713e+03 + 143920 9.659397369825446e-01 -5.958651799654382e+00 -6.045498812339742e+00 3.941984066132457e+00 4.443295079761339e+00 9.357248161348914e+03 + 143940 9.499252733193427e-01 -5.932495142223002e+00 -6.068624006632215e+00 3.960479052772289e+00 4.178806047460901e+00 9.428888812345143e+03 + 143960 1.025897109771379e+00 -6.043656378010708e+00 -5.948933609144008e+00 3.476560964018336e+00 5.020473761152031e+00 9.060954174058699e+03 + 143980 9.902747496636225e-01 -5.987099795935081e+00 -5.942910302669016e+00 3.772094946401851e+00 5.025837855037580e+00 9.042618572532034e+03 + 144000 1.014369870409376e+00 -6.017886043817189e+00 -5.966386763768344e+00 3.611849037809804e+00 4.907565873338106e+00 9.114134677206197e+03 + 144020 1.060071315355936e+00 -6.080474905319726e+00 -5.981649062804132e+00 3.266070536674904e+00 4.833543817649153e+00 9.160801772162207e+03 + 144040 9.336360902447188e-01 -5.889752907444445e+00 -6.026994267898646e+00 4.234643815143498e+00 4.446582685383585e+00 9.300109285921108e+03 + 144060 1.016183759593726e+00 -6.010553227136117e+00 -5.953773299627930e+00 3.655515318849727e+00 4.981554449267125e+00 9.075681674259638e+03 + 144080 1.042448328337857e+00 -6.043492781098114e+00 -5.980600985419255e+00 3.482275370755247e+00 4.843409794017186e+00 9.157594006075678e+03 + 144100 1.055453035269398e+00 -6.057699008517859e+00 -5.981378146222158e+00 3.385918011167252e+00 4.824164213084437e+00 9.159986472115066e+03 + 144120 9.768278981413673e-01 -5.940238731333043e+00 -6.027516242246314e+00 3.924976298429452e+00 4.423815324614287e+00 9.301690925457126e+03 + 144140 9.834784577796795e-01 -5.948209082310563e+00 -5.988030026723845e+00 3.988810300836133e+00 4.760152275743841e+00 9.180292570493884e+03 + 144160 9.903699465857806e-01 -5.954424718797602e+00 -5.995278799276906e+00 3.923677068597578e+00 4.689086616336895e+00 9.202556877187741e+03 + 144180 1.029301056925180e+00 -6.006865177549577e+00 -6.043133211473513e+00 3.618377520503141e+00 4.410120857251790e+00 9.349936721829825e+03 + 144200 9.983792096944891e-01 -5.955916815061374e+00 -5.986795537831901e+00 3.948274998447801e+00 4.770964593832530e+00 9.176539094531541e+03 + 144220 9.289415100248983e-01 -5.846344166606392e+00 -6.038041599636792e+00 4.552108678056678e+00 4.451352352514238e+00 9.334155952656027e+03 + 144240 1.002379075372907e+00 -5.946351141638212e+00 -6.021007892291544e+00 4.008658598588260e+00 4.579967983242004e+00 9.281640685353375e+03 + 144260 1.071559996693637e+00 -6.039084711588035e+00 -6.008024287792261e+00 3.520806622139150e+00 4.699160382159530e+00 9.241708031452441e+03 + 144280 1.043137856430322e+00 -5.990468920749844e+00 -6.016281287919490e+00 3.753439233654996e+00 4.605220626915976e+00 9.267106504027775e+03 + 144300 9.956429338715099e-01 -5.918310251371743e+00 -5.987846446056897e+00 4.105747950252718e+00 4.706460359679213e+00 9.179781891319402e+03 + 144320 1.044458120710779e+00 -5.992211508343604e+00 -5.974984969084431e+00 3.750799579115562e+00 4.849717033340064e+00 9.140414285493685e+03 + 144340 1.010283980211606e+00 -5.943098365747236e+00 -6.039151294722764e+00 3.961705475150188e+00 4.410154692829986e+00 9.337616758301112e+03 + 144360 1.029353828808548e+00 -5.976700898708115e+00 -6.045631880626789e+00 3.822989003481549e+00 4.427176638269541e+00 9.357661160185173e+03 + 144380 1.028447427801659e+00 -5.987087893225515e+00 -6.023929241695418e+00 3.745776287906024e+00 4.534227563811589e+00 9.290652738800543e+03 + 144400 9.692081921801015e-01 -5.915445046845586e+00 -6.015530229527405e+00 4.179696153271037e+00 4.604991546180071e+00 9.264754808114811e+03 + 144420 1.020394386658607e+00 -6.008152185772259e+00 -6.018911213171092e+00 3.649951272140290e+00 4.588171271862080e+00 9.275204951680213e+03 + 144440 9.989798054457499e-01 -5.996896155462064e+00 -6.014284143787217e+00 3.717490107801686e+00 4.617645588056162e+00 9.260972418421827e+03 + 144460 9.828511786228347e-01 -5.996782425122694e+00 -5.988661207397268e+00 3.737312240817089e+00 4.783945529750866e+00 9.182274992167886e+03 + 144480 9.752927864206771e-01 -6.008401457709764e+00 -5.958385143491872e+00 3.699928789219178e+00 4.987130205457923e+00 9.089742022250099e+03 + 144500 9.922385590005608e-01 -6.052653920123117e+00 -5.976508644279844e+00 3.430651551632200e+00 4.867889508967630e+00 9.145068780262003e+03 + 144520 1.017123853915155e+00 -6.105353833576578e+00 -6.000964034910270e+00 3.168960690198380e+00 4.768383068409456e+00 9.220027864427217e+03 + 144540 9.487119707961863e-01 -6.021110358112641e+00 -6.040214741580036e+00 3.558576257006641e+00 4.448875930743070e+00 9.340921783235255e+03 + 144560 9.026028946012893e-01 -5.967611315871537e+00 -6.014737750710964e+00 3.891011627032643e+00 4.620404345392432e+00 9.262350971235863e+03 + 144580 9.874290768127768e-01 -6.103904521217029e+00 -5.966017526379519e+00 3.175748110241649e+00 4.967516572542120e+00 9.113028670455484e+03 + 144600 9.555772537023101e-01 -6.061856679975254e+00 -5.971977075575844e+00 3.415717682482437e+00 4.931820279767676e+00 9.131238649806804e+03 + 144620 1.002106564697661e+00 -6.130561389194900e+00 -5.985031245250846e+00 3.036175285229489e+00 4.871831892473244e+00 9.171153930086708e+03 + 144640 9.548740251438269e-01 -6.054844662563151e+00 -6.006140089569624e+00 3.443062668460361e+00 4.722731863597509e+00 9.235916270339654e+03 + 144660 9.574667831813201e-01 -6.047251958536547e+00 -6.009259667865623e+00 3.445729998679647e+00 4.663887611000070e+00 9.245494254957252e+03 + 144680 9.935237374302001e-01 -6.080875950127553e+00 -6.006597620359730e+00 3.240684340824690e+00 4.667202004885914e+00 9.237328254619470e+03 + 144700 1.003555442415166e+00 -6.063941102186172e+00 -6.074293645540260e+00 3.314050253789290e+00 4.254604347799207e+00 9.446480508453158e+03 + 144720 1.019025153726932e+00 -6.047493788361750e+00 -6.035105376172393e+00 3.477170211038755e+00 4.548306390930634e+00 9.325130596617020e+03 + 144740 1.045326163237689e+00 -6.042208336706166e+00 -5.979536431794300e+00 3.543691574839599e+00 4.903563351289472e+00 9.154327012092313e+03 + 144760 1.002403033047359e+00 -5.936714673399880e+00 -5.998580282713635e+00 4.038788379699493e+00 4.683546477347813e+00 9.212687675037250e+03 + 144780 1.057193355593690e+00 -5.981412378363301e+00 -5.972072272491848e+00 3.829673003025956e+00 4.883305336316552e+00 9.131496380463392e+03 + 144800 1.016129099115472e+00 -5.891847640501859e+00 -6.007914532800223e+00 4.251371163740721e+00 4.584897106869981e+00 9.241339381482812e+03 + 144820 1.101933598111601e+00 -6.000036924601751e+00 -6.005764575985403e+00 3.668584028255698e+00 4.635694967659583e+00 9.234769286642828e+03 + 144840 1.031770440545979e+00 -5.889102975343481e+00 -5.976460742222110e+00 4.303573959866751e+00 4.801952143878929e+00 9.144907823379370e+03 + 144860 1.041268232760532e+00 -5.902540212773613e+00 -5.986459236138743e+00 4.293879999035793e+00 4.812003980446323e+00 9.175461533667130e+03 + 144880 1.052883114936598e+00 -5.922056816640553e+00 -6.001944790626474e+00 4.068539209727355e+00 4.609810100476178e+00 9.223013979141930e+03 + 144900 1.042604009323368e+00 -5.915408320578691e+00 -6.052808209542293e+00 4.085292441540838e+00 4.296321016547741e+00 9.379879341855692e+03 + 144920 1.086754051780475e+00 -5.996094502526765e+00 -6.059591255788689e+00 3.672548908514755e+00 4.307940725193978e+00 9.400908868190780e+03 + 144940 1.093313426701941e+00 -6.030334237964823e+00 -5.996489856500554e+00 3.542656256573276e+00 4.736995932342215e+00 9.206285845821174e+03 + 144960 9.911581930978604e-01 -5.906002446741732e+00 -5.982194407467508e+00 4.229033849360227e+00 4.791527820205011e+00 9.162459639005017e+03 + 144980 1.041393271649913e+00 -6.005101414096837e+00 -5.959243074519414e+00 3.695479799738741e+00 4.958805482147418e+00 9.092323387662025e+03 + 145000 9.874712931500707e-01 -5.944512912253335e+00 -5.955143343358591e+00 4.065727153914446e+00 5.004685573454165e+00 9.079814552272344e+03 + 145020 1.013137349676630e+00 -5.997362055617272e+00 -5.986892836257746e+00 3.671249785856440e+00 4.731365663525300e+00 9.176870571800657e+03 + 145040 1.068891167059814e+00 -6.093898883652746e+00 -5.964241855106389e+00 3.161931138911403e+00 4.906441861184907e+00 9.107614224802788e+03 + 145060 1.011213912769952e+00 -6.021187766152206e+00 -5.999054622220345e+00 3.601250260699259e+00 4.728342198248963e+00 9.214160386902144e+03 + 145080 9.780658222858261e-01 -5.983171572996707e+00 -5.962530549829269e+00 3.815888348747477e+00 4.934412297962912e+00 9.102391661962129e+03 + 145100 9.720462998520066e-01 -5.979207050715813e+00 -5.947481446264239e+00 3.808697964843324e+00 4.990871295125682e+00 9.056518569064914e+03 + 145120 9.743391592880173e-01 -5.981651258752540e+00 -6.011709842264171e+00 3.798795591526098e+00 4.626194553451548e+00 9.253009881822180e+03 + 145140 1.014331013378868e+00 -6.040166132140115e+00 -5.994992635611113e+00 3.514027951964257e+00 4.773421159609784e+00 9.201672397612650e+03 + 145160 9.931208031175235e-01 -6.008158451416429e+00 -5.978686670691088e+00 3.656369979928587e+00 4.825601505596820e+00 9.151740401101335e+03 + 145180 9.475790624594267e-01 -5.939791933474814e+00 -5.968457432874230e+00 4.020263164275666e+00 4.855661430752526e+00 9.120490261249868e+03 + 145200 1.017955111748345e+00 -6.041677097053587e+00 -6.021295644252211e+00 3.408636012929029e+00 4.525669468934161e+00 9.282535257283180e+03 + 145220 9.526689823692729e-01 -5.940916992149564e+00 -6.073555036225358e+00 3.950682128342974e+00 4.189053953588783e+00 9.444211523126007e+03 + 145240 9.335041097603322e-01 -5.909850348770558e+00 -6.006239578738558e+00 4.200062725784658e+00 4.646580851123268e+00 9.236215468487306e+03 + 145260 1.019550575353238e+00 -6.034348261036230e+00 -5.995744101049172e+00 3.521406102546639e+00 4.743077163166782e+00 9.203959046572074e+03 + 145280 1.024980634756864e+00 -6.038258589462449e+00 -5.961112433282899e+00 3.521251883204492e+00 4.964237050316555e+00 9.098061313059632e+03 + 145300 1.003642712589381e+00 -6.000762666124282e+00 -6.010712942930789e+00 3.684758114869472e+00 4.627622085646147e+00 9.249973626649706e+03 + 145320 1.033744561389013e+00 -6.042117180773358e+00 -5.987979750018617e+00 3.437339936045349e+00 4.748205441179408e+00 9.180195905544217e+03 + 145340 1.011783451088057e+00 -6.007179067788475e+00 -6.017114465136246e+00 3.684469228350953e+00 4.627418639282282e+00 9.269642299866960e+03 + 145360 1.092967586923631e+00 -6.125171486909958e+00 -5.963355699245301e+00 3.053486864493879e+00 4.982658158176555e+00 9.104902940462320e+03 + 145380 9.682162726071293e-01 -5.937233548909616e+00 -6.010337406717683e+00 4.031860411286591e+00 4.612086746967239e+00 9.248772243024816e+03 + 145400 1.046575386064725e+00 -6.048581976902052e+00 -5.974643567375191e+00 3.460519971352876e+00 4.885085760788013e+00 9.139373433433399e+03 + 145420 1.007600647814133e+00 -5.983677442895872e+00 -6.035090240117079e+00 3.784176775495172e+00 4.488956537746344e+00 9.325079018630891e+03 + 145440 9.638571545998363e-01 -5.912179908565498e+00 -6.016799192743081e+00 4.165763605929975e+00 4.565023486400396e+00 9.268679395179701e+03 + 145460 1.019083456785201e+00 -5.984129771276293e+00 -5.984455688647537e+00 3.776236927355304e+00 4.774365459374071e+00 9.169371379845108e+03 + 145480 9.870894664988736e-01 -5.924503134147398e+00 -6.027877291741325e+00 4.092112362956762e+00 4.498521952953245e+00 9.302798620654576e+03 + 145500 9.816906500064776e-01 -5.903564928730553e+00 -6.048048205638713e+00 4.211895846254343e+00 4.382250511532852e+00 9.365114880320070e+03 + 145520 1.082824479996435e+00 -6.042077948874216e+00 -6.002867653342624e+00 3.505682477835420e+00 4.730834062551443e+00 9.225846495392634e+03 + 145540 1.040844646776641e+00 -5.971350013758226e+00 -6.041048592723508e+00 3.798125769831970e+00 4.397905743593085e+00 9.343500300733818e+03 + 145560 1.019804143585232e+00 -5.937787314132484e+00 -6.024253217652326e+00 4.003955200689191e+00 4.507454602122932e+00 9.291645145871644e+03 + 145580 1.031286474813202e+00 -5.955396363111252e+00 -6.007380786040503e+00 3.956640774048983e+00 4.658138173025774e+00 9.239707903333529e+03 + 145600 1.038987418999279e+00 -5.970476388547776e+00 -6.027586884532651e+00 3.807027830547201e+00 4.479090524781360e+00 9.301945639376803e+03 + 145620 1.035932158605705e+00 -5.978445654206726e+00 -6.012593903787412e+00 3.741923999718796e+00 4.545839466201954e+00 9.255745353414741e+03 + 145640 9.837738292308880e-01 -5.917204793739272e+00 -5.991695734867803e+00 4.145532617375531e+00 4.717794105979625e+00 9.191552627297691e+03 + 145660 9.836842500762703e-01 -5.933570776768774e+00 -6.011943450305389e+00 4.048867312462821e+00 4.598839292883548e+00 9.253746809324623e+03 + 145680 9.411711280831839e-01 -5.890774029861855e+00 -6.056745290991517e+00 4.225746766358314e+00 4.272714100982140e+00 9.392054781500821e+03 + 145700 9.743102419496299e-01 -5.961497024456220e+00 -5.999957224657376e+00 3.832623925733288e+00 4.611779504481505e+00 9.216928998132345e+03 + 145720 9.780982226129207e-01 -5.987629962371034e+00 -5.990705726878312e+00 3.790746271376127e+00 4.773084755602310e+00 9.188532038363888e+03 + 145740 9.948462064437332e-01 -6.033365698968798e+00 -5.980145974862686e+00 3.512994169408116e+00 4.818590060951104e+00 9.156220692000652e+03 + 145760 1.003769317725403e+00 -6.069465503627400e+00 -5.993995313530084e+00 3.298422195060307e+00 4.731783705573271e+00 9.198641005881693e+03 + 145780 9.506041316927898e-01 -6.011929612584299e+00 -6.000224096304006e+00 3.617254287763143e+00 4.684469173667376e+00 9.217715600310836e+03 + 145800 9.728668483253247e-01 -6.060877702061767e+00 -5.960825538542474e+00 3.413123589772861e+00 4.987638595722905e+00 9.097180685107685e+03 + 145820 9.556485520576307e-01 -6.048200430856607e+00 -5.937880548138871e+00 3.449067575245161e+00 5.082541413757077e+00 9.027339840821322e+03 + 145840 9.933183589544394e-01 -6.110236597500824e+00 -5.946467045893995e+00 3.096220199056275e+00 5.036610307638897e+00 9.053441679947524e+03 + 145860 9.784443209505010e-01 -6.088791789865550e+00 -6.007538757011688e+00 3.230790965284486e+00 4.697358453797559e+00 9.240210349957841e+03 + 145880 1.013295181059930e+00 -6.138126787434806e+00 -5.975460243441630e+00 2.959484756340250e+00 4.893541224515396e+00 9.141892186471507e+03 + 145900 9.082476550196908e-01 -5.975552723767165e+00 -6.006052397222250e+00 3.809120325564397e+00 4.633986480776086e+00 9.235651166895092e+03 + 145920 9.567834750865056e-01 -6.033224612110772e+00 -6.017202338090662e+00 3.484965509286502e+00 4.576967886148863e+00 9.269935291529953e+03 + 145940 9.722272138947428e-01 -6.030628082208806e+00 -5.990683533000507e+00 3.567683116084994e+00 4.797050899038059e+00 9.188470689165501e+03 + 145960 9.758023476667106e-01 -5.999971386669308e+00 -6.010560486265526e+00 3.702835033620540e+00 4.642030785081194e+00 9.249481798077104e+03 + 145980 1.069745781327832e+00 -6.091064445750801e+00 -5.967342563671442e+00 3.225776254763271e+00 4.936206447562325e+00 9.117067785313837e+03 + 146000 9.251665762046253e-01 -5.826788832623731e+00 -6.004874331934950e+00 4.629707718938314e+00 4.607113223251342e+00 9.231990515375182e+03 + 146020 1.035293612937146e+00 -5.948288511163669e+00 -5.985042876295799e+00 3.989739258162590e+00 4.778690005854278e+00 9.171115299340856e+03 + 146040 1.072172678696891e+00 -5.971231224333609e+00 -5.995723109845643e+00 3.821631382101134e+00 4.680995185384003e+00 9.203910461079264e+03 + 146060 1.047336673222628e+00 -5.913950015851645e+00 -6.013445493745230e+00 4.163646691520501e+00 4.592328260580096e+00 9.258356292769116e+03 + 146080 1.009824679823282e+00 -5.849770561908489e+00 -5.995524063887132e+00 4.463993538030841e+00 4.627054374387941e+00 9.203280867288271e+03 + 146100 1.012623781819700e+00 -5.852142707651311e+00 -5.967909878433217e+00 4.502499863371762e+00 4.837746853830280e+00 9.118761003599975e+03 + 146120 1.056437723715421e+00 -5.917973506924930e+00 -6.002152596297615e+00 4.159311457767623e+00 4.675942099917687e+00 9.223603410968901e+03 + 146140 9.785362630741612e-01 -5.810257216633323e+00 -5.983269566300072e+00 4.706128329318606e+00 4.712664643957552e+00 9.165745759444226e+03 + 146160 1.017852916723209e+00 -5.878143895691900e+00 -6.027114502958660e+00 4.329233448570450e+00 4.473821168517744e+00 9.300473109806604e+03 + 146180 1.043911539691283e+00 -5.931726183279805e+00 -6.066501171590415e+00 3.988029534308422e+00 4.214130695066862e+00 9.422320708805637e+03 + 146200 1.068630467382682e+00 -5.991433534256910e+00 -6.003386599902315e+00 3.725438602849283e+00 4.656802250182437e+00 9.227455040859490e+03 + 146220 9.706682045866865e-01 -5.875598124608504e+00 -6.033785671935535e+00 4.349922322986341e+00 4.441584946790698e+00 9.321047674975394e+03 + 146240 1.025752763487855e+00 -5.987449335652083e+00 -6.035811304565427e+00 3.708292086856450e+00 4.430590177365524e+00 9.327330773287156e+03 + 146260 9.760221841134513e-01 -5.945080395924111e+00 -6.058215597854169e+00 3.916146921969132e+00 4.266507084870826e+00 9.396646598824249e+03 + 146280 9.820599578321977e-01 -5.983821636002117e+00 -6.034006805040946e+00 3.693951863586483e+00 4.405780856835722e+00 9.321732186751113e+03 + 146300 9.672924023399080e-01 -5.983642404863553e+00 -5.999110772515513e+00 3.756187968685859e+00 4.667366207906150e+00 9.214338244217857e+03 + 146320 9.589785060529610e-01 -5.985967310669660e+00 -6.020875050021282e+00 3.749049620773948e+00 4.548603979461733e+00 9.281254517054740e+03 + 146340 9.873086177236396e-01 -6.038877223675098e+00 -6.019897966839235e+00 3.467992944668693e+00 4.576974774450723e+00 9.278240092842776e+03 + 146360 9.340283124348085e-01 -5.967537804492419e+00 -5.978954334658646e+00 3.809505384790684e+00 4.743949901873869e+00 9.152564637338362e+03 + 146380 9.110509170889752e-01 -5.935447770733778e+00 -6.003691380281552e+00 3.998732878990329e+00 4.606867512302562e+00 9.228387232167768e+03 + 146400 1.023094940497989e+00 -6.099267253070698e+00 -5.951705452829634e+00 3.161895200161204e+00 5.009217892260184e+00 9.069398951794274e+03 + 146420 9.286690377829251e-01 -5.953075348018171e+00 -6.018902724724329e+00 3.929392803744864e+00 4.551401819944476e+00 9.275129580140883e+03 + 146440 9.160482036479469e-01 -5.925906911346908e+00 -6.009187362928492e+00 4.077328129435224e+00 4.599118888845541e+00 9.245272354753830e+03 + 146460 1.042969284008299e+00 -6.103945097531083e+00 -6.021843402809422e+00 3.096239278416666e+00 4.567679914704639e+00 9.284229175214596e+03 + 146480 1.021580586362234e+00 -6.064026255802167e+00 -5.995276746521092e+00 3.364892774303999e+00 4.759663095548115e+00 9.202561358423933e+03 + 146500 9.556385460279209e-01 -5.959287959727708e+00 -5.994938856151905e+00 3.932743493993035e+00 4.728030529766901e+00 9.201506904906486e+03 + 146520 1.008429353603009e+00 -6.030112464408780e+00 -5.966493137683381e+00 3.567407081964698e+00 4.932719101080933e+00 9.114466623721262e+03 + 146540 9.250206928725512e-01 -5.896197801498803e+00 -6.002937727961774e+00 4.210321134397818e+00 4.597403958697202e+00 9.226064735884262e+03 + 146560 1.000673789919201e+00 -5.996705851811758e+00 -5.982678733719220e+00 3.706563813654161e+00 4.787109696431020e+00 9.163953245340035e+03 + 146580 1.004237239920166e+00 -5.988697354552752e+00 -6.009455737349420e+00 3.702354783448863e+00 4.583156937081041e+00 9.246093084109518e+03 + 146600 1.058442149939690e+00 -6.056281079330957e+00 -5.973841153378213e+00 3.411516705670893e+00 4.884899518028860e+00 9.136911727698009e+03 + 146620 1.017941810858311e+00 -5.982631517124894e+00 -6.023745262832973e+00 3.757687829868722e+00 4.521606339681343e+00 9.290079976926767e+03 + 146640 1.104401600637001e+00 -6.100834892636403e+00 -5.947590398192506e+00 3.142330378809889e+00 5.022283980415622e+00 9.056861249062618e+03 + 146660 1.049294493733776e+00 -6.012137192432932e+00 -5.932578876007909e+00 3.628587867926508e+00 5.085424032448667e+00 9.011222024217524e+03 + 146680 9.762856047130266e-01 -5.894009781371448e+00 -5.930699024052423e+00 4.238098986701860e+00 5.027423677585744e+00 9.005473179860466e+03 + 146700 9.760876525739138e-01 -5.876914480897402e+00 -5.945983963553270e+00 4.408047919013095e+00 5.011440261135205e+00 9.051886410902840e+03 + 146720 1.071797609864190e+00 -5.990442380330000e+00 -5.955067378952279e+00 3.720945152448857e+00 4.924073884623502e+00 9.079599849998383e+03 + 146740 1.054342552977845e+00 -5.921644513997920e+00 -6.016301435219500e+00 4.101684143451884e+00 4.558149453686357e+00 9.267148624379319e+03 + 146760 1.043080819974475e+00 -5.859266416964562e+00 -6.080653946465593e+00 4.473215974966584e+00 4.201974520962200e+00 9.466244079117751e+03 + 146780 1.124671624742567e+00 -5.941342218093446e+00 -6.015532635927275e+00 4.016269413051251e+00 4.590256552919353e+00 9.264805066701374e+03 + 146800 1.048265524614906e+00 -5.802247456472258e+00 -6.050446970314235e+00 4.748556918481068e+00 4.323356901249800e+00 9.372529361867582e+03 + 146820 1.076498034346658e+00 -5.830468102611465e+00 -6.067583489000038e+00 4.567356810917789e+00 4.205803568787149e+00 9.425669029723806e+03 + 146840 1.047895191580802e+00 -5.787475992918536e+00 -6.076126457849664e+00 4.815532379875410e+00 4.158056741725785e+00 9.452216874959806e+03 + 146860 1.105883037357892e+00 -5.887032313468720e+00 -5.981449891729126e+00 4.284469460704704e+00 4.742309115260438e+00 9.160188123523054e+03 + 146880 1.099400189763775e+00 -5.903260290880397e+00 -5.995107268078613e+00 4.176739651311514e+00 4.649340094965567e+00 9.202019212223211e+03 + 146900 1.093052661770129e+00 -5.932411821743210e+00 -6.004697533160536e+00 4.060018062912372e+00 4.644942321776394e+00 9.231470701827609e+03 + 146920 1.069590478226019e+00 -5.943336858653624e+00 -6.029621069746150e+00 4.031833156250342e+00 4.536375863718544e+00 9.308212880247866e+03 + 146940 1.034107791271901e+00 -5.939328425810491e+00 -6.072656962328280e+00 3.978612518119471e+00 4.213019428909984e+00 9.441436044499256e+03 + 146960 1.055704601453745e+00 -6.013828257489641e+00 -5.974760221882641e+00 3.605366851632642e+00 4.829701557847008e+00 9.139728405646985e+03 + 146980 9.954936705477722e-01 -5.955073004713624e+00 -5.981586404843047e+00 3.932435869147313e+00 4.780191822668755e+00 9.160587763415915e+03 + 147000 1.065992677677076e+00 -6.079600013465132e+00 -5.970007676389181e+00 3.275772969410748e+00 4.905069128260214e+00 9.125201823658899e+03 + 147020 1.034138211388486e+00 -6.046075767291795e+00 -6.061346376626426e+00 3.455735784265808e+00 4.368049582347198e+00 9.406325020637914e+03 + 147040 1.017894806478701e+00 -6.038279589225278e+00 -6.019335833811667e+00 3.502377558053666e+00 4.611155533175298e+00 9.276508114268974e+03 + 147060 9.140389479070199e-01 -5.897787672279407e+00 -6.031303026224789e+00 4.247216613353622e+00 4.480550789564990e+00 9.313377875563399e+03 + 147080 1.038753659428150e+00 -6.093657594470680e+00 -5.971790300702791e+00 3.273808098898868e+00 4.973588958616846e+00 9.130654035531490e+03 + 147100 9.792363989036936e-01 -6.013072801226800e+00 -6.041845073720065e+00 3.633086903050637e+00 4.467872061899528e+00 9.345947599181092e+03 + 147120 9.556511416136236e-01 -5.984987381118433e+00 -6.018902096396578e+00 3.786707992204814e+00 4.591964448792474e+00 9.275163612687753e+03 + 147140 9.601838346134909e-01 -5.996618341836211e+00 -6.013004290394294e+00 3.704343795792858e+00 4.610253143455003e+00 9.257018498254371e+03 + 147160 9.805840106623785e-01 -6.030026622576379e+00 -6.000852529990851e+00 3.567701708937618e+00 4.735223863239960e+00 9.219661799430263e+03 + 147180 1.017876948174219e+00 -6.086009114983499e+00 -5.979827854439384e+00 3.258638799469685e+00 4.868348029010958e+00 9.155199299334674e+03 + 147200 9.931146751533079e-01 -6.047372770191480e+00 -5.987036045557725e+00 3.422556116294870e+00 4.769018926219857e+00 9.177296091996648e+03 + 147220 9.761351903487938e-01 -6.017472302584705e+00 -5.986798612110976e+00 3.589617981230208e+00 4.765751058668614e+00 9.176579085160573e+03 + 147240 1.032488780080043e+00 -6.091641844916486e+00 -5.961526901640438e+00 3.226976875033535e+00 4.974117014547002e+00 9.099321877099337e+03 + 147260 9.909708783238195e-01 -6.014349514357239e+00 -6.044902934233122e+00 3.584324349972329e+00 4.408881884918562e+00 9.355395972583703e+03 + 147280 1.011578407048918e+00 -6.028951913937673e+00 -6.010138255871124e+00 3.553616628779026e+00 4.661647564801330e+00 9.248176599863758e+03 + 147300 1.060989239266021e+00 -6.077836545400511e+00 -6.000576073281101e+00 3.264078254404861e+00 4.707719841333931e+00 9.218850140017867e+03 + 147320 1.005432401689564e+00 -5.969353296531612e+00 -5.981168396740696e+00 3.854800221269902e+00 4.786956087488494e+00 9.159310999752950e+03 + 147340 9.798522393251657e-01 -5.902735569118247e+00 -5.975336193463681e+00 4.199498113336196e+00 4.782614093434400e+00 9.141454020429690e+03 + 147360 9.952254019792033e-01 -5.891200787687406e+00 -5.976083385637267e+00 4.237867196638620e+00 4.750458183670934e+00 9.143743559163686e+03 + 147380 1.074271987125533e+00 -5.971213706669562e+00 -5.990459857665112e+00 3.805037980986488e+00 4.694523603637799e+00 9.187757392642527e+03 + 147400 1.048078321189092e+00 -5.897593245797662e+00 -6.051995520056026e+00 4.190205636836806e+00 4.303603884370555e+00 9.377339840327310e+03 + 147420 1.054432252525174e+00 -5.884578972358971e+00 -5.960535862386383e+00 4.288725275374471e+00 4.852569058546333e+00 9.096292705925222e+03 + 147440 1.073986446131941e+00 -5.896932496134309e+00 -6.032840842282691e+00 4.267060482511271e+00 4.486653727178669e+00 9.318124278063069e+03 + 147460 1.045933927628602e+00 -5.849237400121832e+00 -6.043698701726120e+00 4.536082177585032e+00 4.419455290984042e+00 9.351641845311546e+03 + 147480 1.081836177180305e+00 -5.906387748958461e+00 -6.020666111552012e+00 4.249330832267600e+00 4.593126789735968e+00 9.280582772238167e+03 + 147500 1.024278078051951e+00 -5.833560299871292e+00 -6.052111917205425e+00 4.571145650730561e+00 4.316188443244488e+00 9.377709957721452e+03 + 147520 1.118189556494424e+00 -5.997549327457970e+00 -5.985281850560791e+00 3.739550089027719e+00 4.809991839757238e+00 9.171933352829941e+03 + 147540 1.051043548723476e+00 -5.934460959678087e+00 -6.028507489950787e+00 4.064094329544866e+00 4.524064599065496e+00 9.304752241937897e+03 + 147560 9.860461566661262e-01 -5.883190085707709e+00 -6.034198310402381e+00 4.393348116455520e+00 4.526235521811468e+00 9.322305605095815e+03 + 147580 1.049976860726056e+00 -6.025448960550658e+00 -6.010812265536082e+00 3.543525922280762e+00 4.627572090075692e+00 9.250285849841071e+03 + 147600 9.876855694138911e-01 -5.972696067453701e+00 -5.989948898715598e+00 3.926214282376555e+00 4.827145855403735e+00 9.186199601177173e+03 + 147620 9.596203932306527e-01 -5.956816185216270e+00 -5.993341940740624e+00 3.920411184145700e+00 4.710674643582460e+00 9.196615885108258e+03 + 147640 9.503098167818431e-01 -5.955413732439411e+00 -6.026744976883061e+00 3.882895613420072e+00 4.473300569350224e+00 9.299338457762800e+03 + 147660 9.792025788260712e-01 -6.005563932765724e+00 -6.037290165935348e+00 3.703570091056327e+00 4.521393150577628e+00 9.331884896480333e+03 + 147680 1.007749938878115e+00 -6.054358502061521e+00 -6.012042088275933e+00 3.396216264623196e+00 4.639203661023907e+00 9.254072254181929e+03 + 147700 9.428923191843426e-01 -5.962908622824595e+00 -6.002207535948232e+00 3.914391686149993e+00 4.688731245506918e+00 9.223832169728581e+03 + 147720 9.671960549566440e-01 -6.000061673855162e+00 -5.966962070227692e+00 3.770772817665166e+00 4.960835863841207e+00 9.115895950458764e+03 + 147740 9.591341406118271e-01 -5.983855142102416e+00 -5.995895485279360e+00 3.796242622522821e+00 4.727105108763727e+00 9.204437786090157e+03 + 147760 1.002782611483377e+00 -6.042157278596002e+00 -5.963491045382955e+00 3.488741326174172e+00 4.940455010843730e+00 9.105301505226988e+03 + 147780 9.757060023147547e-01 -5.992173036281534e+00 -5.988193637919881e+00 3.814930724336451e+00 4.837781045538970e+00 9.180825377287998e+03 + 147800 9.649849644021182e-01 -5.964111016263060e+00 -6.046593587333906e+00 3.862213128886248e+00 4.388585441660835e+00 9.360640503036137e+03 + 147820 1.017470981989786e+00 -6.030163560658141e+00 -6.030677656959172e+00 3.523876747052479e+00 4.520924726535814e+00 9.311461053081543e+03 + 147840 1.026237549083648e+00 -6.031091799070516e+00 -5.999781704464851e+00 3.544115464218673e+00 4.723902872665882e+00 9.216379698868077e+03 + 147860 1.005522021985366e+00 -5.986606229204186e+00 -6.001977094715025e+00 3.714160581855278e+00 4.625898693458291e+00 9.223127278310338e+03 + 147880 1.014329124580563e+00 -5.987292658819213e+00 -6.000820920704540e+00 3.737879751753013e+00 4.660198378515705e+00 9.219559780674294e+03 + 147900 9.829269821354291e-01 -5.926510306976234e+00 -6.005158785668315e+00 4.011114318903367e+00 4.559502583440694e+00 9.232887356290144e+03 + 147920 9.937424260503718e-01 -5.927227289508981e+00 -5.990095965363997e+00 4.081299984938861e+00 4.720298319283214e+00 9.186657173659509e+03 + 147940 1.028943977642344e+00 -5.961885399576211e+00 -5.984720209978049e+00 3.954655918488980e+00 4.823534903486134e+00 9.170191463397185e+03 + 147960 1.039691175905690e+00 -5.958487865882605e+00 -6.013337456368057e+00 3.955355795412998e+00 4.640400958898841e+00 9.258028650513819e+03 + 147980 1.052993506363975e+00 -5.960208423061725e+00 -6.044193865955648e+00 3.894368591860587e+00 4.412111182058393e+00 9.353228263780298e+03 + 148000 1.037844638160867e+00 -5.923650223914770e+00 -6.033313951152860e+00 4.066991581857732e+00 4.437285489649672e+00 9.319601172019884e+03 + 148020 1.016713527935738e+00 -5.880228166550846e+00 -6.012591264194786e+00 4.362790041504050e+00 4.602740651709388e+00 9.255727238965192e+03 + 148040 1.059464731878219e+00 -5.932819170006319e+00 -5.999894893160636e+00 4.066972643793424e+00 4.681813461506721e+00 9.216718647349062e+03 + 148060 1.020873373701872e+00 -5.868319547450537e+00 -6.078681540224218e+00 4.375806627205301e+00 4.167875511285653e+00 9.460150843666550e+03 + 148080 1.093477458354580e+00 -5.979994514895679e+00 -6.001861127193919e+00 3.850977994115438e+00 4.725416522451630e+00 9.222765573376746e+03 + 148100 1.048469530790213e+00 -5.927404548668319e+00 -5.989622795324542e+00 4.072417164778072e+00 4.715150364235487e+00 9.185172988537115e+03 + 148120 1.010561719535501e+00 -5.893386989675033e+00 -5.980191593971949e+00 4.261320897291439e+00 4.762875426449446e+00 9.156311655866253e+03 + 148140 1.009477591574436e+00 -5.921145943641752e+00 -5.993238971750428e+00 4.087810943819987e+00 4.673841620059919e+00 9.196298636957279e+03 + 148160 1.071815776840783e+00 -6.051876100443477e+00 -6.008621357440243e+00 3.384210343631415e+00 4.632585771605832e+00 9.243532657775057e+03 + 148180 9.992446589319506e-01 -5.987876599243604e+00 -5.995270310163996e+00 3.768625965465616e+00 4.726170133187658e+00 9.202539005389444e+03 + 148200 9.823963588612952e-01 -6.001933566777624e+00 -6.022712139827997e+00 3.636809966221827e+00 4.517496184292795e+00 9.286873264001473e+03 + 148220 9.669405379291510e-01 -6.011315598160169e+00 -5.988747176637188e+00 3.639464770093199e+00 4.769056138930098e+00 9.182537387176979e+03 + 148240 9.707408070311156e-01 -6.040425775450682e+00 -6.008020494168271e+00 3.469343917228231e+00 4.655420057052907e+00 9.241697087399272e+03 + 148260 1.035665193284576e+00 -6.154289405205023e+00 -5.946763961625512e+00 2.879130338440278e+00 5.070773549932433e+00 9.054364677815061e+03 + 148280 9.322460711401074e-01 -6.012039112926700e+00 -5.969594321874745e+00 3.660114884046313e+00 4.903839442576823e+00 9.123927180542354e+03 + 148300 9.723214690843799e-01 -6.076039871552551e+00 -5.948413390324299e+00 3.291610179941796e+00 5.024461185288553e+00 9.059371585573192e+03 + 148320 9.144314542076902e-01 -5.988968609133354e+00 -5.977142859541797e+00 3.711314469251220e+00 4.779219753434777e+00 9.147007417106825e+03 + 148340 8.935731426841854e-01 -5.949948092050392e+00 -6.031430585366335e+00 3.960722108977431e+00 4.492837022982197e+00 9.313769739493915e+03 + 148360 9.515095075674967e-01 -6.021118859705171e+00 -6.061963860269025e+00 3.553052072111833e+00 4.318513758130775e+00 9.408263786677378e+03 + 148380 1.023188399652470e+00 -6.110826104607579e+00 -6.004775775263755e+00 3.095189859317913e+00 4.704147261645579e+00 9.231728861009960e+03 + 148400 9.407457804954813e-01 -5.969995747760130e+00 -6.047634160491102e+00 3.821901665198411e+00 4.376089884791631e+00 9.363865517783128e+03 + 148420 9.748040223817566e-01 -5.999416818784296e+00 -6.020425516284509e+00 3.713418919028129e+00 4.592783726896474e+00 9.279862961688630e+03 + 148440 9.668702039318871e-01 -5.965552349896316e+00 -5.994828264505294e+00 3.856386793442029e+00 4.688279961324133e+00 9.201178264107370e+03 + 148460 1.049285860258161e+00 -6.061430636816282e+00 -5.992923938795249e+00 3.387451809300959e+00 4.780827870714985e+00 9.195312208086449e+03 + 148480 9.810158197886344e-01 -5.930604072492649e+00 -6.011303725330099e+00 4.029513584565181e+00 4.566123689741626e+00 9.251745270312767e+03 + 148500 1.045617725301525e+00 -5.997937299287655e+00 -5.949185706359288e+00 3.737923410747851e+00 5.017862601627152e+00 9.061681319381381e+03 + 148520 1.040176947167913e+00 -5.959170632280092e+00 -5.993343400319155e+00 3.835905114729825e+00 4.639679792430761e+00 9.196634851712159e+03 + 148540 1.045185820414581e+00 -5.938375215071079e+00 -6.010311574148719e+00 4.009339399202730e+00 4.596269693263331e+00 9.248725235567699e+03 + 148560 1.033678281157743e+00 -5.900003060165462e+00 -6.027050101342713e+00 4.223310966207553e+00 4.493787195301693e+00 9.300271513396028e+03 + 148580 1.097623023198674e+00 -5.978423912949175e+00 -5.996017957787000e+00 3.843967858206426e+00 4.742940130077997e+00 9.204821184668708e+03 + 148600 1.039978320760284e+00 -5.883278883874817e+00 -6.008621055668701e+00 4.337510300638531e+00 4.617776153559651e+00 9.243518549319018e+03 + 148620 1.054520060206707e+00 -5.902400618177001e+00 -6.037798217225731e+00 4.232435696301248e+00 4.454961729852702e+00 9.333419185118173e+03 + 148640 1.115851253827198e+00 -6.000320419253126e+00 -5.981912487827808e+00 3.729022284092280e+00 4.834723474954638e+00 9.161610597513662e+03 + 148660 1.028294169045532e+00 -5.892113103142711e+00 -6.043798910559989e+00 4.261194757664579e+00 4.390191378171738e+00 9.351971302715123e+03 + 148680 1.063687371177248e+00 -5.995280690933463e+00 -6.019100285918626e+00 3.731581511620093e+00 4.594805711144875e+00 9.275750424963348e+03 + 148700 1.072823550576143e+00 -6.087409642851145e+00 -5.946784701706004e+00 3.272802833314489e+00 5.080293007009194e+00 9.054389706902370e+03 + 148720 9.674030203615400e-01 -6.000648003358686e+00 -6.002137259285471e+00 3.661284322009833e+00 4.652732784016623e+00 9.223600354090438e+03 + 148740 9.596961167806284e-01 -6.033572019499799e+00 -6.009646072639419e+00 3.471912143543500e+00 4.609298632944110e+00 9.246694254694086e+03 + 148760 9.735577732677104e-01 -6.082877810935974e+00 -5.966801437354873e+00 3.266246124213491e+00 4.932774624076936e+00 9.115409807316104e+03 + 148780 9.114042096614414e-01 -6.007037815285586e+00 -5.988352337469872e+00 3.647955809972905e+00 4.755250715159081e+00 9.181297375522645e+03 + 148800 9.653249093118530e-01 -6.092863021163510e+00 -5.969005493623625e+00 3.186354777918500e+00 4.897563867942967e+00 9.122157302574069e+03 + 148820 9.360867831092657e-01 -6.048240659754943e+00 -6.022701146303866e+00 3.459523449847112e+00 4.606175288310125e+00 9.286881512180533e+03 + 148840 9.296835894333775e-01 -6.034656820689941e+00 -6.000666213089888e+00 3.501926787832102e+00 4.697106116701136e+00 9.219123010809752e+03 + 148860 9.387286991731654e-01 -6.038641610248070e+00 -6.021643393211842e+00 3.477435800240559e+00 4.575042192928167e+00 9.283617805687640e+03 + 148880 9.371735946827094e-01 -6.022089092689532e+00 -5.958880906174485e+00 3.634588780896290e+00 4.997539969300945e+00 9.091244228871992e+03 + 148900 9.628851934134424e-01 -6.038586799431149e+00 -5.974211392858101e+00 3.457684782422162e+00 4.827338329026575e+00 9.138011684075482e+03 + 148920 9.671657612421298e-01 -6.016729941885223e+00 -5.967266101290315e+00 3.572049339900338e+00 4.856078367100891e+00 9.116821589051793e+03 + 148940 9.910974443422421e-01 -6.018594582422983e+00 -5.978354903783978e+00 3.611518750405180e+00 4.842581212220493e+00 9.150710678172176e+03 + 148960 9.965543575983603e-01 -5.994412651333611e+00 -5.980848897073262e+00 3.690366951600623e+00 4.768252127547738e+00 9.158346971285351e+03 + 148980 9.911613949063609e-01 -5.957504842392112e+00 -5.977423252501223e+00 3.955328204423023e+00 4.840953611212499e+00 9.147840854367216e+03 + 149000 1.096188195311424e+00 -6.084687879232021e+00 -5.961800512235048e+00 3.204122333306647e+00 4.909760611361849e+00 9.100178088891196e+03 + 149020 1.106617647704829e+00 -6.076046103448572e+00 -5.992093027790265e+00 3.298630519753476e+00 4.780702071879949e+00 9.192805353652851e+03 + 149040 1.012147902498857e+00 -5.920939655720176e+00 -6.025646712943272e+00 4.099094169359862e+00 4.497850043420100e+00 9.295958765515763e+03 + 149060 1.024953533835675e+00 -5.931014902560691e+00 -6.021250537233001e+00 4.054177098243014e+00 4.536030120035274e+00 9.282410120670780e+03 + 149080 1.040362845918087e+00 -5.949395587618832e+00 -6.023247022340305e+00 3.994354679890840e+00 4.570288313247550e+00 9.288523237282736e+03 + 149100 1.017231410193722e+00 -5.915520430266268e+00 -6.030867027202559e+00 4.150416863362155e+00 4.488078853925786e+00 9.312034258455731e+03 + 149120 1.048133035371628e+00 -5.967450375527211e+00 -6.008666551842436e+00 3.823593595809303e+00 4.586923933224607e+00 9.243681816153889e+03 + 149140 1.042882584617541e+00 -5.971285644936812e+00 -5.981912148591155e+00 3.865547246533051e+00 4.804528218103691e+00 9.161583131570294e+03 + 149160 1.020316611151886e+00 -5.952314756652462e+00 -6.067826497433265e+00 3.916980056624818e+00 4.253693765677328e+00 9.426405182410697e+03 + 149180 1.059858456080144e+00 -6.032343747637514e+00 -6.028270894690387e+00 3.503541250690763e+00 4.526928202585121e+00 9.304057576906105e+03 + 149200 1.059593940880772e+00 -6.063905955611578e+00 -6.002797552033588e+00 3.382443527553797e+00 4.733337437393505e+00 9.225648126764341e+03 + 149220 1.021115452884911e+00 -6.045166922671984e+00 -6.003396158997912e+00 3.483486739646831e+00 4.723340928668140e+00 9.227481572258159e+03 + 149240 1.018458318987525e+00 -6.084758680091620e+00 -5.992817407331193e+00 3.282781016533777e+00 4.810722032590128e+00 9.195015841856368e+03 + 149260 9.227360996230455e-01 -5.981606225385570e+00 -6.016331166048795e+00 3.851471389287807e+00 4.652075406332364e+00 9.267236949185159e+03 + 149280 9.215886030002320e-01 -6.008380907595485e+00 -5.973456894336954e+00 3.642970651825597e+00 4.843509740429663e+00 9.135757775263357e+03 + 149300 1.018622970143336e+00 -6.167002374564963e+00 -5.974561866224058e+00 2.791285811119166e+00 4.896308990085062e+00 9.139140983699554e+03 + 149320 9.528019492473957e-01 -6.076233856804047e+00 -6.032527009528703e+00 3.268460436957420e+00 4.519431917625200e+00 9.317181210000415e+03 + 149340 9.468190235283297e-01 -6.070362788540357e+00 -6.023491164542353e+00 3.372791493947429e+00 4.641935612304337e+00 9.289292021585863e+03 + 149360 9.849219178056967e-01 -6.124710046372337e+00 -6.003413497673040e+00 3.008609749437810e+00 4.705113302649426e+00 9.227543632783560e+03 + 149380 9.373843069248727e-01 -6.048480039846679e+00 -6.022449230104545e+00 3.459500720473126e+00 4.608973658267250e+00 9.286092423586151e+03 + 149400 9.824083115556387e-01 -6.105904662879393e+00 -5.994663711215633e+00 3.130084146533054e+00 4.768846905467996e+00 9.200680694868573e+03 + 149420 9.634066652983554e-01 -6.065115966679685e+00 -6.014598609743746e+00 3.335275550440093e+00 4.625354031501976e+00 9.261928449734736e+03 + 149440 9.283876703378153e-01 -5.999043126881118e+00 -6.028197630478475e+00 3.662927835490395e+00 4.495518164189525e+00 9.303801796941987e+03 + 149460 9.736813109845882e-01 -6.050645234161428e+00 -5.988583294494513e+00 3.448146742840820e+00 4.804516004462376e+00 9.182042923562312e+03 + 149480 9.957145815454619e-01 -6.067043598743706e+00 -6.002426979277081e+00 3.279516659550906e+00 4.650555287917816e+00 9.224501519608206e+03 + 149500 9.796832656481813e-01 -6.027584651381940e+00 -5.988418425978116e+00 3.590955053132103e+00 4.815853580354656e+00 9.181524737303094e+03 + 149520 9.344002661537461e-01 -5.943219959809978e+00 -6.061694037735867e+00 3.942420695015516e+00 4.262124205760756e+00 9.407392638792064e+03 + 149540 1.009045240486583e+00 -6.036924696231344e+00 -6.006785802957721e+00 3.522086190476694e+00 4.695148379632499e+00 9.237886069432136e+03 + 149560 9.340532261769188e-01 -5.910736129731853e+00 -6.029749957909614e+00 4.131380954067493e+00 4.447985135340402e+00 9.308612334763460e+03 + 149580 1.018208148959573e+00 -6.021231933840252e+00 -5.996629543986348e+00 3.578944302635157e+00 4.720215032383799e+00 9.206708468871504e+03 + 149600 1.017792388228405e+00 -6.007337296140144e+00 -6.024663375868839e+00 3.646080524062210e+00 4.546591493057873e+00 9.292915783282600e+03 + 149620 1.044760954073430e+00 -6.037833125943477e+00 -6.011765151249055e+00 3.443446545579238e+00 4.593132890280660e+00 9.253215387966931e+03 + 149640 1.002929192699069e+00 -5.970293719647144e+00 -5.979647420260521e+00 3.863459392518133e+00 4.809748996115633e+00 9.154675739358778e+03 + 149660 9.839124563199826e-01 -5.937109767536231e+00 -5.955278213404253e+00 4.021054214762629e+00 4.916728187030530e+00 9.080256273685625e+03 + 149680 1.013783392358900e+00 -5.975080015888973e+00 -5.974069196723041e+00 3.821546661396524e+00 4.827350941471061e+00 9.137618100331541e+03 + 149700 9.708893972847361e-01 -5.904220188477254e+00 -6.033189294726482e+00 4.224988243853148e+00 4.484427677865386e+00 9.319218144336277e+03 + 149720 1.015390738107077e+00 -5.967166511206442e+00 -6.059709888637153e+00 3.841779269211397e+00 4.310380874962881e+00 9.401262335581490e+03 + 149740 1.021953421127690e+00 -5.977311468980105e+00 -6.033163730482904e+00 3.791413926772328e+00 4.470701598113719e+00 9.319154424346669e+03 + 149760 9.870737393122601e-01 -5.931671866181235e+00 -6.007864022540730e+00 4.035047531805528e+00 4.597540379291216e+00 9.241211028508807e+03 + 149780 1.014859726900752e+00 -5.982232950205913e+00 -5.994618423454178e+00 3.766366341800704e+00 4.695247037763380e+00 9.200538762478012e+03 + 149800 9.747806111225863e-01 -5.937804101835932e+00 -6.032726317088526e+00 3.937322836883411e+00 4.392264787737678e+00 9.317797872616869e+03 + 149820 9.662765851986340e-01 -5.952288627258438e+00 -6.024821681919087e+00 3.975776386274512e+00 4.559280361959135e+00 9.293400347746676e+03 + 149840 8.632469379255969e-01 -5.842964531120230e+00 -6.049665733675299e+00 4.502225004248849e+00 4.315314712269920e+00 9.370117745622576e+03 + 149860 9.875290521982237e-01 -6.078115556610828e+00 -5.980792188974798e+00 3.264481283789447e+00 4.823327121497998e+00 9.158196109320717e+03 + 149880 9.225497323211401e-01 -6.031228393563124e+00 -5.997756575143518e+00 3.572717016935457e+00 4.764917378047997e+00 9.210164152427380e+03 + 149900 9.316963760499051e-01 -6.082020848520450e+00 -6.012003727442896e+00 3.258238607225748e+00 4.660287751567532e+00 9.253934711503098e+03 + 149920 9.613321699146622e-01 -6.150838607426984e+00 -5.980545411690557e+00 2.885088108375474e+00 4.862937991080913e+00 9.157437264502747e+03 + 149940 9.892168127309307e-01 -6.206042995140859e+00 -5.987352742249969e+00 2.557410013226939e+00 4.813163287533692e+00 9.178292404109716e+03 + 149960 8.828202938057288e-01 -6.053479707199010e+00 -6.000047822407321e+00 3.416920862824926e+00 4.723735013856252e+00 9.217227322888964e+03 + 149980 9.387988409005733e-01 -6.133439438764023e+00 -5.982531475860911e+00 2.965811876610625e+00 4.832348752532077e+00 9.163522137512206e+03 + 150000 8.773533104870720e-01 -6.029848249464694e+00 -6.018857162379883e+00 3.524991508146165e+00 4.588104031052383e+00 9.275034662099568e+03 + 150020 9.289321335003504e-01 -6.084334420390995e+00 -5.991313613143171e+00 3.266793787659894e+00 4.800933657800299e+00 9.190410336577786e+03 + 150040 8.419763074105849e-01 -5.926324404908343e+00 -6.043969876362475e+00 4.065325314821750e+00 4.389786812154260e+00 9.352537226507156e+03 + 150060 9.561185106377023e-01 -6.061479005603272e+00 -6.013462996915885e+00 3.297772323287714e+00 4.573487675624022e+00 9.258431549530644e+03 + 150080 9.932488182492362e-01 -6.080801924718049e+00 -5.985687789738340e+00 3.236740285710431e+00 4.782900367628740e+00 9.173170518501653e+03 + 150100 9.598825592664251e-01 -5.997764405659390e+00 -5.998030642645632e+00 3.715606391759910e+00 4.714077617784867e+00 9.211008826165940e+03 + 150120 9.942292106453476e-01 -6.020674409324942e+00 -5.977343307035691e+00 3.593232820249548e+00 4.842046715060831e+00 9.147625648534042e+03 + 150140 9.607506765887810e-01 -5.948383647249267e+00 -5.972664047200150e+00 3.996085399918841e+00 4.856663586021127e+00 9.133304005552283e+03 + 150160 1.019333985721495e+00 -6.015137062101235e+00 -5.986104907092463e+00 3.582513100514222e+00 4.749220227286053e+00 9.174442777719923e+03 + 150180 9.927637948995944e-01 -5.960512738898636e+00 -5.991109367967271e+00 3.895148252771027e+00 4.719457673845884e+00 9.189785176742227e+03 + 150200 1.023511764524766e+00 -5.993816716226081e+00 -6.004460329818900e+00 3.734071992067279e+00 4.672954715723431e+00 9.230715265606261e+03 + 150220 1.060198046434023e+00 -6.038724989466267e+00 -6.008158223925647e+00 3.486915535642436e+00 4.662434633568359e+00 9.242103816205254e+03 + 150240 9.848638118726182e-01 -5.921904859953719e+00 -6.024118511054717e+00 4.072288474255436e+00 4.485361872122119e+00 9.291237899293639e+03 + 150260 1.028133659895182e+00 -5.983732832074012e+00 -5.999660091420660e+00 3.798978829378284e+00 4.707522041474413e+00 9.216016252697727e+03 + 150280 1.021456766331944e+00 -5.973563808355188e+00 -6.038168447756642e+00 3.836466134034373e+00 4.465496297055584e+00 9.334589666152433e+03 + 150300 9.915445232394130e-01 -5.932077797195295e+00 -6.049606584171595e+00 4.049183194623947e+00 4.374314712285025e+00 9.369976349495757e+03 + 150320 1.039461328091913e+00 -6.011206751955931e+00 -6.023905529973336e+00 3.658510340871607e+00 4.585591992366117e+00 9.290581042734677e+03 + 150340 9.746454285653234e-01 -5.925893286041009e+00 -6.035330107825645e+00 4.061980876868432e+00 4.433577710887608e+00 9.325812071087876e+03 + 150360 1.056174956252247e+00 -6.062340574563990e+00 -5.983980631667654e+00 3.353396750310526e+00 4.803351668583262e+00 9.167924468030569e+03 + 150380 9.527306757765671e-01 -5.927335389854666e+00 -5.960662628471865e+00 4.116376200448213e+00 4.925006038934749e+00 9.096673503921229e+03 + 150400 9.973850333784239e-01 -6.012180496926310e+00 -5.979766266652777e+00 3.579110940666666e+00 4.765238466983215e+00 9.155035590494108e+03 + 150420 9.459713632607548e-01 -5.957843061750874e+00 -6.018729734253497e+00 3.967934027123067e+00 4.618313331430891e+00 9.274632666153362e+03 + 150440 9.619378058965578e-01 -6.008876452242495e+00 -6.003036572622412e+00 3.628535754190940e+00 4.662069246687912e+00 9.226372963290802e+03 + 150460 9.677870245435928e-01 -6.051114696796739e+00 -6.012999008659961e+00 3.408255600757694e+00 4.627121780422755e+00 9.256989681637668e+03 + 150480 9.415356369057095e-01 -6.048267221669925e+00 -5.984904618868681e+00 3.424790597269871e+00 4.788628467885710e+00 9.170777973731023e+03 + 150500 9.374038095278562e-01 -6.075945083395894e+00 -5.991402903085043e+00 3.306309627671041e+00 4.791763909876067e+00 9.190673462104967e+03 + 150520 9.539955340314616e-01 -6.129605095403642e+00 -5.991447057325193e+00 3.023550935559805e+00 4.816875770093553e+00 9.190798213987859e+03 + 150540 8.940313886623629e-01 -6.063995128791780e+00 -5.962383696433268e+00 3.327637938828806e+00 4.911106507749720e+00 9.101946953438424e+03 + 150560 9.084140310803310e-01 -6.098125327512221e+00 -5.989685571742864e+00 3.159547806574701e+00 4.782225665200318e+00 9.185423203669785e+03 + 150580 8.878367627652330e-01 -6.071509962499022e+00 -6.013876460590240e+00 3.253182886485816e+00 4.584123373201636e+00 9.259710195205791e+03 + 150600 9.087060588340793e-01 -6.096770947525507e+00 -5.983170818955180e+00 3.182483382036725e+00 4.834792899850623e+00 9.165474729660546e+03 + 150620 9.234718489644897e-01 -6.102986914784077e+00 -6.003122099909126e+00 3.106348813433913e+00 4.679788034476042e+00 9.226632468606695e+03 + 150640 8.688467744595743e-01 -5.991935564270508e+00 -6.008745540012717e+00 3.702137232971948e+00 4.605611750924849e+00 9.243923061842683e+03 + 150660 8.832693643510025e-01 -5.966637009372232e+00 -6.020638689331130e+00 3.911733836567312e+00 4.601647833510358e+00 9.280528247987715e+03 + 150680 1.073117110661551e+00 -6.188014779940824e+00 -6.016806323937202e+00 2.665629303117458e+00 4.648734751913192e+00 9.268735726030436e+03 + 150700 9.816310940494757e-01 -6.003881294393033e+00 -6.042912153292324e+00 3.638919496792345e+00 4.414798264986721e+00 9.349261410826904e+03 + 150720 9.581149634529368e-01 -5.937825560560106e+00 -6.022934882044843e+00 4.092872249295437e+00 4.604161354705145e+00 9.287602122759416e+03 + 150740 1.095273691591849e+00 -6.123179355354659e+00 -5.982342817150593e+00 3.052832464632560e+00 4.861537661384158e+00 9.162918999138285e+03 + 150760 9.339548604721137e-01 -5.872339427512746e+00 -6.012153510854307e+00 4.373519479442733e+00 4.570685376736022e+00 9.254389755215028e+03 + 150780 1.021718467060454e+00 -5.992846371446692e+00 -6.008531041303730e+00 3.750129816798739e+00 4.660066015284810e+00 9.243262215669227e+03 + 150800 1.020821067758811e+00 -5.986064685071893e+00 -6.053197066832262e+00 3.704147778049007e+00 4.318663253278464e+00 9.381074741867240e+03 + 150820 9.692671086257949e-01 -5.908974282948363e+00 -6.014958324294692e+00 4.177365806799305e+00 4.568789040411296e+00 9.263018660193466e+03 + 150840 1.034022245569062e+00 -6.005436407859200e+00 -5.997166741905411e+00 3.725443191545096e+00 4.772928893178428e+00 9.208339793878968e+03 + 150860 1.009576847856824e+00 -5.969473489627489e+00 -5.987356756760285e+00 3.902160053696462e+00 4.799471566393300e+00 9.178273407156787e+03 + 150880 1.082558511121473e+00 -6.079592779551439e+00 -5.970434599788804e+00 3.329639284681543e+00 4.956442445052321e+00 9.126525325461302e+03 + 150900 1.013234181444743e+00 -5.982688851436196e+00 -6.003135626790179e+00 3.761875104075942e+00 4.644466555865109e+00 9.226668203241579e+03 + 150920 9.783288508787957e-01 -5.938784116057776e+00 -6.039999146979610e+00 3.991545663245798e+00 4.410353292717215e+00 9.340232821511836e+03 + 150940 1.056281567220214e+00 -6.064461777282776e+00 -6.010311807607811e+00 3.372235219005565e+00 4.683172724559939e+00 9.248754355026709e+03 + 150960 9.797588514600295e-01 -5.964911030375053e+00 -6.009964269721258e+00 3.907563673592855e+00 4.648861001300691e+00 9.247655626710870e+03 + 150980 1.033725984597089e+00 -6.061710552635518e+00 -5.948158634205329e+00 3.443476119663019e+00 5.095508807391748e+00 9.058570174488996e+03 + 151000 9.804216615056182e-01 -6.000248376998947e+00 -5.974583104654544e+00 3.715573966028643e+00 4.862947931518267e+00 9.139179196906896e+03 + 151020 9.860704884418690e-01 -6.028116232507712e+00 -5.933167968001682e+00 3.590944317569471e+00 5.136151945559536e+00 9.013006785218739e+03 + 151040 9.559084821690419e-01 -5.999531857991830e+00 -5.931141125532753e+00 3.694811142546817e+00 5.087521311758477e+00 9.006841471567232e+03 + 151060 9.539305224329071e-01 -6.007545895623976e+00 -5.965250938625566e+00 3.633102634693068e+00 4.875966822901384e+00 9.110657819587914e+03 + 151080 9.856274609330224e-01 -6.063794463166113e+00 -5.978345986879818e+00 3.299688405741642e+00 4.790346779686518e+00 9.150667520224411e+03 + 151100 9.303909834606774e-01 -5.988312093219127e+00 -5.967726812648809e+00 3.737107574142533e+00 4.855311440739169e+00 9.118248977836540e+03 + 151120 9.616874039440702e-01 -6.036852677738136e+00 -5.988462573874281e+00 3.449601032436915e+00 4.727464497167547e+00 9.181652998427980e+03 + 151140 9.785067504417249e-01 -6.060632728667542e+00 -5.997958842306435e+00 3.331100590556848e+00 4.690983744794894e+00 9.210804865262598e+03 + 151160 9.264877239537771e-01 -5.978701661913051e+00 -6.009919647295771e+00 3.814672373322037e+00 4.635413870286833e+00 9.247517258799780e+03 + 151180 9.577765071995964e-01 -6.014906354921859e+00 -5.982977370738742e+00 3.562549375195529e+00 4.745890543369319e+00 9.164839641366083e+03 + 151200 9.521994086116360e-01 -5.986769416941264e+00 -5.971148887319202e+00 3.747589569104230e+00 4.837285067463259e+00 9.128683767482315e+03 + 151220 9.740138448061736e-01 -5.988744227627172e+00 -5.974614353503411e+00 3.737957425331325e+00 4.819093349140913e+00 9.139274580429214e+03 + 151240 1.005925658295044e+00 -5.997956578600248e+00 -5.984814302557895e+00 3.681253644568615e+00 4.756718627364448e+00 9.170504772255656e+03 + 151260 1.009872827131000e+00 -5.962449973136058e+00 -6.037080873575629e+00 3.868748051212484e+00 4.440205871793952e+00 9.331212858126033e+03 + 151280 1.073244167001375e+00 -6.020876327872808e+00 -5.990865063168961e+00 3.565074690439205e+00 4.737404016596900e+00 9.189041829501741e+03 + 151300 1.039692089841699e+00 -5.943681822961341e+00 -6.015167847610062e+00 3.985004281949398e+00 4.574520465989876e+00 9.263667585855555e+03 + 151320 1.023731823154914e+00 -5.900321409915273e+00 -6.010119120881022e+00 4.234149556101451e+00 4.603674108595265e+00 9.248128272823189e+03 + 151340 1.072018850773465e+00 -5.958925288679311e+00 -6.014028277468061e+00 3.885131155078775e+00 4.568721266293818e+00 9.260158023337488e+03 + 151360 1.008015682531468e+00 -5.858973563515301e+00 -6.071577588533894e+00 4.426560381382772e+00 4.205755169359468e+00 9.438038268555507e+03 + 151380 1.022390159305904e+00 -5.882793648990144e+00 -6.016734435561163e+00 4.279296325563888e+00 4.510187601803366e+00 9.268450691768705e+03 + 151400 1.008224343271581e+00 -5.868837290555525e+00 -6.014116079064953e+00 4.479966479818367e+00 4.645753194377371e+00 9.260399609190876e+03 + 151420 1.054916404981742e+00 -5.950528044724011e+00 -6.028924041429839e+00 3.943063561061342e+00 4.492901616235194e+00 9.306042393612008e+03 + 151440 1.063884087622961e+00 -5.985547566512386e+00 -5.959838303523109e+00 3.856615285314353e+00 5.004241851894369e+00 9.094150327431711e+03 + 151460 9.681430709057014e-01 -5.870435384758603e+00 -5.983135607512210e+00 4.468469972691453e+00 4.821327853337135e+00 9.165309804379149e+03 + 151480 1.047060894687514e+00 -6.016467238812702e+00 -5.984922287915309e+00 3.626050491523698e+00 4.807186481141898e+00 9.170794708639874e+03 + 151500 1.030223143782326e+00 -6.026553885446074e+00 -5.996529269243444e+00 3.523172165716107e+00 4.695578158245949e+00 9.206403431760835e+03 + 151520 9.630495693371202e-01 -5.963115532846690e+00 -5.979854033688142e+00 3.894607031885916e+00 4.798491969779674e+00 9.155274120999275e+03 + 151540 9.576202327337099e-01 -5.983457745797613e+00 -6.009062275915690e+00 3.778571855733494e+00 4.631546681507258e+00 9.244876436539596e+03 + 151560 9.918334627799483e-01 -6.057013837531033e+00 -6.040377649428798e+00 3.375238969389359e+00 4.470766535914184e+00 9.341422868928641e+03 + 151580 9.303592964179678e-01 -5.987642258950951e+00 -6.027414253685720e+00 3.743458326258955e+00 4.515081377795620e+00 9.301392859575204e+03 + 151600 9.370606507245728e-01 -6.009274790109130e+00 -6.001034139615810e+00 3.664610918004958e+00 4.711930008374140e+00 9.220196731161759e+03 + 151620 1.005923512469055e+00 -6.114915451633760e+00 -5.978337710521302e+00 3.072512690482978e+00 4.856763215287841e+00 9.150670938959316e+03 + 151640 9.815152394079441e-01 -6.078282075657696e+00 -5.982590612192332e+00 3.265955368660587e+00 4.815430560084817e+00 9.163703026791452e+03 + 151660 8.853520877753709e-01 -5.931074351547274e+00 -6.020446008651648e+00 4.011626723605684e+00 4.498440838293128e+00 9.279906566311180e+03 + 151680 9.715879526308547e-01 -6.051698666551225e+00 -5.989575680231240e+00 3.390841335697622e+00 4.747561136648043e+00 9.185082385204074e+03 + 151700 9.712433531137389e-01 -6.042563489753583e+00 -6.021119525060909e+00 3.429328470242360e+00 4.552463033950504e+00 9.281992488378733e+03 + 151720 1.016535527391153e+00 -6.101649794882733e+00 -5.939755981345416e+00 3.195840580937303e+00 5.125459911255252e+00 9.033040642703965e+03 + 151740 9.575321000972211e-01 -6.003072399301122e+00 -5.985249025303032e+00 3.725378238613927e+00 4.827722810269175e+00 9.171691277167934e+03 + 151760 9.828078329456489e-01 -6.027124726835721e+00 -5.989025855677907e+00 3.576125221030973e+00 4.794894835000399e+00 9.183352838935720e+03 + 151780 1.044737469821037e+00 -6.104267121098460e+00 -5.979933082539068e+00 3.165414818564888e+00 4.879360108603205e+00 9.155536543719123e+03 + 151800 8.988750397840366e-01 -5.873125620899970e+00 -6.048185763519117e+00 4.329029257937939e+00 4.323806828549286e+00 9.365566493268152e+03 + 151820 9.835669982383161e-01 -5.982931956056682e+00 -6.042160813560942e+00 3.744865139705506e+00 4.404763874279967e+00 9.346939662628591e+03 + 151840 9.259984763818158e-01 -5.882221189169056e+00 -6.052255620353236e+00 4.289697625386172e+00 4.313333608783422e+00 9.378156446838357e+03 + 151860 1.025361168244824e+00 -6.013965479128006e+00 -6.020564443816038e+00 3.587510879856367e+00 4.549618603431210e+00 9.280302652742863e+03 + 151880 9.773980035022569e-01 -5.928479918812855e+00 -6.056095266141819e+00 4.073032959149810e+00 4.340245886375719e+00 9.390038724862903e+03 + 151900 1.082295238372089e+00 -6.071618694785818e+00 -5.974526780414257e+00 3.330163865049538e+00 4.887680662296235e+00 9.139025076284908e+03 + 151920 9.876885591413468e-01 -5.919723258125781e+00 -6.034748874609768e+00 4.075165414161352e+00 4.414670524153672e+00 9.324036353579080e+03 + 151940 1.030334289617298e+00 -5.973147627230021e+00 -6.024078016763076e+00 3.856409754996914e+00 4.563959576845804e+00 9.291107507194823e+03 + 151960 1.027825328229850e+00 -5.963007691079177e+00 -5.989432027622762e+00 3.835847975073889e+00 4.684115345487760e+00 9.184628295104792e+03 + 151980 1.001330806029908e+00 -5.920390493987311e+00 -5.998205899943780e+00 4.127218474266050e+00 4.680390371368849e+00 9.211516707596003e+03 + 152000 1.015355174945420e+00 -5.935442463173820e+00 -6.018574967232228e+00 4.070013990449988e+00 4.592654287433191e+00 9.274136468945466e+03 + 152020 1.081813467003885e+00 -6.029654134816251e+00 -6.014161044426606e+00 3.582904013860103e+00 4.671867736425437e+00 9.260582671327156e+03 + 152040 1.037953212335328e+00 -5.966347477335904e+00 -6.068227140814313e+00 3.876492615983507e+00 4.291483822463510e+00 9.427671495981609e+03 + 152060 1.042095738753555e+00 -5.982448839982646e+00 -6.007450852070577e+00 3.864374405047108e+00 4.720808982589341e+00 9.239932494047756e+03 + 152080 9.794305189039816e-01 -5.907004524235669e+00 -6.064864602938482e+00 4.203234571511945e+00 4.296777570832160e+00 9.417250112761336e+03 + 152100 1.021663222204000e+00 -5.996188384581353e+00 -6.022247892302862e+00 3.715129803864927e+00 4.565492077832233e+00 9.285475485894372e+03 + 152120 1.040839163497207e+00 -6.057657478328912e+00 -5.992201775178495e+00 3.383848341599931e+00 4.759705118326952e+00 9.193106887712018e+03 + 152140 1.000044606562817e+00 -6.030115557757036e+00 -5.959433690630225e+00 3.533266957785017e+00 4.939133176810760e+00 9.092923403764800e+03 + 152160 1.000880381887789e+00 -6.061078376329917e+00 -5.979474777488071e+00 3.448413554342193e+00 4.916994047008182e+00 9.154128108972969e+03 + 152180 9.712034851487680e-01 -6.043096442946593e+00 -5.964222751135901e+00 3.484632520097508e+00 4.937537464138856e+00 9.107535460703170e+03 + 152200 9.603007374470393e-01 -6.047671836745419e+00 -6.018037217215871e+00 3.423771937966564e+00 4.593938509247780e+00 9.272506898698419e+03 + 152220 9.370524167970798e-01 -6.030132613358297e+00 -5.990923113446842e+00 3.542188524449824e+00 4.767335540591898e+00 9.189203137627159e+03 + 152240 9.573493798364791e-01 -6.070803929099231e+00 -5.973892412232568e+00 3.320533064730031e+00 4.877013991587175e+00 9.137068212266357e+03 + 152260 9.523481610136985e-01 -6.067791195923206e+00 -5.940324780667311e+00 3.354390512954885e+00 5.086322394718250e+00 9.034756108495465e+03 + 152280 9.864782413382789e-01 -6.114254925493487e+00 -5.963668304682616e+00 3.098353197140499e+00 4.963044877040778e+00 9.105850966736412e+03 + 152300 9.773774086369922e-01 -6.089980655721680e+00 -5.980387616921889e+00 3.193648976765872e+00 4.822949165022218e+00 9.156947497431504e+03 + 152320 9.638526411570453e-01 -6.054686643516379e+00 -5.985352489018551e+00 3.371195864385506e+00 4.769323308937769e+00 9.172157197012124e+03 + 152340 9.691528967902641e-01 -6.040173225975279e+00 -5.986353691991471e+00 3.514947792239268e+00 4.823987884920259e+00 9.175206221658502e+03 + 152360 9.517683795231072e-01 -5.984674527507289e+00 -6.018418021492047e+00 3.765053783063300e+00 4.571293418814005e+00 9.273689087891498e+03 + 152380 9.857517840710753e-01 -5.999221694654436e+00 -6.035649638689151e+00 3.707334529059264e+00 4.498159637205812e+00 9.326798169050402e+03 + 152400 1.001255379129849e+00 -5.985954080450023e+00 -6.008238613528203e+00 3.795173110160781e+00 4.667211872705525e+00 9.242353457162309e+03 + 152420 9.860917047333877e-01 -5.930586569656579e+00 -6.054137637511012e+00 4.056503288656022e+00 4.347053937569910e+00 9.383974774732240e+03 + 152440 1.032156979254577e+00 -5.971027983236694e+00 -6.040551664364838e+00 3.870190660632621e+00 4.470974924839932e+00 9.341969681515313e+03 + 152460 1.073539670283112e+00 -6.014191584292018e+00 -6.018606990869822e+00 3.575893597387395e+00 4.550539649535686e+00 9.274282598233784e+03 + 152480 1.054752937150641e+00 -5.977079714251149e+00 -6.019800055081217e+00 3.820609406665752e+00 4.575302598668124e+00 9.277915650403069e+03 + 152500 1.050908941153667e+00 -5.967370213672618e+00 -5.973419625162750e+00 3.894287879353919e+00 4.859551222434183e+00 9.135620558263652e+03 + 152520 1.040968540786013e+00 -5.952142971830734e+00 -5.985397296160410e+00 3.941451062015685e+00 4.750499585624630e+00 9.172283084684434e+03 + 152540 1.024954192566925e+00 -5.932061695158469e+00 -6.010159924716710e+00 4.070582330331903e+00 4.622130210546524e+00 9.248259987511783e+03 + 152560 1.000227293617728e+00 -5.903879301634188e+00 -5.988143609018227e+00 4.198183265009614e+00 4.714324572151034e+00 9.180676165150888e+03 + 152580 9.876115562695748e-01 -5.892488653800219e+00 -5.994490256660736e+00 4.297302494384609e+00 4.711593506062491e+00 9.200125840671782e+03 + 152600 1.050421020675910e+00 -5.992504666241546e+00 -6.001227347422077e+00 3.763059729100105e+00 4.712972743930944e+00 9.220809001874206e+03 + 152620 1.014137077361775e+00 -5.948552526012344e+00 -6.022269238419342e+00 3.935680891902844e+00 4.512388121637489e+00 9.285547483828446e+03 + 152640 1.038796383240976e+00 -5.998477772226391e+00 -5.984128389589671e+00 3.737564334207746e+00 4.819960709867577e+00 9.168385496856494e+03 + 152660 9.869735669607721e-01 -5.932330099292184e+00 -6.029945406730527e+00 4.018663345993422e+00 4.458141144762448e+00 9.309194091121035e+03 + 152680 1.076054835242791e+00 -6.076265663758591e+00 -5.979191543845008e+00 3.326423352114141e+00 4.883837970829434e+00 9.153279074664359e+03 + 152700 9.589069949509454e-01 -5.912875144108061e+00 -6.015134784045298e+00 4.170643893376228e+00 4.583453216228476e+00 9.263549947360205e+03 + 152720 1.031658781988468e+00 -6.030201029613650e+00 -5.961455495691435e+00 3.572475940481894e+00 4.967223434600250e+00 9.099091279720553e+03 + 152740 1.033031667619511e+00 -6.039153330224023e+00 -6.000275687273328e+00 3.488212606324611e+00 4.711454048443304e+00 9.217883627263644e+03 + 152760 1.027884831121753e+00 -6.037827738280135e+00 -6.000084514037581e+00 3.474343738288650e+00 4.691071172634471e+00 9.217312255425126e+03 + 152780 9.889380109994573e-01 -5.987470837862720e+00 -6.002745168895943e+00 3.835529903003995e+00 4.747822330516133e+00 9.225472722484183e+03 + 152800 1.010643070218887e+00 -6.024734020767707e+00 -5.986782909610247e+00 3.612596512364478e+00 4.830517665546090e+00 9.176527689605848e+03 + 152820 9.909876627105110e-01 -5.999103417308512e+00 -6.020282969814867e+00 3.726691003607867e+00 4.605074735591215e+00 9.279438843452494e+03 + 152840 9.978607157796281e-01 -6.012214985140097e+00 -6.042423078315131e+00 3.635059288998320e+00 4.461599743299965e+00 9.347739563020819e+03 + 152860 9.999904024660496e-01 -6.019463100492636e+00 -6.000105765427922e+00 3.613561405079170e+00 4.724714218558672e+00 9.217371689191854e+03 + 152880 1.062025779116619e+00 -6.114555987182127e+00 -5.942588921107941e+00 3.098327152688484e+00 5.085788657903930e+00 9.041653874961674e+03 + 152900 9.563341480605191e-01 -5.960031296457307e+00 -5.978097824924878e+00 3.879322927885796e+00 4.775582125638759e+00 9.149934243844067e+03 + 152920 1.010118912642507e+00 -6.040885604728603e+00 -5.959455780873364e+00 3.495178406419227e+00 4.962761056220525e+00 9.093006930743597e+03 + 152940 9.473131694530033e-01 -5.944459304689596e+00 -5.994519481691917e+00 3.972254797953565e+00 4.684801514818889e+00 9.200210748084279e+03 + 152960 9.724403850721123e-01 -5.976117957523456e+00 -5.993088436338878e+00 3.833197038086845e+00 4.735749922555583e+00 9.195815586457788e+03 + 152980 1.020214655939091e+00 -6.040510469965291e+00 -5.991510425412859e+00 3.494712661858521e+00 4.776078500410973e+00 9.190973529994893e+03 + 153000 1.036208513022704e+00 -6.056937139204011e+00 -5.994601585996293e+00 3.377847630647137e+00 4.735788023561543e+00 9.200483600194679e+03 + 153020 1.005432042325397e+00 -6.006495203555549e+00 -6.025888226195338e+00 3.674321010947142e+00 4.562963273888923e+00 9.296701486592521e+03 + 153040 9.817217009391129e-01 -5.967779873149858e+00 -6.014253373316273e+00 3.873173013236408e+00 4.606314983529946e+00 9.260857832832948e+03 + 153060 1.045134922274149e+00 -6.059491960373935e+00 -5.984660889396656e+00 3.378600758307940e+00 4.808292347930290e+00 9.170023461272589e+03 + 153080 9.841610733559720e-01 -5.966959864027751e+00 -6.003596130659754e+00 3.865635617035342e+00 4.655264504590440e+00 9.228068751207287e+03 + 153100 1.011588263011098e+00 -6.006068397340584e+00 -5.967856703393823e+00 3.692577999550670e+00 4.911995459433493e+00 9.118601747728426e+03 + 153120 9.604399087472681e-01 -5.927041570140578e+00 -5.985635321437433e+00 4.131904280248286e+00 4.795449892948038e+00 9.172974449607886e+03 + 153140 9.994921451563397e-01 -5.979711958107544e+00 -5.990970227480188e+00 3.840343666496598e+00 4.775696941547314e+00 9.189339246094725e+03 + 153160 1.029755151423092e+00 -6.021815022036906e+00 -5.995820378722913e+00 3.553619448685116e+00 4.702884713252115e+00 9.204232800835862e+03 + 153180 1.008785376123178e+00 -5.991840981860378e+00 -5.956557867341031e+00 3.785405078761113e+00 4.988006182375529e+00 9.084166578796248e+03 + 153200 1.041430776479210e+00 -6.039017311073954e+00 -5.963638529906178e+00 3.551778589051776e+00 4.984615215345831e+00 9.105754736938788e+03 + 153220 9.924809992564678e-01 -5.965576228342496e+00 -6.010099023519222e+00 3.866525460170758e+00 4.610868680385707e+00 9.248093385596889e+03 + 153240 1.015216797484810e+00 -6.000813891056766e+00 -6.032402071057449e+00 3.641627650854867e+00 4.460243433035890e+00 9.316783622143643e+03 + 153260 9.609661311767491e-01 -5.923328935146872e+00 -6.003859629932724e+00 4.091258963669116e+00 4.628839252124010e+00 9.228898793606686e+03 + 153280 9.985982762031365e-01 -5.979767379599269e+00 -5.968068223205698e+00 3.867209384477118e+00 4.934387750927606e+00 9.119274682159141e+03 + 153300 1.076389353080526e+00 -6.094945620634140e+00 -5.987908791676844e+00 3.182536106422396e+00 4.797158142190934e+00 9.179968284644363e+03 + 153320 1.076586328014824e+00 -6.098111688109872e+00 -6.001849397094427e+00 3.172290553706237e+00 4.725043525258318e+00 9.222720917101580e+03 + 153340 9.927762874214089e-01 -5.980430863763656e+00 -6.013274909638803e+00 3.798689575640260e+00 4.610093981625495e+00 9.257826510823688e+03 + 153360 9.666837952282679e-01 -5.947078158254597e+00 -6.053402041733025e+00 3.966868506110016e+00 4.356340313609090e+00 9.381691747846204e+03 + 153380 9.631482864655275e-01 -5.947853564266724e+00 -6.022645295484957e+00 3.963640933651954e+00 4.534175239013861e+00 9.286705747666676e+03 + 153400 1.014427286364264e+00 -6.030631527040961e+00 -5.987913353289965e+00 3.522319945377023e+00 4.767614309671264e+00 9.179996354096897e+03 + 153420 9.340685669065637e-01 -5.918877450680126e+00 -6.013654735471023e+00 4.178151095164059e+00 4.633925259157311e+00 9.258995885542385e+03 + 153440 9.807819646158761e-01 -5.994889201052865e+00 -6.006613017960170e+00 3.710395799249074e+00 4.643075828312526e+00 9.237370468470430e+03 + 153460 1.026967331185860e+00 -6.070680330810350e+00 -5.987085322481212e+00 3.298253515491341e+00 4.778268989602980e+00 9.177445844123384e+03 + 153480 9.677969546783882e-01 -5.991023306128984e+00 -5.993473002966376e+00 3.751593625792819e+00 4.737527087463149e+00 9.196992055833793e+03 + 153500 9.871493374031156e-01 -6.024056524104576e+00 -5.986895008598643e+00 3.507942208806591e+00 4.721329381567601e+00 9.176856466689585e+03 + 153520 9.702727420678284e-01 -6.001941064799108e+00 -6.034820081623560e+00 3.664247077421193e+00 4.475450674803780e+00 9.324249344276872e+03 + 153540 9.687201100009538e-01 -6.004497623840043e+00 -5.983248322200403e+00 3.693569097263695e+00 4.815585875597312e+00 9.165698651493896e+03 + 153560 9.992654165071334e-01 -6.051343745146426e+00 -5.985503810566636e+00 3.440851893111725e+00 4.818914986165829e+00 9.172601683972123e+03 + 153580 1.001998014771537e+00 -6.054325555450640e+00 -6.009941513150544e+00 3.405597904069605e+00 4.660457943365106e+00 9.247597319865172e+03 + 153600 1.017681271815443e+00 -6.074972841205356e+00 -6.029819018655059e+00 3.274796754086502e+00 4.534076990701765e+00 9.308816357637232e+03 + 153620 1.027068376580897e+00 -6.086031925675162e+00 -5.967108622423098e+00 3.250904949782994e+00 4.933780960378046e+00 9.116352526268784e+03 + 153640 8.939361035895502e-01 -5.882454171864631e+00 -6.014859312011348e+00 4.389415601306393e+00 4.629124796954725e+00 9.262678467596124e+03 + 153660 9.907433298025076e-01 -6.013233662370320e+00 -6.035688474983740e+00 3.590577962861967e+00 4.461638953964687e+00 9.326940786957550e+03 + 153680 1.042359016160419e+00 -6.073193504609386e+00 -6.001180652384355e+00 3.334431854609424e+00 4.747940796038418e+00 9.220687668959170e+03 + 153700 1.034432099643915e+00 -6.042959654120679e+00 -6.029269754972689e+00 3.447670782721925e+00 4.526280302134733e+00 9.307112097156491e+03 + 153720 9.958678929352623e-01 -5.967220771498281e+00 -6.039410366388752e+00 3.876232231522560e+00 4.461708406357767e+00 9.338428940522075e+03 + 153740 1.008517056134427e+00 -5.965187922445955e+00 -6.060040630083936e+00 3.810435309180531e+00 4.265776383514171e+00 9.402283783208028e+03 + 153760 1.043815029446842e+00 -6.001079914927503e+00 -5.983060602316204e+00 3.758321013439192e+00 4.861790694932884e+00 9.165100237605748e+03 + 153780 9.498920919175092e-01 -5.843615219129063e+00 -6.069665697403050e+00 4.564653760630598e+00 4.266636933182910e+00 9.432115198538932e+03 + 153800 1.005852839702275e+00 -5.908668778688988e+00 -6.054282265600472e+00 4.155890092642502e+00 4.319754917182490e+00 9.384439499258631e+03 + 153820 1.028246798778961e+00 -5.926216877816223e+00 -6.033372952217380e+00 4.082308480003612e+00 4.467001718443249e+00 9.319794573471352e+03 + 153840 1.025886740603077e+00 -5.914083976639142e+00 -6.007981334781197e+00 4.209450200392478e+00 4.670277039371580e+00 9.241550226461119e+03 + 153860 9.894342334898864e-01 -5.853395161000053e+00 -6.018075217400717e+00 4.460533263280372e+00 4.514914895271392e+00 9.272605456292864e+03 + 153880 1.127465615427448e+00 -6.053047570224118e+00 -5.980257029132934e+00 3.425732062957253e+00 4.843706614202662e+00 9.156551235197074e+03 + 153900 1.096919088407365e+00 -6.012599324172547e+00 -5.997880923353799e+00 3.551942436567516e+00 4.636457771733935e+00 9.210538052072059e+03 + 153920 9.882435364956793e-01 -5.866038972200365e+00 -6.005936315195900e+00 4.470730834510415e+00 4.667418641986191e+00 9.235213491884149e+03 + 153940 1.029085349332307e+00 -5.946354259705553e+00 -5.949899424364361e+00 4.007171148586128e+00 4.986814264502790e+00 9.063852285545894e+03 + 153960 1.033409350619930e+00 -5.978201126557262e+00 -6.009340836269215e+00 3.789224665529933e+00 4.610415633509397e+00 9.245736635034857e+03 + 153980 1.062015878463885e+00 -6.056680988853945e+00 -6.000009007008988e+00 3.412207446282366e+00 4.737626735996960e+00 9.217076134531166e+03 + 154000 9.850169099327796e-01 -5.986117350006833e+00 -5.964066225190210e+00 3.805561807409364e+00 4.932182778506947e+00 9.107071848958814e+03 + 154020 9.208124639216702e-01 -5.930248285089446e+00 -5.997595277963068e+00 4.082920295246728e+00 4.696203440252925e+00 9.209634894189563e+03 + 154040 1.033522218589729e+00 -6.129715851892761e+00 -5.943192782625213e+00 3.016908304185804e+00 5.087952632271747e+00 9.043494983844079e+03 + 154060 9.309458124750325e-01 -6.002353442289832e+00 -5.974814770685613e+00 3.666367537300787e+00 4.824498851247871e+00 9.139900860296308e+03 + 154080 8.953715010162460e-01 -5.962575758714157e+00 -6.013662404539176e+00 3.913159411574628e+00 4.619811985614479e+00 9.259020048645274e+03 + 154100 9.957073912636289e-01 -6.118429693550341e+00 -5.988174169299165e+00 3.037381800215148e+00 4.785329177442635e+00 9.180803866144041e+03 + 154120 9.236181725258490e-01 -6.014363419250780e+00 -5.975074678048314e+00 3.602718611637942e+00 4.828320643535556e+00 9.140704654691230e+03 + 154140 9.823999916203963e-01 -6.097750326226784e+00 -5.995249057304035e+00 3.134932898633576e+00 4.723511046808105e+00 9.202472906666395e+03 + 154160 9.545416457318852e-01 -6.047962878662474e+00 -5.988661586300505e+00 3.457093086139773e+00 4.797610283727529e+00 9.182274707426657e+03 + 154180 9.376256404251384e-01 -6.011287662291399e+00 -5.968627144741612e+00 3.667577807554429e+00 4.912541101019061e+00 9.120999084489109e+03 + 154200 9.680098037483712e-01 -6.039318911557925e+00 -5.978425826819963e+00 3.515274890640665e+00 4.864932406380452e+00 9.150937265750268e+03 + 154220 9.484879047953447e-01 -5.988345014581715e+00 -6.000981283962727e+00 3.790674352320091e+00 4.718114938077952e+00 9.220031871982181e+03 + 154240 9.851962632780802e-01 -6.018294357771572e+00 -6.028355379525861e+00 3.557410040533713e+00 4.499638096682498e+00 9.304298367230240e+03 + 154260 1.009904287776747e+00 -6.028991253710687e+00 -6.027145155732479e+00 3.473008756204188e+00 4.483609336477795e+00 9.300581916918969e+03 + 154280 9.884318625487580e-01 -5.976419358485089e+00 -5.998833675090060e+00 3.813394308229257e+00 4.684687833679228e+00 9.213438077471679e+03 + 154300 9.966507303851484e-01 -5.969835710530723e+00 -5.945619780365019e+00 3.946445736743306e+00 5.085497355157857e+00 9.050843290803143e+03 + 154320 1.045411286575373e+00 -6.023124724732781e+00 -5.972425895304296e+00 3.609341383297788e+00 4.900461907494648e+00 9.132592133776805e+03 + 154340 9.600104306204874e-01 -5.883502824949063e+00 -6.037108952065433e+00 4.227521018192524e+00 4.345490865818982e+00 9.331323862523430e+03 + 154360 9.904815469406838e-01 -5.919931052252003e+00 -6.008501679263492e+00 4.096643029514631e+00 4.588056782954425e+00 9.243127631502795e+03 + 154380 1.011092591668110e+00 -5.945551674134736e+00 -6.035494431798631e+00 3.963052435278960e+00 4.446587202176108e+00 9.326301620548053e+03 + 154400 1.076168602534045e+00 -6.042101977565962e+00 -6.007041347435274e+00 3.491882603491789e+00 4.693206167317183e+00 9.238672218895561e+03 + 154420 1.023521418216818e+00 -5.968766319896369e+00 -6.049450340094695e+00 3.815844102093414e+00 4.352543972302854e+00 9.369468040922817e+03 + 154440 9.850803793732000e-01 -5.918484044203551e+00 -6.016556988554722e+00 4.183109992499388e+00 4.619959969295878e+00 9.267919780473501e+03 + 154460 1.013464110457321e+00 -5.967244561159388e+00 -5.972436762110178e+00 3.834214339824589e+00 4.804399918474656e+00 9.132588200129274e+03 + 154480 9.854344890204552e-01 -5.930350229681058e+00 -5.995273535390399e+00 4.131547012812470e+00 4.758747344580347e+00 9.202497400818802e+03 + 154500 1.036863097085982e+00 -6.011441115965360e+00 -5.983261773150928e+00 3.602381551443851e+00 4.764191698623526e+00 9.165723568785384e+03 + 154520 9.779362402804955e-01 -5.930126075860749e+00 -6.032807737643213e+00 4.026546708741896e+00 4.436932716851183e+00 9.318019286577368e+03 + 154540 1.032682119472608e+00 -6.019472199091743e+00 -6.015796869341544e+00 3.577839950723495e+00 4.598944262904580e+00 9.265599302602101e+03 + 154560 1.026620619009612e+00 -6.021414888315377e+00 -6.003217206623992e+00 3.604197350445244e+00 4.708691254799315e+00 9.226918425291309e+03 + 154580 9.955114622976984e-01 -5.987943471828876e+00 -6.038177593392995e+00 3.702288730774058e+00 4.413836631047696e+00 9.334618834260411e+03 + 154600 9.983784742615271e-01 -6.006699871905430e+00 -5.998082582820693e+00 3.607187103244213e+00 4.656668910689946e+00 9.211162387084338e+03 + 154620 9.277398522389051e-01 -5.915655225127380e+00 -6.000998356749846e+00 4.177361614808113e+00 4.687308146224979e+00 9.220127020316984e+03 + 154640 9.976902624728630e-01 -6.031254139825228e+00 -6.016392843007117e+00 3.513314835479047e+00 4.598650701586886e+00 9.267451949429736e+03 + 154660 1.002072924916289e+00 -6.054123058910775e+00 -6.016118324779574e+00 3.432948746307167e+00 4.651177810902119e+00 9.266603357289143e+03 + 154680 9.052463081658328e-01 -5.928436839978667e+00 -5.991731256312098e+00 4.144452087467972e+00 4.781005754102138e+00 9.191679158587767e+03 + 154700 9.836142285432771e-01 -6.061643126997803e+00 -5.973731624842715e+00 3.348591555417971e+00 4.853393005053482e+00 9.136585659986598e+03 + 154720 9.558571038288898e-01 -6.037191057035389e+00 -5.952252517892616e+00 3.549908398091495e+00 5.037638634045745e+00 9.071035924478747e+03 + 154740 9.326428215842683e-01 -6.017230477689758e+00 -5.990207482945389e+00 3.573836397638369e+00 4.729006615255455e+00 9.187005285921465e+03 + 154760 9.162728006253601e-01 -6.006614065904072e+00 -5.993220777670850e+00 3.658623800255772e+00 4.735530133895589e+00 9.196225455271006e+03 + 154780 9.350149696642575e-01 -6.046072701938997e+00 -5.979448217524883e+00 3.468023710724606e+00 4.850591810336090e+00 9.154058019389595e+03 + 154800 9.268405584094190e-01 -6.042027380934860e+00 -6.005491372507690e+00 3.454350422477895e+00 4.664145836795735e+00 9.233925675698372e+03 + 154820 9.694715189699855e-01 -6.110297751209170e+00 -5.990082739433813e+00 3.079912780888509e+00 4.770205981715558e+00 9.186650497737703e+03 + 154840 9.998689168767654e-01 -6.156460367588832e+00 -5.949961234815596e+00 2.845952898872887e+00 5.031702874894327e+00 9.064098425884094e+03 + 154860 9.047270042939991e-01 -6.009457784445012e+00 -5.963748961855847e+00 3.689200181418669e+00 4.951667314143091e+00 9.106093414768147e+03 + 154880 9.946047571247092e-01 -6.127276727618858e+00 -5.961093779293643e+00 2.996496467746932e+00 4.950744673758457e+00 9.097996766705457e+03 + 154900 9.987500232156385e-01 -6.107743847641848e+00 -5.954459210426859e+00 3.133087147744911e+00 5.013271255354327e+00 9.077767377743947e+03 + 154920 9.654989694846415e-01 -6.023662242053303e+00 -5.988085295848905e+00 3.584408879036476e+00 4.788697209656757e+00 9.180500837603295e+03 + 154940 1.010196036167359e+00 -6.048735010720269e+00 -6.007446956461974e+00 3.413008851584563e+00 4.650091248441439e+00 9.239946911490269e+03 + 154960 1.025516162266148e+00 -6.034023849151300e+00 -5.984564200090635e+00 3.530183542662047e+00 4.814188501424345e+00 9.169712825881648e+03 + 154980 1.028943051807332e+00 -6.008904523226491e+00 -5.978369075874078e+00 3.642677344767157e+00 4.818016608809916e+00 9.150748762294750e+03 + 155000 1.068531046414956e+00 -6.040038824930837e+00 -5.991216600434181e+00 3.412490487969162e+00 4.692835256243784e+00 9.190110197221496e+03 + 155020 1.015500077072386e+00 -5.939733281955551e+00 -6.052202485497428e+00 4.016746243334056e+00 4.370930672043598e+00 9.377977468094614e+03 + 155040 1.045569355140310e+00 -5.968694314360831e+00 -6.045151840617866e+00 3.805153976530528e+00 4.366123028998683e+00 9.356176401571369e+03 + 155060 1.017639018821679e+00 -5.920355251261887e+00 -5.994402120802588e+00 4.181709692122473e+00 4.756521108503738e+00 9.199834207521906e+03 + 155080 1.051342552465032e+00 -5.966333456487130e+00 -5.955333586615662e+00 3.890964223546198e+00 4.954127178572526e+00 9.080435472193236e+03 + 155100 1.037169784823303e+00 -5.945060838629262e+00 -5.987687819410057e+00 3.973767205780981e+00 4.728996485633694e+00 9.179263534127667e+03 + 155120 1.047753504752014e+00 -5.963329431268913e+00 -5.988249112839913e+00 3.837907672060185e+00 4.694815004171245e+00 9.181008942401078e+03 + 155140 1.038567424095626e+00 -5.956479984282568e+00 -5.989075822632151e+00 3.938691236886254e+00 4.751520888893272e+00 9.183522442467065e+03 + 155160 1.010893281588425e+00 -5.927926312784498e+00 -6.014397293803966e+00 4.020304815615504e+00 4.523775061260653e+00 9.261275967922713e+03 + 155180 9.845625122481979e-01 -5.905604784903248e+00 -5.982643136642935e+00 4.196222112572303e+00 4.753855975236616e+00 9.163831519630194e+03 + 155200 1.022562284903701e+00 -5.983283394788669e+00 -5.982138508016332e+00 3.797919755859774e+00 4.804493872877184e+00 9.162280393728337e+03 + 155220 1.080825014778091e+00 -6.097488988907767e+00 -5.970092297504354e+00 3.217020572765442e+00 4.948552089378124e+00 9.125466178917895e+03 + 155240 9.982265063962322e-01 -6.012211645687749e+00 -5.976195345809986e+00 3.647157795690730e+00 4.853968963093244e+00 9.144095980638182e+03 + 155260 9.742772940006780e-01 -6.016402938810502e+00 -5.949628717446572e+00 3.635170645885501e+00 5.018598558234547e+00 9.063043055847753e+03 + 155280 9.927140818299192e-01 -6.082721234091675e+00 -5.955839454633339e+00 3.275041615623382e+00 5.003616428165064e+00 9.081954188784453e+03 + 155300 9.708245987880417e-01 -6.082009758702881e+00 -5.935043673837592e+00 3.219543567608949e+00 5.063445569833569e+00 9.018720990022528e+03 + 155320 9.036434938499552e-01 -6.004019967156908e+00 -5.932731475804996e+00 3.692870062945815e+00 5.102219612146877e+00 9.011691419010420e+03 + 155340 9.220322885025901e-01 -6.041026200204699e+00 -5.949547496564502e+00 3.487593875348994e+00 5.012878747934641e+00 9.062808341396287e+03 + 155360 9.770031865924084e-01 -6.125901249815149e+00 -5.976098799981226e+00 3.023287739588787e+00 4.883476588389364e+00 9.143821894178624e+03 + 155380 9.765211869193547e-01 -6.122973387064694e+00 -5.961202536664681e+00 2.968230446687989e+00 4.897143703643060e+00 9.098343291163768e+03 + 155400 9.508739394937327e-01 -6.076726857373187e+00 -5.982140108587106e+00 3.309440213715260e+00 4.852571962497002e+00 9.162285637093579e+03 + 155420 9.188608965579500e-01 -6.016822438179955e+00 -5.963859781833828e+00 3.593411356169995e+00 4.897531124854035e+00 9.106442554807449e+03 + 155440 9.399851637450807e-01 -6.030818354562782e+00 -5.983611106774690e+00 3.594253961247608e+00 4.865325283344818e+00 9.166778213970429e+03 + 155460 9.767129791627324e-01 -6.066759519942504e+00 -5.960899200614990e+00 3.337853163261945e+00 4.945719498672000e+00 9.097410208999203e+03 + 155480 9.930339452156947e-01 -6.074495401045570e+00 -5.979594707792964e+00 3.249553596180457e+00 4.794488062671736e+00 9.154524049920432e+03 + 155500 9.386861552995084e-01 -5.980033555291146e+00 -6.024552457026761e+00 3.786893047385143e+00 4.531258624341463e+00 9.292577031850578e+03 + 155520 9.618294888604474e-01 -6.003148294855549e+00 -5.994736908670213e+00 3.680503242193001e+00 4.728802723327007e+00 9.200910481483734e+03 + 155540 9.594608622871416e-01 -5.988643835503059e+00 -5.980632096235697e+00 3.748431817365637e+00 4.794436464051479e+00 9.157689797689365e+03 + 155560 1.011985746744903e+00 -6.055982081015592e+00 -5.975360658671930e+00 3.412205220698084e+00 4.875145903920181e+00 9.141574683423793e+03 + 155580 1.018457559706363e+00 -6.054726981401814e+00 -5.958777681713413e+00 3.474332959814173e+00 5.025288686731107e+00 9.090928343204509e+03 + 155600 1.032214489754560e+00 -6.064127482822865e+00 -5.978950741344148e+00 3.421736755902710e+00 4.910834786531650e+00 9.152545982535501e+03 + 155620 9.981574075858994e-01 -6.002828112638390e+00 -6.031004138430933e+00 3.648859971089819e+00 4.487068870763139e+00 9.312479360349844e+03 + 155640 1.023712461323239e+00 -6.032604682127521e+00 -5.995621924643923e+00 3.544283677256875e+00 4.756644393790916e+00 9.203598319455725e+03 + 155660 9.150557953216502e-01 -5.863260870301786e+00 -6.010254319466276e+00 4.446521153848115e+00 4.602462021582869e+00 9.248545203482465e+03 + 155680 9.960983790250389e-01 -5.971954111501005e+00 -5.981989243562015e+00 3.904521382402756e+00 4.846898101176774e+00 9.161814266083662e+03 + 155700 9.920682976255403e-01 -5.951194210392703e+00 -6.031560794853807e+00 3.917307268716260e+00 4.455829904051855e+00 9.314197962072281e+03 + 155720 1.058700879442675e+00 -6.039794071148918e+00 -6.011148102063370e+00 3.479749289558792e+00 4.644238876997401e+00 9.251319398136764e+03 + 155740 1.028957806105577e+00 -5.986817902538230e+00 -6.007859895586226e+00 3.736385613575957e+00 4.615559233256462e+00 9.241190942897203e+03 + 155760 1.001954198415120e+00 -5.939796338594197e+00 -6.038484200147251e+00 4.003776477384212e+00 4.437095504449355e+00 9.335537026826649e+03 + 155780 1.039539106927784e+00 -5.988831940265251e+00 -5.968598191857904e+00 3.773077784582736e+00 4.889263099100166e+00 9.120885536347174e+03 + 155800 1.004289878555189e+00 -5.930802681263253e+00 -5.981316737331247e+00 4.020448513403998e+00 4.730388986436663e+00 9.159771362492911e+03 + 155820 1.051622559695882e+00 -5.995179785784154e+00 -5.990932386099844e+00 3.767496178177647e+00 4.791885404447932e+00 9.189200209551938e+03 + 155840 1.024444363694612e+00 -5.951296525697587e+00 -5.963983507803741e+00 3.984150199107573e+00 4.911299584549898e+00 9.106792958140664e+03 + 155860 9.975601811825657e-01 -5.908576768605900e+00 -5.974786431119791e+00 4.231800365671537e+00 4.851614237604612e+00 9.139787441422292e+03 + 155880 1.029421430888017e+00 -5.952747854047482e+00 -5.962151059806348e+00 3.971767024167147e+00 4.917772361558350e+00 9.101220366413541e+03 + 155900 1.052048403910336e+00 -5.985430162583285e+00 -5.960789981971791e+00 3.825243678440243e+00 4.966731408567068e+00 9.097048928102413e+03 + 155920 1.072491516788644e+00 -6.018365432759399e+00 -5.992888367330734e+00 3.525391288826692e+00 4.671684541081218e+00 9.195240602772274e+03 + 155940 9.742308242433042e-01 -5.879750392044881e+00 -5.979920705296006e+00 4.344939737074037e+00 4.769746297080199e+00 9.155496283746284e+03 + 155960 1.050134873247860e+00 -6.001372285482092e+00 -6.037111322629559e+00 3.639837143821892e+00 4.434618061923014e+00 9.331323631070760e+03 + 155980 1.060082950449662e+00 -6.033459347575737e+00 -5.994304799976108e+00 3.534915551718116e+00 4.759747023181845e+00 9.199524471311188e+03 + 156000 9.860247076454690e-01 -5.946801982586318e+00 -5.999593391004373e+00 3.968982212168462e+00 4.665845775587940e+00 9.215801864085384e+03 + 156020 9.600097702475310e-01 -5.935309069311873e+00 -5.967078572387117e+00 4.073924123262767e+00 4.891498720290002e+00 9.116225470527686e+03 + 156040 9.617904380326701e-01 -5.962560392087448e+00 -5.987879675534487e+00 3.855199788973863e+00 4.709812545274513e+00 9.179838636580747e+03 + 156060 9.648839634361004e-01 -5.988190069099558e+00 -5.969284636762753e+00 3.724679002229918e+00 4.833236920314050e+00 9.123000408865673e+03 + 156080 9.556958714776603e-01 -5.992484015964607e+00 -5.998820329189599e+00 3.749365655884403e+00 4.712981564805196e+00 9.213432996836458e+03 + 156100 1.021531438916179e+00 -6.106025155693918e+00 -5.990986930705665e+00 3.115238425285698e+00 4.775805715276029e+00 9.189435512501246e+03 + 156120 1.022105554112232e+00 -6.122562434831845e+00 -5.978867261986667e+00 3.059353433251884e+00 4.884473352485029e+00 9.152311852050241e+03 + 156140 1.012808430733923e+00 -6.124376248845142e+00 -5.977675514976339e+00 3.036276430908325e+00 4.878654746648186e+00 9.148658281099310e+03 + 156160 9.437004235933862e-01 -6.034428586584344e+00 -5.947448155445353e+00 3.506476434212221e+00 5.005931529990523e+00 9.056433399159350e+03 + 156180 9.528631257315973e-01 -6.054168581156506e+00 -5.939336332943128e+00 3.405401632989215e+00 5.064786172463413e+00 9.031758346043873e+03 + 156200 9.582074274813688e-01 -6.061234245706294e+00 -5.991144182665312e+00 3.358400839609688e+00 4.760868827993214e+00 9.189887699264604e+03 + 156220 9.422677755565344e-01 -6.029098014208721e+00 -6.012228826077340e+00 3.537998446233988e+00 4.634863934982803e+00 9.254607929685388e+03 + 156240 9.646967619765076e-01 -6.047194459603581e+00 -5.996695497845927e+00 3.466600680002949e+00 4.756573533104477e+00 9.206919763887547e+03 + 156260 9.941131336325121e-01 -6.066616934613710e+00 -6.020545162361872e+00 3.348850860072736e+00 4.613402105926506e+00 9.280242486919804e+03 + 156280 9.870474903696963e-01 -6.024880894070576e+00 -5.989593377560182e+00 3.604499983439220e+00 4.807126363967433e+00 9.185133628278058e+03 + 156300 9.784625895818214e-01 -5.971358800345510e+00 -6.015831927678462e+00 3.817923963535615e+00 4.562552384195593e+00 9.265710261370699e+03 + 156320 1.069548166122868e+00 -6.059955768957600e+00 -6.004656798004405e+00 3.358928208421295e+00 4.676463457122637e+00 9.231360585162553e+03 + 156340 1.030225709110215e+00 -5.959757426608255e+00 -5.996438922707100e+00 3.935752223198967e+00 4.725121396156229e+00 9.206115600902014e+03 + 156360 1.102136953249768e+00 -6.033351300813127e+00 -5.993818147604701e+00 3.564275486030331e+00 4.791280969488799e+00 9.198072234006971e+03 + 156380 1.081893475012560e+00 -5.980834758586768e+00 -6.002155783003046e+00 3.777947142839296e+00 4.655518521223168e+00 9.223683689452017e+03 + 156400 9.979176079572988e-01 -5.845701720244660e+00 -6.036109289521680e+00 4.519878477878393e+00 4.426528749613624e+00 9.328215056825451e+03 + 156420 1.038277649537138e+00 -5.901366749245051e+00 -5.982685165061580e+00 4.212486416903213e+00 4.745543489300531e+00 9.163952255201797e+03 + 156440 1.000649228397848e+00 -5.846493096746441e+00 -6.015452041192910e+00 4.512194200421500e+00 4.542005795097722e+00 9.264507716910946e+03 + 156460 1.084644710618589e+00 -5.977505074596809e+00 -5.975926420079889e+00 3.793393417134634e+00 4.802458295666787e+00 9.143317999361618e+03 + 156480 1.032345104090961e+00 -5.912732478623116e+00 -6.045618174573405e+00 4.155123258382257e+00 4.392073028240714e+00 9.357606713102501e+03 + 156500 1.026017308670078e+00 -5.920846352348364e+00 -6.002751329401363e+00 4.193796559162895e+00 4.723485506170340e+00 9.225482266233119e+03 + 156520 1.034022675889937e+00 -5.952467355795323e+00 -5.979868915174400e+00 3.994486848463894e+00 4.837142854131629e+00 9.155347758676544e+03 + 156540 9.547969581844103e-01 -5.855128419545848e+00 -6.023726613700354e+00 4.459968532796190e+00 4.491851611474789e+00 9.290018300695543e+03 + 156560 1.076425738549095e+00 -6.055261637512548e+00 -5.971905163567992e+00 3.365941474299682e+00 4.844587247061981e+00 9.131007729993786e+03 + 156580 9.231864605071064e-01 -5.845867159647654e+00 -6.061157215696396e+00 4.504309393805437e+00 4.268080575945066e+00 9.405721682328412e+03 + 156600 1.074947448131709e+00 -6.087931181736392e+00 -5.970443080222298e+00 3.194035327761268e+00 4.868670187880152e+00 9.126547447052104e+03 + 156620 9.806425214161109e-01 -5.964787460399743e+00 -5.998565397814652e+00 3.914070766918258e+00 4.720112623162931e+00 9.212653302176705e+03 + 156640 1.007666738455863e+00 -6.018177786544795e+00 -5.991973736414108e+00 3.622066713477596e+00 4.772534424391656e+00 9.192421462017228e+03 + 156660 9.654597818281411e-01 -5.964561117966589e+00 -5.964292798881128e+00 3.921222351430070e+00 4.922763081141031e+00 9.107754879154478e+03 + 156680 9.633779811067518e-01 -5.964887459985927e+00 -6.020784744964363e+00 3.874416731314403e+00 4.553445870891327e+00 9.280973030867974e+03 + 156700 1.012840925889855e+00 -6.040482024975684e+00 -6.016560779520383e+00 3.481370383650158e+00 4.618729876855269e+00 9.267954164161642e+03 + 156720 9.677035272798227e-01 -5.976682392089555e+00 -5.977785444228795e+00 3.794317794626969e+00 4.787983898546686e+00 9.148971114650494e+03 + 156740 9.687355631704844e-01 -5.977626270806263e+00 -6.016142254527434e+00 3.759994772572326e+00 4.538830033716144e+00 9.266647286083449e+03 + 156760 1.076874024490185e+00 -6.135779169810773e+00 -5.969732372447152e+00 3.002071425335534e+00 4.955537831456295e+00 9.124367312836290e+03 + 156780 9.598476311152302e-01 -5.961475471041683e+00 -5.997455095006664e+00 3.854326663191878e+00 4.647726094556138e+00 9.209227415165204e+03 + 156800 9.356992689522694e-01 -5.923879323000756e+00 -6.005618326530044e+00 4.067004702764974e+00 4.597646695429886e+00 9.234273611439630e+03 + 156820 1.006464080354083e+00 -6.023198418467491e+00 -5.990294885222333e+00 3.631990120494783e+00 4.820927300193794e+00 9.187220203193609e+03 + 156840 1.006313820236602e+00 -6.017384170532153e+00 -5.995214714344264e+00 3.609256797524332e+00 4.736557245667445e+00 9.202372546309023e+03 + 156860 1.040225434905872e+00 -6.062466630367660e+00 -6.004393478413311e+00 3.345252333975278e+00 4.678717359288369e+00 9.230559227038844e+03 + 156880 1.028299214899132e+00 -6.042389194884100e+00 -5.994025102421359e+00 3.472927937532903e+00 4.750642040773080e+00 9.198729719228102e+03 + 156900 9.702295857122382e-01 -5.954367727477870e+00 -5.989951026999348e+00 3.948904550582209e+00 4.744579738232078e+00 9.186232670252188e+03 + 156920 9.802250613706779e-01 -5.966719497582075e+00 -6.011603792782036e+00 3.852304673236276e+00 4.594572104375871e+00 9.252708621747352e+03 + 156940 9.944171493315874e-01 -5.985866031952818e+00 -5.986196770527361e+00 3.817816300460538e+00 4.815917148383881e+00 9.174705739285850e+03 + 156960 9.358989187910117e-01 -5.893441812058851e+00 -6.006913534912587e+00 4.299366046903787e+00 4.647793854585273e+00 9.238242625419982e+03 + 156980 1.039331128710779e+00 -6.040674966831532e+00 -6.002002817646383e+00 3.521330209029016e+00 4.743391674145891e+00 9.223190587714100e+03 + 157000 1.017548093378406e+00 -6.000641943828476e+00 -6.017697403175031e+00 3.689686645135702e+00 4.591751558243978e+00 9.271461914428572e+03 + 157020 1.026017147947780e+00 -6.005006201076732e+00 -6.001721630507582e+00 3.678310701895951e+00 4.697171214389661e+00 9.222342261020443e+03 + 157040 1.028231967148681e+00 -5.999441603056658e+00 -6.017853091611360e+00 3.679026765842158e+00 4.573305149392414e+00 9.271920489178330e+03 + 157060 9.839918803697235e-01 -5.922631868580491e+00 -6.020149055900939e+00 4.106604504899400e+00 4.546645724569424e+00 9.278944386963421e+03 + 157080 9.869184742964995e-01 -5.910727763724124e+00 -6.002044565902026e+00 4.189898688973567e+00 4.665543479638583e+00 9.223292073904880e+03 + 157100 1.012655102544502e+00 -5.926301425381177e+00 -5.988159448676408e+00 4.162074956602247e+00 4.806876614342862e+00 9.180719287128459e+03 + 157120 1.036049566939546e+00 -5.936768665598631e+00 -6.020478748302005e+00 4.044128452532119e+00 4.563452203555914e+00 9.279996179146941e+03 + 157140 1.053908925817445e+00 -5.941297625809114e+00 -6.065147164144323e+00 3.974946582961892e+00 4.263783368187010e+00 9.418114889616249e+03 + 157160 9.750414212429849e-01 -5.809542491302873e+00 -6.060090283869345e+00 4.748532965838596e+00 4.309848768776327e+00 9.402418313240802e+03 + 157180 1.048781512456741e+00 -5.910160074725588e+00 -5.999664617600480e+00 4.231437855425727e+00 4.717488919454849e+00 9.215982867349836e+03 + 157200 9.928923941495678e-01 -5.821509812758084e+00 -6.066234495696987e+00 4.625376681055300e+00 4.220129680597826e+00 9.421478091235691e+03 + 157220 1.079815886257194e+00 -5.953659681406927e+00 -6.044080107384148e+00 3.932101249126009e+00 4.412893170649108e+00 9.352860745084377e+03 + 157240 1.037527679606691e+00 -5.902959427509844e+00 -6.010995092694564e+00 4.214649602422707e+00 4.594292094466887e+00 9.250822892247057e+03 + 157260 1.072011977141883e+00 -5.972725150097947e+00 -5.962126066259625e+00 3.849680122990303e+00 4.910541702592872e+00 9.101150322614494e+03 + 157280 1.022747598099079e+00 -5.925456452795429e+00 -6.010232558280670e+00 4.163303432887970e+00 4.676505916131792e+00 9.248461270633137e+03 + 157300 1.089040452863974e+00 -6.059066667793214e+00 -5.941395084501927e+00 3.382572709654842e+00 5.058261150532074e+00 9.038028692139897e+03 + 157320 1.015896021398681e+00 -5.985456488308500e+00 -5.974281660925434e+00 3.753635332973337e+00 4.817802921105848e+00 9.138242605836880e+03 + 157340 1.007260623160975e+00 -6.003615493444865e+00 -5.978954247330535e+00 3.674129147478466e+00 4.815737838982452e+00 9.152549637128875e+03 + 157360 1.043932369280565e+00 -6.085527148918293e+00 -5.989062010467481e+00 3.203851167043168e+00 4.757768919959662e+00 9.183519064323607e+03 + 157380 9.573712824874293e-01 -5.982445730534573e+00 -6.005011568688016e+00 3.822222279154517e+00 4.692645744425272e+00 9.232454953505052e+03 + 157400 9.839637424950695e-01 -6.043069943521168e+00 -5.972768372634302e+00 3.498180573253349e+00 4.901863072418668e+00 9.133636926373707e+03 + 157420 9.540743091260190e-01 -6.012435733721757e+00 -6.009384306477507e+00 3.660626610023276e+00 4.678148377466601e+00 9.245873418446688e+03 + 157440 1.077639679555158e+00 -6.205804664552121e+00 -5.987821154854236e+00 2.602194536211034e+00 4.853889581735390e+00 9.179724451987891e+03 + 157460 8.899981551330978e-01 -5.935955771249519e+00 -6.052824950567125e+00 4.017433764283888e+00 4.346352851195145e+00 9.379931208362468e+03 + 157480 9.576739452411704e-01 -6.039875730555249e+00 -6.024083305919600e+00 3.441895782757318e+00 4.532578328885026e+00 9.291055238702582e+03 + 157500 9.894402996737462e-01 -6.086833609795920e+00 -5.984802531511067e+00 3.220371319719595e+00 4.806249560489555e+00 9.170442167060082e+03 + 157520 9.479556594767882e-01 -6.021518477706805e+00 -6.001705563715723e+00 3.524457824252995e+00 4.638226642428318e+00 9.222289314654796e+03 + 157540 9.648694443185758e-01 -6.037342363067489e+00 -5.988956538250148e+00 3.481539127233241e+00 4.759378021016601e+00 9.183176359397541e+03 + 157560 1.018166778743456e+00 -6.102182200616815e+00 -5.983880865630371e+00 3.091873955923233e+00 4.771178528487818e+00 9.167645599853971e+03 + 157580 9.097781716227297e-01 -5.921138160003744e+00 -6.019650713361212e+00 4.122660139216693e+00 4.556985813069750e+00 9.277445360228279e+03 + 157600 1.035988817329983e+00 -6.079897103190830e+00 -5.993268357531019e+00 3.278276502891600e+00 4.775712166225302e+00 9.196386148587460e+03 + 157620 1.025865356282052e+00 -6.023390769969561e+00 -6.020995216582435e+00 3.565586330679977e+00 4.579341968939543e+00 9.281630837518447e+03 + 157640 1.024259946820580e+00 -5.974090419001708e+00 -5.997244826530540e+00 3.853777543473623e+00 4.720821352310088e+00 9.208574088306130e+03 + 157660 1.052843634585507e+00 -5.967220512966490e+00 -5.953070328808468e+00 3.904378702382231e+00 4.985631249551517e+00 9.073527353632151e+03 + 157680 1.067079560968394e+00 -5.942578946526291e+00 -6.006710328297460e+00 3.985489829773305e+00 4.617237511344001e+00 9.237655160693188e+03 + 157700 1.054917018082333e+00 -5.894005171003320e+00 -6.043318056506330e+00 4.234791705497157e+00 4.377414010844515e+00 9.350508465364928e+03 + 157720 1.033160970159197e+00 -5.848342457523593e+00 -6.053335315690482e+00 4.494864736463324e+00 4.317764022326769e+00 9.381492122787678e+03 + 157740 1.036568401110942e+00 -5.852395095708044e+00 -6.048419968790159e+00 4.508327901727027e+00 4.382722745738447e+00 9.366260329780562e+03 + 157760 1.045312104395617e+00 -5.871273211900852e+00 -6.056506252529332e+00 4.348303713181680e+00 4.284666929172550e+00 9.391319389188986e+03 + 157780 1.028184359958844e+00 -5.857183991393851e+00 -6.062936238105408e+00 4.388464851381827e+00 4.207003610706791e+00 9.411262834732472e+03 + 157800 1.108768922892658e+00 -5.994453814567116e+00 -6.030267872128759e+00 3.645519331169023e+00 4.439869470442575e+00 9.310222049280042e+03 + 157820 1.013345660527794e+00 -5.876481899438243e+00 -6.008256425445802e+00 4.350435972272180e+00 4.593766251894778e+00 9.242405935903091e+03 + 157840 1.048654843193751e+00 -5.951974835943119e+00 -6.000269668826189e+00 3.910940957347285e+00 4.633624553331458e+00 9.217861568494558e+03 + 157860 9.963540951250582e-01 -5.898491106766225e+00 -6.011236964273984e+00 4.183421750212016e+00 4.536017589037408e+00 9.251555638955069e+03 + 157880 1.005109646549181e+00 -5.933411777526399e+00 -6.013061082062393e+00 4.011397809471971e+00 4.554039177136255e+00 9.257186078064578e+03 + 157900 1.021248499399027e+00 -5.978176608610720e+00 -6.039978087911785e+00 3.799362311100594e+00 4.444488653205863e+00 9.340163891422853e+03 + 157920 9.965161966291373e-01 -5.964145870551885e+00 -5.986576347186203e+00 3.883281378684169e+00 4.754482110744872e+00 9.175883271457771e+03 + 157940 1.018000184418513e+00 -6.014707316241329e+00 -5.985859231222199e+00 3.593357396543915e+00 4.759007564950485e+00 9.173698767307358e+03 + 157960 1.065459434486456e+00 -6.102584154278894e+00 -6.011491392058314e+00 3.198417922042519e+00 4.721486659272486e+00 9.252358066968996e+03 + 157980 9.347507301966350e-01 -5.926797120477151e+00 -6.057012773887620e+00 4.076188359163286e+00 4.328469926473135e+00 9.392901682043252e+03 + 158000 9.868709620221353e-01 -6.020605626830092e+00 -6.000296384489306e+00 3.629594540756258e+00 4.746213353122144e+00 9.217965562193229e+03 + 158020 1.008754455742515e+00 -6.066445700988504e+00 -5.968080385098313e+00 3.354172104897235e+00 4.919000970722151e+00 9.119318140259547e+03 + 158040 9.376172799096421e-01 -5.970748732061255e+00 -5.973555108497830e+00 3.880261878810615e+00 4.864147231026446e+00 9.136016093839240e+03 + 158060 9.502422782612084e-01 -5.992149090261105e+00 -6.010475080089077e+00 3.731364521255833e+00 4.626133851725855e+00 9.249244908543957e+03 + 158080 1.042480016935265e+00 -6.129808634445554e+00 -6.023356927415428e+00 2.959994537497852e+00 4.571256712613259e+00 9.288924132761060e+03 + 158100 9.122884967369705e-01 -5.937422501321481e+00 -6.038916328096906e+00 3.998495632197855e+00 4.415702372734431e+00 9.336927969439104e+03 + 158120 1.060321445466710e+00 -6.156236216057479e+00 -5.996192504580589e+00 2.823597409558066e+00 4.742593167542682e+00 9.205390005294772e+03 + 158140 9.295945463056196e-01 -5.960121881730548e+00 -5.985482166047563e+00 3.929875795580849e+00 4.784253118541240e+00 9.172511838900566e+03 + 158160 9.813003410638159e-01 -6.029467727589465e+00 -5.977821073534414e+00 3.525645030821957e+00 4.822208110699950e+00 9.149067682295907e+03 + 158180 9.885166606744838e-01 -6.021503759419323e+00 -5.958333188589033e+00 3.651211155431940e+00 5.013946348753707e+00 9.089566915767708e+03 + 158200 9.828642811058098e-01 -5.982305424104281e+00 -5.990842798105943e+00 3.828476696481462e+00 4.779453773809559e+00 9.188931572763122e+03 + 158220 9.744318212407846e-01 -5.922572515418604e+00 -6.022429605329130e+00 4.078750687459820e+00 4.505355824358858e+00 9.286020220083306e+03 + 158240 1.014119665254342e+00 -5.925313300262539e+00 -5.995703264795803e+00 4.064148857598341e+00 4.659958788436536e+00 9.203851418998374e+03 + 158260 1.103511123873385e+00 -6.007018274659313e+00 -5.946852700233981e+00 3.683068798071818e+00 5.028548837014624e+00 9.054619282829997e+03 + 158280 1.036127191249600e+00 -5.869749843054083e+00 -5.990198150096229e+00 4.353484082433136e+00 4.661851264081860e+00 9.186958945638922e+03 + 158300 1.063577748222445e+00 -5.886208559936533e+00 -6.019600987228854e+00 4.270082012749072e+00 4.504122052825154e+00 9.277263369948327e+03 + 158320 1.101796900561629e+00 -5.930788171744062e+00 -5.979261409985025e+00 4.081539161728755e+00 4.803198326539774e+00 9.153458341138003e+03 + 158340 1.112293415759407e+00 -5.944123323472500e+00 -5.986070795059899e+00 4.044636206421243e+00 4.803767333216153e+00 9.174295624758042e+03 + 158360 1.031922276148501e+00 -5.831506496053739e+00 -6.012935545088179e+00 4.601872451568337e+00 4.560078775957987e+00 9.256788724730704e+03 + 158380 1.096245281413277e+00 -5.942369743352601e+00 -6.010919226475634e+00 4.003828311483748e+00 4.610206571393062e+00 9.250605192098685e+03 + 158400 1.078775291601145e+00 -5.941065338743281e+00 -6.047026456352560e+00 4.014990291278437e+00 4.406545156535998e+00 9.361948908858931e+03 + 158420 1.030670938392361e+00 -5.901807245611191e+00 -6.041918469984020e+00 4.255714290768280e+00 4.451173958277596e+00 9.346137491848314e+03 + 158440 1.008198718546610e+00 -5.902855395038042e+00 -6.015818360294809e+00 4.205064702306332e+00 4.556413874839600e+00 9.265663494312483e+03 + 158460 1.021563074805141e+00 -5.958269043257469e+00 -6.011036209506779e+00 3.943060305211696e+00 4.640063070915573e+00 9.250963265499724e+03 + 158480 1.000041874029309e+00 -5.958794331111794e+00 -6.021809231443833e+00 3.930492771168349e+00 4.568651461937469e+00 9.284109106935693e+03 + 158500 1.051790393201695e+00 -6.058942807813466e+00 -6.009683626728179e+00 3.377336657659848e+00 4.660190498285207e+00 9.246784546311468e+03 + 158520 9.988765278997698e-01 -6.000202278782643e+00 -6.004156242322101e+00 3.715938741801903e+00 4.693234471284455e+00 9.229815308285382e+03 + 158540 1.007249863938297e+00 -6.029094024282705e+00 -5.979992295212773e+00 3.547325480290123e+00 4.829275207077693e+00 9.155726363277518e+03 + 158560 9.382983348117007e-01 -5.937124264915040e+00 -6.038879713439100e+00 4.023134997038739e+00 4.438839465008816e+00 9.336777949436671e+03 + 158580 9.602427303348809e-01 -5.977457853904292e+00 -6.011539981535550e+00 3.804297334034070e+00 4.608592482983182e+00 9.252509299834797e+03 + 158600 9.927640345234163e-01 -6.031012197013839e+00 -5.997572417295464e+00 3.538852143323626e+00 4.730868533255718e+00 9.209609394227591e+03 + 158620 9.503964363828763e-01 -5.970340141586703e+00 -6.003364648638845e+00 3.855866848471048e+00 4.666235018451699e+00 9.227397266742108e+03 + 158640 9.838576803815202e-01 -6.019030649449538e+00 -6.010504247415469e+00 3.604322975691887e+00 4.653282895627961e+00 9.249318450643583e+03 + 158660 9.961048591604530e-01 -6.035874071701697e+00 -6.035211684905775e+00 3.446819808486753e+00 4.450623335972962e+00 9.325460783563753e+03 + 158680 9.734031382292708e-01 -6.000568759756991e+00 -6.034760309015555e+00 3.680954884838088e+00 4.484621717870268e+00 9.324080933887069e+03 + 158700 1.019541886737426e+00 -6.066204348705783e+00 -5.999631091564462e+00 3.393804195363928e+00 4.776078140047643e+00 9.215933281531827e+03 + 158720 9.770116000496499e-01 -5.999649518905536e+00 -6.022055935802896e+00 3.713935474832594e+00 4.585274361626146e+00 9.284877816214650e+03 + 158740 1.034461528565342e+00 -6.079229684640679e+00 -5.974873495393145e+00 3.265935677775587e+00 4.865165065503023e+00 9.140074716689986e+03 + 158760 9.690838414855645e-01 -5.974868814659614e+00 -5.997076499068499e+00 3.816972219345662e+00 4.689452258841789e+00 9.208062347325362e+03 + 158780 9.712806306669008e-01 -5.964292862168566e+00 -6.018842928271001e+00 3.884633175443363e+00 4.571398254287735e+00 9.274968290424587e+03 + 158800 1.000936742962732e+00 -5.985019306328353e+00 -6.025745502264344e+00 3.735436035012129e+00 4.501579915589212e+00 9.296271782368880e+03 + 158820 1.058637606957790e+00 -6.040464222161960e+00 -6.023347752515702e+00 3.495767013673423e+00 4.594052431147353e+00 9.288876776015613e+03 + 158840 9.808939691911815e-01 -5.891650058734743e+00 -6.063935511722193e+00 4.249008624841290e+00 4.259718892699661e+00 9.414353539057578e+03 + 158860 9.999185984748633e-01 -5.882544616797418e+00 -6.048074099742590e+00 4.291882788101017e+00 4.341386881425137e+00 9.365194451352974e+03 + 158880 1.064804123115785e+00 -5.939799699070935e+00 -5.998435221288688e+00 4.010045181105628e+00 4.673350938713551e+00 9.212225161285758e+03 + 158900 1.078696289612449e+00 -5.925445760997094e+00 -6.041047775393562e+00 4.029952682920463e+00 4.366148026902033e+00 9.343504746903074e+03 + 158920 1.137243087169405e+00 -5.986331226856130e+00 -5.997362933149170e+00 3.766778094163539e+00 4.703432329477872e+00 9.208941778343156e+03 + 158940 1.094620580759152e+00 -5.909493933934400e+00 -6.002578281821872e+00 4.168410519049303e+00 4.633905788723160e+00 9.224956280089786e+03 + 158960 1.028753524124946e+00 -5.805932603792663e+00 -6.065645011493352e+00 4.731703597437365e+00 4.240394762054808e+00 9.419663513315605e+03 + 158980 1.136906018952045e+00 -5.974645067938932e+00 -6.015492430493897e+00 3.847318107980001e+00 4.612766231080462e+00 9.264688569213622e+03 + 159000 1.100171971239055e+00 -5.941286847841411e+00 -6.023452160597915e+00 4.022371383756390e+00 4.550565442867487e+00 9.289181752953307e+03 + 159020 1.051610996978976e+00 -5.904387680683501e+00 -6.009523751569358e+00 4.189002135295985e+00 4.585294546515006e+00 9.246286107992850e+03 + 159040 9.474613280854542e-01 -5.793834339823102e+00 -6.008706411702765e+00 4.759951341335533e+00 4.526122653256845e+00 9.243764051027567e+03 + 159060 1.011795340667918e+00 -5.927732720859541e+00 -5.969238260670335e+00 4.069471083058103e+00 4.831139850502995e+00 9.122804665723508e+03 + 159080 1.034418993505762e+00 -5.993426907236168e+00 -5.993521342400056e+00 3.683639026161596e+00 4.683096764836757e+00 9.197136887715007e+03 + 159100 1.000816189494112e+00 -5.970370146108327e+00 -6.041398435508201e+00 3.783250350645740e+00 4.375394921319404e+00 9.344565598049074e+03 + 159120 1.048143334253784e+00 -6.062751878426872e+00 -5.980808715850843e+00 3.343824752129183e+00 4.814355072304167e+00 9.158217386441329e+03 + 159140 9.481942082131043e-01 -5.927168537900184e+00 -5.991272338875397e+00 4.086621938441493e+00 4.718527993210679e+00 9.190254889029742e+03 + 159160 9.674502705608908e-01 -5.964626981256871e+00 -5.969564941559280e+00 3.933087024668994e+00 4.904732492465671e+00 9.123815436678509e+03 + 159180 1.038203007771875e+00 -6.073818954030989e+00 -5.977607902677767e+00 3.317571292670896e+00 4.870030038153173e+00 9.148441378946274e+03 + 159200 1.015096394237751e+00 -6.042734906609613e+00 -5.974918381115140e+00 3.454522121786077e+00 4.843935105748749e+00 9.140198580821701e+03 + 159220 9.560091868802948e-01 -5.956680357924192e+00 -6.003029013179180e+00 3.900981417566300e+00 4.634840266660940e+00 9.226335387455178e+03 + 159240 9.150455860828660e-01 -5.896574242317199e+00 -6.050105778161295e+00 4.226451896582518e+00 4.344850058837332e+00 9.371491318008601e+03 + 159260 1.000205847947655e+00 -6.022410173242243e+00 -5.989154362292501e+00 3.547882628569602e+00 4.738842641363135e+00 9.183792609248230e+03 + 159280 9.711993542221165e-01 -5.977222699851403e+00 -5.993445033203112e+00 3.826467069131730e+00 4.733315920628244e+00 9.196936452918293e+03 + 159300 9.818358822597771e-01 -5.988124951965341e+00 -6.039663512384980e+00 3.725171151352350e+00 4.429228761856339e+00 9.339217575466457e+03 + 159320 9.750292404795829e-01 -5.974153803546288e+00 -6.030807982588010e+00 3.783226023610088e+00 4.457908960346642e+00 9.311858488350774e+03 + 159340 1.025434900082332e+00 -6.043623583382672e+00 -5.983853387832904e+00 3.544382885800363e+00 4.887592598054999e+00 9.167519816410391e+03 + 159360 1.047825784104359e+00 -6.069171101480032e+00 -5.974924228883383e+00 3.264886598758522e+00 4.806066725864881e+00 9.140243515333865e+03 + 159380 9.533980555133019e-01 -5.918787905988847e+00 -6.015309504940378e+00 4.139806183775313e+00 4.585564225926460e+00 9.264066251810889e+03 + 159400 1.018637733524578e+00 -6.003917460170587e+00 -5.980829246962396e+00 3.732553334003841e+00 4.865129427134720e+00 9.158272774227498e+03 + 159420 1.034173301616139e+00 -6.010355963949451e+00 -6.038976120884514e+00 3.613304672606314e+00 4.448963302530217e+00 9.337085937188414e+03 + 159440 9.943493578756768e-01 -5.932827792631599e+00 -6.020966364571638e+00 4.063605864993107e+00 4.557500545513474e+00 9.281514115682674e+03 + 159460 1.024461371204370e+00 -5.955510228803456e+00 -5.989047884340971e+00 3.985871317654927e+00 4.793292909623095e+00 9.183452387765146e+03 + 159480 1.035748289266619e+00 -5.946173434302401e+00 -6.002442290059972e+00 4.054311167602497e+00 4.731206690265242e+00 9.224556277627080e+03 + 159500 1.031212292486131e+00 -5.911378736956396e+00 -6.031463114775706e+00 4.143046578077918e+00 4.453503497642036e+00 9.313901415793647e+03 + 159520 1.058805207813739e+00 -5.925997922008456e+00 -6.023768690451242e+00 4.097934277086076e+00 4.536519394710079e+00 9.290154304678097e+03 + 159540 1.119131363934976e+00 -5.994878013279849e+00 -6.005582956956259e+00 3.757365052212980e+00 4.695895609038359e+00 9.234185175585508e+03 + 159560 1.037350234491170e+00 -5.860492174372813e+00 -6.035886402496120e+00 4.427264658473533e+00 4.420123858420425e+00 9.327532169636152e+03 + 159580 1.079640552140489e+00 -5.916071925804431e+00 -6.033706106231257e+00 4.133965997305567e+00 4.458492329464140e+00 9.320811592453443e+03 + 159600 1.084501794897959e+00 -5.927180154867921e+00 -5.932603267784032e+00 4.120038205939981e+00 5.088897852351660e+00 9.011278945233740e+03 + 159620 1.027930786875877e+00 -5.853060717543073e+00 -5.971058223835776e+00 4.462785060257092e+00 4.785225119069307e+00 9.128386020438607e+03 + 159640 1.082983097112168e+00 -5.951664541646313e+00 -5.946137140979909e+00 4.045920746860257e+00 5.077659936849240e+00 9.052414074896391e+03 + 159660 1.052099447715315e+00 -5.935926992037361e+00 -6.029728556944718e+00 4.048451573885861e+00 4.509828472442561e+00 9.308508057896648e+03 + 159680 1.008622331887496e+00 -5.915257264047999e+00 -6.028868193333594e+00 4.165806247450648e+00 4.513434710258280e+00 9.305874677388445e+03 + 159700 1.012936687573398e+00 -5.969027952360778e+00 -5.999914072773715e+00 3.853731785094020e+00 4.676378902071248e+00 9.216768172349437e+03 + 159720 9.580423099643852e-01 -5.930673089248154e+00 -6.016050142756599e+00 4.077666445434643e+00 4.587418192132821e+00 9.266375596903588e+03 + 159740 1.019066363036946e+00 -6.056071612131017e+00 -6.015449188725151e+00 3.375015366463192e+00 4.608275607959381e+00 9.264537136552035e+03 + 159760 9.552800415534263e-01 -5.989578903561117e+00 -6.037383640961348e+00 3.717991636723654e+00 4.443489436812328e+00 9.332178212165500e+03 + 159780 9.668183874734675e-01 -6.024567629120570e+00 -6.026512803096705e+00 3.535812339052586e+00 4.524642849066920e+00 9.298622207778222e+03 + 159800 9.897765678315403e-01 -6.070397337579338e+00 -5.979611232101687e+00 3.373951709153029e+00 4.895259575910119e+00 9.154569797677621e+03 + 159820 9.372405471486146e-01 -5.998813573325064e+00 -5.997419172987730e+00 3.675076054915405e+00 4.683082917435136e+00 9.209146303935418e+03 + 159840 9.438370536512489e-01 -6.009928521330453e+00 -6.015424072261163e+00 3.585667604814778e+00 4.554111300936884e+00 9.264447564409673e+03 + 159860 9.306294217750053e-01 -5.988305485378703e+00 -5.956544619714080e+00 3.821995470516256e+00 5.004371276140599e+00 9.084109370507584e+03 + 159880 1.052946188671871e+00 -6.161957119427522e+00 -5.923744394843757e+00 2.810548992164053e+00 5.178403320024024e+00 8.984435109516147e+03 + 159900 9.728220541758182e-01 -6.029553126375461e+00 -5.944810219298901e+00 3.567807693000484e+00 5.054414579356582e+00 9.048387610657075e+03 + 159920 9.844970624430790e-01 -6.029525383371160e+00 -5.994957744402039e+00 3.512636911048601e+00 4.711129643334138e+00 9.201588432028382e+03 + 159940 9.801226784897152e-01 -6.003728265598066e+00 -6.004061174876538e+00 3.657306727493465e+00 4.655395110898931e+00 9.229516800387752e+03 + 159960 1.003513387507547e+00 -6.017294716602880e+00 -6.007453659200221e+00 3.539402201391014e+00 4.595911075895795e+00 9.239957630415327e+03 + 159980 1.007947823748043e+00 -6.002540425019272e+00 -5.998753481546204e+00 3.642954413999386e+00 4.664699629449355e+00 9.213211726145228e+03 + 160000 9.543539917104560e-01 -5.900261352826585e+00 -6.038222154854846e+00 4.239763823419176e+00 4.447571548807793e+00 9.334720106571405e+03 + 160020 1.037357033024850e+00 -6.000236300520401e+00 -5.980681545487596e+00 3.677935038480325e+00 4.790221467967249e+00 9.157819391201205e+03 + 160040 1.026583558431805e+00 -5.961638452563316e+00 -5.985112023044009e+00 3.909656178071586e+00 4.774867303848154e+00 9.171397153784097e+03 + 160060 1.045704740248333e+00 -5.968266470371322e+00 -5.996264075452608e+00 3.831462775588807e+00 4.670696194596680e+00 9.205578896734463e+03 + 160080 1.049404147500742e+00 -5.955743797417787e+00 -5.979619860793060e+00 3.977159845644473e+00 4.840059794934790e+00 9.154591284388594e+03 + 160100 1.043601010179561e+00 -5.931497631245326e+00 -6.028016871318217e+00 4.015256873430538e+00 4.461028460627870e+00 9.303255800401419e+03 + 160120 1.055438165176422e+00 -5.935598889123364e+00 -6.021384991831250e+00 4.050156240804776e+00 4.557559163699602e+00 9.282804378832494e+03 + 160140 1.067766959005933e+00 -5.945524210976529e+00 -6.011054992452717e+00 3.980459089576319e+00 4.604171201484383e+00 9.251013580487916e+03 + 160160 1.056972727789983e+00 -5.926064230600744e+00 -5.989708109239521e+00 4.093253054853432e+00 4.727800054851184e+00 9.185470465238870e+03 + 160180 1.064057455614660e+00 -5.938079343333508e+00 -6.001618011425073e+00 4.046076979279231e+00 4.681228114520358e+00 9.222007931817772e+03 + 160200 1.096865378765961e+00 -5.996945069430559e+00 -5.993303904829786e+00 3.788328372230572e+00 4.809236502836614e+00 9.196500735592123e+03 + 160220 1.034108045077602e+00 -5.929309618204704e+00 -6.002858287394838e+00 4.081195167291060e+00 4.658867327181538e+00 9.225806987634365e+03 + 160240 9.690652528380195e-01 -5.868633054986858e+00 -6.011065764215862e+00 4.430787857803531e+00 4.612917200020067e+00 9.251023831886685e+03 + 160260 1.032900863787162e+00 -6.003321296492603e+00 -5.973296261933551e+00 3.705207116566222e+00 4.877615511363378e+00 9.135253302512057e+03 + 160280 1.009421266313451e+00 -6.009729224364233e+00 -5.996863257888558e+00 3.655306832178884e+00 4.729185202684092e+00 9.207413959393434e+03 + 160300 9.898118209843599e-01 -6.017056448600211e+00 -5.974920045504571e+00 3.605856874313787e+00 4.847810621476260e+00 9.140226160652444e+03 + 160320 9.865873670624269e-01 -6.043927894060685e+00 -6.001409975745514e+00 3.457988852588452e+00 4.702133319180756e+00 9.221365570554926e+03 + 160340 9.972764357017723e-01 -6.085613172472881e+00 -5.972072737509894e+00 3.221852994565400e+00 4.873819742448394e+00 9.131514498507227e+03 + 160360 9.625410277080177e-01 -6.054277830916212e+00 -5.910044171312459e+00 3.454905498381671e+00 5.283117491913114e+00 8.942955835836963e+03 + 160380 9.386798611680151e-01 -6.028729755141118e+00 -5.974627975276070e+00 3.565482966246116e+00 4.876143758454599e+00 9.139306228599671e+03 + 160400 9.412621422743230e-01 -6.036043694446783e+00 -5.975777580171305e+00 3.499266153911383e+00 4.845323508232222e+00 9.142838809521978e+03 + 160420 8.901954151449177e-01 -5.958544529686002e+00 -5.983429510312073e+00 3.891254020978171e+00 4.748360611284968e+00 9.166224071270773e+03 + 160440 9.540440279095108e-01 -6.045022557774733e+00 -5.964623702011779e+00 3.397088367044824e+00 4.858751038518428e+00 9.108755604963011e+03 + 160460 9.717326106687892e-01 -6.054274443241994e+00 -5.992345348350361e+00 3.403760462432396e+00 4.759366908796612e+00 9.193558794984960e+03 + 160480 9.841133773759392e-01 -6.050458687910786e+00 -6.008658588829266e+00 3.384959235382650e+00 4.624981872853165e+00 9.243656092332581e+03 + 160500 9.857170965525551e-01 -6.027538402958273e+00 -6.007632686627839e+00 3.555173318537368e+00 4.669475022106365e+00 9.240495970752519e+03 + 160520 9.504548608150292e-01 -5.948634311602605e+00 -6.004835591059705e+00 3.976196247495960e+00 4.653479803733405e+00 9.231883721066608e+03 + 160540 1.025772983123868e+00 -6.030375952437197e+00 -5.993747031623313e+00 3.524860101517636e+00 4.735189033138139e+00 9.197863177757654e+03 + 160560 1.000728380618666e+00 -5.962549678341017e+00 -6.011620542734482e+00 3.902179875678359e+00 4.620407378639363e+00 9.252761589101543e+03 + 160580 1.005717704235259e+00 -5.944086481030424e+00 -6.042090990889849e+00 3.977818870114446e+00 4.415061808352740e+00 9.346704161397722e+03 + 160600 1.077847471288511e+00 -6.029565772986225e+00 -6.046199186084481e+00 3.479160333964883e+00 4.383648701942342e+00 9.359420737771030e+03 + 160620 1.048252225599818e+00 -5.971456961838726e+00 -5.999696464499304e+00 3.861916807231214e+00 4.699761212905262e+00 9.216128718056727e+03 + 160640 9.610462916011152e-01 -5.834330632420808e+00 -6.044968014621085e+00 4.588619796144879e+00 4.379107351521339e+00 9.355599290331964e+03 + 160660 1.024613967875829e+00 -5.923538819381980e+00 -6.063178348026995e+00 4.069431953128927e+00 4.267600170502030e+00 9.412001974198305e+03 + 160680 1.053636107874291e+00 -5.968247058049092e+00 -6.040706656546415e+00 3.834363385155803e+00 4.418289157497547e+00 9.342425048616595e+03 + 160700 1.018286238269592e+00 -5.923814963911751e+00 -6.051965720508552e+00 4.054285371787454e+00 4.318423896143138e+00 9.377277705762193e+03 + 160720 1.059594829726587e+00 -5.998903463655076e+00 -6.003953583729110e+00 3.719464743563103e+00 4.690466172594443e+00 9.229198406020749e+03 + 160740 1.052393942943580e+00 -6.008292726760556e+00 -5.996881706169074e+00 3.703316167885994e+00 4.768840013972017e+00 9.207482280370616e+03 + 160760 1.022482097402826e+00 -5.989466385673874e+00 -6.030674670305198e+00 3.676409211805256e+00 4.439784864490757e+00 9.311462315478340e+03 + 160780 1.108649189565062e+00 -6.149531842300692e+00 -5.955251521763142e+00 2.904125542703263e+00 5.019713208012318e+00 9.080195550316439e+03 + 160800 9.629498461824223e-01 -5.973851642815937e+00 -5.982714019707520e+00 3.892009100698209e+00 4.841119961138350e+00 9.164055548405855e+03 + 160820 8.928878392252760e-01 -5.912579343842498e+00 -5.946018323410957e+00 4.181841444687677e+00 4.989829649340219e+00 9.052059150105721e+03 + 160840 8.977440436836467e-01 -5.953887530137131e+00 -6.007716111957810e+00 3.843146879173263e+00 4.534054832412808e+00 9.240734752360866e+03 + 160860 9.328680901094688e-01 -6.034701165803861e+00 -5.964242630111632e+00 3.515301113848696e+00 4.919884929216640e+00 9.107614328145522e+03 + 160880 9.721897161861465e-01 -6.111994922023370e+00 -5.975615134649156e+00 3.073784958512974e+00 4.856898802319598e+00 9.142349179195591e+03 + 160900 9.896340875941932e-01 -6.148504369293977e+00 -5.976428073598414e+00 2.897305233414045e+00 4.885393952018668e+00 9.144843040933920e+03 + 160920 9.321217545434516e-01 -6.065364051685483e+00 -5.947947632313242e+00 3.427224662009677e+00 5.101447912177262e+00 9.057954697797748e+03 + 160940 9.342985802039493e-01 -6.063782937291748e+00 -5.993726373034649e+00 3.346332106491121e+00 4.748607739673664e+00 9.197796279986298e+03 + 160960 9.843442540391312e-01 -6.130039329454951e+00 -5.952914113698474e+00 3.006942187438287e+00 5.024022586350528e+00 9.073080674535744e+03 + 160980 9.241315234708865e-01 -6.030606467553297e+00 -5.985754963506786e+00 3.558131158551515e+00 4.815675435534398e+00 9.173366568004292e+03 + 161000 9.895675138219547e-01 -6.115456744857433e+00 -5.968390239476424e+00 3.101899387254441e+00 4.946378019620347e+00 9.120262155367234e+03 + 161020 9.484283017247078e-01 -6.039371488429274e+00 -6.000836826311267e+00 3.501239361970288e+00 4.722511355071572e+00 9.219625439609994e+03 + 161040 9.378461028125493e-01 -6.006628779479262e+00 -6.010670577839912e+00 3.636436234150310e+00 4.613227602497182e+00 9.249841072910251e+03 + 161060 9.751397111636719e-01 -6.042248158738417e+00 -6.022947477578064e+00 3.480515484711070e+00 4.591342982704571e+00 9.287621840135949e+03 + 161080 9.526603356935284e-01 -5.988469957403186e+00 -6.012803722631137e+00 3.743660200131113e+00 4.603931954554224e+00 9.256402375927779e+03 + 161100 1.014057667809752e+00 -6.057817090462603e+00 -5.960768761228445e+00 3.393329874986283e+00 4.950596399629228e+00 9.097022318188392e+03 + 161120 1.020164419314882e+00 -6.043060673935757e+00 -6.005260528589705e+00 3.445198437626893e+00 4.662252721757507e+00 9.233190280953428e+03 + 161140 9.973283688029509e-01 -5.987442077490051e+00 -6.016812303752008e+00 3.727850997300435e+00 4.559202613076456e+00 9.268679820290001e+03 + 161160 9.693092690836458e-01 -5.925371244015134e+00 -5.958860041094356e+00 4.153573728045362e+00 4.961275872841876e+00 9.091178255123514e+03 + 161180 1.093899142035211e+00 -6.085998859504999e+00 -5.974671160997230e+00 3.216047101332310e+00 4.855307974069586e+00 9.139443491781911e+03 + 161200 1.064426123811495e+00 -6.021919898102770e+00 -5.973835342614594e+00 3.587132707129706e+00 4.863241665803725e+00 9.136896142548490e+03 + 161220 1.009955988437702e+00 -5.924368384314026e+00 -6.007060245066347e+00 4.067295901571217e+00 4.592466440607295e+00 9.238741240377889e+03 + 161240 1.086097448374550e+00 -6.024406830315661e+00 -5.983686213813101e+00 3.573388559155656e+00 4.807212640608394e+00 9.167027795240174e+03 + 161260 1.019618788514871e+00 -5.917844391594989e+00 -6.030064332701378e+00 4.091250340985165e+00 4.446866073172518e+00 9.309572621804036e+03 + 161280 1.033691115413999e+00 -5.937170957093135e+00 -5.976175260504660e+00 4.063615338596769e+00 4.839646592511344e+00 9.144036144805503e+03 + 161300 1.005882225940329e+00 -5.895702095128709e+00 -6.029941291196819e+00 4.252120459799505e+00 4.481298222527967e+00 9.309201340570153e+03 + 161320 1.078734638251447e+00 -6.008933509390550e+00 -6.036029380839561e+00 3.605003671107842e+00 4.449414984175068e+00 9.327971688714657e+03 + 161340 1.048605035059098e+00 -5.979060326142059e+00 -6.015070541887778e+00 3.821522418231038e+00 4.614746186856244e+00 9.263361507677848e+03 + 161360 9.515518029595686e-01 -5.859089460003956e+00 -6.060679799397777e+00 4.524339358876682e+00 4.366776434073160e+00 9.404248594394612e+03 + 161380 1.025523261669167e+00 -6.004617178858203e+00 -6.006921421792669e+00 3.667895601826619e+00 4.654664282316474e+00 9.238303600004194e+03 + 161400 9.895475119328700e-01 -5.997393818129471e+00 -6.005796487645971e+00 3.718216496115731e+00 4.669967067443085e+00 9.234840289342235e+03 + 161420 9.489099046790658e-01 -5.981680302672672e+00 -5.972045809092243e+00 3.800196074815875e+00 4.855518827887764e+00 9.131445177279282e+03 + 161440 9.824302010935702e-01 -6.069707568709373e+00 -6.019160721392371e+00 3.321708194898907e+00 4.611956014292476e+00 9.275984644478491e+03 + 161460 1.022792577551239e+00 -6.162385411534211e+00 -5.981028412278707e+00 2.872001870536002e+00 4.913381825166039e+00 9.158910389111221e+03 + 161480 9.697303842343118e-01 -6.108263709606693e+00 -5.986622584890484e+00 3.160905603845100e+00 4.859387765868789e+00 9.176043107054831e+03 + 161500 8.711132766710158e-01 -5.973175964813201e+00 -6.021574276639499e+00 3.858909382612777e+00 4.580998786491624e+00 9.283389227556463e+03 + 161520 9.514720950745312e-01 -6.094132184882064e+00 -5.971001776161700e+00 3.179551502515614e+00 4.886585363757110e+00 9.128251928208205e+03 + 161540 9.682115820061473e-01 -6.113333207809963e+00 -5.969154071776005e+00 3.111362170909172e+00 4.939261081665349e+00 9.122582227023777e+03 + 161560 9.391717382794473e-01 -6.058897432527799e+00 -5.979061748222227e+00 3.428338482137149e+00 4.886767335951963e+00 9.152904649896742e+03 + 161580 9.801968985478771e-01 -6.105267930585431e+00 -5.993009208827653e+00 3.158910141688762e+00 4.803517094002979e+00 9.195606395694052e+03 + 161600 8.928627566610730e-01 -5.959282257922852e+00 -6.013929428598797e+00 3.932512752692222e+00 4.618720242048614e+00 9.259848712747371e+03 + 161620 9.736687337846565e-01 -6.060885870622824e+00 -5.999126649962388e+00 3.402878186152601e+00 4.757509188393337e+00 9.214365697766449e+03 + 161640 9.663412620908324e-01 -6.029121513976166e+00 -5.979624146524955e+00 3.589708385813489e+00 4.873929929411195e+00 9.154603136040037e+03 + 161660 9.957287156539052e-01 -6.051556623797238e+00 -5.956198553517322e+00 3.434466593766025e+00 4.982027389926987e+00 9.083078031839552e+03 + 161680 1.012569056726924e+00 -6.053941882193143e+00 -6.030757113884825e+00 3.404172043054397e+00 4.537302570512059e+00 9.311726992608450e+03 + 161700 9.922643539980914e-01 -6.005784353359027e+00 -6.034561769448311e+00 3.668253064831352e+00 4.503008688355931e+00 9.323472907060286e+03 + 161720 9.292812169000150e-01 -5.899570549236382e+00 -6.024191340249188e+00 4.238830046775821e+00 4.523238179775209e+00 9.291472970537761e+03 + 161740 1.070674486573604e+00 -6.097856627760721e+00 -5.977040481546186e+00 3.236309657969971e+00 4.930054665772037e+00 9.146695247507294e+03 + 161760 1.014383953930517e+00 -6.006056172793192e+00 -5.984598135486674e+00 3.655718238704871e+00 4.778933609539438e+00 9.169828163077431e+03 + 161780 1.009062092671237e+00 -5.990904165192948e+00 -5.978169323882467e+00 3.734572826843716e+00 4.807698256358817e+00 9.150160430638423e+03 + 161800 1.028810270868253e+00 -6.012832004605261e+00 -6.001375635292638e+00 3.651195140298952e+00 4.716979385759458e+00 9.221276033019090e+03 + 161820 1.036196998924080e+00 -6.019876702551514e+00 -6.015545314166622e+00 3.604008395943712e+00 4.628879898329947e+00 9.264853254497964e+03 + 161840 1.037283042260460e+00 -6.021128194842947e+00 -6.025194315872060e+00 3.586646370424517e+00 4.563298074245159e+00 9.294552666315698e+03 + 161860 1.108700722609341e+00 -6.129227278529602e+00 -5.987569223578369e+00 3.047881307958539e+00 4.861303781001675e+00 9.178932797790869e+03 + 161880 9.939644425126315e-01 -5.964342200457356e+00 -6.026897679214423e+00 3.926565475405612e+00 4.567362235953478e+00 9.299805436016386e+03 + 161900 9.937327236543428e-01 -5.970679875573376e+00 -6.003489252415774e+00 3.895437691564763e+00 4.707041172501057e+00 9.227764453679720e+03 + 161920 9.727462996333139e-01 -5.946229891437940e+00 -6.025634186171143e+00 4.013385096453662e+00 4.557433348320719e+00 9.295906080135830e+03 + 161940 1.021199693183249e+00 -6.025954736506009e+00 -5.975981704101654e+00 3.560279033965541e+00 4.847231919333117e+00 9.143466923403259e+03 + 161960 9.449240212159047e-01 -5.920753570349351e+00 -6.054464795605219e+00 4.113215856921818e+00 4.345425309757387e+00 9.384995559344998e+03 + 161980 1.022340738626015e+00 -6.045671810814951e+00 -6.021758341060657e+00 3.450301353399193e+00 4.587616197325833e+00 9.283975771685886e+03 + 162000 9.696475607892012e-01 -5.981805618909952e+00 -6.023636557831040e+00 3.795399586468786e+00 4.555199861867022e+00 9.289759410353270e+03 + 162020 9.620830467883295e-01 -5.992361507397943e+00 -6.000616617962190e+00 3.744951916829950e+00 4.697549794495812e+00 9.218951175343944e+03 + 162040 1.048443032182123e+00 -6.155970426410600e+00 -6.015734711618873e+00 2.844728817588674e+00 4.649983993329498e+00 9.265425158011036e+03 + 162060 9.283078851211289e-01 -6.027320028868655e+00 -5.968524643361570e+00 3.559995099804065e+00 4.897607301942256e+00 9.120693403725800e+03 + 162080 8.198153346019057e-01 -5.912188963709472e+00 -6.039196350417110e+00 4.132664063454428e+00 4.403367994649597e+00 9.337768197060705e+03 + 162100 9.248710568636554e-01 -6.106353457205143e+00 -5.955432071881397e+00 3.180481701692716e+00 5.047095651230570e+00 9.080743218991662e+03 + 162120 9.449895670255876e-01 -6.158998837940627e+00 -5.955323531166824e+00 2.844157054295350e+00 5.013692184442381e+00 9.080409182660045e+03 + 162140 9.062080220858205e-01 -6.112521033052403e+00 -5.995792828385763e+00 3.058964756092311e+00 4.729236170919451e+00 9.204142059693064e+03 + 162160 8.713974382900049e-01 -6.062046908413455e+00 -5.994930158865159e+00 3.299554395615973e+00 4.684949157805715e+00 9.201502597039753e+03 + 162180 8.862678923255833e-01 -6.075122136014830e+00 -5.957038028047088e+00 3.291171611610900e+00 4.969228833018324e+00 9.085643585870150e+03 + 162200 9.096464549298351e-01 -6.090203467259455e+00 -5.970988303225447e+00 3.247221104979081e+00 4.931773025349365e+00 9.128202578096285e+03 + 162220 9.349409140836442e-01 -6.098318043961849e+00 -5.953401340529544e+00 3.181697209131612e+00 5.013831346027292e+00 9.074561124917460e+03 + 162240 9.370106122085293e-01 -6.065584912137465e+00 -5.969372439890490e+00 3.368594433848986e+00 4.921061338323081e+00 9.123267713359925e+03 + 162260 9.235452364979483e-01 -6.007959594723721e+00 -5.966384512223540e+00 3.634155693710341e+00 4.872886251149606e+00 9.114146170394381e+03 + 162280 9.961794431043668e-01 -6.080671767458593e+00 -5.960757802077831e+00 3.271158032443318e+00 4.959722578285824e+00 9.096971427553250e+03 + 162300 9.523189383031305e-01 -5.984741306053694e+00 -5.985599298878906e+00 3.788324897945702e+00 4.783398170369374e+00 9.172907905128632e+03 + 162320 1.001688483654537e+00 -6.033842553690658e+00 -6.030344450276324e+00 3.522912723797856e+00 4.542999374932715e+00 9.310416677535124e+03 + 162340 1.025904574764254e+00 -6.051988829280266e+00 -6.000656104700768e+00 3.419363171790314e+00 4.714123620039246e+00 9.219063130052336e+03 + 162360 1.046949091851151e+00 -6.068119541812703e+00 -5.985251988532794e+00 3.360980256718325e+00 4.836818571363991e+00 9.171844527729147e+03 + 162380 1.002845851537773e+00 -5.993126776374245e+00 -6.040598170754031e+00 3.696040299086607e+00 4.423452206383333e+00 9.342102248056308e+03 + 162400 9.839033823356719e-01 -5.959418560043376e+00 -6.015667921373240e+00 3.948192840406903e+00 4.625200303090285e+00 9.265198908223951e+03 + 162420 9.694366514663193e-01 -5.931272109618615e+00 -6.033644749744761e+00 3.986069312161163e+00 4.398229770441969e+00 9.320618278212931e+03 + 162440 1.012396050152234e+00 -5.988677874700462e+00 -6.017640161745479e+00 3.693393522149830e+00 4.527087588037904e+00 9.271277809029927e+03 + 162460 9.269441997739926e-01 -5.856799240311759e+00 -6.045570148259269e+00 4.464923569540539e+00 4.380971803902340e+00 9.357458936632758e+03 + 162480 1.063807442660780e+00 -6.055161347760672e+00 -5.989683645397223e+00 3.388782847974966e+00 4.764765947587579e+00 9.185410615485931e+03 + 162500 1.022911038661207e+00 -5.992387309901241e+00 -5.992108158768743e+00 3.696551561715313e+00 4.698154490716611e+00 9.192850761181518e+03 + 162520 1.054264656346463e+00 -6.039251239762955e+00 -5.988840903365375e+00 3.466422865502104e+00 4.755886818071348e+00 9.182828538086427e+03 + 162540 9.733280258555498e-01 -5.922190016133668e+00 -6.012741480136524e+00 4.059863205134388e+00 4.539902686036221e+00 9.256180924187152e+03 + 162560 9.855309860453070e-01 -5.942965222057665e+00 -6.059015181050457e+00 3.956813778797434e+00 4.290436955587710e+00 9.399055603873489e+03 + 162580 1.055864136735847e+00 -6.054253378276689e+00 -6.002564195630312e+00 3.398990272399224e+00 4.695797558029888e+00 9.224909438256465e+03 + 162600 9.800519700727006e-01 -5.953890902191777e+00 -5.979372999607837e+00 3.941576459866597e+00 4.795254313161748e+00 9.153816831732185e+03 + 162620 1.026595125570893e+00 -6.035291639269955e+00 -5.945470429665647e+00 3.527910908405805e+00 5.043678193741003e+00 9.050391231469672e+03 + 162640 1.022777697899419e+00 -6.045646652750457e+00 -5.981541170689617e+00 3.453266706664487e+00 4.821370304949116e+00 9.160469680342272e+03 + 162660 9.691566401379849e-01 -5.988053158801816e+00 -6.000386808779509e+00 3.752534393813119e+00 4.681712667015042e+00 9.218234804273327e+03 + 162680 1.020888598559480e+00 -6.089587827024706e+00 -5.989985286143323e+00 3.202182691365159e+00 4.774115894549451e+00 9.186339673988603e+03 + 162700 9.209466687283280e-01 -5.967267091345172e+00 -6.063462686540923e+00 3.815939486270949e+00 4.263569492436698e+00 9.412899221202115e+03 + 162720 9.991051786144821e-01 -6.111701599888931e+00 -5.996452793559635e+00 3.123898325108478e+00 4.785674805746435e+00 9.206172135098061e+03 + 162740 9.378060719269914e-01 -6.047652349487604e+00 -5.972033632305697e+00 3.451451605681474e+00 4.885665981698649e+00 9.131416272764287e+03 + 162760 9.390916994810455e-01 -6.070251961734650e+00 -5.964480419050129e+00 3.343613317952257e+00 4.950969884140109e+00 9.108322794983344e+03 + 162780 9.429474163981074e-01 -6.088238306529440e+00 -5.971086393494917e+00 3.197097851562317e+00 4.869802265406499e+00 9.128499018426706e+03 + 162800 9.576233233807784e-01 -6.114839447618790e+00 -6.025373488448162e+00 3.052566139172280e+00 4.566293521542461e+00 9.295118135538882e+03 + 162820 9.010569478704680e-01 -6.032367981292797e+00 -6.050756995162489e+00 3.494428974789758e+00 4.388836411459287e+00 9.373516627036663e+03 + 162840 9.382529723707786e-01 -6.082626891485834e+00 -5.934656618325058e+00 3.299441733603180e+00 5.149109940418123e+00 9.017556740700780e+03 + 162860 9.143661984321241e-01 -6.030937489706036e+00 -5.947368076621897e+00 3.522395097059893e+00 5.002263599313898e+00 9.056192283944229e+03 + 162880 9.363812377383377e-01 -6.035054696544214e+00 -5.996314936840706e+00 3.521187990412149e+00 4.743637685588130e+00 9.205729658004293e+03 + 162900 1.000539660454986e+00 -6.087428456700951e+00 -6.012139535258074e+00 3.200181028910081e+00 4.632501666758020e+00 9.254364091563433e+03 + 162920 1.005459746283917e+00 -6.048809320752847e+00 -5.968419014086199e+00 3.423626285255204e+00 4.885239866494851e+00 9.120351933383501e+03 + 162940 9.600468609334076e-01 -5.939150632349780e+00 -6.012866528171288e+00 4.076717777449703e+00 4.653429696144594e+00 9.256546665421571e+03 + 162960 1.034357349442555e+00 -6.013040491943967e+00 -5.980608310397456e+00 3.652103839853257e+00 4.838334445157193e+00 9.157613350819131e+03 + 162980 9.918071667963645e-01 -5.923608133823135e+00 -6.006367611756969e+00 4.144572934215768e+00 4.669355204931879e+00 9.236593957260600e+03 + 163000 1.057547532451302e+00 -6.005600497920716e+00 -5.992798797076263e+00 3.659295723641008e+00 4.732805070946656e+00 9.194938819356741e+03 + 163020 1.049525876087730e+00 -5.985092196358900e+00 -6.006085651888492e+00 3.740330276864253e+00 4.619782606486588e+00 9.235737014481039e+03 + 163040 1.084150747148902e+00 -6.033847492948065e+00 -5.982462700505708e+00 3.511065893577483e+00 4.806125323552430e+00 9.163296245555146e+03 + 163060 9.769507699404325e-01 -5.876105973424720e+00 -6.062898957961186e+00 4.404432454451126e+00 4.331838231121800e+00 9.411131193994179e+03 + 163080 1.041935449461572e+00 -5.979462172971780e+00 -5.992436744100774e+00 3.817171466414679e+00 4.742669471183607e+00 9.193838005601370e+03 + 163100 1.053567022511191e+00 -6.005452398138313e+00 -6.016400487970577e+00 3.675148119509009e+00 4.612282493480720e+00 9.267457209693708e+03 + 163120 1.003124997396243e+00 -5.942344114675308e+00 -6.050274556599367e+00 3.964113173676785e+00 4.344359873966930e+00 9.372031864187542e+03 + 163140 9.859355520507637e-01 -5.932898854065787e+00 -6.040286983702394e+00 4.065003202818840e+00 4.448363944186091e+00 9.341132738052167e+03 + 163160 1.045364875233624e+00 -6.040755024395786e+00 -6.005278105583509e+00 3.497389210431373e+00 4.701103168286909e+00 9.233267172097298e+03 + 163180 9.707677058002973e-01 -5.949661919303883e+00 -6.070282348684652e+00 3.906930153431946e+00 4.214308981976444e+00 9.434081499659260e+03 + 163200 9.735907385019225e-01 -5.975376847421571e+00 -6.074568679294881e+00 3.782190287348731e+00 4.212615438845810e+00 9.447392045821274e+03 + 163220 9.374662585397168e-01 -5.945562929214664e+00 -6.063187489759457e+00 4.000501850346781e+00 4.325083421356665e+00 9.412049765328986e+03 + 163240 1.002374933859561e+00 -6.066482125813056e+00 -6.041852407751598e+00 3.275163884324605e+00 4.416591536870048e+00 9.345985463868914e+03 + 163260 9.150862993151127e-01 -5.961225509418843e+00 -5.992097675239622e+00 3.883097582967046e+00 4.705824829371914e+00 9.192820539198161e+03 + 163280 9.399988505559478e-01 -6.016559770145100e+00 -6.041771166384676e+00 3.568629771018210e+00 4.423862032359606e+00 9.345716012276354e+03 + 163300 9.704780112688778e-01 -6.076931293233277e+00 -6.007508134581642e+00 3.296999976120679e+00 4.695638496297445e+00 9.240120248895115e+03 + 163320 9.408809394221747e-01 -6.043668691567787e+00 -6.009872590076376e+00 3.456330926751075e+00 4.650393371444562e+00 9.247389884493257e+03 + 163340 9.625997541240725e-01 -6.083925465322570e+00 -6.004540475866350e+00 3.190596141383418e+00 4.646437035628445e+00 9.231010677764496e+03 + 163360 9.882800108769305e-01 -6.126189020156537e+00 -5.978486784746520e+00 2.988392587389415e+00 4.836521679960793e+00 9.151130266329072e+03 + 163380 8.901865656485211e-01 -5.979328226514728e+00 -5.978357905652145e+00 3.858090309110309e+00 4.863662041659925e+00 9.150727532950910e+03 + 163400 9.469875699150684e-01 -6.053525489770889e+00 -5.991634095015122e+00 3.407017019395728e+00 4.762406985745728e+00 9.191404682129001e+03 + 163420 1.011542566003074e+00 -6.122237213464975e+00 -5.966446332793358e+00 3.038705189582827e+00 4.933280534960119e+00 9.114355345122020e+03 + 163440 9.540515180055131e-01 -5.992119434190923e+00 -5.997715262705100e+00 3.730641490025953e+00 4.698509376745888e+00 9.210053398894623e+03 + 163460 9.946748776698743e-01 -5.992887767325203e+00 -5.998087312562419e+00 3.750448867640140e+00 4.720592274261026e+00 9.211191638681305e+03 + 163480 1.059773788864986e+00 -6.036468045598911e+00 -5.995169656596435e+00 3.461014663259891e+00 4.698156403817154e+00 9.202232833639458e+03 + 163500 9.956217695310434e-01 -5.900107294630754e+00 -5.997023284258423e+00 4.255577994750785e+00 4.699071384607779e+00 9.207885450090302e+03 + 163520 1.057224216454209e+00 -5.962304958875155e+00 -5.987327941674829e+00 3.917498741532980e+00 4.773812902003172e+00 9.178186471860283e+03 + 163540 1.111412671351112e+00 -6.020211882977694e+00 -6.007752119047676e+00 3.584577240931668e+00 4.656123133560072e+00 9.240864797183114e+03 + 163560 1.068467727422145e+00 -5.945833352075362e+00 -6.041056012853789e+00 4.039867527001850e+00 4.493084273152991e+00 9.343492434361895e+03 + 163580 1.084511532003489e+00 -5.968236606069263e+00 -5.997278988057432e+00 3.832025646491579e+00 4.665259794821426e+00 9.208704359670903e+03 + 163600 1.118582070583703e+00 -6.024981863299381e+00 -5.997591148042043e+00 3.574278430048835e+00 4.731560155755959e+00 9.209647584853366e+03 + 163620 9.985248717808520e-01 -5.861430513778153e+00 -6.040971260499250e+00 4.377583199476421e+00 4.346632447963121e+00 9.343241803658140e+03 + 163640 1.062974589817197e+00 -5.977857247492961e+00 -6.017905478236272e+00 3.823036712935207e+00 4.593073574563441e+00 9.272060652149868e+03 + 163660 1.018893693271631e+00 -5.937092800697025e+00 -5.985835834906699e+00 4.073070459506291e+00 4.793180414114178e+00 9.173604202043412e+03 + 163680 1.031591260953455e+00 -5.983872404946798e+00 -5.999424284832351e+00 3.770027394621192e+00 4.680726093672711e+00 9.215295834365674e+03 + 163700 1.079205944342481e+00 -6.086409211507690e+00 -6.004468342407057e+00 3.245519595652851e+00 4.716036746337199e+00 9.230761554491524e+03 + 163720 9.812675873468011e-01 -5.972146060271352e+00 -6.035513189289492e+00 3.822118454403185e+00 4.458254593549503e+00 9.326393242758229e+03 + 163740 9.975645748926730e-01 -6.026065441268845e+00 -5.984854887397221e+00 3.580150819568476e+00 4.816788197211949e+00 9.170617190185658e+03 + 163760 9.684036557706799e-01 -6.007369673279056e+00 -6.009026793871195e+00 3.622200233071771e+00 4.612684790193130e+00 9.244769315730444e+03 + 163780 9.153738253604564e-01 -5.945897443134425e+00 -6.040785130857286e+00 4.012842143003315e+00 4.467982356276428e+00 9.342658819386490e+03 + 163800 9.558332817015761e-01 -6.018754431084333e+00 -5.982824598145575e+00 3.666420875091335e+00 4.872735535949360e+00 9.164404044405253e+03 + 163820 9.679519709488037e-01 -6.044566054477608e+00 -5.992524519596310e+00 3.453299502966128e+00 4.752130049656036e+00 9.194115352968131e+03 + 163840 9.151261453773077e-01 -5.970039492899417e+00 -6.019132007392272e+00 3.862473391424353e+00 4.580576576164320e+00 9.275843031456025e+03 + 163860 9.039889876868109e-01 -5.951143350114993e+00 -6.012645723280194e+00 3.946924390225841e+00 4.593768246049772e+00 9.255897488163235e+03 + 163880 9.859204923498662e-01 -6.065231546944524e+00 -6.012221304532954e+00 3.346726223252377e+00 4.651119238488112e+00 9.254611248490693e+03 + 163900 9.681545466516267e-01 -6.028676806571754e+00 -6.023478551560951e+00 3.534132945555673e+00 4.563982130255073e+00 9.289264457307238e+03 + 163920 9.396012507584544e-01 -5.974800362207032e+00 -6.004281250781792e+00 3.830300403134028e+00 4.661016578784995e+00 9.230188100722224e+03 + 163940 9.923433959214450e-01 -6.036924847801824e+00 -6.006166397689398e+00 3.511438574467872e+00 4.688058354868192e+00 9.235974624905397e+03 + 163960 9.686362984195618e-01 -5.981574131221270e+00 -6.023030497433883e+00 3.795251267702432e+00 4.557202397557670e+00 9.287888783357490e+03 + 163980 1.059650376550190e+00 -6.093506946021860e+00 -6.022970558939889e+00 3.160019666736987e+00 4.565050516832287e+00 9.287702963509893e+03 + 164000 9.971159770396719e-01 -5.977241619068239e+00 -5.978006148240961e+00 3.860385411511667e+00 4.855995366691391e+00 9.149635724428328e+03 + 164020 9.050964246293430e-01 -5.813249796164339e+00 -6.053964192959993e+00 4.688129264627769e+00 4.305909947794604e+00 9.383398366353071e+03 + 164040 1.028496415474589e+00 -5.955111537454676e+00 -5.985504100891775e+00 3.913527096207722e+00 4.739008293717908e+00 9.172604921842982e+03 + 164060 1.107622705064118e+00 -6.019685369060274e+00 -5.983995279651374e+00 3.634853856380777e+00 4.839791872790163e+00 9.167971665901036e+03 + 164080 1.063408094586710e+00 -5.902070284021056e+00 -5.969140670066672e+00 4.240553398519834e+00 4.855424862737208e+00 9.122520695107305e+03 + 164100 1.061599488060522e+00 -5.854877393774347e+00 -5.969703072134481e+00 4.564824171796552e+00 4.905477357436365e+00 9.124196831719857e+03 + 164120 1.100869890252349e+00 -5.878327059857710e+00 -5.994582010667012e+00 4.372239756648847e+00 4.704685838706339e+00 9.200395785014220e+03 + 164140 1.136511394344940e+00 -5.909331182215656e+00 -6.044153085248372e+00 4.185727050710640e+00 4.411558819874721e+00 9.353092333013557e+03 + 164160 1.118192867790441e+00 -5.883060959568578e+00 -5.989980190470379e+00 4.279668600650405e+00 4.665721831114753e+00 9.186310796383392e+03 + 164180 1.111232517703800e+00 -5.882169389089628e+00 -5.969768804562344e+00 4.405005108786844e+00 4.901995709176775e+00 9.124434280072626e+03 + 164200 1.117269786150672e+00 -5.905387768707530e+00 -6.024038276264602e+00 4.159724154116934e+00 4.478414578617522e+00 9.290995326695194e+03 + 164220 1.094975867228970e+00 -5.894105816122332e+00 -6.051079932828270e+00 4.244822532098496e+00 4.343452862306947e+00 9.374480862989836e+03 + 164240 1.067784955941933e+00 -5.879341231258513e+00 -6.007849403847105e+00 4.327485970935253e+00 4.589572157356121e+00 9.241134562308154e+03 + 164260 1.027109114708167e+00 -5.847220157632726e+00 -5.970673442130771e+00 4.499568609704085e+00 4.790680745782273e+00 9.127216739626672e+03 + 164280 1.016432128067745e+00 -5.855741263480742e+00 -5.941174707953865e+00 4.500606250185641e+00 5.010034191238163e+00 9.037292992039147e+03 + 164300 1.033186406352248e+00 -5.904234408865707e+00 -5.980340981152151e+00 4.233289023163732e+00 4.796273307640976e+00 9.156625302575785e+03 + 164320 1.040832028289954e+00 -5.939639693254617e+00 -5.940891591654474e+00 4.058104183111572e+00 5.050915588768947e+00 9.036447638221440e+03 + 164340 1.024754839009441e+00 -5.939448811043752e+00 -5.952571189172556e+00 4.039711612802326e+00 4.964360886905282e+00 9.072006121574126e+03 + 164360 1.028650852326712e+00 -5.970953189535612e+00 -5.968974657958665e+00 3.805013598711300e+00 4.816374633202903e+00 9.122028932372818e+03 + 164380 9.998114634570682e-01 -5.953917331440081e+00 -5.984350428002259e+00 3.940868235228549e+00 4.766116685262051e+00 9.169061944623983e+03 + 164400 1.002726068685666e+00 -5.980955395089477e+00 -5.973877574015285e+00 3.765918401334437e+00 4.806560345231722e+00 9.137024415788659e+03 + 164420 9.565950907560035e-01 -5.932421468261052e+00 -6.031678687834620e+00 4.020042680586270e+00 4.450092365789758e+00 9.314540255887101e+03 + 164440 1.025480832283233e+00 -6.054510116664808e+00 -5.987520962423947e+00 3.416580358221581e+00 4.801242448410720e+00 9.178782141271642e+03 + 164460 9.674260668800186e-01 -5.986988703302007e+00 -5.978401932410465e+00 3.752259563243836e+00 4.801566130501573e+00 9.150854044178843e+03 + 164480 9.838339156421041e-01 -6.028033396788077e+00 -5.995498058569312e+00 3.540121460533364e+00 4.726944407412831e+00 9.203233646619796e+03 + 164500 9.706037310128078e-01 -6.021759413882279e+00 -6.010243841327645e+00 3.522382103217763e+00 4.588506302855565e+00 9.248496821830353e+03 + 164520 9.754829110189486e-01 -6.039362646282163e+00 -5.982690733923285e+00 3.524474424231741e+00 4.849893314946515e+00 9.163980146872344e+03 + 164540 9.718835395546767e-01 -6.039838570753404e+00 -5.989744826713121e+00 3.469628908849958e+00 4.757274939111097e+00 9.185612622385257e+03 + 164560 9.191992179765578e-01 -5.964877941656011e+00 -6.039388597087362e+00 3.827168943915428e+00 4.399317229941953e+00 9.338374248565364e+03 + 164580 1.084432116092379e+00 -6.210614438515273e+00 -5.977030825401703e+00 2.581518097717367e+00 4.922791351162791e+00 9.146710149042601e+03 + 164600 9.335082159823005e-01 -5.985814810973878e+00 -6.046790377507905e+00 3.767146320601985e+00 4.417015181625172e+00 9.361265364112360e+03 + 164620 9.349814811889484e-01 -5.985996151292576e+00 -5.999526575645437e+00 3.724605949414201e+00 4.646912158953675e+00 9.215584018143345e+03 + 164640 9.468319882625965e-01 -5.995703666087840e+00 -5.977041967983901e+00 3.646055966295157e+00 4.753214324696422e+00 9.146699543818218e+03 + 164660 9.643671252952503e-01 -6.003327982820285e+00 -5.979108468432036e+00 3.701306280655364e+00 4.840378480230428e+00 9.153018836618030e+03 + 164680 1.021998166135702e+00 -6.056461500062768e+00 -5.963783519556493e+00 3.358469794563737e+00 4.890641100501897e+00 9.106203801965776e+03 + 164700 1.046269052354148e+00 -6.048685444652794e+00 -5.978966040354639e+00 3.443921145884265e+00 4.844260754407224e+00 9.152568958915304e+03 + 164720 1.051696417347132e+00 -6.009111048446540e+00 -5.972952494514720e+00 3.670999726364327e+00 4.878627738558977e+00 9.134191214024278e+03 + 164740 1.040978474194928e+00 -5.949803411172401e+00 -6.010537353973996e+00 3.982951298296942e+00 4.634207600182913e+00 9.249359212305586e+03 + 164760 1.025623638885554e+00 -5.895307582639829e+00 -5.962388141936643e+00 4.276082192456057e+00 4.890895240290749e+00 9.101893085730171e+03 + 164780 1.042456225419418e+00 -5.895355159413683e+00 -6.014296562793065e+00 4.200524702765954e+00 4.517544758438850e+00 9.260936993093348e+03 + 164800 1.068656606223340e+00 -5.917739361049619e+00 -6.008509831398099e+00 4.148044942203878e+00 4.626826854778016e+00 9.243159686713087e+03 + 164820 1.018335320086234e+00 -5.836912576550863e+00 -6.030110608282105e+00 4.479063161896740e+00 4.369690166397162e+00 9.309687078817253e+03 + 164840 1.072673506426081e+00 -5.918105174966652e+00 -5.971422337818447e+00 4.103366756996899e+00 4.797211357097614e+00 9.129510074017495e+03 + 164860 1.025915273658921e+00 -5.854942970353795e+00 -6.041009298341038e+00 4.462263308328819e+00 4.393841659354872e+00 9.343351313401559e+03 + 164880 1.084665357320912e+00 -5.958500976699422e+00 -6.025179311567265e+00 3.884025133426399e+00 4.501147816176270e+00 9.294481646926108e+03 + 164900 1.043902126445272e+00 -5.920664705150137e+00 -6.032279299120764e+00 4.064063170347868e+00 4.423154899465933e+00 9.316413510118817e+03 + 164920 1.122611361386446e+00 -6.068605577410258e+00 -5.983075593297952e+00 3.375370748081294e+00 4.866497152576423e+00 9.165155415975614e+03 + 164940 9.670740599726690e-01 -5.872039974160868e+00 -6.031616856017725e+00 4.319433292759542e+00 4.403118142694812e+00 9.314367122202440e+03 + 164960 1.089354032746623e+00 -6.089454398368446e+00 -5.969560214277891e+00 3.159064471845697e+00 4.847515430458690e+00 9.123874919743450e+03 + 164980 9.700531352679465e-01 -5.943701214606546e+00 -6.041200206362054e+00 3.928342023699579e+00 4.368487725119234e+00 9.343973030392963e+03 + 165000 9.769658728121204e-01 -5.978231304017480e+00 -6.029810035084410e+00 3.827328795792156e+00 4.531155740223004e+00 9.308776288744199e+03 + 165020 1.010168735416380e+00 -6.045415221875551e+00 -5.978760374676797e+00 3.438312058777137e+00 4.821054506196652e+00 9.151963201247345e+03 + 165040 1.005054054920648e+00 -6.048310516864852e+00 -5.949481230094030e+00 3.487425593390847e+00 5.054918651811611e+00 9.062618299601332e+03 + 165060 1.014523291251254e+00 -6.067312905632370e+00 -5.996476608367120e+00 3.301686436026075e+00 4.708439416804723e+00 9.206236727141988e+03 + 165080 9.543702408477041e-01 -5.981085384067523e+00 -6.020673945775648e+00 3.731796724958406e+00 4.504473077320226e+00 9.280635900362739e+03 + 165100 9.727253771495086e-01 -6.009016144867810e+00 -5.994823924012419e+00 3.606182790935523e+00 4.687676719326261e+00 9.201151551942246e+03 + 165120 9.617572093860809e-01 -5.990321708269255e+00 -5.971507373677026e+00 3.762379741821947e+00 4.870414562559400e+00 9.129765427071034e+03 + 165140 9.820892137076324e-01 -6.014620575000152e+00 -5.997580585444950e+00 3.619117609986189e+00 4.716963866942024e+00 9.209599005995622e+03 + 165160 9.619088179754316e-01 -5.977848262489456e+00 -6.015568021509829e+00 3.804931981334170e+00 4.588339287925342e+00 9.264904139084412e+03 + 165180 1.004613122737017e+00 -6.032935843750215e+00 -6.033472662388002e+00 3.503875366520076e+00 4.500792870829486e+00 9.320087822949954e+03 + 165200 9.817502186536257e-01 -5.991091722631145e+00 -6.016199775100425e+00 3.752412551768736e+00 4.608238229031568e+00 9.266859939050199e+03 + 165220 1.037793243937883e+00 -6.066639303456450e+00 -5.955131319855951e+00 3.356356956730553e+00 4.996653054369308e+00 9.079820807117720e+03 + 165240 9.408478438636525e-01 -5.913211797875518e+00 -6.059540530769575e+00 4.137153958621449e+00 4.296911730045541e+00 9.400713331525743e+03 + 165260 1.056202321302382e+00 -6.072884361993731e+00 -6.002450834281791e+00 3.385726536416652e+00 4.790166752091802e+00 9.224585460211125e+03 + 165280 9.956318993119190e-01 -5.970626982876918e+00 -6.017525442249031e+00 3.883805011117702e+00 4.614506799889895e+00 9.270942381596016e+03 + 165300 1.033258383753133e+00 -6.013240003780882e+00 -6.009393342336059e+00 3.653708140288823e+00 4.675796265573927e+00 9.245899792824561e+03 + 165320 1.038360998468479e+00 -6.004595751847910e+00 -6.011821456358575e+00 3.664385336482137e+00 4.622894223007743e+00 9.253369192527471e+03 + 165340 1.021338148043310e+00 -5.959479167051520e+00 -6.008425338002967e+00 3.953436407707745e+00 4.672379919709060e+00 9.242928949339082e+03 + 165360 1.015575513426695e+00 -5.925642791344301e+00 -6.070136474003647e+00 4.040396173119261e+00 4.210691086964174e+00 9.433611815624807e+03 + 165380 1.039804046873806e+00 -5.936048975719386e+00 -6.061173350899948e+00 3.978412233747961e+00 4.259928708526689e+00 9.405806775931182e+03 + 165400 1.042556575508926e+00 -5.914461507033701e+00 -6.026848968962740e+00 4.146432177017839e+00 4.501085978717771e+00 9.299625229993206e+03 + 165420 9.977039289707226e-01 -5.823902664767362e+00 -5.985229405389468e+00 4.650333187946110e+00 4.723970078061545e+00 9.171728872089087e+03 + 165440 1.068296251354389e+00 -5.901796126901480e+00 -6.027568089692879e+00 4.123737036977791e+00 4.401534963481240e+00 9.301850009709620e+03 + 165460 1.098248037293794e+00 -5.923791750159210e+00 -6.018083376237074e+00 4.086637899317971e+00 4.545200790796898e+00 9.272611399229312e+03 + 165480 1.063153422020545e+00 -5.857820525567718e+00 -6.036322631177760e+00 4.404318448061345e+00 4.379331734536913e+00 9.328857249715391e+03 + 165500 1.098491840064453e+00 -5.906518008535035e+00 -6.006749987199053e+00 4.189349696742466e+00 4.613802164405103e+00 9.237755000038700e+03 + 165520 1.104873607144362e+00 -5.923594587943448e+00 -6.020876317218788e+00 4.112202131189014e+00 4.553595387391066e+00 9.281241201914198e+03 + 165540 1.083340706492949e+00 -5.912541536142948e+00 -6.004085017349616e+00 4.158376319675264e+00 4.632719484278641e+00 9.229595481470982e+03 + 165560 1.064433518446639e+00 -5.920553264396656e+00 -6.057762922465115e+00 4.035435383755443e+00 4.247556294000383e+00 9.395178650764199e+03 + 165580 1.059594300726101e+00 -5.960256413048246e+00 -5.990933669896851e+00 3.881414852365370e+00 4.705261296250525e+00 9.189235476617834e+03 + 165600 9.578878049833790e-01 -5.858779536531175e+00 -6.016671497060699e+00 4.379429544982029e+00 4.472789473919579e+00 9.268284528847695e+03 + 165620 9.860863426100877e-01 -5.938909239617971e+00 -6.028497882457073e+00 3.972318658651538e+00 4.457886807671741e+00 9.304743696353415e+03 + 165640 9.903699795838622e-01 -5.977744498520449e+00 -6.041881946426940e+00 3.782304897806056e+00 4.414017746688996e+00 9.346079866347858e+03 + 165660 1.056830160155249e+00 -6.103907014461154e+00 -6.001936894152008e+00 3.077942985353171e+00 4.663471195993410e+00 9.223013706719576e+03 + 165680 9.064631414816192e-01 -5.900187761570707e+00 -6.055460346234909e+00 4.143383477544194e+00 4.251784268047522e+00 9.388042642517534e+03 + 165700 9.833907734372845e-01 -6.026726328495697e+00 -5.948845595943602e+00 3.624233227061930e+00 5.071436445380474e+00 9.060671264085009e+03 + 165720 1.023381494728409e+00 -6.090759543815699e+00 -5.948819161374006e+00 3.204392050443085e+00 5.019435691626480e+00 9.060603135029378e+03 + 165740 9.747053698121926e-01 -6.020270881561415e+00 -5.982813294832175e+00 3.576306759306865e+00 4.791394018848973e+00 9.164373897988969e+03 + 165760 9.543154074357806e-01 -5.990672692636865e+00 -6.010986091431414e+00 3.712513216646573e+00 4.595870537279968e+00 9.250783871721011e+03 + 165780 9.554647733168787e-01 -5.990205385478275e+00 -5.971065314528296e+00 3.733287122092894e+00 4.843192371404079e+00 9.128447743785096e+03 + 165800 9.732244930071225e-01 -6.010631298193614e+00 -5.965211675228476e+00 3.672709202279019e+00 4.933515706008778e+00 9.110551526546511e+03 + 165820 9.473743471869892e-01 -5.962235396079466e+00 -6.011246127063638e+00 3.881759483464122e+00 4.600332281766899e+00 9.251547037464021e+03 + 165840 1.011924310432692e+00 -6.043385435605010e+00 -5.972675738908853e+00 3.474971429022394e+00 4.880997449741924e+00 9.133341722474919e+03 + 165860 1.013295165509699e+00 -6.026967378925008e+00 -5.983888650980971e+00 3.552134439396830e+00 4.799499161663098e+00 9.167652163248356e+03 + 165880 9.847839593526763e-01 -5.963368809264665e+00 -5.978726523272172e+00 3.897929601048453e+00 4.809743230618782e+00 9.151872253100451e+03 + 165900 1.049072551985663e+00 -6.033724968718434e+00 -6.000078750219553e+00 3.504815763241334e+00 4.698017556597394e+00 9.217291316682305e+03 + 165920 1.020196019336090e+00 -5.965434959364369e+00 -6.027808249932958e+00 3.880020043893011e+00 4.521862957212651e+00 9.302613637969582e+03 + 165940 1.056421889380903e+00 -5.994747870495123e+00 -6.008647296987023e+00 3.701665257630231e+00 4.621852599784442e+00 9.243616728342626e+03 + 165960 9.924313193398050e-01 -5.877499241298957e+00 -6.024178712104055e+00 4.361994386639634e+00 4.519738166702012e+00 9.291392935428195e+03 + 165980 1.072087859979581e+00 -5.970643447750860e+00 -5.952949845527375e+00 3.877577391269416e+00 4.979176793312766e+00 9.073155590724476e+03 + 166000 1.080955707512629e+00 -5.957709921967445e+00 -6.026331627000244e+00 3.953844754985171e+00 4.559808305512306e+00 9.298033881954072e+03 + 166020 1.070824669500611e+00 -5.921138750473912e+00 -6.019494639713771e+00 4.082104324536289e+00 4.517329587996354e+00 9.276971808743703e+03 + 166040 9.817239352684638e-01 -5.771338927385496e+00 -6.013532499602240e+00 4.923077546259635e+00 4.532364575256917e+00 9.258622612691252e+03 + 166060 1.044741590637170e+00 -5.846599938542488e+00 -6.025065317257440e+00 4.501165021063160e+00 4.476389199053805e+00 9.294149286012944e+03 + 166080 1.078490164408772e+00 -5.879650625016050e+00 -6.032492188645634e+00 4.362420813788909e+00 4.484780903272312e+00 9.317050432607357e+03 + 166100 1.138171028242104e+00 -5.956743455057570e+00 -6.025912076540264e+00 3.930201697944175e+00 4.533024769580966e+00 9.296771239207448e+03 + 166120 1.028287180167065e+00 -5.795511558084518e+00 -6.095249898844538e+00 4.631061724922556e+00 3.909917787920196e+00 9.511784097227841e+03 + 166140 1.089761491445663e+00 -5.905229731986621e+00 -5.982898783564384e+00 4.193531048070700e+00 4.747543334664297e+00 9.164628017108820e+03 + 166160 1.058615306112008e+00 -5.891802045709340e+00 -6.020021242460093e+00 4.207026329029580e+00 4.470771859430185e+00 9.278602796795421e+03 + 166180 1.062940105276478e+00 -5.944192797629976e+00 -5.959626484201280e+00 3.969565289498466e+00 4.880942672850757e+00 9.093528096234922e+03 + 166200 9.888429213514667e-01 -5.883278452283350e+00 -6.023515519233941e+00 4.319340117149365e+00 4.514077177103098e+00 9.289358208487991e+03 + 166220 1.051702488927136e+00 -6.023886786142014e+00 -6.019302245442235e+00 3.541763805563480e+00 4.568088947716989e+00 9.276398849808000e+03 + 166240 1.019045101323452e+00 -6.016806213414773e+00 -5.989426676190296e+00 3.649432114740178e+00 4.806649654452820e+00 9.184623518112741e+03 + 166260 9.824916960038327e-01 -5.994122208710265e+00 -6.002035222637783e+00 3.657809400784662e+00 4.612371650277907e+00 9.223301137996665e+03 + 166280 1.003163576358764e+00 -6.049079477134097e+00 -5.986728581831542e+00 3.465934104005252e+00 4.823962593602382e+00 9.176344594168633e+03 + 166300 9.880437105272510e-01 -6.044789314033777e+00 -6.008098597272616e+00 3.496370989524164e+00 4.707054763036824e+00 9.241895593987210e+03 + 166320 8.980946262365008e-01 -5.924239694071879e+00 -5.981527661669339e+00 4.069634023932797e+00 4.740677648703849e+00 9.160443142450125e+03 + 166340 9.803097422697198e-01 -6.052039970201533e+00 -6.034627058876715e+00 3.344833750994691e+00 4.444821382461113e+00 9.323651574189877e+03 + 166360 9.621337593517958e-01 -6.028690771817849e+00 -6.021025481531747e+00 3.514417836653004e+00 4.558433119675643e+00 9.281714657807030e+03 + 166380 1.018722453043519e+00 -6.114153949597096e+00 -5.992759052536343e+00 3.078965751775217e+00 4.776034036497668e+00 9.194839674395589e+03 + 166400 9.408289358595047e-01 -5.997622779727496e+00 -6.017494690752390e+00 3.661195904868232e+00 4.547088316594998e+00 9.270830466725287e+03 + 166420 9.566200810122690e-01 -6.017519729330752e+00 -5.972826693219920e+00 3.614882932911116e+00 4.871517262484501e+00 9.133810381533072e+03 + 166440 9.448289404782083e-01 -5.988921341645425e+00 -6.049652361129952e+00 3.699354681435433e+00 4.350627769460390e+00 9.370104144652429e+03 + 166460 9.714069360399427e-01 -6.013318248930421e+00 -6.036075302816402e+00 3.601595253259851e+00 4.470920728203845e+00 9.328135562974447e+03 + 166480 1.013357361065510e+00 -6.058340115972192e+00 -5.982558542292470e+00 3.423879936991908e+00 4.859029460221498e+00 9.163565378841517e+03 + 166500 9.703128896339069e-01 -5.972296823807082e+00 -5.991084258028825e+00 3.834051437987631e+00 4.726171083340333e+00 9.189689902987575e+03 + 166520 9.571751637558621e-01 -5.926173922930206e+00 -6.000008126687392e+00 4.052101487088195e+00 4.628134063308322e+00 9.217076384433414e+03 + 166540 1.039880114046356e+00 -6.013219898585210e+00 -6.030854401147799e+00 3.597795979334305e+00 4.496535936689469e+00 9.312005740095510e+03 + 166560 1.041390106611749e+00 -5.980506430579786e+00 -6.014342437570929e+00 3.758449286306154e+00 4.564157698057852e+00 9.261135439803022e+03 + 166580 1.110460555318594e+00 -6.054338678341166e+00 -5.973471478150576e+00 3.350850383747578e+00 4.815202361400731e+00 9.135817473272567e+03 + 166600 1.061221099922338e+00 -5.958097725723356e+00 -5.996303464918835e+00 3.979711584577955e+00 4.760328317798485e+00 9.205677454533614e+03 + 166620 1.043716709224948e+00 -5.913166465421947e+00 -5.984463416776052e+00 4.189183330385278e+00 4.779785202542445e+00 9.169393461271482e+03 + 166640 1.028057032987457e+00 -5.875412435130477e+00 -6.066643490439782e+00 4.284945193655410e+00 4.186866881159212e+00 9.422750810508847e+03 + 166660 1.037168389036773e+00 -5.881768157210791e+00 -6.013388620994963e+00 4.327156555120002e+00 4.571371483870342e+00 9.258189848752347e+03 + 166680 1.050877531331690e+00 -5.903974277614931e+00 -6.009529490624907e+00 4.210561224669931e+00 4.604446856950228e+00 9.246326082804910e+03 + 166700 1.025596187429537e+00 -5.876562636174276e+00 -6.034124136485524e+00 4.296264453750373e+00 4.391521936399816e+00 9.322105014156095e+03 + 166720 1.138393992090791e+00 -6.064965945319823e+00 -5.944471505844042e+00 3.366046022779667e+00 5.057943740703850e+00 9.047378999948754e+03 + 166740 9.686668918353576e-01 -5.847351708554185e+00 -5.979442814730794e+00 4.538173140194328e+00 4.779685567495624e+00 9.154002767234599e+03 + 166760 9.985051542472910e-01 -5.937324419906267e+00 -5.947767401627976e+00 4.035573107152253e+00 4.975607890060003e+00 9.057375388576269e+03 + 166780 1.003825264929499e+00 -6.003858588798810e+00 -5.974483602863861e+00 3.665147942703196e+00 4.833823657706055e+00 9.138875650980375e+03 + 166800 9.576300552377509e-01 -5.992491253671163e+00 -5.976383750357904e+00 3.802107063050104e+00 4.894598839702923e+00 9.144672094975796e+03 + 166820 1.002434333289818e+00 -6.101736914368355e+00 -5.958256418346563e+00 3.142448790310936e+00 4.966336002003064e+00 9.089370518746031e+03 + 166840 9.620779427723199e-01 -6.064745723709705e+00 -6.013682420761530e+00 3.330506617587796e+00 4.623720005136809e+00 9.259101432003305e+03 + 166860 1.003489299029601e+00 -6.138423350988524e+00 -5.961156248787313e+00 2.973281599235478e+00 4.991176732070238e+00 9.098213745398043e+03 + 166880 9.775316476436242e-01 -6.104764934486347e+00 -5.962355934443709e+00 3.172862157272285e+00 4.990596673238647e+00 9.101851307250265e+03 + 166900 9.403452259315485e-01 -6.046782522773098e+00 -5.985600665315387e+00 3.436721083735883e+00 4.788036777119903e+00 9.172881170875033e+03 + 166920 9.330254618684513e-01 -6.027612092860740e+00 -5.968457798859585e+00 3.555460320774836e+00 4.895133431026878e+00 9.120486251690278e+03 + 166940 9.586002465029356e-01 -6.051849792598676e+00 -5.985330337645550e+00 3.375706187971280e+00 4.757671192164517e+00 9.172096025760129e+03 + 166960 9.714061394774155e-01 -6.051723602416153e+00 -6.011787809695470e+00 3.400945690097849e+00 4.630263191943966e+00 9.253293015434305e+03 + 166980 1.019945844436534e+00 -6.103703868024522e+00 -5.986513843317903e+00 3.173860129992980e+00 4.846783386956098e+00 9.175706903226654e+03 + 167000 9.967567792874311e-01 -6.047763846288339e+00 -5.991061166911404e+00 3.462402439496906e+00 4.787997999190540e+00 9.189639774144065e+03 + 167020 1.001113670401895e+00 -6.031482839549992e+00 -6.017827023640234e+00 3.566658016387454e+00 4.645071824571965e+00 9.271848884138444e+03 + 167040 1.033707594470653e+00 -6.055774237017538e+00 -5.999685247344539e+00 3.416963017203707e+00 4.739034675649163e+00 9.216069825992030e+03 + 167060 1.026573680350488e+00 -6.022847994290831e+00 -5.980262760583542e+00 3.559897142885866e+00 4.804428144876740e+00 9.156582554288751e+03 + 167080 1.011831074564014e+00 -5.980435038606925e+00 -5.987953446405372e+00 3.845386817181125e+00 4.802214956132593e+00 9.180097213675272e+03 + 167100 1.096561454948223e+00 -6.087185408061775e+00 -6.003559779106312e+00 3.277212703984756e+00 4.757404006471281e+00 9.227988337753650e+03 + 167120 1.053694923563616e+00 -6.008189606156913e+00 -6.019876518075974e+00 3.656401445980805e+00 4.589293389197783e+00 9.278174192650242e+03 + 167140 9.814194498957651e-01 -5.890448412965628e+00 -6.035489537953167e+00 4.310147699608074e+00 4.477299114888070e+00 9.326317698517538e+03 + 167160 1.066819568770250e+00 -6.009257807432592e+00 -6.028859181819357e+00 3.669805579296161e+00 4.557251454264474e+00 9.305867925104201e+03 + 167180 1.064085605237366e+00 -6.003681019543407e+00 -6.038769751407557e+00 3.661338721583927e+00 4.459853793256275e+00 9.336458148533913e+03 + 167200 1.037627159819815e+00 -5.968254707061046e+00 -6.003017113251405e+00 3.869776631791377e+00 4.670165515981368e+00 9.226315668885503e+03 + 167220 9.834626937560229e-01 -5.896575693161480e+00 -6.082680103988425e+00 4.216741077319478e+00 4.148100750786660e+00 9.472603496475551e+03 + 167240 9.832837858535851e-01 -5.913697111999280e+00 -6.040728527885348e+00 4.155941018939332e+00 4.426506970873456e+00 9.342480551619055e+03 + 167260 1.040088384177310e+00 -6.025510347719773e+00 -5.990656684251925e+00 3.551109864833161e+00 4.751244994052536e+00 9.188389527874853e+03 + 167280 1.037757888713675e+00 -6.064157491568846e+00 -5.969358847555505e+00 3.398308668201893e+00 4.942657152169242e+00 9.123245328698647e+03 + 167300 9.593723770729133e-01 -6.000702405496546e+00 -5.989845340167843e+00 3.689198952952725e+00 4.751541902195570e+00 9.185910485001827e+03 + 167320 9.998361980444108e-01 -6.108305917284426e+00 -5.951004853828296e+00 3.143637720820341e+00 5.046884769446338e+00 9.067251309766254e+03 + 167340 9.112913740603147e-01 -6.015697731156003e+00 -5.966930834496928e+00 3.665225458122509e+00 4.945252525391783e+00 9.115816361494381e+03 + 167360 9.563823307781835e-01 -6.108250637640312e+00 -5.976352613329128e+00 3.127314517998898e+00 4.884693384747010e+00 9.144602177819317e+03 + 167380 9.311146007781271e-01 -6.084143989975370e+00 -5.991676589713742e+00 3.222764767390947e+00 4.753726888977164e+00 9.191525814340639e+03 + 167400 9.507028892241529e-01 -6.117153403416495e+00 -5.969471983277300e+00 3.108804237696396e+00 4.956813805761559e+00 9.123589335260520e+03 + 167420 9.296182230122145e-01 -6.081578044092806e+00 -5.980311394244137e+00 3.279571697146591e+00 4.861060471541068e+00 9.156724538785918e+03 + 167440 9.102224246456192e-01 -6.040783489802114e+00 -6.004598076194632e+00 3.456468238631792e+00 4.664250483240612e+00 9.231185621095112e+03 + 167460 1.005427905469429e+00 -6.165806495040464e+00 -5.957583484314961e+00 2.856044963808080e+00 5.051693713800690e+00 9.087324215569588e+03 + 167480 9.214599244554507e-01 -6.020481279917561e+00 -6.038276589420587e+00 3.536302341804785e+00 4.434118920823167e+00 9.334935704158399e+03 + 167500 9.348585986479099e-01 -6.018159720045126e+00 -6.033936638250783e+00 3.547575545395710e+00 4.456982039588625e+00 9.321541271075021e+03 + 167520 9.468031239634074e-01 -6.012373296623038e+00 -5.981267347845003e+00 3.616229626853679e+00 4.794844798367171e+00 9.159619881502626e+03 + 167540 1.012826515723096e+00 -6.085123355415104e+00 -5.937411062466097e+00 3.244630145371254e+00 5.092816989887908e+00 9.025901962336189e+03 + 167560 1.022615022816148e+00 -6.073775262749619e+00 -5.995529587885822e+00 3.270364219495986e+00 4.719662993042959e+00 9.203336316279376e+03 + 167580 9.993960094877274e-01 -6.019603275470510e+00 -5.997629481902055e+00 3.599467808128003e+00 4.725644731231634e+00 9.209768861862360e+03 + 167600 9.990844069406728e-01 -6.001219713077002e+00 -5.987700840185054e+00 3.732464436550246e+00 4.810091896734630e+00 9.179322312900817e+03 + 167620 9.881750620881449e-01 -5.971237270207006e+00 -5.980372768008182e+00 3.880333548040924e+00 4.827876105952851e+00 9.156870609449463e+03 + 167640 1.033437731621355e+00 -6.025582412873549e+00 -5.965097915129141e+00 3.632481730141118e+00 4.979793076135282e+00 9.110202331863458e+03 + 167660 1.009233072297676e+00 -5.979930226926234e+00 -6.004270274939434e+00 3.813377533736998e+00 4.673613211434946e+00 9.230179699124590e+03 + 167680 1.014657939906897e+00 -5.982540545330568e+00 -6.018193656450469e+00 3.791742487342926e+00 4.587016805991334e+00 9.273012169714779e+03 + 167700 1.006325735085429e+00 -5.968928462868825e+00 -5.987545910151798e+00 3.835612721842244e+00 4.728708458502759e+00 9.178863362613936e+03 + 167720 1.016891959626797e+00 -5.982743835991818e+00 -5.982879697282100e+00 3.794147622689979e+00 4.793367486136711e+00 9.164569118280913e+03 + 167740 1.050943833020899e+00 -6.031954269919368e+00 -5.995229609466750e+00 3.535717486609272e+00 4.746596170051044e+00 9.202420881140461e+03 + 167760 1.023572763326777e+00 -5.992370845458000e+00 -6.043743888341522e+00 3.719480086977578e+00 4.424488124787699e+00 9.351835973940371e+03 + 167780 1.039307026921117e+00 -6.021684527878901e+00 -6.005139313942886e+00 3.606205218017199e+00 4.701210396801380e+00 9.232833839312536e+03 + 167800 1.017221214268295e+00 -5.998056631095202e+00 -6.016991753724259e+00 3.667249633242073e+00 4.558521228905269e+00 9.269292557514043e+03 + 167820 9.634952856818766e-01 -5.927891552712405e+00 -6.030225527901367e+00 4.062517081578475e+00 4.474899559911976e+00 9.310073127198380e+03 + 167840 9.611412882551429e-01 -5.935516326584742e+00 -5.989681853048115e+00 4.033608110711751e+00 4.722581275670938e+00 9.185388297042371e+03 + 167860 1.062970337739529e+00 -6.097131995895975e+00 -5.952988719358926e+00 3.163250550260106e+00 4.990943550235797e+00 9.073296329290666e+03 + 167880 9.864761583829662e-01 -5.997219812008232e+00 -5.976622999775326e+00 3.651471163629979e+00 4.769741246817717e+00 9.145423920459418e+03 + 167900 1.052037809857959e+00 -6.113590631902396e+00 -5.969237227455555e+00 3.063909855225909e+00 4.892809442176818e+00 9.122854033141546e+03 + 167920 9.410337240472494e-01 -5.973960372523970e+00 -5.997763204791343e+00 3.798310333560688e+00 4.661630787205042e+00 9.210189009433443e+03 + 167940 9.334714260198247e-01 -5.996387844177987e+00 -5.990889118186077e+00 3.715123623861683e+00 4.746698159432324e+00 9.189110282068155e+03 + 167960 9.379568128956154e-01 -6.043985794408927e+00 -6.003745201518966e+00 3.446704058289647e+00 4.677771769875426e+00 9.228559916857446e+03 + 167980 9.948006081814911e-01 -6.171292492708036e+00 -5.953536045499912e+00 2.798647331583942e+00 5.049038549154292e+00 9.074982762220727e+03 + 168000 9.383895196821082e-01 -6.123023103533602e+00 -5.974311067782224e+00 3.099347962826321e+00 4.953275485223891e+00 9.138370731796069e+03 + 168020 9.413189404896527e-01 -6.153926622760743e+00 -5.996017789379167e+00 2.816553687026450e+00 4.723290644616451e+00 9.204863316945160e+03 + 168040 9.138411771542604e-01 -6.130115886871891e+00 -5.974274415776335e+00 3.050679520124919e+00 4.945545363545319e+00 9.138251230288608e+03 + 168060 9.150638139918201e-01 -6.137915688828189e+00 -5.981592241086162e+00 2.943264619962643e+00 4.840898047872718e+00 9.160612146307951e+03 + 168080 8.884086520784776e-01 -6.094065717293469e+00 -5.956114740199460e+00 3.218922103706161e+00 5.011057962024669e+00 9.082813403826252e+03 + 168100 9.568459313697452e-01 -6.179843243044539e+00 -5.943902373087063e+00 2.692468472422336e+00 5.047277459449788e+00 9.045662948397752e+03 + 168120 9.258550952280904e-01 -6.106812940434820e+00 -5.983565544930765e+00 3.174615047729296e+00 4.882320665186398e+00 9.166668341425264e+03 + 168140 8.710843280929065e-01 -5.993115729716971e+00 -5.987596959319970e+00 3.768628205066208e+00 4.800317838712745e+00 9.178997996944228e+03 + 168160 8.868751785135580e-01 -5.977432275098972e+00 -5.990717213353087e+00 3.819295053850280e+00 4.743010882557600e+00 9.188562503514549e+03 + 168180 9.495499787711148e-01 -6.032549112945284e+00 -5.991359961556847e+00 3.483695351256405e+00 4.720209832529388e+00 9.190561861200749e+03 + 168200 9.711189070062899e-01 -6.033822396908478e+00 -6.010617352543587e+00 3.517462301639646e+00 4.650709257351864e+00 9.249673740625323e+03 + 168220 1.003721390505510e+00 -6.060650574577572e+00 -5.974897197552052e+00 3.395781768218215e+00 4.888190929390958e+00 9.140148819128683e+03 + 168240 9.921659939967847e-01 -6.027007408864042e+00 -6.006603829008624e+00 3.570786951933661e+00 4.687947464907252e+00 9.237333005803357e+03 + 168260 1.000246360206373e+00 -6.026349680580876e+00 -6.006252953513782e+00 3.559383337588293e+00 4.674781854366011e+00 9.236259104583927e+03 + 168280 1.008233692176989e+00 -6.027731159384143e+00 -5.997791763447743e+00 3.572661727179475e+00 4.744578371752834e+00 9.210277207963347e+03 + 168300 9.621854149723802e-01 -5.948119970464739e+00 -6.004734526378185e+00 3.986048769565755e+00 4.660959228436536e+00 9.231580038568241e+03 + 168320 1.023853663869215e+00 -6.029207644781547e+00 -5.966074547732816e+00 3.577358309881812e+00 4.939878322950816e+00 9.113192112101315e+03 + 168340 1.053917179915700e+00 -6.062741642677145e+00 -5.962402125173819e+00 3.364421295899963e+00 4.940586332894215e+00 9.101982712327152e+03 + 168360 1.029005272475812e+00 -6.016159644350546e+00 -5.986284732953273e+00 3.617362984605689e+00 4.788909348976432e+00 9.174971344482918e+03 + 168380 1.026929089176922e+00 -6.003097605967356e+00 -5.974828809138337e+00 3.759490105572481e+00 4.921813911546881e+00 9.139926402477027e+03 + 168400 1.008977971873487e+00 -5.965833980491781e+00 -6.026580291268949e+00 3.877247785931973e+00 4.528433068988258e+00 9.298825978495370e+03 + 168420 1.053684305851986e+00 -6.023082992815064e+00 -6.021616071862441e+00 3.573922481932552e+00 4.582345769047794e+00 9.283544685254130e+03 + 168440 1.031884094789772e+00 -5.986090407020926e+00 -5.993449941898679e+00 3.800265316004946e+00 4.758005727852547e+00 9.196966796631108e+03 + 168460 9.852226694937535e-01 -5.914640901710015e+00 -6.041743802772221e+00 4.123735919728253e+00 4.393891392718698e+00 9.345636496870862e+03 + 168480 1.087733441728491e+00 -6.067045724319438e+00 -5.986452415965427e+00 3.413139903547838e+00 4.875919151890731e+00 9.175509158970042e+03 + 168500 1.018248840164626e+00 -5.968303946737057e+00 -6.041838198039556e+00 3.901405699918016e+00 4.479160649550458e+00 9.345925124012176e+03 + 168520 1.075458784627423e+00 -6.064266385903880e+00 -5.996644518884498e+00 3.354077574679680e+00 4.742372799555074e+00 9.206743186076998e+03 + 168540 9.740503181344710e-01 -5.930696933678960e+00 -5.974510939922792e+00 4.128504784024946e+00 4.876917979977313e+00 9.138960757023553e+03 + 168560 9.657549858354950e-01 -5.940597826872752e+00 -5.999192480457107e+00 3.990182226091908e+00 4.653722657717206e+00 9.214566662937335e+03 + 168580 9.546383909295242e-01 -5.950356871217194e+00 -5.990439596292282e+00 3.988777926727522e+00 4.758616716564712e+00 9.187685846984223e+03 + 168600 9.669023417219762e-01 -5.998169238841697e+00 -6.012063292022248e+00 3.720833870846353e+00 4.641052067385846e+00 9.254089835689538e+03 + 168620 9.710216343082106e-01 -6.034270384132317e+00 -5.978043320457503e+00 3.547391325588189e+00 4.870255826318957e+00 9.149775269086114e+03 + 168640 9.548061451664647e-01 -6.037803593325010e+00 -6.009348685434089e+00 3.482114250486965e+00 4.645506734979397e+00 9.245779633429325e+03 + 168660 9.576729819040480e-01 -6.068018929987289e+00 -6.021783345104843e+00 3.318737722972347e+00 4.584229606300985e+00 9.284047177407992e+03 + 168680 9.816024318843886e-01 -6.127703062844926e+00 -5.977757616418001e+00 2.973665118986230e+00 4.834675076352481e+00 9.148924562988219e+03 + 168700 9.150111041469448e-01 -6.046027606280883e+00 -6.013849876035446e+00 3.440238356832352e+00 4.625007863389309e+00 9.259600785805618e+03 + 168720 8.908934561568038e-01 -6.020233464252655e+00 -5.997013760333375e+00 3.616908588533875e+00 4.750239721675951e+00 9.207875310320878e+03 + 168740 9.200818731898882e-01 -6.066392186006778e+00 -5.975831372734131e+00 3.326421234155162e+00 4.846435438207265e+00 9.143006813505430e+03 + 168760 9.259493374979539e-01 -6.069402511272567e+00 -5.970770792695657e+00 3.329512074345840e+00 4.895870665623574e+00 9.127530954501777e+03 + 168780 9.563818994058654e-01 -6.098565678759384e+00 -5.975729840801327e+00 3.088512971994952e+00 4.793855362334609e+00 9.142705355536891e+03 + 168800 9.895988455251853e-01 -6.120270106418423e+00 -5.966495169751097e+00 3.010835218033764e+00 4.893834700972095e+00 9.114494578116932e+03 + 168820 8.904207109799234e-01 -5.933774374506596e+00 -6.003238613028914e+00 4.046009779253557e+00 4.647135372102235e+00 9.226979361544551e+03 + 168840 1.021475991046943e+00 -6.078709519679041e+00 -5.970942665809279e+00 3.296145779034523e+00 4.914959730821439e+00 9.128060530252958e+03 + 168860 1.007655779841924e+00 -6.003706244223635e+00 -6.034397125900093e+00 3.649544981442411e+00 4.473313189457599e+00 9.322960071461235e+03 + 168880 9.682603913858385e-01 -5.905828358063924e+00 -6.047929262256256e+00 4.198315802958135e+00 4.382350421041908e+00 9.364791756572688e+03 + 168900 1.036551256798434e+00 -5.985065890091158e+00 -6.018953877582488e+00 3.806273184514593e+00 4.611683116190257e+00 9.275327694434283e+03 + 168920 1.009792724936917e+00 -5.933897761473536e+00 -6.023027112055599e+00 3.987468277193405e+00 4.475673753428771e+00 9.287879260354513e+03 + 168940 1.042526314606135e+00 -5.977525561089611e+00 -6.039338781828504e+00 3.812557982951335e+00 4.457616903903617e+00 9.338180956516635e+03 + 168960 9.912492024317425e-01 -5.900963974162535e+00 -6.017162275934007e+00 4.188479309170055e+00 4.521250678769172e+00 9.269807087838246e+03 + 168980 1.061410575942813e+00 -6.006548959964072e+00 -6.030150070656759e+00 3.685533657815345e+00 4.550012427957860e+00 9.309824080215629e+03 + 169000 1.080985460187876e+00 -6.042753678448036e+00 -6.011864382803369e+00 3.453888062287601e+00 4.631259177982336e+00 9.253517986685900e+03 + 169020 1.033638719948892e+00 -5.985789553842850e+00 -6.034942283257405e+00 3.749638935939329e+00 4.467396357280659e+00 9.324597778040294e+03 + 169040 1.000379080094399e+00 -5.951628635772606e+00 -5.995185093438185e+00 3.997419446924790e+00 4.747311526668989e+00 9.202274511619285e+03 + 169060 1.039150676148027e+00 -6.025518074332592e+00 -6.010269875863942e+00 3.568077693997275e+00 4.655635209255350e+00 9.248617804825160e+03 + 169080 1.030619402876652e+00 -6.032638472950861e+00 -6.016036651012687e+00 3.491614691630834e+00 4.586944922323469e+00 9.266379507801366e+03 + 169100 9.950484197391044e-01 -6.002315518126736e+00 -6.009158598343881e+00 3.698292025024159e+00 4.658997999454071e+00 9.245192530279157e+03 + 169120 1.003887602339846e+00 -6.037590050919004e+00 -5.978368502684877e+00 3.564882009057151e+00 4.904941303522476e+00 9.150762572145253e+03 + 169140 1.059468915878609e+00 -6.142155117325781e+00 -5.944840150445326e+00 2.949364653201345e+00 5.082377727421362e+00 9.048525251287339e+03 + 169160 9.991555581882451e-01 -6.072471246424792e+00 -5.994126251195656e+00 3.397623095690538e+00 4.847492182145063e+00 9.199036778577145e+03 + 169180 9.694489570831617e-01 -6.045523255722547e+00 -5.992547956676155e+00 3.515447572932870e+00 4.819639937958287e+00 9.194190024250112e+03 + 169200 9.898417446870906e-01 -6.090344309066446e+00 -5.964969267326335e+00 3.241216711180919e+00 4.961139602577640e+00 9.109824912184633e+03 + 169220 9.620952516347171e-01 -6.059771906115283e+00 -5.966687124554939e+00 3.389823876920818e+00 4.924331097463703e+00 9.115055674271365e+03 + 169240 9.694654039818967e-01 -6.076208074357113e+00 -5.974944192440557e+00 3.288786430952067e+00 4.870259311452013e+00 9.140304694149445e+03 + 169260 9.734106108900487e-01 -6.084199309027094e+00 -5.994666209301532e+00 3.296835846444939e+00 4.810948760271522e+00 9.200642893491869e+03 + 169280 9.325223631875836e-01 -6.021453369980403e+00 -6.011600779158541e+00 3.600810198341237e+00 4.657385299523871e+00 9.252693721073181e+03 + 169300 9.609681009651780e-01 -6.053646828352426e+00 -6.012370946631914e+00 3.403540760576754e+00 4.640553260837986e+00 9.255077262143581e+03 + 169320 9.880126012820191e-01 -6.071846744778904e+00 -6.026053332303361e+00 3.266362035464952e+00 4.529314896407201e+00 9.297208384230673e+03 + 169340 9.251030700560248e-01 -5.943213281720544e+00 -6.006876810964818e+00 4.008699380601946e+00 4.643133543782013e+00 9.238158851077211e+03 + 169360 9.688463638493808e-01 -5.960694619686832e+00 -5.989847502295073e+00 3.932118634266373e+00 4.764718270935846e+00 9.185881095311350e+03 + 169380 1.035632126802773e+00 -6.006136279078014e+00 -6.020563950865945e+00 3.678800638191140e+00 4.595954714109844e+00 9.280284680271569e+03 + 169400 1.031948963252832e+00 -5.954238853048322e+00 -6.046082004288253e+00 3.926299905442797e+00 4.398922318341387e+00 9.359059697959192e+03 + 169420 9.836899199891413e-01 -5.851578297127750e+00 -6.051752812348653e+00 4.458339986860842e+00 4.308906943556298e+00 9.376574989437635e+03 + 169440 9.975989847946768e-01 -5.851987778500742e+00 -6.044531869115407e+00 4.490589197960336e+00 4.384971233549204e+00 9.354189126083489e+03 + 169460 1.088849002527564e+00 -5.974482012198449e+00 -5.999240928785714e+00 3.871613515039481e+00 4.729443984565444e+00 9.214712217733657e+03 + 169480 1.039575963639487e+00 -5.897321788403902e+00 -6.014872887236861e+00 4.260614159269900e+00 4.585617558797295e+00 9.262726929984759e+03 + 169500 1.111737693690222e+00 -6.008977241299908e+00 -5.952071362752218e+00 3.658420616128578e+00 4.985182976905660e+00 9.070500824880033e+03 + 169520 1.100718096168355e+00 -6.001278220080768e+00 -5.989587378913010e+00 3.696965381134939e+00 4.764096000272033e+00 9.185107543196527e+03 + 169540 1.006406421064793e+00 -5.878849435339262e+00 -6.042215239183952e+00 4.274083078911200e+00 4.336011352458549e+00 9.347107881399956e+03 + 169560 1.071437048711733e+00 -6.000820453001209e+00 -5.996058448253518e+00 3.685803148557329e+00 4.713147316736425e+00 9.204933104764525e+03 + 169580 9.767551306375043e-01 -5.887782617852316e+00 -6.029480947960923e+00 4.220441645817146e+00 4.406787906587804e+00 9.307719869210190e+03 + 169600 1.095865946743768e+00 -6.093194537847676e+00 -5.952355747706914e+00 3.218671676415595e+00 5.027389804136186e+00 9.071369844141205e+03 + 169620 9.922102926649395e-01 -5.969753283157125e+00 -6.005111323316995e+00 3.905833587204286e+00 4.702802248967283e+00 9.232741400903531e+03 + 169640 1.027886943769917e+00 -6.051936125447833e+00 -5.996677563830591e+00 3.401263846097801e+00 4.718567058138779e+00 9.206866287587252e+03 + 169660 1.015270687207266e+00 -6.060216336731480e+00 -6.003685123244937e+00 3.366104040975069e+00 4.690715016991810e+00 9.228383429377704e+03 + 169680 9.583584552526668e-01 -5.997648166539186e+00 -5.993415346087563e+00 3.734693699994446e+00 4.758999210054516e+00 9.196831422150062e+03 + 169700 8.814374183560253e-01 -5.896709484400326e+00 -6.017569080704042e+00 4.204999834971860e+00 4.511005330033844e+00 9.271057918955123e+03 + 169720 1.002354447126447e+00 -6.083451542134706e+00 -5.960775780241400e+00 3.241668375158200e+00 4.946091583962364e+00 9.097025019061424e+03 + 169740 9.800100549066005e-01 -6.052537389145223e+00 -5.961235767598550e+00 3.446135878630047e+00 4.970403918431314e+00 9.098428644750000e+03 + 169760 9.399023376703267e-01 -5.990741989306374e+00 -6.024191677897829e+00 3.689128627740699e+00 4.497055339525989e+00 9.291469720768617e+03 + 169780 9.992416801208411e-01 -6.075068614256406e+00 -5.998050229516107e+00 3.273667353631898e+00 4.715918837367217e+00 9.211070430953154e+03 + 169800 9.823309347586578e-01 -6.044285304883560e+00 -6.002670626346523e+00 3.429936262357627e+00 4.668894186367982e+00 9.225259625188341e+03 + 169820 9.661372734507073e-01 -6.013513597967610e+00 -5.996039437741839e+00 3.588767163371952e+00 4.689106495505887e+00 9.204902023562327e+03 + 169840 9.016075617759874e-01 -5.908695576683233e+00 -6.001794456188049e+00 4.215078456682802e+00 4.680490283561105e+00 9.222545242346599e+03 + 169860 9.984263155824883e-01 -6.040231351148529e+00 -6.019906904910684e+00 3.422213355966835e+00 4.538919471462437e+00 9.278268787473553e+03 + 169880 9.750401159914284e-01 -5.993476449682745e+00 -6.025010455226798e+00 3.687548345755095e+00 4.506475206049553e+00 9.294002227376619e+03 + 169900 9.906153955373167e-01 -6.007525773419571e+00 -5.977957571158984e+00 3.688377370256769e+00 4.858162563301574e+00 9.149487915154841e+03 + 169920 1.010931329067255e+00 -6.028366839983063e+00 -5.985135101501476e+00 3.584065158539265e+00 4.832308490990444e+00 9.171455644613499e+03 + 169940 1.002171630692229e+00 -6.006583708615265e+00 -6.003972312255345e+00 3.649562003785862e+00 4.664557045796801e+00 9.229259032828717e+03 + 169960 1.009528245738229e+00 -6.011197381598198e+00 -5.958334246806613e+00 3.594621046798536e+00 4.898169347315488e+00 9.089593722029183e+03 + 169980 9.934678395553863e-01 -5.981057860098879e+00 -6.018821763945614e+00 3.769432315109447e+00 4.552586135276259e+00 9.274924280096493e+03 + 170000 9.643797590840050e-01 -5.932363202079293e+00 -6.008258965178160e+00 4.106875170895925e+00 4.671069954350852e+00 9.242404644298567e+03 + 170020 1.034868216782194e+00 -6.032832202611027e+00 -5.938802289129314e+00 3.560482655974604e+00 5.100416970268686e+00 9.030098795312973e+03 + 170040 9.660772565341149e-01 -5.926740983854126e+00 -5.988774330421126e+00 4.092689775017770e+00 4.736484699400699e+00 9.182599000702623e+03 + 170060 9.424347095776406e-01 -5.887313267937267e+00 -6.061546610968998e+00 4.314178110859880e+00 4.313703292648984e+00 9.406935737568021e+03 + 170080 9.932186417945106e-01 -5.961442117530333e+00 -6.023825234756191e+00 3.942404046046826e+00 4.584190533179761e+00 9.290325596068200e+03 + 170100 1.026179274678806e+00 -6.009935630093080e+00 -6.020782311072656e+00 3.667324372087532e+00 4.605041051384348e+00 9.280956340620338e+03 + 170120 1.025539165060953e+00 -6.011080571102890e+00 -6.021540158373923e+00 3.696624025587909e+00 4.636563456861741e+00 9.283284643520172e+03 + 170140 9.795577687366973e-01 -5.947343844031010e+00 -6.031585610100498e+00 3.941189064660740e+00 4.457459807518569e+00 9.314244262366035e+03 + 170160 1.056700176049770e+00 -6.064584031531657e+00 -5.987062967781903e+00 3.405527222646565e+00 4.850665167043505e+00 9.177369951902667e+03 + 170180 1.025528614600322e+00 -6.022838550203346e+00 -5.998144099943062e+00 3.566804654287117e+00 4.708604009135495e+00 9.211385509496413e+03 + 170200 1.028045498652423e+00 -6.033247267885280e+00 -6.015680740013789e+00 3.510471445515627e+00 4.611341166965135e+00 9.265248284931880e+03 + 170220 9.661324631078133e-01 -5.947283602819051e+00 -6.006738495231341e+00 4.012134447859003e+00 4.670735255012774e+00 9.237738630272956e+03 + 170240 9.228527648445937e-01 -5.886678427627704e+00 -5.997270572657571e+00 4.377074162350583e+00 4.742036951509951e+00 9.208652394419651e+03 + 170260 9.916406128709299e-01 -5.990699385039692e+00 -5.972784592791598e+00 3.815034786713130e+00 4.917904296106828e+00 9.133664354607054e+03 + 170280 1.012434846524056e+00 -6.022223298197826e+00 -5.986792758879913e+00 3.563599777753468e+00 4.767047417375163e+00 9.176556912911527e+03 + 170300 1.017852840109710e+00 -6.031417448984766e+00 -6.003829987869699e+00 3.502768896111980e+00 4.661180366980505e+00 9.228822571187291e+03 + 170320 9.901453144353372e-01 -5.993341882671093e+00 -6.001568622875125e+00 3.705228928798038e+00 4.657989713462553e+00 9.221861274424569e+03 + 170340 1.009375110835687e+00 -6.022748591971467e+00 -5.957271224475421e+00 3.564536631014192e+00 4.940517807766364e+00 9.086343635334411e+03 + 170360 9.863401621134336e-01 -5.987148740973277e+00 -5.997851734300003e+00 3.791410111972408e+00 4.729951868007485e+00 9.210453897530228e+03 + 170380 1.055373474286365e+00 -6.087619729054341e+00 -5.968732762980673e+00 3.318818250890247e+00 5.001485607783788e+00 9.121315807436826e+03 + 170400 9.896899386518493e-01 -5.988357165202401e+00 -6.024364670483925e+00 3.736977937466862e+00 4.530217269996920e+00 9.291972387291231e+03 + 170420 9.813420049202334e-01 -5.973513648178885e+00 -6.032540223669620e+00 3.873729482259483e+00 4.534789751458650e+00 9.317211633673163e+03 + 170440 1.008577676152275e+00 -6.008764747465349e+00 -6.011390306258970e+00 3.694979350016443e+00 4.679902985119566e+00 9.252051209349764e+03 + 170460 9.793866655886480e-01 -5.960251486398899e+00 -6.042209735009721e+00 3.885680479105672e+00 4.415063532584351e+00 9.347072524183268e+03 + 170480 9.734919413677160e-01 -5.945318800400297e+00 -5.987370239448702e+00 3.948461453454954e+00 4.706995582999855e+00 9.178303929476469e+03 + 170500 1.010955107718629e+00 -5.989934221086841e+00 -5.994445826990805e+00 3.772291925738952e+00 4.746385586469638e+00 9.199991944484978e+03 + 170520 1.049706059087194e+00 -6.036806301019123e+00 -5.951662253335695e+00 3.518748411324114e+00 5.007658709121150e+00 9.069256430846148e+03 + 170540 1.034838486846277e+00 -6.005243162761539e+00 -5.997800166680191e+00 3.655003335868053e+00 4.697742171167076e+00 9.210265608967711e+03 + 170560 1.007547177768787e+00 -5.955101768362383e+00 -5.994907638220459e+00 3.915346504227887e+00 4.686775039564367e+00 9.201406273564053e+03 + 170580 1.055546324415076e+00 -6.017990336722996e+00 -5.949995026734666e+00 3.630288677427767e+00 5.020728269620978e+00 9.064163509887672e+03 + 170600 9.999773186418766e-01 -5.928009182464370e+00 -5.983553077265558e+00 4.075090082001987e+00 4.756148442663627e+00 9.166611330621965e+03 + 170620 1.006695466947057e+00 -5.930912313524150e+00 -6.007710872686597e+00 4.076396671756227e+00 4.635407460506834e+00 9.240728903099680e+03 + 170640 1.045450800674862e+00 -5.983928880697783e+00 -5.972923737009420e+00 3.798267680638328e+00 4.861460918737389e+00 9.134130832313947e+03 + 170660 1.057329688760471e+00 -5.999095871624740e+00 -6.007006674702184e+00 3.719911552067431e+00 4.674486496603929e+00 9.238563773052105e+03 + 170680 1.038355720335202e+00 -5.972294477682075e+00 -6.042562190004876e+00 3.878444804117965e+00 4.474956726067102e+00 9.348175524707411e+03 + 170700 1.082784500663266e+00 -6.048317627638418e+00 -6.013067405168802e+00 3.482512911242416e+00 4.684925143617246e+00 9.257200960009566e+03 + 170720 9.836398783554349e-01 -5.917365401802329e+00 -6.014685159306641e+00 4.145642143861292e+00 4.586817036087736e+00 9.262188786837280e+03 + 170740 9.884245069363407e-01 -5.942865941863843e+00 -6.017981934698451e+00 3.979808744151664e+00 4.548481089133023e+00 9.272317177238940e+03 + 170760 1.083769212845659e+00 -6.103566254457836e+00 -5.992120786612444e+00 3.113872139978044e+00 4.753809262476697e+00 9.192894777099840e+03 + 170780 1.018904968244766e+00 -6.033694929927331e+00 -6.001852837702122e+00 3.543325176560730e+00 4.726167397665725e+00 9.222744418901504e+03 + 170800 9.322317969823218e-01 -5.934005765197714e+00 -5.978914249511707e+00 4.073885149679052e+00 4.816013683182617e+00 9.152413123786735e+03 + 170820 9.734445940150313e-01 -6.018223589840959e+00 -5.972949752348622e+00 3.604869465405922e+00 4.864838846390631e+00 9.134170287763463e+03 + 170840 9.338396409762513e-01 -5.979801544081721e+00 -6.015846572445904e+00 3.776224791722167e+00 4.569248660904917e+00 9.265751839936718e+03 + 170860 1.007241636597744e+00 -6.104880698479732e+00 -5.976711871613114e+00 3.181747755375571e+00 4.917712993305553e+00 9.145679344939001e+03 + 170880 9.353007093559882e-01 -6.011752863793090e+00 -5.993927571834623e+00 3.624554063736940e+00 4.726909648617474e+00 9.198404742269644e+03 + 170900 8.669303148752174e-01 -5.919128904324069e+00 -5.975529144719998e+00 4.133650798059749e+00 4.809791889797334e+00 9.142062728849889e+03 + 170920 9.375900372207764e-01 -6.024542123916757e+00 -5.940338971672216e+00 3.578253569403636e+00 5.061761099987486e+00 9.034801652707298e+03 + 170940 9.224804326797671e-01 -5.994735668499260e+00 -5.998581416885013e+00 3.673606164830768e+00 4.651523282472129e+00 9.212698055469828e+03 + 170960 9.738488740015886e-01 -6.057406738970749e+00 -5.956570201441150e+00 3.435383102906228e+00 5.014402105804937e+00 9.084194463132757e+03 + 170980 9.827702327813992e-01 -6.048808287152438e+00 -5.984259562073184e+00 3.438909448451674e+00 4.809558216739676e+00 9.168774007716609e+03 + 171000 9.614423512938622e-01 -5.981990308498846e+00 -5.974995795590846e+00 3.811020523583601e+00 4.851184099098707e+00 9.140456850604076e+03 + 171020 9.341419167311333e-01 -5.896657692082381e+00 -6.021411496235404e+00 4.248442118340607e+00 4.532086469305148e+00 9.282867550791127e+03 + 171040 1.089763750808032e+00 -6.074887733031060e+00 -5.977868011709748e+00 3.322412666460733e+00 4.879514920041063e+00 9.149229325908907e+03 + 171060 1.044678018437807e+00 -5.961473579236479e+00 -6.016016163455745e+00 3.870466562664103e+00 4.557274603639446e+00 9.266279238112509e+03 + 171080 1.069231173015828e+00 -5.965719268980839e+00 -6.017941781443076e+00 3.805721243486496e+00 4.505851495520650e+00 9.272217741240036e+03 + 171100 1.025524496174299e+00 -5.884285867738590e+00 -6.046656458256355e+00 4.318655496230336e+00 4.386298438709649e+00 9.360830372647195e+03 + 171120 1.115871940338693e+00 -6.013897004910620e+00 -6.009492752754130e+00 3.593712485224819e+00 4.619002382663206e+00 9.246231919818452e+03 + 171140 9.997884202307962e-01 -5.844973782291404e+00 -6.067080061929643e+00 4.468658421282161e+00 4.193289792763696e+00 9.424131166529325e+03 + 171160 1.108098097226425e+00 -6.014010462478983e+00 -6.041129629152362e+00 3.588990246665126e+00 4.433267794949104e+00 9.343749309514262e+03 + 171180 1.045955267576649e+00 -5.937503359696183e+00 -6.026491980618074e+00 4.047895045488536e+00 4.536908613210460e+00 9.298544408561100e+03 + 171200 1.116229317824131e+00 -6.061229884228023e+00 -5.978284483423574e+00 3.373262078163369e+00 4.849547405341807e+00 9.150510840939558e+03 + 171220 1.035812631040356e+00 -5.965144065129761e+00 -6.018420223396846e+00 3.830947377845474e+00 4.525027432617026e+00 9.273701015607920e+03 + 171240 1.033854411005143e+00 -5.987474142654667e+00 -5.991106287462664e+00 3.759423089879033e+00 4.738566752318925e+00 9.189758291723963e+03 + 171260 9.670509209815820e-01 -5.911377559133582e+00 -5.991826532202758e+00 4.134444876835493e+00 4.672494424033936e+00 9.191973283630621e+03 + 171280 1.036671925235268e+00 -6.033269859382447e+00 -5.955537140355809e+00 3.537833449724508e+00 4.984186751474854e+00 9.081053940477766e+03 + 171300 9.927072009102836e-01 -5.982931278158822e+00 -6.014208475483221e+00 3.765310312369080e+00 4.585711805201737e+00 9.260716968593795e+03 + 171320 1.061415823148270e+00 -6.100119356264079e+00 -5.957006318452284e+00 3.129238250709453e+00 4.951015460495805e+00 9.085557308758733e+03 + 171340 9.969164359611890e-01 -6.018752584102920e+00 -5.957449922804393e+00 3.633630632531200e+00 4.985640000263516e+00 9.086873697315972e+03 + 171360 1.044004787694057e+00 -6.097923516113910e+00 -5.951652563471976e+00 3.213026306616766e+00 5.052936752043518e+00 9.069228989271547e+03 + 171380 1.014981139126053e+00 -6.062970687613119e+00 -5.988649879078780e+00 3.422530603249237e+00 4.849292186961367e+00 9.182231478711474e+03 + 171400 9.688600526909591e-01 -5.999908700079660e+00 -6.014189474997020e+00 3.702193532561448e+00 4.620191113043195e+00 9.260643730773270e+03 + 171420 9.607611520037407e-01 -5.990937031087308e+00 -6.005719117309654e+00 3.713768455126276e+00 4.628887428517118e+00 9.234591428973687e+03 + 171440 9.801590721344541e-01 -6.019389247016242e+00 -5.980641073382660e+00 3.596314592192450e+00 4.818812601456965e+00 9.157682909028850e+03 + 171460 9.837897527670453e-01 -6.021340905086048e+00 -5.971589994275901e+00 3.603394202424087e+00 4.889071631224519e+00 9.130040214543207e+03 + 171480 9.489604625291226e-01 -5.963223507142723e+00 -6.016459823620766e+00 3.879939466225578e+00 4.574248298715304e+00 9.267658791086538e+03 + 171500 1.038029574164246e+00 -6.084776312750206e+00 -6.022645959825747e+00 3.205475059020658e+00 4.562237160153944e+00 9.286706175235404e+03 + 171520 1.006568680396404e+00 -6.024784925648107e+00 -6.024256900674940e+00 3.600742330041794e+00 4.603774331149316e+00 9.291671351317202e+03 + 171540 9.972797754582072e-01 -5.991907218478854e+00 -6.039958420612166e+00 3.720141617121902e+00 4.444224178572926e+00 9.340108126787209e+03 + 171560 9.590660408209971e-01 -5.906420970528697e+00 -6.056011457953046e+00 4.181785770578569e+00 4.322814042734849e+00 9.389772062217142e+03 + 171580 1.015226474841625e+00 -5.947882389703611e+00 -6.025070445113712e+00 3.923061171321612e+00 4.479835412343835e+00 9.294153320384967e+03 + 171600 1.063859318783091e+00 -5.964229923437229e+00 -6.024654308972276e+00 3.876122677772234e+00 4.529156505386553e+00 9.292886394059598e+03 + 171620 1.093267583587449e+00 -5.954904443138620e+00 -5.992793868416239e+00 3.959613482032049e+00 4.742046538718348e+00 9.194947377596498e+03 + 171640 1.060179687644635e+00 -5.867020420577555e+00 -5.989292101513357e+00 4.422262538691510e+00 4.720159625276668e+00 9.184195436607362e+03 + 171660 1.084422288791476e+00 -5.877993881675875e+00 -6.025831763374813e+00 4.299047502046447e+00 4.450139507492891e+00 9.296472968430555e+03 + 171680 1.055594947371593e+00 -5.823576016010756e+00 -6.012949432264341e+00 4.633049851799982e+00 4.545638390230450e+00 9.256806394080702e+03 + 171700 1.035222907768172e+00 -5.792722407709438e+00 -6.006714118208413e+00 4.822384659749773e+00 4.593611142954481e+00 9.237622849291329e+03 + 171720 1.125565914992021e+00 -5.934585076510309e+00 -5.978027145245576e+00 4.046656211113723e+00 4.797205129797411e+00 9.149702163839533e+03 + 171740 1.110167018941457e+00 -5.930956960805832e+00 -5.978402385366794e+00 4.104904431962148e+00 4.832465461977381e+00 9.150845539796894e+03 + 171760 1.096837594586954e+00 -5.940014445792213e+00 -5.985736381940547e+00 4.013951841749620e+00 4.751409408939138e+00 9.173297717409276e+03 + 171780 1.061028002547277e+00 -5.922137195029791e+00 -5.984528861118182e+00 4.115405426809351e+00 4.757142825050682e+00 9.169587544150787e+03 + 171800 1.026251104279131e+00 -5.909735562651350e+00 -5.956285827471440e+00 4.156925612696300e+00 4.889626788469141e+00 9.083358684262339e+03 + 171820 1.050899550924081e+00 -5.982239538268079e+00 -6.003089091030812e+00 3.757031498850283e+00 4.637310140428806e+00 9.226517261747937e+03 + 171840 1.005518249893278e+00 -5.946581905354568e+00 -5.960766272962466e+00 3.965856206751424e+00 4.884407372923087e+00 9.096980149061403e+03 + 171860 1.006226919054962e+00 -5.970292721974282e+00 -5.981861712007944e+00 3.858791544297044e+00 4.792360613228329e+00 9.161406709181772e+03 + 171880 1.003407021767245e+00 -5.984167483736634e+00 -5.964392744752828e+00 3.815179154949326e+00 4.928728766325305e+00 9.108044906913101e+03 + 171900 9.714299356646670e-01 -5.949328923854448e+00 -6.003290165807435e+00 3.933111850258842e+00 4.623258048489587e+00 9.227108806781325e+03 + 171920 1.010813905533065e+00 -6.016480264765061e+00 -5.975281707309240e+00 3.621717375299899e+00 4.858285867667384e+00 9.141343148853861e+03 + 171940 1.063986269059849e+00 -6.102707973533846e+00 -5.967910538510069e+00 3.165346948424411e+00 4.939374680166592e+00 9.118805535831509e+03 + 171960 1.040037438579652e+00 -6.075516329248450e+00 -5.929474088669818e+00 3.302778049307411e+00 5.141375194673605e+00 9.001816571928401e+03 + 171980 1.008604501542496e+00 -6.034214346624529e+00 -5.959415272400460e+00 3.498875682415707e+00 4.928383541729640e+00 9.092875782294839e+03 + 172000 1.021278818231547e+00 -6.055278862477794e+00 -5.988968323480544e+00 3.358454804955045e+00 4.739220181400004e+00 9.183228894732885e+03 + 172020 1.023511452890147e+00 -6.060720022355659e+00 -5.999197129928102e+00 3.358172885976177e+00 4.711446854932042e+00 9.214589996752911e+03 + 172040 9.502329000628527e-01 -5.954555242794927e+00 -5.995799493720359e+00 3.962775627261482e+00 4.725944755920455e+00 9.204151550428247e+03 + 172060 9.465938909261682e-01 -5.949515909456838e+00 -6.048214210120602e+00 3.926778193581540e+00 4.360037277657542e+00 9.365622330266286e+03 + 172080 9.757288808331365e-01 -5.992714343967151e+00 -5.955892669497317e+00 3.767798180500432e+00 4.979233933441931e+00 9.082109897300978e+03 + 172100 9.680880334721694e-01 -5.977259144623698e+00 -6.023132753360902e+00 3.733034311798320e+00 4.469620951511287e+00 9.288171551916736e+03 + 172120 9.613518871879845e-01 -5.959637889366848e+00 -5.971420939468560e+00 3.924977977887008e+00 4.857317880781865e+00 9.129481067592789e+03 + 172140 1.053364221338451e+00 -6.083329425596241e+00 -5.966993022594636e+00 3.267634422520076e+00 4.935656051555473e+00 9.115999090442654e+03 + 172160 9.641438236399102e-01 -5.931655030314246e+00 -6.047038859772361e+00 4.002807445523938e+00 4.340255641185541e+00 9.362040664131495e+03 + 172180 1.003123599919656e+00 -5.963444039357844e+00 -6.036465582456242e+00 3.866098087074900e+00 4.446797086556623e+00 9.329346693127007e+03 + 172200 9.936808426682591e-01 -5.918180752513441e+00 -5.999689373620462e+00 4.137127664479366e+00 4.669092548664506e+00 9.216109308820811e+03 + 172220 9.874484933335420e-01 -5.873444292512225e+00 -6.030115785511875e+00 4.391144137920489e+00 4.491512180281314e+00 9.309721999498544e+03 + 172240 1.102442361230882e+00 -6.006573975267710e+00 -6.003754932403208e+00 3.689525599701950e+00 4.705712980075395e+00 9.228592705453126e+03 + 172260 1.042541089189107e+00 -5.885497895054067e+00 -6.061041995165239e+00 4.336814005843109e+00 4.328812617643067e+00 9.405379168719626e+03 + 172280 1.084976361778584e+00 -5.926525282700452e+00 -6.059711655422442e+00 4.077802365217355e+00 4.313025602523124e+00 9.401261332152915e+03 + 172300 1.109355939282497e+00 -5.950350254199269e+00 -6.038279078602029e+00 3.950222492390845e+00 4.445321575728597e+00 9.334929711219807e+03 + 172320 1.003584708105690e+00 -5.793739216062012e+00 -6.038003707175055e+00 4.776135602726221e+00 4.373531094947293e+00 9.334086350674639e+03 + 172340 1.108898055603473e+00 -5.958096424724505e+00 -5.978891885837462e+00 4.000223422557277e+00 4.880812666759469e+00 9.152358030893638e+03 + 172360 1.082092906968975e+00 -5.935229388084096e+00 -6.014932543672260e+00 4.060217806355488e+00 4.602549952944787e+00 9.262944310231367e+03 + 172380 1.078438691370033e+00 -5.960240458318766e+00 -5.994779314802082e+00 3.925555532362223e+00 4.727228073564254e+00 9.201027995988139e+03 + 172400 9.814009334062834e-01 -5.855395790522992e+00 -6.007851282551651e+00 4.387462185213970e+00 4.512039157574264e+00 9.241172084690805e+03 + 172420 1.021743129277072e+00 -5.956837513807445e+00 -5.994116653489170e+00 3.974839393251570e+00 4.760776804270879e+00 9.198910455215106e+03 + 172440 1.053920389505867e+00 -6.045607330263085e+00 -5.991479826826130e+00 3.475262217715492e+00 4.786070718654573e+00 9.190918417116220e+03 + 172460 1.082915963835048e+00 -6.124412456062573e+00 -5.999329392200013e+00 3.013133983891955e+00 4.731380293132347e+00 9.214982112917138e+03 + 172480 8.827385838888753e-01 -5.854611635975007e+00 -6.039715753941731e+00 4.478855506695748e+00 4.415959016561141e+00 9.339360430917295e+03 + 172500 9.395221064289503e-01 -5.954537162025894e+00 -5.987377572901988e+00 3.941865705173236e+00 4.753290983885543e+00 9.178332038922812e+03 + 172520 9.562492133338030e-01 -5.986477440667693e+00 -5.995587853207351e+00 3.797155238482059e+00 4.744841839847560e+00 9.203477255287717e+03 + 172540 1.013172301241755e+00 -6.073392857772878e+00 -5.936215519266264e+00 3.334503815708587e+00 5.122197321538090e+00 9.022288696002517e+03 + 172560 1.025892863433420e+00 -6.092426587794312e+00 -5.971723612824439e+00 3.242427085038059e+00 4.935522246040082e+00 9.130463384862524e+03 + 172580 1.016416706699466e+00 -6.077774864556412e+00 -5.984222703100864e+00 3.276260993055796e+00 4.813451981283751e+00 9.168680074976264e+03 + 172600 9.909712897099451e-01 -6.037434783814548e+00 -5.981090574205504e+00 3.496337152278371e+00 4.819874323091756e+00 9.159105597165002e+03 + 172620 9.702376154232129e-01 -5.999655584291099e+00 -5.997118574376934e+00 3.737892513388313e+00 4.752460416916463e+00 9.208208253426084e+03 + 172640 9.879027141280502e-01 -6.017261575208793e+00 -6.023397485733884e+00 3.581840284111784e+00 4.546606936347621e+00 9.289011565890265e+03 + 172660 9.337106385124090e-01 -5.928758674840387e+00 -6.020769115739597e+00 4.031162328747874e+00 4.502824138534897e+00 9.280917108341760e+03 + 172680 9.970695467790591e-01 -6.012375779174469e+00 -6.017411625196958e+00 3.569168348261318e+00 4.540251741105532e+00 9.270573511260933e+03 + 172700 9.907264065483334e-01 -5.990047253747540e+00 -5.998736010953619e+00 3.728718289729752e+00 4.678826101271612e+00 9.213163413807137e+03 + 172720 1.018256036372882e+00 -6.015906867707852e+00 -5.973573412703888e+00 3.601792805038770e+00 4.844878054752525e+00 9.136096343829127e+03 + 172740 1.023750449451012e+00 -6.006687076612080e+00 -5.997007228027146e+00 3.576425378509376e+00 4.632008567035791e+00 9.207877679881378e+03 + 172760 1.008988904995452e+00 -5.965890041967508e+00 -5.975621856805157e+00 3.892625307785823e+00 4.836743720994559e+00 9.142339660903255e+03 + 172780 1.063130395155624e+00 -6.023827980803579e+00 -5.957331239822098e+00 3.596785520191515e+00 4.978620097244585e+00 9.086518488234364e+03 + 172800 1.022393587675879e+00 -5.937507932669403e+00 -6.017985457603124e+00 4.052584438616729e+00 4.590470036590571e+00 9.272331223898891e+03 + 172820 1.031611687280333e+00 -5.921413699347695e+00 -6.021036527112228e+00 4.108306822277820e+00 4.536257128671095e+00 9.281715665023614e+03 + 172840 1.031007636383035e+00 -5.891006058018329e+00 -6.011215109186184e+00 4.253991878342570e+00 4.563732904246199e+00 9.251469535469074e+03 + 172860 9.683699205661638e-01 -5.766711627701183e+00 -6.056583016110435e+00 4.907500057269260e+00 4.243013687570953e+00 9.391474114734932e+03 + 172880 1.071366663507554e+00 -5.889067926579171e+00 -5.969185888378441e+00 4.222685639699995e+00 4.762635904834062e+00 9.122681510932109e+03 + 172900 1.078655521201729e+00 -5.870543494892486e+00 -5.993229272601227e+00 4.428339668542163e+00 4.723858947375829e+00 9.196243799953598e+03 + 172920 1.115431075665988e+00 -5.903221687787881e+00 -6.005051491989077e+00 4.213316223216818e+00 4.628593729382279e+00 9.232531162642696e+03 + 172940 1.125800411141910e+00 -5.905989603825843e+00 -5.984387081838152e+00 4.156197379597584e+00 4.706026928880390e+00 9.169138127188025e+03 + 172960 1.054018295839549e+00 -5.795964890106038e+00 -6.019522461966774e+00 4.795822749179632e+00 4.512120576132845e+00 9.277014991634098e+03 + 172980 1.118908432724137e+00 -5.902360832194248e+00 -5.967497673964703e+00 4.203612894101524e+00 4.829587068761882e+00 9.117541079121560e+03 + 173000 1.107445668595430e+00 -5.914268772818446e+00 -5.928971585201426e+00 4.189897859940557e+00 5.105472035984628e+00 9.000267493343028e+03 + 173020 1.091958137261895e+00 -5.938685733781594e+00 -5.966512324980659e+00 4.041620853392430e+00 4.881836260576327e+00 9.114469158573092e+03 + 173040 1.001323380955421e+00 -5.865958757884489e+00 -5.978348956085010e+00 4.351236669978316e+00 4.705874759583967e+00 9.150664597268353e+03 + 173060 1.004755324962607e+00 -5.926512009099835e+00 -5.980960821552534e+00 4.093733533306475e+00 4.781080026276582e+00 9.158660922792677e+03 + 173080 1.017692612200240e+00 -5.988083199150920e+00 -5.979495073414678e+00 3.770128040512883e+00 4.819442387498548e+00 9.154216515370597e+03 + 173100 1.000777478443841e+00 -5.993195002474382e+00 -5.966110282693140e+00 3.783534134544125e+00 4.939058786874858e+00 9.113300123699335e+03 + 173120 1.003924431822632e+00 -6.018530320867154e+00 -5.962239186926102e+00 3.610487496672246e+00 4.933719898786598e+00 9.101490355683713e+03 + 173140 9.790852529238024e-01 -5.996006337456165e+00 -5.979403564121951e+00 3.720947353321449e+00 4.816283047077381e+00 9.153943694089201e+03 + 173160 9.839379202268819e-01 -6.012801539639699e+00 -6.034388013370886e+00 3.617825294260405e+00 4.493872421599911e+00 9.322922496189836e+03 + 173180 1.004973072884249e+00 -6.054372488696514e+00 -6.002843070080139e+00 3.406589144734990e+00 4.702479040581979e+00 9.225780924046707e+03 + 173200 9.353664544418824e-01 -5.958574081268814e+00 -6.005472642007595e+00 3.912698897704575e+00 4.643400104413680e+00 9.233841823163724e+03 + 173220 9.458394286645943e-01 -5.977909528610584e+00 -5.983922726724805e+00 3.796548247257893e+00 4.762019533146637e+00 9.167759504923144e+03 + 173240 1.020340065600994e+00 -6.088276100598461e+00 -5.982690468672452e+00 3.236925779513019e+00 4.843214817355895e+00 9.163970584689092e+03 + 173260 9.952805205955944e-01 -6.047870193045654e+00 -5.982104273282050e+00 3.392524005817335e+00 4.770162094343141e+00 9.162206716484268e+03 + 173280 9.980990834454792e-01 -6.046276427030458e+00 -5.990106496779951e+00 3.459547080193107e+00 4.782083511960128e+00 9.186658637295684e+03 + 173300 9.878746402879192e-01 -6.023019641490797e+00 -5.971610792524971e+00 3.592277158150344e+00 4.887474724405783e+00 9.130107710597140e+03 + 173320 9.541462466870148e-01 -5.960943052553656e+00 -6.026500111943178e+00 3.903923172214026e+00 4.527484392277239e+00 9.298585789503839e+03 + 173340 1.026501507859694e+00 -6.051681680776657e+00 -6.006362799384036e+00 3.422512820541773e+00 4.682740850572434e+00 9.236618645914488e+03 + 173360 9.932104061462316e-01 -5.984038573203277e+00 -6.005824685013628e+00 3.744182362364341e+00 4.619083136959398e+00 9.234934776763557e+03 + 173380 1.009984802041753e+00 -5.988081768675634e+00 -5.987520753202867e+00 3.785748189215987e+00 4.788969626877478e+00 9.178770620875497e+03 + 173400 1.030449786738089e+00 -5.991692157322114e+00 -6.035116002669131e+00 3.698287010934624e+00 4.448940571133704e+00 9.325177053550073e+03 + 173420 1.066024739325461e+00 -6.018493236209102e+00 -5.995082133604891e+00 3.647136655411122e+00 4.781566829420924e+00 9.201958403328243e+03 + 173440 1.067642134111627e+00 -5.995588105235458e+00 -6.024666128332058e+00 3.707093135237975e+00 4.540122626807772e+00 9.292931066361034e+03 + 173460 1.081816509633934e+00 -5.994489195240281e+00 -5.998103024201956e+00 3.736771067361874e+00 4.716019902225714e+00 9.211229032503517e+03 + 173480 9.975506406078951e-01 -5.852591496843242e+00 -6.014782523956264e+00 4.481409050255010e+00 4.550083073591712e+00 9.262450570656778e+03 + 173500 1.023690360739035e+00 -5.874914622582520e+00 -6.005005017867528e+00 4.329290909431641e+00 4.582291728281515e+00 9.232395034829417e+03 + 173520 1.077785366570953e+00 -5.941516833277189e+00 -5.944231789419466e+00 4.060915825770490e+00 5.045326127463431e+00 9.046608646803092e+03 + 173540 1.063941819075422e+00 -5.908713050364923e+00 -5.973317951040684e+00 4.132818994103865e+00 4.761847656847579e+00 9.135310131215530e+03 + 173560 1.086531510936248e+00 -5.931421269085421e+00 -6.017235363468231e+00 4.055836925374791e+00 4.563079115740507e+00 9.270037745465261e+03 + 173580 1.136390693591882e+00 -6.004689280755624e+00 -5.985869610927346e+00 3.657306895415380e+00 4.765372351903845e+00 9.173719318163470e+03 + 173600 1.039754461713528e+00 -5.873932130552928e+00 -6.010342184849663e+00 4.361348956092039e+00 4.578061314932507e+00 9.248821906350566e+03 + 173620 1.008390423740151e+00 -5.851757625912639e+00 -6.004260601569459e+00 4.481933222817341e+00 4.606237536836671e+00 9.230102541229438e+03 + 173640 1.039116729923969e+00 -5.935777510019093e+00 -5.938119858087401e+00 4.057147123761267e+00 5.043696998675858e+00 9.028018438654699e+03 + 173660 1.005080409730513e+00 -5.930981436532204e+00 -5.944001730556888e+00 4.106243247702714e+00 5.031478704528996e+00 9.045861741230661e+03 + 173680 1.026237204647207e+00 -6.004957621005611e+00 -5.965811205241733e+00 3.672510520041122e+00 4.897295297245574e+00 9.112359608715806e+03 + 173700 1.031923939354743e+00 -6.053307303009847e+00 -5.937029403374755e+00 3.383668469451927e+00 5.051354163103442e+00 9.024759772791909e+03 + 173720 9.948527102879733e-01 -6.030552376706215e+00 -5.964037991927033e+00 3.516307112003030e+00 4.898243002472871e+00 9.106960148247514e+03 + 173740 9.608551193693246e-01 -6.002535728539605e+00 -5.997078934799910e+00 3.622117323984375e+00 4.653451078073806e+00 9.208066856175088e+03 + 173760 9.824669174407913e-01 -6.050888907466445e+00 -5.981449718654126e+00 3.418130891294903e+00 4.816861459134979e+00 9.160182123608276e+03 + 173780 9.336155689611729e-01 -5.989020632331643e+00 -5.991028017417711e+00 3.736174416065628e+00 4.724647700259590e+00 9.189507097738082e+03 + 173800 9.602355099042567e-01 -6.032734439713542e+00 -6.001287127277745e+00 3.490079744786138e+00 4.670655079248352e+00 9.221001568201002e+03 + 173820 9.498960638773298e-01 -6.016748969875607e+00 -6.007134733944648e+00 3.579543621536020e+00 4.634750052049791e+00 9.238956772395615e+03 + 173840 9.852900264695768e-01 -6.066069902766070e+00 -5.988076444817199e+00 3.318665080445857e+00 4.766515585436892e+00 9.180490857477598e+03 + 173860 9.836570038385419e-01 -6.057878676131812e+00 -5.982346587509959e+00 3.406807887134686e+00 4.840524828554305e+00 9.162948800168608e+03 + 173880 9.929565190773034e-01 -6.061366800179039e+00 -5.996711578548871e+00 3.418202363373149e+00 4.789462651336786e+00 9.206969518717147e+03 + 173900 9.927590825756769e-01 -6.048161076826857e+00 -5.979034372994226e+00 3.434696779978238e+00 4.831633010708048e+00 9.152805912378397e+03 + 173920 9.726517316414648e-01 -6.001755806988286e+00 -5.974703333446178e+00 3.678005843949589e+00 4.833345333385124e+00 9.139543416864919e+03 + 173940 9.715420896759521e-01 -5.973865771339408e+00 -6.004807932767068e+00 3.796847563728977e+00 4.619172884527347e+00 9.231826433439666e+03 + 173960 1.074008428969160e+00 -6.093068164648981e+00 -5.984248716772878e+00 3.204004947548575e+00 4.828863057008292e+00 9.168786398101072e+03 + 173980 9.882841338057282e-01 -5.930802096529248e+00 -6.046339331314269e+00 4.047490297750650e+00 4.384057616285756e+00 9.359864883541753e+03 + 174000 1.044937198571008e+00 -5.980716647654766e+00 -6.055387944104370e+00 3.864568680772850e+00 4.435794541213438e+00 9.387869687633191e+03 + 174020 1.012179894145418e+00 -5.903757709824338e+00 -6.024859148329945e+00 4.218581743029880e+00 4.523198542743641e+00 9.293535338431930e+03 + 174040 1.014681212084544e+00 -5.883616213917592e+00 -6.052646090808726e+00 4.315133762289497e+00 4.344538051891694e+00 9.379359789027403e+03 + 174060 1.010626986648662e+00 -5.858911741943656e+00 -5.992121408611119e+00 4.460163313402711e+00 4.695252793268845e+00 9.192849155053716e+03 + 174080 1.095429786318195e+00 -5.968927528544659e+00 -5.998074410764060e+00 3.832388522292853e+00 4.665022614123612e+00 9.211121070891251e+03 + 174100 1.102434908975461e+00 -5.968333066368058e+00 -5.983151786471380e+00 3.875600601891949e+00 4.790509217869152e+00 9.165409210050813e+03 + 174120 1.110705581278694e+00 -5.979628017800168e+00 -5.994194532541202e+00 3.817077958518305e+00 4.733434776714418e+00 9.199216664045731e+03 + 174140 9.645728663838430e-01 -5.771965871407673e+00 -6.033703787274841e+00 4.919387169870882e+00 4.416447553150028e+00 9.320796192123315e+03 + 174160 1.143471012735451e+00 -6.057201242260327e+00 -5.984222310123451e+00 3.384495954356815e+00 4.803552276140001e+00 9.168692667622588e+03 + 174180 1.114228194416204e+00 -6.060018984704160e+00 -6.034010040842800e+00 3.359952294580819e+00 4.509299675103809e+00 9.321768637924351e+03 + 174200 1.035545675851006e+00 -6.019835581615722e+00 -5.984858016856825e+00 3.604487537278268e+00 4.805334126884508e+00 9.170619398829798e+03 + 174220 9.519149595492782e-01 -5.963254127919057e+00 -5.943614391122633e+00 3.944308211322939e+00 5.057082619247447e+00 9.044744192008386e+03 + 174240 9.906746425471189e-01 -6.063801351276808e+00 -5.963637807940319e+00 3.340751943489447e+00 4.915906509585810e+00 9.105700105342768e+03 + 174260 9.267405335466790e-01 -5.993076214347078e+00 -5.986359538088935e+00 3.735504874343718e+00 4.774073068820272e+00 9.175183850634010e+03 + 174280 9.241900134792869e-01 -6.003454537177995e+00 -5.960222566679866e+00 3.694962471519037e+00 4.943207136245107e+00 9.095338415824601e+03 + 174300 9.665557829592610e-01 -6.073240158781647e+00 -5.951876815238919e+00 3.306008545952532e+00 5.002895645491590e+00 9.069899559460257e+03 + 174320 9.128699189045938e-01 -5.993826631248002e+00 -5.961654280244311e+00 3.724014941510094e+00 4.908753559628513e+00 9.099691484580217e+03 + 174340 9.707981487654367e-01 -6.072337761985562e+00 -5.968453451519562e+00 3.288364882809992e+00 4.884884669550850e+00 9.120433725647670e+03 + 174360 9.380757919619065e-01 -6.011142889904589e+00 -5.995907737564730e+00 3.601282728418124e+00 4.688765330785798e+00 9.204488029253091e+03 + 174380 9.618260475116973e-01 -6.028796559083496e+00 -5.988557491870419e+00 3.559552094322779e+00 4.790611045235792e+00 9.181946389808234e+03 + 174400 9.499519782289373e-01 -5.988295221087204e+00 -6.002647141934475e+00 3.727950521118987e+00 4.645539570661384e+00 9.225157664108969e+03 + 174420 1.000556501339247e+00 -6.036773534869895e+00 -5.973367565628996e+00 3.511871545864321e+00 4.875958433287594e+00 9.135461308473074e+03 + 174440 1.028999140666390e+00 -6.048934936596396e+00 -5.965449106713238e+00 3.467942832285403e+00 4.947331386864918e+00 9.111294174406876e+03 + 174460 1.026822782836855e+00 -6.018111825296588e+00 -6.000903780554323e+00 3.559449099306790e+00 4.658260355153195e+00 9.219820027532754e+03 + 174480 1.026940028507454e+00 -5.991359740555537e+00 -5.956477164030031e+00 3.788282887187052e+00 4.988584039657780e+00 9.083920803218996e+03 + 174500 1.068577183163967e+00 -6.030315505609322e+00 -5.969489104837730e+00 3.531841358709154e+00 4.881115964794738e+00 9.123603449442782e+03 + 174520 1.028732500171579e+00 -5.952032096973272e+00 -5.982452602415385e+00 3.958532566755477e+00 4.783853316948865e+00 9.163254033535399e+03 + 174540 1.016028408732502e+00 -5.916559863845978e+00 -6.029517412928802e+00 4.131699999946326e+00 4.483080272988528e+00 9.307860362809872e+03 + 174560 1.034085296672262e+00 -5.931916042652173e+00 -6.016824447758401e+00 4.030769129582472e+00 4.543211927929286e+00 9.268741340334504e+03 + 174580 1.069464036652090e+00 -5.978519402719918e+00 -5.990808444442746e+00 3.856528446197731e+00 4.785962866902192e+00 9.188853241433259e+03 + 174600 1.063524134247026e+00 -5.968353384538040e+00 -6.016356464764080e+00 3.874540738504850e+00 4.598899623394276e+00 9.267357696617173e+03 + 174620 1.039866634172809e+00 -5.940056701058808e+00 -6.074248910985186e+00 4.032055292353467e+00 4.261502856778834e+00 9.446378748339603e+03 + 174640 1.040236495224821e+00 -5.956058351892226e+00 -6.046009755812667e+00 3.941184200427036e+00 4.424669319181093e+00 9.358844098545360e+03 + 174660 1.022772460457805e+00 -5.954827700981319e+00 -6.064390411189723e+00 3.933167986575437e+00 4.304041949784172e+00 9.415783472026056e+03 + 174680 9.829749500444194e-01 -5.928453727341313e+00 -6.075091434664500e+00 4.071501609808770e+00 4.229485202247162e+00 9.449007394609172e+03 + 174700 1.039401120925224e+00 -6.055205302996512e+00 -6.034188289339775e+00 3.439254560482783e+00 4.559937505272123e+00 9.322286708465619e+03 + 174720 1.010095901966845e+00 -6.061446469071280e+00 -6.002030015548879e+00 3.401846740286702e+00 4.743025211078795e+00 9.223270501057315e+03 + 174740 9.502785796361295e-01 -6.014551668114291e+00 -6.052748465608851e+00 3.565733532396602e+00 4.346401610247526e+00 9.379684029717993e+03 + 174760 9.148974451783527e-01 -5.991516504991664e+00 -6.017562649981153e+00 3.736539573277869e+00 4.586978578120315e+00 9.271051591568870e+03 + 174780 9.644508808957944e-01 -6.083305898606405e+00 -5.957925160263165e+00 3.249366061164889e+00 4.969321663338325e+00 9.088348347607980e+03 + 174800 9.474565283054365e-01 -6.064146406379244e+00 -5.968466930851296e+00 3.363633574853645e+00 4.913039929686112e+00 9.120498957537216e+03 + 174820 9.584785123366982e-01 -6.079695095214923e+00 -6.019083318558723e+00 3.226359157619604e+00 4.574401358821628e+00 9.275730655104362e+03 + 174840 9.369789673075278e-01 -6.043330303644593e+00 -5.982817463858819e+00 3.477547181685590e+00 4.825021272067199e+00 9.164378797812968e+03 + 174860 9.769982730338885e-01 -6.093589801816066e+00 -5.956418635640756e+00 3.186452675082323e+00 4.974110738430312e+00 9.083763930830319e+03 + 174880 9.828502457769762e-01 -6.088181401454269e+00 -6.029697895360165e+00 3.213353799341999e+00 4.549175141627667e+00 9.308467828434899e+03 + 174900 9.227160312064646e-01 -5.984811348096058e+00 -6.015620290314531e+00 3.815183806870710e+00 4.638274092983840e+00 9.265072405298237e+03 + 174920 1.020733655416700e+00 -6.115446304811709e+00 -5.921068679912113e+00 3.100765621387073e+00 5.216912023400788e+00 8.976340908249087e+03 + 174940 9.426754452770276e-01 -5.979957764736304e+00 -5.991167518744058e+00 3.777623704912783e+00 4.713255562696434e+00 9.189949475669659e+03 + 174960 9.555339846482395e-01 -5.974677060231760e+00 -6.029876213829874e+00 3.850370421698661e+00 4.533408339696872e+00 9.308981464220138e+03 + 174980 1.030033169254394e+00 -6.061333850483272e+00 -5.997139547067653e+00 3.347476708517317e+00 4.716090332766147e+00 9.208283541949057e+03 + 175000 9.883273369644735e-01 -5.978444481262841e+00 -6.020783585992502e+00 3.772134472082301e+00 4.529016780769306e+00 9.280955281783554e+03 + 175020 1.038641352396164e+00 -6.035211204689436e+00 -5.980535423233059e+00 3.473240555955543e+00 4.787197354127897e+00 9.157396379972011e+03 + 175040 1.028122379584812e+00 -6.002668782255830e+00 -5.951079771758026e+00 3.701897343032095e+00 4.998129424684054e+00 9.067488678539250e+03 + 175060 1.019149068156492e+00 -5.976165819239180e+00 -5.955720356298011e+00 3.853303022049817e+00 4.970704034183179e+00 9.081567959619360e+03 + 175080 9.924343167451991e-01 -5.922424534526516e+00 -5.951252692220498e+00 4.151558692082870e+00 4.986022949461037e+00 9.067984405528090e+03 + 175100 1.125442130559867e+00 -6.105009591307002e+00 -5.953366530379454e+00 3.156056867608716e+00 5.026814790142535e+00 9.074431789188950e+03 + 175120 1.010888449395482e+00 -5.926248361631479e+00 -6.028755645572832e+00 4.077592079223833e+00 4.488979391881661e+00 9.305516886890644e+03 + 175140 9.825931912286066e-01 -5.879507161473648e+00 -6.024734186418986e+00 4.313678701641070e+00 4.479762650595466e+00 9.293126945564973e+03 + 175160 1.098058489820219e+00 -6.049171312785719e+00 -5.989741803710071e+00 3.440773975064071e+00 4.782027412863247e+00 9.185557676083341e+03 + 175180 1.004178065746951e+00 -5.914705300404457e+00 -5.964959074224990e+00 4.193701522940900e+00 4.905136576917037e+00 9.109783933699291e+03 + 175200 1.032299672848394e+00 -5.963647468880897e+00 -5.996015250861229e+00 3.846429513910107e+00 4.660568700880963e+00 9.204796190128158e+03 + 175220 1.124963962969908e+00 -6.114751773246700e+00 -5.973022661825462e+00 3.068949720988168e+00 4.882780211278023e+00 9.134431799259555e+03 + 175240 1.004726615297099e+00 -5.963339920802834e+00 -6.011618351873967e+00 3.886593628856656e+00 4.609371406583150e+00 9.252753396854248e+03 + 175260 1.012539278011511e+00 -6.020787744590081e+00 -6.032876507505645e+00 3.613681026374775e+00 4.544265478983585e+00 9.318227492271531e+03 + 175280 9.501784681326232e-01 -5.991428162104357e+00 -6.015229739835565e+00 3.730677228110832e+00 4.594004885495989e+00 9.263862655312767e+03 + 175300 9.049495538954495e-01 -5.980230419858019e+00 -5.984744184390006e+00 3.835503967834212e+00 4.809585233388736e+00 9.170267776481365e+03 + 175320 9.625946801857106e-01 -6.105587042548430e+00 -5.987654708479709e+00 3.138060553067871e+00 4.815246265260182e+00 9.179192441136040e+03 + 175340 9.611593842436630e-01 -6.127386314682732e+00 -5.984304603259023e+00 3.033423891235361e+00 4.855021220053585e+00 9.168943811878677e+03 + 175360 9.577346070435174e-01 -6.134221393353250e+00 -6.000072659892959e+00 2.955859204247411e+00 4.726161991225809e+00 9.217274447504249e+03 + 175380 8.751222882102426e-01 -6.015479252713113e+00 -6.012881599399479e+00 3.560427355293016e+00 4.575343482605453e+00 9.256630427610622e+03 + 175400 9.246382488262139e-01 -6.083994020160435e+00 -5.992809807604388e+00 3.212651535361954e+00 4.736245394570064e+00 9.195002857403058e+03 + 175420 9.578104429722245e-01 -6.119923039606261e+00 -5.995326223644550e+00 3.044701364611058e+00 4.760155563158159e+00 9.202731234831344e+03 + 175440 9.126630700904075e-01 -6.034342717355619e+00 -5.997586723817907e+00 3.530319457994218e+00 4.741378060859378e+00 9.209653952085946e+03 + 175460 9.071313665414691e-01 -6.001581429118350e+00 -6.025779365966012e+00 3.692687901389883e+00 4.553739603391985e+00 9.296351493891840e+03 + 175480 9.539260855425356e-01 -6.040866856613547e+00 -6.011784556819912e+00 3.493690039983741e+00 4.660685105870144e+00 9.253270824667034e+03 + 175500 9.420454072380610e-01 -5.991052537005707e+00 -6.003149742830227e+00 3.754976679016329e+00 4.685512651135384e+00 9.226704512782173e+03 + 175520 9.762994786071494e-01 -6.012763873430769e+00 -5.968833790371192e+00 3.635163389770772e+00 4.887416724857249e+00 9.121616803134493e+03 + 175540 9.616361829561672e-01 -5.960699281058593e+00 -5.987252050692313e+00 3.872882600166490e+00 4.720412487901851e+00 9.177952620005324e+03 + 175560 9.962229184111530e-01 -5.985654402755954e+00 -6.026830958039572e+00 3.752744433501419e+00 4.516302281011550e+00 9.299584955504601e+03 + 175580 1.020391756936409e+00 -5.999981018438340e+00 -6.023941903012725e+00 3.699175638967934e+00 4.561588531806914e+00 9.290703401874423e+03 + 175600 1.018718030926390e+00 -5.984610244921231e+00 -6.038889867868517e+00 3.768434351434888e+00 4.456752356727067e+00 9.336821110565888e+03 + 175620 9.926230477787235e-01 -5.937961192252602e+00 -6.067229629035874e+00 3.991537352333521e+00 4.249257984098032e+00 9.424565506684852e+03 + 175640 1.033822840681058e+00 -5.994281468421066e+00 -5.996775853934509e+00 3.751128326344914e+00 4.736805178721813e+00 9.207148824832640e+03 + 175660 1.028089092567386e+00 -5.982791618342983e+00 -6.013732890955994e+00 3.801152836336515e+00 4.623483260846141e+00 9.259261676336724e+03 + 175680 1.023727874557679e+00 -5.978885299606310e+00 -6.047836031670769e+00 3.826052356122163e+00 4.430126582516730e+00 9.364475572118150e+03 + 175700 9.624539768250001e-01 -5.892658679982171e+00 -6.030466179838964e+00 4.289713609083069e+00 4.498401619263684e+00 9.310797376608863e+03 + 175720 1.077874436185885e+00 -6.071523628354904e+00 -5.963936067317414e+00 3.313912977252087e+00 4.931697401850619e+00 9.106671789646864e+03 + 175740 9.737934490336826e-01 -5.926520549055900e+00 -5.978397808529782e+00 4.114949458012934e+00 4.817062206133946e+00 9.150828800036576e+03 + 175760 1.063377281562902e+00 -6.067420596081009e+00 -5.957377159110511e+00 3.406370761021432e+00 5.038257205272866e+00 9.086649531203431e+03 + 175780 9.973759186878994e-01 -5.978475862365390e+00 -5.967586787797789e+00 3.866842059886845e+00 4.929368811132861e+00 9.117808817092229e+03 + 175800 9.937225696531075e-01 -5.984754953701366e+00 -6.036361768570295e+00 3.695246966955813e+00 4.398912649849633e+00 9.328995809250117e+03 + 175820 9.481475596367271e-01 -5.934626529840555e+00 -6.030441643773690e+00 4.098568313024088e+00 4.548383101479065e+00 9.310702726506537e+03 + 175840 1.021398864396286e+00 -6.065268897546405e+00 -6.006396132020552e+00 3.330244113772832e+00 4.668300643953297e+00 9.236696583043087e+03 + 175860 9.866447579928614e-01 -6.044519873185536e+00 -5.992466028979715e+00 3.475129945553504e+00 4.774031174289683e+00 9.193940125489687e+03 + 175880 9.557781570554120e-01 -6.036866114417260e+00 -6.002945794925373e+00 3.507983837252379e+00 4.702759560927269e+00 9.226098204897035e+03 + 175900 9.062997221478712e-01 -6.006264456937022e+00 -6.006513269432029e+00 3.652059465704973e+00 4.650630745855038e+00 9.237080392159220e+03 + 175920 9.966955023445492e-01 -6.180201067561790e+00 -5.981269596721669e+00 2.746563421232051e+00 4.888858711341650e+00 9.159666904970629e+03 + 175940 9.232025988797197e-01 -6.104299080106553e+00 -5.995880646841077e+00 3.146462774567491e+00 4.769018196076177e+00 9.204423337922226e+03 + 175960 8.924156985265349e-01 -6.078897953954409e+00 -6.008056715616781e+00 3.234402710373457e+00 4.641184063554322e+00 9.241784167871418e+03 + 175980 8.935724669128199e-01 -6.089881677619999e+00 -6.004825381999945e+00 3.185614857094834e+00 4.674021268964398e+00 9.231888496852451e+03 + 176000 8.986062907857139e-01 -6.098119826707854e+00 -6.001796191389563e+00 3.183902381815586e+00 4.737007601847600e+00 9.222586025195222e+03 + 176020 8.809374512636972e-01 -6.063547503828098e+00 -5.993072247026541e+00 3.356446616058313e+00 4.761126446623599e+00 9.195800357714566e+03 + 176040 8.869267582129664e-01 -6.054347851817991e+00 -5.976652140701734e+00 3.447558870474169e+00 4.893699667076151e+00 9.145497003263183e+03 + 176060 8.517390374290222e-01 -5.975061785526035e+00 -5.965006216386549e+00 3.880883472142874e+00 4.938624106236091e+00 9.109933093821301e+03 + 176080 9.888422529061435e-01 -6.144861792259138e+00 -5.940574695069701e+00 2.934357200050217e+00 5.107405325438087e+00 9.035539417770127e+03 + 176100 9.719936354504375e-01 -6.081871345377892e+00 -5.993829286556139e+00 3.294900366030117e+00 4.800451492249199e+00 9.198128418574939e+03 + 176120 9.750761513999207e-01 -6.055629297554794e+00 -6.008654331640664e+00 3.330691143906253e+00 4.600428667537667e+00 9.243641554936870e+03 + 176140 9.950954801328914e-01 -6.063177410180696e+00 -5.989417154191916e+00 3.364338382029859e+00 4.787881186280158e+00 9.184592754270490e+03 + 176160 1.019001179667554e+00 -6.082920494703306e+00 -5.979809548370751e+00 3.256246276600879e+00 4.848325286809786e+00 9.155174326174762e+03 + 176180 9.695599784671377e-01 -5.997869925035133e+00 -6.004023605798888e+00 3.717874924456759e+00 4.682539537232256e+00 9.229400224934390e+03 + 176200 9.812862146168398e-01 -6.005398539180472e+00 -5.977175327252737e+00 3.687593365061628e+00 4.849655415478617e+00 9.147117144571128e+03 + 176220 9.546311878538136e-01 -5.954260723838222e+00 -6.004918139647143e+00 3.949271258579334e+00 4.658388537794751e+00 9.232133439262472e+03 + 176240 1.064196193697975e+00 -6.102202866149449e+00 -5.963141566320380e+00 3.183098018833873e+00 4.981609522118989e+00 9.104236028811119e+03 + 176260 1.001909443368228e+00 -5.996606940179253e+00 -5.969439062973599e+00 3.690425411328300e+00 4.846427566458574e+00 9.123472921973358e+03 + 176280 1.019788995966022e+00 -6.012279028898646e+00 -5.959615756243861e+00 3.618241765982385e+00 4.920642427181264e+00 9.093475865964230e+03 + 176300 9.409695068619488e-01 -5.884201469837969e+00 -5.982088685039401e+00 4.328061944860868e+00 4.765978407176649e+00 9.162123023337886e+03 + 176320 9.937297150749048e-01 -5.947935788037548e+00 -6.008272992940279e+00 3.913298382383327e+00 4.566832814679566e+00 9.242406703626539e+03 + 176340 1.064494683642742e+00 -6.037466323073327e+00 -5.975996791104336e+00 3.518857420705624e+00 4.871824985650900e+00 9.143507901222927e+03 + 176360 1.005086581668455e+00 -5.935548915079872e+00 -6.011474496050011e+00 4.018238139454020e+00 4.582261704077798e+00 9.252274594176804e+03 + 176380 1.047603000349351e+00 -5.985950172717834e+00 -5.944701174825263e+00 3.870336106282152e+00 5.107194235443087e+00 9.048048036583168e+03 + 176400 1.089181455360497e+00 -6.034772752875433e+00 -6.040385476654031e+00 3.480229078633911e+00 4.447999950131011e+00 9.341437390662282e+03 + 176420 1.030926696299160e+00 -5.944886461470995e+00 -6.047468046240445e+00 3.981767530488987e+00 4.392728196293872e+00 9.363379995960631e+03 + 176440 1.026934887762462e+00 -5.942564152241033e+00 -6.024869152928494e+00 3.946795811042042e+00 4.474187760436951e+00 9.293537667693627e+03 + 176460 9.643262746744488e-01 -5.856640823299201e+00 -6.043243524375518e+00 4.452964050574058e+00 4.381462464319180e+00 9.350232978009708e+03 + 176480 9.622228501928415e-01 -5.866432140946119e+00 -5.979351165315364e+00 4.465351359180620e+00 4.816952847089865e+00 9.153720817276519e+03 + 176500 1.017832116967643e+00 -5.965125606831761e+00 -5.957745530532303e+00 3.868856059206451e+00 4.911233599381052e+00 9.087752570202163e+03 + 176520 1.017433567174433e+00 -5.986150759726931e+00 -5.996574840893778e+00 3.756004067836588e+00 4.696147380655206e+00 9.206535205818709e+03 + 176540 9.930222311278950e-01 -5.982292797011112e+00 -6.001675132099680e+00 3.776330908978138e+00 4.665034541492919e+00 9.222189405992169e+03 + 176560 9.861831545577099e-01 -6.009778514613711e+00 -6.000547596959232e+00 3.591360911498064e+00 4.644366269149975e+00 9.218732567223518e+03 + 176580 9.316597009560512e-01 -5.966753575799440e+00 -6.010419396320726e+00 3.914271442015075e+00 4.663535543317963e+00 9.249064656808265e+03 + 176600 1.025526785905236e+00 -6.142466004627759e+00 -5.973454646269502e+00 2.997753623759771e+00 4.968242997876060e+00 9.135750588770365e+03 + 176620 9.462601616276066e-01 -6.056752967978743e+00 -5.975517748618122e+00 3.393724623838188e+00 4.860189824516440e+00 9.142045560214367e+03 + 176640 9.011670619671394e-01 -6.008564630661673e+00 -5.987050318340939e+00 3.638765972320290e+00 4.762304482995012e+00 9.177336292623029e+03 + 176660 9.966796216470689e-01 -6.159672891574279e+00 -5.957535956026446e+00 2.893677776457225e+00 5.054379340962562e+00 9.087148268757579e+03 + 176680 9.219297311592743e-01 -6.051616383862637e+00 -5.988385733942934e+00 3.456130164757842e+00 4.819210341508226e+00 9.181419248035869e+03 + 176700 9.413551756788491e-01 -6.076573091528524e+00 -5.982775272770724e+00 3.285393033750096e+00 4.823994624222927e+00 9.164258344655449e+03 + 176720 9.366085423911275e-01 -6.059982859481717e+00 -5.984452788398366e+00 3.378563335425142e+00 4.812268691826462e+00 9.169389978002695e+03 + 176740 9.900897333085992e-01 -6.121477370547104e+00 -6.034307174838750e+00 3.019045418634611e+00 4.519590171936171e+00 9.322674231664401e+03 + 176760 1.016208626664217e+00 -6.138684352411471e+00 -5.976034731547335e+00 2.945690904257302e+00 4.879650197206656e+00 9.143666810559218e+03 + 176780 9.530338097516060e-01 -6.020351127806330e+00 -5.996183317734912e+00 3.620057121595960e+00 4.758832426982567e+00 9.205355316303736e+03 + 176800 9.682745571435608e-01 -6.013069326042160e+00 -6.014277226468020e+00 3.582290433607024e+00 4.575354482439747e+00 9.260961113265390e+03 + 176820 1.034964985437818e+00 -6.083523966701486e+00 -5.976270747699402e+00 3.228375445815947e+00 4.844240026707915e+00 9.144366941808841e+03 + 176840 1.046706980269812e+00 -6.074922323994896e+00 -5.958727702953662e+00 3.344797698668679e+00 5.012005193746935e+00 9.090784587108121e+03 + 176860 9.729612257408558e-01 -5.939948894763692e+00 -5.992114144511187e+00 4.092132258961424e+00 4.792591322365001e+00 9.192833997985492e+03 + 176880 1.045808219335535e+00 -6.028965555909846e+00 -6.022157791351494e+00 3.570869455421531e+00 4.609960693013750e+00 9.285178298920750e+03 + 176900 1.010008580955347e+00 -5.965408432171372e+00 -6.015207980388746e+00 3.896641422386298e+00 4.610684710066951e+00 9.263789287458745e+03 + 176920 1.005127640641504e+00 -5.954505938723486e+00 -6.027085227934097e+00 3.884370831716405e+00 4.467609321460371e+00 9.300384487016729e+03 + 176940 9.555627544458064e-01 -5.878923530376210e+00 -6.029517061893988e+00 4.362844428330418e+00 4.498113066081651e+00 9.307887484672141e+03 + 176960 1.031878666322668e+00 -5.992092723648729e+00 -6.026301731582747e+00 3.720566678130754e+00 4.524133260746755e+00 9.297983062890315e+03 + 176980 1.030501468493919e+00 -5.993810080607679e+00 -6.027687932134070e+00 3.720949259846150e+00 4.526417393801029e+00 9.302253100255897e+03 + 177000 1.011861710735242e+00 -5.971174015409585e+00 -6.015192220348965e+00 3.843089222303855e+00 4.590329877746741e+00 9.263756662825645e+03 + 177020 1.077283415903592e+00 -6.077144595856915e+00 -5.983548868693687e+00 3.287487968117705e+00 4.824929117380934e+00 9.166630095207081e+03 + 177040 9.992791234590713e-01 -5.970257654188434e+00 -6.018758247482945e+00 3.801876922589872e+00 4.523379010450235e+00 9.274745401708929e+03 + 177060 1.018547771974707e+00 -6.008403756146746e+00 -6.048564050568668e+00 3.667033954165444e+00 4.436427328809294e+00 9.366745261832275e+03 + 177080 1.047721774777730e+00 -6.064981210931400e+00 -5.981518061771327e+00 3.386722692244029e+00 4.865981010601759e+00 9.160395649981214e+03 + 177100 1.006422912339376e+00 -6.017832153544813e+00 -5.972037374924797e+00 3.676509755686134e+00 4.939470461241347e+00 9.131390357603161e+03 + 177120 9.534574193096707e-01 -5.953815965971993e+00 -6.003581134927177e+00 3.955494046618929e+00 4.669734745343256e+00 9.228013643765782e+03 + 177140 9.908752202858442e-01 -6.021622809665597e+00 -5.967980052017126e+00 3.615750830627108e+00 4.923775846234551e+00 9.118999245214931e+03 + 177160 9.614031930210879e-01 -5.988527454839986e+00 -6.031834810140364e+00 3.711860041814782e+00 4.463182505888440e+00 9.315038549134284e+03 + 177180 1.002326644091698e+00 -6.059513041006094e+00 -5.971920514750349e+00 3.330810086142860e+00 4.833779926802976e+00 9.131070630262184e+03 + 177200 9.866280742585251e-01 -6.046822787454454e+00 -5.999362828351520e+00 3.464494749147344e+00 4.737017178721324e+00 9.215091025672480e+03 + 177220 9.543133279273504e-01 -6.008833504444504e+00 -6.040366643931398e+00 3.669213383390875e+00 4.488145216719567e+00 9.341382275682156e+03 + 177240 9.826891880629230e-01 -6.063025955178062e+00 -6.019676239398929e+00 3.306663628962859e+00 4.555584405313477e+00 9.277552963327373e+03 + 177260 9.520512127287534e-01 -6.030582628373042e+00 -5.979741654746134e+00 3.569799457794526e+00 4.861736195975477e+00 9.154960439018592e+03 + 177280 9.761273176342086e-01 -6.078354996247361e+00 -6.004397002560967e+00 3.246110445327665e+00 4.670788690037478e+00 9.230556963124951e+03 + 177300 9.463689636241770e-01 -6.045977586164057e+00 -6.019887383478678e+00 3.428035972481918e+00 4.577849953747184e+00 9.278216930187195e+03 + 177320 9.105099355536990e-01 -6.003289513324095e+00 -6.031303729577803e+00 3.659687333202133e+00 4.498825368287389e+00 9.313380585053781e+03 + 177340 9.660354995946909e-01 -6.094436162943923e+00 -5.986877173060761e+00 3.175177971922463e+00 4.792798336531473e+00 9.176818688544845e+03 + 177360 9.677452712961405e-01 -6.101277659220135e+00 -5.960199926664378e+00 3.162853069368813e+00 4.972943241412526e+00 9.095278552114276e+03 + 177380 9.695065632663575e-01 -6.100387625561450e+00 -5.993591795554059e+00 3.155587499180826e+00 4.768825681684550e+00 9.197396083585842e+03 + 177400 9.184628351099136e-01 -6.015468022805097e+00 -6.006232444012744e+00 3.596421893801756e+00 4.649454016428649e+00 9.236199188012950e+03 + 177420 9.757323513045072e-01 -6.083381388651985e+00 -5.995543822581549e+00 3.247039161745378e+00 4.751416058941239e+00 9.203374321615860e+03 + 177440 9.738627608994629e-01 -6.055509332898874e+00 -6.006491603997840e+00 3.433834112417169e+00 4.715301497235937e+00 9.236997630411264e+03 + 177460 9.729432767466634e-01 -6.022174434204733e+00 -6.019835788191788e+00 3.568574074442331e+00 4.582002941752966e+00 9.278049816596711e+03 + 177480 1.010567097004502e+00 -6.043844188261650e+00 -6.002020081086783e+00 3.472729128711060e+00 4.712889624368815e+00 9.223258009128143e+03 + 177500 1.046838689790379e+00 -6.063707549993555e+00 -6.020401433609310e+00 3.318503981268742e+00 4.567174403146924e+00 9.279796936174422e+03 + 177520 1.047895207828843e+00 -6.034157552712553e+00 -6.018955515200203e+00 3.526813423430003e+00 4.614105875333617e+00 9.275328728681496e+03 + 177540 9.747947864616407e-01 -5.901819467142194e+00 -6.013777390753243e+00 4.225418158742682e+00 4.582538435935354e+00 9.259390730265681e+03 + 177560 1.044435484446132e+00 -5.984734454140878e+00 -6.020966056074871e+00 3.754853604802647e+00 4.546806139675381e+00 9.281520098666371e+03 + 177580 9.825187369789184e-01 -5.878139564957324e+00 -6.055614758426344e+00 4.330652679767782e+00 4.311562654671236e+00 9.388514483779221e+03 + 177600 1.033610640802592e+00 -5.946117046457956e+00 -5.975562821386276e+00 3.986851329209644e+00 4.817769132852284e+00 9.142174020956209e+03 + 177620 1.051401740162681e+00 -5.966030114102947e+00 -6.002444266957772e+00 3.854821376102510e+00 4.645725675338161e+00 9.224556684122923e+03 + 177640 1.049381713451125e+00 -5.962132633288412e+00 -6.007581548986621e+00 3.886520938935460e+00 4.625546231799373e+00 9.240332169293963e+03 + 177660 9.805190896069492e-01 -5.863881568056750e+00 -6.048943882728227e+00 4.385172514448403e+00 4.322516065304143e+00 9.367899778239173e+03 + 177680 1.007773931141368e+00 -5.913363828159510e+00 -6.033864980931240e+00 4.161484440444921e+00 4.469548173736524e+00 9.321288782362280e+03 + 177700 1.081299008670981e+00 -6.036451634224500e+00 -5.980814272368226e+00 3.536074928287603e+00 4.855553269920245e+00 9.158259885254047e+03 + 177720 1.016925395234491e+00 -5.963196646737559e+00 -6.021911802465483e+00 3.925874198909861e+00 4.588722688579136e+00 9.284416891603592e+03 + 177740 1.000621605424866e+00 -5.969350885595855e+00 -5.995232699057502e+00 3.855965248210628e+00 4.707347870116161e+00 9.202411273201798e+03 + 177760 1.024212464613263e+00 -6.040286711156051e+00 -5.997837615956288e+00 3.496128393997294e+00 4.739877667610587e+00 9.210416704063970e+03 + 177780 1.049957507498452e+00 -6.121866831766280e+00 -5.988080962447684e+00 3.079712504565480e+00 4.847931669489220e+00 9.180509297216224e+03 + 177800 9.469484199446444e-01 -6.015540840861155e+00 -5.997922419961623e+00 3.622152742640934e+00 4.723320441887872e+00 9.210675361429527e+03 + 177820 9.874079922084479e-01 -6.114482008659087e+00 -5.987281024217284e+00 3.099968749392686e+00 4.830376486346243e+00 9.178053829385133e+03 + 177840 9.275643880409704e-01 -6.054070019104115e+00 -6.009851815184737e+00 3.386322808841023e+00 4.640230578491032e+00 9.247323056627471e+03 + 177860 9.608875470349093e-01 -6.117274389678698e+00 -6.006509681033987e+00 3.058446332238035e+00 4.694474430059236e+00 9.237064270475688e+03 + 177880 9.159610740944811e-01 -6.055447235481718e+00 -5.986380168609575e+00 3.419799282941844e+00 4.816393069015744e+00 9.175309377685726e+03 + 177900 9.378535979777097e-01 -6.086088984682631e+00 -5.971057204520895e+00 3.276390046755703e+00 4.936920329554843e+00 9.128420723134981e+03 + 177920 9.193098434925079e-01 -6.050352181949292e+00 -5.994164043441574e+00 3.446633100253055e+00 4.769274086650702e+00 9.199120006284540e+03 + 177940 9.112216245037928e-01 -6.026070025543798e+00 -6.024605273279377e+00 3.498533446290490e+00 4.506944280462474e+00 9.292731475498413e+03 + 177960 9.215426931825211e-01 -6.025501908228765e+00 -5.989818044867556e+00 3.540886668794511e+00 4.745788934274581e+00 9.185822314302852e+03 + 177980 8.988539311918621e-01 -5.973455859922202e+00 -6.003939407055233e+00 3.810574928913037e+00 4.635533683961500e+00 9.229156028783927e+03 + 178000 9.752132252513728e-01 -6.065807283074414e+00 -5.987346342104764e+00 3.290476884064467e+00 4.741011748903576e+00 9.178245292291795e+03 + 178020 9.837997295469654e-01 -6.055414253407513e+00 -6.019895647101516e+00 3.344732778090987e+00 4.548686111986584e+00 9.278219938160206e+03 + 178040 9.979511480230382e-01 -6.055907473934412e+00 -5.992507185032440e+00 3.392618405927625e+00 4.756672675965749e+00 9.194047545988080e+03 + 178060 9.257600250475497e-01 -5.928643085750463e+00 -6.007843489299198e+00 4.060796923950452e+00 4.606015950550780e+00 9.241116353272499e+03 + 178080 9.337190056765867e-01 -5.920695979805094e+00 -5.984305246792397e+00 4.154367193484552e+00 4.789112938941205e+00 9.168913120700063e+03 + 178100 1.017258640189517e+00 -6.023583284042605e+00 -5.974620436726044e+00 3.567660598039432e+00 4.848812844307260e+00 9.139310587030535e+03 + 178120 1.057495262438576e+00 -6.064280196418083e+00 -5.990672262192798e+00 3.369350051437696e+00 4.792018200550288e+00 9.188443270304868e+03 + 178140 9.302431617042208e-01 -5.860302543759597e+00 -6.090146968428724e+00 4.434471149717234e+00 4.114668894957345e+00 9.495832969047173e+03 + 178160 1.083403816864987e+00 -6.076452107656603e+00 -5.992060666042850e+00 3.278194676834656e+00 4.762783394114216e+00 9.192710153517357e+03 + 178180 9.836250588032699e-01 -5.920564148485058e+00 -6.048031734906729e+00 4.133269736438100e+00 4.401331129659618e+00 9.365083894600730e+03 + 178200 9.930946722779177e-01 -5.931614341212926e+00 -6.031878383742103e+00 4.041484805618371e+00 4.465753157605402e+00 9.315147230036260e+03 + 178220 9.951756995533535e-01 -5.932841274021201e+00 -6.032423554222772e+00 4.007180080578848e+00 4.435363217353368e+00 9.316838803478622e+03 + 178240 1.006975644249011e+00 -5.949478656472123e+00 -6.045019751628504e+00 3.943852218521189e+00 4.395240465196553e+00 9.355780377296418e+03 + 178260 9.916664789592852e-01 -5.931450970399820e+00 -6.009553804992096e+00 4.077166373104860e+00 4.628687810501419e+00 9.246412904839626e+03 + 178280 9.975215051463683e-01 -5.946031456802832e+00 -6.032187152515867e+00 3.953181424560299e+00 4.458462087225229e+00 9.316115416104250e+03 + 178300 1.039595268086907e+00 -6.018172249998901e+00 -6.023762397481839e+00 3.592931461269476e+00 4.560831969349918e+00 9.290131527458898e+03 + 178320 9.980172613266477e-01 -5.973707844745709e+00 -5.961214164238558e+00 3.849331567125344e+00 4.921072213988217e+00 9.098341130389916e+03 + 178340 9.887939718963190e-01 -5.984500457472275e+00 -5.945712267851960e+00 3.739737357977650e+00 4.962465145230447e+00 9.051137954810132e+03 + 178360 9.871481057211928e-01 -6.013930802956386e+00 -5.962212983664378e+00 3.580505917604592e+00 4.877477639285969e+00 9.101400749810924e+03 + 178380 9.727381187262096e-01 -6.033944115851936e+00 -5.951784093572853e+00 3.506953511904297e+00 4.978729074053154e+00 9.069614086120684e+03 + 178400 9.477746673907185e-01 -6.042881243320062e+00 -5.967279121289091e+00 3.482175331854116e+00 4.916294415946526e+00 9.116877039067213e+03 + 178420 9.292865912329386e-01 -6.057907926142990e+00 -5.997289389578915e+00 3.410884126275685e+00 4.758965143914817e+00 9.208733992010342e+03 + 178440 9.208593381717737e-01 -6.078175077567024e+00 -5.990538329809087e+00 3.282819732505419e+00 4.786043499874379e+00 9.188032085093866e+03 + 178460 9.022327472579774e-01 -6.071015445929968e+00 -6.046466498301334e+00 3.247871153175036e+00 4.388835009396017e+00 9.360250485062043e+03 + 178480 8.872720837383771e-01 -6.060623813723814e+00 -6.006174493410626e+00 3.363315868385820e+00 4.675972291629234e+00 9.236017270276376e+03 + 178500 9.110628306468648e-01 -6.097210943416791e+00 -5.980898330223722e+00 3.183626933057273e+00 4.851511957330601e+00 9.158502695275882e+03 + 178520 9.346979709965093e-01 -6.124605874697580e+00 -5.973970115512733e+00 3.051756718846815e+00 4.916730558894601e+00 9.137327862879289e+03 + 178540 9.017508805187439e-01 -6.060825972231974e+00 -5.991775198946760e+00 3.365662245935380e+00 4.762162471711714e+00 9.191808175867889e+03 + 178560 9.626212204154936e-01 -6.129138331424397e+00 -5.946570727580172e+00 2.992227684957942e+00 5.040559118476876e+00 9.053759385410724e+03 + 178580 9.367896250181373e-01 -6.061227818257970e+00 -5.954541162025910e+00 3.393246433097285e+00 5.005857722888469e+00 9.078023294809644e+03 + 178600 9.768803052964884e-01 -6.087517118945788e+00 -5.969433702915037e+00 3.257790933056741e+00 4.935844181254888e+00 9.123460088080217e+03 + 178620 9.672124210046233e-01 -6.043061596373003e+00 -5.979214357346669e+00 3.483923019488819e+00 4.850543746306337e+00 9.153362906925991e+03 + 178640 9.491985784725766e-01 -5.991267570492515e+00 -5.982162752076092e+00 3.754660196283434e+00 4.806941472596632e+00 9.162380396606037e+03 + 178660 1.001549348545947e+00 -6.049425843812911e+00 -5.990697437612562e+00 3.437255081815271e+00 4.774482678409167e+00 9.188503084400150e+03 + 178680 9.730459136525558e-01 -5.991419880571842e+00 -5.963752812885994e+00 3.700478083316173e+00 4.859346667433201e+00 9.106122171162719e+03 + 178700 1.010300858579606e+00 -6.032993587332658e+00 -5.954144780519288e+00 3.556648975299374e+00 5.009411025835170e+00 9.076794050853048e+03 + 178720 1.058121060290484e+00 -6.091756509058480e+00 -5.926388788916959e+00 3.189650574259390e+00 5.139217613883992e+00 8.992455103290677e+03 + 178740 9.566449514252516e-01 -5.930526685986979e+00 -6.011944271847286e+00 4.061905411665405e+00 4.594393034324832e+00 9.253715199165885e+03 + 178760 9.831735096126760e-01 -5.959020580674279e+00 -5.978488591793916e+00 3.903790093928747e+00 4.792001761414807e+00 9.151099867653829e+03 + 178780 1.007462610216310e+00 -5.982920356313245e+00 -5.986881165954163e+00 3.815419569490058e+00 4.792675987598595e+00 9.176776911325174e+03 + 178800 1.043023195872440e+00 -6.022410827708279e+00 -5.992187197687645e+00 3.570429675428799e+00 4.743978436098907e+00 9.193067834598593e+03 + 178820 1.003676221135294e+00 -5.953126111065577e+00 -6.013168170476298e+00 3.949690102321434e+00 4.604919305706408e+00 9.257516582895763e+03 + 178840 9.958779376691825e-01 -5.933770854408212e+00 -6.056828633338899e+00 4.006125803290432e+00 4.299508993540682e+00 9.392348326357436e+03 + 178860 1.009868684194753e+00 -5.950956142775554e+00 -5.985098770194756e+00 3.960698202332261e+00 4.764645952136685e+00 9.171361412638780e+03 + 178880 9.762769749423450e-01 -5.898784006602943e+00 -6.058612490337696e+00 4.187258563136266e+00 4.269498676153394e+00 9.397858440911003e+03 + 178900 1.006640121235364e+00 -5.944359315340793e+00 -6.060830697584284e+00 3.976504014301752e+00 4.307707313571475e+00 9.404733106452702e+03 + 178920 9.717983411397244e-01 -5.900295718591179e+00 -6.021503190961872e+00 4.191014139051394e+00 4.495022075903144e+00 9.283164598731792e+03 + 178940 1.030659499707377e+00 -5.996625876225156e+00 -5.981431638044052e+00 3.658134626043470e+00 4.745382292980128e+00 9.160131704667461e+03 + 178960 1.011796289291045e+00 -5.982716284680880e+00 -6.012987351698850e+00 3.723997173714047e+00 4.550176022464380e+00 9.256943445712575e+03 + 178980 1.018257619323644e+00 -6.013704217700987e+00 -5.973464872841347e+00 3.628367248878446e+00 4.859427794080993e+00 9.135783833728425e+03 + 179000 1.005538090894788e+00 -6.022087831101407e+00 -5.977779086127667e+00 3.552395327021677e+00 4.806822997417017e+00 9.148962021415457e+03 + 179020 9.871773140059937e-01 -6.028503108937826e+00 -5.984509502906627e+00 3.537739495819350e+00 4.790357589639033e+00 9.169559461192624e+03 + 179040 9.890512577211202e-01 -6.069683592325773e+00 -5.974265169644680e+00 3.367460473203514e+00 4.915367822191534e+00 9.138209740485972e+03 + 179060 9.377698894894231e-01 -6.027600280103387e+00 -6.010229288557836e+00 3.524972712865041e+00 4.624719634471851e+00 9.248485839929061e+03 + 179080 9.508318063647958e-01 -6.075193199059759e+00 -5.989946598641268e+00 3.292002636339630e+00 4.781501807811392e+00 9.186244201559197e+03 + 179100 9.231533208151848e-01 -6.055070885938232e+00 -6.014230034638274e+00 3.422526461153692e+00 4.657040949419361e+00 9.260793235007475e+03 + 179120 9.670173527204713e-01 -6.135990584641366e+00 -5.975899760853457e+00 2.947278554195161e+00 4.866544838360255e+00 9.143235117886206e+03 + 179140 9.231424382349311e-01 -6.079468550606004e+00 -5.964979917689194e+00 3.267363978886650e+00 4.924775426153656e+00 9.109867912921512e+03 + 179160 8.972243785825634e-01 -6.040742675362394e+00 -6.016293343222900e+00 3.420850022581818e+00 4.561241871248716e+00 9.267123491028213e+03 + 179180 9.333702165616738e-01 -6.084953667060239e+00 -5.996722206386099e+00 3.234693947365735e+00 4.741332648331061e+00 9.206989927817067e+03 + 179200 8.887356777233024e-01 -6.000264399202305e+00 -5.990046786677777e+00 3.638971343030065e+00 4.697642455316334e+00 9.186528907809345e+03 + 179220 9.371855584504322e-01 -6.045983406395718e+00 -5.960070389854783e+00 3.438142346960688e+00 4.931468182935078e+00 9.094873876913249e+03 + 179240 9.424316522481940e-01 -6.015384537145374e+00 -6.030580222830965e+00 3.557461797380223e+00 4.470205818648800e+00 9.311161047273165e+03 + 179260 1.024691559280740e+00 -6.096939028048443e+00 -5.983375080803297e+00 3.140664189792147e+00 4.792765948837809e+00 9.166082095115918e+03 + 179280 9.777150200799675e-01 -5.988629774841272e+00 -5.955095023445792e+00 3.821675998350145e+00 5.014237730348997e+00 9.079700331290989e+03 + 179300 1.008927886205068e+00 -6.003358959666291e+00 -5.960030964866531e+00 3.704605956807700e+00 4.953402007933446e+00 9.094781385543050e+03 + 179320 1.058937543266019e+00 -6.056604242083179e+00 -6.007697801278803e+00 3.390539854463767e+00 4.671368205809753e+00 9.240714986475432e+03 + 179340 1.029438621065921e+00 -6.002930940880934e+00 -6.008335628418729e+00 3.735784470820268e+00 4.704749918605553e+00 9.242653323019065e+03 + 179360 9.323305601847687e-01 -5.854876623007066e+00 -5.988868639655203e+00 4.466991728634019e+00 4.697588833842857e+00 9.182904365762872e+03 + 179380 1.027891388580157e+00 -5.992853569818510e+00 -5.991610031377688e+00 3.684136522282514e+00 4.691277112446668e+00 9.191289617666527e+03 + 179400 9.816833079571915e-01 -5.921361948842689e+00 -5.981853514751498e+00 4.137564267948997e+00 4.790212335461043e+00 9.161408582209699e+03 + 179420 1.039203551354381e+00 -6.005047944980960e+00 -5.979298919164639e+00 3.716528525818559e+00 4.864383416704744e+00 9.153617089864681e+03 + 179440 1.024848111434919e+00 -5.984294333058598e+00 -6.035633382749717e+00 3.766534035106983e+00 4.471737267088313e+00 9.326739739346780e+03 + 179460 9.964425804936998e-01 -5.945395427747669e+00 -6.012848512276618e+00 3.982313260833368e+00 4.594987211137051e+00 9.256524325654116e+03 + 179480 1.023485143748230e+00 -5.990653363323336e+00 -6.014480964394620e+00 3.735142709534104e+00 4.598320936873444e+00 9.261565108518471e+03 + 179500 1.019145035002925e+00 -5.992163656984376e+00 -5.982641933271649e+00 3.832732271345608e+00 4.887407482386063e+00 9.163833087530053e+03 + 179520 1.021874916670919e+00 -6.006649160567449e+00 -5.980320686409351e+00 3.693644791106322e+00 4.844826964040322e+00 9.156750300003707e+03 + 179540 1.006258087077832e+00 -5.996510247440908e+00 -5.982869821445139e+00 3.778982520214743e+00 4.857307957131548e+00 9.164529722401407e+03 + 179560 9.579271034967214e-01 -5.941022847127870e+00 -5.988549636047189e+00 4.015106506577621e+00 4.742200329856078e+00 9.181915556479495e+03 + 179580 1.005944902811730e+00 -6.025961629892605e+00 -5.976379800892399e+00 3.531275182540387e+00 4.815981717422812e+00 9.144668624265430e+03 + 179600 9.560055416991273e-01 -5.967044835269899e+00 -5.986194806024526e+00 3.830053556469882e+00 4.720091460948421e+00 9.174709618057143e+03 + 179620 1.002016564192858e+00 -6.050628611469199e+00 -5.944529282037625e+00 3.459724824957692e+00 5.068963593371955e+00 9.047529406118811e+03 + 179640 9.275264593171521e-01 -5.954692606041387e+00 -5.995558704671607e+00 3.932655585318110e+00 4.697996122975065e+00 9.203398252011750e+03 + 179660 9.947450432442272e-01 -6.068989935616901e+00 -5.967144780562403e+00 3.278629757043341e+00 4.863440397853076e+00 9.116458418732631e+03 + 179680 9.628414125133123e-01 -6.035286530964840e+00 -5.984770047064842e+00 3.508980961702016e+00 4.799054429656422e+00 9.170318096442701e+03 + 179700 9.184617308834511e-01 -5.981321522261661e+00 -6.009654223250839e+00 3.757573621802128e+00 4.594882868250962e+00 9.246702149024228e+03 + 179720 9.696047206517507e-01 -6.068112142322871e+00 -5.992258557166714e+00 3.340478219910946e+00 4.776041244181966e+00 9.193304579047266e+03 + 179740 9.827059840701606e-01 -6.098398263427691e+00 -5.951967790338935e+00 3.170177198443020e+00 5.011003634961133e+00 9.070188539496932e+03 + 179760 9.345088298382044e-01 -6.033619293424791e+00 -5.986099712647723e+00 3.520510874241725e+00 4.793375660695006e+00 9.174398317039160e+03 + 179780 9.078825465894179e-01 -5.995169451688890e+00 -5.976390910858860e+00 3.770089147918263e+00 4.877918435334101e+00 9.144699753438297e+03 + 179800 9.840094398934990e-01 -6.101616715723819e+00 -6.013930840786265e+00 3.132570724973893e+00 4.636076588210620e+00 9.259872237248999e+03 + 179820 9.683153559832544e-01 -6.065401234054118e+00 -6.001942708276190e+00 3.336215925307922e+00 4.700604600499908e+00 9.223031953096741e+03 + 179840 9.044883609414539e-01 -5.951506467680859e+00 -6.013466749991403e+00 3.929424326123033e+00 4.573638796773192e+00 9.258453162901389e+03 + 179860 9.745267207657654e-01 -6.027651913954385e+00 -5.973026552302374e+00 3.512244285503057e+00 4.825911565356297e+00 9.134444866508455e+03 + 179880 9.353581158889364e-01 -5.933751050919922e+00 -6.015936596591660e+00 4.038539127325994e+00 4.566617005906793e+00 9.266027967059046e+03 + 179900 1.019350959973823e+00 -6.016851107430098e+00 -6.044048730719568e+00 3.581368127410697e+00 4.425195165663951e+00 9.352777512456874e+03 + 179920 1.046110029502650e+00 -6.021224697310109e+00 -6.010653739949583e+00 3.640411302852100e+00 4.701111375866608e+00 9.249784246075938e+03 + 179940 1.061253136921800e+00 -6.016704509793685e+00 -6.022602480689760e+00 3.544186570535905e+00 4.510319508942597e+00 9.286583549433466e+03 + 179960 9.630192247999988e-01 -5.850242475035231e+00 -6.067149708700074e+00 4.500469484641711e+00 4.254954582652253e+00 9.424341429080398e+03 + 179980 9.797844444306657e-01 -5.861742335694476e+00 -6.082488324250414e+00 4.386958660376444e+00 4.119401033756925e+00 9.471990648827617e+03 + 180000 1.034786354841392e+00 -5.936007848877723e+00 -6.022929515221119e+00 4.048403840447799e+00 4.549286181219628e+00 9.287542255518287e+03 + 180020 1.021964502611247e+00 -5.915192273264887e+00 -5.977865700479429e+00 4.136323202301416e+00 4.776442684553996e+00 9.149185241295132e+03 + 180040 9.913971663599148e-01 -5.871044258698255e+00 -6.065832911568029e+00 4.287052993332116e+00 4.168546405107265e+00 9.420195120295768e+03 + 180060 1.035697380772151e+00 -5.941843679182977e+00 -6.027278295111419e+00 4.012234641611554e+00 4.521655855986352e+00 9.300956189061377e+03 + 180080 1.018935140786330e+00 -5.928795451468694e+00 -6.039111031504174e+00 4.067731467750102e+00 4.434282335905537e+00 9.337504061438123e+03 + 180100 1.010760262180409e+00 -5.934412530656129e+00 -6.041448931487182e+00 4.075035024523258e+00 4.460415447121858e+00 9.344721412534369e+03 + 180120 1.021376235574492e+00 -5.974982648285839e+00 -5.986903888836091e+00 3.821035840641998e+00 4.752582232596443e+00 9.176895032975068e+03 + 180140 1.055138182449216e+00 -6.056332963733523e+00 -5.949852735617117e+00 3.408901288736006e+00 5.020327236342451e+00 9.063726648728303e+03 + 180160 9.627915541490045e-01 -5.953160429210146e+00 -5.978247893955608e+00 3.917014696584656e+00 4.772958591743595e+00 9.150335025198850e+03 + 180180 1.053868765815246e+00 -6.125249043554541e+00 -5.915496207625521e+00 2.993934998562399e+00 5.198368241613286e+00 8.959473277017731e+03 + 180200 9.352082602154845e-01 -5.983727611234171e+00 -6.012549128268754e+00 3.736285148794207e+00 4.570787537866283e+00 9.255609204215447e+03 + 180220 9.303007313691823e-01 -6.005093531989797e+00 -6.038229363864311e+00 3.617557024719403e+00 4.427285950342535e+00 9.334786571325480e+03 + 180240 8.897454525751072e-01 -5.967483225944779e+00 -6.032740080439469e+00 3.866941955732087e+00 4.492226998757985e+00 9.317824489479384e+03 + 180260 9.591163506030060e-01 -6.084811682175545e+00 -6.027357465046377e+00 3.218172571918331e+00 4.548083577685383e+00 9.301243993768687e+03 + 180280 9.813306391577704e-01 -6.128198512844894e+00 -5.972916434146478e+00 3.034131638916488e+00 4.925785364626806e+00 9.134107367971821e+03 + 180300 9.294405989803959e-01 -6.053561753809691e+00 -5.992886904589620e+00 3.460944095540228e+00 4.809348469164444e+00 9.195231573545969e+03 + 180320 9.814610239191737e-01 -6.126289771798487e+00 -5.982460732193657e+00 3.033015264383551e+00 4.858903867266429e+00 9.163289963507241e+03 + 180340 8.859763563462557e-01 -5.976464151159750e+00 -6.008574607287054e+00 3.849780846816632e+00 4.665397638656623e+00 9.243397445467770e+03 + 180360 9.937822301540788e-01 -6.125871504516959e+00 -5.953761009505927e+00 3.077362756662007e+00 5.065647853028382e+00 9.075646805621665e+03 + 180380 9.513988772968641e-01 -6.050947943554001e+00 -5.992729448213415e+00 3.434748916071980e+00 4.769048525600658e+00 9.194743507410172e+03 + 180400 9.720348401335628e-01 -6.069932066837446e+00 -5.965833130725153e+00 3.321297772676080e+00 4.919049973091170e+00 9.112461635631780e+03 + 180420 9.318507708208762e-01 -5.998007362083089e+00 -5.971642521872344e+00 3.749094675624184e+00 4.900485668060123e+00 9.130183590360770e+03 + 180440 9.637426235716429e-01 -6.030678129729671e+00 -5.999909229737474e+00 3.532975616246512e+00 4.709655401473595e+00 9.216740282601842e+03 + 180460 9.474128483537408e-01 -5.990077015741282e+00 -6.020259309910871e+00 3.715000773646942e+00 4.541689369830237e+00 9.279338794072431e+03 + 180480 9.519713512578222e-01 -5.981170207002066e+00 -5.992049720863887e+00 3.817216802694582e+00 4.754744950500677e+00 9.192636281517800e+03 + 180500 9.997220244895449e-01 -6.033960625086773e+00 -5.998149983193220e+00 3.480817749369180e+00 4.686447996800887e+00 9.211350322908525e+03 + 180520 9.773977577984200e-01 -5.981245144075377e+00 -6.048917184257764e+00 3.769842845941346e+00 4.381259518999704e+00 9.367824850745175e+03 + 180540 9.945423629088589e-01 -5.989457279287903e+00 -5.996486524527907e+00 3.769576460176713e+00 4.729213446236423e+00 9.206275913183439e+03 + 180560 9.842490220213659e-01 -5.957960818224442e+00 -6.005897735877062e+00 3.891726185723779e+00 4.616464986348403e+00 9.235163388349241e+03 + 180580 1.010210368020916e+00 -5.980709151072529e+00 -6.010153022099554e+00 3.760891811554489e+00 4.591820547692993e+00 9.248229497802486e+03 + 180600 1.018155795866661e+00 -5.978469711566603e+00 -5.948584929340415e+00 3.808760787553420e+00 4.980363831751299e+00 9.059862867219206e+03 + 180620 9.896673065011419e-01 -5.922801113711766e+00 -5.948700044964703e+00 4.133483363737769e+00 4.984767692636747e+00 9.060188716152341e+03 + 180640 1.040634496558391e+00 -5.982654885227849e+00 -5.931546472023783e+00 3.846027434189356e+00 5.139499851808493e+00 9.008066354660854e+03 + 180660 1.054466098703342e+00 -5.987283417838095e+00 -5.976390766895032e+00 3.769379459644987e+00 4.831926746992342e+00 9.144693828139914e+03 + 180680 1.072121812772743e+00 -5.998508477302567e+00 -6.009372847582433e+00 3.661292629441542e+00 4.598907734038688e+00 9.245864668121043e+03 + 180700 1.029446243351263e+00 -5.925391042147684e+00 -6.030153459261540e+00 4.070408716620914e+00 4.468846705621498e+00 9.309854418099128e+03 + 180720 1.017783625385705e+00 -5.903836249382018e+00 -6.026722451811116e+00 4.219930977266966e+00 4.514299386340717e+00 9.299249180682602e+03 + 180740 1.047962300133713e+00 -5.950878851328903e+00 -5.984033563167922e+00 3.999506148439217e+00 4.809126662384491e+00 9.168069594804532e+03 + 180760 1.021452290013906e+00 -5.917787674345241e+00 -5.979346787758189e+00 4.168255542949527e+00 4.814773587490365e+00 9.153657106734150e+03 + 180780 1.069411874842502e+00 -6.000884360594074e+00 -6.003374397619430e+00 3.644234710694995e+00 4.629936532763420e+00 9.227367217092431e+03 + 180800 1.052178118993749e+00 -5.998189073513588e+00 -6.033366883989587e+00 3.676855684028539e+00 4.474859252526775e+00 9.319763575529145e+03 + 180820 9.999655913702344e-01 -5.960333866323841e+00 -6.024999851625926e+00 3.894886833772555e+00 4.523564739139104e+00 9.293971033985450e+03 + 180840 9.477815705279524e-01 -5.931721242374710e+00 -6.024159962931067e+00 4.004369047686163e+00 4.473571609405782e+00 9.291344154125045e+03 + 180860 9.067995289209830e-01 -5.914762835906449e+00 -5.991048422788839e+00 4.125150687631036e+00 4.687107042595939e+00 9.189563819038076e+03 + 180880 9.178455460076030e-01 -5.964447884656017e+00 -5.965002752491132e+00 3.906444676518987e+00 4.903258539544236e+00 9.109922636371053e+03 + 180900 9.799435348963781e-01 -6.080037042714024e+00 -5.958434110931577e+00 3.284826886974150e+00 4.983089739261835e+00 9.089874206822165e+03 + 180920 1.064910560510838e+00 -6.220574776712455e+00 -5.933675206651498e+00 2.530123336567668e+00 5.177545065422666e+00 9.014583946248693e+03 + 180940 9.060692503607407e-01 -5.994232631079623e+00 -6.035949440150567e+00 3.748875002999614e+00 4.509330629658915e+00 9.327755086621299e+03 + 180960 9.233509983673189e-01 -6.025901219368020e+00 -6.028188475182017e+00 3.553143558193124e+00 4.540009781357462e+00 9.303785272401401e+03 + 180980 9.682015875231426e-01 -6.092225490543352e+00 -6.013201145831619e+00 3.257206037340018e+00 4.710976053652608e+00 9.257620623006997e+03 + 181000 1.018504547750321e+00 -6.162004995173548e+00 -5.972158783986933e+00 2.855533141078936e+00 4.945659464318720e+00 9.131798834548035e+03 + 181020 9.701680392607483e-01 -6.080433280246861e+00 -5.979518683457886e+00 3.273981175184143e+00 4.853448406429822e+00 9.154262739934687e+03 + 181040 9.128067485052869e-01 -5.978898734478824e+00 -5.995233002675540e+00 3.807360898902805e+00 4.713567003197435e+00 9.202416061333541e+03 + 181060 1.004570593788307e+00 -6.091190967988172e+00 -5.982067103083709e+00 3.175022236763096e+00 4.801628355908043e+00 9.162103737942607e+03 + 181080 1.012316984249455e+00 -6.071801671111086e+00 -5.986304234634141e+00 3.306633323695874e+00 4.797572834632027e+00 9.175049379093149e+03 + 181100 1.008274168518649e+00 -6.030960373132744e+00 -5.993919115160687e+00 3.566328688013135e+00 4.779025323404829e+00 9.198392555268409e+03 + 181120 1.014927996834015e+00 -6.008039738705468e+00 -5.974319866054709e+00 3.648278703347180e+00 4.841903430241265e+00 9.138395638564672e+03 + 181140 9.840754200499160e-01 -5.927501650599653e+00 -6.049296315422483e+00 4.095285090908090e+00 4.395921277831934e+00 9.368973477556608e+03 + 181160 1.031279684695693e+00 -5.970283916150835e+00 -6.005401794949570e+00 3.836605113585409e+00 4.634952819048888e+00 9.233641311024739e+03 + 181180 1.006286508171421e+00 -5.914263726271347e+00 -6.041621131880399e+00 4.158951308915015e+00 4.427645377413013e+00 9.345244482935343e+03 + 181200 1.023514089641117e+00 -5.928765921253950e+00 -6.011508444612775e+00 4.111146267240811e+00 4.636025893750329e+00 9.252416473560706e+03 + 181220 1.063272892422102e+00 -5.983801920162226e+00 -6.000292894068529e+00 3.773935427105247e+00 4.679241702965292e+00 9.217943858192886e+03 + 181240 1.011956326173096e+00 -5.908547431586107e+00 -6.013489568175513e+00 4.226937900248498e+00 4.624343912208976e+00 9.258485524364023e+03 + 181260 9.866250551073861e-01 -5.876125302965813e+00 -6.023194845714832e+00 4.321422196289584e+00 4.476926122886536e+00 9.288384349938933e+03 + 181280 1.027143618065350e+00 -5.943022183082362e+00 -5.983707646265501e+00 4.032676889092916e+00 4.799054663440251e+00 9.167103095490966e+03 + 181300 1.012083913897663e+00 -5.928831831996433e+00 -6.002603534510957e+00 4.110802319947798e+00 4.687193787975337e+00 9.225038817200822e+03 + 181320 1.025666181159366e+00 -5.956695652373408e+00 -5.994424052261999e+00 3.907651378289242e+00 4.691009067677943e+00 9.199927434518446e+03 + 181340 1.045972180937544e+00 -5.996111723454984e+00 -5.990664668300277e+00 3.737836641593027e+00 4.769114475220414e+00 9.188394325549456e+03 + 181360 9.764574273876603e-01 -5.904425822425165e+00 -6.005718857258745e+00 4.269492475938604e+00 4.687852194877708e+00 9.234598354100177e+03 + 181380 1.091612123159539e+00 -6.088281757507255e+00 -5.975327740338939e+00 3.250804414603619e+00 4.899403860761762e+00 9.141465230438718e+03 + 181400 9.892569978854406e-01 -5.950661130487217e+00 -5.974389520249618e+00 4.039696503150343e+00 4.903444417178185e+00 9.138573930637020e+03 + 181420 9.965602519826430e-01 -5.973002526749511e+00 -6.014464292203127e+00 3.811565342221249e+00 4.573485468799119e+00 9.261491126913132e+03 + 181440 9.806594498431351e-01 -5.960618993042701e+00 -6.007925585841321e+00 3.920236454761281e+00 4.648594678240023e+00 9.241350152101633e+03 + 181460 9.639201710825499e-01 -5.946025956665160e+00 -6.035719892436476e+00 3.949785333130235e+00 4.434748873839634e+00 9.327034800685546e+03 + 181480 9.898659960385122e-01 -5.997002751450939e+00 -6.011978729749038e+00 3.735061032171536e+00 4.649066647258698e+00 9.253841279035378e+03 + 181500 1.019081878738118e+00 -6.052346730319625e+00 -5.947039479155590e+00 3.450234818326094e+00 5.054925350754438e+00 9.055184820908818e+03 + 181520 9.471894848870266e-01 -5.954985100573234e+00 -5.960410280467213e+00 3.931688534900137e+00 4.900536312405035e+00 9.095923045883712e+03 + 181540 9.645158102101971e-01 -5.986977141201313e+00 -5.957549642916633e+00 3.766383766969418e+00 4.935361016010694e+00 9.087212506021617e+03 + 181560 1.009162946036698e+00 -6.054372210780657e+00 -5.985837615594498e+00 3.383785447637797e+00 4.777321698891047e+00 9.173631161931533e+03 + 181580 1.026040787949162e+00 -6.080601431499735e+00 -6.001384088166795e+00 3.250861485743189e+00 4.705739730005195e+00 9.221314234456337e+03 + 181600 9.818197038578823e-01 -6.018052330433643e+00 -5.998322851922516e+00 3.633428646336736e+00 4.746718365074555e+00 9.211896176602591e+03 + 181620 9.628893040335789e-01 -5.992927832365296e+00 -6.005791180725057e+00 3.731230005158143e+00 4.657366668279667e+00 9.234827636194381e+03 + 181640 1.003982993014364e+00 -6.054138229741735e+00 -6.033054619961514e+00 3.355666582969798e+00 4.476731933005894e+00 9.318821140968934e+03 + 181660 9.727142675398996e-01 -6.008020510485025e+00 -6.020887597527756e+00 3.674808344974523e+00 4.600923539999876e+00 9.281279855941930e+03 + 181680 9.462944864764442e-01 -5.967570993569518e+00 -6.000801972144816e+00 3.827267807945716e+00 4.636450386489038e+00 9.219505517986767e+03 + 181700 1.030273791933878e+00 -6.086919811274250e+00 -5.985254661066538e+00 3.171012012461752e+00 4.754789037585590e+00 9.171857187011457e+03 + 181720 9.905825826729636e-01 -6.019610500052217e+00 -6.017171695440518e+00 3.595052142539841e+00 4.609056136024011e+00 9.269842862509262e+03 + 181740 1.002613845302332e+00 -6.029154923628338e+00 -6.039000815458850e+00 3.520688067682312e+00 4.464151433144679e+00 9.337161466928632e+03 + 181760 9.808623118470851e-01 -5.987281176919955e+00 -6.015581206666042e+00 3.811203192185828e+00 4.648700041968345e+00 9.264931545141821e+03 + 181780 1.006858030373523e+00 -6.014567237880800e+00 -6.016684801417337e+00 3.545889455671579e+00 4.533730078152889e+00 9.268354181145247e+03 + 181800 9.707834853625439e-01 -5.948055536058483e+00 -6.014894104598900e+00 3.999406044982323e+00 4.615608641188194e+00 9.262805408062719e+03 + 181820 1.015050267280861e+00 -5.999572886907787e+00 -6.018093331935707e+00 3.724765529327150e+00 4.618418267947228e+00 9.272680854611132e+03 + 181840 9.874341760438577e-01 -5.945782150646543e+00 -5.989470236874347e+00 3.990672448190378e+00 4.739808696360837e+00 9.184740204843290e+03 + 181860 1.028764960934823e+00 -5.993728989352462e+00 -5.991714181186871e+00 3.737810697251242e+00 4.749380037528624e+00 9.191606693291553e+03 + 181880 1.094871989340855e+00 -6.077376192462176e+00 -6.023687855040802e+00 3.272991245312908e+00 4.581277987029804e+00 9.289902479639015e+03 + 181900 1.061484943226851e+00 -6.018743641128387e+00 -5.997678261901029e+00 3.606192628960282e+00 4.727153296340671e+00 9.209930227679331e+03 + 181920 1.041770129689278e+00 -5.984723358621962e+00 -5.981417142040281e+00 3.855636900533377e+00 4.874621707780751e+00 9.160090388246912e+03 + 181940 1.089693812783205e+00 -6.052619385536496e+00 -5.999148656113325e+00 3.406772059186081e+00 4.713809262102561e+00 9.214438445125801e+03 + 181960 1.057743810563610e+00 -6.005909495032145e+00 -5.990143219052668e+00 3.710765509769440e+00 4.801297906266917e+00 9.186811848488474e+03 + 181980 1.019357929555168e+00 -5.953914669978669e+00 -5.977523997605832e+00 3.955347151034168e+00 4.819778738267356e+00 9.148161395016159e+03 + 182000 1.015788569884573e+00 -5.958131039905917e+00 -5.972259121410397e+00 3.962478390695513e+00 4.881352760383236e+00 9.132029114260142e+03 + 182020 1.064769751724360e+00 -6.041710444403511e+00 -6.000523814358916e+00 3.440238306651224e+00 4.676738309977686e+00 9.218657846795448e+03 + 182040 1.017575686263339e+00 -5.987984033952788e+00 -6.058971198967568e+00 3.718402305095835e+00 4.310783018352685e+00 9.398948948001018e+03 + 182060 9.526618395678402e-01 -5.914395069367944e+00 -6.039496186059900e+00 4.152639695031388e+00 4.434289723650941e+00 9.338678107251872e+03 + 182080 9.885129185707038e-01 -5.993515333089393e+00 -5.974206971427144e+00 3.793987370150671e+00 4.904858970774615e+00 9.138043109810415e+03 + 182100 1.025382237816900e+00 -6.075618811728842e+00 -6.020398045814337e+00 3.311073200813982e+00 4.628159384080975e+00 9.279786079496715e+03 + 182120 1.030362623954514e+00 -6.115355815721492e+00 -6.004645382018563e+00 3.049354077727444e+00 4.685070520433909e+00 9.231331267822487e+03 + 182140 9.566262185284485e-01 -6.038505121121864e+00 -5.993531985218322e+00 3.539655412234968e+00 4.797898118163396e+00 9.197200573994960e+03 + 182160 9.162558026861913e-01 -6.003606004133784e+00 -6.007288976372581e+00 3.654977966857007e+00 4.633829770323722e+00 9.239431585200222e+03 + 182180 9.696037854035258e-01 -6.102125674718873e+00 -6.019935994545732e+00 3.104455553000762e+00 4.576401415366838e+00 9.278353660428995e+03 + 182200 9.880939815007709e-01 -6.145174583963687e+00 -5.952926634122242e+00 2.936739437178391e+00 5.040656915442060e+00 9.073127942151788e+03 + 182220 9.428936785225798e-01 -6.087241863139080e+00 -5.975155516653115e+00 3.228181795963988e+00 4.871798942792462e+00 9.140931217104158e+03 + 182240 9.138093616092147e-01 -6.045415221885472e+00 -5.960576345475547e+00 3.456477976553503e+00 4.943635933672985e+00 9.096403361594543e+03 + 182260 9.487712667746948e-01 -6.090045164192873e+00 -5.954285701984497e+00 3.208953387805698e+00 4.988505228515075e+00 9.077253970347027e+03 + 182280 9.427556601355718e-01 -6.063709840726833e+00 -5.986174803162628e+00 3.297467833015790e+00 4.742686017217740e+00 9.174664970982583e+03 + 182300 8.902619345958647e-01 -5.960782122354770e+00 -5.971262151856626e+00 3.860305120718892e+00 4.800127169539909e+00 9.129032329552932e+03 + 182320 9.750626195912316e-01 -6.047424575175914e+00 -5.969191930254336e+00 3.432176476944995e+00 4.881400430547372e+00 9.122713389470387e+03 + 182340 1.071867747953989e+00 -6.137360215123249e+00 -5.982502580395765e+00 2.962311786894896e+00 4.851528289641639e+00 9.163423512453041e+03 + 182360 1.006009586177461e+00 -5.989125516484894e+00 -6.052758565948650e+00 3.744885861569823e+00 4.379495044366356e+00 9.379731369936144e+03 + 182380 1.053304915955003e+00 -6.024674997382701e+00 -6.027244994813511e+00 3.539827538110176e+00 4.525070215156649e+00 9.300873107805835e+03 + 182400 9.849575935930915e-01 -5.904078422813933e+00 -6.052561078503235e+00 4.221867901915020e+00 4.369257515330344e+00 9.379100441236973e+03 + 182420 1.015316062399475e+00 -5.939904462427696e+00 -6.039133959521897e+00 4.028242866031373e+00 4.458451738001427e+00 9.337562864809912e+03 + 182440 1.072179257331362e+00 -6.021934726972622e+00 -6.002161625374856e+00 3.592829900283994e+00 4.706370109535952e+00 9.223671936789746e+03 + 182460 9.501501885831585e-01 -5.843924629358502e+00 -5.970709826570117e+00 4.585252472113124e+00 4.857232249778170e+00 9.127309220774854e+03 + 182480 9.716649654670941e-01 -5.876658844571335e+00 -5.955358418695038e+00 4.350314800914693e+00 4.898409667576654e+00 9.080490098232032e+03 + 182500 1.105768289425222e+00 -6.077192317261938e+00 -5.977519966482068e+00 3.249871428120305e+00 4.822205490544753e+00 9.148154239991345e+03 + 182520 1.022767804765886e+00 -5.958758662483815e+00 -6.031614862710540e+00 3.882850422084541e+00 4.464498845922138e+00 9.314350662081333e+03 + 182540 1.002489569450779e+00 -5.936652882064885e+00 -6.033063051255612e+00 4.038260676730509e+00 4.484658565811884e+00 9.318844812148560e+03 + 182560 1.084657948399603e+00 -6.072089857274799e+00 -6.002128159727716e+00 3.320091827580915e+00 4.721822721433968e+00 9.223605591811534e+03 + 182580 1.067050310330299e+00 -6.064777866087181e+00 -6.003331510230780e+00 3.359000808374712e+00 4.711835292495010e+00 9.227260104333391e+03 + 182600 9.564823493849928e-01 -5.922446449569024e+00 -6.022011401854908e+00 4.150577474668788e+00 4.578860111016668e+00 9.284751193730981e+03 + 182620 9.441944083056689e-01 -5.927197829985434e+00 -6.006078754417603e+00 4.087493737974933e+00 4.634547263101816e+00 9.235703042022618e+03 + 182640 1.036913740959963e+00 -6.086524645344479e+00 -5.990094939801179e+00 3.202702660057022e+00 4.756416951735356e+00 9.186657670220742e+03 + 182660 9.890626708118589e-01 -6.037048878787637e+00 -6.013357961311989e+00 3.522538927428304e+00 4.658575841731103e+00 9.258108052580928e+03 + 182680 1.000888646270679e+00 -6.075716114045341e+00 -5.962188197127944e+00 3.268042379299279e+00 4.919937246627335e+00 9.101336107667823e+03 + 182700 9.901298427721023e-01 -6.077392185884660e+00 -5.991063240596166e+00 3.278199255167244e+00 4.773913418374891e+00 9.189626347437672e+03 + 182720 9.620443388576426e-01 -6.049509329389321e+00 -6.014866968031617e+00 3.439066830102729e+00 4.637988629906757e+00 9.262718295569270e+03 + 182740 9.784743672164511e-01 -6.085900908955075e+00 -5.992822553757209e+00 3.236005260603938e+00 4.770475579979003e+00 9.195040974855114e+03 + 182760 1.013783831386332e+00 -6.148071141692538e+00 -5.977698717716732e+00 2.887242729718550e+00 4.865547553235023e+00 9.148738400907629e+03 + 182780 9.349864912068125e-01 -6.037534082094063e+00 -5.982225882025431e+00 3.523655873743368e+00 4.841244117453754e+00 9.162580037729231e+03 + 182800 9.580642636603198e-01 -6.073212487971444e+00 -6.024871513690589e+00 3.304646766741784e+00 4.582228121804044e+00 9.293550163716329e+03 + 182820 9.122653868202937e-01 -6.003704314486412e+00 -6.017519820900538e+00 3.697547429595031e+00 4.618216653822413e+00 9.270902707054960e+03 + 182840 1.001245185439745e+00 -6.125796924445758e+00 -5.992812558137458e+00 3.065723516984460e+00 4.829340327590894e+00 9.195002711475150e+03 + 182860 9.141892594135640e-01 -5.974001064899376e+00 -6.022556476900679e+00 3.848357295324167e+00 4.569544605686966e+00 9.286426545563665e+03 + 182880 9.649782369911409e-01 -6.013898396189093e+00 -6.045681252584395e+00 3.610211765630601e+00 4.427709685827645e+00 9.357820965497796e+03 + 182900 1.005357998909439e+00 -6.030490932872071e+00 -6.019693891491767e+00 3.512380345602465e+00 4.574378628044929e+00 9.277612529971177e+03 + 182920 1.044993125806035e+00 -6.043939723735056e+00 -6.023373639212405e+00 3.412366937291548e+00 4.530460577211901e+00 9.288940331911288e+03 + 182940 1.007880320715940e+00 -5.950002520719052e+00 -5.988067674742375e+00 4.002889128744857e+00 4.784313123779392e+00 9.180401423421969e+03 + 182960 9.810044460800680e-01 -5.880192271296242e+00 -5.980900893774838e+00 4.347616401684764e+00 4.769331906803707e+00 9.158454251363086e+03 + 182980 9.877139432990183e-01 -5.861948081038506e+00 -6.005056636967500e+00 4.444030319126291e+00 4.622278845004548e+00 9.232537550085091e+03 + 183000 1.031229386741818e+00 -5.905802247691381e+00 -5.997450745909051e+00 4.202423602417909e+00 4.676163743092786e+00 9.209217950040384e+03 + 183020 1.047363247977307e+00 -5.915034788759170e+00 -5.999890236669732e+00 4.137780978804355e+00 4.650527865563780e+00 9.216710259468198e+03 + 183040 1.063495286684998e+00 -5.933113104036942e+00 -6.015345186340257e+00 4.013418966237922e+00 4.541229624278679e+00 9.264203316159666e+03 + 183060 1.098259251577959e+00 -5.986469755056461e+00 -6.008414234112216e+00 3.743879465399741e+00 4.617870870764438e+00 9.242901862942350e+03 + 183080 1.079597470674723e+00 -5.968037969966009e+00 -5.984881211655237e+00 3.880933937205047e+00 4.784217436942271e+00 9.170697151207953e+03 + 183100 1.057214484272781e+00 -5.950549249047874e+00 -6.013472826848893e+00 3.976040318144328e+00 4.614723397018683e+00 9.258454995796481e+03 + 183120 9.724056520294404e-01 -5.848759222746648e+00 -6.053637943080783e+00 4.516011638471676e+00 4.339566321433564e+00 9.382427135581094e+03 + 183140 1.052014891392743e+00 -5.996467291555065e+00 -5.971281140042882e+00 3.739368031453873e+00 4.883990810981185e+00 9.129105195301594e+03 + 183160 1.057756386629021e+00 -6.036508675357037e+00 -6.007197435855051e+00 3.524941664150271e+00 4.693251337270324e+00 9.239156546206572e+03 + 183180 9.742602203603242e-01 -5.948732191019153e+00 -6.015147038916361e+00 3.988574764757764e+00 4.607210430467499e+00 9.263608406229039e+03 + 183200 9.937897335521763e-01 -6.008690816433447e+00 -6.025848884566182e+00 3.639288250620909e+00 4.540763968200284e+00 9.296575680858035e+03 + 183220 1.002372078518033e+00 -6.048579026278200e+00 -5.974472537706095e+00 3.436993579868363e+00 4.862524505191431e+00 9.138864002451426e+03 + 183240 9.889035100578704e-01 -6.048227378942555e+00 -6.021274427183096e+00 3.393084246765260e+00 4.547852266723885e+00 9.282478524244076e+03 + 183260 9.358445811720060e-01 -5.981752897095433e+00 -6.021045948715351e+00 3.840869365270255e+00 4.615242582288602e+00 9.281774568500243e+03 + 183280 1.026918384235583e+00 -6.125967228017389e+00 -5.976457799517840e+00 3.007648046447226e+00 4.866154321400920e+00 9.144935013734112e+03 + 183300 9.431543541729727e-01 -6.005107932187757e+00 -6.009613177565723e+00 3.609335453441685e+00 4.583465637296936e+00 9.246586767559105e+03 + 183320 9.986003469017705e-01 -6.087238812515289e+00 -5.962137056080940e+00 3.236835390897606e+00 4.955189035777877e+00 9.101183863871953e+03 + 183340 9.240943091646798e-01 -5.971397236574089e+00 -6.009093518172287e+00 3.815592882701114e+00 4.599135000283535e+00 9.244987447826792e+03 + 183360 9.634058891940351e-01 -6.022544356233273e+00 -6.019047237334718e+00 3.524904234256025e+00 4.544985232148933e+00 9.275601239847494e+03 + 183380 9.979258153419266e-01 -6.065047154748023e+00 -6.006163810764862e+00 3.333805533343365e+00 4.671922806662709e+00 9.235994101829301e+03 + 183400 9.290772944652672e-01 -5.953961215398813e+00 -6.044603937415631e+00 3.928271190446292e+00 4.407786653709824e+00 9.354465174071371e+03 + 183420 9.828734309403858e-01 -6.022433893474582e+00 -6.018196850104997e+00 3.622166189551808e+00 4.646495948260311e+00 9.272981358821489e+03 + 183440 1.061379763790595e+00 -6.127692967412578e+00 -5.994632262783430e+00 3.009734417580240e+00 4.773789574638306e+00 9.200590148780888e+03 + 183460 9.466087243126081e-01 -5.947962791738287e+00 -6.020896401306304e+00 4.007031192819722e+00 4.588235120240563e+00 9.281292474063499e+03 + 183480 1.035052804771157e+00 -6.068467030312210e+00 -6.001034314885581e+00 3.295646158708948e+00 4.682855245867636e+00 9.220222892314410e+03 + 183500 1.039798099962219e+00 -6.065391051822946e+00 -5.959410775060739e+00 3.394963293630178e+00 5.003518443193595e+00 9.092867326033655e+03 + 183520 9.474717466935799e-01 -5.919151116899060e+00 -5.974690750219394e+00 4.146111506855162e+00 4.827194337599329e+00 9.139493542302886e+03 + 183540 9.786989012947097e-01 -5.953176634931132e+00 -6.002449213450504e+00 3.956566153123887e+00 4.673635382358766e+00 9.224586037475017e+03 + 183560 1.030116725417436e+00 -6.015351183505921e+00 -6.033169621411803e+00 3.589156666775229e+00 4.486840438925301e+00 9.319190476559248e+03 + 183580 1.006234479606220e+00 -5.971137637983199e+00 -6.033600342917856e+00 3.838165807997568e+00 4.479495290190425e+00 9.320489029967044e+03 + 183600 9.974146461467154e-01 -5.951604023837853e+00 -5.983602734708565e+00 4.001925153389386e+00 4.818183603785251e+00 9.166749244899396e+03 + 183620 9.805326134018771e-01 -5.917996205297022e+00 -6.019128697650789e+00 4.096918912522282e+00 4.516200491224342e+00 9.275873505713076e+03 + 183640 1.032125881422371e+00 -5.982636263840545e+00 -6.016134039425769e+00 3.825607142221499e+00 4.633257731047129e+00 9.266629778163917e+03 + 183660 1.077642571295205e+00 -6.035760827804297e+00 -5.987559113187468e+00 3.589704209447742e+00 4.866485913968800e+00 9.178900441833153e+03 + 183680 1.018386505443185e+00 -5.927402634929761e+00 -6.054145926134913e+00 4.128632756257134e+00 4.400853164696227e+00 9.384015062602222e+03 + 183700 1.008109267276090e+00 -5.887446389066246e+00 -6.093033500847690e+00 4.221181179941819e+00 4.040668169590040e+00 9.504847955762505e+03 + 183720 1.031324340743340e+00 -5.896574851595319e+00 -6.044908072956693e+00 4.247902770546983e+00 4.396150458998155e+00 9.355434269205278e+03 + 183740 1.006784798808802e+00 -5.836705007327609e+00 -6.049473165874452e+00 4.531344627226689e+00 4.309596935084593e+00 9.369529806105747e+03 + 183760 1.101424887944964e+00 -5.956092396097172e+00 -5.977241749824822e+00 3.942899067163566e+00 4.821456205207484e+00 9.147315049578781e+03 + 183780 1.115052803102607e+00 -5.962449670861370e+00 -5.977979025609891e+00 3.851105497534266e+00 4.761933539408380e+00 9.149526703306186e+03 + 183800 1.058038526784510e+00 -5.872337742893871e+00 -5.980981332503998e+00 4.396671082550046e+00 4.772822778467545e+00 9.158733851948051e+03 + 183820 1.113766544673128e+00 -5.958705299936583e+00 -5.951357502871469e+00 3.933554287778860e+00 4.975746475594667e+00 9.068301118622367e+03 + 183840 1.043034808067082e+00 -5.865365421385027e+00 -5.972696111670938e+00 4.385120555224953e+00 4.768811122232610e+00 9.133406410393760e+03 + 183860 1.044918719754484e+00 -5.884952786190659e+00 -5.994835133488733e+00 4.278017228032663e+00 4.647055785608834e+00 9.201182440227418e+03 + 183880 1.093462489546802e+00 -5.983724684974982e+00 -6.007550821780359e+00 3.809986903039649e+00 4.673173538420423e+00 9.240239073837531e+03 + 183900 1.057148807307428e+00 -5.965071148323464e+00 -5.975913232270150e+00 3.970985589981417e+00 4.908728666152477e+00 9.143235005001532e+03 + 183920 9.912250083079684e-01 -5.907250534550263e+00 -6.013445829260425e+00 4.188899917949707e+00 4.579110102055215e+00 9.258356978295453e+03 + 183940 1.031487113506778e+00 -6.006802958831130e+00 -5.985000166665996e+00 3.653518883249906e+00 4.778713889833291e+00 9.171067960716873e+03 + 183960 9.927317643620102e-01 -5.984129767330581e+00 -5.985472801129321e+00 3.749977112294655e+00 4.742265204388483e+00 9.172479544433027e+03 + 183980 9.498852608275915e-01 -5.946807728370525e+00 -5.971967134166327e+00 4.048863090730922e+00 4.904393889245964e+00 9.131168761827077e+03 + 184000 9.868994024346354e-01 -6.019713074155316e+00 -6.009930171706437e+00 3.562542680347696e+00 4.618717620108418e+00 9.247553552423098e+03 + 184020 1.039678731393795e+00 -6.113236783503364e+00 -5.988072468008662e+00 3.083977038422753e+00 4.802689907108556e+00 9.180462392118807e+03 + 184040 1.022886842586167e+00 -6.100339353888593e+00 -5.990249874116433e+00 3.202766747434130e+00 4.834917576577811e+00 9.187149082308233e+03 + 184060 9.879602440484496e-01 -6.058007908874687e+00 -5.997026768033187e+00 3.404975920606850e+00 4.755139068119789e+00 9.207919829383292e+03 + 184080 9.779395332185139e-01 -6.049004257386456e+00 -5.981753717711048e+00 3.522084163151884e+00 4.908247168955457e+00 9.161125205702463e+03 + 184100 1.016464091175654e+00 -6.108707635785919e+00 -5.959932765065052e+00 3.162937082411502e+00 5.017225412927556e+00 9.094469983344146e+03 + 184120 9.764291441895490e-01 -6.047393485704079e+00 -5.990483286670049e+00 3.460995954646740e+00 4.787783124324979e+00 9.187876187436710e+03 + 184140 9.829202884396158e-01 -6.052481356475666e+00 -5.992418660493836e+00 3.446975769520605e+00 4.791865064520436e+00 9.193791702440873e+03 + 184160 9.971653219186806e-01 -6.065312566917989e+00 -5.945362259773045e+00 3.365683429599877e+00 5.054456655476188e+00 9.050093697386697e+03 + 184180 9.846653687718639e-01 -6.032301026344959e+00 -5.999723206910732e+00 3.562380961734957e+00 4.749447842327552e+00 9.216198718039375e+03 + 184200 9.846500602136498e-01 -6.012135630554483e+00 -6.001411636772502e+00 3.617503630078308e+00 4.679082461907116e+00 9.221374946068874e+03 + 184220 9.764643303548862e-01 -5.972629342184030e+00 -5.997819129732612e+00 3.872162438626460e+00 4.727518780415475e+00 9.210333591439694e+03 + 184240 1.011333300997123e+00 -5.988852935303811e+00 -6.009413667786253e+00 3.759582012171433e+00 4.641519104494178e+00 9.245969152286087e+03 + 184260 1.023675915995934e+00 -5.962785403940132e+00 -6.013358081448491e+00 3.948971254830431e+00 4.658575114480886e+00 9.258079462302390e+03 + 184280 1.060054260078496e+00 -5.973740275953009e+00 -6.021090022982408e+00 3.801229851169018e+00 4.529340276376535e+00 9.281886230244621e+03 + 184300 1.063199315893236e+00 -5.940433320437109e+00 -6.015701580592967e+00 3.982386495080835e+00 4.550184497540283e+00 9.265312797343237e+03 + 184320 1.081792110424217e+00 -5.939355144842389e+00 -6.020752014326860e+00 4.031197213760992e+00 4.563803793056320e+00 9.280850261450802e+03 + 184340 1.093272467808163e+00 -5.938266756706020e+00 -6.006595536716134e+00 4.114874666266844e+00 4.722520237604239e+00 9.237296768854121e+03 + 184360 1.110756093719319e+00 -5.960146618950159e+00 -6.026692165120724e+00 3.909264541104779e+00 4.527149717103406e+00 9.299156227246693e+03 + 184380 1.107670286957531e+00 -5.962283487283559e+00 -5.971273719595462e+00 3.915806170034438e+00 4.864182864865535e+00 9.129061861545691e+03 + 184400 1.056238517927874e+00 -5.895843122222988e+00 -5.981723011518270e+00 4.272291545613071e+00 4.779155931409645e+00 9.161011245455908e+03 + 184420 1.043975892627608e+00 -5.892787313531788e+00 -6.031400022184282e+00 4.239210980725054e+00 4.443275357395099e+00 9.313700551585469e+03 + 184440 1.131282813112820e+00 -6.041916775116773e+00 -6.019230552765037e+00 3.422707858189155e+00 4.552975657614386e+00 9.276174590700180e+03 + 184460 1.021584923966032e+00 -5.903170004195438e+00 -6.016263258159931e+00 4.195813987407101e+00 4.546415022018492e+00 9.267027456981394e+03 + 184480 1.046694216894824e+00 -5.960731962998117e+00 -6.000867204681484e+00 3.905443641912329e+00 4.674980873257861e+00 9.219685836947174e+03 + 184500 1.018405997592934e+00 -5.935041190270415e+00 -6.013766445318071e+00 4.024343289521956e+00 4.572290692344469e+00 9.259345065078560e+03 + 184520 1.067671387763121e+00 -6.023400989872116e+00 -5.943746477205917e+00 3.573121991582715e+00 5.030510529808026e+00 9.045157586823949e+03 + 184540 1.042082871822497e+00 -5.998356814095334e+00 -5.959225481080560e+00 3.747368850238591e+00 4.972067019963640e+00 9.092272617861177e+03 + 184560 9.864592649516118e-01 -5.927595537860892e+00 -5.999770788000561e+00 4.081319704345249e+00 4.666878248959408e+00 9.216315967120465e+03 + 184580 1.013281044411565e+00 -5.977649403324318e+00 -5.968669623675581e+00 3.851534899812935e+00 4.903098184172394e+00 9.121087219984693e+03 + 184600 9.484236434955317e-01 -5.890142817557208e+00 -6.011296042223881e+00 4.301009678207553e+00 4.605329113770591e+00 9.251753056364882e+03 + 184620 1.018340227122341e+00 -6.002462022232959e+00 -6.005352566554682e+00 3.635027552320818e+00 4.618429599515198e+00 9.233513819782984e+03 + 184640 1.005991746881530e+00 -5.993274318394762e+00 -5.989568075212894e+00 3.767272080442044e+00 4.788553902331607e+00 9.185048784188382e+03 + 184660 9.900007034189967e-01 -5.978241999524661e+00 -5.981331954620222e+00 3.833057124647236e+00 4.815314124319516e+00 9.159843040035092e+03 + 184680 1.024029947038209e+00 -6.039447766766517e+00 -5.989638253701488e+00 3.498798113547532e+00 4.784812045564166e+00 9.185271227290650e+03 + 184700 1.025932717479758e+00 -6.053042711404411e+00 -5.995958699014500e+00 3.454731382545428e+00 4.782516615410669e+00 9.204642785454624e+03 + 184720 8.709723632678468e-01 -5.834295036451319e+00 -6.068562329702715e+00 4.555410314391826e+00 4.210211263795842e+00 9.428744716468311e+03 + 184740 1.007938921452820e+00 -6.048241926894878e+00 -6.008964481395323e+00 3.412903641270719e+00 4.638440811494212e+00 9.244596118436815e+03 + 184760 1.001163663396630e+00 -6.050343617837003e+00 -6.009379928597156e+00 3.432295655982411e+00 4.667515498708035e+00 9.245846859265743e+03 + 184780 9.602290082104903e-01 -6.003011880796844e+00 -6.004760913444803e+00 3.728742717534523e+00 4.718699501408015e+00 9.231664350205572e+03 + 184800 9.876109397736118e-01 -6.057098727741096e+00 -5.993864615743540e+00 3.422652161125108e+00 4.785752217662281e+00 9.198228195075490e+03 + 184820 9.613140200318818e-01 -6.033783465880657e+00 -6.024371278183887e+00 3.517682590975075e+00 4.571728829261270e+00 9.292017843678716e+03 + 184840 9.403438782999645e-01 -6.023770937127686e+00 -6.005700754900780e+00 3.566877983436505e+00 4.670639766135064e+00 9.234553477119085e+03 + 184860 9.248302508182439e-01 -6.022425305338126e+00 -5.983504546561015e+00 3.595249566558121e+00 4.818738586424250e+00 9.166457808174275e+03 + 184880 9.142287992307874e-01 -6.027034015554238e+00 -5.976283254208735e+00 3.532255862808601e+00 4.823674588109416e+00 9.144373105577295e+03 + 184900 9.702061179794451e-01 -6.126860383147412e+00 -5.939703873956619e+00 2.997719336775240e+00 5.072400974924975e+00 9.032886693729855e+03 + 184920 9.369193761322693e-01 -6.089664121383340e+00 -5.962934734222476e+00 3.242857731157446e+00 4.970557483544405e+00 9.103597926778035e+03 + 184940 9.326974353530773e-01 -6.087693168833210e+00 -5.980633961534583e+00 3.241228982559597e+00 4.855979518227105e+00 9.157680121813359e+03 + 184960 9.436810154952806e-01 -6.102264682657212e+00 -5.996159313225495e+00 3.139942217198551e+00 4.749215668228328e+00 9.205277028662942e+03 + 184980 9.399605712478332e-01 -6.087790072104664e+00 -5.989951697500601e+00 3.245398762470294e+00 4.807201849886360e+00 9.186228882094596e+03 + 185000 9.412967735263311e-01 -6.070893259622386e+00 -5.961625281833065e+00 3.368762830485333e+00 4.996196468116529e+00 9.099643040212581e+03 + 185020 9.987256182182895e-01 -6.126629633624533e+00 -5.974549572853361e+00 3.028531966411728e+00 4.901799209673141e+00 9.139108027254226e+03 + 185040 9.863156396480806e-01 -6.067762409842441e+00 -6.011592356811549e+00 3.358882224714888e+00 4.681419361505881e+00 9.252678003476818e+03 + 185060 9.574272614564947e-01 -5.982801370180530e+00 -6.037690922178650e+00 3.761559526564238e+00 4.446375224860310e+00 9.333129256777444e+03 + 185080 1.012097437572886e+00 -6.026103163211535e+00 -5.986077101381630e+00 3.562328090398865e+00 4.792163931439227e+00 9.174357613822167e+03 + 185100 1.029343463421197e+00 -6.020958590465044e+00 -5.995505655397212e+00 3.580946118620209e+00 4.727100810608679e+00 9.203229916056336e+03 + 185120 1.023393382980984e+00 -5.987637845733543e+00 -5.959377467834615e+00 3.760608702407979e+00 4.922884165582970e+00 9.092751378449322e+03 + 185140 1.002260308617291e+00 -5.936111200692053e+00 -5.992843381901519e+00 4.052502130578477e+00 4.726737166797055e+00 9.195059530618140e+03 + 185160 1.063971401936506e+00 -6.010398598339458e+00 -5.972107507609772e+00 3.692795290854355e+00 4.912668659351354e+00 9.131624680313887e+03 + 185180 9.862668811129939e-01 -5.883840334827548e+00 -6.050561807277160e+00 4.303904515373567e+00 4.346564020503417e+00 9.372915021931532e+03 + 185200 1.005396258302665e+00 -5.908399463733574e+00 -6.037184744884700e+00 4.222250585125001e+00 4.482745571297387e+00 9.331542181607500e+03 + 185220 1.050572007105858e+00 -5.975954949726953e+00 -6.019021738117678e+00 3.798651793264707e+00 4.551355629761201e+00 9.275542472350844e+03 + 185240 9.948202791580726e-01 -5.898560438997340e+00 -6.052553869596414e+00 4.197475833014334e+00 4.313221724108079e+00 9.379079609207227e+03 + 185260 1.054151143865180e+00 -5.996977682555052e+00 -5.989729909135392e+00 3.730934119777992e+00 4.772551956342989e+00 9.185544667918906e+03 + 185280 1.005062924340876e+00 -5.935775057434811e+00 -6.011386534554047e+00 4.033721145269915e+00 4.599548342812993e+00 9.252021314635876e+03 + 185300 1.012829714159185e+00 -5.963495863736303e+00 -6.019933959034971e+00 3.883441647663263e+00 4.559365370691289e+00 9.278343361560732e+03 + 185320 1.030089083503214e+00 -6.010648952852334e+00 -6.024506215894244e+00 3.590209977746933e+00 4.510639428955754e+00 9.292437285956645e+03 + 185340 1.023706316066184e+00 -6.028112577073878e+00 -5.969060213191920e+00 3.541386443186380e+00 4.880474254920356e+00 9.122320151671151e+03 + 185360 1.015569157115144e+00 -6.044855130531360e+00 -5.992276851707185e+00 3.440098586309802e+00 4.742011199780567e+00 9.193370968281557e+03 + 185380 1.038658504349097e+00 -6.112492479135274e+00 -5.965187951376989e+00 3.110771119679198e+00 4.956616513369271e+00 9.110502414452141e+03 + 185400 9.566770268019414e-01 -6.022034298453513e+00 -5.964523867966527e+00 3.626057876048340e+00 4.956291667614972e+00 9.108463353313931e+03 + 185420 9.790308554285170e-01 -6.083166222235739e+00 -5.980854535508378e+00 3.262830706757951e+00 4.850320244628813e+00 9.158366360164333e+03 + 185440 9.644899540033735e-01 -6.085612805784473e+00 -5.997010327208331e+00 3.265396819775616e+00 4.774165962949071e+00 9.207895153653244e+03 + 185460 9.595211790735395e-01 -6.099162230159524e+00 -5.995133765135066e+00 3.192521501831366e+00 4.789869046354736e+00 9.202124195648081e+03 + 185480 9.641705989162596e-01 -6.120469750298537e+00 -5.981707677350906e+00 3.092436107351236e+00 4.889229403577923e+00 9.160993973580624e+03 + 185500 9.361979487937765e-01 -6.088403576109956e+00 -5.974427249895344e+00 3.250376069799699e+00 4.904845772703480e+00 9.138728744490090e+03 + 185520 9.685598288623074e-01 -6.139115618045952e+00 -5.961941765977130e+00 2.915196824856765e+00 4.932556501000937e+00 9.100587217690441e+03 + 185540 9.582122417985277e-01 -6.116972094700881e+00 -5.966966719430085e+00 3.077979874281680e+00 4.939333952343393e+00 9.115950210604811e+03 + 185560 9.733983643631922e-01 -6.118981325159002e+00 -6.012957018162440e+00 3.048150065063006e+00 4.656958043045748e+00 9.256857880800915e+03 + 185580 9.412085791397626e-01 -6.027808908102295e+00 -6.000822570554435e+00 3.552787795761607e+00 4.707747522083659e+00 9.219597280805348e+03 + 185600 9.811113601609597e-01 -6.017866929374473e+00 -6.042545744235124e+00 3.597044067312204e+00 4.455334493348088e+00 9.348139417772250e+03 + 185620 1.024145655819124e+00 -6.007400260436129e+00 -6.042835241971519e+00 3.664341834895736e+00 4.460868687373857e+00 9.349016620269582e+03 + 185640 1.063840794093235e+00 -6.018519330917581e+00 -6.012007213157973e+00 3.597073391057128e+00 4.634466978979766e+00 9.253964667510121e+03 + 185660 1.026581685469844e+00 -5.933969479774971e+00 -5.992481508558945e+00 4.040962477239463e+00 4.704977353254693e+00 9.193984126981428e+03 + 185680 1.078151080967840e+00 -5.992655917886520e+00 -5.986979780925774e+00 3.783560298904948e+00 4.816153555712910e+00 9.177103476127242e+03 + 185700 1.012130971825542e+00 -5.882931594490105e+00 -6.013634249016426e+00 4.292239944343645e+00 4.541725075883095e+00 9.258908118355834e+03 + 185720 9.767909946811538e-01 -5.825171828036736e+00 -6.006547693383329e+00 4.640697336797187e+00 4.599209050152599e+00 9.237119606001008e+03 + 185740 1.084120904607112e+00 -5.981470273271851e+00 -6.024350912626154e+00 3.859400892447963e+00 4.613173625518058e+00 9.291937297898663e+03 + 185760 1.081393785579987e+00 -5.981996150805671e+00 -6.006353003055173e+00 3.783725934061269e+00 4.643865119233923e+00 9.236558439089140e+03 + 185780 1.124813034765929e+00 -6.058442833141447e+00 -5.983189581098347e+00 3.380410629519436e+00 4.812526448154035e+00 9.165537823858129e+03 + 185800 1.034745720731353e+00 -5.946125334820570e+00 -6.043936881977040e+00 3.980638819572957e+00 4.418989779512501e+00 9.352427662321083e+03 + 185820 1.044281049489139e+00 -5.988543699590392e+00 -6.014818720141438e+00 3.814245162115545e+00 4.663369928065150e+00 9.262590934430564e+03 + 185840 1.021537501661532e+00 -5.987219679051372e+00 -5.976575422126455e+00 3.806070995140578e+00 4.867191965596888e+00 9.145260267061798e+03 + 185860 9.999401436761414e-01 -5.982909246713431e+00 -6.009542378452903e+00 3.775874859141211e+00 4.622943295229352e+00 9.246343592305737e+03 + 185880 1.043905595999872e+00 -6.077546084685965e+00 -5.987082356884550e+00 3.291387540057864e+00 4.810844264310218e+00 9.177447767853082e+03 + 185900 9.221254916929871e-01 -5.924226979417692e+00 -6.003045746445409e+00 4.126475878457343e+00 4.673886321019418e+00 9.226395053732394e+03 + 185920 1.003142468481264e+00 -6.065655957980752e+00 -6.002719487651074e+00 3.358080963099984e+00 4.719471915120299e+00 9.225382551469213e+03 + 185940 9.325162515854724e-01 -5.978590068558076e+00 -6.004099606215238e+00 3.812356579206249e+00 4.665876866390632e+00 9.229643567372221e+03 + 185960 9.547779279896200e-01 -6.023932726469558e+00 -6.002328252904176e+00 3.613630652799420e+00 4.737686883293320e+00 9.224197578226207e+03 + 185980 9.364279765049806e-01 -6.005075485003418e+00 -6.014011648735464e+00 3.627102089421121e+00 4.575789254404842e+00 9.260104292026539e+03 + 186000 9.865751709881700e-01 -6.083643441139275e+00 -5.983158535497191e+00 3.247012879748303e+00 4.824012757934042e+00 9.165410241663300e+03 + 186020 9.427207696479050e-01 -6.018307434186882e+00 -6.006279857670863e+00 3.587256311165426e+00 4.656320516781856e+00 9.236265845155620e+03 + 186040 9.837854615514343e-01 -6.075144496130968e+00 -5.968324389339072e+00 3.284742412421733e+00 4.898119995978906e+00 9.120070573153573e+03 + 186060 9.602199563091689e-01 -6.029319983575497e+00 -5.976634493045383e+00 3.547822769645548e+00 4.850351009322774e+00 9.145460165429358e+03 + 186080 9.549544395468589e-01 -6.003892421567865e+00 -6.024083011042957e+00 3.625430782793619e+00 4.509493293544016e+00 9.291125829755327e+03 + 186100 9.919904880721139e-01 -6.034679456245360e+00 -6.011944343269034e+00 3.451170971533744e+00 4.581719508491172e+00 9.253751568126596e+03 + 186120 8.972386619357468e-01 -5.861138466004364e+00 -6.046779941868154e+00 4.397772912572661e+00 4.331790830237236e+00 9.361167621422921e+03 + 186140 1.066835584741982e+00 -6.067030508037554e+00 -6.032338099561853e+00 3.290081544910571e+00 4.489290723010907e+00 9.316600636879757e+03 + 186160 9.783637312710609e-01 -5.888596946369382e+00 -6.028823207459542e+00 4.305621525064534e+00 4.500420633941063e+00 9.305739031190018e+03 + 186180 1.042790483563403e+00 -5.942272569075919e+00 -6.023978483118418e+00 3.958634925545078e+00 4.489466923163712e+00 9.290787834749568e+03 + 186200 1.047885876719849e+00 -5.917563098587251e+00 -5.985681399832464e+00 4.144601213379666e+00 4.753455386356603e+00 9.173115681237759e+03 + 186220 1.000887291035678e+00 -5.825049353540382e+00 -6.019701041766036e+00 4.649541651768573e+00 4.531821535725464e+00 9.277607950377926e+03 + 186240 1.061490981848287e+00 -5.903515660730037e+00 -6.018624154187203e+00 4.253309539503181e+00 4.592338757090343e+00 9.274302123046917e+03 + 186260 1.146557582356523e+00 -6.028287971776903e+00 -5.958965247321975e+00 3.553992149382973e+00 4.952053960860109e+00 9.091505308628930e+03 + 186280 1.037458403977267e+00 -5.872652618397060e+00 -6.034211026881774e+00 4.378332981570358e+00 4.450639598968214e+00 9.322359569283526e+03 + 186300 1.110129109621654e+00 -5.992888313263420e+00 -6.033266600646734e+00 3.714188219976237e+00 4.482329845301471e+00 9.319467642897034e+03 + 186320 1.063607588190618e+00 -5.943180927052186e+00 -6.003066524320833e+00 4.045426681631403e+00 4.701554314848610e+00 9.226458748310422e+03 + 186340 1.045506402369506e+00 -5.936232483535441e+00 -6.006378292160906e+00 4.086846991418937e+00 4.684058903262717e+00 9.236609427116311e+03 + 186360 1.067402994916683e+00 -5.987891560652560e+00 -6.016828911132722e+00 3.717205343365357e+00 4.551042598867753e+00 9.268773584850434e+03 + 186380 1.053472929130548e+00 -5.988618357818217e+00 -6.023131192000714e+00 3.706777484659305e+00 4.508599449939576e+00 9.288069650329569e+03 + 186400 9.830065344854569e-01 -5.905781254255033e+00 -5.957026333283442e+00 4.199796766398856e+00 4.905539592467382e+00 9.085602875952025e+03 + 186420 9.595621033072821e-01 -5.887535015199235e+00 -5.976975495639305e+00 4.279123074992378e+00 4.765541995435881e+00 9.146510569327142e+03 + 186440 1.035719900536216e+00 -6.015167218031865e+00 -5.975423583250131e+00 3.609349210286989e+00 4.837563311511315e+00 9.141766838661257e+03 + 186460 9.998393929808415e-01 -5.975996020275486e+00 -6.021445448033493e+00 3.789288850236937e+00 4.528311202774247e+00 9.283003308486002e+03 + 186480 1.082397043101837e+00 -6.111189441918532e+00 -6.010575403303888e+00 3.097263974412351e+00 4.675005354109794e+00 9.249538089580845e+03 + 186500 9.950817034112857e-01 -5.997316875789464e+00 -6.023586643805307e+00 3.713062865229156e+00 4.562217792048723e+00 9.289591170245161e+03 + 186520 1.009619855998729e+00 -6.035084393305131e+00 -5.946294614868298e+00 3.534567701818747e+00 5.044412349776844e+00 9.052925172165989e+03 + 186540 9.693801222909489e-01 -5.987728109310411e+00 -5.989307027375220e+00 3.743575926327941e+00 4.734509534463026e+00 9.184255163928450e+03 + 186560 9.345799345196549e-01 -5.943813770576265e+00 -6.010959056391489e+00 3.963827656698701e+00 4.578269034848288e+00 9.250744614154721e+03 + 186580 9.574065195068804e-01 -5.985621766488286e+00 -6.034044525124528e+00 3.712754797016869e+00 4.434703823529889e+00 9.321864755451938e+03 + 186600 9.646403998972567e-01 -6.003353766540596e+00 -5.969652816976503e+00 3.659310599055284e+00 4.852826666657395e+00 9.124124868192084e+03 + 186620 9.770127988971109e-01 -6.022970258492482e+00 -5.962854972042094e+00 3.696003591830399e+00 5.041194869439037e+00 9.103340318892089e+03 + 186640 9.519534543394043e-01 -5.980864029766674e+00 -6.021124692670636e+00 3.805734368637304e+00 4.574551411925306e+00 9.282021382029956e+03 + 186660 1.029049614000655e+00 -6.087394873643568e+00 -6.020275065006955e+00 3.240600326641311e+00 4.626012654589561e+00 9.279407363570144e+03 + 186680 1.019624642311598e+00 -6.064986952548659e+00 -5.951067703081215e+00 3.396916260910121e+00 5.051058220299065e+00 9.067444707889634e+03 + 186700 9.041588446419763e-01 -5.882083051248837e+00 -5.997579727206786e+00 4.358799849192316e+00 4.695600062788930e+00 9.209517016182293e+03 + 186720 1.021929701188076e+00 -6.030548569008134e+00 -5.990225214096194e+00 3.502554471490208e+00 4.734097415413570e+00 9.187023625161817e+03 + 186740 9.768861668306952e-01 -5.921411091960417e+00 -6.037748023118157e+00 4.081206228214217e+00 4.413181566424560e+00 9.333289434801667e+03 + 186760 1.067512680047897e+00 -6.007079235070205e+00 -5.954108807545566e+00 3.749564750103683e+00 5.053729142097326e+00 9.076697789916559e+03 + 186780 1.014121181537407e+00 -5.881393811823530e+00 -5.996031176294835e+00 4.301396006672316e+00 4.643130519803266e+00 9.204874425183545e+03 + 186800 1.090933298500881e+00 -5.957762966761258e+00 -5.990254222274790e+00 3.913056420095945e+00 4.726486602931708e+00 9.187097390014562e+03 + 186820 9.833928280783956e-01 -5.771122398210339e+00 -6.042892756408789e+00 4.936070874108800e+00 4.375523421006293e+00 9.349123028317399e+03 + 186840 1.083989239694932e+00 -5.903765690588592e+00 -6.017055797430192e+00 4.190619270390795e+00 4.540089945318958e+00 9.269474307528131e+03 + 186860 1.085898075353681e+00 -5.902453201779672e+00 -6.009887540254247e+00 4.223775324729869e+00 4.606870727798712e+00 9.247383782881960e+03 + 186880 1.101906524831336e+00 -5.931543848688380e+00 -5.962283109389383e+00 4.057245787581426e+00 4.880736195751050e+00 9.101611454362455e+03 + 186900 1.117335723091285e+00 -5.967225375525144e+00 -6.028180493466218e+00 3.872265447178839e+00 4.522251727187176e+00 9.303720340083395e+03 + 186920 1.036011632449771e+00 -5.871159638062257e+00 -6.017383086341606e+00 4.384019082108074e+00 4.544381414082557e+00 9.270486319023559e+03 + 186940 1.011605186859108e+00 -5.866688562059066e+00 -6.041452891575094e+00 4.372887218119118e+00 4.369363393345499e+00 9.344726607624290e+03 + 186960 9.932792895410691e-01 -5.875546808667986e+00 -6.014474168768420e+00 4.316787409158877e+00 4.519045008522687e+00 9.261522397652219e+03 + 186980 1.072248401742994e+00 -6.028800496955707e+00 -5.968815116695609e+00 3.530114617350662e+00 4.874559953511742e+00 9.121548313682042e+03 + 187000 1.011966192968974e+00 -5.971156466508948e+00 -5.985838195380230e+00 3.876873700984139e+00 4.792568941815036e+00 9.173612608044572e+03 + 187020 1.039765020363477e+00 -6.040232487694320e+00 -6.012345989496141e+00 3.454926679996300e+00 4.615055268071895e+00 9.254991713938534e+03 + 187040 1.005572094719602e+00 -6.010814244919445e+00 -6.000825974920766e+00 3.646433555790930e+00 4.703787747803130e+00 9.219560178906941e+03 + 187060 1.027318122452260e+00 -6.058598133194166e+00 -5.994787486236991e+00 3.367513733928683e+00 4.733924343422483e+00 9.201055861384892e+03 + 187080 1.037636337263683e+00 -6.085247372639406e+00 -6.003637593687760e+00 3.242396334279341e+00 4.711012314092171e+00 9.228238795365502e+03 + 187100 9.860793923139735e-01 -6.020183555882539e+00 -6.013621858107854e+00 3.561151233083503e+00 4.598829517125194e+00 9.258924932056028e+03 + 187120 9.110852161589589e-01 -5.917199110797673e+00 -6.009768719825155e+00 4.136490803177767e+00 4.604941783041263e+00 9.247063899018602e+03 + 187140 9.732490339970734e-01 -6.012117080032494e+00 -5.977531137367938e+00 3.661289012736984e+00 4.859886847674198e+00 9.148189712350179e+03 + 187160 9.870372515747904e-01 -6.031421483692184e+00 -5.964185839468122e+00 3.546045895568166e+00 4.932123369385046e+00 9.107434982568118e+03 + 187180 9.912988424946013e-01 -6.034505761136522e+00 -5.973235622258882e+00 3.504830927381230e+00 4.856653546339988e+00 9.135077423023960e+03 + 187200 1.031667514101677e+00 -6.089478396434104e+00 -5.963553439324839e+00 3.249402215056004e+00 4.972482805601540e+00 9.105499043335980e+03 + 187220 9.573835424832821e-01 -5.971448722060335e+00 -6.014905219036551e+00 3.820355840563944e+00 4.570821910055333e+00 9.262870080507235e+03 + 187240 1.021656708233916e+00 -6.057277236057662e+00 -5.993418647247994e+00 3.383137760118035e+00 4.749823659147834e+00 9.196856900038920e+03 + 187260 9.754887916764853e-01 -5.979228358835576e+00 -5.975370131636208e+00 3.809010006779916e+00 4.831164544417415e+00 9.141577336708622e+03 + 187280 9.527498982396159e-01 -5.933574700201921e+00 -5.950782987620823e+00 3.998782923985383e+00 4.899970274652174e+00 9.066556164188725e+03 + 187300 9.445417970818046e-01 -5.902634024657086e+00 -5.970801854428159e+00 4.238535800504369e+00 4.847105573021305e+00 9.127563644477821e+03 + 187320 9.978672047197774e-01 -5.950808355941462e+00 -5.956363590649250e+00 3.957987403677119e+00 4.926088386315201e+00 9.083569923978896e+03 + 187340 1.076836346408877e+00 -6.027610535353595e+00 -6.000401720815070e+00 3.571727905376628e+00 4.727965129007282e+00 9.218286662444410e+03 + 187360 1.090244844189440e+00 -6.005463239722641e+00 -6.019504969334273e+00 3.624339352934656e+00 4.543709568554031e+00 9.277016853933561e+03 + 187380 1.040498882089004e+00 -5.891559984850800e+00 -6.003302845040398e+00 4.251907124732083e+00 4.610262329371682e+00 9.227151285137801e+03 + 187400 1.049641461597717e+00 -5.870926987498423e+00 -5.988825714065054e+00 4.370427273343706e+00 4.693434540629139e+00 9.182725768316694e+03 + 187420 1.125020089897373e+00 -5.952512833337888e+00 -6.019943030788504e+00 3.895773979707287e+00 4.508579351156516e+00 9.278361904098769e+03 + 187440 1.067805839287663e+00 -5.850083871159086e+00 -6.017281724455709e+00 4.491402821524456e+00 4.531326874111066e+00 9.270153158912106e+03 + 187460 1.089674223704599e+00 -5.876976802426681e+00 -6.009177646336478e+00 4.273355924639009e+00 4.514238220894477e+00 9.245210483686344e+03 + 187480 1.112305888169971e+00 -5.914301687524146e+00 -5.998094040410418e+00 4.129991973799774e+00 4.648843316702097e+00 9.211170210729930e+03 + 187500 1.095721476502235e+00 -5.904733067809425e+00 -6.014314002599639e+00 4.175555981661386e+00 4.546325296501120e+00 9.261038343666196e+03 + 187520 1.129890490086196e+00 -5.985158948121041e+00 -6.018572162935287e+00 3.712274565503034e+00 4.520410715361352e+00 9.274129396237866e+03 + 187540 9.713323595519057e-01 -5.792670124267233e+00 -6.059852377916348e+00 4.752023168645737e+00 4.217821321872390e+00 9.401693466788025e+03 + 187560 1.046146708918315e+00 -5.954496709839717e+00 -6.014949240579383e+00 3.956801427131057e+00 4.609673640625001e+00 9.262995384303777e+03 + 187580 1.053583522000687e+00 -6.015921950287440e+00 -6.017044257255536e+00 3.566301632396450e+00 4.559857172109199e+00 9.269461359975287e+03 + 187600 1.021111357887142e+00 -6.004015822435168e+00 -6.005189132504156e+00 3.664692367086573e+00 4.657955039101298e+00 9.233009366767739e+03 + 187620 1.070091147484666e+00 -6.099367418185931e+00 -5.986219531096507e+00 3.133293283131405e+00 4.783005960377816e+00 9.174814143606427e+03 + 187640 9.909494916969200e-01 -5.994189900450438e+00 -6.029776856824252e+00 3.701225719268508e+00 4.496879908706365e+00 9.308695457981990e+03 + 187660 1.006741660425191e+00 -6.025106736568172e+00 -6.007615974835820e+00 3.621173277714114e+00 4.721607938267912e+00 9.240434687102166e+03 + 187680 1.017673701299515e+00 -6.046984416653858e+00 -5.995779832866852e+00 3.420074151784442e+00 4.714098795773165e+00 9.204111196784930e+03 + 187700 9.978196421165930e-01 -6.021642328271223e+00 -6.019090640372303e+00 3.610509981786508e+00 4.625162168574533e+00 9.275732044164977e+03 + 187720 1.028863666277457e+00 -6.071626007418413e+00 -6.021578553580339e+00 3.318715368015426e+00 4.606095592772097e+00 9.283413459940875e+03 + 187740 1.000614264642976e+00 -6.033642092805144e+00 -6.000245456550781e+00 3.537974460191829e+00 4.729743113677142e+00 9.217813968424962e+03 + 187760 9.829999690184826e-01 -6.011413776387128e+00 -6.007798248161731e+00 3.668298778762758e+00 4.689059701334169e+00 9.240999723086245e+03 + 187780 1.020726485952122e+00 -6.069845682520405e+00 -5.999777585014566e+00 3.337229267269158e+00 4.739571126150735e+00 9.216371149257280e+03 + 187800 1.038997182307271e+00 -6.099087884049345e+00 -5.956045643754971e+00 3.224087165003675e+00 5.045457844489114e+00 9.082608084828631e+03 + 187820 9.122305606748948e-01 -5.912466780827520e+00 -5.996536551127279e+00 4.155056953916227e+00 4.672315323100105e+00 9.206402011509692e+03 + 187840 9.461805597296103e-01 -5.959396003073463e+00 -6.038458796807508e+00 3.904998805095451e+00 4.451008008546774e+00 9.335481548661934e+03 + 187860 9.915293822254819e-01 -6.019628496480236e+00 -5.994377644605236e+00 3.650430511535238e+00 4.795424810558187e+00 9.199799963553427e+03 + 187880 9.832554234456775e-01 -5.998077622735107e+00 -6.005493951167119e+00 3.699826677510083e+00 4.657240971980358e+00 9.233920515183372e+03 + 187900 1.055953890645090e+00 -6.094755055561174e+00 -5.995364848382829e+00 3.186801038456484e+00 4.757514988659388e+00 9.202838445921037e+03 + 187920 9.609044700569084e-01 -5.942456359699412e+00 -6.054879862756176e+00 3.972838063239229e+00 4.327284911206422e+00 9.386288001584593e+03 + 187940 1.018681371116864e+00 -6.016587888617467e+00 -6.004937732461141e+00 3.602895924228079e+00 4.669792923733548e+00 9.232204175275132e+03 + 187960 9.665492455221173e-01 -5.924986308865441e+00 -6.004634178897405e+00 4.082828769594828e+00 4.625478374403241e+00 9.231286375574929e+03 + 187980 9.893054303827753e-01 -5.944663252691586e+00 -6.028586165402113e+00 3.988329814357630e+00 4.506431462545017e+00 9.305011393009770e+03 + 188000 9.792544115739478e-01 -5.914243564331886e+00 -6.050182372081820e+00 4.152698011195435e+00 4.372116340632805e+00 9.371715032028504e+03 + 188020 1.029651373912197e+00 -5.972093357999048e+00 -5.999300220129203e+00 3.844551505045167e+00 4.688325492445512e+00 9.214906959499589e+03 + 188040 1.017456422741918e+00 -5.936510671602509e+00 -6.034720020257022e+00 4.087595417516251e+00 4.523662139694450e+00 9.323945883094200e+03 + 188060 9.825377821298039e-01 -5.870637537406160e+00 -6.093722652996654e+00 4.374778401293991e+00 4.093789145263307e+00 9.506995161626894e+03 + 188080 1.064334368842517e+00 -5.983122279282391e+00 -6.007828465717056e+00 3.796870242269896e+00 4.655003496492053e+00 9.241105225799130e+03 + 188100 1.022599810293121e+00 -5.913530087727156e+00 -6.070486852643192e+00 4.160774861383462e+00 4.259504828254713e+00 9.434700815271164e+03 + 188120 1.011364139325243e+00 -5.895194394958018e+00 -6.091208593350279e+00 4.263710175740153e+00 4.138166315472625e+00 9.499156560451122e+03 + 188140 1.035986457190639e+00 -5.939148350760794e+00 -6.022824946553668e+00 4.060715235314700e+00 4.580231273360666e+00 9.287240281002692e+03 + 188160 1.045634256673235e+00 -5.967726891733440e+00 -6.018384906629809e+00 3.869850429187999e+00 4.578964268350578e+00 9.273556946221332e+03 + 188180 9.867575747186296e-01 -5.903766984687859e+00 -6.002685766745776e+00 4.253902426390906e+00 4.685895472182296e+00 9.225282447247666e+03 + 188200 1.050746278721140e+00 -6.030881626775353e+00 -5.978800259456347e+00 3.559816170838876e+00 4.858875441550157e+00 9.152085906821534e+03 + 188220 9.725027936816462e-01 -5.951555416159512e+00 -6.028179832536782e+00 3.946283918626283e+00 4.506294662197886e+00 9.303766564423093e+03 + 188240 1.000239492131249e+00 -6.032988992385877e+00 -5.997386912918585e+00 3.519416843697121e+00 4.723849493402303e+00 9.209032401599914e+03 + 188260 1.022737901850711e+00 -6.101899028332215e+00 -6.006997838851309e+00 3.161837684257663e+00 4.706775000168636e+00 9.238554898411308e+03 + 188280 9.479811796270937e-01 -6.023450353208957e+00 -6.033923741626424e+00 3.604335164987508e+00 4.544195347942795e+00 9.321503658884072e+03 + 188300 9.653452324571075e-01 -6.075181232634119e+00 -5.994615544213258e+00 3.276254252974332e+00 4.738874903386904e+00 9.200540852924523e+03 + 188320 8.881585587407771e-01 -5.977389865899354e+00 -6.003355900306247e+00 3.849267239980338e+00 4.700166252185115e+00 9.227313275406934e+03 + 188340 9.408629267719103e-01 -6.060716093660590e+00 -5.954507138504253e+00 3.352105621085954e+00 4.961973877376330e+00 9.077930164186813e+03 + 188360 9.409613946392548e-01 -6.058191936322547e+00 -6.014096242716897e+00 3.337654194552734e+00 4.590858491022910e+00 9.260381861850979e+03 + 188380 9.734435623812695e-01 -6.100494463464449e+00 -5.969764332682729e+00 3.136970043624076e+00 4.887642684995071e+00 9.124484824421152e+03 + 188400 9.442103763174035e-01 -6.046143825472029e+00 -5.961096844866542e+00 3.507447214833078e+00 4.995800138447498e+00 9.098015439363558e+03 + 188420 9.483521326352081e-01 -6.036413556328778e+00 -5.967879601499162e+00 3.569766671476529e+00 4.963299245703418e+00 9.118709643967435e+03 + 188440 9.841408056194197e-01 -6.068617181120462e+00 -5.981408699872695e+00 3.331478112781652e+00 4.832242707575189e+00 9.160056870412112e+03 + 188460 1.038590149147225e+00 -6.124352440514215e+00 -5.969146883323125e+00 3.064320780650116e+00 4.955535108023708e+00 9.122576868596447e+03 + 188480 9.106374012218605e-01 -5.908724267090371e+00 -6.040524522322999e+00 4.155045750296466e+00 4.398228288727134e+00 9.341837815494860e+03 + 188500 1.006635619529266e+00 -6.027058562019530e+00 -5.996226067974712e+00 3.511308369489478e+00 4.688353321607856e+00 9.205456392409846e+03 + 188520 9.108984356651380e-01 -5.861353833954616e+00 -6.039395671724597e+00 4.382717005822665e+00 4.360373221462084e+00 9.338373555236849e+03 + 188540 9.793185955220237e-01 -5.943514094580059e+00 -5.996912204570042e+00 4.019310960163216e+00 4.712690749269920e+00 9.207562338657846e+03 + 188560 1.059285450156670e+00 -6.045253578178310e+00 -5.998463419504421e+00 3.530201206582955e+00 4.798877538442083e+00 9.212328354552690e+03 + 188580 9.780019189614730e-01 -5.915968498335595e+00 -6.040679745793125e+00 4.133956064696723e+00 4.417844782792415e+00 9.342365564928979e+03 + 188600 1.052717421625437e+00 -6.024709778093428e+00 -6.019137569302348e+00 3.596177237134250e+00 4.628173722309148e+00 9.275889673630018e+03 + 188620 1.090041687140318e+00 -6.081820338402635e+00 -5.980465020361054e+00 3.252599468875911e+00 4.834597389755450e+00 9.157172783157814e+03 + 188640 1.037101260134824e+00 -6.006091602089427e+00 -5.962612465047537e+00 3.621206253184516e+00 4.870870186453761e+00 9.102641859686839e+03 + 188660 1.007964017711743e+00 -5.965309992394196e+00 -5.963488882369886e+00 3.871596510521200e+00 4.882053606096650e+00 9.105291860010650e+03 + 188680 9.997004798608997e-01 -5.954990602194666e+00 -6.001224574187162e+00 3.944446177626584e+00 4.678963555761630e+00 9.220797290901015e+03 + 188700 1.052730405028764e+00 -6.037688539638236e+00 -5.980782124974112e+00 3.535565208126762e+00 4.862330647367372e+00 9.158141109825800e+03 + 188720 9.799635287365537e-01 -5.935272560842371e+00 -6.002376441223687e+00 4.085393607160711e+00 4.700072741719265e+00 9.224335995946813e+03 + 188740 1.003504895610224e+00 -5.976604720684354e+00 -6.013732271241614e+00 3.838236497368292e+00 4.625044356598627e+00 9.259257770084329e+03 + 188760 9.773936762911285e-01 -5.945836137439832e+00 -6.023110368797303e+00 3.985436457174665e+00 4.541715862571411e+00 9.288111579750539e+03 + 188780 1.001361067034065e+00 -5.990798817172465e+00 -5.968663379494609e+00 3.688151166429103e+00 4.815256275023261e+00 9.121067185415508e+03 + 188800 1.004105895272921e+00 -6.001541494445028e+00 -5.981247428493603e+00 3.654164139792173e+00 4.770695806981811e+00 9.159555254690806e+03 + 188820 9.551214596720535e-01 -5.933996559837165e+00 -5.985728631550634e+00 4.041137056368591e+00 4.744083495077623e+00 9.173281192349514e+03 + 188840 1.001067697203345e+00 -6.007374567236664e+00 -6.019782418702512e+00 3.636730003547913e+00 4.565482200322206e+00 9.277847126910137e+03 + 188860 9.173470194606513e-01 -5.887818901328602e+00 -6.052003803059247e+00 4.287322513737160e+00 4.344547400468373e+00 9.377373415329708e+03 + 188880 1.078370357194244e+00 -6.132536769291884e+00 -6.002229388985913e+00 3.018919036710302e+00 4.767164179429122e+00 9.223921261571682e+03 + 188900 1.007755551233746e+00 -6.039333959773012e+00 -6.034413467656064e+00 3.413279354129003e+00 4.441533581308217e+00 9.323022107632230e+03 + 188920 1.091857928185486e+00 -6.182942496275771e+00 -5.964344883000384e+00 2.765879128287330e+00 5.021100451585927e+00 9.107935742804970e+03 + 188940 9.234267420491796e-01 -5.959100041556242e+00 -6.021597311595134e+00 3.882678572252410e+00 4.523809576267809e+00 9.283459071229830e+03 + 188960 9.657424196704705e-01 -6.052577759038441e+00 -5.946749137271805e+00 3.386876792910526e+00 4.994561116020842e+00 9.054298778876513e+03 + 188980 9.320610789565064e-01 -6.030826180788404e+00 -5.934559086855344e+00 3.509257140923759e+00 5.062037691572026e+00 9.017241093081047e+03 + 189000 8.672804574472469e-01 -5.956794080713724e+00 -6.004995950372959e+00 3.896357997259608e+00 4.619575402461058e+00 9.232376709842252e+03 + 189020 9.544869406151526e-01 -6.101850760774086e+00 -5.969304168787883e+00 3.168868641412536e+00 4.929971684116140e+00 9.123067999327202e+03 + 189040 9.739095755578714e-01 -6.141351321602954e+00 -5.975188769564815e+00 2.947132772202851e+00 4.901263859577673e+00 9.141040584173928e+03 + 189060 9.375815953801838e-01 -6.093446265786305e+00 -5.988100835648619e+00 3.178469935724336e+00 4.783379697727558e+00 9.180590216633966e+03 + 189080 9.450438942663600e-01 -6.104144767541471e+00 -5.975224899152375e+00 3.179917557473389e+00 4.920195392048740e+00 9.141155802861516e+03 + 189100 9.242465210845818e-01 -6.064784573567142e+00 -5.983392453232580e+00 3.338643537153801e+00 4.806009687504773e+00 9.166141883930759e+03 + 189120 9.371846001243667e-01 -6.065783778769316e+00 -5.981311024237955e+00 3.379362749454327e+00 4.864418378089920e+00 9.159762544255416e+03 + 189140 9.209652503509672e-01 -6.011634946921604e+00 -6.005729670851983e+00 3.644654323237719e+00 4.678563332268004e+00 9.234656887785408e+03 + 189160 9.938091577818602e-01 -6.077573012428418e+00 -6.036954294565664e+00 3.218611586939800e+00 4.451850550634008e+00 9.330851421968919e+03 + 189180 9.672589397674841e-01 -5.994579517237863e+00 -6.006381423294198e+00 3.719959145864531e+00 4.652190774949997e+00 9.236666199376017e+03 + 189200 1.015013515586272e+00 -6.026247846630299e+00 -5.998741722911931e+00 3.588155438434998e+00 4.746099857384755e+00 9.213182032025512e+03 + 189220 1.034144720611114e+00 -6.023254463983983e+00 -5.990529642229261e+00 3.584405443769672e+00 4.772316434435085e+00 9.187977786805335e+03 + 189240 1.044016364993099e+00 -6.013568381301496e+00 -5.998151979182812e+00 3.582189349730727e+00 4.670712716376726e+00 9.211389704008836e+03 + 189260 1.027498641841579e+00 -5.973576836432010e+00 -6.000872124529335e+00 3.865112614062334e+00 4.708378845875316e+00 9.219727352639014e+03 + 189280 1.038165707553652e+00 -5.980059684325155e+00 -5.983450501185790e+00 3.824455100333259e+00 4.804984505192282e+00 9.166304242453652e+03 + 189300 1.060858683028968e+00 -6.007331906008186e+00 -6.001198467115297e+00 3.668771919796146e+00 4.703991075065717e+00 9.220724062543997e+03 + 189320 9.929866358021024e-01 -5.905388812080290e+00 -6.006286999381382e+00 4.201531940854392e+00 4.622158935427497e+00 9.236355090529003e+03 + 189340 9.779280124576570e-01 -5.886599608094234e+00 -5.966538972058198e+00 4.328713869572582e+00 4.869689671114905e+00 9.114585231217832e+03 + 189360 1.036748673736210e+00 -5.976159061171371e+00 -5.976482595594208e+00 3.772184889230258e+00 4.770327104507537e+00 9.144966098491788e+03 + 189380 1.014240702014481e+00 -5.946888485207029e+00 -5.987092747451317e+00 4.019220492380313e+00 4.788361396984132e+00 9.177432605723970e+03 + 189400 1.014071203209337e+00 -5.954188406278993e+00 -5.993949936891656e+00 3.979600085840912e+00 4.751283223986021e+00 9.198458090212796e+03 + 189420 1.004186178058447e+00 -5.947765252829197e+00 -6.026572481098816e+00 3.930653375761982e+00 4.478130075658668e+00 9.298783190064281e+03 + 189440 1.091264643642990e+00 -6.088427591831430e+00 -5.969051017029226e+00 3.239478719675504e+00 4.924957485655007e+00 9.122286778126359e+03 + 189460 9.709705637157013e-01 -5.926091046621782e+00 -6.010543348663234e+00 4.115862056481033e+00 4.630923869207508e+00 9.249419038964639e+03 + 189480 1.009896260383370e+00 -6.004664916548604e+00 -5.998424249538518e+00 3.689035950212216e+00 4.724870825924229e+00 9.212202145946354e+03 + 189500 9.847105927014280e-01 -5.992514580038136e+00 -6.015984724161422e+00 3.705086960700759e+00 4.570317761151784e+00 9.266193162091187e+03 + 189520 9.891008818229059e-01 -6.029893479565382e+00 -5.986498378612109e+00 3.546983882860181e+00 4.796165267904048e+00 9.175668118022691e+03 + 189540 9.700387811560235e-01 -6.038141472481678e+00 -6.014729839379546e+00 3.461439564291220e+00 4.595872784502175e+00 9.262329736949519e+03 + 189560 9.187065739797919e-01 -6.000114755271084e+00 -5.975652520992858e+00 3.752511408976021e+00 4.892977343720114e+00 9.142454782615670e+03 + 189580 9.826372192171458e-01 -6.129661460813762e+00 -5.984035006265776e+00 2.982062210166316e+00 4.818271847801863e+00 9.168129969672213e+03 + 189600 9.256146485600103e-01 -6.076517738924355e+00 -6.004892021139657e+00 3.303604193141366e+00 4.714890148705102e+00 9.232094978472824e+03 + 189620 9.125610129429221e-01 -6.082255193986525e+00 -5.977072859807848e+00 3.247302359865775e+00 4.851275599633352e+00 9.146805748445950e+03 + 189640 8.956321091981019e-01 -6.070589951173189e+00 -5.955925371539328e+00 3.413342066310738e+00 5.071763826854722e+00 9.082230540484694e+03 + 189660 1.011626863101136e+00 -6.244756785893398e+00 -5.963892725008185e+00 2.402831381742082e+00 5.015596282917930e+00 9.106578068341967e+03 + 189680 9.355513694653862e-01 -6.127754247264849e+00 -5.999202091960938e+00 3.022687466500769e+00 4.760853835637569e+00 9.214622528801197e+03 + 189700 9.116328353524825e-01 -6.080440598541761e+00 -5.970227126018383e+00 3.263762564864783e+00 4.896625379573775e+00 9.125866264698730e+03 + 189720 8.826480550729751e-01 -6.015484970350329e+00 -5.993517199781119e+00 3.648804181694583e+00 4.774946519804496e+00 9.197142992368988e+03 + 189740 9.591745498985730e-01 -6.093180245780527e+00 -5.982743710118360e+00 3.232878680787813e+00 4.867022358558636e+00 9.164161858991709e+03 + 189760 9.516012715418856e-01 -6.038374032812517e+00 -6.001802737489411e+00 3.525260468117910e+00 4.735258505252848e+00 9.222572685277664e+03 + 189780 1.007024119564611e+00 -6.076674968945555e+00 -5.989996694089540e+00 3.287398853403228e+00 4.785118921046154e+00 9.186376447344481e+03 + 189800 9.323509455336298e-01 -5.931312243791061e+00 -5.997625811601975e+00 4.079233020266152e+00 4.698450251904434e+00 9.209749263639487e+03 + 189820 9.582523924494802e-01 -5.948209692361762e+00 -5.963848691931989e+00 4.020767323665949e+00 4.930965768006344e+00 9.106397951159039e+03 + 189840 1.021652401074239e+00 -6.028723744040034e+00 -5.987189510197891e+00 3.573624979731654e+00 4.812120977855159e+00 9.177763907077340e+03 + 189860 1.047239867341324e+00 -6.059002912372088e+00 -5.974745568788780e+00 3.420505748026585e+00 4.904324453663717e+00 9.139692409629180e+03 + 189880 1.023213751124093e+00 -6.019124349089250e+00 -5.975346613796274e+00 3.634352361653716e+00 4.885730892288623e+00 9.141529456263195e+03 + 189900 1.003307969230358e+00 -5.986316835824987e+00 -5.996202416849924e+00 3.761629053792192e+00 4.704864517758287e+00 9.205414467201637e+03 + 189920 1.036233114266616e+00 -6.031416955781196e+00 -6.022099011223807e+00 3.560788018573433e+00 4.614293098169222e+00 9.285020308674813e+03 + 189940 1.003952441829978e+00 -5.982188284031203e+00 -6.030606660864757e+00 3.768991069900208e+00 4.490965257402339e+00 9.311264432146792e+03 + 189960 1.036263077993498e+00 -6.032585408715040e+00 -5.993729452474438e+00 3.558960630982596e+00 4.782077544655929e+00 9.197817041367318e+03 + 189980 1.059259280515890e+00 -6.069641564287687e+00 -5.981315179867200e+00 3.329379502087259e+00 4.836563269893511e+00 9.159794923374971e+03 + 190000 1.002000343812157e+00 -5.988410060782896e+00 -5.988560886335374e+00 3.821622855285393e+00 4.820756791622890e+00 9.181959014582308e+03 + 190020 1.041702268620511e+00 -6.053007634060574e+00 -5.982211360530052e+00 3.446027445315846e+00 4.852550603616023e+00 9.162516727011876e+03 + 190040 9.823300423336282e-01 -5.972388292651483e+00 -5.982700433335363e+00 3.864348655866578e+00 4.805134748261128e+00 9.164035314345982e+03 + 190060 9.566651526499863e-01 -5.939933337160141e+00 -6.035210143955053e+00 4.012826209314950e+00 4.465732040660362e+00 9.325448452588407e+03 + 190080 9.576092041552912e-01 -5.947598374514730e+00 -6.061384005582275e+00 3.954643515810290e+00 4.301268813950942e+00 9.406444480677808e+03 + 190100 1.040261073260992e+00 -6.078855061919229e+00 -5.972103295831728e+00 3.298194736413429e+00 4.911179897070275e+00 9.131608395828671e+03 + 190120 1.006710923122538e+00 -6.037657615603883e+00 -5.979278012384514e+00 3.528344376282516e+00 4.863569092182531e+00 9.153535480878607e+03 + 190140 9.560250694306736e-01 -5.971512581133732e+00 -5.994555242512783e+00 3.857351086743968e+00 4.725036559265135e+00 9.200338223595281e+03 + 190160 9.747167472025371e-01 -6.006615582876423e+00 -5.969039848794996e+00 3.734865257294858e+00 4.950630937216466e+00 9.122235167308296e+03 + 190180 9.581189011083978e-01 -5.986897061364489e+00 -5.971111668974573e+00 3.833050840704989e+00 4.923693006589466e+00 9.128558407696410e+03 + 190200 9.865637571576783e-01 -6.031819088796250e+00 -5.978777671488865e+00 3.596572180254893e+00 4.901144206566699e+00 9.151992193348762e+03 + 190220 9.763796951015768e-01 -6.015686077699007e+00 -6.001006895103124e+00 3.583722779822932e+00 4.668012917884655e+00 9.220148322282585e+03 + 190240 9.631005264470269e-01 -5.993041403880172e+00 -6.005058197746798e+00 3.720348634107060e+00 4.651346344132048e+00 9.232584987399505e+03 + 190260 9.545734508626229e-01 -5.975814402477456e+00 -6.019814642996149e+00 3.815481933965266e+00 4.562825743891720e+00 9.277959982329210e+03 + 190280 9.815805038027789e-01 -6.007846082357604e+00 -6.018213133871492e+00 3.678554965895673e+00 4.619025751806893e+00 9.273033224732862e+03 + 190300 9.896107273989241e-01 -6.004852267900675e+00 -6.023840343848775e+00 3.667413842213147e+00 4.558381371723900e+00 9.290382719510642e+03 + 190320 1.070697843779483e+00 -6.108023296021521e+00 -6.008664100441186e+00 3.077492013531892e+00 4.648027890340003e+00 9.243668900167826e+03 + 190340 1.016689062457228e+00 -6.010679130767457e+00 -5.971487280930207e+00 3.714785121925001e+00 4.939830788609655e+00 9.129728015999715e+03 + 190360 1.004649412357485e+00 -5.971897282616390e+00 -6.004404541407405e+00 3.863483434306393e+00 4.676821723846345e+00 9.230589399117905e+03 + 190380 1.018563188091038e+00 -5.967117242327284e+00 -6.026446639889587e+00 3.819751294128822e+00 4.479072712131480e+00 9.298403960740767e+03 + 190400 1.042705343183053e+00 -5.977241676309036e+00 -5.993757284225943e+00 3.840443127557852e+00 4.745607951116907e+00 9.197892816674586e+03 + 190420 1.014070933629324e+00 -5.910056236345643e+00 -6.073111191459941e+00 4.124275405175911e+00 4.187988620236853e+00 9.442848327005117e+03 + 190440 1.110322036690122e+00 -6.033805788266423e+00 -6.002826506766937e+00 3.495303911296413e+00 4.673191739694779e+00 9.225742758261154e+03 + 190460 1.045646065068417e+00 -5.923128427943123e+00 -6.026094333398999e+00 4.118181628451645e+00 4.526935465401633e+00 9.297318712759305e+03 + 190480 9.978241201854654e-01 -5.845424973672015e+00 -6.023864469268741e+00 4.523314735764464e+00 4.498687538625364e+00 9.290439633606158e+03 + 190500 1.058826773083271e+00 -5.931256335567634e+00 -6.035162004841672e+00 4.055344687374828e+00 4.458702255052947e+00 9.325296385255930e+03 + 190520 1.041653626735848e+00 -5.909217065334498e+00 -6.032417881760611e+00 4.239182197603425e+00 4.531744044419956e+00 9.316828890195045e+03 + 190540 1.066274924649685e+00 -5.957559356974743e+00 -6.012116899159263e+00 3.969358989988431e+00 4.656081140012544e+00 9.254269392373943e+03 + 190560 1.106622883495302e+00 -6.041470793916690e+00 -6.011150524388858e+00 3.481798014044122e+00 4.655901693719480e+00 9.251311010591506e+03 + 190580 1.038954503655643e+00 -5.978408599467051e+00 -6.036675873368168e+00 3.847486327282831e+00 4.512906623711122e+00 9.329967479692195e+03 + 190600 1.060154066116299e+00 -6.060854626762197e+00 -5.980382831050607e+00 3.350677073572117e+00 4.812758577518211e+00 9.156936656578242e+03 + 190620 9.512076578601641e-01 -5.946932570149857e+00 -5.963349828673189e+00 3.990004879742953e+00 4.895734440739433e+00 9.104855847940189e+03 + 190640 9.493197679997870e-01 -5.980503164294089e+00 -5.974501127406373e+00 3.792738711558295e+00 4.827203336179769e+00 9.138903335761162e+03 + 190660 9.663279165366178e-01 -6.030487528394742e+00 -5.984229411321823e+00 3.573544036669124e+00 4.839165303322308e+00 9.168701933426415e+03 + 190680 9.544780462033906e-01 -6.028360135481010e+00 -6.050009605457242e+00 3.498469334480327e+00 4.374154727632152e+00 9.371235920797439e+03 + 190700 9.599815635012572e-01 -6.048235279745158e+00 -6.015650892435908e+00 3.465837537821318e+00 4.652942132168668e+00 9.265174428458482e+03 + 190720 9.741658849007470e-01 -6.076243019262829e+00 -5.975104026718848e+00 3.314844308433392e+00 4.895600054829453e+00 9.140804607508078e+03 + 190740 9.209044396640363e-01 -5.997482234273251e+00 -5.990893621421936e+00 3.734592484163027e+00 4.772425318739822e+00 9.189107540833946e+03 + 190760 9.167679485284640e-01 -5.986432497301693e+00 -6.010098725024983e+00 3.800892732716176e+00 4.664997590792141e+00 9.248020649270115e+03 + 190780 1.024247423660809e+00 -6.136913795728070e+00 -5.965610036696949e+00 3.038006391389240e+00 5.021659084916973e+00 9.111718345354451e+03 + 190800 9.402516168482492e-01 -5.998624698274003e+00 -5.968988415371907e+00 3.790472475072030e+00 4.960648597695817e+00 9.122077679742873e+03 + 190820 9.479366002874461e-01 -5.991477976202970e+00 -5.998311635433904e+00 3.759490779648969e+00 4.720250850839600e+00 9.211851968453526e+03 + 190840 1.047796139977899e+00 -6.117613017216276e+00 -5.970833218386895e+00 3.126260146764354e+00 4.969092465743120e+00 9.127739986782561e+03 + 190860 1.066115415116186e+00 -6.121010936658070e+00 -6.021118025542735e+00 3.007060135258536e+00 4.580660689260828e+00 9.282011213171299e+03 + 190880 1.025113190400180e+00 -6.040131149350029e+00 -5.988530196853709e+00 3.486136411487577e+00 4.782437065943038e+00 9.181889814338312e+03 + 190900 1.020948912948637e+00 -6.015557544170445e+00 -5.963786311029964e+00 3.651157798120269e+00 4.948436230385346e+00 9.106206474593115e+03 + 190920 1.020886268970268e+00 -5.995928391909649e+00 -5.984760933877678e+00 3.756726850328695e+00 4.820852122506817e+00 9.170314783122525e+03 + 190940 1.012431235554254e+00 -5.963671813796256e+00 -6.039918927798000e+00 3.880969125489838e+00 4.443146397689065e+00 9.340007683742455e+03 + 190960 1.097645444753711e+00 -6.076383825086185e+00 -5.997568870460207e+00 3.295883829905931e+00 4.748451495943105e+00 9.209584439368147e+03 + 190980 1.010259804318700e+00 -5.938031973335732e+00 -6.002427722414703e+00 4.045724472038551e+00 4.675954115617135e+00 9.224481272665093e+03 + 191000 1.018704041858450e+00 -5.942327428571978e+00 -5.998376034055347e+00 4.037026208890730e+00 4.715186442711558e+00 9.212062380653251e+03 + 191020 1.073936169087454e+00 -6.018112277676075e+00 -6.002650345017425e+00 3.583925685473588e+00 4.672710495525903e+00 9.225208030569225e+03 + 191040 1.003168606148687e+00 -5.912507101982788e+00 -6.068142384992453e+00 4.157610749362245e+00 4.263928869838541e+00 9.427417313987655e+03 + 191060 9.586184551214803e-01 -5.854148189669719e+00 -6.043914933272790e+00 4.502861109211237e+00 4.413191101133735e+00 9.352337817204163e+03 + 191080 1.028232595182057e+00 -5.974894903632490e+00 -5.977387184024499e+00 3.901984454413006e+00 4.887673394722947e+00 9.147728088548018e+03 + 191100 1.013235484032532e+00 -5.984500477419813e+00 -6.007576320011090e+00 3.763061885800089e+00 4.630556826665875e+00 9.240309812252091e+03 + 191120 9.521529224436910e-01 -5.946570268397061e+00 -5.970743734958461e+00 4.099376813889192e+00 4.960569028061777e+00 9.127415320420534e+03 + 191140 9.550399982758525e-01 -6.005767110517900e+00 -5.985333864950523e+00 3.686518383175263e+00 4.803849241257677e+00 9.172061069122714e+03 + 191160 9.510409627650923e-01 -6.046545179085324e+00 -5.992833822469372e+00 3.390042459374403e+00 4.698461380868775e+00 9.195068898074893e+03 + 191180 9.501315620752302e-01 -6.079975530612507e+00 -5.987169428839056e+00 3.308493758843910e+00 4.841400756924904e+00 9.177673180047750e+03 + 191200 9.045989450352149e-01 -6.035534260807115e+00 -6.029542803065583e+00 3.500523306224039e+00 4.534927183751005e+00 9.307954338391251e+03 + 191220 9.373486369008189e-01 -6.095746817487751e+00 -6.017117692242503e+00 3.160766283579474e+00 4.612266888555496e+00 9.269689350100856e+03 + 191240 9.349828891591804e-01 -6.096876881131269e+00 -5.977857689217425e+00 3.238605888397710e+00 4.922032506527430e+00 9.149195301573200e+03 + 191260 8.940781172580391e-01 -6.035654379450566e+00 -5.960340011842199e+00 3.566607058656234e+00 4.999073812324198e+00 9.095684633115519e+03 + 191280 8.736757694868976e-01 -5.994349401786306e+00 -6.013387808080138e+00 3.766767738836653e+00 4.657446263713622e+00 9.258176671332803e+03 + 191300 9.763740196483891e-01 -6.124460672010238e+00 -5.988817041677562e+00 3.051728780227339e+00 4.830615496381519e+00 9.182766385155906e+03 + 191320 9.815752218585243e-01 -6.105897408239872e+00 -5.971164419161475e+00 3.116758688014547e+00 4.890416361165378e+00 9.128745760243517e+03 + 191340 9.809850755669589e-01 -6.073450605929524e+00 -5.983542686580833e+00 3.316633935270348e+00 4.832899121376082e+00 9.166595602867323e+03 + 191360 9.977228183558724e-01 -6.062998791340311e+00 -6.005273469318062e+00 3.359950036342977e+00 4.691417768359445e+00 9.233259470601648e+03 + 191380 1.017970702159216e+00 -6.060081095466974e+00 -6.004226138794278e+00 3.430848902287466e+00 4.751576707028693e+00 9.230030565223289e+03 + 191400 1.015469537524013e+00 -6.028367111236157e+00 -5.994194195571880e+00 3.578383931146198e+00 4.774610101132089e+00 9.199221699988308e+03 + 191420 9.835383367285012e-01 -5.957859037928421e+00 -5.948957198717197e+00 3.914400487972997e+00 4.965516226279012e+00 9.061015358952969e+03 + 191440 1.019570921293598e+00 -5.991417318027834e+00 -5.961376909352484e+00 3.756020528763462e+00 4.928517204115540e+00 9.098853143508890e+03 + 191460 1.003479357216277e+00 -5.948494673059741e+00 -6.013939109310937e+00 3.931850989913131e+00 4.556058909464985e+00 9.259876649025848e+03 + 191480 1.051470343724972e+00 -6.005530277166252e+00 -5.998888960185941e+00 3.670870033090198e+00 4.709005502931628e+00 9.213644416775191e+03 + 191500 1.009274430061284e+00 -5.932434247530918e+00 -6.044543730823118e+00 4.112272000310284e+00 4.468521998360005e+00 9.354298243761985e+03 + 191520 1.058113455630465e+00 -6.002937325224207e+00 -6.023234113411297e+00 3.714156944915155e+00 4.597609646227067e+00 9.288502838323171e+03 + 191540 9.945245520899875e-01 -5.911555351276329e+00 -6.018762983858352e+00 4.108611183304932e+00 4.493008366691430e+00 9.274743925277704e+03 + 191560 1.010352817990935e+00 -5.940572551021598e+00 -6.009143566307461e+00 3.981526400810686e+00 4.587781019708936e+00 9.245133850948221e+03 + 191580 1.017874163232890e+00 -5.958163846636958e+00 -6.033085260178677e+00 3.900026065822345e+00 4.469815715214523e+00 9.318885098974570e+03 + 191600 1.052072743483916e+00 -6.018342463532246e+00 -6.015429065273006e+00 3.596682812100352e+00 4.613411995751830e+00 9.264454206710596e+03 + 191620 1.033582014517184e+00 -6.006244183265349e+00 -5.979113426399386e+00 3.676689978313955e+00 4.832478982709372e+00 9.153036386894692e+03 + 191640 9.783459178955162e-01 -5.944303370307665e+00 -5.996279380945139e+00 3.974380911839639e+00 4.675926615497612e+00 9.205607882972066e+03 + 191660 9.495605591885232e-01 -5.922646190290551e+00 -5.980351816715322e+00 4.160824540255213e+00 4.829469903407352e+00 9.156820024740990e+03 + 191680 1.073278135576532e+00 -6.131808122476375e+00 -5.963799293317770e+00 2.962638447736812e+00 4.927371144047812e+00 9.106264747772977e+03 + 191700 1.019904030798344e+00 -6.084539211203764e+00 -5.979937340649491e+00 3.233326052044087e+00 4.833966179853875e+00 9.155564173048439e+03 + 191720 1.003580227232314e+00 -6.097715189088562e+00 -5.973374924366634e+00 3.228128919491218e+00 4.942109961118311e+00 9.135501062137542e+03 + 191740 9.623827344372552e-01 -6.079941057435414e+00 -6.031768791670542e+00 3.281121125446143e+00 4.557733730102068e+00 9.314830370931300e+03 + 191760 9.541383746607742e-01 -6.112825226105445e+00 -5.981236433237981e+00 3.134580833584481e+00 4.890184045529351e+00 9.159527744020006e+03 + 191780 9.136424430679708e-01 -6.086815869207977e+00 -5.964120515641339e+00 3.266687622341837e+00 4.971223329566079e+00 9.107240365268188e+03 + 191800 9.016746540508660e-01 -6.091471018046007e+00 -5.987490404732738e+00 3.207811553867312e+00 4.804884326460009e+00 9.178702730301608e+03 + 191820 9.382766986989368e-01 -6.156465463297501e+00 -5.982982351852922e+00 2.845991209673524e+00 4.842158082013032e+00 9.164901414733786e+03 + 191840 8.772620646725818e-01 -6.066907258646674e+00 -5.998734176745101e+00 3.377608236353926e+00 4.769068622383089e+00 9.213146570738658e+03 + 191860 9.102359678844832e-01 -6.108228874497914e+00 -5.978214124349288e+00 3.131208744811996e+00 4.877773559882970e+00 9.150290623292751e+03 + 191880 9.130914466306342e-01 -6.097742579919884e+00 -5.954023133831194e+00 3.196115511968611e+00 5.021374811922272e+00 9.076439251745565e+03 + 191900 8.938525386101819e-01 -6.049296524990670e+00 -5.965909445672166e+00 3.388659391471166e+00 4.867480905026844e+00 9.112702287526863e+03 + 191920 8.936389474865665e-01 -6.025819417077584e+00 -5.988406242107807e+00 3.566857510541190e+00 4.781689750887770e+00 9.181482971096410e+03 + 191940 9.197943474258892e-01 -6.041861018588466e+00 -5.973154903716193e+00 3.456953368780187e+00 4.851474512613695e+00 9.134817149127686e+03 + 191960 9.678635059504289e-01 -6.092653386390560e+00 -5.985167912130876e+00 3.199637609045962e+00 4.816835835568451e+00 9.171565340244420e+03 + 191980 9.431687246303684e-01 -6.037935444933433e+00 -5.964313983484297e+00 3.530869535999547e+00 4.953615360524828e+00 9.107817187256251e+03 + 192000 9.576251207916190e-01 -6.040255296306430e+00 -5.982904442310485e+00 3.478806372176783e+00 4.808123850837474e+00 9.164623958095663e+03 + 192020 9.593518930677277e-01 -6.021170125105177e+00 -6.033032409394900e+00 3.542533497062882e+00 4.474418424988730e+00 9.318738188676089e+03 + 192040 1.007020196346745e+00 -6.072579985899557e+00 -5.993588078922735e+00 3.283115101393803e+00 4.736698855212814e+00 9.197383980548619e+03 + 192060 9.555891805065074e-01 -5.976963811548091e+00 -6.032205551743185e+00 3.772729423712545e+00 4.455522802880646e+00 9.316186789004389e+03 + 192080 9.733215524975060e-01 -5.983572408840113e+00 -5.976541698493543e+00 3.796867436938792e+00 4.837238863747702e+00 9.145178533190827e+03 + 192100 9.679647377956010e-01 -5.955598685348470e+00 -5.962530490556784e+00 3.948947199077776e+00 4.909143700878250e+00 9.102379837467881e+03 + 192120 1.045525563242220e+00 -6.048192643245182e+00 -5.986666318709317e+00 3.466589525217151e+00 4.819883201870034e+00 9.176157172220881e+03 + 192140 9.406567299728716e-01 -5.873374389452994e+00 -6.060692939495844e+00 4.326640703886595e+00 4.251028602088614e+00 9.404268866703327e+03 + 192160 1.012779331627218e+00 -5.963601088370486e+00 -6.002007241332899e+00 3.840035796750179e+00 4.619501723107041e+00 9.223217252894934e+03 + 192180 9.790478402541377e-01 -5.895157056663507e+00 -6.012591727570991e+00 4.316078822356825e+00 4.641750769049466e+00 9.255690722751136e+03 + 192200 1.029879957366478e+00 -5.956134396368607e+00 -6.023410296771222e+00 3.933979119652544e+00 4.547670488628789e+00 9.289055937230540e+03 + 192220 9.931537580234043e-01 -5.891391563264853e+00 -6.035254263086532e+00 4.215054845482317e+00 4.388972960425386e+00 9.325572284766355e+03 + 192240 1.040612308030105e+00 -5.954706802396915e+00 -5.954489189313839e+00 3.968073982647547e+00 4.969323550646086e+00 9.077832608937457e+03 + 192260 1.005221444621524e+00 -5.896126220228802e+00 -6.016982323913732e+00 4.199935601406573e+00 4.505961151626103e+00 9.269234238250092e+03 + 192280 1.083546802658243e+00 -6.008360630947656e+00 -6.018197940938515e+00 3.697869643067642e+00 4.641382286781329e+00 9.273001052357928e+03 + 192300 1.010336581954323e+00 -5.902107497643581e+00 -6.091841795284350e+00 4.170741115659305e+00 4.081257417318340e+00 9.501131350256646e+03 + 192320 1.041805277740136e+00 -5.963323932798932e+00 -6.024687655049785e+00 3.906363257754418e+00 4.554003268584692e+00 9.292997470367978e+03 + 192340 9.768973282589276e-01 -5.891088042206332e+00 -6.036793257865988e+00 4.309409872944383e+00 4.472747976817387e+00 9.330319001741347e+03 + 192360 1.033542857166404e+00 -6.012537748361447e+00 -5.978474859878798e+00 3.638689716029130e+00 4.834284092911458e+00 9.151080468582000e+03 + 192380 9.659139271004019e-01 -5.956860038445155e+00 -6.018565432697192e+00 3.893963652798107e+00 4.539641730124008e+00 9.274111979144322e+03 + 192400 8.967879880967317e-01 -5.901928702877667e+00 -6.007455282442073e+00 4.237230082021938e+00 4.631280131977704e+00 9.239928377635053e+03 + 192420 9.746097922455307e-01 -6.057216609161243e+00 -5.948687250149206e+00 3.410272714158284e+00 5.033465088469429e+00 9.060188070740265e+03 + 192440 9.471052988486731e-01 -6.046407878073064e+00 -5.958533476656565e+00 3.489497225984359e+00 4.994085637437570e+00 9.090173394915937e+03 + 192460 9.353684383857561e-01 -6.045718236663029e+00 -5.976989110661730e+00 3.450545043794382e+00 4.845198321091716e+00 9.146541970821156e+03 + 192480 9.939048077375074e-01 -6.140243172837104e+00 -5.986964513291386e+00 2.947500593138268e+00 4.827650376045687e+00 9.177092559008019e+03 + 192500 9.146719508165742e-01 -6.024212076760592e+00 -6.033263444065296e+00 3.549520273209473e+00 4.497545921451296e+00 9.319460559552594e+03 + 192520 9.807177052988922e-01 -6.120995865590154e+00 -5.957907512484915e+00 3.055455646461861e+00 4.991934207833220e+00 9.088299572814507e+03 + 192540 9.221259462994515e-01 -6.025519473796090e+00 -5.976846745676211e+00 3.549930414251555e+00 4.829416751196232e+00 9.146111074578694e+03 + 192560 9.217870751269673e-01 -6.009199929391844e+00 -6.017217326278747e+00 3.614289956644090e+00 4.568252823031339e+00 9.269995336460124e+03 + 192580 9.662691560521297e-01 -6.056371653367839e+00 -5.980723435820643e+00 3.433798893766838e+00 4.868182665446671e+00 9.157984651873956e+03 + 192600 9.503504370838111e-01 -6.011653250127982e+00 -5.996713584569786e+00 3.641178158681920e+00 4.726964030222855e+00 9.206937145557937e+03 + 192620 9.373358815981214e-01 -5.967289547031760e+00 -6.023447087822232e+00 3.809162348862350e+00 4.486697059292106e+00 9.289161989993619e+03 + 192640 1.030187041733637e+00 -6.080931738237631e+00 -5.956211515256458e+00 3.241635194319849e+00 4.957798015069875e+00 9.083111978218405e+03 + 192660 1.013829522811777e+00 -6.034178034372769e+00 -5.953385923476665e+00 3.523578088241455e+00 4.987498891545645e+00 9.074467594379037e+03 + 192680 9.407627319835281e-01 -5.905594912104410e+00 -5.992221483333143e+00 4.236005681895677e+00 4.738582504481717e+00 9.193148284639608e+03 + 192700 1.003212142847814e+00 -5.980829427637343e+00 -6.016094575607014e+00 3.738342084543816e+00 4.535844147637956e+00 9.266481902903404e+03 + 192720 1.007889770097951e+00 -5.975588895918214e+00 -5.991723967987950e+00 3.787167498561387e+00 4.694517417842631e+00 9.191656019528140e+03 + 192740 1.024881593061589e+00 -5.992288930007204e+00 -5.996692697481517e+00 3.675655287312233e+00 4.650368172993914e+00 9.206893867309969e+03 + 192760 1.039707542063000e+00 -6.007727488520697e+00 -6.054344794272981e+00 3.617069498750900e+00 4.349385715116535e+00 9.384636750520622e+03 + 192780 1.006709212962323e+00 -5.959881708491642e+00 -6.015425609087472e+00 3.929179648379150e+00 4.610237975767054e+00 9.264476050978265e+03 + 192800 9.854824735506763e-01 -5.933020091932467e+00 -5.985219210218506e+00 4.024287870581253e+00 4.724552455595364e+00 9.171714522878097e+03 + 192820 1.023832631215471e+00 -5.991921278501300e+00 -5.977792236617633e+00 3.784263118426029e+00 4.865394263384211e+00 9.148986376082168e+03 + 192840 1.052000262815415e+00 -6.037455528421045e+00 -5.990360118257201e+00 3.450820639447785e+00 4.721249772599746e+00 9.187483286954999e+03 + 192860 1.029843776873423e+00 -6.008314338260278e+00 -5.941443746166821e+00 3.739097718352827e+00 5.123079006344138e+00 9.038125338709613e+03 + 192880 1.008424253319556e+00 -5.979981659584528e+00 -6.012986777994043e+00 3.806749737742957e+00 4.617229240309952e+00 9.256890562970551e+03 + 192900 1.006484228571428e+00 -5.982238498500737e+00 -6.003669187810764e+00 3.725817986958154e+00 4.602759652551528e+00 9.228317093979820e+03 + 192920 9.552758763545041e-01 -5.910204749626405e+00 -6.043167225553050e+00 4.126402932903841e+00 4.362911820256389e+00 9.350013837800443e+03 + 192940 1.032030353125798e+00 -6.029332970594379e+00 -6.041192063631321e+00 3.506869975760779e+00 4.438773228353941e+00 9.343930476620228e+03 + 192960 1.028642868277555e+00 -6.033996839059620e+00 -6.023399274163221e+00 3.492719415259459e+00 4.553572272862453e+00 9.289032635909294e+03 + 192980 9.516282139765604e-01 -5.932174617125932e+00 -6.022984277936913e+00 4.048216472291362e+00 4.526773347165120e+00 9.287719065222647e+03 + 193000 9.221747874392042e-01 -5.901948938264630e+00 -5.972287271837005e+00 4.296536958136088e+00 4.892643361941571e+00 9.132145968463776e+03 + 193020 9.967620906617108e-01 -6.024434171772220e+00 -6.008409717074946e+00 3.487407009000026e+00 4.579421907648120e+00 9.242892891105204e+03 + 193040 9.453373255909743e-01 -5.964202147077200e+00 -6.010474077541184e+00 3.939647686705684e+00 4.673947101423395e+00 9.249242173418534e+03 + 193060 9.609140540355077e-01 -6.007102328049189e+00 -6.035018225517256e+00 3.618892007921688e+00 4.458594604688876e+00 9.324864642014463e+03 + 193080 9.561465559938862e-01 -6.028977961760090e+00 -6.031410303002341e+00 3.512037138254525e+00 4.498070258437931e+00 9.313743946658156e+03 + 193100 9.566715363582162e-01 -6.066414189457478e+00 -5.999729544895190e+00 3.330795694133351e+00 4.713709242625406e+00 9.216229603957807e+03 + 193120 9.333866191278156e-01 -6.069982557625226e+00 -5.970855157729405e+00 3.340031449054857e+00 4.909236319172214e+00 9.127805621720665e+03 + 193140 9.134541874023875e-01 -6.072814792974334e+00 -5.982541077263695e+00 3.290500238948896e+00 4.808865884371741e+00 9.163539020822553e+03 + 193160 9.576172466378968e-01 -6.161933811703527e+00 -5.960396325893591e+00 2.835435688610958e+00 4.992695119956750e+00 9.095875731634671e+03 + 193180 8.670986831403696e-01 -6.041524937722428e+00 -5.985440169616753e+00 3.466095037167460e+00 4.788142454720065e+00 9.172410711022309e+03 + 193200 9.053845020733399e-01 -6.102267418017212e+00 -6.016420104683939e+00 3.105011243185027e+00 4.597959801173484e+00 9.267535513569921e+03 + 193220 8.980117527856828e-01 -6.086830582377294e+00 -5.999572075103172e+00 3.227013274466935e+00 4.728065126445300e+00 9.215733819370422e+03 + 193240 9.410914474458053e-01 -6.135473115789558e+00 -5.998930077312314e+00 2.952376071807813e+00 4.736427328711065e+00 9.213785280443230e+03 + 193260 9.601176850693679e-01 -6.137312698012403e+00 -6.011367316933711e+00 2.949862175113902e+00 4.673060043252484e+00 9.251990484759672e+03 + 193280 9.166411273789244e-01 -6.040337267665028e+00 -6.006284162429790e+00 3.475516789453556e+00 4.671054989415296e+00 9.236362997994192e+03 + 193300 9.270422170559988e-01 -6.016904814733277e+00 -5.995357343659677e+00 3.617885212865659e+00 4.741614126230640e+00 9.202806997259806e+03 + 193320 9.655667914312422e-01 -6.030578136774420e+00 -5.987442640271071e+00 3.568934820418284e+00 4.816625516537023e+00 9.178528748468669e+03 + 193340 9.820138122671324e-01 -6.016296243480034e+00 -6.018572543766212e+00 3.595566292725177e+00 4.582495424225613e+00 9.274163776895248e+03 + 193360 9.692003756745533e-01 -5.971191859835379e+00 -6.049280713406879e+00 3.787932905128748e+00 4.339534623710161e+00 9.368964038164671e+03 + 193380 1.002257820711203e+00 -6.003792747994935e+00 -6.018722761083982e+00 3.629905806765611e+00 4.544175361196244e+00 9.274622882985874e+03 + 193400 1.048449079955170e+00 -6.061515350559915e+00 -6.005200751983695e+00 3.325003602414117e+00 4.648370742094739e+00 9.233023174105296e+03 + 193420 1.025792989482752e+00 -6.020378786169019e+00 -5.937770120602330e+00 3.609684534313829e+00 5.084036275647439e+00 9.027005516265350e+03 + 193440 9.598117108338120e-01 -5.914258456734489e+00 -6.015925575603523e+00 4.121599330049314e+00 4.537811000567523e+00 9.265969287100012e+03 + 193460 9.471950022608682e-01 -5.887847802848131e+00 -6.023034033504663e+00 4.288814462863103e+00 4.512554206431712e+00 9.287872772075083e+03 + 193480 1.048279665534575e+00 -6.031503082231900e+00 -5.977419259777339e+00 3.461589019377868e+00 4.772146697356437e+00 9.147849180578820e+03 + 193500 9.949953597411039e-01 -5.947098720124854e+00 -6.032610169971354e+00 4.006223698789862e+00 4.515203720917161e+00 9.317417636061589e+03 + 193520 9.942678565652801e-01 -5.942597684598464e+00 -6.075065388873304e+00 3.989843196429985e+00 4.229193139172873e+00 9.448932173960282e+03 + 193540 1.074236918599756e+00 -6.062408444122731e+00 -5.998578223520866e+00 3.404078300582758e+00 4.770601304973379e+00 9.212700003471789e+03 + 193560 1.008016265052329e+00 -5.969427675045067e+00 -6.012377811564146e+00 3.817414929479055e+00 4.570788599074351e+00 9.255094595661074e+03 + 193580 9.692217185312093e-01 -5.919583548496787e+00 -5.991877961582524e+00 4.158906384111495e+00 4.743780676648922e+00 9.192135438797513e+03 + 193600 1.030487255384755e+00 -6.020175320177704e+00 -5.963956682905048e+00 3.556715471030745e+00 4.879531586056338e+00 9.106721005341877e+03 + 193620 9.902610268112152e-01 -5.972326687209407e+00 -5.998043373042836e+00 3.898846346045933e+00 4.751177156346116e+00 9.211016583797722e+03 + 193640 1.012585871431132e+00 -6.019606478852444e+00 -6.000994151799338e+00 3.612091322234165e+00 4.718966184421403e+00 9.220074309532871e+03 + 193660 9.951820073350311e-01 -6.011990981008261e+00 -5.987661294357156e+00 3.654635199446539e+00 4.794340025204028e+00 9.179200461549322e+03 + 193680 9.440051165897440e-01 -5.956440565358391e+00 -5.983905003578301e+00 3.897299854159983e+00 4.739594799793178e+00 9.167707530233289e+03 + 193700 9.510300164625005e-01 -5.990100864424569e+00 -6.001597578453840e+00 3.770140545450684e+00 4.704124634383869e+00 9.221945828509024e+03 + 193720 9.508551718695956e-01 -6.015159660741341e+00 -6.030752653391935e+00 3.564339334264950e+00 4.474801957457430e+00 9.311702694451800e+03 + 193740 9.717774222513653e-01 -6.072986463311710e+00 -6.037421352216301e+00 3.266937151335431e+00 4.471157522928429e+00 9.332296476942043e+03 + 193760 9.340553451268199e-01 -6.045264166567318e+00 -6.000632930351231e+00 3.459578220853651e+00 4.715857685867905e+00 9.219008563351808e+03 + 193780 9.595354352992714e-01 -6.109002742075771e+00 -5.978551705032745e+00 3.129046094695315e+00 4.878116136629110e+00 9.151318752953488e+03 + 193800 9.046420520675820e-01 -6.045195877916576e+00 -5.983989895134261e+00 3.436939771202169e+00 4.788393995933442e+00 9.167989653881526e+03 + 193820 9.243055451462868e-01 -6.086217394207283e+00 -6.020108949575155e+00 3.196600840449380e+00 4.576205759775801e+00 9.278891373635590e+03 + 193840 8.892897230436768e-01 -6.041169044673222e+00 -6.005300917494747e+00 3.490601287084406e+00 4.696561623917956e+00 9.233344950048257e+03 + 193860 9.307563021372819e-01 -6.101448265492746e+00 -5.979017286367676e+00 3.100641545019982e+00 4.803659173288921e+00 9.152758490983766e+03 + 193880 8.986729992885011e-01 -6.040522267533941e+00 -6.023014959248859e+00 3.492900735821956e+00 4.593430409242100e+00 9.287815919061168e+03 + 193900 9.525957807427563e-01 -6.097053215686828e+00 -6.013036163302107e+00 3.137074002218578e+00 4.619512918608479e+00 9.257129516350107e+03 + 193920 9.823341661429406e-01 -6.102576369619105e+00 -6.005233682518390e+00 3.110681440872853e+00 4.669638213937304e+00 9.233130567580258e+03 + 193940 9.502053605734744e-01 -6.007160131129385e+00 -5.984914969238337e+00 3.671274383595851e+00 4.799009545601926e+00 9.170786122394105e+03 + 193960 9.816071685293634e-01 -6.001864277112706e+00 -6.004062432620557e+00 3.681765827791661e+00 4.669143678702111e+00 9.229521579930230e+03 + 193980 9.617886614250544e-01 -5.926559730116336e+00 -6.026979307151656e+00 4.104473769145425e+00 4.527849017929296e+00 9.300014722334588e+03 + 194000 1.024485437360066e+00 -5.989106826575084e+00 -5.974766972883923e+00 3.710923629298715e+00 4.793265288278548e+00 9.139739549608748e+03 + 194020 9.957750828356648e-01 -5.926974619591436e+00 -5.965476532018317e+00 4.065848860112366e+00 4.844764920805525e+00 9.111334187289571e+03 + 194040 1.018235906778185e+00 -5.945672992547292e+00 -5.955136216633873e+00 3.998605878017963e+00 4.944266580883618e+00 9.079813809930081e+03 + 194060 1.014995399663806e+00 -5.929033498387922e+00 -6.034039174219503e+00 4.055360899364022e+00 4.452402059163267e+00 9.321827148095863e+03 + 194080 1.037497960937172e+00 -5.957884679447076e+00 -5.992709031296734e+00 3.967686639620832e+00 4.767719822249067e+00 9.194658179659207e+03 + 194100 1.066448146130094e+00 -6.001610338615022e+00 -5.987259092836767e+00 3.723432050154174e+00 4.805839124261017e+00 9.177965028885823e+03 + 194120 1.026214527613712e+00 -5.946215891079811e+00 -5.965285702263070e+00 4.045438732375304e+00 4.935936925517292e+00 9.110790023717551e+03 + 194140 1.016298081411599e+00 -5.938494320631506e+00 -6.024149887827736e+00 4.040102274056103e+00 4.548254752059165e+00 9.291314603744044e+03 + 194160 1.011249067204034e+00 -5.942844304575742e+00 -6.024447142633424e+00 4.001995973263663e+00 4.533419849138083e+00 9.292244228918116e+03 + 194180 1.022851902090925e+00 -5.975531183768096e+00 -6.000079073453587e+00 3.832595210026639e+00 4.691637428678900e+00 9.217285085005435e+03 + 194200 9.983077110015581e-01 -5.958916442946118e+00 -5.974545211740619e+00 3.956805636930254e+00 4.867062827968081e+00 9.139065387502940e+03 + 194220 9.440526392907095e-01 -5.898869083982945e+00 -6.012101755000233e+00 4.203962052461295e+00 4.553762532780815e+00 9.254239337947702e+03 + 194240 1.080733567929887e+00 -6.123108556622436e+00 -5.956959231573098e+00 3.071134877844902e+00 5.025190013803160e+00 9.085402790020411e+03 + 194260 9.737382111031422e-01 -5.987954219844417e+00 -6.034891547820374e+00 3.780944501644778e+00 4.511423100878802e+00 9.324494928199780e+03 + 194280 9.975125169201211e-01 -6.048527197364016e+00 -6.047516666689599e+00 3.397607459257824e+00 4.403410082769443e+00 9.363508670400774e+03 + 194300 9.435485097442139e-01 -5.996945341425461e+00 -6.017536271615102e+00 3.694615427813358e+00 4.576379120228294e+00 9.270972830985793e+03 + 194320 9.204297750056399e-01 -5.987071711519894e+00 -5.986566621725789e+00 3.760758544203275e+00 4.763658847963422e+00 9.175853457539728e+03 + 194340 1.003210044440870e+00 -6.130690528335132e+00 -5.956268441211414e+00 3.010826201303048e+00 5.012384817298184e+00 9.083293145898378e+03 + 194360 9.157749371875800e-01 -6.016876617991064e+00 -5.977752225361162e+00 3.632476746752585e+00 4.857135063713677e+00 9.148871575894396e+03 + 194380 9.422466776727291e-01 -6.065991085352614e+00 -5.951736782879858e+00 3.365884260767706e+00 5.021950146362438e+00 9.069480703882353e+03 + 194400 9.834099985349986e-01 -6.128197824941129e+00 -5.968689460576061e+00 3.009957681764494e+00 4.925879393788323e+00 9.121192488892601e+03 + 194420 1.013194410556246e+00 -6.168028187055096e+00 -5.989075184118316e+00 2.819521942417330e+00 4.847097778168029e+00 9.183565406100037e+03 + 194440 9.263761478519698e-01 -6.028116146302384e+00 -6.014379881236366e+00 3.551344053990355e+00 4.630219813679584e+00 9.261274956772035e+03 + 194460 9.932393852035065e-01 -6.102947606769537e+00 -6.002921594692144e+00 3.158454931911577e+00 4.732819772235310e+00 9.226015704464431e+03 + 194480 9.052023386377490e-01 -5.931051922937816e+00 -5.976226459981921e+00 4.086994849516230e+00 4.827595667071963e+00 9.144190248297869e+03 + 194500 1.012931860130209e+00 -6.033583329171025e+00 -5.997407906947040e+00 3.532696392883950e+00 4.740421265422566e+00 9.209092100004480e+03 + 194520 1.033559082153970e+00 -6.001570048807977e+00 -6.057796717928790e+00 3.670350128827394e+00 4.347487893686763e+00 9.395319184637421e+03 + 194540 1.028348159236356e+00 -5.947652199109034e+00 -6.045998907887073e+00 3.968236307289352e+00 4.403514286381855e+00 9.358801335055672e+03 + 194560 1.027064710840331e+00 -5.919291799315753e+00 -5.984431546451627e+00 4.181549311585931e+00 4.807506803188454e+00 9.169295673072071e+03 + 194580 1.075027888614115e+00 -5.972728785536670e+00 -5.986214838204464e+00 3.829659051295233e+00 4.752220049916857e+00 9.174768441531387e+03 + 194600 1.022956580169680e+00 -5.885642196346944e+00 -6.023362084192408e+00 4.319913427800806e+00 4.529104519708381e+00 9.288881675335770e+03 + 194620 1.066661883179943e+00 -5.946325844652015e+00 -6.045522819927838e+00 4.001326191943191e+00 4.431721809227106e+00 9.357332257445103e+03 + 194640 1.067359001206917e+00 -5.953188307826789e+00 -6.021220964332403e+00 3.970457938654704e+00 4.579803896979898e+00 9.282310030681263e+03 + 194660 1.083364446139227e+00 -5.988988145575913e+00 -6.001230620021657e+00 3.753056731725506e+00 4.682758548941248e+00 9.220833828615414e+03 + 194680 1.047244718865614e+00 -5.954091308926347e+00 -6.034789731538917e+00 3.959971631682409e+00 4.496588801000494e+00 9.324149460401417e+03 + 194700 1.052979102711896e+00 -5.987863284096330e+00 -6.025970732819832e+00 3.724092554417755e+00 4.505273686738779e+00 9.296942096064631e+03 + 194720 9.881345128073428e-01 -5.922073336040594e+00 -6.011198699346856e+00 4.098234154707811e+00 4.586462526497857e+00 9.251440209953935e+03 + 194740 9.139238765405863e-01 -5.842445433571315e+00 -5.988806999312830e+00 4.538474984321857e+00 4.698044224454974e+00 9.182711584226841e+03 + 194760 9.719882212122737e-01 -5.953830033859441e+00 -5.998372005098083e+00 3.962831056063020e+00 4.707064164362966e+00 9.212026532227837e+03 + 194780 9.879078353243927e-01 -6.000741597265784e+00 -6.005537336361003e+00 3.725425105541702e+00 4.697887229518728e+00 9.234070536604015e+03 + 194800 1.048372767288372e+00 -6.111335194929350e+00 -5.990977878113209e+00 3.112639695783624e+00 4.803750034176486e+00 9.189383895490930e+03 + 194820 9.023908454245887e-01 -5.913862804081949e+00 -6.047341438039045e+00 4.115172425347900e+00 4.348717453414403e+00 9.362942535794453e+03 + 194840 9.678881488642577e-01 -6.024791997355376e+00 -6.030376897551854e+00 3.567873045821821e+00 4.535803684633130e+00 9.310556916745858e+03 + 194860 9.768458078943340e-01 -6.049588727759937e+00 -6.023704187237696e+00 3.376928294040593e+00 4.525561331339002e+00 9.289972940342110e+03 + 194880 9.841797597778549e-01 -6.068375498000267e+00 -5.970690640810600e+00 3.328667067139163e+00 4.889588633805030e+00 9.127299678094048e+03 + 194900 8.861678225018721e-01 -5.925691185358503e+00 -6.026610466418308e+00 4.120952137337278e+00 4.541458008283607e+00 9.298901005237185e+03 + 194920 9.882653012354137e-01 -6.075168715346120e+00 -6.007539761653294e+00 3.333316616203706e+00 4.721652533854672e+00 9.240218388524016e+03 + 194940 9.728430377410036e-01 -6.047346213529561e+00 -6.009859286438171e+00 3.426636607093120e+00 4.641892343535104e+00 9.247328503005765e+03 + 194960 1.027546616732236e+00 -6.119761806917442e+00 -5.978634450710405e+00 3.073148520484556e+00 4.883523639213148e+00 9.151590376779071e+03 + 194980 1.041196346045546e+00 -6.125185260115226e+00 -5.982440548013432e+00 3.043682442937001e+00 4.863344669498316e+00 9.163233859463489e+03 + 195000 9.785209658312166e-01 -6.013311194767229e+00 -5.991178606353222e+00 3.643419687696193e+00 4.770508435376408e+00 9.189990221036411e+03 + 195020 1.031850945958863e+00 -6.060141834429955e+00 -5.997741544392487e+00 3.370562782501036e+00 4.728874904309855e+00 9.210120233020480e+03 + 195040 9.674849870548101e-01 -5.914024189934994e+00 -6.062666667541665e+00 4.153171222006355e+00 4.299643113239786e+00 9.410423935718543e+03 + 195060 1.068454047061228e+00 -6.005147404645366e+00 -6.015492827478642e+00 3.687796575085263e+00 4.628391556227585e+00 9.264679901629477e+03 + 195080 1.037943724067844e+00 -5.899010103776524e+00 -6.040824753676988e+00 4.178818332966619e+00 4.364496667492006e+00 9.342805482543628e+03 + 195100 1.091265130443541e+00 -5.938149955470487e+00 -6.029362263779415e+00 3.984252802744566e+00 4.460497613375606e+00 9.307417203504157e+03 + 195120 1.108284774380668e+00 -5.942593429551157e+00 -5.993509001114340e+00 4.016629242373025e+00 4.724264151297993e+00 9.197109775128896e+03 + 195140 1.109040097042377e+00 -5.935260810410387e+00 -5.973344572545153e+00 4.056600576285014e+00 4.837917720664044e+00 9.135375014709356e+03 + 195160 1.130877413555004e+00 -5.968515068558276e+00 -5.983932052923331e+00 3.895517653181329e+00 4.806990943186566e+00 9.167778861471577e+03 + 195180 1.093156306920436e+00 -5.924013211308193e+00 -6.015034188968398e+00 4.088440760733825e+00 4.565784221558154e+00 9.263262636146044e+03 + 195200 1.060974291882846e+00 -5.897189168434219e+00 -6.018880272875743e+00 4.233464178690634e+00 4.534695025349853e+00 9.275065084393518e+03 + 195220 9.912683735722263e-01 -5.818286867332745e+00 -5.984878420680416e+00 4.691277184128419e+00 4.734682704846530e+00 9.170652403217671e+03 + 195240 1.061569483046638e+00 -5.945269013670535e+00 -6.003468030436856e+00 3.953539616962259e+00 4.619351856421302e+00 9.227703402245008e+03 + 195260 1.052929034895196e+00 -5.959018203543150e+00 -6.040539511455994e+00 3.927154746577597e+00 4.459046781160421e+00 9.341922857284288e+03 + 195280 1.068965843257288e+00 -6.012291705589042e+00 -6.031506911292057e+00 3.663420359669321e+00 4.553083674979134e+00 9.314032432931792e+03 + 195300 1.006538632832713e+00 -5.951142656852239e+00 -6.060921493991385e+00 3.974206568028704e+00 4.343839496955582e+00 9.404991852671619e+03 + 195320 9.589021443974243e-01 -5.908552200412034e+00 -6.034819334084642e+00 4.170740760733112e+00 4.445695339409208e+00 9.324252076091745e+03 + 195340 1.014784999861582e+00 -6.013782000627955e+00 -6.023138856429611e+00 3.577512675293565e+00 4.523784161311701e+00 9.288246778114179e+03 + 195360 9.309996316952405e-01 -5.908420272505087e+00 -6.032282432857651e+00 4.157953833463136e+00 4.446718141111350e+00 9.316406182725261e+03 + 195380 9.506303619349689e-01 -5.950742460884308e+00 -6.020554207916141e+00 3.920210987587033e+00 4.519341132797308e+00 9.280231516032365e+03 + 195400 9.835865752125958e-01 -6.010114104572669e+00 -6.016454658511489e+00 3.610638034472048e+00 4.574229592557794e+00 9.267637771107546e+03 + 195420 9.681555571854904e-01 -5.993707766344327e+00 -5.991330050371896e+00 3.715043616429753e+00 4.728696829493813e+00 9.190457844040404e+03 + 195440 9.457743779534938e-01 -5.964516945934775e+00 -6.010340929138503e+00 3.794709959652249e+00 4.531581556857955e+00 9.248802205308046e+03 + 195460 9.143861506562426e-01 -5.918681211623412e+00 -6.002772481927474e+00 4.089532518748589e+00 4.606667431580642e+00 9.225554956729096e+03 + 195480 9.207583258790997e-01 -5.924559705955359e+00 -6.039331327616480e+00 4.062298502164776e+00 4.403262089735566e+00 9.338167053082436e+03 + 195500 9.827210939434317e-01 -6.012454450566005e+00 -5.982069597266509e+00 3.648443097354031e+00 4.822917627040589e+00 9.162093967311053e+03 + 195520 1.024595005560078e+00 -6.066649411953991e+00 -5.993960229857764e+00 3.313287145186318e+00 4.730679677397426e+00 9.198502096097025e+03 + 195540 9.173785224805937e-01 -5.897563283022935e+00 -6.040675656019531e+00 4.248174252437241e+00 4.426400860122637e+00 9.342309243884254e+03 + 195560 1.021339652449600e+00 -6.039506100194989e+00 -5.992296297768468e+00 3.539318353838091e+00 4.810404345064493e+00 9.193417395302449e+03 + 195580 1.008308403358865e+00 -6.005014189512828e+00 -6.022612079538067e+00 3.667228377750170e+00 4.566178569960561e+00 9.286592408233244e+03 + 195600 9.997542728009768e-01 -5.975234476987739e+00 -6.006136734916364e+00 3.852923816297130e+00 4.675478269162010e+00 9.235891951254935e+03 + 195620 9.701013589336697e-01 -5.907328543935792e+00 -6.035656252123649e+00 4.206990065799034e+00 4.470112506735700e+00 9.326807595097669e+03 + 195640 1.031570390624593e+00 -5.966916493330304e+00 -5.986856272710686e+00 3.927037705866337e+00 4.812540406993302e+00 9.176704351323720e+03 + 195660 1.034838000530701e+00 -5.930061006415778e+00 -5.988050464289927e+00 4.092731136759607e+00 4.759746695806641e+00 9.180386945439654e+03 + 195680 1.103343436778477e+00 -5.984126496259647e+00 -6.014309587487356e+00 3.733321237132906e+00 4.560005256485133e+00 9.261010948805497e+03 + 195700 1.030117971391306e+00 -5.830488207587748e+00 -6.028131357459952e+00 4.622435055405390e+00 4.487537503660601e+00 9.303607295531910e+03 + 195720 1.043771650334911e+00 -5.817489488557357e+00 -6.037159433526663e+00 4.646014578681230e+00 4.384635760853353e+00 9.331474432674315e+03 + 195740 1.109502239448264e+00 -5.893142462046918e+00 -5.975932573416783e+00 4.327816865736255e+00 4.852423234522168e+00 9.143289087547106e+03 + 195760 1.203622420289884e+00 -6.023647047468567e+00 -5.958471813207203e+00 3.554590934528555e+00 4.928837215492212e+00 9.089991127436406e+03 + 195780 1.025763282680875e+00 -5.762924165083025e+00 -6.064199170860745e+00 4.970966442472552e+00 4.240998737140416e+00 9.415157422421986e+03 + 195800 1.150305917748389e+00 -5.963624691095585e+00 -5.997845526089270e+00 3.884980961008975e+00 4.688479630818135e+00 9.210411907480182e+03 + 195820 1.029302771349974e+00 -5.813863527385857e+00 -6.088792848711325e+00 4.655490259945367e+00 4.076803551719556e+00 9.491610443941916e+03 + 195840 1.061079312409690e+00 -5.899083819617505e+00 -6.049104365717444e+00 4.155500437328173e+00 4.294059246017851e+00 9.368421708130536e+03 + 195860 1.084799665186829e+00 -5.977167034915016e+00 -6.014921058876938e+00 3.846474853025037e+00 4.629685405019358e+00 9.262906998870449e+03 + 195880 1.045054978832134e+00 -5.956683928026305e+00 -5.973701236154893e+00 3.963260584830127e+00 4.865544568135847e+00 9.136452701478986e+03 + 195900 9.980838992881256e-01 -5.912094188057544e+00 -5.994176397667002e+00 4.248177378764812e+00 4.776848629006422e+00 9.199116434182821e+03 + 195920 9.788310446986191e-01 -5.900461278441330e+00 -5.957523871722727e+00 4.244823983343492e+00 4.917161742313935e+00 9.087121051044682e+03 + 195940 1.109424694478011e+00 -6.106819290213096e+00 -5.943808738518188e+00 3.112346909323401e+00 5.048378722956913e+00 9.045364271006429e+03 + 195960 9.868670999573856e-01 -5.935082963025387e+00 -6.039264653131007e+00 4.065093522041795e+00 4.466866135390885e+00 9.337950493773402e+03 + 195980 1.015353267431872e+00 -5.988512136884857e+00 -6.011998002858749e+00 3.785098745219610e+00 4.650239268371513e+00 9.253914337205419e+03 + 196000 9.762518212461302e-01 -5.941699130558347e+00 -6.028064418808317e+00 3.985377079326182e+00 4.489454229209694e+00 9.303382289104353e+03 + 196020 1.025268059393474e+00 -6.025907688671422e+00 -6.027068140442571e+00 3.556115788427973e+00 4.549452294778707e+00 9.300326118308833e+03 + 196040 9.789862474855155e-01 -5.970312459544172e+00 -6.027891854381036e+00 3.826568380206134e+00 4.495938584670310e+00 9.302857492504578e+03 + 196060 1.038765041711593e+00 -6.071759861808702e+00 -5.974056621483405e+00 3.332654705778670e+00 4.893681831254100e+00 9.137574059475333e+03 + 196080 9.613493345037628e-01 -5.969826094817813e+00 -5.994581489826163e+00 3.891112399080832e+00 4.748963090057893e+00 9.200423549726422e+03 + 196100 9.632818152527783e-01 -5.984751422027773e+00 -6.016077682465077e+00 3.761701017156386e+00 4.581820782002248e+00 9.266468825874474e+03 + 196120 9.814433536943094e-01 -6.021385953118086e+00 -6.003045320514879e+00 3.529852630281688e+00 4.635167380893028e+00 9.226407349847639e+03 + 196140 9.542280245903060e-01 -5.990684331666362e+00 -6.020197539135954e+00 3.743985997424326e+00 4.574516592979832e+00 9.279149865497217e+03 + 196160 9.796670291339024e-01 -6.036575551269958e+00 -6.023644622958218e+00 3.448822486249040e+00 4.523073877669736e+00 9.289768095886840e+03 + 196180 1.004913699703821e+00 -6.081103446843636e+00 -6.020846000717034e+00 3.193787857256879e+00 4.539795437725479e+00 9.281166969847038e+03 + 196200 9.072807497277826e-01 -5.943133793041028e+00 -6.030456325565718e+00 3.985557362852485e+00 4.484137867977481e+00 9.310772677102919e+03 + 196220 1.017485087939072e+00 -6.111008502014367e+00 -5.973459383217977e+00 3.100866455646824e+00 4.890694781433037e+00 9.135751702356602e+03 + 196240 9.966495689880164e-01 -6.080819096042160e+00 -5.986772628335506e+00 3.183573419150070e+00 4.723602790365520e+00 9.176501344713612e+03 + 196260 9.674832197506874e-01 -6.034669329523607e+00 -5.971869761704508e+00 3.537578394363829e+00 4.898183230982805e+00 9.130900852390239e+03 + 196280 9.839026416470281e-01 -6.052098536100198e+00 -5.960533136511234e+00 3.423336561425150e+00 4.949119255564772e+00 9.096291441605750e+03 + 196300 9.726166914996156e-01 -6.018638323206472e+00 -6.026142702725586e+00 3.545403355364974e+00 4.502312046867243e+00 9.297495271429132e+03 + 196320 9.801225092071612e-01 -6.006808617812212e+00 -6.049173246633879e+00 3.619101363066059e+00 4.375837108466922e+00 9.368621649990835e+03 + 196340 9.563569203546441e-01 -5.943050198906358e+00 -6.048469812939507e+00 3.976700445333563e+00 4.371364707922671e+00 9.366446359388423e+03 + 196360 1.016728831749194e+00 -6.001168492801508e+00 -6.012307883485610e+00 3.654546650826205e+00 4.590582545702953e+00 9.254876651820887e+03 + 196380 1.008156594513306e+00 -5.954048034756957e+00 -6.023822192688198e+00 3.943586010787734e+00 4.542931998430503e+00 9.290333386865057e+03 + 196400 1.041124516804299e+00 -5.970271545252571e+00 -6.044143450797173e+00 3.842178728542472e+00 4.417994815264929e+00 9.353054540713165e+03 + 196420 1.086576681300038e+00 -6.011560463914763e+00 -6.024765669467967e+00 3.589886430235164e+00 4.514060096449715e+00 9.293242786800582e+03 + 196440 1.063279643299886e+00 -5.958440407334984e+00 -6.012366558837368e+00 3.913189380883155e+00 4.603537073911491e+00 9.255045380419879e+03 + 196460 1.097943994054016e+00 -5.997964065017324e+00 -5.999119533977978e+00 3.718612839764888e+00 4.711977958184568e+00 9.214333194476187e+03 + 196480 1.104999436025522e+00 -6.003260341139711e+00 -5.987425606832627e+00 3.728764886970749e+00 4.819690381779241e+00 9.178479116638713e+03 + 196500 1.157593607922789e+00 -6.083708436207534e+00 -5.949969614095542e+00 3.307321772338487e+00 5.075270784921381e+00 9.064111759971396e+03 + 196520 1.015622505444549e+00 -5.884498037167493e+00 -6.012648919237864e+00 4.353883725711413e+00 4.618021529578432e+00 9.255907775082427e+03 + 196540 1.034827590909407e+00 -5.931003680236585e+00 -5.990301880990764e+00 4.053676541565276e+00 4.713177096467867e+00 9.187281873121270e+03 + 196560 1.090095937186121e+00 -6.037090085142685e+00 -5.981296819889002e+00 3.549257062086189e+00 4.869630625152731e+00 9.159729771859715e+03 + 196580 1.015615315155922e+00 -5.961011072904907e+00 -6.011173602004468e+00 3.885343947489878e+00 4.597302942773910e+00 9.251383080898193e+03 + 196600 9.805102370214637e-01 -5.946776819149309e+00 -6.069265175581814e+00 3.958615766271772e+00 4.255268668624435e+00 9.430879170386048e+03 + 196620 1.029964652562008e+00 -6.063341047901074e+00 -6.037461349333261e+00 3.354036757738375e+00 4.502641991785164e+00 9.332423949758762e+03 + 196640 1.007854952122786e+00 -6.073271327198606e+00 -6.023129330707247e+00 3.295624910160848e+00 4.583548013463110e+00 9.288205109033779e+03 + 196660 9.863193990583288e-01 -6.074665220235833e+00 -6.024149668923817e+00 3.250603602435604e+00 4.540671715325496e+00 9.291361080810797e+03 + 196680 9.112782263198529e-01 -5.984865063030747e+00 -6.010485917086636e+00 3.823316633633444e+00 4.676197724830176e+00 9.249269505523172e+03 + 196700 9.767864350966584e-01 -6.092836893426465e+00 -6.021345396612986e+00 3.173173728191611e+00 4.583688966167979e+00 9.282699101437358e+03 + 196720 9.252090462546205e-01 -6.019818772993522e+00 -5.985480012798076e+00 3.627309679390998e+00 4.824488154339212e+00 9.172509918057183e+03 + 196740 9.692097874625549e-01 -6.082938119993261e+00 -5.928433517626152e+00 3.277735657938218e+00 5.164924994240101e+00 8.998645847964159e+03 + 196760 9.615295905077944e-01 -6.062552192151873e+00 -5.928436945389441e+00 3.402403288970505e+00 5.172513790147756e+00 8.998657873479819e+03 + 196780 9.977560858939010e-01 -6.102184763880998e+00 -5.980059792862673e+00 3.114914034033379e+00 4.816174516398789e+00 9.155934902051180e+03 + 196800 9.675207016624822e-01 -6.039843280306894e+00 -6.002095199909910e+00 3.474149675627556e+00 4.690904994763605e+00 9.223485481145588e+03 + 196820 9.638818696861348e-01 -6.017246308335776e+00 -6.041356952476862e+00 3.635968278757683e+00 4.497521228989442e+00 9.344453432519334e+03 + 196840 9.845313428514493e-01 -6.032814341817515e+00 -5.994484748412670e+00 3.491016320259656e+00 4.711110777075685e+00 9.200125620177883e+03 + 196860 9.775141694748302e-01 -6.004681469969341e+00 -5.941306427321474e+00 3.679382826208122e+00 5.043292128348329e+00 9.037743006840519e+03 + 196880 9.470717791762979e-01 -5.937092312029226e+00 -6.003340955140673e+00 4.015598765879453e+00 4.635188805189141e+00 9.227283704393325e+03 + 196900 1.041305202265814e+00 -6.052782919192036e+00 -5.977833175729330e+00 3.354954828065854e+00 4.785327853464030e+00 9.149116339519176e+03 + 196920 1.006554410730470e+00 -5.982003884302880e+00 -6.027482130148678e+00 3.782827148589351e+00 4.521684023206984e+00 9.301591837631777e+03 + 196940 1.036517480273102e+00 -6.009718335793380e+00 -6.000085040720283e+00 3.678765604840485e+00 4.734081475897803e+00 9.217303855736047e+03 + 196960 1.019830546584941e+00 -5.971056096146942e+00 -5.998844138747987e+00 3.872200881737766e+00 4.712637640936871e+00 9.213494715759080e+03 + 196980 1.059778467145453e+00 -6.017628757349546e+00 -6.009881207823598e+00 3.638145379491315e+00 4.682633007798721e+00 9.247410350768210e+03 + 197000 1.087866225725763e+00 -6.050110833842114e+00 -6.052689843081360e+00 3.401598535427826e+00 4.386789465275683e+00 9.379522645689653e+03 + 197020 9.952247096938055e-01 -5.912448110081366e+00 -6.058346125850791e+00 4.090589548265740e+00 4.252820564072723e+00 9.397022947566409e+03 + 197040 1.036299814653037e+00 -5.976396498780574e+00 -6.009026458459568e+00 3.852580110947072e+00 4.665213833000347e+00 9.244759199028014e+03 + 197060 1.062549535261439e+00 -6.022710484788391e+00 -5.988841610995904e+00 3.581569170025671e+00 4.776049484533408e+00 9.182813412472669e+03 + 197080 9.821659609422909e-01 -5.914985821582271e+00 -6.030221719868052e+00 4.146131838998538e+00 4.484429478343958e+00 9.310049213503347e+03 + 197100 9.833750573263563e-01 -5.936797837007573e+00 -6.012680831294200e+00 4.042183425266504e+00 4.606451529217276e+00 9.256014601442441e+03 + 197120 1.018590784121291e+00 -6.021542108669974e+00 -6.010925624776585e+00 3.575696881275249e+00 4.636658374686663e+00 9.250621654186678e+03 + 197140 9.970257086326541e-01 -6.038824266224516e+00 -5.980147130418392e+00 3.479536808579721e+00 4.816470002635906e+00 9.156210517239904e+03 + 197160 9.447318746727433e-01 -6.017195603286956e+00 -6.016745222234792e+00 3.584175642107418e+00 4.586761799805185e+00 9.268496888240523e+03 + 197180 9.211466053213765e-01 -6.028823342983472e+00 -5.979792192031918e+00 3.532058871993285e+00 4.813603328303194e+00 9.155123515840092e+03 + 197200 8.972494171421812e-01 -6.024642149058459e+00 -6.016584316939118e+00 3.595895901142344e+00 4.642165220117089e+00 9.268038235118700e+03 + 197220 9.450035844020773e-01 -6.113877129568417e+00 -6.015179657889069e+00 3.076326509148350e+00 4.643062664915547e+00 9.263711814178168e+03 + 197240 9.248491484687311e-01 -6.092100876280478e+00 -5.994803091156780e+00 3.214246804306167e+00 4.772945743270028e+00 9.201123057850760e+03 + 197260 8.928805766595573e-01 -6.044804932982550e+00 -5.996976111315328e+00 3.449084093700811e+00 4.723724589200234e+00 9.207777746159645e+03 + 197280 9.429077659103208e-01 -6.111393848038091e+00 -5.993536001255046e+00 3.132634409886822e+00 4.809392404557910e+00 9.197225727154786e+03 + 197300 9.337250573038549e-01 -6.083429067092582e+00 -6.016055751978173e+00 3.243997730927900e+00 4.630865732301656e+00 9.266405399200301e+03 + 197320 9.347213220383986e-01 -6.065103715947722e+00 -5.991102165433047e+00 3.375319516833337e+00 4.800247871591535e+00 9.189769108818811e+03 + 197340 9.107954466508693e-01 -6.004173921937875e+00 -6.043437290057229e+00 3.664521986304679e+00 4.439065650576774e+00 9.350867034514349e+03 + 197360 1.000959050434747e+00 -6.109636352317988e+00 -5.969448327709875e+00 3.152836216235806e+00 4.957817547562286e+00 9.123488371583759e+03 + 197380 9.181909692959097e-01 -5.957218413043210e+00 -5.974844745099697e+00 3.886926324612274e+00 4.785713198277863e+00 9.140015350136366e+03 + 197400 1.013551262009398e+00 -6.069090447568509e+00 -5.969577980785264e+00 3.325859474138235e+00 4.897275457912093e+00 9.123903635765693e+03 + 197420 9.665649579516111e-01 -5.973397562741050e+00 -6.009234123900441e+00 3.825272487953096e+00 4.619493408085955e+00 9.245390633875952e+03 + 197440 9.616431774203565e-01 -5.947113579012772e+00 -5.975488376721257e+00 3.988659396710443e+00 4.825726917282568e+00 9.141934569131077e+03 + 197460 1.007990109517695e+00 -5.998586268605723e+00 -5.987620754028715e+00 3.668982175962272e+00 4.731947857571353e+00 9.179065280914945e+03 + 197480 9.938987022393959e-01 -5.963728969179312e+00 -5.984372193422512e+00 3.915857761961960e+00 4.797321173828871e+00 9.169121130510450e+03 + 197500 9.952069392280736e-01 -5.954430211427869e+00 -5.994279088491001e+00 3.946957165347160e+00 4.718138746656861e+00 9.199491723787800e+03 + 197520 1.025447261308761e+00 -5.989867834344991e+00 -6.049223240490740e+00 3.684163329045925e+00 4.343335401737615e+00 9.368770378888914e+03 + 197540 1.027316325832084e+00 -5.987938049405289e+00 -6.058175237343848e+00 3.728658440719781e+00 4.325345638406865e+00 9.396492475419753e+03 + 197560 1.045769849547193e+00 -6.016628055253443e+00 -6.009281311388126e+00 3.604949197449734e+00 4.647135337629328e+00 9.245565493440867e+03 + 197580 1.024641324665733e+00 -5.989857020866583e+00 -6.031799823317945e+00 3.719888006544131e+00 4.479045944240707e+00 9.314894048358636e+03 + 197600 9.948405832165920e-01 -5.951510362109664e+00 -5.983714879364257e+00 4.008625524539507e+00 4.823702202830694e+00 9.167116640824519e+03 + 197620 1.043726248494387e+00 -6.029377088965027e+00 -6.009141941235067e+00 3.534119241531021e+00 4.650312591175439e+00 9.245127395663467e+03 + 197640 1.059417637946556e+00 -6.062234915669706e+00 -6.037257552720386e+00 3.322290079912379e+00 4.465713963201797e+00 9.331790239706390e+03 + 197660 1.000538947446706e+00 -5.988161779770518e+00 -6.014546815993135e+00 3.780166266949874e+00 4.628659305888449e+00 9.261765968774540e+03 + 197680 9.505265149528022e-01 -5.930454508792954e+00 -6.047518601362722e+00 4.091196182037317e+00 4.418996046891930e+00 9.363474167439092e+03 + 197700 9.136420130454131e-01 -5.893941253697677e+00 -6.076443531832822e+00 4.212581030291268e+00 4.164624707103003e+00 9.453203614226817e+03 + 197720 9.716452206084153e-01 -6.001406764287977e+00 -6.011959986280830e+00 3.704474574078925e+00 4.643876340290136e+00 9.253811256246727e+03 + 197740 9.537756770372696e-01 -6.000305991416917e+00 -5.982823644112180e+00 3.743477037882249e+00 4.843863381490547e+00 9.164386603497553e+03 + 197760 9.672931133405581e-01 -6.049787007711215e+00 -5.943046923041340e+00 3.463941548993556e+00 5.076859633142698e+00 9.043017810722262e+03 + 197780 9.504061808160099e-01 -6.055533068388716e+00 -5.953924918764353e+00 3.415189109732583e+00 4.998638828686008e+00 9.076135766432890e+03 + 197800 9.350545847192464e-01 -6.066147910984273e+00 -6.022650869675914e+00 3.324287857839802e+00 4.574054600177790e+00 9.286708597365907e+03 + 197820 9.064920753727723e-01 -6.057608790851518e+00 -5.992625730262431e+00 3.364237131816541e+00 4.737379921815201e+00 9.194438381228259e+03 + 197840 9.562194732190428e-01 -6.160755711073429e+00 -5.992896580723779e+00 2.850849871290338e+00 4.814722973874501e+00 9.195268774079248e+03 + 197860 9.619619601774402e-01 -6.196128941061715e+00 -5.961194702955090e+00 2.664129871842813e+00 5.013158623006900e+00 9.098324974539973e+03 + 197880 8.747175519464750e-01 -6.087925850515919e+00 -5.955731405007326e+00 3.247647565235023e+00 5.006728528369695e+00 9.081644008419016e+03 + 197900 8.321548273458380e-01 -6.033995138826964e+00 -5.970506748500067e+00 3.487542083424376e+00 4.852102245478072e+00 9.126741618580003e+03 + 197920 9.421788162219494e-01 -6.194522337021407e+00 -5.950983428183675e+00 2.688808259573325e+00 5.087246361643926e+00 9.067190741583783e+03 + 197940 8.489872485602420e-01 -6.039832441017881e+00 -5.982096814521033e+00 3.462743177183030e+00 4.794270079087252e+00 9.162178741936470e+03 + 197960 8.975913981917948e-01 -6.078772082083197e+00 -5.990837072444972e+00 3.266814006259232e+00 4.771750439500682e+00 9.188945307323582e+03 + 197980 9.596673566466472e-01 -6.114853329752729e+00 -6.000387258635163e+00 3.053105729529817e+00 4.710387623454138e+00 9.218251550122932e+03 + 198000 9.628984841871359e-01 -6.060647187915722e+00 -5.992346759922613e+00 3.375175481157961e+00 4.767367108151464e+00 9.193597551092174e+03 + 198020 1.063591312428472e+00 -6.165053985873827e+00 -5.956633223368648e+00 2.842111542876408e+00 5.038895814189910e+00 9.084404677348039e+03 + 198040 9.742946147218073e-01 -6.002920189415740e+00 -5.979075146049471e+00 3.701343329704074e+00 4.838265258721728e+00 9.152914723735114e+03 + 198060 9.452556951838758e-01 -5.939057668446917e+00 -5.947859659620867e+00 4.087651155160527e+00 5.037108759735974e+00 9.057655138683424e+03 + 198080 9.914354251396262e-01 -5.990274338935600e+00 -5.944957353616624e+00 3.710150568762728e+00 4.970367711245100e+00 9.048804454086483e+03 + 198100 1.007891810846757e+00 -5.997347872770734e+00 -5.957401625806985e+00 3.718511323509456e+00 4.947888855237045e+00 9.086724847525280e+03 + 198120 1.008519921498139e+00 -5.980795036971089e+00 -6.031200768488663e+00 3.785618653620818e+00 4.496181142985165e+00 9.313060908025178e+03 + 198140 9.944802289907780e-01 -5.946512166478981e+00 -6.017712871472882e+00 3.941535363791742e+00 4.532689897443277e+00 9.271509865359794e+03 + 198160 1.022048680283345e+00 -5.976725881186028e+00 -6.040523217264704e+00 3.803852970221724e+00 4.437518793852112e+00 9.341858431105984e+03 + 198180 1.036483595567536e+00 -5.992347394508426e+00 -6.022640183692157e+00 3.737179221867581e+00 4.563233338580622e+00 9.286675140810505e+03 + 198200 9.939294650977639e-01 -5.925743091689836e+00 -6.061828054030014e+00 4.099657585813675e+00 4.318236672976504e+00 9.407819078104629e+03 + 198220 1.091431651609032e+00 -6.070752880516344e+00 -5.994901750431593e+00 3.338653979521939e+00 4.774202906393027e+00 9.201404798889002e+03 + 198240 1.039312334683389e+00 -5.997317976924388e+00 -6.012213407178908e+00 3.671092920689600e+00 4.585561055107765e+00 9.254574954326979e+03 + 198260 9.946654879860215e-01 -5.937556788342109e+00 -6.017969073194935e+00 4.048190805331084e+00 4.586451021945291e+00 9.272309153497896e+03 + 198280 1.047995695570773e+00 -6.027713034648081e+00 -5.980230758999721e+00 3.549674652511009e+00 4.822325227142307e+00 9.156452465927299e+03 + 198300 1.052699430025746e+00 -6.048210784471575e+00 -6.002955659074358e+00 3.438769528001926e+00 4.698631461240765e+00 9.226138722723614e+03 + 198320 9.688758296127389e-01 -5.943687689467716e+00 -6.035649344141804e+00 3.955034344800880e+00 4.426976292642203e+00 9.326809866036298e+03 + 198340 1.022541098185601e+00 -6.045296620529220e+00 -5.997659455026600e+00 3.426051619224081e+00 4.699591595367659e+00 9.209866805734659e+03 + 198360 1.013587727822711e+00 -6.058047565674674e+00 -6.000653992623605e+00 3.416232029702295e+00 4.745794807788259e+00 9.219044880343310e+03 + 198380 8.776914810592665e-01 -5.882968025979028e+00 -5.989177805756103e+00 4.344733032506587e+00 4.734860041116318e+00 9.183845579291268e+03 + 198400 9.399338613663344e-01 -5.997770260904317e+00 -5.992222023774770e+00 3.751767757420519e+00 4.783626593605300e+00 9.193130451538545e+03 + 198420 9.510216201676326e-01 -6.033516721460382e+00 -5.977919904724008e+00 3.492706126195917e+00 4.811951651475763e+00 9.149355214785730e+03 + 198440 9.575596482066964e-01 -6.058404249342193e+00 -5.983210802085194e+00 3.364234028941637e+00 4.796006439239680e+00 9.165567632623439e+03 + 198460 9.469661833664313e-01 -6.054741440885420e+00 -5.976860033841709e+00 3.360735382725997e+00 4.807942474079773e+00 9.146148795525183e+03 + 198480 9.205644693643100e-01 -6.022211942311505e+00 -5.959006992353511e+00 3.615358766017073e+00 4.978291369610268e+00 9.091630336856837e+03 + 198500 9.602195321752535e-01 -6.081418407666621e+00 -5.965534480537926e+00 3.231907593933849e+00 4.897331036486582e+00 9.111539150733250e+03 + 198520 9.543685781069688e-01 -6.065733982061526e+00 -5.964457639495851e+00 3.353882744850391e+00 4.935427176325859e+00 9.108254309173606e+03 + 198540 9.801376563841013e-01 -6.086339648807977e+00 -5.955002958667776e+00 3.267190307167815e+00 5.021345906239965e+00 9.079426948620256e+03 + 198560 1.001353231299162e+00 -6.086001600918469e+00 -5.960014484700064e+00 3.255404758568124e+00 4.978842276337428e+00 9.094705499276521e+03 + 198580 1.013793436303187e+00 -6.058868512751597e+00 -5.972271750157815e+00 3.360089578870077e+00 4.857341590489274e+00 9.132112982330653e+03 + 198600 9.382127627346599e-01 -5.893120743656720e+00 -6.014385922564192e+00 4.274078131770974e+00 4.577754708758484e+00 9.261233267652397e+03 + 198620 9.791896129990146e-01 -5.903203817361431e+00 -6.012041428944842e+00 4.230321405827615e+00 4.605358997549710e+00 9.254049742054543e+03 + 198640 1.040101711211262e+00 -5.953584458515397e+00 -6.030114421632332e+00 3.890609529334399e+00 4.451162638143447e+00 9.309735123585824e+03 + 198660 1.073502489133408e+00 -5.979645541362601e+00 -6.028466916866151e+00 3.787901410208299e+00 4.507561516983468e+00 9.304653633407443e+03 + 198680 1.001488517381944e+00 -5.862965709341985e+00 -6.054229813650651e+00 4.433528991787151e+00 4.335260906822306e+00 9.384267693906222e+03 + 198700 9.653453709591486e-01 -5.806466718580577e+00 -6.027741523755282e+00 4.798667655332317e+00 4.528073481853730e+00 9.302372722921566e+03 + 198720 1.089862916088797e+00 -5.991362551258456e+00 -6.016559573828363e+00 3.719237708213714e+00 4.574552505390663e+00 9.267947241663262e+03 + 198740 1.074647670704674e+00 -5.976759224544218e+00 -5.984856686447376e+00 3.926595778449924e+00 4.880098899123810e+00 9.170601153538933e+03 + 198760 1.024595553801952e+00 -5.914481543029816e+00 -6.016363424759256e+00 4.220843950815384e+00 4.635822419754695e+00 9.267351675361424e+03 + 198780 1.040301868687808e+00 -5.954516164642564e+00 -6.041887285459937e+00 3.985707012350834e+00 4.484008515980230e+00 9.346091115018129e+03 + 198800 9.268248803264314e-01 -5.808683593327189e+00 -6.112668968366199e+00 4.702460105542665e+00 3.956929040483913e+00 9.566173314461343e+03 + 198820 1.043616179987061e+00 -6.010909924152204e+00 -6.056828965085332e+00 3.624734943758010e+00 4.361060704771374e+00 9.392323771006913e+03 + 198840 9.974703210282363e-01 -5.974531900468828e+00 -6.032309698045626e+00 3.784751083812432e+00 4.452982029041180e+00 9.316500753800274e+03 + 198860 9.617204533033882e-01 -5.950176758615055e+00 -6.024771060544092e+00 3.966742215316064e+00 4.538410190208619e+00 9.293239746157942e+03 + 198880 1.034272446172191e+00 -6.083498506444230e+00 -6.028682210535152e+00 3.221812872191052e+00 4.536576526095356e+00 9.305319608293303e+03 + 198900 9.567657983667074e-01 -5.992234741776585e+00 -6.023004768288084e+00 3.752637231384829e+00 4.575950977509589e+00 9.287810897233385e+03 + 198920 9.909439114340390e-01 -6.061833063974454e+00 -5.998561966772941e+00 3.413380083067317e+00 4.776692514369053e+00 9.212640604686629e+03 + 198940 9.318876708270594e-01 -5.986333209714253e+00 -5.995538533531874e+00 3.816403987877523e+00 4.763545593997485e+00 9.203335943978669e+03 + 198960 9.493821758106603e-01 -6.017935314200439e+00 -5.953408611112618e+00 3.636239332759810e+00 5.006761647365112e+00 9.074566218469419e+03 + 198980 1.018262657232479e+00 -6.118467218452872e+00 -5.983468966554721e+00 3.029045754606628e+00 4.804226607917773e+00 9.166374247732587e+03 + 199000 9.875875896218168e-01 -6.070905504619651e+00 -5.991426913529296e+00 3.323071242153216e+00 4.779449611466251e+00 9.190739817208707e+03 + 199020 9.721058819122163e-01 -6.042830617463405e+00 -5.986960266738362e+00 3.481263408070497e+00 4.802079607842529e+00 9.177072401986643e+03 + 199040 9.432280529116500e-01 -5.990196636472671e+00 -6.002557270580770e+00 3.751946998049983e+00 4.680970324199335e+00 9.224902679578991e+03 + 199060 9.807031422093141e-01 -6.035444028219263e+00 -5.985968417328162e+00 3.498720865357976e+00 4.782817479420718e+00 9.174031659324395e+03 + 199080 1.013545234686219e+00 -6.071576513127721e+00 -5.984687614569946e+00 3.396238919531455e+00 4.895168421063799e+00 9.170095166078969e+03 + 199100 9.995317748829399e-01 -6.038863456165707e+00 -5.994796339527912e+00 3.496224762611806e+00 4.749264965710287e+00 9.201073811324275e+03 + 199120 9.569438605606729e-01 -5.964863724097417e+00 -6.024148632539451e+00 3.879141459637709e+00 4.538718341053616e+00 9.291335059569286e+03 + 199140 1.043465808305374e+00 -6.084151197292503e+00 -5.970877625541311e+00 3.261252026653834e+00 4.911686404677758e+00 9.127871927196889e+03 + 199160 9.888466304859235e-01 -5.994698494594202e+00 -5.991821042735012e+00 3.779486533287518e+00 4.796009307147220e+00 9.191946821979931e+03 + 199180 1.038351433769356e+00 -6.060032889345124e+00 -5.972903461152788e+00 3.408641365130578e+00 4.908952025046413e+00 9.134075074344624e+03 + 199200 1.087042705658193e+00 -6.126547666689510e+00 -5.997310221469487e+00 3.061651520331414e+00 4.803752930214802e+00 9.208801849511990e+03 + 199220 9.357196934661954e-01 -5.899896573906688e+00 -6.041714389185898e+00 4.237988114199084e+00 4.423648272629880e+00 9.345548159151345e+03 + 199240 1.001999391504507e+00 -5.997688614709538e+00 -5.998886253556439e+00 3.744453246274875e+00 4.737576218681958e+00 9.213616955286139e+03 + 199260 9.741222560019579e-01 -5.954428673184900e+00 -6.009091823588172e+00 3.949633254469517e+00 4.635748985758749e+00 9.244958459576705e+03 + 199280 1.018995046919940e+00 -6.018645580825041e+00 -5.981151237033027e+00 3.665707003744082e+00 4.881005328028778e+00 9.159263627748211e+03 + 199300 9.523798101299401e-01 -5.918232667453390e+00 -5.998723135883461e+00 4.163542274049221e+00 4.701353548464017e+00 9.213109595715912e+03 + 199320 1.047474480588589e+00 -6.056307448133158e+00 -5.990589763484913e+00 3.443288105590085e+00 4.820649220619144e+00 9.188171568825132e+03 + 199340 1.052063333482815e+00 -6.061954723129742e+00 -5.995274675364363e+00 3.360298110510838e+00 4.743185263483689e+00 9.202556647255178e+03 + 199360 9.899399315649036e-01 -5.969841175554527e+00 -6.031105574437271e+00 3.837881644118959e+00 4.486091985099155e+00 9.312795952955328e+03 + 199380 1.045345255275729e+00 -6.054903517585581e+00 -6.000275517756035e+00 3.428601172163945e+00 4.742283600840854e+00 9.217917022324442e+03 + 199400 9.780104923920887e-01 -5.958423420917970e+00 -6.016396141193878e+00 3.865736483935700e+00 4.532848152861964e+00 9.267458321744127e+03 + 199420 9.694306975833765e-01 -5.949393899958658e+00 -6.034676514495618e+00 3.942958172837187e+00 4.453252202724016e+00 9.323803532354184e+03 + 199440 1.011138230619257e+00 -6.015121038088004e+00 -6.009321354178946e+00 3.625230601241597e+00 4.658533283745596e+00 9.245682356743368e+03 + 199460 9.823835158722997e-01 -5.976377539506453e+00 -6.001894201937834e+00 3.798620426431028e+00 4.652099802059292e+00 9.222862453835854e+03 + 199480 1.074562355574544e+00 -6.118486926125487e+00 -5.995296473648373e+00 3.016297520865714e+00 4.723676162650218e+00 9.202624643333613e+03 + 199500 9.926831596967829e-01 -6.005199868966562e+00 -6.000357663445108e+00 3.700903545492443e+00 4.728708238925513e+00 9.218133858751144e+03 + 199520 9.528151168241586e-01 -5.959418705000071e+00 -5.963065830859622e+00 3.901076693474031e+00 4.880134332397586e+00 9.104004014073711e+03 + 199540 9.557829809703990e-01 -5.977637161975556e+00 -5.991671870257975e+00 3.799602485859072e+00 4.719013019037336e+00 9.191491214806965e+03 + 199560 9.838846370790553e-01 -6.036655642150919e+00 -6.003509719541851e+00 3.458439215320582e+00 4.648768232256796e+00 9.227830722879620e+03 + 199580 9.843932648042784e-01 -6.058662065699025e+00 -6.020554801397395e+00 3.374629497019970e+00 4.593447305720019e+00 9.280268165956993e+03 + 199600 1.065184573658751e+00 -6.206851690895959e+00 -5.968086425263754e+00 2.610633649932813e+00 4.981660753998377e+00 9.119370099006041e+03 + 199620 9.388817486791809e-01 -6.048259703771625e+00 -6.004812660448888e+00 3.444013103007198e+00 4.693492749174577e+00 9.231822964740768e+03 + 199640 9.473654082682319e-01 -6.087966531003856e+00 -5.979134478052076e+00 3.195402416940680e+00 4.820332906695564e+00 9.153129876030411e+03 + 199660 9.210577256459164e-01 -6.068236326393697e+00 -5.967782053655758e+00 3.335152873111248e+00 4.911976852420958e+00 9.118414230427796e+03 + 199680 9.497229600007705e-01 -6.121910609110069e+00 -5.971990252219380e+00 3.092920192420396e+00 4.953786081786985e+00 9.131271875339731e+03 + 199700 9.516524276659803e-01 -6.127906301058084e+00 -6.000100462469979e+00 2.979286429490728e+00 4.713167332553232e+00 9.217372102518229e+03 + 199720 9.443608833647245e-01 -6.114016019953694e+00 -6.000580190700743e+00 3.091035310234930e+00 4.742401395943221e+00 9.218828712551509e+03 + 199740 8.681959517945045e-01 -5.990991490549361e+00 -5.977120027277696e+00 3.797772807366312e+00 4.877424896074221e+00 9.146908120580996e+03 + 199760 9.625155118642070e-01 -6.110458936060956e+00 -5.978494259332300e+00 3.124357089378134e+00 4.882118684621803e+00 9.151154400341169e+03 + 199780 9.848261985222230e-01 -6.112095588872020e+00 -5.980370944143631e+00 3.096964062230267e+00 4.853347356583562e+00 9.156887038258950e+03 + 199800 9.658504385268453e-01 -6.044741959287682e+00 -5.983150214559801e+00 3.514935168261291e+00 4.868604497780478e+00 9.165405595380049e+03 + 199820 9.830751481829464e-01 -6.030277382849008e+00 -6.003547531492968e+00 3.595906231692601e+00 4.749393174610113e+00 9.227958060577354e+03 + 199840 1.019195363692946e+00 -6.047159382563301e+00 -6.018232273751166e+00 3.484691277977978e+00 4.650795213232877e+00 9.273127872675630e+03 + 199860 1.009814556481902e+00 -6.004451936660288e+00 -6.029796701673096e+00 3.664786858860082e+00 4.519253296066829e+00 9.308739911114350e+03 + 199880 1.004112823631311e+00 -5.975808665464897e+00 -5.994508893678078e+00 3.866906624242725e+00 4.759527019991680e+00 9.200211087352904e+03 + 199900 1.017006687798344e+00 -5.979166475348716e+00 -6.024287631510320e+00 3.884200204963863e+00 4.625107543807584e+00 9.291749564292193e+03 + 199920 1.029645300704506e+00 -5.988407957108219e+00 -6.015604824463416e+00 3.792038397567344e+00 4.635869776512177e+00 9.265017077501841e+03 + 199940 1.016090771897235e+00 -5.963111834339648e+00 -5.964819076856839e+00 3.924983490607407e+00 4.915180239878768e+00 9.109359800541135e+03 + 199960 1.089150523107765e+00 -6.068080542656683e+00 -5.972503306663688e+00 3.396420435709163e+00 4.945239715310409e+00 9.132824214410233e+03 + 199980 9.700833243472550e-01 -5.891585904890412e+00 -6.005450837672986e+00 4.354796401538968e+00 4.700966336960025e+00 9.233789429481529e+03 + 200000 1.036656071639917e+00 -5.992403506639822e+00 -5.993257960485003e+00 3.764547892583718e+00 4.759641486378383e+00 9.196316925648398e+03 +Loop time of 380.886 on 1 procs for 200000 steps with 256 atoms + +Performance: 226839.823 tau/day, 525.092 timesteps/s +99.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 308.99 | 308.99 | 308.99 | 0.0 | 81.12 +Neigh | 22.559 | 22.559 | 22.559 | 0.0 | 5.92 +Comm | 5.1164 | 5.1164 | 5.1164 | 0.0 | 1.34 +Output | 41.166 | 41.166 | 41.166 | 0.0 | 10.81 +Modify | 2.379 | 2.379 | 2.379 | 0.0 | 0.62 +Other | | 0.6754 | | | 0.18 + +Nlocal: 256 ave 256 max 256 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 2125 ave 2125 max 2125 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 19131 ave 19131 max 19131 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 19131 +Ave neighs/atom = 74.7305 +Neighbor list builds = 19989 +Dangerous builds = 19886 +Total wall time: 0:06:54 diff --git a/examples/USER/hma/log.6Nov18.hma.g++.4 b/examples/USER/hma/log.6Nov18.hma.g++.4 new file mode 100644 index 0000000000..5b25fa5cf5 --- /dev/null +++ b/examples/USER/hma/log.6Nov18.hma.g++.4 @@ -0,0 +1,10159 @@ +LAMMPS (31 Aug 2018) +# Harmonically mapped average example + +units lj +dimension 3 +boundary p p p +atom_style atomic +atom_modify map array +# ---------- Create Atoms ---------------------------- +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874 1.5874 1.5874 +region box block 0 4 0 4 0 4 units lattice +create_box 1 box +Created orthogonal box = (0 0 0) to (6.3496 6.3496 6.3496) + 1 by 2 by 2 MPI processor grid +lattice fcc 1.0 orient x 1 0 0 orient y 0 1 0 orient z 0 0 1 +Lattice spacing in x,y,z = 1.5874 1.5874 1.5874 +create_atoms 1 region box +Created 256 atoms + Time spent = 0.000636816 secs +# ---------- Define Interatomic Potential --------------------- +pair_style lj/smooth/linear 3 +pair_coeff * * 1.0 1.0 +mass 1 1.0 + +atom_modify sort 0 1 +velocity all create 0.1 45678 dist gaussian + +compute u all pe + +compute p all pressure NULL pair + +compute hma all HMA settemp u p 9.579586686264458 cv + +timestep 0.005 + +fix settemp all nvt temp 1.0 1.0 0.5 +thermo_style custom elapsed temp c_u c_hma[1] c_p c_hma[2] c_hma[3] +thermo_modify format float '%22.15e' +thermo 500 +run 20000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 3.3 + ghost atom cutoff = 3.3 + binsize = 1.65, bins = 4 4 4 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair lj/smooth/linear, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard + (2) compute HMA, occasional, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 3.389 | 3.389 | 3.389 Mbytes +Elapsed Temp c_u c_hma[1] c_p c_hma[2] c_hma[3] + 0 9.999999999999999e-02 -7.321210550030622e+00 -5.827069925030622e+00 -3.541123363606526e+00 6.038463322657932e+00 8.693908581891272e+03 + 500 2.319904532047116e-01 -7.021814067268549e+00 -5.841520703728273e+00 -1.859554996730893e+00 5.917872146525079e+00 8.737041016754241e+03 + 1000 1.104889191155021e+00 -6.005326544560477e+00 -6.005300065747159e+00 3.645694884120414e+00 4.645846929564070e+00 9.233336265503700e+03 + 1500 9.475049376144361e-01 -6.133389836457317e+00 -5.983811791861923e+00 2.980778280706599e+00 4.839678559900945e+00 9.167450093661304e+03 + 2000 9.009354935012601e-01 -6.066361566415782e+00 -5.975649385751911e+00 3.331919983683387e+00 4.852803362719920e+00 9.142450653666589e+03 + 2500 1.002748731362028e+00 -6.037709705055500e+00 -5.998660236350431e+00 3.517524667487255e+00 4.741752759677512e+00 9.212938381713899e+03 + 3000 1.123087652951704e+00 -6.025819107168451e+00 -5.970493239986080e+00 3.598743028856235e+00 4.916432719867683e+00 9.126676463986189e+03 + 3500 1.115128009750835e+00 -6.000529470165528e+00 -5.980015761414576e+00 3.665878335379198e+00 4.783671225513338e+00 9.155782280210480e+03 + 4000 9.904879689205039e-01 -5.990830917252424e+00 -6.007049321999301e+00 3.700324729502504e+00 4.607196139655914e+00 9.238716127101230e+03 + 4500 9.696423790018132e-01 -6.095364960235830e+00 -5.949103254372231e+00 3.188999551316120e+00 5.028856900310743e+00 9.061471896280929e+03 + 5000 1.005681297563624e+00 -6.094938179693363e+00 -6.014945551672039e+00 3.140253069724724e+00 4.599583118642348e+00 9.263005212755274e+03 + 5500 1.067821663160412e+00 -6.055271652935048e+00 -6.039553220002009e+00 3.350955211546091e+00 4.441212885867230e+00 9.338870121131475e+03 + 6000 1.019349023817732e+00 -5.912735006243721e+00 -6.010199997355059e+00 4.160148455119939e+00 4.600489393500003e+00 9.248369562541713e+03 + 6500 1.033977564076081e+00 -5.962511500402099e+00 -5.953097811556573e+00 3.913955620678704e+00 4.968010478793357e+00 9.073605525336026e+03 + 7000 1.035036973336388e+00 -6.011513860495915e+00 -5.988661036457318e+00 3.570585392636366e+00 4.701809844729083e+00 9.182284012600518e+03 + 7500 9.759766417830451e-01 -6.011014245515786e+00 -5.997095489328838e+00 3.659421763886547e+00 4.739345415832561e+00 9.208142257833988e+03 + 8000 9.701274032979823e-01 -6.070706464001116e+00 -5.987899394187518e+00 3.293522632549048e+00 4.769013641771370e+00 9.179944973040452e+03 + 8500 1.002959574283594e+00 -6.000331246180245e+00 -6.022939013616290e+00 3.707537441996905e+00 4.577720142838428e+00 9.287619492673581e+03 + 9000 9.541471061067928e-01 -5.891837375294362e+00 -6.000893913894259e+00 4.214373867383508e+00 4.588154346298096e+00 9.219760426705488e+03 + 9500 1.005476043930556e+00 -6.054397260431607e+00 -5.963822185829731e+00 3.425817325831102e+00 4.945913420642570e+00 9.106317976320150e+03 + 10000 9.834510517532772e-01 -5.979858570968017e+00 -6.007829122692488e+00 3.832487507111145e+00 4.671876270680338e+00 9.241093007564954e+03 + 10500 1.053423257346257e+00 -5.984863687481322e+00 -5.990560458118040e+00 3.742155897948207e+00 4.709444159379769e+00 9.188099433599265e+03 + 11000 1.027766819783240e+00 -5.964303012082833e+00 -5.987340607292543e+00 3.942276092974025e+00 4.809990656223532e+00 9.178213465454402e+03 + 11500 1.030919611642090e+00 -5.996031790431708e+00 -6.010813071174461e+00 3.713452645350145e+00 4.628576243929453e+00 9.250277317464830e+03 + 12000 1.015499044847646e+00 -5.983611533298556e+00 -6.000577066405612e+00 3.747611330243804e+00 4.650192613735324e+00 9.218807640515772e+03 + 12500 9.260784226173562e-01 -5.995616138164384e+00 -6.024603077235440e+00 3.708688522431407e+00 4.542241032571079e+00 9.292727745364478e+03 + 13000 9.581084725650251e-01 -6.095817502268568e+00 -5.989303506622369e+00 3.230806633332333e+00 4.842426479320365e+00 9.184229513868806e+03 + 13500 9.246476920572243e-01 -5.986197290479123e+00 -5.980486024616446e+00 3.778398028002328e+00 4.811193000401358e+00 9.157208321147285e+03 + 14000 9.018834156590910e-01 -5.891981523518482e+00 -5.961281643266227e+00 4.310640039569481e+00 4.912708027819059e+00 9.098571305044385e+03 + 14500 9.458192412990540e-01 -5.924212527125402e+00 -5.974831040418032e+00 4.099524287456710e+00 4.808864950940809e+00 9.139925423823777e+03 + 15000 1.079258475602827e+00 -5.842389291052847e+00 -5.997594135488276e+00 4.542013464261510e+00 4.650803229641226e+00 9.209631946001080e+03 + 15500 1.003773905363782e+00 -5.990536501227417e+00 -5.978949148782005e+00 3.711448614654375e+00 4.777984985532921e+00 9.152543385133793e+03 + 16000 9.589971646383746e-01 -6.022404990638810e+00 -6.013121691584658e+00 3.591520611305744e+00 4.644826751060574e+00 9.257382394405931e+03 + 16500 1.027873542611377e+00 -6.062068879792612e+00 -5.995808570227100e+00 3.344041739290934e+00 4.724518690565871e+00 9.204185610519249e+03 + 17000 9.721883229756479e-01 -6.076377536863534e+00 -5.995495525201934e+00 3.317173564950596e+00 4.781610592362355e+00 9.203227919920830e+03 + 17500 9.870692120707141e-01 -5.965983792560558e+00 -6.036111701999152e+00 3.838886592024325e+00 4.436201283769008e+00 9.328234074356338e+03 + 18000 1.004272604822617e+00 -5.960763698221652e+00 -5.980795290630440e+00 3.950710186832507e+00 4.835685683342340e+00 9.158184493996429e+03 + 18500 9.381056200232580e-01 -5.953631223909241e+00 -6.011057530919335e+00 3.898044457090124e+00 4.568293715545873e+00 9.251034889270257e+03 + 19000 9.369931263537112e-01 -6.012014674095721e+00 -5.987682214265706e+00 3.582518713971043e+00 4.722239463750979e+00 9.179299635700279e+03 + 19500 9.837184187823201e-01 -5.957066902345472e+00 -6.012125787465584e+00 3.937810342708973e+00 4.621653704014352e+00 9.254320960371275e+03 + 20000 1.079101865720838e+00 -6.089503178102808e+00 -5.960131548856806e+00 3.215696838220799e+00 4.958568753546265e+00 9.095068306811330e+03 +Loop time of 4.841 on 4 procs for 20000 steps with 256 atoms + +Performance: 1784755.120 tau/day, 4131.378 timesteps/s +98.7% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 2.3889 | 2.6923 | 3.0228 | 14.4 | 55.62 +Neigh | 0.52899 | 0.5489 | 0.57081 | 2.3 | 11.34 +Comm | 1.0419 | 1.3856 | 1.697 | 20.8 | 28.62 +Output | 0.022234 | 0.022308 | 0.022518 | 0.1 | 0.46 +Modify | 0.13626 | 0.14418 | 0.15704 | 2.2 | 2.98 +Other | | 0.04763 | | | 0.98 + +Nlocal: 64 ave 68 max 60 min +Histogram: 1 1 0 0 0 0 0 0 1 1 +Nghost: 1344.25 ave 1352 max 1339 min +Histogram: 1 0 0 2 0 0 0 0 0 1 +Neighs: 4758 ave 5243 max 3935 min +Histogram: 1 0 0 0 0 0 1 0 1 1 + +Total # of neighbors = 19032 +Ave neighs/atom = 74.3438 +Neighbor list builds = 1938 +Dangerous builds = 1898 +thermo 20 +run 200000 +Per MPI rank memory allocation (min/avg/max) = 3.771 | 3.771 | 3.771 Mbytes +Elapsed Temp c_u c_hma[1] c_p c_hma[2] c_hma[3] + 0 1.079101865720838e+00 -6.089503178102806e+00 -5.960131548856804e+00 3.215696838220800e+00 4.958568753546269e+00 9.095068306811325e+03 + 20 1.045882952900159e+00 -6.018338283555533e+00 -5.972366139305224e+00 3.616958874311578e+00 4.880938040763178e+00 9.132383004784513e+03 + 40 1.023416907678504e+00 -5.967053445329114e+00 -5.982864893458127e+00 3.888481015323551e+00 4.797689233353067e+00 9.164513217016609e+03 + 60 9.899033883056040e-01 -5.902992198654239e+00 -5.995283741619580e+00 4.218205169077458e+00 4.688252847300357e+00 9.202566117085955e+03 + 80 1.077050480328796e+00 -6.019809533578615e+00 -6.001598077962455e+00 3.565599069062933e+00 4.670172065424577e+00 9.221945457239293e+03 + 100 1.080384560249323e+00 -6.016438905244236e+00 -6.024415917706303e+00 3.607676959151043e+00 4.561871719155161e+00 9.292169644904860e+03 + 120 9.997046598216068e-01 -5.896119196502427e+00 -6.046186059637260e+00 4.218098095544917e+00 4.356390944652691e+00 9.359373348945550e+03 + 140 1.078735984732703e+00 -6.019266040588759e+00 -6.034332020308546e+00 3.590176101522915e+00 4.503664914519074e+00 9.322748132452190e+03 + 160 9.760415116951116e-01 -5.879721306575083e+00 -6.054494533913690e+00 4.331789309870658e+00 4.328214392422853e+00 9.385084700332845e+03 + 180 1.031538652705958e+00 -5.980163604486879e+00 -6.034579522560372e+00 3.780608517952989e+00 4.468143895538888e+00 9.323487886411000e+03 + 200 1.056471731975392e+00 -6.039286251806756e+00 -5.961205747060128e+00 3.529192708205122e+00 4.977543049379323e+00 9.098340498472173e+03 + 220 1.018770273422817e+00 -6.011576467489766e+00 -5.956325424998603e+00 3.639782521372246e+00 4.957042557427693e+00 9.083454391480973e+03 + 240 1.042819636360988e+00 -6.078833887266810e+00 -5.924026301164385e+00 3.316341825846475e+00 5.205270941643121e+00 8.985297958019297e+03 + 260 9.827038416572660e-01 -6.025801008390236e+00 -5.973596229242497e+00 3.552269333175087e+00 4.852037253704874e+00 9.136147448449266e+03 + 280 9.330683939380402e-01 -5.987241712695330e+00 -5.981808536495530e+00 3.776217634541064e+00 4.807415773061615e+00 9.161283472448169e+03 + 300 9.367212503823726e-01 -6.023294771844806e+00 -5.980308288453488e+00 3.522452586519692e+00 4.769287626289448e+00 9.156676177175032e+03 + 320 8.866502119132115e-01 -5.971552725763028e+00 -5.999883540078049e+00 3.832954064130393e+00 4.670274144154201e+00 9.216690919308339e+03 + 340 9.812173419090766e-01 -6.127345466738726e+00 -5.971758235372432e+00 3.042675332936083e+00 4.936081292487585e+00 9.130565671999488e+03 + 360 9.701678838757176e-01 -6.123214162223682e+00 -5.956471391747523e+00 3.024346518793122e+00 4.981809310227565e+00 9.083925283172193e+03 + 380 9.530521608125605e-01 -6.101948718277182e+00 -5.969346784103942e+00 3.160159309894476e+00 4.921580136000209e+00 9.123183696589322e+03 + 400 9.257718531546387e-01 -6.058094727447953e+00 -6.005990817706857e+00 3.375612369879977e+00 4.674801082667322e+00 9.235454101684938e+03 + 420 9.378475032879857e-01 -6.063808619486702e+00 -6.039127865978216e+00 3.321015355026043e+00 4.462736061006034e+00 9.337565742684808e+03 + 440 9.868229541930312e-01 -6.115563509613311e+00 -6.006885830025272e+00 3.048783352987000e+00 4.672827406998083e+00 9.238210334985924e+03 + 460 9.566601962627783e-01 -6.040790766879258e+00 -5.996276961059726e+00 3.432349289595275e+00 4.687954451100221e+00 9.205623814062721e+03 + 480 9.859778191204607e-01 -6.032992456497698e+00 -6.004207130185696e+00 3.562741803657827e+00 4.728031601856195e+00 9.229978972138921e+03 + 500 1.051590614980880e+00 -6.055418879049184e+00 -5.975387332570744e+00 3.412139370691222e+00 4.871692895412218e+00 9.141625620994606e+03 + 520 1.016928028177617e+00 -5.934484344864495e+00 -5.988482020119943e+00 4.036280150584107e+00 4.726217143154087e+00 9.181703401118843e+03 + 540 1.021626621375652e+00 -5.896726491861172e+00 -6.042286195219953e+00 4.211849774755440e+00 4.376023432778024e+00 9.347266091640566e+03 + 560 1.057963649785121e+00 -5.930514935075140e+00 -5.994193066656623e+00 4.133424884461160e+00 4.767775198761271e+00 9.199220503239567e+03 + 580 1.126457484615616e+00 -6.025302767770825e+00 -6.002248753792481e+00 3.577314302596564e+00 4.709694018457352e+00 9.223950233643571e+03 + 600 1.053775583014867e+00 -5.920880666414229e+00 -6.025321044401184e+00 4.089562432812162e+00 4.489849620314809e+00 9.294932166324394e+03 + 620 1.068125791364220e+00 -5.952048336294525e+00 -5.991548889906705e+00 3.948582501628295e+00 4.721764210096242e+00 9.191125075855618e+03 + 640 1.001917999683921e+00 -5.868889196279280e+00 -6.078442481513278e+00 4.387667520056008e+00 4.184380127976309e+00 9.459397710993178e+03 + 660 1.013785745023234e+00 -5.908440588408116e+00 -6.021185701862593e+00 4.194475718233535e+00 4.547075829528006e+00 9.282200503824031e+03 + 680 1.006272102195670e+00 -5.922361783809079e+00 -6.015315424402591e+00 4.108572526673648e+00 4.574818337856310e+00 9.264102856651089e+03 + 700 1.050062861284214e+00 -6.012992437584885e+00 -6.015529119993223e+00 3.635097335980956e+00 4.620531313041945e+00 9.264804219762771e+03 + 720 1.045358840625471e+00 -6.037807695505035e+00 -6.027135304464126e+00 3.474817177730830e+00 4.536099698634905e+00 9.300555520485419e+03 + 740 9.642925485448076e-01 -5.948158503381118e+00 -6.034972091799299e+00 4.003503145179767e+00 4.505006086123185e+00 9.324713510866124e+03 + 760 9.675102936861227e-01 -5.982924400760570e+00 -6.015096232174412e+00 3.870382414802911e+00 4.685646780249812e+00 9.263451837988561e+03 + 780 9.790720662584512e-01 -6.026047065185467e+00 -5.979529232557102e+00 3.625058207440162e+00 4.892170801003571e+00 9.154322435131195e+03 + 800 1.004123930050531e+00 -6.082912408400262e+00 -5.968506093674343e+00 3.259659032213952e+00 4.916597795690173e+00 9.120630367341679e+03 + 820 1.004543182217278e+00 -6.098101606885474e+00 -5.980350258056370e+00 3.164901910898681e+00 4.841048377837739e+00 9.156849592436240e+03 + 840 9.630748088451148e-01 -6.048903166205694e+00 -5.994027918620555e+00 3.392810786130890e+00 4.707912949681882e+00 9.198714740374367e+03 + 860 9.228861378211657e-01 -5.996861888124024e+00 -6.008496153064605e+00 3.703560501505661e+00 4.636754751820165e+00 9.243110577356250e+03 + 880 9.651481015705456e-01 -6.061582878325297e+00 -5.953924133351292e+00 3.391579294709795e+00 5.009772468487476e+00 9.076133332861597e+03 + 900 9.348983371800531e-01 -6.011608836096201e+00 -5.995661702368822e+00 3.600911181002898e+00 4.692482090676478e+00 9.203743757888953e+03 + 920 1.036896738232031e+00 -6.151779143268755e+00 -5.937278934425017e+00 2.942196267685299e+00 5.173889660666077e+00 9.025521017635112e+03 + 940 9.705242919454212e-01 -6.036396171757210e+00 -6.007701602226906e+00 3.498512079639252e+00 4.663280738352547e+00 9.240700537524001e+03 + 960 9.703590513777164e-01 -6.015671221414300e+00 -5.958550157140520e+00 3.653576696163561e+00 4.981574686679732e+00 9.090248498660674e+03 + 980 1.022109298884103e+00 -6.064126871372943e+00 -5.994058900431912e+00 3.333754888286173e+00 4.736096020413037e+00 9.198811725431875e+03 + 1000 9.685007477272927e-01 -5.947157585823188e+00 -6.028697640132853e+00 3.910210723383799e+00 4.441995113255079e+00 9.305381841761822e+03 + 1020 1.008136117042101e+00 -5.967693663042624e+00 -6.031031238423907e+00 3.855538252977954e+00 4.491844093680513e+00 9.312561366234242e+03 + 1040 1.107445497004232e+00 -6.079939803816606e+00 -5.987270852102483e+00 3.255889721065741e+00 4.788009182282165e+00 9.178015036361758e+03 + 1060 1.044758630971925e+00 -5.958437495305702e+00 -6.013937506863499e+00 3.914339676403526e+00 4.595650021439628e+00 9.259867433592528e+03 + 1080 1.035880587544461e+00 -5.922449944887129e+00 -6.033637939351922e+00 4.066129013791143e+00 4.427670343287764e+00 9.320588435674486e+03 + 1100 9.751140198525383e-01 -5.818558920459956e+00 -6.080906309495900e+00 4.694663995350776e+00 4.188224689379140e+00 9.467068759704607e+03 + 1120 1.067993684112638e+00 -5.951955232026927e+00 -6.021480919464405e+00 3.976881891871271e+00 4.577654635539909e+00 9.283099457617489e+03 + 1140 1.035716301260880e+00 -5.907061488350916e+00 -5.987039157900400e+00 4.180855135543586e+00 4.721610980486084e+00 9.177290886449660e+03 + 1160 1.019375948323584e+00 -5.886370518000196e+00 -6.028553863042942e+00 4.262813756746125e+00 4.446374986709141e+00 9.304925235198898e+03 + 1180 1.093380159162734e+00 -6.005503518747864e+00 -6.027072672089359e+00 3.641764885299509e+00 4.517911468996958e+00 9.300367982427439e+03 + 1200 1.042582047788811e+00 -5.946489662612521e+00 -6.037144910525036e+00 4.039402242433351e+00 4.518845780065416e+00 9.331413378313986e+03 + 1220 9.663542177685119e-01 -5.850641497244586e+00 -6.039704867708192e+00 4.486145434613865e+00 4.400514303949820e+00 9.339315441642380e+03 + 1240 1.029347247685795e+00 -5.959706239835747e+00 -5.999980184600757e+00 3.952447527563560e+00 4.721188304350065e+00 9.216989638017812e+03 + 1260 1.056078831132393e+00 -6.013384114236571e+00 -6.006253875724207e+00 3.560314479129267e+00 4.601257412068100e+00 9.236281130215775e+03 + 1280 9.804605261528435e-01 -5.913173019151906e+00 -6.048673912743030e+00 4.129404127893233e+00 4.351337028197486e+00 9.367090226916964e+03 + 1300 1.002428567847763e+00 -5.956218706909874e+00 -6.026214030433431e+00 3.948146858765891e+00 4.546222879352323e+00 9.297669545173119e+03 + 1320 9.770121717042179e-01 -5.928459695639935e+00 -6.054311638894687e+00 4.059717030184133e+00 4.337055696490075e+00 9.384514061962318e+03 + 1340 1.010334021233879e+00 -5.989226656323354e+00 -6.045065983070645e+00 3.736771279435648e+00 4.416133224144823e+00 9.355907696214039e+03 + 1360 1.015572014704490e+00 -6.009053674086513e+00 -6.012142286665330e+00 3.643636318592968e+00 4.625901027204147e+00 9.254363506332575e+03 + 1380 1.020423639644608e+00 -6.027930181386951e+00 -5.977965193222040e+00 3.543866434942286e+00 4.830773129042132e+00 9.149538312252938e+03 + 1400 9.683530022348545e-01 -5.959739001021481e+00 -6.037775362729338e+00 3.892719200438814e+00 4.444622335424349e+00 9.333373098016767e+03 + 1420 1.061363887238329e+00 -6.107202372992392e+00 -5.986695431269363e+00 3.125532375241542e+00 4.817501883004134e+00 9.176250195089011e+03 + 1440 9.629301181714207e-01 -5.970065775172462e+00 -6.007557664457972e+00 3.880295862869057e+00 4.665011632740542e+00 9.240258153641324e+03 + 1460 9.635359109549591e-01 -5.979073289500995e+00 -5.993303451814675e+00 3.866832622748392e+00 4.785120828632738e+00 9.196511815318074e+03 + 1480 9.567370930802896e-01 -5.977043341669617e+00 -6.001458456586717e+00 3.843778320819849e+00 4.703582952739037e+00 9.221532949075470e+03 + 1500 9.900361347227478e-01 -6.031792149531222e+00 -5.978707340260190e+00 3.506946225863090e+00 4.811767415545044e+00 9.151805317615643e+03 + 1520 9.938001600708007e-01 -6.039815351178462e+00 -5.991857013957798e+00 3.509960601875635e+00 4.785344795725385e+00 9.192066992791384e+03 + 1540 9.953112874815186e-01 -6.042719174169688e+00 -6.005353097187282e+00 3.450947940436433e+00 4.665509736851135e+00 9.233495244612268e+03 + 1560 1.069271904932656e+00 -6.152073224941286e+00 -5.969125473261437e+00 2.902794673513004e+00 4.953308974731771e+00 9.122518662457122e+03 + 1580 9.501493252167980e-01 -5.973938733141406e+00 -6.000864862162931e+00 3.840243568541768e+00 4.685629568895167e+00 9.219698694560499e+03 + 1600 9.589556423068437e-01 -5.981441670093458e+00 -5.997147587285640e+00 3.775158017965434e+00 4.684972210965098e+00 9.208288701353231e+03 + 1620 1.006291995863496e+00 -6.039790244792102e+00 -5.997886280316983e+00 3.510158752278993e+00 4.750777800912672e+00 9.210569812571066e+03 + 1640 9.806403775285769e-01 -5.983382951803718e+00 -6.026193959638568e+00 3.749644127205098e+00 4.503816695235340e+00 9.297642102207012e+03 + 1660 9.960868367948952e-01 -5.984566094202703e+00 -6.008397964351241e+00 3.822908175157749e+00 4.686061888794857e+00 9.242848512513441e+03 + 1680 9.505830390822479e-01 -5.891050024485596e+00 -6.049352098638883e+00 4.204519529126921e+00 4.295524522171942e+00 9.369180422451216e+03 + 1700 1.016998032951114e+00 -5.961998321104554e+00 -6.036169082272856e+00 3.869686127281646e+00 4.443786138765061e+00 9.328432280716304e+03 + 1720 9.140780237941266e-01 -5.779748720443006e+00 -6.132739644266486e+00 4.806172771311286e+00 3.779244261547943e+00 9.629014795126626e+03 + 1740 1.021525743250995e+00 -5.915200249926897e+00 -6.067511755916038e+00 4.138223841906265e+00 4.263627604387245e+00 9.425471443436001e+03 + 1760 1.056258655220493e+00 -5.948052653311422e+00 -5.994831308132557e+00 4.015012130619880e+00 4.746401855663484e+00 9.201170045659454e+03 + 1780 1.091760533190582e+00 -5.988967165690083e+00 -6.005106813609913e+00 3.749688782186766e+00 4.657012426228656e+00 9.232735305379583e+03 + 1800 1.056844747086857e+00 -5.929879681313796e+00 -6.037475961365871e+00 4.078193170902743e+00 4.460358680373206e+00 9.332458516430353e+03 + 1820 1.051672648702115e+00 -5.923554403937755e+00 -6.035937325815052e+00 4.114528236311266e+00 4.469208107690868e+00 9.327690787933538e+03 + 1840 1.079191787915328e+00 -5.974647120335245e+00 -6.031330024822035e+00 3.772111845151964e+00 4.446629835937700e+00 9.313492955648153e+03 + 1860 1.100065683075181e+00 -6.026110253503338e+00 -5.977894555395919e+00 3.612546010636712e+00 4.889408010524683e+00 9.149326728161452e+03 + 1880 1.049314676910492e+00 -5.979511344177174e+00 -6.008981366727259e+00 3.819927821828574e+00 4.650706391874736e+00 9.244641974401233e+03 + 1900 1.036184806597899e+00 -5.997668388798338e+00 -5.980165503078808e+00 3.750662416783600e+00 4.851166695147951e+00 9.156241696330460e+03 + 1920 1.005535619010941e+00 -5.989666607848737e+00 -5.979483632166835e+00 3.791000171996873e+00 4.849472394172748e+00 9.154171845743464e+03 + 1940 1.005750784090165e+00 -6.027399163835307e+00 -6.033277752287585e+00 3.510098996283014e+00 4.476343231681413e+00 9.319475245493330e+03 + 1960 1.033242556008971e+00 -6.101125728237266e+00 -5.965821687674877e+00 3.181007642040000e+00 4.957944381181844e+00 9.112435021612959e+03 + 1980 9.690750026426086e-01 -6.030404089771947e+00 -5.965755592818375e+00 3.604559043262781e+00 4.975780717092768e+00 9.112214479823842e+03 + 2000 9.573730217782468e-01 -6.027212106364522e+00 -5.975251913179205e+00 3.536899098041686e+00 4.835262568125687e+00 9.141197427790356e+03 + 2020 9.580965930334331e-01 -6.035090785097059e+00 -5.982669904413302e+00 3.529901381040305e+00 4.830910190031504e+00 9.163899364309213e+03 + 2040 9.660262002751682e-01 -6.048666659007282e+00 -5.974940385248316e+00 3.407366200012847e+00 4.830713873040818e+00 9.140302196515371e+03 + 2060 9.595238897940745e-01 -6.035918296845781e+00 -5.995067147797715e+00 3.522627130509846e+00 4.757200750038729e+00 9.201927798556333e+03 + 2080 9.661463423743272e-01 -6.040141946598026e+00 -5.974654975432848e+00 3.537300360750312e+00 4.913336683256795e+00 9.139403566643907e+03 + 2100 1.000737593509061e+00 -6.083070298292498e+00 -5.981508654049288e+00 3.301870240239810e+00 4.885052918097971e+00 9.160384300410915e+03 + 2120 1.003290524959656e+00 -6.076963276900972e+00 -5.996724631137527e+00 3.267021808580333e+00 4.727764529444345e+00 9.206983820623636e+03 + 2140 1.007272603225144e+00 -6.072101933930028e+00 -6.002236011835721e+00 3.336549560204369e+00 4.737730496586387e+00 9.223895452315091e+03 + 2160 9.818101233336093e-01 -6.021976171896148e+00 -5.973717484374421e+00 3.570816311975517e+00 4.847925163733031e+00 9.136548609801810e+03 + 2180 1.000151459290246e+00 -6.035791855429288e+00 -5.983648452238181e+00 3.461164862337852e+00 4.760580352626755e+00 9.166930243754949e+03 + 2200 9.554121253276487e-01 -5.953809904471409e+00 -5.997391068390868e+00 3.989846806393845e+00 4.739597019004995e+00 9.209044134300921e+03 + 2220 9.839307642154455e-01 -5.980435775872271e+00 -6.021082810199923e+00 3.805083503591285e+00 4.571681942373672e+00 9.281886750620795e+03 + 2240 1.002960186749692e+00 -5.995430900010174e+00 -6.023260190551815e+00 3.710502562964110e+00 4.550702470105212e+00 9.288593336517781e+03 + 2260 1.004767606786110e+00 -5.985537956324077e+00 -6.045660500958030e+00 3.756604139229965e+00 4.411371184008087e+00 9.357759338904747e+03 + 2280 1.027991188691278e+00 -6.009888852210896e+00 -6.029728511350481e+00 3.694370641299767e+00 4.580448248342943e+00 9.308542224423340e+03 + 2300 9.604690161306196e-01 -5.903919967771139e+00 -6.021619395360090e+00 4.221870042258548e+00 4.546021715115236e+00 9.283529012272789e+03 + 2320 9.946467322845283e-01 -5.949491168189271e+00 -6.001321789945751e+00 3.985664349476699e+00 4.688044898588194e+00 9.221101422118352e+03 + 2340 1.031418105782714e+00 -5.999037826700263e+00 -6.015810873249690e+00 3.712547809461479e+00 4.616234380554106e+00 9.265645565660403e+03 + 2360 1.049610677981517e+00 -6.024346266801204e+00 -6.004432597265719e+00 3.561393145671440e+00 4.675740517774594e+00 9.230668695670809e+03 + 2380 9.914143832608640e-01 -5.939099363307784e+00 -6.018592866977644e+00 4.017360671250756e+00 4.560896671598486e+00 9.274215260865354e+03 + 2400 1.012991710877029e+00 -5.974665694252671e+00 -5.998910952792016e+00 3.855916194011024e+00 4.716696167536472e+00 9.213669904923117e+03 + 2420 1.058602658768619e+00 -6.048244304439085e+00 -5.984697603248392e+00 3.462541409542367e+00 4.827436401599554e+00 9.170128929181448e+03 + 2440 1.109174134477418e+00 -6.136390280741399e+00 -5.992316036744899e+00 2.926837265224963e+00 4.754133869670067e+00 9.193511792371128e+03 + 2460 9.746235130019915e-01 -5.968140791495582e+00 -6.012617563886733e+00 3.937490663295441e+00 4.682098153467168e+00 9.255821060287928e+03 + 2480 9.650319105898962e-01 -6.002441576881545e+00 -5.978626243559641e+00 3.699446377866919e+00 4.836197707212214e+00 9.151542428373863e+03 + 2500 9.562145253501082e-01 -6.042757398039974e+00 -5.998266775327734e+00 3.460543874070221e+00 4.716015914585518e+00 9.211731616562987e+03 + 2520 9.392688056445878e-01 -6.065333014050135e+00 -5.989345446958505e+00 3.316274866757337e+00 4.752607236035481e+00 9.184379853073106e+03 + 2540 9.406177693886535e-01 -6.100166140233386e+00 -5.968893953695828e+00 3.155325092288356e+00 4.909110301692236e+00 9.121812727403245e+03 + 2560 9.537238463889391e-01 -6.140016309834929e+00 -5.982886306498713e+00 2.944294917721612e+00 4.846559712667592e+00 9.164603346280961e+03 + 2580 8.810188432457828e-01 -6.042725236824022e+00 -6.007667748565008e+00 3.490684281974295e+00 4.691989804686326e+00 9.240594978367333e+03 + 2600 9.094600770632164e-01 -6.086683812285889e+00 -5.998017013092426e+00 3.244363042440130e+00 4.753501524551827e+00 9.210971236299811e+03 + 2620 9.014685641839246e-01 -6.066208464713696e+00 -6.020726280185013e+00 3.337757233546257e+00 4.598922975455263e+00 9.280792410484673e+03 + 2640 8.996095265007245e-01 -6.047294977170358e+00 -6.036558941908634e+00 3.432204809079916e+00 4.493852784948821e+00 9.329628755554510e+03 + 2660 9.264650946544774e-01 -6.063693217577973e+00 -5.993544923139384e+00 3.361926625139612e+00 4.764728987219474e+00 9.197264368662391e+03 + 2680 9.607489566346843e-01 -6.083333443466573e+00 -6.019685213109618e+00 3.273614216083375e+00 4.639092204324826e+00 9.277587125123229e+03 + 2700 9.446857719108780e-01 -6.025299013812226e+00 -6.003942020769401e+00 3.622922879040403e+00 4.745558038076301e+00 9.229153636927742e+03 + 2720 9.758232641651808e-01 -6.036071511335988e+00 -6.004508109933705e+00 3.523269141476572e+00 4.704511076749059e+00 9.230873025302106e+03 + 2740 9.631955302082444e-01 -5.984144335667126e+00 -5.997033965351227e+00 3.739817464366789e+00 4.665803216056938e+00 9.207951610907328e+03 + 2760 1.038657344532288e+00 -6.066715514131998e+00 -5.941164815416744e+00 3.364525789782332e+00 5.085457330713151e+00 9.037303005750202e+03 + 2780 9.720294437836885e-01 -5.940555041413755e+00 -6.020825789263021e+00 4.039637789034717e+00 4.578710733026142e+00 9.281050385575518e+03 + 2800 1.063602106253152e+00 -6.053879744546151e+00 -5.996175753453945e+00 3.390894208431495e+00 4.722239454946707e+00 9.205305939813175e+03 + 2820 1.045554226520253e+00 -6.011434130210202e+00 -5.986523863901667e+00 3.642798180238799e+00 4.785836784233663e+00 9.175733653912088e+03 + 2840 1.018604147027625e+00 -5.962079091285482e+00 -5.997161666327792e+00 3.848279269649105e+00 4.646829694745222e+00 9.208322947426321e+03 + 2860 9.674294147173387e-01 -5.878116439520070e+00 -5.979415440483137e+00 4.371307046421917e+00 4.789632506922255e+00 9.153956985671797e+03 + 2880 1.068227645295234e+00 -6.022416081732619e+00 -5.970996395176160e+00 3.558576852878756e+00 4.853836650256722e+00 9.128221660084995e+03 + 2900 9.876236212699944e-01 -5.900765484775541e+00 -5.978866996978657e+00 4.178181843319684e+00 4.729710874079442e+00 9.152264151159983e+03 + 2920 9.989385608189564e-01 -5.915223530828172e+00 -5.990431948654901e+00 4.093737047958474e+00 4.661878674332344e+00 9.187661757397405e+03 + 2940 1.086915531475070e+00 -6.045051127794636e+00 -5.975984572636248e+00 3.435146786277699e+00 4.831737634012029e+00 9.143486209654353e+03 + 2960 9.915887757158284e-01 -5.908029039101748e+00 -6.000420308696699e+00 4.178425840892116e+00 4.647900873375139e+00 9.218318860614439e+03 + 2980 1.014253575230600e+00 -5.948986033304946e+00 -6.025530613274452e+00 4.004932939925229e+00 4.565402116504858e+00 9.295552859091133e+03 + 3000 1.082983966669505e+00 -6.064532511715673e+00 -5.992898859252366e+00 3.355725039220080e+00 4.767056556936281e+00 9.195252684831547e+03 + 3020 9.736603307772786e-01 -5.923534685683446e+00 -6.020888484883230e+00 4.082042940712521e+00 4.523022360255628e+00 9.281289840296087e+03 + 3040 1.014020183822986e+00 -6.012578043699898e+00 -6.007861142396603e+00 3.584969816148293e+00 4.612054993369931e+00 9.241208675832058e+03 + 3060 9.680052995194210e-01 -5.981695359378753e+00 -6.018510452806395e+00 3.842717385884264e+00 4.631319422305445e+00 9.273938567905921e+03 + 3080 9.557725275502270e-01 -6.004785341913009e+00 -6.002541778103556e+00 3.629366551404802e+00 4.642249441989062e+00 9.224867470491785e+03 + 3100 9.302031263612272e-01 -6.009272271114598e+00 -6.055701088184148e+00 3.590218736284929e+00 4.323617283835349e+00 9.388850948703917e+03 + 3120 9.483141574862957e-01 -6.073099379329267e+00 -6.006024068763062e+00 3.367998801191937e+00 4.753155614333849e+00 9.235554446350028e+03 + 3140 9.582860564150950e-01 -6.114673504425299e+00 -5.980828423392261e+00 3.082750058479112e+00 4.851309226230168e+00 9.158312256220290e+03 + 3160 9.324044247077475e-01 -6.093018737326735e+00 -5.992248345004642e+00 3.198757491367820e+00 4.777396678249088e+00 9.193274085134834e+03 + 3180 9.196977860658837e-01 -6.080838754049616e+00 -5.946181626391017e+00 3.281657636389512e+00 5.054879701528347e+00 9.052570912787898e+03 + 3200 8.828086680776239e-01 -6.022172336618174e+00 -5.968404862232271e+00 3.585991623970842e+00 4.894732782384466e+00 9.120313121980313e+03 + 3220 9.552772631648037e-01 -6.117068917095198e+00 -5.997909123999969e+00 2.999307069061937e+00 4.683541040933129e+00 9.210652362418152e+03 + 3240 9.215162564957043e-01 -6.049003702899177e+00 -6.053184578525918e+00 3.394457994419126e+00 4.370450759581967e+00 9.381029438716432e+03 + 3260 8.679224326862217e-01 -5.951227853736288e+00 -6.030090004804739e+00 3.966746250267494e+00 4.513907574954013e+00 9.309651928219242e+03 + 3280 9.559946536674298e-01 -6.062558606339359e+00 -5.962292652969051e+00 3.331788850212740e+00 4.907531470571191e+00 9.101662771243704e+03 + 3300 9.784302446374680e-01 -6.072964680969816e+00 -5.948200022635401e+00 3.332206433175636e+00 5.048624408600331e+00 9.058733949040237e+03 + 3320 9.765467561225118e-01 -6.047872186736956e+00 -6.012236111807583e+00 3.425821534012516e+00 4.630449390921743e+00 9.254676912259902e+03 + 3340 9.843568938032443e-01 -6.042071972895625e+00 -5.985766888542596e+00 3.448932451265526e+00 4.772244958804269e+00 9.173417072005017e+03 + 3360 9.215840893918434e-01 -5.932926288823767e+00 -5.969984742388449e+00 4.091854578806972e+00 4.879059203661414e+00 9.125135119348153e+03 + 3380 9.687394925973194e-01 -5.987212840513108e+00 -5.986014210073209e+00 3.759741059776169e+00 4.766623781249524e+00 9.174160364689043e+03 + 3400 9.772432286983908e-01 -5.983555965976329e+00 -6.011488073192909e+00 3.784267986789303e+00 4.623877504672083e+00 9.252329517471078e+03 + 3420 9.824193308806957e-01 -5.979030385430723e+00 -5.999283156345692e+00 3.801353519335255e+00 4.685058974635331e+00 9.214844883438287e+03 + 3440 1.024170024685142e+00 -6.029930207017909e+00 -5.979341842704698e+00 3.516411120637934e+00 4.806897337048470e+00 9.153739100175311e+03 + 3460 9.428977919711881e-01 -5.900490716818319e+00 -5.994298857082136e+00 4.226958306873071e+00 4.688297448715448e+00 9.199531958086702e+03 + 3480 1.058402989307893e+00 -6.061926264859768e+00 -5.953815791832962e+00 3.373038631280029e+00 4.993825697441572e+00 9.075825160520708e+03 + 3500 1.040416102185497e+00 -6.025872360221016e+00 -6.004864641054125e+00 3.499583190507550e+00 4.620212764897878e+00 9.231992229701502e+03 + 3520 9.822629923594154e-01 -5.931150643530076e+00 -6.013119066061455e+00 4.042294452287814e+00 4.571619085540245e+00 9.257378892511784e+03 + 3540 1.104699379231245e+00 -6.106214672284169e+00 -5.993878726932016e+00 3.136869061109301e+00 4.781919443252727e+00 9.198266622901281e+03 + 3560 1.066019360687542e+00 -6.048029056360878e+00 -5.981361282226180e+00 3.455804329076229e+00 4.838621004962368e+00 9.159921746463959e+03 + 3580 1.050208236203343e+00 -6.025117293531656e+00 -6.024849472762165e+00 3.508092521065522e+00 4.509630389369065e+00 9.293485643367150e+03 + 3600 1.012760468395914e+00 -5.974264473569868e+00 -5.990684756408938e+00 3.871765544721085e+00 4.777477739628587e+00 9.188484901476568e+03 + 3620 9.568049504734903e-01 -5.899234040046347e+00 -6.026094810555316e+00 4.174547864256597e+00 4.446093688353309e+00 9.297313203764568e+03 + 3640 1.014590848537890e+00 -5.995848543922659e+00 -5.987918997166485e+00 3.782945247357538e+00 4.828477931924889e+00 9.179988557423707e+03 + 3660 1.019818488351462e+00 -6.019886063631723e+00 -5.995688200182876e+00 3.575106391588004e+00 4.714054268118549e+00 9.203827806971716e+03 + 3680 1.034310235893273e+00 -6.066901641123715e+00 -6.001890069297374e+00 3.335789841135917e+00 4.709096347070989e+00 9.222843555969139e+03 + 3700 9.295870244544072e-01 -5.946054215591680e+00 -6.021906310456092e+00 3.910904585589538e+00 4.475350118804338e+00 9.284411686400106e+03 + 3720 1.019820518976140e+00 -6.119249170514344e+00 -5.933181843848311e+00 3.065708137068993e+00 5.134135520611096e+00 9.013091374588774e+03 + 3740 9.649417389083867e-01 -6.075255342288441e+00 -5.965685008386437e+00 3.296457619388129e+00 4.925627432607814e+00 9.112011472372647e+03 + 3760 9.656492123442376e-01 -6.108323359664857e+00 -5.961262170971308e+00 3.177983054064289e+00 5.022431157188044e+00 9.098523642699138e+03 + 3780 9.226331693168127e-01 -6.069068674337219e+00 -5.961266221463664e+00 3.358173456886388e+00 4.977191823662004e+00 9.098509935225944e+03 + 3800 9.179814788206815e-01 -6.075896239459354e+00 -5.996930751612742e+00 3.261442468765725e+00 4.714874519850725e+00 9.207617680425241e+03 + 3820 9.146704203067683e-01 -6.076008380244993e+00 -5.979199191999661e+00 3.360966131036247e+00 4.916859471114403e+00 9.153285539843302e+03 + 3840 9.293070156998194e-01 -6.093995862231288e+00 -5.976315876588238e+00 3.184851467074354e+00 4.860588155555666e+00 9.144480147702692e+03 + 3860 9.750351274215672e-01 -6.148797045914271e+00 -5.954640048422515e+00 2.910949903352011e+00 5.025829428647930e+00 9.078349857389134e+03 + 3880 9.665731152462683e-01 -6.114563170224449e+00 -6.008411982785262e+00 3.057472206289281e+00 4.667008751408260e+00 9.242906847124481e+03 + 3900 9.618591694594970e-01 -6.080690003863024e+00 -6.028690066613374e+00 3.258025406652431e+00 4.556617093304205e+00 9.305327881061823e+03 + 3920 9.850576990394742e-01 -6.083629108609698e+00 -5.997148290708218e+00 3.319008230400256e+00 4.815594469653875e+00 9.208306886724573e+03 + 3940 9.519355084770160e-01 -5.998946822943996e+00 -6.057332441579519e+00 3.723835697708302e+00 4.388576440357840e+00 9.393889062292306e+03 + 3960 9.928625005003138e-01 -6.027687220812267e+00 -5.979472623285224e+00 3.581515234175218e+00 4.858370914360356e+00 9.154146114075158e+03 + 3980 1.055409700060590e+00 -6.091892687229631e+00 -5.944742680032918e+00 3.196020081352717e+00 5.040978194066264e+00 9.048200716946576e+03 + 4000 9.565073768551122e-01 -5.922477431880549e+00 -6.002506314457438e+00 4.089672732762155e+00 4.630134504576104e+00 9.224744972512171e+03 + 4020 9.482449255463001e-01 -5.892942723009963e+00 -6.012418510833687e+00 4.301665125875270e+00 4.615616663373036e+00 9.255220171608911e+03 + 4040 1.038919706062922e+00 -6.016488548995719e+00 -6.013168998614837e+00 3.614127977111805e+00 4.633189349097592e+00 9.257495276112901e+03 + 4060 9.866871132477888e-01 -5.933813133139401e+00 -5.993039149756936e+00 4.051875847118295e+00 4.711790894503955e+00 9.195683471498565e+03 + 4080 1.067952099559177e+00 -6.052005374521505e+00 -5.974400479437518e+00 3.430874135502294e+00 4.876493452393244e+00 9.138636414630148e+03 + 4100 9.724287476088145e-01 -5.909615973497374e+00 -5.986123172460852e+00 4.238191376219045e+00 4.798875200319977e+00 9.174483263533950e+03 + 4120 9.873162730934302e-01 -5.932192122910184e+00 -6.001484002555977e+00 4.033516701247188e+00 4.635632005437324e+00 9.221576816329141e+03 + 4140 1.017515710046528e+00 -5.977808592754990e+00 -5.979893255212614e+00 3.805653289351545e+00 4.793682834919393e+00 9.155418998053992e+03 + 4160 9.810727434084010e-01 -5.925878778169631e+00 -6.033748909737148e+00 4.123690354249779e+00 4.504283365940185e+00 9.320940767673927e+03 + 4180 1.025310615732101e+00 -5.994451869004166e+00 -6.013841917271868e+00 3.669341165752669e+00 4.558000507999251e+00 9.259601629061828e+03 + 4200 1.047551917624051e+00 -6.033225032087906e+00 -6.012374171520302e+00 3.529008830986295e+00 4.648737699025722e+00 9.255082879587231e+03 + 4220 1.033243752978466e+00 -6.021079660245851e+00 -5.975379441500917e+00 3.602384625607859e+00 4.864802353727264e+00 9.141653033504830e+03 + 4240 1.064274118788744e+00 -6.079052469845770e+00 -5.998764317204787e+00 3.257991202047767e+00 4.719018199063757e+00 9.213279829096937e+03 + 4260 9.789312428336630e-01 -5.968383445114686e+00 -6.036947988876489e+00 3.871206189852660e+00 4.477497969243530e+00 9.330845613389345e+03 + 4280 1.032852904379636e+00 -6.070726954591553e+00 -6.035343479940346e+00 3.265118140888453e+00 4.468295527910687e+00 9.325874801191769e+03 + 4300 9.778152650389655e-01 -6.015214863448747e+00 -6.000708752028511e+00 3.660478706973720e+00 4.743775043562206e+00 9.219222541627527e+03 + 4320 9.589419751360239e-01 -6.015541832463819e+00 -5.988049408475147e+00 3.596787196364251e+00 4.754652949346069e+00 9.180418000326265e+03 + 4340 9.742631118579683e-01 -6.067969577464320e+00 -5.975101656229723e+00 3.357180635224962e+00 4.890442610218381e+00 9.140777439948526e+03 + 4360 9.388606888885961e-01 -6.044641775262376e+00 -6.003562930105986e+00 3.479739695999048e+00 4.715620781817780e+00 9.227985117652817e+03 + 4380 9.327510532852272e-01 -6.063810570993684e+00 -6.016670300051674e+00 3.321018721172865e+00 4.591705451855246e+00 9.268308835067632e+03 + 4400 9.475128995284288e-01 -6.109923442956447e+00 -6.005632668864542e+00 3.115509659228004e+00 4.714363423008857e+00 9.234360114557157e+03 + 4420 9.407268721708809e-01 -6.121750779416526e+00 -5.980060381863261e+00 3.053667934764019e+00 4.867276124033030e+00 9.155960625530452e+03 + 4440 9.086542439537799e-01 -6.089416999609051e+00 -5.969043225172886e+00 3.199069814867110e+00 4.890274655460967e+00 9.122266762512392e+03 + 4460 9.015957999123217e-01 -6.086010388442796e+00 -5.949103442388193e+00 3.255114702838553e+00 5.041255573365514e+00 9.061479721210455e+03 + 4480 9.229320685175242e-01 -6.115002206643276e+00 -5.977632686619868e+00 3.059741463484381e+00 4.848538505323308e+00 9.148516360305031e+03 + 4500 8.870793222288843e-01 -6.045778776716148e+00 -5.998831920549165e+00 3.470765002643376e+00 4.740341115756701e+00 9.213473874249768e+03 + 4520 9.316908274076666e-01 -6.079351963502633e+00 -6.015815008557974e+00 3.238916986973568e+00 4.603756014577807e+00 9.265683667494772e+03 + 4540 9.855433644824192e-01 -6.103654672621630e+00 -5.971741310873790e+00 3.123144143418572e+00 4.880611080101430e+00 9.130520177236956e+03 + 4560 8.993318263813408e-01 -5.912564141308755e+00 -6.001118462330025e+00 4.156969645224192e+00 4.648477030183167e+00 9.220489494267606e+03 + 4580 1.024751460878388e+00 -6.043608276669022e+00 -5.988424823210932e+00 3.427755778765943e+00 4.744627708134121e+00 9.181575906060809e+03 + 4600 1.019606211956627e+00 -6.001106283398768e+00 -6.015599922023636e+00 3.617872693866590e+00 4.534647977999267e+00 9.264979652321685e+03 + 4620 9.692737915977039e-01 -5.905116860256100e+00 -5.964380532388331e+00 4.235512512694811e+00 4.895211336287916e+00 9.107987053211973e+03 + 4640 1.047656798164206e+00 -6.002300921254660e+00 -5.955877262541110e+00 3.679409545505914e+00 4.945981377877086e+00 9.082085402058434e+03 + 4660 9.885234376510259e-01 -5.897918258197231e+00 -6.031404417153833e+00 4.169472063481171e+00 4.402973881836021e+00 9.313711123181569e+03 + 4680 1.022278941163547e+00 -5.938445010260647e+00 -6.024691798323269e+00 4.015237487673716e+00 4.519995083970824e+00 9.292983778547399e+03 + 4700 1.067033892588570e+00 -5.999699379873799e+00 -5.993911318776776e+00 3.715744664359256e+00 4.748980606877922e+00 9.198362066352935e+03 + 4720 1.041627997978736e+00 -5.962258504412741e+00 -6.014422411600076e+00 3.876085999228677e+00 4.576552771820452e+00 9.261383503587735e+03 + 4740 1.011130039027457e+00 -5.921220635519050e+00 -6.040501004946947e+00 4.115335207862723e+00 4.430408868030227e+00 9.341799380762961e+03 + 4760 1.022760206709960e+00 -5.949771659580606e+00 -6.028614164081205e+00 3.885669341545859e+00 4.432943479865285e+00 9.305102300257813e+03 + 4780 1.040726179942608e+00 -5.990696009652583e+00 -5.983925765460149e+00 3.733227943966438e+00 4.772103733811296e+00 9.167749357146846e+03 + 4800 1.037817162747346e+00 -6.004014262033660e+00 -5.947473867054223e+00 3.654797555592501e+00 4.979461253162279e+00 9.056492416314461e+03 + 4820 1.068131340636593e+00 -6.070120511489455e+00 -5.923555829352535e+00 3.334820523877982e+00 5.176417609519442e+00 8.983861210898671e+03 + 4840 9.931985305451585e-01 -5.979873140149472e+00 -5.986668235115590e+00 3.801132498641155e+00 4.762114011808157e+00 9.176160540100684e+03 + 4860 1.044276044209831e+00 -6.077152872141601e+00 -5.982141662161400e+00 3.292541305710907e+00 4.838110376354454e+00 9.162319829898215e+03 + 4880 9.317087355420148e-01 -5.933894768735680e+00 -6.061976830665452e+00 3.995829215424912e+00 4.260362195189130e+00 9.408291148300863e+03 + 4900 1.017518093548281e+00 -6.086956814941328e+00 -5.986050181895459e+00 3.213617086157798e+00 4.793038588358177e+00 9.174282985029069e+03 + 4920 9.296240603403478e-01 -5.980512727946044e+00 -5.980809321608535e+00 3.802249777384747e+00 4.800546690677001e+00 9.158218107132570e+03 + 4940 9.015791720315198e-01 -5.956662015883299e+00 -6.049070006043820e+00 3.847287446094596e+00 4.316666466502621e+00 9.368284916611934e+03 + 4960 9.699703008756473e-01 -6.072676526520175e+00 -5.956918803592605e+00 3.295773275536687e+00 4.960472034036526e+00 9.085292789411473e+03 + 4980 9.806448847543581e-01 -6.098682579389591e+00 -5.975858576429935e+00 3.159167707151245e+00 4.864442139098621e+00 9.143087445044757e+03 + 5000 8.974225085129036e-01 -5.981929734215370e+00 -5.944437959670164e+00 3.855171960101127e+00 5.070455531373065e+00 9.047265017811827e+03 + 5020 9.561935623503454e-01 -6.066398428607554e+00 -5.974322747013768e+00 3.368205880326709e+00 4.896918692703906e+00 9.138392955426314e+03 + 5040 1.004057308601558e+00 -6.126299620761916e+00 -5.997131009198861e+00 3.015008481311754e+00 4.756714637684855e+00 9.208259997822264e+03 + 5060 9.849117169081997e-01 -6.080103489458722e+00 -5.984878116326396e+00 3.273925233524659e+00 4.820724062129339e+00 9.170698262826898e+03 + 5080 9.908366071930947e-01 -6.057706528075720e+00 -5.974847124983457e+00 3.377985840811509e+00 4.853777355818469e+00 9.140006178063155e+03 + 5100 9.771539815822897e-01 -5.990942021953365e+00 -6.004536978605548e+00 3.691675147012577e+00 4.613610802102993e+00 9.230983745830979e+03 + 5120 1.032278736232676e+00 -6.015841198156314e+00 -5.972458088059938e+00 3.638714940090964e+00 4.887827471778941e+00 9.132698353053305e+03 + 5140 1.028627974621518e+00 -5.956891379563531e+00 -5.972320538878256e+00 3.927573588385711e+00 4.838976967945879e+00 9.132257658021521e+03 + 5160 1.007232133238073e+00 -5.886095159907374e+00 -6.029701925442451e+00 4.282524846519369e+00 4.457912575741810e+00 9.308449122893173e+03 + 5180 1.090491748089998e+00 -5.984036999334295e+00 -6.015730470933634e+00 3.788786464180200e+00 4.606797645707918e+00 9.265397439485851e+03 + 5200 1.050708258974349e+00 -5.913419335026415e+00 -6.010847321836398e+00 4.174659400299506e+00 4.615212823104346e+00 9.250370066750167e+03 + 5220 1.016352524573795e+00 -5.860023479565696e+00 -6.041187352588485e+00 4.415616800814671e+00 4.375345806899070e+00 9.343909630690034e+03 + 5240 1.074992555704176e+00 -5.950940983467232e+00 -6.055368124593319e+00 3.945476945763994e+00 4.345840141370141e+00 9.387804902449074e+03 + 5260 1.027721092513089e+00 -5.893777525903121e+00 -6.031979672027708e+00 4.236544494326052e+00 4.442966384565680e+00 9.315484540254663e+03 + 5280 1.079176464061436e+00 -5.989267529607163e+00 -5.974560415334167e+00 3.789786289676842e+00 4.874236815750962e+00 9.139119673688196e+03 + 5300 1.059999716891454e+00 -5.983469650277590e+00 -6.043242209496077e+00 3.784423903340143e+00 4.441200618533951e+00 9.350264272680171e+03 + 5320 1.029361575629399e+00 -5.967862815101084e+00 -5.980497410155740e+00 3.933418407141061e+00 4.860868607139956e+00 9.157273690876304e+03 + 5340 9.939829445005901e-01 -5.944265808186808e+00 -6.001372744035221e+00 3.941834624443284e+00 4.613917761531937e+00 9.221231392115746e+03 + 5360 1.002347141807476e+00 -5.981766963077394e+00 -5.982409571908413e+00 3.834214042105230e+00 4.830524082754128e+00 9.163109792510033e+03 + 5380 9.922709497894977e-01 -5.990774557502838e+00 -6.025026422721659e+00 3.750138861042017e+00 4.553459350496536e+00 9.294028311952472e+03 + 5400 9.508013318942231e-01 -5.951953771769782e+00 -6.008154724056148e+00 3.904216998544369e+00 4.581502433446799e+00 9.242100493211838e+03 + 5420 9.804559441734161e-01 -6.011243487471830e+00 -5.970239145135222e+00 3.673641929012173e+00 4.909095208110443e+00 9.125894173494014e+03 + 5440 1.004942721263019e+00 -6.058813121797945e+00 -5.976525362827058e+00 3.413890302526983e+00 4.886399348527364e+00 9.145100181239737e+03 + 5460 1.061547705765180e+00 -6.150779631457584e+00 -5.953309016851688e+00 2.872544941834724e+00 5.006451769380628e+00 9.074287370967444e+03 + 5480 9.297799736091874e-01 -5.959891555236977e+00 -6.009254856772337e+00 3.896502191446372e+00 4.613050475084114e+00 9.245483392329066e+03 + 5500 9.361742094286684e-01 -5.969752623865404e+00 -6.049262797858599e+00 3.811683572762313e+00 4.355123849533723e+00 9.368916955620309e+03 + 5520 9.858600198733015e-01 -6.041654800972768e+00 -6.043056089465784e+00 3.478372831998727e+00 4.470326416623138e+00 9.349707388124003e+03 + 5540 1.003069533423004e+00 -6.066204985263413e+00 -6.032614961300689e+00 3.319617876539157e+00 4.512496992172522e+00 9.317459630966303e+03 + 5560 9.316648413133540e-01 -5.958525880637334e+00 -6.004372647590115e+00 3.955060615420489e+00 4.691801384813365e+00 9.230479922348693e+03 + 5580 9.507656042053820e-01 -5.980640465489707e+00 -6.027010626065092e+00 3.785234937976507e+00 4.518970300193487e+00 9.300153003629017e+03 + 5600 9.860409688741618e-01 -6.021738425153599e+00 -6.011213456068123e+00 3.606997492223968e+00 4.667433493446472e+00 9.251499424952544e+03 + 5620 9.645523403348569e-01 -5.976906707758470e+00 -5.985601357224780e+00 3.820284958720100e+00 4.770358935991887e+00 9.172913404955720e+03 + 5640 9.858535755648066e-01 -5.987286215858703e+00 -6.004868064897952e+00 3.747833994349626e+00 4.646876296383908e+00 9.232006529207254e+03 + 5660 1.047512573076879e+00 -6.047377952769070e+00 -5.970501155426838e+00 3.480678631434559e+00 4.922117098419593e+00 9.126717327386912e+03 + 5680 1.007161517675931e+00 -5.938629001535418e+00 -5.950875996505930e+00 3.995137633433824e+00 4.924813493096795e+00 9.066819803877379e+03 + 5700 9.937902825741408e-01 -5.856681332590008e+00 -5.935599748798062e+00 4.513101529458910e+00 5.059939771006826e+00 9.020360707662177e+03 + 5720 1.050834366181098e+00 -5.874422435989541e+00 -6.025831156209742e+00 4.324021279215323e+00 4.454608977287198e+00 9.296521581399067e+03 + 5740 1.101525194162983e+00 -5.905787041933178e+00 -6.030948677867882e+00 4.156251876258815e+00 4.437554394021180e+00 9.312275590688911e+03 + 5760 1.039972423741618e+00 -5.796233619049751e+00 -6.056418903703963e+00 4.692678800748967e+00 4.198654632721809e+00 9.391024973702413e+03 + 5780 1.114542697914913e+00 -5.901829574616368e+00 -6.071327914859436e+00 4.149102485331635e+00 4.175816785872553e+00 9.437273650968817e+03 + 5800 1.045710538384237e+00 -5.808509062210256e+00 -6.079078501710234e+00 4.646830887537621e+00 4.093179295443306e+00 9.461361277715969e+03 + 5820 1.068381737833680e+00 -5.863737026566657e+00 -6.058924895229969e+00 4.371261291274465e+00 4.250462344184675e+00 9.398808290275932e+03 + 5840 9.988759948329279e-01 -5.787975240495646e+00 -6.028797202463188e+00 4.778894947305101e+00 4.396057974609304e+00 9.305664667454823e+03 + 5860 9.942441500367526e-01 -5.810996239899330e+00 -6.072444645525382e+00 4.707023346966302e+00 4.205746142851503e+00 9.440768158165072e+03 + 5880 1.130752371061504e+00 -6.051483634977819e+00 -5.984531494534464e+00 3.437891123731533e+00 4.822340674967530e+00 9.169636868705893e+03 + 5900 1.058167279416327e+00 -5.983073016547560e+00 -5.998884071635485e+00 3.786762308116388e+00 4.695972783048654e+00 9.213615079346297e+03 + 5920 1.021645499093240e+00 -5.964768444494412e+00 -5.990279211182726e+00 3.893987917909978e+00 4.747501147807299e+00 9.187188752909122e+03 + 5940 9.955602938411011e-01 -5.954737780459459e+00 -5.978099533833019e+00 3.916231484241579e+00 4.782084681150947e+00 9.149918122200836e+03 + 5960 9.832028117884604e-01 -5.956990417530747e+00 -6.017851883698061e+00 3.925603001062145e+00 4.576127044047981e+00 9.271911965102374e+03 + 5980 1.056804691345300e+00 -6.085534823424322e+00 -5.996063959191838e+00 3.226880970980619e+00 4.740636518975036e+00 9.204975944688573e+03 + 6000 9.827816972307938e-01 -5.993114706541585e+00 -6.006057820440198e+00 3.736188829857133e+00 4.661867466910893e+00 9.235645890356222e+03 + 6020 9.927825241335750e-01 -6.024386147788722e+00 -5.960518907125483e+00 3.558190729332620e+00 4.924926308644492e+00 9.096238139120040e+03 + 6040 9.550228211123102e-01 -5.978439675616897e+00 -5.996893398891559e+00 3.824079821402093e+00 4.718115686654538e+00 9.207502029306059e+03 + 6060 9.885194331368943e-01 -6.034704845719184e+00 -6.026646182732798e+00 3.447658443674084e+00 4.493932533615978e+00 9.299034538166110e+03 + 6080 1.017383922439883e+00 -6.083954427828170e+00 -5.972156660873335e+00 3.282862932933779e+00 4.924823011436962e+00 9.131779829706002e+03 + 6100 1.007185226422580e+00 -6.074494674679825e+00 -5.956634827429297e+00 3.280227929166410e+00 4.956997410831359e+00 9.084406693866094e+03 + 6120 9.200505619146969e-01 -5.946177449864086e+00 -5.975467384227859e+00 3.964012248614480e+00 4.795824912894997e+00 9.141879300941420e+03 + 6140 9.904711936561045e-01 -6.046266535416278e+00 -5.975527594389998e+00 3.399672310613563e+00 4.805866256802203e+00 9.142056554514576e+03 + 6160 9.359448260532386e-01 -5.957899043092437e+00 -5.947745705204099e+00 3.958058964404593e+00 5.016361001783394e+00 9.057324578759306e+03 + 6180 9.516829458501335e-01 -5.967443360590737e+00 -6.004647461304478e+00 3.817101854207913e+00 4.603470150593632e+00 9.231299474331759e+03 + 6200 1.032817955582340e+00 -6.067816473790483e+00 -5.962609612070656e+00 3.288650634854922e+00 4.892764715559402e+00 9.102641273032164e+03 + 6220 9.902282671615050e-01 -5.975694393581183e+00 -5.999875045683858e+00 3.857054508744313e+00 4.718205462426931e+00 9.216649235523946e+03 + 6240 1.048440895607203e+00 -6.023814741506930e+00 -6.022839448909082e+00 3.529394856350803e+00 4.534995137373694e+00 9.287312082407818e+03 + 6260 1.058210726141701e+00 -5.995734163488008e+00 -6.013943938101269e+00 3.694048177620358e+00 4.589484833837497e+00 9.259903568025162e+03 + 6280 1.011167896953987e+00 -5.888018825924141e+00 -6.061232316227425e+00 4.261065841294839e+00 4.266447175272389e+00 9.405973226168264e+03 + 6300 1.121875130168260e+00 -6.019450192259485e+00 -6.002587871642650e+00 3.621358152423874e+00 4.718184206841420e+00 9.224979488573748e+03 + 6320 1.056933162678728e+00 -5.897642024118499e+00 -6.049309127276980e+00 4.234540587707433e+00 4.363644610963072e+00 9.369014970866787e+03 + 6340 1.082161702236923e+00 -5.919284400986758e+00 -6.025559242440309e+00 4.125533988566872e+00 4.515287402962017e+00 9.295684196235683e+03 + 6360 1.094795651046679e+00 -5.933773511445818e+00 -6.081407768954552e+00 3.977518900160365e+00 4.129780147217696e+00 9.468633453612098e+03 + 6380 1.036781926328056e+00 -5.857104111546207e+00 -6.073112898127896e+00 4.418219654330143e+00 4.177863774526396e+00 9.442795118709108e+03 + 6400 9.901618803514718e-01 -5.805224182879377e+00 -6.015792151638482e+00 4.761022635144186e+00 4.551908773241555e+00 9.265554282845605e+03 + 6420 1.029595153230245e+00 -5.885651028033211e+00 -6.073447752616358e+00 4.220201838492843e+00 4.141843984487208e+00 9.443876232434268e+03 + 6440 1.072288460916004e+00 -5.981702690081717e+00 -5.994266580341420e+00 3.866012053048963e+00 4.793868250922018e+00 9.199426360480013e+03 + 6460 1.063587072725687e+00 -6.007512654510931e+00 -5.987780624415180e+00 3.710665847130440e+00 4.823970217462031e+00 9.179569132008515e+03 + 6480 1.008417233703150e+00 -5.962709065019967e+00 -5.957105982372020e+00 3.914215188154749e+00 4.946388955793497e+00 9.085826160781588e+03 + 6500 9.946654699164605e-01 -5.969018543972053e+00 -5.991151555586138e+00 3.826040284060052e+00 4.698949106299500e+00 9.189906226444627e+03 + 6520 1.028063289928327e+00 -6.038671862440445e+00 -6.021910973632878e+00 3.478844196022966e+00 4.575087813295180e+00 9.284435866786205e+03 + 6540 1.014605148110911e+00 -6.032464495894615e+00 -6.011077706451258e+00 3.509192067743895e+00 4.631998322322623e+00 9.251082588727302e+03 + 6560 9.635061968787028e-01 -5.964764380753449e+00 -6.017067215211133e+00 3.873894583172384e+00 4.573563613878886e+00 9.269503667898596e+03 + 6580 9.718687633755881e-01 -5.981736519797508e+00 -5.997465202882282e+00 3.756303155370881e+00 4.665986623092265e+00 9.209284514355026e+03 + 6600 1.061683940152056e+00 -6.117589987185446e+00 -5.948048643585839e+00 3.060286430224825e+00 5.033819061611899e+00 9.058266975099343e+03 + 6620 9.274267642679134e-01 -5.918790025936023e+00 -6.000727300331480e+00 4.078278501062465e+00 4.607781991731518e+00 9.219262459612988e+03 + 6640 9.954932698429221e-01 -6.016810857664492e+00 -6.005476785630377e+00 3.623732484431428e+00 4.688814479993295e+00 9.233860943338510e+03 + 6660 1.110676758119130e+00 -6.182961608711219e+00 -5.964060671985285e+00 2.718941905649896e+00 4.975904959140691e+00 9.107060632415163e+03 + 6680 1.008328476849361e+00 -6.027087061917306e+00 -6.008173933104363e+00 3.553472523247021e+00 4.662074635688166e+00 9.242190885011580e+03 + 6700 1.013898210746834e+00 -6.032018060539982e+00 -6.011170639247409e+00 3.538087130269019e+00 4.657796249458992e+00 9.251399418341643e+03 + 6720 9.562030201255899e-01 -5.942261957930596e+00 -6.073230620771294e+00 4.017125894259062e+00 4.265083564892699e+00 9.443243680528773e+03 + 6740 9.783672866065568e-01 -5.973919375388831e+00 -6.065897184432872e+00 3.858279970770491e+00 4.330129157719658e+00 9.420443645399815e+03 + 6760 1.053308276321733e+00 -6.085200414009361e+00 -5.974464101858132e+00 3.288470192655914e+00 4.924335233417191e+00 9.138842529785892e+03 + 6780 9.661514957810220e-01 -5.955907970278579e+00 -6.030042910510641e+00 3.979014112462032e+00 4.553319813304610e+00 9.309480964345175e+03 + 6800 1.017670790722191e+00 -6.031139927527134e+00 -5.999776771454921e+00 3.531350061460125e+00 4.711442157059488e+00 9.216366723367106e+03 + 6820 9.958657760981524e-01 -5.996910435275414e+00 -6.016753438793784e+00 3.720320047545983e+00 4.606378450648632e+00 9.268555175870073e+03 + 6840 1.020559975823928e+00 -6.033509998339319e+00 -5.983109390973723e+00 3.510552081532023e+00 4.799960168494056e+00 9.165263509764311e+03 + 6860 9.737651095029531e-01 -5.962873824177495e+00 -5.976166356349753e+00 3.893590173868428e+00 4.817262397122616e+00 9.144027603336624e+03 + 6880 9.903211776014194e-01 -5.983169958249334e+00 -5.995811957243391e+00 3.834163594505035e+00 4.761571279938140e+00 9.204168540732442e+03 + 6900 9.934968546055921e-01 -5.980261669037813e+00 -6.048374519331410e+00 3.792246019650054e+00 4.401131492834706e+00 9.366144552206764e+03 + 6920 1.024996183601244e+00 -6.020325760182681e+00 -6.010823032064735e+00 3.598592105678598e+00 4.653158241074264e+00 9.250311781338753e+03 + 6940 1.017604094682016e+00 -6.004274070797440e+00 -5.961279643239948e+00 3.646003805266135e+00 4.892884461667418e+00 9.098569424944342e+03 + 6960 9.949482101534036e-01 -5.964610663649457e+00 -5.955277375507672e+00 3.872226033252690e+00 4.925819218084492e+00 9.080258503656165e+03 + 6980 9.903229173836756e-01 -5.950019474298431e+00 -5.952398120639085e+00 3.998524590637901e+00 4.984866035255533e+00 9.071423764470448e+03 + 7000 9.916889971875306e-01 -5.939546068791379e+00 -5.944170629681906e+00 3.992152392009156e+00 4.965597447727262e+00 9.046433493432276e+03 + 7020 1.025135671977226e+00 -5.971484183415836e+00 -6.026676766047819e+00 3.787216104860340e+00 4.470291754362933e+00 9.299108882933162e+03 + 7040 1.031615147079532e+00 -5.964882897510957e+00 -6.013081409958710e+00 3.824432600791719e+00 4.547669283621028e+00 9.257257656093245e+03 + 7060 1.033749059542605e+00 -5.955939846591569e+00 -5.983998390740918e+00 3.962696184835532e+00 4.801579682284300e+00 9.167962185071008e+03 + 7080 1.008376994228577e+00 -5.905957342447813e+00 -5.996384867878945e+00 4.182514522888098e+00 4.663265678248207e+00 9.205939252830076e+03 + 7100 1.113979398187659e+00 -6.050727425320332e+00 -5.974805977101429e+00 3.433628603170633e+00 4.869581307649718e+00 9.139859891016687e+03 + 7120 9.483727834629774e-01 -5.797545580776678e+00 -6.029016616446878e+00 4.740304958567982e+00 4.411162451722686e+00 9.306310777296268e+03 + 7140 1.024391346513533e+00 -5.905649927889755e+00 -6.000003528563532e+00 4.166418104602656e+00 4.624625128361315e+00 9.217049603429366e+03 + 7160 1.067502694858423e+00 -5.969564001863686e+00 -6.034240775328664e+00 3.791291989688327e+00 4.419907947754079e+00 9.322465615485669e+03 + 7180 1.069782942683294e+00 -5.982413761560339e+00 -6.005813393943151e+00 3.751523557829650e+00 4.617159247606132e+00 9.234902157555271e+03 + 7200 1.001636856988447e+00 -5.896890669031081e+00 -5.992270030852033e+00 4.278970200332358e+00 4.731287144847909e+00 9.193316518531097e+03 + 7220 1.041955257376149e+00 -5.979040947105043e+00 -5.987832900613595e+00 3.828443004816374e+00 4.777958247219855e+00 9.179726438631405e+03 + 7240 1.021159284843875e+00 -5.980890929528915e+00 -5.986841300932499e+00 3.800532234521315e+00 4.766364281104932e+00 9.176707525315020e+03 + 7260 9.841741776995032e-01 -5.961638066619208e+00 -6.007186841507625e+00 3.909030434707887e+00 4.647482320648459e+00 9.239103887416764e+03 + 7280 9.692632583118538e-01 -5.976284283478131e+00 -5.981627433650576e+00 3.888518644971742e+00 4.857837449831747e+00 9.160712968640501e+03 + 7300 1.000852152666041e+00 -6.056851208780508e+00 -5.974248467144246e+00 3.382448779341675e+00 4.856766504550048e+00 9.138154400706651e+03 + 7320 9.272274690871283e-01 -5.973631518311374e+00 -5.981058131635247e+00 3.805868649333959e+00 4.763223886363583e+00 9.159000834697565e+03 + 7340 9.695978387501567e-01 -6.052998963621831e+00 -6.017268368235714e+00 3.365647074538355e+00 4.570817682537204e+00 9.270134722428336e+03 + 7360 1.029609462429732e+00 -6.156591341652917e+00 -5.960792255693071e+00 2.838815248097193e+00 4.963123899489258e+00 9.097104350016809e+03 + 7380 9.424387377146329e-01 -6.037320325121494e+00 -6.002363637621662e+00 3.428750458628788e+00 4.629477167782734e+00 9.224313406843272e+03 + 7400 9.481095286209023e-01 -6.049135836612690e+00 -5.990588243243112e+00 3.410971447553949e+00 4.747160788892857e+00 9.188184502962427e+03 + 7420 9.455148003004439e-01 -6.042177479954564e+00 -5.958390648227891e+00 3.446402615640576e+00 4.927519569385439e+00 9.089770219793187e+03 + 7440 9.661849777789109e-01 -6.064351906325400e+00 -5.954270093113720e+00 3.383349096664117e+00 5.015455903231122e+00 9.077200724269193e+03 + 7460 9.404673670693910e-01 -6.012415353754005e+00 -5.986050610806424e+00 3.616137936942440e+00 4.767528370878242e+00 9.174269267443105e+03 + 7480 9.655095547602536e-01 -6.027548896938033e+00 -6.030536754836675e+00 3.552400217955231e+00 4.535243475531717e+00 9.311026397073203e+03 + 7500 9.768851330149607e-01 -6.019611787873226e+00 -6.008352734774491e+00 3.562847264953782e+00 4.627498490179552e+00 9.242730317607527e+03 + 7520 1.007935542505234e+00 -6.039719267446659e+00 -5.986176263582580e+00 3.502760974358537e+00 4.810213188299150e+00 9.174676434389083e+03 + 7540 9.892652778197105e-01 -5.982965490701243e+00 -6.032804611515336e+00 3.807449266120674e+00 4.521265321827135e+00 9.318019284935517e+03 + 7560 1.002703142624787e+00 -5.975599857304917e+00 -6.027293261383916e+00 3.807045167665055e+00 4.510213641915015e+00 9.301039633487062e+03 + 7580 1.065240646693610e+00 -6.043802505753950e+00 -5.985339149709022e+00 3.449117374420996e+00 4.784823012006084e+00 9.172111639278279e+03 + 7600 1.022495809024182e+00 -5.962093851293497e+00 -5.974220601208099e+00 3.876391276020052e+00 4.806757601401922e+00 9.138058000750785e+03 + 7620 9.917271173913326e-01 -5.901939749586052e+00 -5.968673748724665e+00 4.264198985619513e+00 4.881002035512609e+00 9.121108579094054e+03 + 7640 1.003486175946281e+00 -5.908618864270528e+00 -6.007592810348852e+00 4.162378469999749e+00 4.594054755449357e+00 9.240334486155800e+03 + 7660 1.045412717037611e+00 -5.964504479716386e+00 -5.993769821270725e+00 3.864042099041694e+00 4.695995979039707e+00 9.197924017990506e+03 + 7680 1.027437642020808e+00 -5.937264452844249e+00 -6.000246805143464e+00 3.999526753106084e+00 4.637872339716475e+00 9.217773085669816e+03 + 7700 1.061570173742260e+00 -5.989652994552815e+00 -5.979587545068409e+00 3.710585298104648e+00 4.768382666667384e+00 9.154488817430729e+03 + 7720 1.063242532008590e+00 -5.997974559566547e+00 -6.021575360997013e+00 3.649728379660084e+00 4.514208925634131e+00 9.283383505038137e+03 + 7740 9.636213022851071e-01 -5.858818592387362e+00 -6.024070644061817e+00 4.464778579436111e+00 4.515875726049038e+00 9.291078567129565e+03 + 7760 1.016236950224726e+00 -5.945110529882687e+00 -6.015834047874455e+00 3.987023329554243e+00 4.580917944816477e+00 9.265675022270656e+03 + 7780 1.028040754794131e+00 -5.972512907378281e+00 -6.010812628105839e+00 3.845435831879405e+00 4.625512908599141e+00 9.250238689525759e+03 + 7800 1.043608342142548e+00 -6.007012222872336e+00 -6.013831908129344e+00 3.619547890829323e+00 4.580388202740702e+00 9.259552840938031e+03 + 7820 1.085077831410023e+00 -6.084451370855996e+00 -5.975362215363215e+00 3.243586581798044e+00 4.869993394129849e+00 9.141582333186177e+03 + 7840 9.889279781114304e-01 -5.959396374037639e+00 -6.003058706882266e+00 3.924489283027553e+00 4.673773411109535e+00 9.226450349331570e+03 + 7860 1.013711201878013e+00 -6.014485839316144e+00 -6.015728050222421e+00 3.591492665971820e+00 4.584359698716465e+00 9.265409023927101e+03 + 7880 1.034188645842074e+00 -6.064674937463971e+00 -6.001462097708278e+00 3.375118869298491e+00 4.738096777331017e+00 9.221546327434877e+03 + 7900 9.967874986278219e-01 -6.028644481042379e+00 -5.986418148219897e+00 3.551557401548016e+00 4.794027539118591e+00 9.175420370504416e+03 + 7920 1.014403812167638e+00 -6.075383812298158e+00 -5.992703677957975e+00 3.278680010099246e+00 4.753442136190019e+00 9.194657827273149e+03 + 7940 9.247460565844577e-01 -5.960172675370466e+00 -6.018607509330633e+00 3.936256791853897e+00 4.600714932493291e+00 9.274237730875890e+03 + 7960 9.842402127024615e-01 -6.063533257141492e+00 -5.965723547017135e+00 3.406664846557850e+00 4.968303338095629e+00 9.112119052967357e+03 + 7980 9.941496713881786e-01 -6.089272050499535e+00 -5.955804635545148e+00 3.260885009539949e+00 5.027275560223760e+00 9.081876409332344e+03 + 8000 1.014268221016080e+00 -6.126397090503144e+00 -5.946599383216699e+00 3.084322197540495e+00 5.116748456384545e+00 9.053841258564025e+03 + 8020 9.084787635395473e-01 -5.973183595537950e+00 -6.004645608687474e+00 3.852612143429630e+00 4.671952395194264e+00 9.231289246612310e+03 + 8040 9.457229160853107e-01 -6.028098458301938e+00 -5.976175010390559e+00 3.573685418253183e+00 4.871837891287915e+00 9.144032996970482e+03 + 8060 9.217790178844402e-01 -5.985432287980048e+00 -6.016795406707681e+00 3.773062681226091e+00 4.592970800065088e+00 9.268674914087276e+03 + 8080 9.928709681515657e-01 -6.073771480244977e+00 -5.984437405888368e+00 3.331112038688137e+00 4.844082118047115e+00 9.169331707527293e+03 + 8100 9.602619489853486e-01 -5.997167072809022e+00 -6.007618656862315e+00 3.722060924185867e+00 4.662046311174453e+00 9.240466555260395e+03 + 8120 1.023400174337499e+00 -6.052740926542024e+00 -5.966207031011225e+00 3.465419502095283e+00 4.962310521310190e+00 9.113612370358282e+03 + 8140 1.039190543711173e+00 -6.030692550510784e+00 -5.966007599561972e+00 3.552640364729506e+00 4.924071363041394e+00 9.112975093863261e+03 + 8160 9.754133026862892e-01 -5.891039106097580e+00 -5.977826254216075e+00 4.313803501420507e+00 4.815458266656340e+00 9.149072788319401e+03 + 8180 1.015801642791104e+00 -5.907451112856613e+00 -6.000367226709385e+00 4.143426944451869e+00 4.609888239987098e+00 9.218164970110764e+03 + 8200 1.021688871640516e+00 -5.882073080260526e+00 -6.043878947115670e+00 4.284105777791714e+00 4.354991450932510e+00 9.352234022907280e+03 + 8220 1.080301675909575e+00 -5.948723809209726e+00 -6.040341534358636e+00 3.943937499191578e+00 4.417854343589392e+00 9.341305968443316e+03 + 8240 1.108382660967092e+00 -5.984492876110729e+00 -5.982067012789423e+00 3.764387527347858e+00 4.778317209939934e+00 9.162061960736852e+03 + 8260 1.045503993036920e+00 -5.893075006996722e+00 -6.008987443355833e+00 4.274628361711495e+00 4.609041214745924e+00 9.244635190211489e+03 + 8280 1.069644424321301e+00 -5.936854412499327e+00 -5.984993049009274e+00 3.989824002094092e+00 4.713404501824050e+00 9.171045672589971e+03 + 8300 1.038806367684439e+00 -5.904820776209504e+00 -6.021667069963057e+00 4.200395326479708e+00 4.529445825841286e+00 9.283658853671044e+03 + 8320 1.050280684495871e+00 -5.942145328192187e+00 -5.970552227891130e+00 3.967978799030100e+00 4.804861985005249e+00 9.126856923972080e+03 + 8340 9.950251347572576e-01 -5.880309089343729e+00 -5.959533980608529e+00 4.325005565715962e+00 4.870083980061183e+00 9.093242673808831e+03 + 8360 1.041626682637950e+00 -5.970855810800938e+00 -5.978517077592771e+00 3.820017031197647e+00 4.776024851701735e+00 9.151203358062694e+03 + 8380 1.004124815092561e+00 -5.937556618195869e+00 -5.968003788122336e+00 4.005086850455758e+00 4.830254489053670e+00 9.119080216536127e+03 + 8400 1.030785410544355e+00 -5.999044846975131e+00 -5.975767944378014e+00 3.683074873158704e+00 4.816734449960385e+00 9.142801050732520e+03 + 8420 9.760472254088591e-01 -5.938647137708887e+00 -6.009635482662998e+00 4.025075970972286e+00 4.617449908834904e+00 9.246646937955480e+03 + 8440 9.811586737657725e-01 -5.967864705083958e+00 -5.988583641794389e+00 3.795403875673599e+00 4.676432534837214e+00 9.182033592884563e+03 + 8460 9.818938801712748e-01 -5.985833380564230e+00 -5.958540446383595e+00 3.776411463146998e+00 4.933131714780119e+00 9.090180370122020e+03 + 8480 9.665609780835528e-01 -5.971968880586969e+00 -5.996242064708357e+00 3.904693555687026e+00 4.765313176198918e+00 9.205499974128566e+03 + 8500 1.018619771488148e+00 -6.056435876823723e+00 -5.940112224449670e+00 3.457401655212753e+00 5.125350068171593e+00 9.034126317569646e+03 + 8520 9.526710325316246e-01 -5.962098014157290e+00 -5.954922970433390e+00 3.937525395210844e+00 4.978725606607903e+00 9.079151585649128e+03 + 8540 1.011437546985064e+00 -6.049004612189174e+00 -5.954297911803649e+00 3.455869094546850e+00 4.999689623975053e+00 9.077269058914992e+03 + 8560 9.923068617028381e-01 -6.018438507246602e+00 -5.992829229807393e+00 3.624579791357629e+00 4.771632225436443e+00 9.195046944676606e+03 + 8580 9.743329077901528e-01 -5.989294301925881e+00 -5.997955201050744e+00 3.739524265204194e+00 4.689792042159421e+00 9.210777417493282e+03 + 8600 1.038933545219520e+00 -6.081563955744997e+00 -5.997223892384987e+00 3.269861181009516e+00 4.754154876405315e+00 9.208538237702434e+03 + 8620 1.004811924004112e+00 -6.028877850677456e+00 -5.995013314879081e+00 3.570292047105434e+00 4.764747452179684e+00 9.201761134775503e+03 + 8640 9.042409371983062e-01 -5.877601545746147e+00 -6.034651157575736e+00 4.343849649522177e+00 4.442046475047794e+00 9.323683328489375e+03 + 8660 9.718515117529635e-01 -5.974053793488278e+00 -6.009060146001669e+00 3.826125968638301e+00 4.625114075290863e+00 9.244857456706844e+03 + 8680 1.016038699402894e+00 -6.035719410748202e+00 -6.009122709991038e+00 3.480858643460031e+00 4.633581015033807e+00 9.245078034264425e+03 + 8700 9.941146580714835e-01 -6.001209525154175e+00 -6.015517562125872e+00 3.647393829228893e+00 4.565234866775848e+00 9.264725546595986e+03 + 8720 1.020850629244716e+00 -6.038482920019320e+00 -5.966927802404495e+00 3.500044423324201e+00 4.910924981787194e+00 9.115771740672224e+03 + 8740 9.827152680494838e-01 -5.977465725698175e+00 -5.998610884721756e+00 3.764528230540248e+00 4.643109455224063e+00 9.212791804753073e+03 + 8760 9.968507621604232e-01 -5.994377224372432e+00 -6.039805528028324e+00 3.730097368203098e+00 4.469241018603689e+00 9.339650961123880e+03 + 8780 8.764117556433408e-01 -5.813904581373118e+00 -6.080300259718758e+00 4.680319570871971e+00 4.150634361213320e+00 9.465181815917984e+03 + 8800 1.018890091346957e+00 -6.024250927257823e+00 -5.988207989347802e+00 3.581025741682792e+00 4.787989868788746e+00 9.180882617943131e+03 + 8820 1.009950037046913e+00 -6.008399317055590e+00 -6.029000789768031e+00 3.669577025388054e+00 4.551280181005616e+00 9.306297915466588e+03 + 8840 9.657074160205878e-01 -5.941935136208945e+00 -6.034786248103749e+00 4.010848803173062e+00 4.477683350009975e+00 9.324153654693951e+03 + 8860 1.017173515156002e+00 -6.019911136688190e+00 -6.008080623081010e+00 3.566105899136201e+00 4.634038539034688e+00 9.241867924631366e+03 + 8880 1.001287290454898e+00 -5.996396447196171e+00 -6.017130346559332e+00 3.703743305639244e+00 4.584686046935414e+00 9.269705346917985e+03 + 8900 1.083519703159325e+00 -6.118841234972435e+00 -5.984385083776121e+00 3.067181130901148e+00 4.839249158092535e+00 9.169201796099618e+03 + 8920 1.031656373245042e+00 -6.044993580790487e+00 -6.042037061766809e+00 3.469482297378607e+00 4.486459087132403e+00 9.346568668921378e+03 + 8940 9.992368937580539e-01 -6.003231992659405e+00 -5.985832084005798e+00 3.664207041824773e+00 4.764120009940944e+00 9.173612903210898e+03 + 8960 9.256933703749293e-01 -5.899335870553142e+00 -5.984592465147309e+00 4.281068818826553e+00 4.791512259251472e+00 9.169782332135363e+03 + 8980 9.934508117826832e-01 -6.001804246681455e+00 -5.941733625996394e+00 3.694421118573314e+00 5.039355918445444e+00 9.039041576431067e+03 + 9000 9.635314000748008e-01 -5.956856421192263e+00 -5.980939344254325e+00 3.967109315802432e+00 4.828821444759770e+00 9.158603176617566e+03 + 9020 9.864768993431361e-01 -5.986170031861555e+00 -5.989608470064649e+00 3.802458272197657e+00 4.782714227938897e+00 9.185149667300690e+03 + 9040 1.055279273689911e+00 -6.080548945254758e+00 -6.011118480123336e+00 3.254017883636210e+00 4.652698358750590e+00 9.251209100135407e+03 + 9060 1.049276594851777e+00 -6.064058947568468e+00 -5.979973919269995e+00 3.442759410417775e+00 4.925588655023684e+00 9.155678309029194e+03 + 9080 9.918661805998126e-01 -5.966781543457326e+00 -5.989011285081634e+00 3.888723022761304e+00 4.761076406313132e+00 9.183340517330136e+03 + 9100 1.043097998987318e+00 -6.019321313890502e+00 -6.013849871457147e+00 3.625738302727086e+00 4.657156171882392e+00 9.259615889429295e+03 + 9120 1.036785088172081e+00 -5.980262880017015e+00 -6.009884505613908e+00 3.840258640696548e+00 4.670166682587443e+00 9.247413539332798e+03 + 9140 9.789414837735084e-01 -5.864837285409031e+00 -6.046999958780339e+00 4.406333413865533e+00 4.360327153784882e+00 9.361885865529463e+03 + 9160 1.032735672841391e+00 -5.914574040801467e+00 -6.046510937536700e+00 4.160783024575714e+00 4.403180946353222e+00 9.360364952724496e+03 + 9180 1.048820574180894e+00 -5.913306563879768e+00 -6.048670364366198e+00 4.136331827703472e+00 4.359051937829967e+00 9.367066883878968e+03 + 9200 1.102916272286579e+00 -5.976446412844500e+00 -6.005362276025407e+00 3.809114410504149e+00 4.643075049404015e+00 9.233512892243549e+03 + 9220 1.020106471684230e+00 -5.842952569818697e+00 -6.055987341861826e+00 4.509948878543689e+00 4.286670250447619e+00 9.389705518197474e+03 + 9240 1.063499030535254e+00 -5.905779325686924e+00 -6.049374439040145e+00 4.196329296411197e+00 4.371783934265024e+00 9.369224244106515e+03 + 9260 9.831228089335664e-01 -5.794820336157807e+00 -6.058288736570042e+00 4.847116780761882e+00 4.334240453991639e+00 9.396825705241983e+03 + 9280 1.067546029595670e+00 -5.937393516846343e+00 -6.012767442625028e+00 4.105451163872145e+00 4.672642417973614e+00 9.256268885243620e+03 + 9300 1.070060199542935e+00 -5.965404811776148e+00 -6.026261696808802e+00 3.859583688312535e+00 4.510134036882516e+00 9.297829181994499e+03 + 9320 1.011676603253283e+00 -5.911827779316992e+00 -6.017160731525385e+00 4.139388535651622e+00 4.534550423849356e+00 9.269783946998074e+03 + 9340 1.004392753977360e+00 -5.936406715757382e+00 -6.005581558932750e+00 4.100563183277258e+00 4.703350528991913e+00 9.234178880473659e+03 + 9360 1.072040378465132e+00 -6.075185475531935e+00 -5.984105573333039e+00 3.252158557648542e+00 4.775153450643913e+00 9.168336450100089e+03 + 9380 1.027991800584641e+00 -6.044690576645766e+00 -5.983403786925880e+00 3.409043321930048e+00 4.760961552601691e+00 9.166177202653271e+03 + 9400 1.015460170146175e+00 -6.055355379100657e+00 -5.967598039759229e+00 3.386797775958455e+00 4.890713998861303e+00 9.117872150062454e+03 + 9420 9.277164053513555e-01 -5.946516163525734e+00 -6.032460310687878e+00 4.009825721860647e+00 4.516321129041834e+00 9.316975296019922e+03 + 9440 1.028688187071396e+00 -6.112842701303800e+00 -5.981429785676115e+00 3.061546210667481e+00 4.816139508284615e+00 9.160138661836780e+03 + 9460 8.823062911491397e-01 -5.907495429295074e+00 -6.035057002222356e+00 4.165093329118388e+00 4.432615037280322e+00 9.324962979642603e+03 + 9480 9.487148977767945e-01 -6.012302741876283e+00 -5.976176060187790e+00 3.587882136842998e+00 4.795327133684247e+00 9.144035256215631e+03 + 9500 9.788746013326195e-01 -6.056998165875655e+00 -5.966584592389978e+00 3.353089749347117e+00 4.872258479757154e+00 9.114743786951982e+03 + 9520 9.462804637740253e-01 -6.004424038086052e+00 -5.990731807575887e+00 3.655124731896214e+00 4.733747638351405e+00 9.188625080820930e+03 + 9540 9.870842078827310e-01 -6.056653307127925e+00 -6.006781522697102e+00 3.356623954916282e+00 4.642995458751768e+00 9.237875496261415e+03 + 9560 9.567080731439971e-01 -6.002127208647144e+00 -5.981233863757245e+00 3.696771376327647e+00 4.816744195920122e+00 9.159499591487505e+03 + 9580 9.126428083279599e-01 -5.921403881952156e+00 -6.001836284559061e+00 4.106722409751839e+00 4.644867107108913e+00 9.222663491142104e+03 + 9600 9.747629701341237e-01 -5.992665615111491e+00 -6.019381939128658e+00 3.711376813681429e+00 4.557967546837073e+00 9.276642740214236e+03 + 9620 1.048171679937623e+00 -6.077481130868685e+00 -5.970460106527288e+00 3.287003408383000e+00 4.901534691601299e+00 9.126605496164279e+03 + 9640 1.002604844972445e+00 -5.985779474754782e+00 -6.008464594358172e+00 3.775672572429824e+00 4.645411105156248e+00 9.243044063358853e+03 + 9660 1.012768162180425e+00 -5.976323284983285e+00 -5.970800828178485e+00 3.863586297685199e+00 4.895297099255785e+00 9.127629574711606e+03 + 9680 9.460434196189967e-01 -5.848809673973721e+00 -6.018393433801712e+00 4.537376521357970e+00 4.563600329423625e+00 9.273579890957326e+03 + 9700 1.040083543218447e+00 -5.957487134633883e+00 -6.006248816293832e+00 3.942551236333663e+00 4.662554114396388e+00 9.236231278178886e+03 + 9720 1.078120582865295e+00 -5.980219920957683e+00 -5.987632979580344e+00 3.745404982499811e+00 4.702838052721379e+00 9.179141009926960e+03 + 9740 1.065959098480569e+00 -5.933100985034915e+00 -5.978317621378944e+00 4.106435965544792e+00 4.846795042405517e+00 9.150599119378992e+03 + 9760 1.041619311912237e+00 -5.868126136015771e+00 -6.038608161697590e+00 4.442553867916603e+00 4.463619694443390e+00 9.335948980511874e+03 + 9780 1.112387100577437e+00 -5.948156711931792e+00 -6.031453981305036e+00 3.986004737345746e+00 4.507698926393800e+00 9.313838479091874e+03 + 9800 1.078116900723983e+00 -5.875907347200986e+00 -5.957942378711030e+00 4.457336772635692e+00 4.986278926824919e+00 9.088378446001607e+03 + 9820 1.096684714146620e+00 -5.883078848821527e+00 -6.001351071871992e+00 4.364102280667699e+00 4.684964873344559e+00 9.221146025201337e+03 + 9840 1.107859076922788e+00 -5.877066314220531e+00 -6.016018352405779e+00 4.273634790471869e+00 4.475750684453764e+00 9.266243552536167e+03 + 9860 1.019892986921529e+00 -5.725521322947404e+00 -6.049404045064248e+00 5.118763019087349e+00 4.258978308003166e+00 9.369296714111288e+03 + 9880 1.162674840810392e+00 -5.918911789561905e+00 -6.021304712648304e+00 4.144656723610029e+00 4.556700713994294e+00 9.282554289293150e+03 + 9900 1.181857539976539e+00 -5.940766526539827e+00 -6.024439476454921e+00 4.020599451829673e+00 4.540136425070052e+00 9.292221161686657e+03 + 9920 1.042830541057546e+00 -5.748972972060615e+00 -6.095022799098583e+00 4.942853002682374e+00 3.955781344792697e+00 9.511062924306727e+03 + 9940 1.057344192286364e+00 -5.804436579073846e+00 -6.027665703086377e+00 4.724533934606615e+00 4.442717759931359e+00 9.302148984327232e+03 + 9960 1.073237774920256e+00 -5.872984821043216e+00 -6.004337585745535e+00 4.397555817930519e+00 4.643307916235162e+00 9.230347088731030e+03 + 9980 1.106753768256607e+00 -5.972024408278690e+00 -5.989821298009029e+00 3.864947826287557e+00 4.762755331396169e+00 9.185814528116402e+03 + 10000 1.062782064138489e+00 -5.957927223060536e+00 -6.027754502803509e+00 3.942889497489095e+00 4.541930451468325e+00 9.302438277605383e+03 + 10020 1.042537879853328e+00 -5.974027835401715e+00 -6.016273109172037e+00 3.871895242664557e+00 4.629316343240381e+00 9.267072695461178e+03 + 10040 9.824528935330273e-01 -5.923353609670399e+00 -5.991845771106131e+00 4.086303248157003e+00 4.693010658065302e+00 9.192039358845515e+03 + 10060 1.009026067214335e+00 -5.993186977710830e+00 -5.961767005443864e+00 3.825805129364932e+00 5.006223472346843e+00 9.100017191871380e+03 + 10080 1.012369647695517e+00 -6.021915851550521e+00 -5.973650075153748e+00 3.628192289885843e+00 4.905341847060869e+00 9.136343337072285e+03 + 10100 9.839540576276056e-01 -6.001448457337824e+00 -6.050142978242833e+00 3.651739740940596e+00 4.372128266451278e+00 9.371575626376309e+03 + 10120 9.874738092876713e-01 -6.024245994287664e+00 -6.018110015127808e+00 3.507016292061510e+00 4.542250033937114e+00 9.272758919002190e+03 + 10140 9.772970721197446e-01 -6.027333634718453e+00 -6.010490467958778e+00 3.536501474921955e+00 4.633217544927636e+00 9.249253759284773e+03 + 10160 9.131511494721745e-01 -5.946162283591611e+00 -6.004402456138424e+00 4.004246556709828e+00 4.669822473308455e+00 9.230553626379216e+03 + 10180 9.801757437641923e-01 -6.054496280302692e+00 -5.949986650364843e+00 3.476768842320137e+00 5.076879310236231e+00 9.064137866066840e+03 + 10200 9.904875027833777e-01 -6.074972341924766e+00 -5.983054466221962e+00 3.331524889168096e+00 4.859331555698887e+00 9.165096892041263e+03 + 10220 9.955464454554274e-01 -6.084836956399575e+00 -6.012829441788008e+00 3.225455306457840e+00 4.638933598484329e+00 9.256484659487238e+03 + 10240 9.075006830368464e-01 -5.954363392774244e+00 -6.025069412893169e+00 3.985646594623759e+00 4.579641685379642e+00 9.294162053585482e+03 + 10260 9.199302775779932e-01 -5.968762266516940e+00 -5.969655614967563e+00 3.887132337200949e+00 4.882002592152249e+00 9.124108915991603e+03 + 10280 1.015454521710652e+00 -6.097950904199731e+00 -5.965431436201008e+00 3.157027543140851e+00 4.917974835710917e+00 9.111242842938962e+03 + 10300 9.904370786584795e-01 -6.044835999991675e+00 -5.982792007482603e+00 3.469308506122033e+00 4.825574712385935e+00 9.164295921759409e+03 + 10320 1.042884323798245e+00 -6.100165225806546e+00 -5.976957246913199e+00 3.137135579975738e+00 4.844614861154449e+00 9.146448308135014e+03 + 10340 9.978575966735166e-01 -6.007263783462824e+00 -5.967242347509822e+00 3.653197492189464e+00 4.883006770728799e+00 9.116738737971184e+03 + 10360 1.017390393751297e+00 -6.006634167465231e+00 -5.934117292484586e+00 3.691911380225945e+00 5.108314498314948e+00 9.015879935005583e+03 + 10380 1.011763668369974e+00 -5.964535864620655e+00 -5.973430823651527e+00 3.854269594797032e+00 4.803193363551301e+00 9.135641207758668e+03 + 10400 1.006294621833472e+00 -5.921058678604258e+00 -5.981444576165668e+00 4.131868630047681e+00 4.785123461562620e+00 9.160141819685843e+03 + 10420 1.088962771933305e+00 -6.011497716545380e+00 -5.998556861239488e+00 3.623467161009761e+00 4.697775554767079e+00 9.212616640389639e+03 + 10440 1.019311325497249e+00 -5.885100156046828e+00 -6.015238600405290e+00 4.310680853664079e+00 4.563405767298616e+00 9.263878567206251e+03 + 10460 9.824141619172314e-01 -5.815566925582319e+00 -6.049166210928774e+00 4.638421436962689e+00 4.297058191130762e+00 9.368553257047512e+03 + 10480 1.039227562698450e+00 -5.890200573021524e+00 -6.017732625877509e+00 4.277915220318094e+00 4.545606437297631e+00 9.271557511978977e+03 + 10500 1.013217216499692e+00 -5.851011735149619e+00 -6.070085553719180e+00 4.446632312656345e+00 4.188676544866071e+00 9.433431767275655e+03 + 10520 1.062279317409516e+00 -5.930592597578407e+00 -6.034238238304610e+00 4.067816578327991e+00 4.472667270167066e+00 9.322438997258418e+03 + 10540 1.037690557252582e+00 -5.908917384402380e+00 -6.034196847415637e+00 4.173344106119112e+00 4.453970042562747e+00 9.322299392743840e+03 + 10560 1.057948486647663e+00 -5.957968130810841e+00 -6.020218881627506e+00 3.888325063975439e+00 4.530871619513592e+00 9.279212568123232e+03 + 10580 1.049447309014212e+00 -5.969579705589926e+00 -6.007406918928693e+00 3.827239809531239e+00 4.610030096797692e+00 9.239830476939771e+03 + 10600 1.081233708254768e+00 -6.044211148743543e+00 -6.005547033495003e+00 3.471817697902211e+00 4.693833030911822e+00 9.234086084549992e+03 + 10620 1.037882007268125e+00 -6.008130085361410e+00 -6.003640545608080e+00 3.651453823006729e+00 4.677233455024378e+00 9.228237773507257e+03 + 10640 1.002011179069096e+00 -5.977919837210095e+00 -5.978827604055644e+00 3.831243770756652e+00 4.826031233053047e+00 9.152156555214324e+03 + 10660 9.191693871012315e-01 -5.868584758489209e+00 -6.023390541535559e+00 4.276069223614195e+00 4.387150461244552e+00 9.288983023738641e+03 + 10680 1.017800701473648e+00 -6.022111649766810e+00 -6.013130530073434e+00 3.527647639787632e+00 4.579218618890773e+00 9.257358255075036e+03 + 10700 9.959971034611009e-01 -5.995642208164071e+00 -5.995025318916811e+00 3.689856193239597e+00 4.693398466760667e+00 9.201791378094571e+03 + 10720 9.652774858413338e-01 -5.953724782843397e+00 -6.013114345438640e+00 3.946560759681575e+00 4.605536700754576e+00 9.257349825790012e+03 + 10740 1.049449200613198e+00 -6.081318918629134e+00 -6.004749357649367e+00 3.262550939653003e+00 4.702225207900090e+00 9.231629294717548e+03 + 10760 1.025841480270781e+00 -6.050044995863201e+00 -6.017178447483561e+00 3.422739345900134e+00 4.611464152777955e+00 9.269850734454205e+03 + 10780 9.262053658743513e-01 -5.905647758659430e+00 -6.032833296806214e+00 4.225555343587694e+00 4.495236301650441e+00 9.318098276851128e+03 + 10800 9.667228040797280e-01 -5.967755568495869e+00 -6.021129911326202e+00 3.868201683391729e+00 4.561717947207101e+00 9.282042410770426e+03 + 10820 9.698155457884314e-01 -5.972584742832305e+00 -6.044154767856118e+00 3.817085213110897e+00 4.406119053998585e+00 9.353093208085902e+03 + 10840 1.009894503388891e+00 -6.032495116073739e+00 -6.018473165562448e+00 3.489091355214843e+00 4.569607564940505e+00 9.273867172695398e+03 + 10860 1.008072085554609e+00 -6.032026729179854e+00 -6.021847075476702e+00 3.498229858248470e+00 4.556683005108287e+00 9.284210446461891e+03 + 10880 1.004708032182679e+00 -6.027669550773167e+00 -5.962792414629952e+00 3.591143956208357e+00 4.963678511647073e+00 9.103146752833105e+03 + 10900 9.884308822651190e-01 -6.001192920280648e+00 -6.010633084591926e+00 3.738417658217239e+00 4.684210773881174e+00 9.249714563650543e+03 + 10920 1.033092893488223e+00 -6.064527962658701e+00 -6.023550677113668e+00 3.330316750412575e+00 4.565614665226600e+00 9.289498191456823e+03 + 10940 1.014486724481529e+00 -6.035096993321953e+00 -6.038072432722831e+00 3.458925579544984e+00 4.441840146057386e+00 9.334295667558827e+03 + 10960 1.028030684552815e+00 -6.054818058945912e+00 -5.994100191086344e+00 3.379552051838103e+00 4.728203445147431e+00 9.198958876149241e+03 + 10980 9.681596892005307e-01 -5.965910145771780e+00 -5.976132434405902e+00 3.874437336999790e+00 4.815739373768604e+00 9.143918056697232e+03 + 11000 9.537240445728551e-01 -5.941843499088440e+00 -5.981042451904003e+00 4.026383306783371e+00 4.801296853698068e+00 9.158930299432537e+03 + 11020 9.922668799709220e-01 -5.991669364431152e+00 -6.026007958332180e+00 3.734315729496472e+00 4.537138209436536e+00 9.297029312125607e+03 + 11040 1.074662614043527e+00 -6.103773264493199e+00 -6.023687271410833e+00 3.113400323166056e+00 4.573266488712378e+00 9.289921366493900e+03 + 11060 1.017535448474088e+00 -6.008984187702763e+00 -6.048439029021065e+00 3.648983701020969e+00 4.422427896554323e+00 9.366354751637838e+03 + 11080 9.841443207394001e-01 -5.951640274586071e+00 -6.025844019806799e+00 3.955730502192746e+00 4.529641114142862e+00 9.296554966282294e+03 + 11100 9.722037192109234e-01 -5.924907390698005e+00 -5.997322136247743e+00 4.094856277254687e+00 4.679039602162432e+00 9.208839049151047e+03 + 11120 1.006787203558836e+00 -5.966142577868007e+00 -5.961218300188949e+00 3.931449262301388e+00 4.959725226764050e+00 9.098352949235779e+03 + 11140 1.023833601903766e+00 -5.981555234537621e+00 -5.986092286292642e+00 3.779374161582284e+00 4.753321708298460e+00 9.174392841116220e+03 + 11160 9.814120578547727e-01 -5.905981103915170e+00 -5.956264299695937e+00 4.264453455636060e+00 4.975719564163499e+00 9.083236079902754e+03 + 11180 1.035507342033103e+00 -5.971384207677268e+00 -5.984630226911241e+00 3.813484284622155e+00 4.737423592365832e+00 9.169899882888370e+03 + 11200 1.014673255722701e+00 -5.924156880947510e+00 -6.036737893060928e+00 4.113232613871728e+00 4.466775020461166e+00 9.330151088269064e+03 + 11220 1.027101674241339e+00 -5.928677878447156e+00 -6.072655555881941e+00 4.057520169928059e+00 4.230778065623954e+00 9.441442466022509e+03 + 11240 1.009535419846097e+00 -5.895916945114865e+00 -6.045643335348117e+00 4.249700095346263e+00 4.389947992542924e+00 9.357681609585836e+03 + 11260 1.056474828979347e+00 -5.962171015147373e+00 -6.035701183637293e+00 3.862866806938879e+00 4.440645200712957e+00 9.326982705941058e+03 + 11280 1.073505805376476e+00 -5.992646152004697e+00 -6.007312965760439e+00 3.759790844205411e+00 4.675571729937843e+00 9.239490550968980e+03 + 11300 1.027837941948915e+00 -5.937895383553011e+00 -5.929020962089674e+00 4.029823941446037e+00 5.080782242800801e+00 9.000428403194948e+03 + 11320 9.679178384492290e-01 -5.863364184537270e+00 -5.987730208531579e+00 4.397029340781053e+00 4.682900385425721e+00 9.179371101404571e+03 + 11340 1.031896210002186e+00 -5.975610495624409e+00 -6.008444604154413e+00 3.886094272446564e+00 4.697555740205408e+00 9.242949487151007e+03 + 11360 9.756252298265461e-01 -5.917320970225714e+00 -6.047507455947283e+00 4.121002814304926e+00 4.373451866998121e+00 9.363469137323824e+03 + 11380 1.012672441073498e+00 -6.005482875820356e+00 -5.997605046344849e+00 3.681545703448684e+00 4.726781419387216e+00 9.209710367818236e+03 + 11400 9.875214243974701e-01 -6.004695378857832e+00 -6.000895329816085e+00 3.629533295244342e+00 4.651353764897743e+00 9.219781692041966e+03 + 11420 9.922960109224869e-01 -6.046560552754995e+00 -5.977040107336223e+00 3.510470391074532e+00 4.909667546923281e+00 9.146680816497288e+03 + 11440 1.012843080183593e+00 -6.105728371683282e+00 -5.981421775193635e+00 3.095607317494015e+00 4.809395030921207e+00 9.160115723110732e+03 + 11460 1.008050047071573e+00 -6.121347042898979e+00 -5.946335228853945e+00 3.085238309416540e+00 5.090183228653821e+00 9.053056570579782e+03 + 11480 9.687681671469743e-01 -6.080525904368686e+00 -5.951750855046871e+00 3.312704036682407e+00 5.052150297762749e+00 9.069540996965261e+03 + 11500 9.088836695462323e-01 -6.001387047600026e+00 -6.009976170629004e+00 3.679052430933058e+00 4.629732357338172e+00 9.247693077136599e+03 + 11520 9.951724902988180e-01 -6.133607397720047e+00 -5.968623800720589e+00 2.990270745564536e+00 4.937632090664543e+00 9.120983355757238e+03 + 11540 9.376707590320388e-01 -6.047205264356971e+00 -5.945620132563029e+00 3.451435012294503e+00 5.034752559303660e+00 9.050857174923454e+03 + 11560 9.748801426975526e-01 -6.094398794535675e+00 -5.929034173124574e+00 3.147932612041331e+00 5.097481858276339e+00 9.000459128102664e+03 + 11580 9.505487071155164e-01 -6.041111040984991e+00 -5.937427674852026e+00 3.510085505506332e+00 5.105451438790873e+00 9.025957331551010e+03 + 11600 9.622138807647858e-01 -6.032977400867259e+00 -5.972399332485563e+00 3.568870778357429e+00 4.916719421430914e+00 9.132497024245227e+03 + 11620 9.808364142709015e-01 -6.031633431503484e+00 -5.969893033923491e+00 3.510737877810404e+00 4.865260795010367e+00 9.124854807914033e+03 + 11640 9.368128661161454e-01 -5.935512719511946e+00 -5.996191897077992e+00 4.050322741992083e+00 4.701893514335465e+00 9.205333547496100e+03 + 11660 9.939384690669947e-01 -5.990149772087907e+00 -5.991804094532365e+00 3.764537199663331e+00 4.755037824181681e+00 9.191889666351990e+03 + 11680 1.031176591633643e+00 -6.018393478922981e+00 -5.992203247543886e+00 3.618726950753056e+00 4.769115312257031e+00 9.193114970175029e+03 + 11700 1.026333415010537e+00 -5.993285983281188e+00 -5.998795351882253e+00 3.714450677654117e+00 4.682815030574766e+00 9.213353653188040e+03 + 11720 1.023903335911007e+00 -5.979767390997818e+00 -6.018795532255941e+00 3.788822601208074e+00 4.564716974518594e+00 9.274847496489676e+03 + 11740 1.063973422247846e+00 -6.036133468204518e+00 -6.007709969872422e+00 3.502055225241880e+00 4.665267351186932e+00 9.240710733767537e+03 + 11760 1.001232523245312e+00 -5.943014891062190e+00 -6.014831546187494e+00 3.934358758622791e+00 4.521976411301829e+00 9.262646407561469e+03 + 11780 1.028605356124832e+00 -5.985580523188041e+00 -6.013435845506908e+00 3.788143090306529e+00 4.628193518954393e+00 9.258339362056562e+03 + 11800 9.829852024559178e-01 -5.924538657734039e+00 -5.990024246040984e+00 4.046232234234598e+00 4.670203852314081e+00 9.186436983498932e+03 + 11820 9.668595446891648e-01 -5.906130730282630e+00 -6.002347042959519e+00 4.189844620207651e+00 4.637355663390687e+00 9.224210300696834e+03 + 11840 9.665569284796279e-01 -5.911368672867480e+00 -6.028853998703951e+00 4.134332382403381e+00 4.459713460654949e+00 9.305815507115014e+03 + 11860 9.420107033072974e-01 -5.879826944255774e+00 -6.013522395740694e+00 4.314613972629463e+00 4.546914000898800e+00 9.258594832639512e+03 + 11880 9.706963715011303e-01 -5.926588993370581e+00 -6.038891680192034e+00 4.014996543168088e+00 4.370137136654689e+00 9.336830676625586e+03 + 11900 1.031829254703316e+00 -6.022143357234981e+00 -6.028180106940601e+00 3.588699978105402e+00 4.554036027111736e+00 9.303747512547789e+03 + 11920 1.083590856041194e+00 -6.109430703077940e+00 -6.000633971358427e+00 3.113669027628229e+00 4.738396697401489e+00 9.219010235958558e+03 + 11940 1.018825931777119e+00 -6.028304836282217e+00 -6.008723607218321e+00 3.499353607664596e+00 4.611792055134894e+00 9.243841220815502e+03 + 11960 9.921154876310159e-01 -6.005916695499235e+00 -5.975317382305399e+00 3.689331855134716e+00 4.865037846722134e+00 9.141414014995440e+03 + 11980 9.128976380662722e-01 -5.906178649011517e+00 -5.985161244697197e+00 4.222389862117776e+00 4.768859575173418e+00 9.171495611095059e+03 + 12000 9.936365493014621e-01 -6.040262978868384e+00 -5.917453138138081e+00 3.487428661589617e+00 5.192621771824454e+00 8.965356477479274e+03 + 12020 1.021082686198270e+00 -6.090201941847695e+00 -5.957874062676535e+00 3.236539089531557e+00 4.996386249405480e+00 9.088192558803965e+03 + 12040 9.446713296686358e-01 -5.987015476276399e+00 -6.022496599392487e+00 3.758680955135377e+00 4.554942855516744e+00 9.286257249072985e+03 + 12060 9.812553265687054e-01 -6.052874638990982e+00 -6.024938546704787e+00 3.381790741361544e+00 4.542204106365189e+00 9.293776781068053e+03 + 12080 9.836325727811694e-01 -6.070668039313007e+00 -5.977087980733996e+00 3.311022080432358e+00 4.848373258260301e+00 9.146847159661207e+03 + 12100 9.733129906534999e-01 -6.068663267479435e+00 -5.948082500370528e+00 3.317252181535941e+00 5.009645606088684e+00 9.058353116841852e+03 + 12120 9.762342734466067e-01 -6.083307343685128e+00 -5.962626527758808e+00 3.236358550962773e+00 4.929326471307617e+00 9.102678583375000e+03 + 12140 8.668529164497186e-01 -5.928090872192326e+00 -6.007146634343116e+00 4.081028772240834e+00 4.627078352131344e+00 9.238980811316243e+03 + 12160 9.409951141521423e-01 -6.041543913746894e+00 -5.939412860996989e+00 3.565883255885642e+00 5.152335565504931e+00 9.031963970251563e+03 + 12180 1.003506225645033e+00 -6.129148366304634e+00 -5.972961870275594e+00 3.012661789625465e+00 4.909508819606355e+00 9.134204292112059e+03 + 12200 9.372706188133398e-01 -6.016424230767914e+00 -6.011501527699544e+00 3.606228798998631e+00 4.634495721803049e+00 9.252396447144802e+03 + 12220 9.871702099326898e-01 -6.068962112158292e+00 -6.011938531717732e+00 3.318941825099819e+00 4.646380048360073e+00 9.253742163710487e+03 + 12240 9.432562850867839e-01 -5.975034766069568e+00 -6.051200510294937e+00 3.825535516664446e+00 4.388180026711553e+00 9.374892515038211e+03 + 12260 1.012356869432345e+00 -6.045711524006354e+00 -5.982311854500773e+00 3.499173786612128e+00 4.863224499980320e+00 9.162837475887362e+03 + 12280 9.667773918214954e-01 -5.944047852540212e+00 -5.984915420871344e+00 4.044049208117990e+00 4.809381306524872e+00 9.170758236034731e+03 + 12300 9.546881029827269e-01 -5.890214345389857e+00 -5.983889520691763e+00 4.317584576667389e+00 4.779687223897312e+00 9.167622820388759e+03 + 12320 1.012688224095185e+00 -5.943441354802263e+00 -6.007257119937497e+00 4.002692846953775e+00 4.636252848089524e+00 9.239325748663687e+03 + 12340 1.046428021950719e+00 -5.966617548869865e+00 -5.973768885203241e+00 3.885459563552900e+00 4.844395483660930e+00 9.136712514234390e+03 + 12360 1.051536522785374e+00 -5.952808502232223e+00 -6.030061118594013e+00 3.963090083986544e+00 4.519493606033399e+00 9.309572125300614e+03 + 12380 1.098800361680690e+00 -6.011120842743171e+00 -6.019548756949925e+00 3.602636604026077e+00 4.554242216435386e+00 9.277141018114015e+03 + 12400 1.004504307056334e+00 -5.867103321160864e+00 -6.080114007420112e+00 4.392282832411368e+00 4.169142508613604e+00 9.464602221534666e+03 + 12420 1.006343669651734e+00 -5.874787232707534e+00 -6.013726158375403e+00 4.395333258605750e+00 4.597524446691586e+00 9.259226184573574e+03 + 12440 1.046288880276163e+00 -5.944309691551034e+00 -5.971828670948153e+00 3.962948013759905e+00 4.804929775513344e+00 9.130753347008769e+03 + 12460 1.054296850413643e+00 -5.968049715350995e+00 -5.979943244797585e+00 3.903791982543229e+00 4.835497495943171e+00 9.155511097616454e+03 + 12480 1.076144745519811e+00 -6.015354301615249e+00 -5.946730052875632e+00 3.616583407464474e+00 5.010634463295528e+00 9.054264731331319e+03 + 12500 1.022943210207720e+00 -5.956244532985490e+00 -6.036877110788494e+00 3.910273739551172e+00 4.447268999955235e+00 9.330593935103736e+03 + 12520 9.887961814755137e-01 -5.931760194440408e+00 -6.006649492040931e+00 4.084398861423808e+00 4.654372925520257e+00 9.237482394115003e+03 + 12540 1.013387562013467e+00 -6.000393955030078e+00 -6.031900478880081e+00 3.705245782069585e+00 4.524330446504058e+00 9.315232455684438e+03 + 12560 9.969098266830383e-01 -6.011190819273282e+00 -6.045660195551387e+00 3.620460240002740e+00 4.422531747295120e+00 9.357749842389620e+03 + 12580 1.002251677571879e+00 -6.055027141064377e+00 -6.010807484109926e+00 3.371762946614229e+00 4.625679059816482e+00 9.250278931036046e+03 + 12600 9.282518067092916e-01 -5.976746757508428e+00 -6.011705716033195e+00 3.798359631798945e+00 4.597619882068383e+00 9.253000279254489e+03 + 12620 9.545766676823163e-01 -6.038570625496161e+00 -5.981404528154663e+00 3.484799664208816e+00 4.813056241568672e+00 9.160050295622394e+03 + 12640 9.429581438290054e-01 -6.033768797923829e+00 -6.001992499391473e+00 3.496457966350360e+00 4.678922389889458e+00 9.223147140809169e+03 + 12660 9.104948121606214e-01 -5.990625215167247e+00 -6.005302438822258e+00 3.744006334926893e+00 4.659727445406801e+00 9.233307758194469e+03 + 12680 9.730728906488229e-01 -6.082248158023729e+00 -5.964043624606446e+00 3.330773163046458e+00 5.009521886020927e+00 9.106981627627800e+03 + 12700 9.448463075761803e-01 -6.034866028153978e+00 -5.991524187305273e+00 3.506120065389001e+00 4.754995622670460e+00 9.191056158710204e+03 + 12720 9.660760426471577e-01 -6.059147830629197e+00 -5.993227885799763e+00 3.392129391067980e+00 4.770651915357087e+00 9.196268447382396e+03 + 12740 1.003859220232606e+00 -6.106130324046015e+00 -5.952697472093877e+00 3.152064989821686e+00 5.033100169387962e+00 9.072409577247410e+03 + 12760 9.723320335523702e-01 -6.047526379932048e+00 -5.981877207007941e+00 3.406881134769545e+00 4.783848844876443e+00 9.161517485923019e+03 + 12780 9.688533895390007e-01 -6.027604122064929e+00 -6.016732815077759e+00 3.537356306704929e+00 4.599781033754578e+00 9.268495774764344e+03 + 12800 9.883777549893901e-01 -6.042874058242262e+00 -6.002351687662585e+00 3.451548945664995e+00 4.684234668350083e+00 9.224287468922868e+03 + 12820 1.018431618328430e+00 -6.074955785427985e+00 -5.966535039394754e+00 3.304381040324913e+00 4.926949742103953e+00 9.114603918316487e+03 + 12840 9.567449284977366e-01 -5.969317766158151e+00 -5.998310271510414e+00 3.896851276666259e+00 4.730371824357865e+00 9.211832061602032e+03 + 12860 9.224980491058583e-01 -5.902560302180225e+00 -5.982873831733098e+00 4.209827498723163e+00 4.748654783552037e+00 9.164548669616894e+03 + 12880 1.008008264748782e+00 -6.009926678683335e+00 -5.996034828786046e+00 3.610291024040890e+00 4.690060175907952e+00 9.204848704307260e+03 + 12900 1.058209656703621e+00 -6.063082317312167e+00 -5.961935120418953e+00 3.352572293274985e+00 4.933375150313951e+00 9.100580677515885e+03 + 12920 9.698236900208641e-01 -5.911592768809861e+00 -6.049807552568206e+00 4.154929178276744e+00 4.361278501267665e+00 9.370581299358122e+03 + 12940 1.052181367921238e+00 -6.017708279389982e+00 -6.007290014837530e+00 3.572592554097738e+00 4.632415841379148e+00 9.239437206502558e+03 + 12960 1.012727559202565e+00 -5.946755943425700e+00 -6.014578640587840e+00 3.970353573233212e+00 4.580905150599737e+00 9.261875673819126e+03 + 12980 1.046639767181839e+00 -5.986892370320407e+00 -6.009292350011466e+00 3.731756609309503e+00 4.603132459537789e+00 9.245573082319206e+03 + 13000 9.862625447977591e-01 -5.890123585110835e+00 -6.027184012338742e+00 4.293561362559682e+00 4.506539179384479e+00 9.300668667748032e+03 + 13020 1.020818141011533e+00 -5.935412169568536e+00 -6.002028041519155e+00 4.047056004216996e+00 4.664537358703673e+00 9.223287750057447e+03 + 13040 9.875746366692447e-01 -5.883273136781042e+00 -6.033228209782699e+00 4.297445107940162e+00 4.436379873292096e+00 9.319302949589714e+03 + 13060 1.032217254715105e+00 -5.949148353462636e+00 -6.017661116001882e+00 3.968626230353882e+00 4.575215345537790e+00 9.271338906193248e+03 + 13080 1.028181637733138e+00 -5.946287890245642e+00 -6.029583358749967e+00 3.996110643475530e+00 4.517815173391603e+00 9.308083981093983e+03 + 13100 1.076523285493425e+00 -6.032669563333755e+00 -6.032518246382167e+00 3.478282244139011e+00 4.479151129491255e+00 9.317163390583468e+03 + 13120 1.066424524098081e+00 -6.045803936336907e+00 -6.005718222311781e+00 3.477047020036573e+00 4.707225393213038e+00 9.234624444904259e+03 + 13140 1.040112053762905e+00 -6.046858256240305e+00 -5.965185991692822e+00 3.500172089255986e+00 4.969146871029723e+00 9.110481541518930e+03 + 13160 9.771776086825158e-01 -5.998414418418232e+00 -5.985249744747446e+00 3.776697246755947e+00 4.852290840200268e+00 9.171734546182493e+03 + 13180 1.029850553093112e+00 -6.118059487021155e+00 -5.967660831628075e+00 3.045597101434379e+00 4.909209454818141e+00 9.118027742727234e+03 + 13200 9.197616144938635e-01 -5.988550785817424e+00 -5.956798991196708e+00 3.819150495713135e+00 5.001474213999619e+00 9.084894977804215e+03 + 13220 8.855935729999710e-01 -5.958424069653322e+00 -5.972232091412314e+00 3.947504284121817e+00 4.868216486397226e+00 9.131999226519147e+03 + 13240 9.794652785409539e-01 -6.108650965950458e+00 -5.968379323494716e+00 3.110119599996902e+00 4.915581077944291e+00 9.120247573611590e+03 + 13260 9.637767044175340e-01 -6.090701838341100e+00 -6.023270520690153e+00 3.171239160811156e+00 4.558440221725574e+00 9.288632148269577e+03 + 13280 9.452164966529814e-01 -6.065098818080330e+00 -5.981138959702298e+00 3.357784877859307e+00 4.839895377412065e+00 9.159259960900450e+03 + 13300 9.278959487064370e-01 -6.035660704295840e+00 -6.009862760202399e+00 3.509630429252612e+00 4.657766216456102e+00 9.247351810164537e+03 + 13320 9.595362917539829e-01 -6.071465399039795e+00 -6.031643569806985e+00 3.294870913142138e+00 4.523534019005088e+00 9.314453704476618e+03 + 13340 9.805624617854728e-01 -6.085190074157312e+00 -5.988327127657031e+00 3.221796621359888e+00 4.777998649657031e+00 9.181293738467939e+03 + 13360 9.564863138806143e-01 -6.028027073372440e+00 -5.990019601011497e+00 3.561791510268483e+00 4.780036298202358e+00 9.186432799782106e+03 + 13380 1.017249245072571e+00 -6.089673368403393e+00 -5.969905569928443e+00 3.239062186477798e+00 4.926787419327875e+00 9.124908149263345e+03 + 13400 9.860846812565249e-01 -6.010790841497132e+00 -6.020038489940672e+00 3.665909761213462e+00 4.612808332781688e+00 9.278692902879280e+03 + 13420 9.617480303310642e-01 -5.941670688533135e+00 -6.075114204473765e+00 3.963182405633642e+00 4.196929086785190e+00 9.449064704569932e+03 + 13440 9.422580794241145e-01 -5.883039193763986e+00 -6.043125360475765e+00 4.325496353967473e+00 4.406256811454210e+00 9.349897510993082e+03 + 13460 1.063611572978500e+00 -6.035655157937191e+00 -6.004283858156993e+00 3.483781313764660e+00 4.663920171795509e+00 9.230202331206068e+03 + 13480 1.019972782762877e+00 -5.949986820005857e+00 -6.035211668302278e+00 3.945866976127029e+00 4.456492708706330e+00 9.325443452036052e+03 + 13500 9.858598643386435e-01 -5.886243240473112e+00 -6.037245731370238e+00 4.267204306987614e+00 4.400124636696376e+00 9.331712727227063e+03 + 13520 1.047216680259085e+00 -5.970525409645569e+00 -5.991014817592088e+00 3.882184408775273e+00 4.764531057620733e+00 9.189486268518549e+03 + 13540 1.012813642199252e+00 -5.917045534507268e+00 -6.016879334860818e+00 4.150392844857342e+00 4.577131713996587e+00 9.268932707567043e+03 + 13560 1.003265927948378e+00 -5.905321558213074e+00 -5.982774922662885e+00 4.201108594815326e+00 4.756359390275097e+00 9.164230230697767e+03 + 13580 9.728317627239790e-01 -5.864141905152371e+00 -5.998456274726784e+00 4.418493197806667e+00 4.647239302628871e+00 9.212263676175953e+03 + 13600 1.062511192606216e+00 -6.000848606645679e+00 -5.963486470013160e+00 3.718001485725216e+00 4.932540656041093e+00 9.105286590344953e+03 + 13620 9.944470366193420e-01 -5.905069242254024e+00 -6.010969941921219e+00 4.187794103876942e+00 4.579695898307602e+00 9.250746900405089e+03 + 13640 1.052983168544651e+00 -5.999674691804699e+00 -6.026482450514163e+00 3.651897312924177e+00 4.497963013927182e+00 9.298527569248752e+03 + 13660 9.948285228931260e-01 -5.923482826028681e+00 -6.048022268965010e+00 4.118721808671049e+00 4.403597054914138e+00 9.365047555838521e+03 + 13680 1.008833465975767e+00 -5.956245161446682e+00 -6.024708353216541e+00 4.016567752412502e+00 4.623441510625284e+00 9.292994359121565e+03 + 13700 1.041611328897764e+00 -6.017120393368925e+00 -5.993182931005585e+00 3.633817548521341e+00 4.771270161721974e+00 9.196123608793143e+03 + 13720 1.097039987299764e+00 -6.110198534360299e+00 -5.971062841274488e+00 3.122278772638490e+00 4.921217453516133e+00 9.128438445485421e+03 + 13740 1.045277027607819e+00 -6.044370630199463e+00 -5.976870550262293e+00 3.478315088227706e+00 4.865910992830545e+00 9.146175162997592e+03 + 13760 1.043205741031296e+00 -6.050534985556409e+00 -5.974205437742651e+00 3.416593462837814e+00 4.854889538343758e+00 9.138028143313251e+03 + 13780 9.063476619276001e-01 -5.856395031904208e+00 -6.002017369452898e+00 4.490747970006066e+00 4.654561972817582e+00 9.223222640258713e+03 + 13800 9.936159624019997e-01 -5.990392703823709e+00 -5.968742964348268e+00 3.722495325514806e+00 4.846811479869147e+00 9.121338368793360e+03 + 13820 1.017297040734155e+00 -6.026751134163661e+00 -6.013074779175863e+00 3.566883226355780e+00 4.645414973104812e+00 9.257227670348386e+03 + 13840 1.028205875824722e+00 -6.045273320395550e+00 -6.016070122164336e+00 3.441137377161181e+00 4.608826660585129e+00 9.266439287610217e+03 + 13860 1.057474035231557e+00 -6.092367041448914e+00 -5.979541503729791e+00 3.176552352949079e+00 4.824414050227821e+00 9.154357577156265e+03 + 13880 9.565213607707287e-01 -5.946596497454079e+00 -6.012588176211166e+00 4.012647435490965e+00 4.633713003888491e+00 9.255727864738592e+03 + 13900 1.009951541446198e+00 -6.027940255328508e+00 -5.991101279353382e+00 3.571363538175433e+00 4.782898639037716e+00 9.189741571120921e+03 + 13920 1.060426624950769e+00 -6.103552218976274e+00 -5.996321247059604e+00 3.157862471567484e+00 4.773599306252279e+00 9.205770188538536e+03 + 13940 1.020796304156536e+00 -6.047973470179844e+00 -6.013833936049226e+00 3.415827590169402e+00 4.611862078223245e+00 9.259573438135360e+03 + 13960 9.688319700885443e-01 -5.975161100952267e+00 -5.949337114740882e+00 3.862059762578487e+00 5.010345087653210e+00 9.062148920818714e+03 + 13980 9.717995189189411e-01 -5.980866352318083e+00 -5.905720321617858e+00 3.810228664818141e+00 5.241728801909503e+00 8.929845348688315e+03 + 14000 9.902082230717405e-01 -6.002557929457116e+00 -5.970815940590418e+00 3.690462572351313e+00 4.872729984480795e+00 9.127584429663788e+03 + 14020 9.774126390981804e-01 -5.972779347995193e+00 -5.982744454146278e+00 3.898781060421271e+00 4.841559878806546e+00 9.164142793343401e+03 + 14040 9.993847287378332e-01 -5.990413789568542e+00 -5.995804987946816e+00 3.832452013032250e+00 4.801494917658952e+00 9.204165978999381e+03 + 14060 1.027455782402183e+00 -6.011902961460427e+00 -6.043802976812951e+00 3.571285238555380e+00 4.388110413889768e+00 9.352012653753844e+03 + 14080 1.021964547008326e+00 -5.973798309097214e+00 -5.995300463360326e+00 3.870814182833477e+00 4.747345485607074e+00 9.202618012136081e+03 + 14100 1.094163790166205e+00 -6.033124954348923e+00 -6.005109087131116e+00 3.554859293389214e+00 4.715730738395306e+00 9.232735439293487e+03 + 14120 1.059002607549278e+00 -5.923278480214687e+00 -6.044181891517956e+00 4.108143630060153e+00 4.413897532614349e+00 9.353199121130050e+03 + 14140 1.091470221148424e+00 -5.919914498084180e+00 -6.037429510331143e+00 4.098453051811305e+00 4.423663666099873e+00 9.332322614204319e+03 + 14160 1.048352675169480e+00 -5.817158433825469e+00 -6.051947481997662e+00 4.687246970658661e+00 4.339051922566150e+00 9.377168776264632e+03 + 14180 1.081165798820521e+00 -5.843514379823632e+00 -6.022180369014292e+00 4.569661881375913e+00 4.543734122970671e+00 9.285236864644210e+03 + 14200 1.103525510205556e+00 -5.866842670330175e+00 -6.043626216785276e+00 4.460193038747022e+00 4.445074557836434e+00 9.351426958736041e+03 + 14220 1.152953746866324e+00 -5.945574789361446e+00 -6.047840224565404e+00 3.959194425341438e+00 4.371970470875358e+00 9.364459573091732e+03 + 14240 1.060571639307739e+00 -5.829887378726657e+00 -6.065838753870069e+00 4.585565469742528e+00 4.230696160311759e+00 9.420209084155020e+03 + 14260 1.081696966328759e+00 -5.892578224014195e+00 -6.000794929711442e+00 4.270831244327438e+00 4.649434173732761e+00 9.219464588312712e+03 + 14280 1.066694503502946e+00 -5.909248160495229e+00 -6.025427035808105e+00 4.172829517647796e+00 4.505712436978418e+00 9.295258017468965e+03 + 14300 1.061024901607693e+00 -5.940428224763174e+00 -6.016502520430822e+00 3.989792052876566e+00 4.552961674693723e+00 9.267775044805019e+03 + 14320 1.021582786743855e+00 -5.917970021489351e+00 -6.034414538896677e+00 4.144527223973610e+00 4.475884785289911e+00 9.322971510600943e+03 + 14340 9.958850001190119e-01 -5.910810869089333e+00 -6.004304456918030e+00 4.217179708370615e+00 4.680325058972279e+00 9.230248723293766e+03 + 14360 1.053437587973987e+00 -6.019898538737448e+00 -6.005299600318861e+00 3.671625235613868e+00 4.755454599191813e+00 9.233308853978338e+03 + 14380 9.541316908247983e-01 -5.893535860182322e+00 -6.076319082577913e+00 4.306072069066847e+00 4.256502520459110e+00 9.452824332325059e+03 + 14400 1.029215163989680e+00 -6.024522662461229e+00 -5.961539659937682e+00 3.565507050431850e+00 4.927165197510196e+00 9.099361753477606e+03 + 14420 9.534903521577018e-01 -5.925875767554153e+00 -5.981375502600432e+00 4.085683058501636e+00 4.766994991309660e+00 9.159938465661013e+03 + 14440 9.698858380002957e-01 -5.958209379860687e+00 -6.010389751569601e+00 3.913298753625897e+00 4.613670984386886e+00 9.248977084845874e+03 + 14460 1.000966090966179e+00 -6.012927322557827e+00 -6.044991611849244e+00 3.575880319986879e+00 4.391762208942833e+00 9.355704669952616e+03 + 14480 9.623197249514560e-01 -5.966104515959567e+00 -6.026067889261418e+00 3.879764441459854e+00 4.535445472658600e+00 9.297252657604580e+03 + 14500 9.821437273902185e-01 -6.006594827107545e+00 -5.981175960876802e+00 3.696985909192997e+00 4.842944972646756e+00 9.159331943388563e+03 + 14520 9.919920402789800e-01 -6.028306231632368e+00 -5.984807359559664e+00 3.526323933764272e+00 4.776101188634438e+00 9.170464425307053e+03 + 14540 9.346247387059581e-01 -5.947384739348180e+00 -6.006619333314084e+00 3.971033368518927e+00 4.630899163442908e+00 9.237348397598604e+03 + 14560 9.641676508487763e-01 -5.991637091320682e+00 -5.982779649707224e+00 3.712914882719768e+00 4.763775683148911e+00 9.164258400682342e+03 + 14580 1.005234774766878e+00 -6.048992485429141e+00 -5.994931450793544e+00 3.445722661758888e+00 4.756149488554554e+00 9.201481251800495e+03 + 14600 9.684328998229146e-01 -5.989435245732968e+00 -6.009438340172015e+00 3.769306027534895e+00 4.654445163797028e+00 9.246051170361588e+03 + 14620 9.779945041045314e-01 -5.997863161047110e+00 -6.038608008290250e+00 3.653054745858388e+00 4.419091527743547e+00 9.335945151192320e+03 + 14640 9.577514660441624e-01 -5.960339801077783e+00 -6.040487489346980e+00 3.891172821384758e+00 4.430952392528352e+00 9.341727510673518e+03 + 14660 9.783610442859163e-01 -5.978909297983122e+00 -5.972570791189567e+00 3.806937884300257e+00 4.843334571189607e+00 9.133015859676379e+03 + 14680 9.999348720428707e-01 -5.991052527930605e+00 -5.974896021658771e+00 3.698931006378255e+00 4.791704165602390e+00 9.140114024957415e+03 + 14700 9.698802100305616e-01 -5.917255271438414e+00 -5.976476165626075e+00 4.101844072818190e+00 4.761788533988882e+00 9.144954224403748e+03 + 14720 1.029786868695904e+00 -5.968851860996097e+00 -6.015166705893619e+00 3.878886565586542e+00 4.612939558985889e+00 9.263632724305020e+03 + 14740 1.068664592981896e+00 -5.987373554738988e+00 -6.017374443476910e+00 3.759913435033350e+00 4.587643689277678e+00 9.270489411092214e+03 + 14760 1.063746812009008e+00 -5.946245432474186e+00 -6.040315065451830e+00 3.943214245502948e+00 4.403051855716664e+00 9.341232514747418e+03 + 14780 1.070032557436574e+00 -5.931561111515113e+00 -5.941416848794622e+00 4.086738805974029e+00 5.030145637344678e+00 9.038080608980725e+03 + 14800 9.628110895669011e-01 -5.755091098972152e+00 -6.051099594384665e+00 4.959817222885889e+00 4.260090635060612e+00 9.374527790553844e+03 + 14820 1.082713720975084e+00 -5.920272896100458e+00 -5.992112772307081e+00 4.084505923838528e+00 4.671990237475181e+00 9.192821264096263e+03 + 14840 1.070100621106793e+00 -5.896893222751780e+00 -5.989332822545553e+00 4.291845135155654e+00 4.761042648157974e+00 9.184302583726434e+03 + 14860 1.075631638489945e+00 -5.910928329215073e+00 -5.996270993108518e+00 4.155581082685414e+00 4.665530299874698e+00 9.205573625194160e+03 + 14880 1.110678387064713e+00 -5.977930899831851e+00 -5.959475226143216e+00 3.845110769289208e+00 4.951086103615623e+00 9.093035975371420e+03 + 14900 1.040136577417129e+00 -5.897728204057829e+00 -5.992471567261740e+00 4.288740771327346e+00 4.744709718322417e+00 9.193808987806964e+03 + 14920 1.023301836150553e+00 -5.904849354344107e+00 -6.001071776785536e+00 4.256774304055654e+00 4.704250264025216e+00 9.220305307301551e+03 + 14940 1.003288747372904e+00 -5.918189274238317e+00 -6.057147046114451e+00 4.115573623039244e+00 4.317656593280785e+00 9.393297854063090e+03 + 14960 1.063595949235403e+00 -6.058015167982024e+00 -5.960528307548136e+00 3.364031310421907e+00 4.923815949076183e+00 9.096272944374403e+03 + 14980 9.565019023717873e-01 -5.944162202183536e+00 -5.988092175200501e+00 3.990940330748498e+00 4.738687627543732e+00 9.180489158632692e+03 + 15000 9.821581544113632e-01 -6.012804736993520e+00 -5.976756665923899e+00 3.624099310311555e+00 4.831092912814285e+00 9.145821220628506e+03 + 15020 9.774052501488819e-01 -6.024406691190674e+00 -5.955512230140702e+00 3.572310422574056e+00 4.967913079306390e+00 9.080979021983643e+03 + 15040 9.824079478411509e-01 -6.039587382006729e+00 -5.913115105179362e+00 3.523265887154135e+00 5.249489272218470e+00 8.952230294841374e+03 + 15060 1.013589889227844e+00 -6.087146632568857e+00 -5.966063558947152e+00 3.218509138280423e+00 4.913786884561341e+00 9.113179947073584e+03 + 15080 9.457788550552571e-01 -5.984397465342965e+00 -5.988010673368933e+00 3.802155535178195e+00 4.781407935550945e+00 9.180280897043081e+03 + 15100 9.231296855573002e-01 -5.944593088584159e+00 -6.039903316864887e+00 4.025583557712675e+00 4.478297477714575e+00 9.339921386931739e+03 + 15120 9.664668690129848e-01 -6.001873901486968e+00 -6.027352810823709e+00 3.700805045279978e+00 4.554501205019934e+00 9.301224542032145e+03 + 15140 9.698020036600523e-01 -6.000343991467510e+00 -6.048368792445078e+00 3.684924681670710e+00 4.409158842643578e+00 9.366127145671382e+03 + 15160 1.027309732025433e+00 -6.078821420448955e+00 -5.988469665975130e+00 3.292675873625204e+00 4.811489629702732e+00 9.181695317027446e+03 + 15180 1.061851356847342e+00 -6.120217709095547e+00 -5.956289493505754e+00 3.087341074581664e+00 5.028642256307629e+00 9.083357854998476e+03 + 15200 9.756057264002541e-01 -5.980716206116241e+00 -6.017537730309797e+00 3.768435179773415e+00 4.557000289741561e+00 9.270946055263663e+03 + 15220 1.013885158349901e+00 -6.024690784112360e+00 -5.973933642651733e+00 3.610439282014667e+00 4.901894642923843e+00 9.137202588973305e+03 + 15240 9.232966510089982e-01 -5.876492798221065e+00 -6.017846554965667e+00 4.287947927352361e+00 4.476272781701696e+00 9.271924836352235e+03 + 15260 9.645358928353595e-01 -5.921202086300058e+00 -5.980284186537640e+00 4.128710530911118e+00 4.789451968421459e+00 9.156605614305972e+03 + 15280 1.082039670616094e+00 -6.072544193043312e+00 -5.987846000532518e+00 3.294245234552406e+00 4.780595362952315e+00 9.179794069090336e+03 + 15300 9.851123917564566e-01 -5.907059650661733e+00 -6.025633239293390e+00 4.192456789786100e+00 4.511588894659584e+00 9.295903757081040e+03 + 15320 1.033844942228233e+00 -5.957037604759506e+00 -5.997103899249235e+00 3.918644595471503e+00 4.688577732272444e+00 9.208149900501419e+03 + 15340 1.047452779188516e+00 -5.952480940196741e+00 -5.975011097776807e+00 3.966287510886098e+00 4.836915859530744e+00 9.140500777070516e+03 + 15360 1.023467561928792e+00 -5.893313671474440e+00 -6.043001710999679e+00 4.215925139273232e+00 4.356393252170052e+00 9.349509104608955e+03 + 15380 1.102133662319126e+00 -5.988284442376143e+00 -5.984639253669283e+00 3.760822621769325e+00 4.781753859415250e+00 9.169929350395296e+03 + 15400 1.017139437727689e+00 -5.844006234079988e+00 -5.992109761595763e+00 4.527547051284819e+00 4.677113677342422e+00 9.192814078021969e+03 + 15420 1.036128477156556e+00 -5.852656968084491e+00 -5.995990824215644e+00 4.464006494648715e+00 4.640961311901088e+00 9.204736052143677e+03 + 15440 1.109105412199050e+00 -5.941394014603929e+00 -6.035425234763540e+00 4.001908002443299e+00 4.461966185002521e+00 9.326106494747453e+03 + 15460 1.071954567987569e+00 -5.874826061232791e+00 -6.013503413067120e+00 4.313033433587963e+00 4.516726619104403e+00 9.258537290284348e+03 + 15480 1.120888743577574e+00 -5.943552278958609e+00 -5.977074075881849e+00 4.016411202064395e+00 4.823923856649846e+00 9.146805421056526e+03 + 15500 1.064734379008857e+00 -5.866722944380350e+00 -6.042529866705488e+00 4.450300497270649e+00 4.440789943246405e+00 9.348048802241201e+03 + 15520 1.110504455951506e+00 -5.955811631882441e+00 -5.995418521794598e+00 3.977884952303195e+00 4.750456061281185e+00 9.202994441624318e+03 + 15540 1.066111757122827e+00 -5.927370590599241e+00 -5.993602693985870e+00 4.142991259228705e+00 4.762676272197809e+00 9.197411613962040e+03 + 15560 1.062771213390365e+00 -5.970738081241895e+00 -6.029277792700410e+00 3.853195035858489e+00 4.517050953672626e+00 9.307150605656399e+03 + 15580 1.041191744477500e+00 -5.993696497017045e+00 -6.058617310012500e+00 3.714532550536253e+00 4.341747195853008e+00 9.397873685968769e+03 + 15600 1.004583570276568e+00 -5.987396629717518e+00 -6.008307451093899e+00 3.761101027011870e+00 4.641027854729534e+00 9.242565519103106e+03 + 15620 9.461968182669699e-01 -5.937098179513779e+00 -5.997072477839563e+00 4.013046101726536e+00 4.668664399747214e+00 9.208047908013883e+03 + 15640 1.023092614007132e+00 -6.073970141285652e+00 -6.001804556753408e+00 3.290107655379645e+00 4.704493609351903e+00 9.222592482409151e+03 + 15660 1.054974560295018e+00 -6.139460140105442e+00 -5.992245245034646e+00 2.930831193620910e+00 4.776161902548807e+00 9.193283691456092e+03 + 15680 9.896416314709399e-01 -6.058985849561802e+00 -6.001405253434925e+00 3.397125173726790e+00 4.727761867255773e+00 9.221345769256677e+03 + 15700 9.677667345035497e-01 -6.037271119820157e+00 -5.981341170702658e+00 3.518837178487781e+00 4.839995601452117e+00 9.159848058925223e+03 + 15720 9.881755911559977e-01 -6.073531092243111e+00 -5.990774437568365e+00 3.313790440782526e+00 4.788991958475842e+00 9.188732303815068e+03 + 15740 9.272241841318681e-01 -5.985959901193210e+00 -5.993123352283762e+00 3.747568512610520e+00 4.706434867908101e+00 9.195960196097763e+03 + 15760 9.611615138107921e-01 -6.033664165987467e+00 -5.970265875992006e+00 3.531291365487481e+00 4.895334157495094e+00 9.126004628178702e+03 + 15780 9.645593797894779e-01 -6.031554933433757e+00 -5.974343822408631e+00 3.562393880558975e+00 4.890908933456062e+00 9.138459224313321e+03 + 15800 9.965820680326115e-01 -6.066477238720612e+00 -5.963338021294724e+00 3.301977040290528e+00 4.894218387492295e+00 9.104853795431320e+03 + 15820 9.875208780759510e-01 -6.035040021091230e+00 -5.999887661875132e+00 3.519638319118651e+00 4.721488605547500e+00 9.216695047234560e+03 + 15840 9.708236721224347e-01 -5.988678137365131e+00 -5.954176079750782e+00 3.779289300661726e+00 4.977405454659476e+00 9.076926489351115e+03 + 15860 1.014498863252133e+00 -6.026443762392806e+00 -6.027527655770642e+00 3.528521506962738e+00 4.522297623455245e+00 9.301742825334530e+03 + 15880 1.012902190743901e+00 -5.993385016897898e+00 -6.026326446576242e+00 3.682765980829801e+00 4.493611193946984e+00 9.298058677702191e+03 + 15900 1.010531910168358e+00 -5.960758939448815e+00 -6.012540761192181e+00 3.919475859422282e+00 4.622136625760858e+00 9.255575812866149e+03 + 15920 1.013452922061067e+00 -5.937683646278209e+00 -6.042155219047390e+00 4.020529700591055e+00 4.420637762826779e+00 9.346887563487015e+03 + 15940 1.076318376318981e+00 -6.006574633257475e+00 -6.019672058835874e+00 3.655329916888902e+00 4.580122472397681e+00 9.277536513679603e+03 + 15960 9.841079210456581e-01 -5.851242586527896e+00 -6.047928819770194e+00 4.493630700190399e+00 4.364227911816900e+00 9.364774536691490e+03 + 15980 1.070878565678429e+00 -5.967443670056086e+00 -6.009704923106494e+00 3.885826045954172e+00 4.643155391030963e+00 9.246858250587953e+03 + 16000 1.021194409532658e+00 -5.885838441826692e+00 -6.049081498262325e+00 4.248200594011408e+00 4.310833702176662e+00 9.368345880666357e+03 + 16020 1.060752644919037e+00 -5.942979110361371e+00 -6.049880694676967e+00 3.989584315071969e+00 4.375738874965107e+00 9.370825516352839e+03 + 16040 1.053611173905449e+00 -5.941096696709803e+00 -6.068177063473180e+00 3.973282811554546e+00 4.243567679976033e+00 9.427541347140776e+03 + 16060 1.001911283588902e+00 -5.887536097059613e+00 -6.071527359897142e+00 4.249722303956128e+00 4.193216000187129e+00 9.437920343453152e+03 + 16080 1.066947124567536e+00 -6.019612414443590e+00 -6.001180096931925e+00 3.609287345041948e+00 4.715128564585841e+00 9.220660505611491e+03 + 16100 9.892895132258607e-01 -5.956858281407446e+00 -6.024956602633026e+00 3.921742715530747e+00 4.530711616872317e+00 9.293836593467575e+03 + 16120 1.005457949750512e+00 -6.047336124859807e+00 -5.976269421175104e+00 3.470383412318605e+00 4.878459422413026e+00 9.144337531548550e+03 + 16140 9.391857817413237e-01 -6.004513565181886e+00 -5.987395181479780e+00 3.701942682994888e+00 4.800239091273694e+00 9.178396903311012e+03 + 16160 9.533955125430742e-01 -6.059871778275905e+00 -5.999492237047129e+00 3.363712470534267e+00 4.710421139973709e+00 9.215496656678502e+03 + 16180 9.353162575185290e-01 -6.049165341534939e+00 -5.994605143596504e+00 3.427571377844989e+00 4.740864477570833e+00 9.200493948559289e+03 + 16200 9.102101205518702e-01 -6.015909386641571e+00 -6.029279402852018e+00 3.590603502563604e+00 4.513830800479893e+00 9.307163328796301e+03 + 16220 9.680405420298733e-01 -6.100957430880167e+00 -5.989612548388584e+00 3.151250162917664e+00 4.790609708749212e+00 9.185211751552950e+03 + 16240 9.528308595735678e-01 -6.072943363915742e+00 -6.002312216527661e+00 3.282620274011712e+00 4.688195252448805e+00 9.224156432162035e+03 + 16260 9.050272927967775e-01 -5.991060651503573e+00 -5.999028872575962e+00 3.821031703779050e+00 4.775276945303169e+00 9.214059387026335e+03 + 16280 9.410565855028433e-01 -6.028349606154639e+00 -6.024439594963527e+00 3.529587777945880e+00 4.552039667277526e+00 9.292233851492814e+03 + 16300 1.060506513591971e+00 -6.185436850699585e+00 -5.972550189279037e+00 2.658373695942250e+00 4.880801849923420e+00 9.133004834549192e+03 + 16320 9.315690718242288e-01 -5.970797680493542e+00 -6.047642387776252e+00 3.836274895128626e+00 4.395020694231282e+00 9.363874153951487e+03 + 16340 9.248152344387465e-01 -5.937633520634433e+00 -6.015907931625134e+00 3.984936635791548e+00 4.535472854956993e+00 9.265955382136253e+03 + 16360 9.877534509837823e-01 -6.003333943193039e+00 -6.000511144715660e+00 3.660553366798207e+00 4.676762312481967e+00 9.218611502661020e+03 + 16380 9.840610218470404e-01 -5.970283294522878e+00 -5.978637751814201e+00 3.875147107840143e+00 4.827174521225284e+00 9.151587145490943e+03 + 16400 1.046696725200996e+00 -6.036470974254309e+00 -6.018606071931801e+00 3.503496955996756e+00 4.606079989717295e+00 9.274264933074623e+03 + 16420 1.046098877584747e+00 -6.014997980091431e+00 -5.987421577615349e+00 3.616398656627151e+00 4.774746627079312e+00 9.178472007247476e+03 + 16440 1.003390753401376e+00 -5.935940672624148e+00 -5.999835262165734e+00 3.990307520650581e+00 4.623414899847020e+00 9.216511173118253e+03 + 16460 9.381971418056982e-01 -5.824878469235403e+00 -6.041871268281389e+00 4.605255977825419e+00 4.359249746176239e+00 9.346015217452632e+03 + 16480 1.091142938260067e+00 -6.040679771717731e+00 -6.017698320177081e+00 3.413838659599869e+00 4.545801710714418e+00 9.271482345453496e+03 + 16500 1.026923891428277e+00 -5.939981208871211e+00 -6.023598845458247e+00 4.032317736843900e+00 4.552172327773691e+00 9.289648196789272e+03 + 16520 1.028431924319835e+00 -5.942950583110042e+00 -5.998879221909244e+00 4.001567799979348e+00 4.680416901065446e+00 9.213616039046994e+03 + 16540 1.082116490419838e+00 -6.026936041405730e+00 -6.015612780478216e+00 3.522812886656712e+00 4.587832803171457e+00 9.265037606940468e+03 + 16560 1.040268532110304e+00 -5.975226444158871e+00 -6.029216907286781e+00 3.825812201250680e+00 4.515790606973058e+00 9.306974155724591e+03 + 16580 1.057288879899200e+00 -6.020491368330060e+00 -5.987760377232169e+00 3.554442151233567e+00 4.742388567222161e+00 9.179506517168657e+03 + 16600 1.024045198892182e+00 -5.997841346965934e+00 -5.975509136144869e+00 3.794689210003344e+00 4.922924220436349e+00 9.141979663130925e+03 + 16620 1.006303193919409e+00 -6.005960916143772e+00 -5.963088140350083e+00 3.729831626760122e+00 4.976013739908096e+00 9.104071703510001e+03 + 16640 1.040166613003569e+00 -6.098055688908863e+00 -5.988024461638537e+00 3.178175684551824e+00 4.809992018815423e+00 9.180309017701698e+03 + 16660 9.702965559083476e-01 -6.044484308697625e+00 -5.996995206499786e+00 3.483907469610105e+00 4.756597243344910e+00 9.207835854889834e+03 + 16680 9.339736142232450e-01 -6.039501046456410e+00 -6.025350428538545e+00 3.492525138700030e+00 4.573780176585460e+00 9.295032336269769e+03 + 16700 8.703895273489322e-01 -5.981064906144507e+00 -6.060966010408890e+00 3.737884476329712e+00 4.279079970987699e+00 9.405146896072176e+03 + 16720 9.091900110529726e-01 -6.060049810484167e+00 -6.013275252119989e+00 3.355805018797593e+00 4.624391771264218e+00 9.257857111034076e+03 + 16740 9.169984993348442e-01 -6.079698668894569e+00 -5.999431958747753e+00 3.265355809181278e+00 4.726259680077546e+00 9.215312660563572e+03 + 16760 9.776799274899726e-01 -6.168722686868296e+00 -5.995295532091939e+00 2.785257390090833e+00 4.781102950582144e+00 9.202617917779986e+03 + 16780 9.245299428224846e-01 -6.083520095591708e+00 -5.995297244622381e+00 3.268924099823303e+00 4.775513362531242e+00 9.202629648546683e+03 + 16800 8.614187295941028e-01 -5.979378321038616e+00 -6.001429742971851e+00 3.851230249745236e+00 4.724607572558082e+00 9.221417946381904e+03 + 16820 9.838072498547534e-01 -6.142509426713205e+00 -5.976068133363982e+00 2.960172394350084e+00 4.915904057468228e+00 9.143729460227052e+03 + 16840 9.672189256048042e-01 -6.096715350009793e+00 -6.007550340419989e+00 3.177166960252264e+00 4.689166243557556e+00 9.240246622443206e+03 + 16860 8.748125267148347e-01 -5.938748613352183e+00 -6.036341495662775e+00 4.032905866717656e+00 4.472512434040506e+00 9.328944248489264e+03 + 16880 1.004674392724796e+00 -6.106606710263478e+00 -6.002440783279478e+00 3.124112571888795e+00 4.722249444256025e+00 9.224567470072127e+03 + 16900 9.556449326119837e-01 -6.010730761152153e+00 -5.997591088827024e+00 3.640179022940244e+00 4.715629054788859e+00 9.209657205729507e+03 + 16920 1.001137606798068e+00 -6.056369388415390e+00 -5.957593349623107e+00 3.472526622590596e+00 5.039713922878484e+00 9.087320682225942e+03 + 16940 1.046037888394493e+00 -6.100597904774219e+00 -5.951769481259623e+00 3.205361798525841e+00 5.059957637470760e+00 9.069581496703928e+03 + 16960 9.613314734583852e-01 -5.952461369394727e+00 -6.004836060658921e+00 3.930305178265050e+00 4.629561596068773e+00 9.231874273596453e+03 + 16980 1.068202736342690e+00 -6.092256073839376e+00 -5.933440059081227e+00 3.210678683879328e+00 5.122624817319476e+00 9.013854057470771e+03 + 17000 1.008430125596781e+00 -5.984379446179471e+00 -5.971887074863695e+00 3.818655723391561e+00 4.890388852674958e+00 9.130948030180931e+03 + 17020 1.053337979566619e+00 -6.033271645269577e+00 -5.996066670741617e+00 3.502180488595771e+00 4.715817209786524e+00 9.204974749995416e+03 + 17040 9.900646079111670e-01 -5.927952685909984e+00 -6.029104410141850e+00 4.060441761870684e+00 4.479612908152579e+00 9.306585399853297e+03 + 17060 1.027653930462488e+00 -5.976081510467584e+00 -5.997459180926849e+00 3.850210711471686e+00 4.727456819510775e+00 9.209228202494374e+03 + 17080 1.020642617093729e+00 -5.961273347695263e+00 -6.009289528589694e+00 3.852741348897136e+00 4.577025007721335e+00 9.245565604196028e+03 + 17100 9.652632513652823e-01 -5.875841948376283e+00 -6.090915570378339e+00 4.317811757183218e+00 4.082825737111971e+00 9.498147743181162e+03 + 17120 1.052305314767479e+00 -6.005985830346548e+00 -5.972796613209613e+00 3.629782805424523e+00 4.820360426239558e+00 9.133712490206215e+03 + 17140 9.675136298320702e-01 -5.881840264550553e+00 -6.026657017843405e+00 4.304321912070769e+00 4.472761704343066e+00 9.299026473494925e+03 + 17160 1.036016008809293e+00 -5.988363599181775e+00 -6.037635007149823e+00 3.796256479538453e+00 4.513332430260181e+00 9.332926938448243e+03 + 17180 1.070385088524221e+00 -6.052749095343440e+00 -5.978661363608897e+00 3.391793419813519e+00 4.817216640472699e+00 9.151660563266525e+03 + 17200 9.706794070904557e-01 -5.923536598172579e+00 -5.979365676283626e+00 4.122913346054468e+00 4.802334140018922e+00 9.153815682753509e+03 + 17220 9.979015133682821e-01 -5.990504239831981e+00 -5.970794219457034e+00 3.770273847218086e+00 4.883451834326828e+00 9.127586638671199e+03 + 17240 9.682017397339567e-01 -5.981891568292143e+00 -6.048453664719201e+00 3.756352423917688e+00 4.374142565782392e+00 9.366383893700973e+03 + 17260 9.555357193491194e-01 -6.013962397560986e+00 -6.021273018480390e+00 3.624956268131544e+00 4.582977551497396e+00 9.282485243477284e+03 + 17280 9.600169471741620e-01 -6.073486309216973e+00 -5.997687429013509e+00 3.307371805312548e+00 4.742620705279638e+00 9.209949903105384e+03 + 17300 8.963944716279043e-01 -6.023297241074425e+00 -5.977018002768935e+00 3.605962512265781e+00 4.871705060304888e+00 9.146643987881291e+03 + 17320 9.644271390152944e-01 -6.151817220818386e+00 -5.961393627123243e+00 2.931289390740353e+00 5.024731133693749e+00 9.098936520998954e+03 + 17340 9.228406122907082e-01 -6.106094402204155e+00 -6.000307195152284e+00 3.163531113117444e+00 4.770977626526673e+00 9.217996657018355e+03 + 17360 8.838839847990284e-01 -6.053637087529264e+00 -5.995551303549200e+00 3.374941203449785e+00 4.708478763809334e+00 9.203430965020803e+03 + 17380 9.279346218405647e-01 -6.114179937697940e+00 -5.994722379862341e+00 3.068155461708163e+00 4.754099244797502e+00 9.200846697887479e+03 + 17400 8.985650048851552e-01 -6.057789395915485e+00 -5.983511356886128e+00 3.351306289588739e+00 4.777822284184701e+00 9.166501901586687e+03 + 17420 9.094700726602285e-01 -6.053271419445093e+00 -6.009101801840788e+00 3.389175850626927e+00 4.642804630137078e+00 9.244972778513087e+03 + 17440 9.437671071682426e-01 -6.079537612175593e+00 -5.944444502033163e+00 3.307177441768476e+00 5.082902985797539e+00 9.047300174763110e+03 + 17460 9.597628166778134e-01 -6.074123714405999e+00 -6.022374675956629e+00 3.296904866699463e+00 4.594055853613563e+00 9.285868192333959e+03 + 17480 9.524413281634901e-01 -6.036222483019147e+00 -6.015762964918697e+00 3.513579428664094e+00 4.631061147697073e+00 9.265506230923478e+03 + 17500 9.888619017419695e-01 -6.066579391397657e+00 -5.980347049840451e+00 3.333954955007209e+00 4.829114404640418e+00 9.156815713494794e+03 + 17520 9.271556887463571e-01 -5.953414479326898e+00 -5.967974572922465e+00 3.944398975316754e+00 4.860792664723807e+00 9.118951029365708e+03 + 17540 9.527496765722386e-01 -5.969858760519857e+00 -5.941871759026137e+00 3.840668567533657e+00 5.001374261085084e+00 9.039423225907492e+03 + 17560 9.677001089988455e-01 -5.969080647172332e+00 -6.001308373899962e+00 3.832571614966604e+00 4.647515020871954e+00 9.221069238703849e+03 + 17580 1.050786500272591e+00 -6.072784833262293e+00 -6.000301311437447e+00 3.311832843088999e+00 4.728044442196017e+00 9.217982394213359e+03 + 17600 1.012755005404517e+00 -6.004180359946029e+00 -5.994347111306388e+00 3.676028992843289e+00 4.732493028222418e+00 9.199706033374339e+03 + 17620 9.924959395806293e-01 -5.964491753688129e+00 -6.012112197177112e+00 3.915123634903848e+00 4.641679679150297e+00 9.254229456084555e+03 + 17640 9.378956176472304e-01 -5.874487950214588e+00 -6.054303101194511e+00 4.397942602695079e+00 4.365416179463682e+00 9.384480852594208e+03 + 17660 9.740680643639937e-01 -5.921799293911687e+00 -6.009829863229713e+00 4.150594641213758e+00 4.645109489503074e+00 9.247248064573425e+03 + 17680 1.068815650036030e+00 -6.056675407529572e+00 -5.982867154575640e+00 3.400313836689417e+00 4.824132246941129e+00 9.164516971521978e+03 + 17700 1.020739114394580e+00 -5.979196887200175e+00 -6.031166674356621e+00 3.854588039135055e+00 4.556169478984167e+00 9.312967711498919e+03 + 17720 1.032602844371905e+00 -5.995971392455163e+00 -6.057580415191714e+00 3.705316135102745e+00 4.351547592584015e+00 9.394647123705654e+03 + 17740 9.936870313315410e-01 -5.944490340408734e+00 -6.029139661107052e+00 3.972668867698805e+00 4.486599368809024e+00 9.306710604697897e+03 + 17760 1.023609298453200e+00 -5.995273872536520e+00 -5.951550651117770e+00 3.697292590505528e+00 4.948358094038642e+00 9.068913239440846e+03 + 17780 9.950515926080136e-01 -5.960320055123219e+00 -5.978337210368894e+00 3.923536932278735e+00 4.820079638712309e+00 9.150636636251847e+03 + 17800 9.971454940412500e-01 -5.972514180255792e+00 -6.002253157194717e+00 3.816536271290828e+00 4.645770463615710e+00 9.223951993487948e+03 + 17820 9.872667491857564e-01 -5.970979052456981e+00 -5.964560101459409e+00 3.865489076955754e+00 4.902347686913267e+00 9.108544545904691e+03 + 17840 9.999790075493451e-01 -6.006791059844137e+00 -5.956958056218920e+00 3.615684890578483e+00 4.901833709026863e+00 9.085403715803883e+03 + 17860 9.326373284327524e-01 -5.929007380510170e+00 -6.014705905548337e+00 4.070307096641783e+00 4.578212904068740e+00 9.262250677191863e+03 + 17880 9.926967723460791e-01 -6.047692328467138e+00 -6.011632969887435e+00 3.413518184901833e+00 4.620576602034193e+00 9.252795833599515e+03 + 17900 9.407776595316566e-01 -6.007252413082350e+00 -6.005062503809948e+00 3.630516808232570e+00 4.643091606162066e+00 9.232608379964166e+03 + 17920 8.859507036650586e-01 -5.961554689470237e+00 -6.002918910485016e+00 3.858131836289042e+00 4.620612078129668e+00 9.226013582352694e+03 + 17940 9.624307396727535e-01 -6.104826411945009e+00 -5.967213734336006e+00 3.128331348305189e+00 4.918524638629121e+00 9.116678488685493e+03 + 17960 9.413083681400927e-01 -6.097212432956436e+00 -5.953752973578435e+00 3.218736461785716e+00 5.042502877813783e+00 9.075637283892283e+03 + 17980 8.837580126394070e-01 -6.026817160516157e+00 -5.937112701637551e+00 3.623419290418707e+00 5.138516175019810e+00 9.024990524924146e+03 + 18000 9.042811169916926e-01 -6.060651596504969e+00 -5.942348284292163e+00 3.395733868966937e+00 5.075049795071267e+00 9.040911205059034e+03 + 18020 9.421035874646172e-01 -6.109789903855603e+00 -6.013203555216644e+00 3.122740817246149e+00 4.677354577820198e+00 9.257613958372205e+03 + 18040 9.063105926573231e-01 -6.042494469109269e+00 -6.018006223664475e+00 3.482542811831732e+00 4.623158106719474e+00 9.272409390829036e+03 + 18060 9.384785406404660e-01 -6.068661899499261e+00 -5.996863579832524e+00 3.298482133612976e+00 4.710759195893438e+00 9.207444076724061e+03 + 18080 9.467679663793056e-01 -6.048446001291123e+00 -6.007973860924826e+00 3.423091939372320e+00 4.655489232399075e+00 9.241550890847107e+03 + 18100 9.313647721942748e-01 -5.988619260022254e+00 -6.006972147424687e+00 3.747209646809608e+00 4.641824527244692e+00 9.238466522825389e+03 + 18120 1.050312872564898e+00 -6.125175164038207e+00 -5.976962424569500e+00 3.031379980892847e+00 4.882440466769472e+00 9.146460194439796e+03 + 18140 9.408304511163956e-01 -5.927825208948574e+00 -5.992941302162925e+00 4.086413958132303e+00 4.712507274212643e+00 9.195372645526606e+03 + 18160 9.524746606812198e-01 -5.917938534388973e+00 -5.946145059258487e+00 4.128032009642167e+00 4.966065778895808e+00 9.052466376914865e+03 + 18180 1.074058564339236e+00 -6.075146124533438e+00 -5.948122152878433e+00 3.317588311922023e+00 5.046979614061144e+00 9.058491978185248e+03 + 18200 9.607933498187966e-01 -5.892328074912680e+00 -6.006934846052454e+00 4.270555394358041e+00 4.612465579132942e+00 9.238357130326845e+03 + 18220 1.012135415675914e+00 -5.959262382415376e+00 -5.980220669010532e+00 3.897943134819257e+00 4.777597409905500e+00 9.156442339051890e+03 + 18240 1.038575983604448e+00 -5.991117412970359e+00 -6.004509288109811e+00 3.702063435255536e+00 4.625165215818824e+00 9.230903810732470e+03 + 18260 1.008861617219233e+00 -5.945594866576123e+00 -6.050255312495206e+00 3.932918658055269e+00 4.331942181436232e+00 9.371957079605701e+03 + 18280 9.962977082685011e-01 -5.929402912946832e+00 -6.057150146367145e+00 4.052388942964742e+00 4.318844559844826e+00 9.393324143996448e+03 + 18300 9.881061756646630e-01 -5.924866890207941e+00 -6.042626466898055e+00 4.090449428303485e+00 4.414255715713254e+00 9.348346765220815e+03 + 18320 9.810843276923751e-01 -5.922634290886080e+00 -6.000343816879697e+00 4.121228574704958e+00 4.675008450939327e+00 9.218084109800711e+03 + 18340 1.032532167732856e+00 -6.007536365978980e+00 -5.999285218864442e+00 3.700385554853621e+00 4.747764918446185e+00 9.214838600904492e+03 + 18360 1.030872314766707e+00 -6.015116192156126e+00 -5.988359477020829e+00 3.628687799887183e+00 4.782328998782348e+00 9.181346422567827e+03 + 18380 1.017412487686301e+00 -6.007493421592137e+00 -6.016090780176630e+00 3.608010441351725e+00 4.558643077922627e+00 9.266517355272841e+03 + 18400 9.833266297122549e-01 -5.971547248509009e+00 -6.019927989944458e+00 3.839258039244644e+00 4.561448335026757e+00 9.278323059401589e+03 + 18420 9.278959986902980e-01 -5.906596492191706e+00 -5.985289411191200e+00 4.279601945278666e+00 4.827735026693719e+00 9.171927644095178e+03 + 18440 1.014728984942653e+00 -6.051646222720157e+00 -5.996712818207249e+00 3.405692013804418e+00 4.721128123434408e+00 9.206963342665880e+03 + 18460 9.866724733082185e-01 -6.027960919400622e+00 -6.033726398543780e+00 3.574020256462353e+00 4.540913983017324e+00 9.320880472359482e+03 + 18480 1.001724141957931e+00 -6.072569589068930e+00 -5.982657582689000e+00 3.377122228273636e+00 4.893410882745215e+00 9.163910640525492e+03 + 18500 9.552876152881393e-01 -6.029284415118875e+00 -5.997949259205825e+00 3.555753250289100e+00 4.735684564641541e+00 9.210748090605952e+03 + 18520 9.231927421028870e-01 -6.007691593088179e+00 -5.999365586335180e+00 3.660827452782569e+00 4.708636672003667e+00 9.215099046181713e+03 + 18540 9.166542175619531e-01 -6.024584852999875e+00 -6.061526092510811e+00 3.513136504342735e+00 4.301014190432600e+00 9.406894487752423e+03 + 18560 9.453146677732607e-01 -6.095169031231560e+00 -6.004713975862544e+00 3.205938562670321e+00 4.725345488473787e+00 9.231558275500163e+03 + 18580 9.362656498262208e-01 -6.108418426741267e+00 -6.017568037365256e+00 3.042743919702270e+00 4.564420914551636e+00 9.271069000694213e+03 + 18600 8.877285582776270e-01 -6.058629058737030e+00 -6.010389375742344e+00 3.375573881176206e+00 4.652573605998509e+00 9.248970689876278e+03 + 18620 9.234585091340065e-01 -6.126967271478303e+00 -5.973838619799340e+00 3.069587918571890e+00 4.948876333094757e+00 9.136917786835718e+03 + 18640 8.862161700949893e-01 -6.080189250426587e+00 -6.021787371396615e+00 3.259883451898770e+00 4.595236078950435e+00 9.284081826897478e+03 + 18660 9.252662583295668e-01 -6.140878309816120e+00 -5.997324018932301e+00 2.968207447920866e+00 4.792518401130476e+00 9.208857430593989e+03 + 18680 8.882026090956644e-01 -6.079315889597320e+00 -5.980235949812567e+00 3.308545290413565e+00 4.877477637228743e+00 9.156481011918877e+03 + 18700 9.673866332591117e-01 -6.174955410019118e+00 -5.963902215142327e+00 2.735218019752237e+00 4.947118125111124e+00 9.106575410419575e+03 + 18720 9.227969241531256e-01 -6.068367589308782e+00 -5.983933485190297e+00 3.339807400735651e+00 4.824641092719377e+00 9.167818836686511e+03 + 18740 9.896593637207061e-01 -6.110773850966568e+00 -6.027895932410174e+00 3.086061288689078e+00 4.561959122356341e+00 9.302867880596965e+03 + 18760 9.358053121608656e-01 -5.975242540240949e+00 -6.029612007809115e+00 3.822534856606702e+00 4.510336960182374e+00 9.308169670074116e+03 + 18780 1.009597907550461e+00 -6.044132487491591e+00 -5.998347263371341e+00 3.453305917308451e+00 4.716211759447468e+00 9.211979798197443e+03 + 18800 1.040115638287558e+00 -6.057741531632725e+00 -6.013745276934753e+00 3.382497807243181e+00 4.635131110117355e+00 9.259292112179048e+03 + 18820 9.771089031804527e-01 -5.943443533472965e+00 -6.041249154119972e+00 3.985084046666050e+00 4.423469037540050e+00 9.344095419475045e+03 + 18840 1.018482437018722e+00 -5.989938437975324e+00 -5.977918419256522e+00 3.772785790077438e+00 4.841806597652685e+00 9.149375188215190e+03 + 18860 9.771942032073392e-01 -5.914949470940913e+00 -6.041888128547916e+00 4.172042437527670e+00 4.443141021854482e+00 9.346062640831899e+03 + 18880 1.048014251648741e+00 -6.010886101681797e+00 -5.998413696642849e+00 3.653485111244007e+00 4.725103591076094e+00 9.212193768868348e+03 + 18900 9.948691857668355e-01 -5.924438078139539e+00 -6.061753751031747e+00 4.067792393973731e+00 4.279304550694968e+00 9.407606943198860e+03 + 18920 1.097228018877286e+00 -6.073994212036475e+00 -6.018374365774182e+00 3.314278974083848e+00 4.633656738465328e+00 9.273555560378982e+03 + 18940 9.604727651457727e-01 -5.875035147051078e+00 -6.032652607391003e+00 4.355268284342964e+00 4.450204435847955e+00 9.317573308669009e+03 + 18960 1.014891530647821e+00 -5.961095309698981e+00 -6.009077034489934e+00 3.915097383430591e+00 4.639578894533026e+00 9.244943237387255e+03 + 18980 1.017096357803230e+00 -5.972085934055454e+00 -6.007292843751464e+00 3.851782611555240e+00 4.649619087829086e+00 9.239448035572042e+03 + 19000 1.020040706972445e+00 -5.987861425071889e+00 -5.996441349099570e+00 3.808242502086979e+00 4.758975250581082e+00 9.206122372545380e+03 + 19020 1.040666635284262e+00 -6.033566636366722e+00 -5.969626207786091e+00 3.544359314777569e+00 4.911515150436893e+00 9.124033750508172e+03 + 19040 9.521528385813555e-01 -5.920307450211971e+00 -5.999878651751171e+00 4.101540538909045e+00 4.644630386067314e+00 9.216672742113227e+03 + 19060 9.624443869236516e-01 -5.954738660718965e+00 -6.040314882137063e+00 3.872421061453295e+00 4.381029155193106e+00 9.341225183525752e+03 + 19080 1.023424317147171e+00 -6.068365673883448e+00 -6.031445138113728e+00 3.323011384698629e+00 4.535014814522804e+00 9.313846861580399e+03 + 19100 9.740824850460736e-01 -6.021540389358001e+00 -6.027026078239665e+00 3.571297743781515e+00 4.539798069315394e+00 9.300207646441295e+03 + 19120 9.980776972453711e-01 -6.084806905907326e+00 -6.005730822408683e+00 3.221663847419633e+00 4.675730955853209e+00 9.234659545975901e+03 + 19140 9.373356055229507e-01 -6.021856208107364e+00 -5.987050365899011e+00 3.598747899106620e+00 4.798608431253658e+00 9.177342247248929e+03 + 19160 9.330647770714388e-01 -6.039514079431144e+00 -5.987829541452365e+00 3.482369363504863e+00 4.779149978735417e+00 9.179731636603705e+03 + 19180 9.279399908615729e-01 -6.050498217414654e+00 -5.999099373972910e+00 3.388401998657284e+00 4.683542111645100e+00 9.214291062278973e+03 + 19200 8.956359087468414e-01 -6.015865301728788e+00 -6.031426882928081e+00 3.555854522869549e+00 4.466497515476295e+00 9.313781720339926e+03 + 19220 9.569270293830302e-01 -6.115187254514965e+00 -5.964530413551637e+00 3.100749465345507e+00 4.965844360227727e+00 9.108490633595966e+03 + 19240 8.844520966257453e-01 -6.008956513122878e+00 -6.019422578389401e+00 3.607265331871341e+00 4.547167565492598e+00 9.276785214468231e+03 + 19260 9.029897050268201e-01 -6.030730448663404e+00 -6.004557181896495e+00 3.515486409840979e+00 4.665777357916514e+00 9.231042658900735e+03 + 19280 1.018983730320968e+00 -6.184130405545977e+00 -5.933611034466018e+00 2.748740888637548e+00 5.187261885126050e+00 9.014384727450250e+03 + 19300 9.591863431323470e-01 -6.061579821776936e+00 -5.972696906639946e+00 3.357409119106580e+00 4.867788572409842e+00 9.133433354004321e+03 + 19320 9.711552719983121e-01 -6.027012218814872e+00 -5.981237181950013e+00 3.534113163061516e+00 4.796960508403599e+00 9.159546482986791e+03 + 19340 9.923028418288491e-01 -5.997777454272756e+00 -5.989336665041538e+00 3.739357839660138e+00 4.787826157633700e+00 9.184335272236978e+03 + 19360 9.994583303532698e-01 -5.956976990939816e+00 -5.998043122026106e+00 3.938724345400118e+00 4.702916265739391e+00 9.211042900207005e+03 + 19380 1.040183321082863e+00 -5.981503895413347e+00 -6.011691859966874e+00 3.803926581385276e+00 4.630582617346505e+00 9.252964230863028e+03 + 19400 1.031064276729721e+00 -5.947246223560530e+00 -6.014138375327945e+00 3.970634393580227e+00 4.586529306604701e+00 9.260493102345710e+03 + 19420 1.015542562780274e+00 -5.911593227093505e+00 -6.012736570413939e+00 4.182131502774967e+00 4.601350773547238e+00 9.256170522067654e+03 + 19440 1.050642916863836e+00 -5.957153891674837e+00 -6.005762993700367e+00 3.907329886313077e+00 4.628208900248257e+00 9.234727011790956e+03 + 19460 9.682214538038811e-01 -5.834160064611331e+00 -6.062280583232774e+00 4.525083492617819e+00 4.215180173157328e+00 9.409194287245553e+03 + 19480 1.092121186075386e+00 -6.021956343386993e+00 -5.988046377367127e+00 3.578285225255097e+00 4.773001497691454e+00 9.180383835619190e+03 + 19500 1.027670728036196e+00 -5.934185049998915e+00 -6.030729779393898e+00 4.058286155814476e+00 4.503911379379896e+00 9.311614558024072e+03 + 19520 1.062161845219044e+00 -5.997804589463905e+00 -6.009015528315937e+00 3.706185504911256e+00 4.641810559135704e+00 9.244764662721320e+03 + 19540 1.117039023840299e+00 -6.099630659415546e+00 -5.982817078208775e+00 3.179797419483702e+00 4.850559079616248e+00 9.164384049853026e+03 + 19560 9.767091069867175e-01 -5.919549608182157e+00 -6.018913853051975e+00 4.047346577651420e+00 4.476781707041727e+00 9.275203770249405e+03 + 19580 1.034997721242716e+00 -6.033328834092401e+00 -5.937709433386654e+00 3.545986786728953e+00 5.095048182635788e+00 9.026772920104300e+03 + 19600 9.565025938281539e-01 -5.942024003791266e+00 -5.978925803457495e+00 4.011690393216279e+00 4.799794548997748e+00 9.152442525939734e+03 + 19620 9.390049108411177e-01 -5.939599140383142e+00 -6.017209584802309e+00 3.995787255077951e+00 4.550136073045631e+00 9.269912326628093e+03 + 19640 9.620006695438020e-01 -5.992892832799843e+00 -5.933894112141241e+00 3.791555820551238e+00 5.130335604595444e+00 9.015221499549873e+03 + 19660 1.027407428633609e+00 -6.103469929183914e+00 -5.991262908377840e+00 3.122438086669169e+00 4.766748164117997e+00 9.190250860526021e+03 + 19680 9.846784328206103e-01 -6.054396100034158e+00 -5.977227555467032e+00 3.374224450895261e+00 4.817338175593383e+00 9.147277131354118e+03 + 19700 8.839014541520454e-01 -5.915294962692283e+00 -5.993856161129200e+00 4.167467680551059e+00 4.716357121820112e+00 9.198181047672770e+03 + 19720 9.608495018591175e-01 -6.033931708499466e+00 -5.967912342603042e+00 3.506619243299334e+00 4.885712658740457e+00 9.118811335229120e+03 + 19740 1.028866361051609e+00 -6.135273853070878e+00 -5.950987670745421e+00 2.980862597971826e+00 5.039062375079149e+00 9.067189359212596e+03 + 19760 9.494367656951985e-01 -6.014238447076496e+00 -5.977516032295368e+00 3.668015212303506e+00 4.878881000752067e+00 9.148131327034347e+03 + 19780 9.399650185978269e-01 -5.990139398236494e+00 -5.974373820365550e+00 3.766917835203639e+00 4.857446223053893e+00 9.138526511849472e+03 + 19800 9.597860599557870e-01 -5.997558916222217e+00 -6.039112780604921e+00 3.681185590409884e+00 4.442576870684668e+00 9.337503291294139e+03 + 19820 9.773345993131665e-01 -5.986624071091871e+00 -6.039338893057596e+00 3.755779028447766e+00 4.453082363128238e+00 9.338209024679365e+03 + 19840 1.010266887823799e+00 -5.985861805522562e+00 -6.027639598305671e+00 3.746123201757292e+00 4.506228650504142e+00 9.302114013001166e+03 + 19860 1.073892816396898e+00 -6.022204975928164e+00 -6.025639865667331e+00 3.553197915968077e+00 4.533474247538310e+00 9.295935948185475e+03 + 19880 1.001481423652326e+00 -5.866593180012009e+00 -6.018218374861289e+00 4.408924378777017e+00 4.538269046029382e+00 9.273059950641114e+03 + 19900 1.091494835304404e+00 -5.964236863214112e+00 -6.038114268929823e+00 3.927850348973171e+00 4.503634852861979e+00 9.334387523672331e+03 + 19920 1.130875539056626e+00 -6.002530982859863e+00 -5.990803193839389e+00 3.706757417825620e+00 4.774100197250673e+00 9.188838368118992e+03 + 19940 1.062489127375442e+00 -5.895341915779257e+00 -6.020795557042826e+00 4.256292226143284e+00 4.535918004119628e+00 9.280980835781798e+03 + 19960 1.049981919426291e+00 -5.877840447581205e+00 -6.003744211437261e+00 4.349204861942891e+00 4.626245966336930e+00 9.228544344282162e+03 + 19980 1.078646962288277e+00 -5.930673021987042e+00 -6.008906791788738e+00 4.067465468234571e+00 4.618235055396481e+00 9.244410822926044e+03 + 20000 1.000269908016438e+00 -5.831617690615593e+00 -6.042137572985030e+00 4.557557688092182e+00 4.348719945680363e+00 9.346858192964777e+03 + 20020 9.435750716971292e-01 -5.767197816723897e+00 -6.040478050862435e+00 4.912987715041937e+00 4.343770320638898e+00 9.341715099281502e+03 + 20040 1.062653892257728e+00 -5.966587757966392e+00 -6.022752185054109e+00 3.845342598159459e+00 4.522837766404785e+00 9.287028578227770e+03 + 20060 9.663276133721543e-01 -5.853909344397016e+00 -6.037853857225858e+00 4.481564580934558e+00 4.425326722949985e+00 9.333614329753345e+03 + 20080 9.821043619756223e-01 -5.905945493486180e+00 -5.972556055937867e+00 4.206258682912015e+00 4.823770525363204e+00 9.132975874516000e+03 + 20100 1.057813383211524e+00 -6.044439624596865e+00 -5.960436124762455e+00 3.509033030514794e+00 4.991394126063566e+00 9.095971117910480e+03 + 20120 9.746985970657231e-01 -5.943475246123540e+00 -5.994325041647893e+00 3.924154118670535e+00 4.632166723789272e+00 9.199608709595988e+03 + 20140 9.389124280805821e-01 -5.907630738676508e+00 -5.965652454722341e+00 4.164461558024364e+00 4.831291885657651e+00 9.111890501589316e+03 + 20160 9.901736844817238e-01 -5.994381659344556e+00 -5.960343115986217e+00 3.739343434450539e+00 4.934798017861681e+00 9.095683926559672e+03 + 20180 9.870685478358164e-01 -5.995679621242634e+00 -5.995794389400219e+00 3.703122199086489e+00 4.702463182565321e+00 9.204138801396401e+03 + 20200 9.808574747280039e-01 -5.989392263313140e+00 -6.049095638691884e+00 3.736015692125228e+00 4.393189671633001e+00 9.368391664273973e+03 + 20220 1.016965141764929e+00 -6.049349437971520e+00 -5.982202052586022e+00 3.431179482534074e+00 4.816750160441909e+00 9.162507160786441e+03 + 20240 9.861430814749272e-01 -6.007102407961306e+00 -6.011218332338673e+00 3.696941928853318e+00 4.673307654141236e+00 9.251510062202258e+03 + 20260 9.405936206617813e-01 -5.942195833043561e+00 -6.055781457630557e+00 3.924739429600359e+00 4.272513195903229e+00 9.389085798850740e+03 + 20280 9.805480149222873e-01 -6.002687781075884e+00 -5.989735179017092e+00 3.721844142167145e+00 4.796219987597417e+00 9.185566691048263e+03 + 20300 9.706827011806651e-01 -5.985610589325684e+00 -6.051859323420521e+00 3.744540622888489e+00 4.364130139757462e+00 9.376952047337207e+03 + 20320 1.068733059033512e+00 -6.129544708449274e+00 -6.001568710419985e+00 3.024546389674345e+00 4.759404374580209e+00 9.221891222022272e+03 + 20340 9.794570203032898e-01 -5.997048265894277e+00 -6.057933250327647e+00 3.708667107966524e+00 4.359056105429223e+00 9.395746030950391e+03 + 20360 9.770829054613281e-01 -5.993687033862550e+00 -6.009079497378258e+00 3.727072590709730e+00 4.638686683226505e+00 9.244957907243524e+03 + 20380 1.002133245790943e+00 -6.029853383618754e+00 -5.991783214986997e+00 3.550013987799178e+00 4.768618787422284e+00 9.191868217510111e+03 + 20400 9.472772142789257e-01 -5.946808075841325e+00 -5.997675630091474e+00 4.012504176806673e+00 4.720414808573737e+00 9.209913887731114e+03 + 20420 1.014192086829486e+00 -6.040777001317944e+00 -6.012451121140776e+00 3.468434014848575e+00 4.631085602241669e+00 9.255316520455894e+03 + 20440 1.050186936604881e+00 -6.085781377171626e+00 -6.014440760031966e+00 3.227857800314198e+00 4.637506663854952e+00 9.261449370507275e+03 + 20460 9.807375831300983e-01 -5.970646754460472e+00 -6.024792324392498e+00 3.802572311342199e+00 4.491660069792639e+00 9.293329017797170e+03 + 20480 9.907901984679863e-01 -5.968719470629054e+00 -6.024575060145367e+00 3.893116999479061e+00 4.572385560851847e+00 9.292605659613748e+03 + 20500 9.740540493222988e-01 -5.916287546760791e+00 -6.032040520429035e+00 4.127425946481626e+00 4.462754458963784e+00 9.315646302711850e+03 + 20520 1.043480955921285e+00 -5.981752443590510e+00 -5.996234930195419e+00 3.786266060250839e+00 4.703105381007895e+00 9.205481234825786e+03 + 20540 1.076193397646792e+00 -5.988243320817396e+00 -5.990379169641106e+00 3.770083979467131e+00 4.757819604999856e+00 9.187536436074761e+03 + 20560 1.112186467207307e+00 -6.005097502974290e+00 -6.020209458213637e+00 3.638708700495076e+00 4.551933514943231e+00 9.279199705920008e+03 + 20580 1.044174981412470e+00 -5.879908256610170e+00 -5.993803420588197e+00 4.322831372948009e+00 4.668827716166513e+00 9.198007197624062e+03 + 20600 9.975717522327996e-01 -5.793243936578589e+00 -6.007931768772957e+00 4.848455720195553e+00 4.615684964900828e+00 9.241336031333087e+03 + 20620 1.098067456508000e+00 -5.928387762087036e+00 -6.035327414136665e+00 4.059566504973487e+00 4.445502474046847e+00 9.325787161698740e+03 + 20640 1.063333505477310e+00 -5.874048520600956e+00 -6.002243562077636e+00 4.398272694232821e+00 4.662156927955171e+00 9.223930112575763e+03 + 20660 1.084801540141090e+00 -5.913090840923056e+00 -6.002826983718414e+00 4.186248134060500e+00 4.670969315506336e+00 9.225736051273207e+03 + 20680 1.021662076094505e+00 -5.838108476582249e+00 -6.049166687138635e+00 4.544955480838302e+00 4.333026574671004e+00 9.368589877607361e+03 + 20700 1.022764765296458e+00 -5.868131624538714e+00 -6.017826199171981e+00 4.368311828685547e+00 4.508742415980769e+00 9.271838690796232e+03 + 20720 1.065405369115974e+00 -5.967403109372003e+00 -5.949788644892561e+00 3.858497333347670e+00 4.959642314218191e+00 9.063528575138669e+03 + 20740 9.759238150040030e-01 -5.870851666842524e+00 -6.000352654015559e+00 4.447614702167244e+00 4.703999993606676e+00 9.218096448121722e+03 + 20760 1.010452425542852e+00 -5.958520888917298e+00 -5.995049490054967e+00 3.917538120304946e+00 4.707785239789692e+00 9.201847401234005e+03 + 20780 1.023576167188246e+00 -6.011003807764922e+00 -5.986012503698199e+00 3.638122023276601e+00 4.781625958619530e+00 9.174164093210504e+03 + 20800 1.053968797308957e+00 -6.084166244871769e+00 -5.987085684173628e+00 3.227239874031057e+00 4.784691476727997e+00 9.177436747836224e+03 + 20820 9.935676034972494e-01 -6.015652221019179e+00 -5.969644438771562e+00 3.628642187756728e+00 4.892825993103838e+00 9.124100756397323e+03 + 20840 1.005558982561341e+00 -6.049511334532268e+00 -5.969553032206277e+00 3.429620547986969e+00 4.888753493450108e+00 9.123825756249435e+03 + 20860 9.849149869967847e-01 -6.029458955252252e+00 -6.002294926689953e+00 3.545970358363884e+00 4.701950413988442e+00 9.224098724280328e+03 + 20880 1.023133857683913e+00 -6.093658219226695e+00 -6.010501351655464e+00 3.197146814970753e+00 4.674646417048433e+00 9.249335776049798e+03 + 20900 9.283506708574563e-01 -5.958665354356949e+00 -6.031748884389691e+00 3.901204885579098e+00 4.481547946491371e+00 9.314776944930894e+03 + 20920 9.728970037354627e-01 -6.026307355429102e+00 -6.009935809560459e+00 3.554194339048871e+00 4.648202288915156e+00 9.247578464827862e+03 + 20940 9.990652401259520e-01 -6.063487644739144e+00 -5.997337584166799e+00 3.405329484061499e+00 4.785173368556695e+00 9.208879601272636e+03 + 20960 9.798144692042623e-01 -6.033476138988419e+00 -6.004236514427561e+00 3.477622080060239e+00 4.645520529105967e+00 9.230076126795699e+03 + 20980 9.755689889544166e-01 -6.023493904682441e+00 -6.028323719862426e+00 3.571147175653642e+00 4.543413629478688e+00 9.304202750525485e+03 + 21000 9.644761293573554e-01 -5.999588150924776e+00 -6.004966910098013e+00 3.666669895710057e+00 4.635784228177044e+00 9.232315629382309e+03 + 21020 1.031214805769750e+00 -6.087914023844531e+00 -6.003176559557147e+00 3.190768807349337e+00 4.677344440367714e+00 9.226814293579466e+03 + 21040 9.826584091417588e-01 -6.003613028405124e+00 -5.976714239452956e+00 3.645010060191101e+00 4.799467068928585e+00 9.145710528857706e+03 + 21060 9.438143736525921e-01 -5.927599647042834e+00 -6.030985598860433e+00 4.046364630383923e+00 4.452706496122937e+00 9.312412899756817e+03 + 21080 1.006785417446187e+00 -5.995713434579613e+00 -5.991652955329818e+00 3.709523298824741e+00 4.732839199034201e+00 9.191440561035070e+03 + 21100 1.032536243899388e+00 -5.999799998980365e+00 -5.979895493076684e+00 3.682831218019327e+00 4.797125971130594e+00 9.155429641165165e+03 + 21120 9.932779087044918e-01 -5.894547195768276e+00 -6.024273073278764e+00 4.294787315886884e+00 4.549881252206993e+00 9.291685203283479e+03 + 21140 1.042949984981962e+00 -5.916846588439665e+00 -6.001628564479260e+00 4.125932828010661e+00 4.639101601622914e+00 9.222015978352098e+03 + 21160 1.033527544230416e+00 -5.854924193430558e+00 -5.978771673861806e+00 4.538309335569391e+00 4.827157937597506e+00 9.151962310151646e+03 + 21180 1.069629222611741e+00 -5.873617491857473e+00 -6.028013657883055e+00 4.387348922961035e+00 4.500782244912666e+00 9.303206413504528e+03 + 21200 1.069554727962755e+00 -5.852884303326673e+00 -6.048313171143107e+00 4.519290630115002e+00 4.397107828593484e+00 9.365936838385702e+03 + 21220 1.162437437752148e+00 -5.983886239561020e+00 -6.017301182400144e+00 3.845239331869627e+00 4.653365559141685e+00 9.270242835367450e+03 + 21240 1.110927368371439e+00 -5.913093429662656e+00 -6.030391969691578e+00 4.172126778072816e+00 4.498580409336339e+00 9.310580942004379e+03 + 21260 1.076156925729344e+00 -5.879327709136879e+00 -6.056924509322673e+00 4.339480739768585e+00 4.319692430085749e+00 9.392579533432981e+03 + 21280 1.070917955958969e+00 -5.898186156484973e+00 -6.031325659822243e+00 4.169117056077584e+00 4.404609424643428e+00 9.313422772339565e+03 + 21300 1.096514350867134e+00 -5.964242122462515e+00 -5.965856745133010e+00 3.852627379552065e+00 4.843355966316033e+00 9.112523989324796e+03 + 21320 1.067116952072880e+00 -5.949828696643183e+00 -5.983683640868516e+00 3.961301917667972e+00 4.766901588890426e+00 9.167008976229488e+03 + 21340 9.733042516427146e-01 -5.835069249974747e+00 -5.947280280487305e+00 4.612307680114125e+00 4.967974578310169e+00 9.055851518306297e+03 + 21360 1.027577094914803e+00 -5.934853032564371e+00 -5.968813881455328e+00 4.021935460196642e+00 4.826927010440385e+00 9.121532734448489e+03 + 21380 1.072609431119996e+00 -6.017543317914700e+00 -5.945600472818894e+00 3.620825948338215e+00 5.033932897997630e+00 9.050796974970299e+03 + 21400 9.898946527274978e-01 -5.910041399240425e+00 -6.033861952900703e+00 4.166328072670215e+00 4.455331292384146e+00 9.321277870693659e+03 + 21420 1.002618689541760e+00 -5.943549275291296e+00 -6.058161470521888e+00 4.037367424121746e+00 4.379246462927791e+00 9.396465339080180e+03 + 21440 1.022523196262328e+00 -5.991500822278101e+00 -6.015991109776595e+00 3.798009117407330e+00 4.657382096731232e+00 9.266207608493725e+03 + 21460 1.059089874788827e+00 -6.066078896928149e+00 -5.990081880932252e+00 3.311912550245063e+00 4.748299176593717e+00 9.186645376663882e+03 + 21480 1.054238961730728e+00 -6.077712979255447e+00 -6.017636717937188e+00 3.262195039965717e+00 4.607162229226548e+00 9.271264107581936e+03 + 21500 9.117177860077734e-01 -5.883921577482081e+00 -6.014824999103746e+00 4.325280397932168e+00 4.573612693741538e+00 9.262617603510133e+03 + 21520 1.010417205342929e+00 -6.044304872359831e+00 -6.001938698005755e+00 3.443219211531480e+00 4.686492340816871e+00 9.222972778370078e+03 + 21540 1.031517411384685e+00 -6.088394098247186e+00 -5.975013701558337e+00 3.249523428909468e+00 4.900571212256517e+00 9.140519997862086e+03 + 21560 9.802114896980247e-01 -6.023301455488809e+00 -5.987417889694369e+00 3.631336888261532e+00 4.837385876017068e+00 9.178455184561197e+03 + 21580 9.523865789964984e-01 -5.990036382421643e+00 -6.036381431848802e+00 3.702501173525748e+00 4.436380727841776e+00 9.329074912816708e+03 + 21600 9.618832287670501e-01 -6.009764519970290e+00 -5.998858361310391e+00 3.661114967047775e+00 4.723739817795517e+00 9.213557308102641e+03 + 21620 9.991822204948586e-01 -6.069333989204245e+00 -6.012598936711749e+00 3.281312772338182e+00 4.607094223471096e+00 9.255787206887571e+03 + 21640 9.975387108981174e-01 -6.069686768196506e+00 -5.959094625635263e+00 3.336562171232038e+00 4.971599367897445e+00 9.091906516735027e+03 + 21660 9.176883502925216e-01 -5.948980258039859e+00 -6.043294795370389e+00 3.937871652254803e+00 4.396302983775419e+00 9.350411904248975e+03 + 21680 1.037480589102382e+00 -6.120968083484707e+00 -5.968890150255713e+00 3.053663895513688e+00 4.926918922098682e+00 9.121798567109558e+03 + 21700 1.017693248961251e+00 -6.079083182585039e+00 -6.013947341096353e+00 3.269668584615350e+00 4.643688666182284e+00 9.259919286489428e+03 + 21720 9.784267063155418e-01 -6.001117367213049e+00 -5.991560774637366e+00 3.715632779882378e+00 4.770508213329871e+00 9.191147402971383e+03 + 21740 1.008826176109950e+00 -6.016998960806224e+00 -5.975838622257434e+00 3.672092229815318e+00 4.908441263304280e+00 9.143009594972627e+03 + 21760 1.057957010716708e+00 -6.047520604583877e+00 -5.974675309421018e+00 3.448097911739364e+00 4.866386869337496e+00 9.139464789237909e+03 + 21780 9.857884497081655e-01 -5.893655433098539e+00 -6.020546630397257e+00 4.259868270578128e+00 4.531239379339565e+00 9.280243038816960e+03 + 21800 1.065179958817701e+00 -5.970910252406604e+00 -6.006105104891636e+00 3.867233776365414e+00 4.665139487010541e+00 9.235795396948753e+03 + 21820 1.060341471203150e+00 -5.930967415214470e+00 -6.017087578744073e+00 4.067489978088696e+00 4.572974672049476e+00 9.269567944167715e+03 + 21840 1.062198680552602e+00 -5.910844443134891e+00 -6.040499018472351e+00 4.138637361855372e+00 4.394140726286985e+00 9.341778960706453e+03 + 21860 1.071349459120031e+00 -5.912297703179904e+00 -6.038503742565334e+00 4.137643532929964e+00 4.412948924457350e+00 9.335614050126283e+03 + 21880 9.921804189413620e-01 -5.794255659959075e+00 -6.032695035148310e+00 4.814590726099097e+00 4.445434935388448e+00 9.317651938648412e+03 + 21900 1.030933188808533e+00 -5.857939950527225e+00 -5.985168744207794e+00 4.465382652877279e+00 4.734815230971265e+00 9.171543263581410e+03 + 21920 1.087784855516030e+00 -5.954498888403711e+00 -6.028302886128120e+00 3.896412090381455e+00 4.472618114316157e+00 9.304115210492164e+03 + 21940 1.019372206528466e+00 -5.873423736170621e+00 -6.001249277681659e+00 4.426888385923693e+00 4.692894345628693e+00 9.220856434609326e+03 + 21960 1.005064329583877e+00 -5.880187997663567e+00 -6.038125488443774e+00 4.249357550793266e+00 4.342456037985607e+00 9.334433809838858e+03 + 21980 1.075590252776410e+00 -6.017467360143520e+00 -5.984017293280871e+00 3.614421480089248e+00 4.806496940395697e+00 9.168044221181342e+03 + 22000 9.791842540399127e-01 -5.910893630165966e+00 -5.999990913893009e+00 4.153733472935152e+00 4.642123082014378e+00 9.217017459902554e+03 + 22020 1.078276493899278e+00 -6.092097855927024e+00 -5.960477442012960e+00 3.233857554953847e+00 4.989642339841625e+00 9.096104996897084e+03 + 22040 9.946238097588608e-01 -5.996268955262110e+00 -6.031266671234464e+00 3.706267606356142e+00 4.505305305363844e+00 9.313279354901801e+03 + 22060 9.863429011588278e-01 -6.007988761806122e+00 -6.008849202428545e+00 3.669029130642902e+00 4.664088347436194e+00 9.244252909920553e+03 + 22080 1.014110122613598e+00 -6.066710450700308e+00 -6.026594965597335e+00 3.320255272978876e+00 4.550604596291404e+00 9.298875735232668e+03 + 22100 9.635746292318319e-01 -6.004607018160431e+00 -6.025035674097280e+00 3.662145872559921e+00 4.544841368846241e+00 9.294063866334929e+03 + 22120 9.756423201190462e-01 -6.030219494163190e+00 -6.005196959354591e+00 3.494781540305620e+00 4.638464807401343e+00 9.232979094433753e+03 + 22140 9.781356968218186e-01 -6.036788409492193e+00 -6.011170967323522e+00 3.515071815672006e+00 4.662171132890879e+00 9.251355786874048e+03 + 22160 9.773806029344771e-01 -6.035621433563411e+00 -5.968222151680054e+00 3.528900864758814e+00 4.915917971338214e+00 9.119774347634357e+03 + 22180 9.873137347130815e-01 -6.047992354179838e+00 -5.970940039230413e+00 3.443251160958964e+00 4.885697477205763e+00 9.128058866293246e+03 + 22200 9.433788662083131e-01 -5.976718640691713e+00 -6.030278506159959e+00 3.810206589008355e+00 4.502657553127293e+00 9.310210493666234e+03 + 22220 1.002202782726228e+00 -6.056621195965553e+00 -5.987791228584612e+00 3.398155433633847e+00 4.793387757738240e+00 9.179618695345227e+03 + 22240 1.045122163464989e+00 -6.110949579240421e+00 -5.995108964808876e+00 3.086447118241544e+00 4.751621852584622e+00 9.202050882342955e+03 + 22260 1.032069982609295e+00 -6.082048895281526e+00 -6.008549811889415e+00 3.224977830209054e+00 4.647020940992954e+00 9.243325747453144e+03 + 22280 9.488492854565588e-01 -5.947876096516975e+00 -6.028210992060165e+00 4.001492710907394e+00 4.540197308913486e+00 9.303870597169464e+03 + 22300 1.022933068185239e+00 -6.047374766531158e+00 -6.015438072648855e+00 3.467186927507160e+00 4.650572365966749e+00 9.264499143348086e+03 + 22320 1.013649306702181e+00 -6.022835324079803e+00 -6.017814666505347e+00 3.554289745009737e+00 4.583119137746509e+00 9.271825300975739e+03 + 22340 1.021903390132573e+00 -6.022701364889643e+00 -6.004916882618241e+00 3.604623772061068e+00 4.706745021403194e+00 9.232131730126526e+03 + 22360 1.012739045580087e+00 -5.995756241031027e+00 -5.973393793525524e+00 3.717661834500649e+00 4.846070468654819e+00 9.135549941828902e+03 + 22380 1.010190828357459e+00 -5.975399110851088e+00 -6.000114424650384e+00 3.838577960625002e+00 4.696658804106994e+00 9.217368615969996e+03 + 22400 9.880203182961083e-01 -5.920467293067025e+00 -5.982862634910545e+00 4.113524516532355e+00 4.755240808018917e+00 9.164505555565565e+03 + 22420 9.897084656321042e-01 -5.892123913270458e+00 -6.018992393641823e+00 4.257475638325859e+00 4.528977191199597e+00 9.275417911259763e+03 + 22440 1.071792787752470e+00 -5.974080398413129e+00 -5.970799873845892e+00 3.800270611356679e+00 4.819107891081288e+00 9.127619543840616e+03 + 22460 1.061269894937528e+00 -5.909992261626056e+00 -6.026280229392357e+00 4.111674680589880e+00 4.443931174170925e+00 9.297886780924415e+03 + 22480 1.017486846457113e+00 -5.799625911062781e+00 -6.045686551027796e+00 4.789648785615475e+00 4.376730513175393e+00 9.357823538952111e+03 + 22500 1.150917520413689e+00 -5.961445657331696e+00 -6.022149601380879e+00 3.894672483520631e+00 4.546101042885240e+00 9.285158609210597e+03 + 22520 1.088721251061558e+00 -5.846850275644146e+00 -6.055708996639575e+00 4.482440596607650e+00 4.283141499869277e+00 9.388797684589230e+03 + 22540 1.134036404892634e+00 -5.906985870378605e+00 -6.009617519884742e+00 4.188178044451480e+00 4.598851230790808e+00 9.246566159902792e+03 + 22560 1.110402598658546e+00 -5.876964244023634e+00 -6.042903493646666e+00 4.350953311061009e+00 4.398104460709675e+00 9.349231875310472e+03 + 22580 1.127121746776977e+00 -5.921967624334484e+00 -6.025388875661401e+00 4.091775324358464e+00 4.497914494852389e+00 9.295154677335213e+03 + 22600 1.119081371964110e+00 -5.945095749626113e+00 -6.010954108234255e+00 4.013430903879822e+00 4.635262017203816e+00 9.250688851743560e+03 + 22620 1.083575986922793e+00 -5.938036943466445e+00 -5.991486865382374e+00 4.071656756710355e+00 4.764739033720404e+00 9.190893418647351e+03 + 22640 1.023425350867024e+00 -5.889817555634862e+00 -5.979574038499083e+00 4.289643349288475e+00 4.774247734911291e+00 9.154393592083175e+03 + 22660 1.016049366706371e+00 -5.910594642931821e+00 -6.018363912409598e+00 4.194848991501653e+00 4.576021168919703e+00 9.273494421174470e+03 + 22680 1.019362715649544e+00 -5.941671153670428e+00 -6.053775143749082e+00 4.002753316952152e+00 4.359034857884120e+00 9.382855435500314e+03 + 22700 1.009147208958071e+00 -5.946887610575694e+00 -6.050604580039914e+00 3.929319252235040e+00 4.333760363422339e+00 9.373065408314136e+03 + 22720 9.917939204053360e-01 -5.939725427232059e+00 -6.039452249715718e+00 4.015311498394498e+00 4.442664651017422e+00 9.338559838362818e+03 + 22740 9.917983440078565e-01 -5.955244795444909e+00 -5.977281657003357e+00 3.950073152599922e+00 4.823534083338011e+00 9.147417428729206e+03 + 22760 9.934982793514509e-01 -5.968303801051256e+00 -5.995861864421935e+00 3.898795239613080e+00 4.740552575142114e+00 9.204343814396707e+03 + 22780 9.959015940190978e-01 -5.981246746080947e+00 -6.010751541374797e+00 3.772277637418077e+00 4.602856536988476e+00 9.250101310686056e+03 + 22800 1.067864695646853e+00 -6.099386971394566e+00 -5.995166889645763e+00 3.170890444839320e+00 4.769338282246469e+00 9.202220161996514e+03 + 22820 9.829507758994138e-01 -5.986911488436851e+00 -5.978442797388142e+00 3.793468680330104e+00 4.842097214857494e+00 9.150985888901510e+03 + 22840 1.011033585730668e+00 -6.038924600947125e+00 -5.962539641825717e+00 3.540221251749691e+00 4.978835507559038e+00 9.102405955831222e+03 + 22860 9.712546253928072e-01 -5.988815276776822e+00 -6.031471855858626e+00 3.689635540153840e+00 4.444694861981839e+00 9.313909945226049e+03 + 22880 1.006454689527280e+00 -6.049567795360125e+00 -5.988920296720647e+00 3.433190406984386e+00 4.781437729342353e+00 9.183061211793434e+03 + 22900 9.386964559902257e-01 -5.955594453236765e+00 -5.999689384080467e+00 3.914822107841274e+00 4.661622191268242e+00 9.216106597189138e+03 + 22920 1.007394457245683e+00 -6.061847621554983e+00 -6.012327536351181e+00 3.363278260553941e+00 4.647630253002590e+00 9.254937766312627e+03 + 22940 9.856526122832221e-01 -6.034066044950441e+00 -6.004231947329220e+00 3.554380557368126e+00 4.725692562720859e+00 9.230031823235486e+03 + 22960 9.277948979763895e-01 -5.951212396230093e+00 -5.999064466929994e+00 3.946278199114185e+00 4.671504204071347e+00 9.214174265640529e+03 + 22980 9.849845352007680e-01 -6.033691290143869e+00 -5.988549144811508e+00 3.555269295324171e+00 4.814482479547006e+00 9.181943358955863e+03 + 23000 9.593695194668642e-01 -5.990161174826070e+00 -6.042727478124340e+00 3.740217058008258e+00 4.438373209860441e+00 9.348693846786753e+03 + 23020 9.725084319887580e-01 -6.002389754789930e+00 -6.049871289363112e+00 3.621792119668010e+00 4.349145800405072e+00 9.370781724633902e+03 + 23040 9.898607363961632e-01 -6.017834627085242e+00 -6.009095379658098e+00 3.595951019431225e+00 4.646133130552053e+00 9.244998541093833e+03 + 23060 9.811426977747457e-01 -5.989916236214349e+00 -6.048329802687061e+00 3.672607010378285e+00 4.337187272221772e+00 9.366003662076519e+03 + 23080 9.741572166262803e-01 -5.960423297079621e+00 -6.010949377970067e+00 3.889171744034374e+00 4.599043168675684e+00 9.250676319587432e+03 + 23100 1.012521286047647e+00 -5.992948362440125e+00 -6.005821413047384e+00 3.701821779981683e+00 4.627902731296657e+00 9.234928075040900e+03 + 23120 1.033441909342704e+00 -5.993466095531886e+00 -6.016665799834858e+00 3.737451449511797e+00 4.604235157261493e+00 9.268278304532692e+03 + 23140 9.839719562834255e-01 -5.890483385032412e+00 -6.021384655078157e+00 4.259201109391816e+00 4.507545759883075e+00 9.282802283237195e+03 + 23160 1.026149895686381e+00 -5.924878627775872e+00 -6.046219349490654e+00 4.044858561377625e+00 4.348101359875349e+00 9.359483789355767e+03 + 23180 1.028697724661663e+00 -5.904062481675901e+00 -6.043329338090022e+00 4.204983137031388e+00 4.405291296025125e+00 9.350535760772420e+03 + 23200 9.980700119762436e-01 -5.840127364905873e+00 -6.076029806657210e+00 4.478516899961652e+00 4.123928573640600e+00 9.451900233429831e+03 + 23220 1.058994619633527e+00 -5.919345476709426e+00 -6.017838613992297e+00 4.168795971461033e+00 4.603233135419054e+00 9.271868556231011e+03 + 23240 1.031573877085271e+00 -5.875266293667829e+00 -5.998217711288674e+00 4.339147528162528e+00 4.633141461513252e+00 9.211571431317750e+03 + 23260 1.102825573245005e+00 -5.983738132594798e+00 -5.949134346531535e+00 3.863028937651286e+00 5.061729232145133e+00 9.061557750696631e+03 + 23280 1.045748094352845e+00 -5.908666347075487e+00 -5.987616138066322e+00 4.183209929465819e+00 4.729868012155770e+00 9.179022870235434e+03 + 23300 1.019932737237722e+00 -5.888847334362409e+00 -5.975519434104493e+00 4.306510626363432e+00 4.808826017180297e+00 9.142035954516321e+03 + 23320 1.076023815098867e+00 -5.999473789687279e+00 -5.961668537275158e+00 3.729108550553048e+00 4.946192160247353e+00 9.099738705580121e+03 + 23340 9.897645344163664e-01 -5.909750207532914e+00 -6.037025754741103e+00 4.177027002458995e+00 4.446191114562295e+00 9.331026448331851e+03 + 23360 1.031551352684153e+00 -6.017780762340863e+00 -5.975994869735930e+00 3.633175452541894e+00 4.873116514225400e+00 9.143498879736911e+03 + 23380 9.858864315093101e-01 -5.996644894474031e+00 -6.010268311654070e+00 3.750106788288680e+00 4.671879018623899e+00 9.248602736459068e+03 + 23400 1.001463710505521e+00 -6.059715796838573e+00 -5.997178557384169e+00 3.411405585371386e+00 4.770504091925101e+00 9.208386622632825e+03 + 23420 9.272625447238150e-01 -5.979300009921445e+00 -5.987719764977788e+00 3.868219897412903e+00 4.819872360926496e+00 9.179384970901743e+03 + 23440 9.790489579046698e-01 -6.071663597663365e+00 -6.017463239992027e+00 3.315125456262189e+00 4.626352297489250e+00 9.270739234005696e+03 + 23460 9.498444317901912e-01 -6.037071217677043e+00 -6.029516770523903e+00 3.519351028086443e+00 4.562729832686690e+00 9.307889742652553e+03 + 23480 9.587451758153004e-01 -6.053120840798645e+00 -6.006499058858436e+00 3.403503749548825e+00 4.671213236146944e+00 9.237028700563680e+03 + 23500 9.580971217050270e-01 -6.050669376979902e+00 -6.003372098162060e+00 3.386329065201100e+00 4.657917359403393e+00 9.227420406352667e+03 + 23520 9.618333854857086e-01 -6.051226744828899e+00 -5.987168060212904e+00 3.484344524877296e+00 4.852179404991750e+00 9.177689260641102e+03 + 23540 9.256909825770875e-01 -5.988130663443041e+00 -6.013616897643071e+00 3.737973401501503e+00 4.591627500742938e+00 9.258892346360060e+03 + 23560 9.388474676000665e-01 -5.994663789035952e+00 -6.013648492429573e+00 3.659408208648807e+00 4.550395103889278e+00 9.258995664711287e+03 + 23580 1.033284476206907e+00 -6.118741274703321e+00 -5.981643977154798e+00 3.037711113451839e+00 4.824945011713691e+00 9.160792645420865e+03 + 23600 9.519040455179578e-01 -5.980089820255312e+00 -5.999916908400648e+00 3.785027667215040e+00 4.671177458852547e+00 9.216796751694106e+03 + 23620 9.510668118423510e-01 -5.960526742228542e+00 -5.991342513987050e+00 3.904037397892837e+00 4.727088467730221e+00 9.190417703350557e+03 + 23640 9.704996060251925e-01 -5.966749573255314e+00 -5.966868434022453e+00 3.944081522410401e+00 4.943399005491838e+00 9.115594267495035e+03 + 23660 1.036087641881834e+00 -6.039445002027708e+00 -5.975949467243177e+00 3.513120831014192e+00 4.877722017649218e+00 9.143369609065048e+03 + 23680 1.015852972346701e+00 -5.986689522443347e+00 -5.994056703826891e+00 3.774296722845871e+00 4.731993227273925e+00 9.198816404600164e+03 + 23700 1.057937618686519e+00 -6.028660309030625e+00 -5.981268215407511e+00 3.529025933235599e+00 4.801158668722306e+00 9.159634717256593e+03 + 23720 1.038624978041034e+00 -5.983225462523315e+00 -6.014821956745623e+00 3.820556958933788e+00 4.639124999567619e+00 9.262555526581698e+03 + 23740 1.073526975972904e+00 -6.022254942842240e+00 -6.002423181036693e+00 3.530249124822784e+00 4.644126170065451e+00 9.224485996391422e+03 + 23760 1.084856207923616e+00 -6.032507058155222e+00 -5.992586169092958e+00 3.549181051059947e+00 4.778412973793083e+00 9.194297872983710e+03 + 23780 9.829457539641898e-01 -5.880809830170332e+00 -6.000033499784257e+00 4.343334773172973e+00 4.658734012446571e+00 9.217139005390751e+03 + 23800 1.034422900736371e+00 -5.959025052083293e+00 -5.984580144561593e+00 3.887999272833734e+00 4.741257977185553e+00 9.169781637771348e+03 + 23820 1.031886180157727e+00 -5.959416208015627e+00 -6.034136432326788e+00 3.886796221063539e+00 4.457741130151510e+00 9.322133684205193e+03 + 23840 9.951000712718758e-01 -5.913518452648532e+00 -6.040119713245875e+00 4.129335276720804e+00 4.402371246889094e+00 9.340620039053312e+03 + 23860 1.017771427992971e+00 -5.961577581985477e+00 -6.039937451346551e+00 3.901020262927456e+00 4.451065766905569e+00 9.340046665981188e+03 + 23880 9.695564443225816e-01 -5.911934511938344e+00 -6.025563753982830e+00 4.174713523118706e+00 4.522236831230891e+00 9.295689381826751e+03 + 23900 1.017922555481183e+00 -6.014934897600943e+00 -5.986808715496805e+00 3.652990556827992e+00 4.814495446982569e+00 9.176576109159181e+03 + 23920 9.862784642173218e-01 -6.014207631817699e+00 -5.974217975416686e+00 3.632495870917814e+00 4.862122666351761e+00 9.138033402900586e+03 + 23940 9.330227206985735e-01 -5.993666234544509e+00 -5.993285881035311e+00 3.761297248232474e+00 4.763481296941806e+00 9.196457316476412e+03 + 23960 9.254457258346219e-01 -6.051594061061197e+00 -6.016324576480473e+00 3.427856633576790e+00 4.630379471974402e+00 9.267249535778268e+03 + 23980 9.735717043445666e-01 -6.175742417946459e+00 -5.976136574820107e+00 2.712806761154854e+00 4.858974401290765e+00 9.143959595157115e+03 + 24000 9.461904016993739e-01 -6.162362801842079e+00 -5.942708611897298e+00 2.822091742574888e+00 5.083380092613861e+00 9.042024653545230e+03 + 24020 8.827740075669109e-01 -6.074994615589641e+00 -5.965608107864369e+00 3.327661798667717e+00 4.955776053533588e+00 9.111770632495462e+03 + 24040 8.694914430515757e-01 -6.049834139684096e+00 -5.997112163632315e+00 3.446530054846037e+00 4.749267800034789e+00 9.208196656681861e+03 + 24060 9.770259115146306e-01 -6.196234744784419e+00 -5.951866099524890e+00 2.630889104396634e+00 5.034091681402490e+00 9.069898493160508e+03 + 24080 9.500184915643773e-01 -6.137244672977647e+00 -5.997965708629570e+00 2.983471802648181e+00 4.783233169284918e+00 9.210809015067754e+03 + 24100 9.420962014318667e-01 -6.101469350232633e+00 -6.006033130706827e+00 3.105708382404392e+00 4.653717923628812e+00 9.235592766975195e+03 + 24120 9.005996509335893e-01 -6.012477049791240e+00 -6.029872390385022e+00 3.597806074122518e+00 4.497919336512764e+00 9.308968757018341e+03 + 24140 9.010626127323625e-01 -5.982477216570068e+00 -5.989285181675137e+00 3.748674817132712e+00 4.709582427970213e+00 9.184171513823811e+03 + 24160 9.340095060498078e-01 -5.996126183762268e+00 -5.988685410335099e+00 3.687672227795691e+00 4.730398300270459e+00 9.182352736068940e+03 + 24180 1.035111043595285e+00 -6.111302657768197e+00 -5.988778468249215e+00 3.090053368594201e+00 4.793606225369240e+00 9.182638767890978e+03 + 24200 1.010220698003109e+00 -6.044298089255832e+00 -5.975470784254828e+00 3.522563701777810e+00 4.917780738084607e+00 9.141859723944701e+03 + 24220 9.983542603191261e-01 -6.000767529831013e+00 -5.992122209290900e+00 3.736755116293572e+00 4.786397884693931e+00 9.192859081593504e+03 + 24240 1.016583207696205e+00 -6.005094356643840e+00 -5.970443641816342e+00 3.718750405015055e+00 4.917720171735339e+00 9.126531775333135e+03 + 24260 1.022579859651586e+00 -5.994450041568252e+00 -5.976274265585198e+00 3.778326428489127e+00 4.882694546876062e+00 9.144330910439183e+03 + 24280 1.014956747587736e+00 -5.966298557591905e+00 -5.959606009886473e+00 3.889281573583992e+00 4.927711218176997e+00 9.093475534569921e+03 + 24300 1.005012926340284e+00 -5.935451858044829e+00 -6.056797693668470e+00 4.031581558630239e+00 4.334794992271921e+00 9.392212664331517e+03 + 24320 1.050812889178244e+00 -5.992316416034029e+00 -6.007485130162472e+00 3.786865558077262e+00 4.699764454200819e+00 9.240046012263678e+03 + 24340 1.052751976300991e+00 -5.989337970114093e+00 -6.008636429419245e+00 3.706146593502732e+00 4.595331853745623e+00 9.243588463416218e+03 + 24360 1.020140407111782e+00 -5.940444061288757e+00 -5.964522902994716e+00 3.971568843392322e+00 4.833304408127990e+00 9.108444583215429e+03 + 24380 1.004476407976813e+00 -5.917642030958069e+00 -6.002092366228823e+00 4.118010119754702e+00 4.633083225982882e+00 9.223441691313181e+03 + 24400 9.682290933549051e-01 -5.866504879326892e+00 -6.033010760154932e+00 4.427329357197440e+00 4.471226822781056e+00 9.318645430569970e+03 + 24420 1.106115694556303e+00 -6.077447382232939e+00 -6.002388163695597e+00 3.245260593546187e+00 4.676262241764134e+00 9.224402761741734e+03 + 24440 1.058058242281482e+00 -6.018222460160856e+00 -6.045898858625310e+00 3.560866388236781e+00 4.401944225345067e+00 9.358495826767145e+03 + 24460 1.042267008513897e+00 -6.018523225681511e+00 -5.987975837921740e+00 3.584047117655611e+00 4.759454945365192e+00 9.180170621034884e+03 + 24480 8.925470910252520e-01 -5.826080163260807e+00 -6.044688016840915e+00 4.659401622998088e+00 4.404121498285098e+00 9.354724363514482e+03 + 24500 1.010885171849571e+00 -6.036783431494696e+00 -6.005133100398313e+00 3.477245382619505e+00 4.658986481647840e+00 9.232815281754381e+03 + 24520 1.000192092925360e+00 -6.062621912243226e+00 -5.998938392836215e+00 3.322692004629349e+00 4.688372628057186e+00 9.213797462472592e+03 + 24540 9.496901712257360e-01 -6.026168831452337e+00 -5.978729232232556e+00 3.580368102496390e+00 4.852773622470629e+00 9.151852236469351e+03 + 24560 9.349994211157662e-01 -6.036811959563241e+00 -5.995365458101583e+00 3.485507649975990e+00 4.723499875194205e+00 9.202844637446275e+03 + 24580 9.594872195241546e-01 -6.096634286460734e+00 -5.997022123165960e+00 3.168506738203195e+00 4.740495194774237e+00 9.207903964021212e+03 + 24600 9.358544131224551e-01 -6.076735174192317e+00 -6.010444660283974e+00 3.266325980765547e+00 4.646976370051126e+00 9.249144290688375e+03 + 24620 8.793918590744703e-01 -5.998620939868289e+00 -6.009058734772514e+00 3.702464222521960e+00 4.642528788938360e+00 9.244885923350712e+03 + 24640 9.674796517535932e-01 -6.127324090752232e+00 -5.967901047524539e+00 3.025991535915402e+00 4.941423320765022e+00 9.118789808488358e+03 + 24660 9.272482877804114e-01 -6.059013047479327e+00 -6.028383756566683e+00 3.338425938815589e+00 4.514304067103444e+00 9.304400717487002e+03 + 24680 9.737364887749883e-01 -6.116164012234549e+00 -5.990895767685797e+00 3.046696682249796e+00 4.766006327646926e+00 9.189105913326261e+03 + 24700 9.546602890124146e-01 -6.073396841626093e+00 -5.948036984103352e+00 3.307859737983236e+00 5.027695439254074e+00 9.058223685346475e+03 + 24720 9.832679866205666e-01 -6.096846566116435e+00 -5.960973696232048e+00 3.207534602400585e+00 4.987737647535395e+00 9.097631621271865e+03 + 24740 9.529922521218857e-01 -6.031820128561122e+00 -5.988200428581051e+00 3.549567357472303e+00 4.800038424884631e+00 9.180861983816398e+03 + 24760 1.036792047074321e+00 -6.137162173427456e+00 -5.950839395590419e+00 2.998072075224386e+00 5.067966298921332e+00 9.066761137572857e+03 + 24780 9.904124243112699e-01 -6.050418697482343e+00 -5.984693812984037e+00 3.452079023875175e+00 4.829481481557446e+00 9.170116887276052e+03 + 24800 9.792890160642059e-01 -6.021112177883894e+00 -5.985531448149162e+00 3.608845123100123e+00 4.813155179337080e+00 9.172673570066894e+03 + 24820 9.129681458441139e-01 -5.911114654388607e+00 -6.062104369024154e+00 4.116292930374581e+00 4.249286623354442e+00 9.408691636209087e+03 + 24840 1.000443111894707e+00 -6.030816371374836e+00 -5.978089379319548e+00 3.533106823965638e+00 4.835873371822753e+00 9.149908052214265e+03 + 24860 9.433365677920791e-01 -5.935414945143329e+00 -6.005012458767000e+00 4.138149598343958e+00 4.738509904936406e+00 9.232417950027228e+03 + 24880 1.039633429264508e+00 -6.066763472567557e+00 -6.012948455084690e+00 3.293692687400208e+00 4.602706845633868e+00 9.256862007623395e+03 + 24900 1.046654868050936e+00 -6.067824313299510e+00 -6.032086510570363e+00 3.351935675274722e+00 4.557147668952580e+00 9.315831426737019e+03 + 24920 9.798090665952561e-01 -5.964326730862574e+00 -6.058145222665829e+00 3.879416457529528e+00 4.340696159230550e+00 9.396396538489462e+03 + 24940 1.002469710022253e+00 -5.995405415392223e+00 -6.019520255781652e+00 3.696641879978579e+00 4.558170734702986e+00 9.277091772472982e+03 + 24960 9.793523473480422e-01 -5.958876118003082e+00 -6.013686293810457e+00 3.922841050409297e+00 4.608112539076059e+00 9.259102041762973e+03 + 24980 9.766590227129539e-01 -5.952998822635317e+00 -5.993001939619436e+00 3.856720895784525e+00 4.627016807599366e+00 9.195572980313684e+03 + 25000 1.020959816205742e+00 -6.017090485402843e+00 -5.950818931041267e+00 3.605634771342587e+00 4.986176291976646e+00 9.066667709933334e+03 + 25020 9.553022473356746e-01 -5.914670279099575e+00 -5.969217055584691e+00 4.215995262780355e+00 4.902779231116434e+00 9.122763783131621e+03 + 25040 1.005679102133422e+00 -5.982474229928066e+00 -5.988865466364407e+00 3.777606727126918e+00 4.740907258468805e+00 9.182875490640034e+03 + 25060 1.042805791167808e+00 -6.027685552991912e+00 -5.978330413467694e+00 3.505804533606453e+00 4.789209382437667e+00 9.150638903832736e+03 + 25080 1.035880321145391e+00 -6.005860261386481e+00 -5.991434782667788e+00 3.633636554050326e+00 4.716469885188674e+00 9.190782468987978e+03 + 25100 1.020331486659574e+00 -5.969355480348847e+00 -6.010545859659783e+00 3.909419132344935e+00 4.672897600150943e+00 9.249442225689534e+03 + 25120 9.979429304773371e-01 -5.921363184317777e+00 -6.036630371074986e+00 4.104502372420211e+00 4.442620348520808e+00 9.329861671823552e+03 + 25140 1.064351319742265e+00 -6.003068221208171e+00 -6.089040767736607e+00 3.602278065148408e+00 4.108610398773552e+00 9.492412530308518e+03 + 25160 1.021146818493982e+00 -5.926075073891381e+00 -6.013816999393066e+00 4.114035196192441e+00 4.610207481942675e+00 9.259510954001786e+03 + 25180 1.062418251837265e+00 -5.974997132322318e+00 -5.988641448992002e+00 3.862044301905011e+00 4.783696524136504e+00 9.182203731458512e+03 + 25200 1.063823771219057e+00 -5.966559792012468e+00 -6.038700589495576e+00 3.861853733241042e+00 4.447610110340706e+00 9.336221843554262e+03 + 25220 1.090892318495591e+00 -5.999676358971332e+00 -6.044614174187076e+00 3.649544178440481e+00 4.391504289367244e+00 9.354529036423701e+03 + 25240 1.016664578847220e+00 -5.890764901671462e+00 -6.076146488675689e+00 4.259093566001685e+00 4.194603805715538e+00 9.452279615158539e+03 + 25260 1.104998034692448e+00 -6.033991763381508e+00 -5.960289653863373e+00 3.498710156762688e+00 4.921919074980407e+00 9.095580523923165e+03 + 25280 1.013593005434118e+00 -5.916637796452709e+00 -6.002422056396536e+00 4.088443444170732e+00 4.595856948501954e+00 9.224507161631376e+03 + 25300 1.052227617607659e+00 -5.997914707456580e+00 -6.047675182243269e+00 3.713006668360321e+00 4.427274321726565e+00 9.363972984115084e+03 + 25320 9.930837492726612e-01 -5.942116910824335e+00 -6.010196106868012e+00 4.020377557931493e+00 4.629456279027166e+00 9.248359664462345e+03 + 25340 1.020050945048198e+00 -6.016110688238202e+00 -6.010811093722440e+00 3.632882737421312e+00 4.663313829240418e+00 9.250267705638453e+03 + 25360 9.886632948425029e-01 -6.004874321957470e+00 -6.011674125548289e+00 3.619201339420101e+00 4.580155814935409e+00 9.252941189213490e+03 + 25380 9.447601439068783e-01 -5.970824004084458e+00 -6.038764987346963e+00 3.828677767911000e+00 4.438550128184516e+00 9.336429410704366e+03 + 25400 9.351050303246574e-01 -5.980875300590840e+00 -6.024920291057240e+00 3.848556878104587e+00 4.595643726906275e+00 9.293720525508710e+03 + 25420 9.458259625197807e-01 -6.016965955125965e+00 -6.040123464514681e+00 3.599246352109410e+00 4.466272349586404e+00 9.340633714413470e+03 + 25440 9.143578405666148e-01 -5.985495591247549e+00 -6.037700022524932e+00 3.766705009072273e+00 4.466939086067907e+00 9.333171759395051e+03 + 25460 9.492546867119083e-01 -6.047110625001029e+00 -5.986913032458006e+00 3.467052869140589e+00 4.812716761069966e+00 9.176934785302868e+03 + 25480 9.285870339023531e-01 -6.019209564223438e+00 -5.994904591227594e+00 3.638112330831868e+00 4.777675246956418e+00 9.201414083388094e+03 + 25500 9.413858012164735e-01 -6.035717056551403e+00 -5.995186935031222e+00 3.521129034219242e+00 4.753859264004159e+00 9.202289065763522e+03 + 25520 9.867391117476341e-01 -6.096036573481160e+00 -5.981121229631416e+00 3.193191867847851e+00 4.853053555325067e+00 9.159205528520999e+03 + 25540 9.241767442962597e-01 -5.990119050225297e+00 -6.010464480841605e+00 3.765220433261872e+00 4.648393822217816e+00 9.249201540934318e+03 + 25560 9.770623405958951e-01 -6.051042790398601e+00 -5.971394590542369e+00 3.432995163019640e+00 4.890347452113214e+00 9.129452215770312e+03 + 25580 9.765719047505141e-01 -6.026345837267691e+00 -5.984903656598581e+00 3.585540786911479e+00 4.823508201470237e+00 9.170732497500769e+03 + 25600 1.014273220257752e+00 -6.051694068852829e+00 -5.994518263903659e+00 3.413947939148512e+00 4.742260259093865e+00 9.200237079150498e+03 + 25620 1.008708228610282e+00 -6.005340897341257e+00 -6.045009324706399e+00 3.636276997662487e+00 4.408494749062543e+00 9.355751794833244e+03 + 25640 1.018662370118818e+00 -5.983554614877721e+00 -6.004440386919961e+00 3.804421731131100e+00 4.684492396001783e+00 9.230697439596504e+03 + 25660 1.027197781299544e+00 -5.960522366980814e+00 -6.026859053469870e+00 3.888820138420245e+00 4.507904619031024e+00 9.299674847866734e+03 + 25680 1.104133205010506e+00 -6.045668433715699e+00 -6.041320901633043e+00 3.415555954405400e+00 4.440520156402426e+00 9.344334316908558e+03 + 25700 1.090224811973544e+00 -6.009396516975108e+00 -6.003081711009367e+00 3.633925261515931e+00 4.670185854584278e+00 9.226533851928749e+03 + 25720 1.036185828154176e+00 -5.923442553373091e+00 -5.998021747841191e+00 4.137325667084580e+00 4.709080391355704e+00 9.210972191410034e+03 + 25740 1.084627744218413e+00 -5.994343160255793e+00 -5.996659705533876e+00 3.713535901392562e+00 4.700233939921588e+00 9.206777956896403e+03 + 25760 9.925623953759372e-01 -5.860837407814413e+00 -6.043942728851949e+00 4.509425110772726e+00 4.458006021918340e+00 9.352414521089293e+03 + 25780 1.053914009996417e+00 -5.958559267074294e+00 -6.074024666069338e+00 3.837088192767696e+00 4.174068003525407e+00 9.445693552512668e+03 + 25800 1.131548566653586e+00 -6.085681337165779e+00 -5.982706154246033e+00 3.258775995012757e+00 4.850075430695991e+00 9.164042445711953e+03 + 25820 1.010355438687462e+00 -5.919969127048371e+00 -6.010793374405725e+00 4.156713598177535e+00 4.635186714844756e+00 9.250209002666148e+03 + 25840 9.912868733789852e-01 -5.906856196266823e+00 -6.020439442079985e+00 4.237211261145743e+00 4.584998686736082e+00 9.279866729984094e+03 + 25860 1.008905781413956e+00 -5.945777763237190e+00 -6.000395650166884e+00 4.005506804557444e+00 4.691882445716459e+00 9.218237301730076e+03 + 25880 1.076253801739938e+00 -6.059222573028830e+00 -5.962509789937499e+00 3.351492923143545e+00 4.906832689908777e+00 9.102314132595555e+03 + 25900 1.058152693960372e+00 -6.047086255023916e+00 -5.949847612000378e+00 3.440422248731696e+00 4.998781584604228e+00 9.063721294347557e+03 + 25920 9.862616305097897e-01 -5.954709864711935e+00 -5.972413194525735e+00 3.941840190566885e+00 4.840184931194613e+00 9.132558267418955e+03 + 25940 1.038805639368242e+00 -6.046513711427526e+00 -5.966394527348346e+00 3.448865709698259e+00 4.908922463084582e+00 9.114166865982550e+03 + 25960 9.832850884751654e-01 -5.978130315068257e+00 -6.013147165800047e+00 3.780807910385833e+00 4.579735734643756e+00 9.257449366518318e+03 + 25980 9.529777577008581e-01 -5.949527511935555e+00 -5.984556057026845e+00 3.966259058835861e+00 4.765119732271837e+00 9.169692352215947e+03 + 26000 9.940838498176053e-01 -6.023905481402221e+00 -5.968436639904443e+00 3.563512669807055e+00 4.882023341462781e+00 9.120394477755679e+03 + 26020 9.346943118141999e-01 -5.946881519488707e+00 -5.997318112615389e+00 3.956698612876353e+00 4.667083890105386e+00 9.208817694018948e+03 + 26040 9.953492104066727e-01 -6.045465043683992e+00 -5.994412654910384e+00 3.421947751549713e+00 4.715098468219399e+00 9.199902111006817e+03 + 26060 1.006810543707758e+00 -6.070991020569164e+00 -5.969621931624417e+00 3.321729263379867e+00 4.903806258916420e+00 9.124044714713305e+03 + 26080 9.747605910057292e-01 -6.030769277227451e+00 -6.005311641125301e+00 3.519136071288097e+00 4.665317757343095e+00 9.233371749064550e+03 + 26100 1.007824228777871e+00 -6.086755838345994e+00 -5.990459990571938e+00 3.241691581448944e+00 4.794637241101855e+00 9.187801265283655e+03 + 26120 9.721011045548780e-01 -6.040685805381742e+00 -5.987789476817904e+00 3.466323186172942e+00 4.770062090466888e+00 9.179607268976166e+03 + 26140 9.499053811749903e-01 -6.013886508492658e+00 -6.006199647191895e+00 3.677070606688133e+00 4.721209753815053e+00 9.236073429269491e+03 + 26160 9.533018223744318e-01 -6.022752455370613e+00 -5.977535074427967e+00 3.605555253754752e+00 4.865200452494507e+00 9.148185676915593e+03 + 26180 9.844288071435597e-01 -6.068411886310296e+00 -5.965215882033615e+00 3.358340976603119e+00 4.950908402689877e+00 9.110550375536859e+03 + 26200 9.560000804546451e-01 -6.018897635296897e+00 -6.024854573748485e+00 3.586138200300101e+00 4.551932537877841e+00 9.293476251933096e+03 + 26220 9.879248052934423e-01 -6.054265350201657e+00 -5.988810511468910e+00 3.407949824262543e+00 4.783801637369535e+00 9.182730083339313e+03 + 26240 9.410623958247131e-01 -5.967216379472633e+00 -6.030007226135012e+00 3.841913974795511e+00 4.481359216408015e+00 9.309353433890046e+03 + 26260 9.807402886379231e-01 -6.002958067853997e+00 -6.010984149730601e+00 3.668298883665959e+00 4.622211879498341e+00 9.250796141753644e+03 + 26280 1.055032093646526e+00 -6.086161395561585e+00 -5.974021506283568e+00 3.234950098801332e+00 4.878874696627491e+00 9.137479286509497e+03 + 26300 9.405452954915010e-01 -5.887549264600992e+00 -6.036390864862978e+00 4.243481749693408e+00 4.388810247825885e+00 9.329071510852049e+03 + 26320 1.047255610799983e+00 -6.017421486011067e+00 -5.957480945173816e+00 3.618898549806329e+00 4.963086411062537e+00 9.086971282100165e+03 + 26340 9.605922143462470e-01 -5.859977586555987e+00 -6.011474247811536e+00 4.410162390942063e+00 4.540245117980136e+00 9.252287901526446e+03 + 26360 1.094255751266944e+00 -6.032589926433507e+00 -5.964380171251914e+00 3.540623099714306e+00 4.932294069392517e+00 9.108006112462790e+03 + 26380 1.018411854017626e+00 -5.898902101421170e+00 -6.016212023709368e+00 4.225503230528148e+00 4.551891503097513e+00 9.266878678228140e+03 + 26400 1.064043429189415e+00 -5.953903755946179e+00 -6.020886917164560e+00 3.900570264615699e+00 4.515942587289053e+00 9.281288999018956e+03 + 26420 1.054704788793459e+00 -5.933376001410140e+00 -6.038452767389989e+00 4.017213250877870e+00 4.413846200044595e+00 9.335455794255688e+03 + 26440 1.056388898317192e+00 -5.936642536177325e+00 -6.012946469605094e+00 4.037455608580672e+00 4.599306614842888e+00 9.256833638980735e+03 + 26460 1.029870314975667e+00 -5.903635507863286e+00 -6.009348616733649e+00 4.174881175582282e+00 4.567860145397932e+00 9.245729964210792e+03 + 26480 1.026846883653676e+00 -5.911109153432253e+00 -6.020401189827643e+00 4.174066565116027e+00 4.546494779245727e+00 9.279779813765732e+03 + 26500 1.019262135170913e+00 -5.921114043255461e+00 -6.014177577669528e+00 4.166713127516645e+00 4.632327911375662e+00 9.260638901084014e+03 + 26520 1.020729476326522e+00 -5.952879196511964e+00 -6.010498675866328e+00 3.965768019381913e+00 4.634908052343541e+00 9.249277593614152e+03 + 26540 9.720434897874302e-01 -5.917249254843538e+00 -6.035885404546484e+00 4.119779349059971e+00 4.438552218580827e+00 9.327517148553319e+03 + 26560 1.061416521289598e+00 -6.091620491762859e+00 -6.002444970212493e+00 3.201271438153555e+00 4.713331082763115e+00 9.224564540491992e+03 + 26580 1.001773453080956e+00 -6.045907589418753e+00 -5.985023412644757e+00 3.495626974358911e+00 4.845233339191104e+00 9.171132721832068e+03 + 26600 9.210643810253827e-01 -5.961817837708081e+00 -6.029846623365211e+00 3.890385597769983e+00 4.499753783106184e+00 9.308900087750608e+03 + 26620 9.568098092348561e-01 -6.039598264497504e+00 -5.993917278740419e+00 3.477393578769624e+00 4.739700868096502e+00 9.198391832249505e+03 + 26640 9.579175026138667e-01 -6.054467121467203e+00 -5.968772665679406e+00 3.473071985132243e+00 4.965142811439950e+00 9.121444654457804e+03 + 26660 9.900325563975334e-01 -6.107215419962095e+00 -5.958737181423349e+00 3.170679181129139e+00 5.023264203751777e+00 9.090827088500182e+03 + 26680 9.567096199955172e-01 -6.057099534402689e+00 -5.989025826427775e+00 3.392339039355661e+00 4.783228804919883e+00 9.183394495238457e+03 + 26700 9.409824791183173e-01 -6.028613103033564e+00 -6.006994573845368e+00 3.544053388565389e+00 4.668190328620585e+00 9.238524144300141e+03 + 26720 9.333844678869592e-01 -6.009220470437168e+00 -6.026972123339775e+00 3.641995727434851e+00 4.540062989408677e+00 9.300021142122054e+03 + 26740 9.794263135651858e-01 -6.065302644005799e+00 -6.002149804216389e+00 3.432040035182732e+00 4.794673414123901e+00 9.223647032199686e+03 + 26760 9.418059437911422e-01 -5.995913882233298e+00 -6.006751426349085e+00 3.740738057085439e+00 4.678507201668058e+00 9.237777776837143e+03 + 26780 9.301392916961533e-01 -5.963599287663057e+00 -6.033245014048774e+00 3.876236031630848e+00 4.476319493082737e+00 9.319393143485468e+03 + 26800 1.034828919322403e+00 -6.101831421569607e+00 -6.029981313825543e+00 3.156379016780641e+00 4.568953454215296e+00 9.309338118694077e+03 + 26820 1.015266683393898e+00 -6.058518528531983e+00 -5.979358651417229e+00 3.407657546459094e+00 4.862205810803404e+00 9.153809223316070e+03 + 26840 9.532064198943914e-01 -5.952668950452562e+00 -6.006558377364348e+00 3.965091509861067e+00 4.655650081171729e+00 9.237188721357286e+03 + 26860 1.013702220098276e+00 -6.027479427828938e+00 -5.992968996919442e+00 3.496983105361957e+00 4.695147340116203e+00 9.195483770860892e+03 + 26880 9.290626221138844e-01 -5.884873382566338e+00 -6.018319081298090e+00 4.299408655315244e+00 4.533142802542383e+00 9.273354482147346e+03 + 26900 1.032983451373186e+00 -6.023130516950366e+00 -5.972632699557215e+00 3.589824447485921e+00 4.879790729469380e+00 9.133213188963689e+03 + 26920 9.992412378169185e-01 -5.956275043206094e+00 -5.990370085850206e+00 3.950792586262423e+00 4.755013575209137e+00 9.187444906138882e+03 + 26940 1.056690665278629e+00 -6.027005001692126e+00 -5.952811221231368e+00 3.632390731905471e+00 5.058422900761569e+00 9.072729180083998e+03 + 26960 1.006462695689157e+00 -5.938172291971407e+00 -5.955790066309103e+00 4.003628055540743e+00 4.902464068951922e+00 9.081797464896152e+03 + 26980 1.016119371309259e+00 -5.937209281419866e+00 -5.960974645672403e+00 4.044019378472751e+00 4.907554979256455e+00 9.097614698164720e+03 + 27000 1.078956807243606e+00 -6.013670306220698e+00 -6.021232495466674e+00 3.645757109613328e+00 4.602333848717928e+00 9.282348409224305e+03 + 27020 1.021524655950530e+00 -5.916272259984026e+00 -6.032874518435022e+00 4.179009182424974e+00 4.509460970258178e+00 9.318233015324604e+03 + 27040 1.136750979651484e+00 -6.077116761346083e+00 -5.943915802910732e+00 3.280256441232214e+00 5.045116957349698e+00 9.045678571776074e+03 + 27060 1.042640771289591e+00 -5.926594296889591e+00 -6.024813513201654e+00 4.035042034646434e+00 4.471052095207971e+00 9.293367332844851e+03 + 27080 1.059798401420964e+00 -5.940828548702703e+00 -6.018764961161267e+00 4.053968237137504e+00 4.606445296179577e+00 9.274724545653882e+03 + 27100 1.091130926873672e+00 -5.978430086257071e+00 -5.975096966330393e+00 3.859033093041253e+00 4.878172383458881e+00 9.140764425856503e+03 + 27120 1.046874413218975e+00 -5.910747427188234e+00 -6.024257935981265e+00 4.191096515100937e+00 4.539301607916884e+00 9.291651593192973e+03 + 27140 1.096208906914375e+00 -5.990033159672841e+00 -5.979721959431418e+00 3.715496747453263e+00 4.774705254892593e+00 9.154895336608350e+03 + 27160 1.025434738705987e+00 -5.898165213419515e+00 -6.043339071313996e+00 4.205117382520929e+00 4.371506624908911e+00 9.350538477643948e+03 + 27180 1.032899609364002e+00 -5.928788961747625e+00 -5.965546765842568e+00 4.108670521454401e+00 4.897601522089441e+00 9.111564709721579e+03 + 27200 1.075882170686844e+00 -6.016819321213504e+00 -5.958712846743836e+00 3.573560472372067e+00 4.907216840724763e+00 9.090744325665246e+03 + 27220 1.090745834549236e+00 -6.068777439522943e+00 -5.961110955102235e+00 3.350795946154748e+00 4.969033561033074e+00 9.098058157368288e+03 + 27240 1.007682295856299e+00 -5.979342780691049e+00 -6.016402678071232e+00 3.783358008422188e+00 4.570554342664590e+00 9.267474526280834e+03 + 27260 1.034115084162430e+00 -6.053245480295663e+00 -6.004651803390438e+00 3.366819727703744e+00 4.645852140340747e+00 9.231315322132183e+03 + 27280 9.949298813491422e-01 -6.027184359818352e+00 -6.004542981967770e+00 3.541067226510891e+00 4.671077521870830e+00 9.230972050054139e+03 + 27300 9.647303636515141e-01 -6.010044448618398e+00 -5.982497236662692e+00 3.656927320349185e+00 4.815107674316126e+00 9.163368383544241e+03 + 27320 1.018194239105845e+00 -6.110421073358152e+00 -5.939331698395755e+00 3.090239826226949e+00 5.072661493256246e+00 9.031723417424355e+03 + 27340 9.769340132131886e-01 -6.065077228504077e+00 -5.943150064182475e+00 3.359495483447407e+00 5.059620129149744e+00 9.043356346856552e+03 + 27360 9.101649169660315e-01 -5.975544313230104e+00 -5.991987650495955e+00 3.813227054772816e+00 4.718806867594084e+00 9.192459330407661e+03 + 27380 9.265608415544417e-01 -6.002644184346522e+00 -6.001970263579063e+00 3.679739091868751e+00 4.683608849204408e+00 9.223083536784095e+03 + 27400 9.508472447264311e-01 -6.035438809955840e+00 -5.993530298758067e+00 3.513541935069528e+00 4.754187091688292e+00 9.197182292430251e+03 + 27420 1.049089474697299e+00 -6.171894109036053e+00 -5.985881412450361e+00 2.788261175075025e+00 4.856374864241834e+00 9.173778558307229e+03 + 27440 1.006848593492841e+00 -6.098527895899158e+00 -6.008844913711014e+00 3.167343431827824e+00 4.682316993948790e+00 9.244234216243007e+03 + 27460 9.678996532164935e-01 -6.028256842249204e+00 -6.011675586216039e+00 3.581159082559920e+00 4.676371220643436e+00 9.252938287004517e+03 + 27480 1.000501655310759e+00 -6.057500506817994e+00 -5.995716894896110e+00 3.345482290669906e+00 4.700253351308410e+00 9.203936625420773e+03 + 27500 9.704656490998697e-01 -5.989379920752549e+00 -5.980601605507433e+00 3.785701736859338e+00 4.836108181436690e+00 9.157591751382963e+03 + 27520 9.202173088190145e-01 -5.886863810967327e+00 -6.022910157549195e+00 4.270984543860078e+00 4.489785368682905e+00 9.287465205504499e+03 + 27540 1.094703585249402e+00 -6.108906542850082e+00 -5.937699988030598e+00 3.196703628613672e+00 5.179798160515881e+00 9.026775252899077e+03 + 27560 1.024599080126616e+00 -5.966334585280480e+00 -6.015126090125728e+00 3.793448764514199e+00 4.513280393231815e+00 9.263546971963044e+03 + 27580 1.016288005942892e+00 -5.918296204095491e+00 -6.037359113714773e+00 4.081789202929937e+00 4.398111550970299e+00 9.332088470114750e+03 + 27600 1.038945601229166e+00 -5.925718942124202e+00 -6.037415429926929e+00 4.054829693667650e+00 4.413451175728768e+00 9.332279338812185e+03 + 27620 1.036237700438675e+00 -5.906775581428764e+00 -5.995688792099817e+00 4.172532092754212e+00 4.661978677806146e+00 9.203810133262979e+03 + 27640 9.933775620127856e-01 -5.836510959828939e+00 -6.014890930966772e+00 4.498858312999909e+00 4.474572914515144e+00 9.262784408457417e+03 + 27660 1.032957917178952e+00 -5.890780333335727e+00 -5.977009497048684e+00 4.265818517823478e+00 4.770677315863726e+00 9.146563868341582e+03 + 27680 9.987872694502733e-01 -5.839720141150880e+00 -6.009752587872207e+00 4.493934986677420e+00 4.517582365167475e+00 9.246982365017777e+03 + 27700 1.108703874684024e+00 -6.006509121151729e+00 -5.987817596614515e+00 3.677572219859795e+00 4.784901846256552e+00 9.179674489207022e+03 + 27720 1.054796980348682e+00 -5.937846202312077e+00 -6.012214050100617e+00 4.007257657019357e+00 4.580225966630311e+00 9.254571517946257e+03 + 27740 1.088228669946797e+00 -6.003889091428633e+00 -5.995510761084083e+00 3.642894690792948e+00 4.691004360173782e+00 9.203272267296128e+03 + 27760 9.749052351385830e-01 -5.854702375683103e+00 -6.029669913903491e+00 4.458117498328424e+00 4.453426817727926e+00 9.308295071105771e+03 + 27780 1.039267036448282e+00 -5.967584616355351e+00 -5.998682059652458e+00 3.849660007969069e+00 4.671093676243287e+00 9.212993902722479e+03 + 27800 1.023508585456083e+00 -5.958871068704244e+00 -5.999442445825661e+00 3.925028811285237e+00 4.692061685453743e+00 9.215332650347738e+03 + 27820 1.021661469920530e+00 -5.969226724579544e+00 -5.994700274573052e+00 3.899781938596666e+00 4.753508872514822e+00 9.200770827701253e+03 + 27840 1.025252086007113e+00 -5.985532257963772e+00 -6.003194964417547e+00 3.780772736869397e+00 4.679350743116833e+00 9.226842726776855e+03 + 27860 1.042090278165483e+00 -6.020647232121075e+00 -5.973937779937510e+00 3.617790796587610e+00 4.886003699290009e+00 9.137196664714582e+03 + 27880 9.931823823051343e-01 -5.956466159874375e+00 -6.007448153248207e+00 3.953105267200670e+00 4.660358771810150e+00 9.239925793276783e+03 + 27900 1.085898353727896e+00 -6.100522201888604e+00 -5.968994484358133e+00 3.163161449131986e+00 4.918413957040462e+00 9.122126417483107e+03 + 27920 9.650040066371505e-01 -5.929789623144175e+00 -5.998210823590538e+00 4.075649515524924e+00 4.682764394415355e+00 9.211530158186750e+03 + 27940 1.016290546257501e+00 -6.012131965288077e+00 -5.967465120439428e+00 3.668090921851813e+00 4.924574857144655e+00 9.117403660996721e+03 + 27960 1.032461559633738e+00 -6.041118845987069e+00 -5.960827962001916e+00 3.530873950883116e+00 4.991916631700004e+00 9.097171205599219e+03 + 27980 9.751376003279202e-01 -5.961546109832475e+00 -6.027330285380660e+00 3.882804407138010e+00 4.505061491072066e+00 9.301128856426021e+03 + 28000 1.005319751826434e+00 -6.012615074395310e+00 -5.997103030001085e+00 3.614713674409434e+00 4.703786233802187e+00 9.208137741715600e+03 + 28020 1.003570241906397e+00 -6.015359695451327e+00 -5.963739519140836e+00 3.598324579434817e+00 4.894735620006127e+00 9.106061272169825e+03 + 28040 9.755883553175906e-01 -5.977843077002850e+00 -6.003698358655894e+00 3.803645881902229e+00 4.655180853558543e+00 9.228388869164250e+03 + 28060 9.920352413174970e-01 -6.006189140134730e+00 -5.968978551785961e+00 3.675446004349865e+00 4.889114960968438e+00 9.122051604236796e+03 + 28080 9.825887906903008e-01 -5.993226577908968e+00 -6.020422747114497e+00 3.719313287908264e+00 4.563148675736530e+00 9.279863519768114e+03 + 28100 1.012233378619919e+00 -6.040052320429769e+00 -6.054028225288405e+00 3.455585231814737e+00 4.375333423352165e+00 9.383657258283878e+03 + 28120 9.409839227245846e-01 -5.938211067674108e+00 -6.038018945553459e+00 4.046482071170700e+00 4.473369791168280e+00 9.334141649195686e+03 + 28140 1.043010694245405e+00 -6.095773820978430e+00 -6.002650633502081e+00 3.174968247859983e+00 4.709696001115866e+00 9.225213685968161e+03 + 28160 9.640102994563712e-01 -5.987999390170565e+00 -6.035279684223952e+00 3.732305464567713e+00 4.460814699511307e+00 9.325673993947919e+03 + 28180 1.034126535635780e+00 -6.103779112126466e+00 -5.943177233018829e+00 3.163052748892641e+00 5.085253591789160e+00 9.043446922350260e+03 + 28200 9.698878567476057e-01 -6.019956599256201e+00 -5.998547590553052e+00 3.569721340310033e+00 4.692655181316900e+00 9.212597198909447e+03 + 28220 9.520936037128325e-01 -6.003832161486097e+00 -5.995024023569829e+00 3.709698279680612e+00 4.760275970650765e+00 9.201772831580201e+03 + 28240 9.550291638396985e-01 -6.017331496855164e+00 -6.004725573827228e+00 3.610487031048012e+00 4.682872191834702e+00 9.231575064025357e+03 + 28260 9.573368251479983e-01 -6.028759157254113e+00 -5.965609037124850e+00 3.559546106378174e+00 4.922163868609914e+00 9.111764904743941e+03 + 28280 9.429409403696467e-01 -6.013065711746425e+00 -5.949322714980654e+00 3.695355771850104e+00 5.061377923476030e+00 9.062101872838175e+03 + 28300 9.452608184678790e-01 -6.015205506454981e+00 -5.967306523130855e+00 3.597338823943299e+00 4.872382198534142e+00 9.116938990005290e+03 + 28320 9.368831965733057e-01 -5.993468050653759e+00 -6.001947868638773e+00 3.758882804160002e+00 4.710190377042460e+00 9.223017623566486e+03 + 28340 9.491419025141812e-01 -5.996110676103718e+00 -6.002436840856872e+00 3.707418714857039e+00 4.671092897873596e+00 9.224559562586730e+03 + 28360 9.978159558674639e-01 -6.046390539873354e+00 -6.001781934705503e+00 3.420766712182409e+00 4.676916226215551e+00 9.222535699091812e+03 + 28380 1.052581699255401e+00 -6.102424542186387e+00 -5.996949504401195e+00 3.138883165123370e+00 4.744537154295287e+00 9.207695186281686e+03 + 28400 9.901255561788616e-01 -5.984214164607419e+00 -5.991502116373704e+00 3.842419588434125e+00 4.800571041585229e+00 9.190987455741377e+03 + 28420 9.978752719125502e-01 -5.968718255430496e+00 -6.006701505514476e+00 3.821384877689754e+00 4.603279177818589e+00 9.237645759368186e+03 + 28440 1.052832190331810e+00 -6.021744949713979e+00 -5.985142108600930e+00 3.582153189453640e+00 4.792332367396122e+00 9.171486335905454e+03 + 28460 1.014923780566742e+00 -5.938810326893853e+00 -6.018258941217416e+00 4.033022292330498e+00 4.576816054251262e+00 9.273194692226858e+03 + 28480 1.088340117178027e+00 -6.025579463518811e+00 -6.013417735205302e+00 3.567938313297644e+00 4.637772839295186e+00 9.258270004359718e+03 + 28500 1.013094475705368e+00 -5.900448145166157e+00 -6.014041098641869e+00 4.229257815846879e+00 4.576989498536606e+00 9.260191060087271e+03 + 28520 1.007623870912483e+00 -5.883321381281474e+00 -6.009940768529432e+00 4.299941570777655e+00 4.572873454913028e+00 9.247543897518279e+03 + 28540 1.003612564236609e+00 -5.869785259587345e+00 -6.025602498193580e+00 4.326633052997561e+00 4.431906356280814e+00 9.295797635616627e+03 + 28560 1.014767524960878e+00 -5.882579893146128e+00 -6.038810706025442e+00 4.329630671478879e+00 4.432529167285694e+00 9.336569620904609e+03 + 28580 1.052113858740745e+00 -5.942695346825536e+00 -6.050623174710733e+00 3.991629073541671e+00 4.371890784047481e+00 9.373085055295822e+03 + 28600 1.087088445074823e+00 -6.008649143909981e+00 -5.995132043246144e+00 3.693203661658844e+00 4.770820945435164e+00 9.202097352301791e+03 + 28620 9.736304811708715e-01 -5.863697146715683e+00 -6.005049795662690e+00 4.445158420551911e+00 4.633489636046467e+00 9.232549864821387e+03 + 28640 1.027540968316297e+00 -5.980257745038665e+00 -6.026345297332439e+00 3.754112431509946e+00 4.489470574213432e+00 9.298103391154977e+03 + 28660 9.515304434448906e-01 -5.916708694705935e+00 -6.050075170992013e+00 4.051120794525225e+00 4.285309849295060e+00 9.371400618970183e+03 + 28680 9.779906657005709e-01 -6.008598282403232e+00 -6.024669868218375e+00 3.627216860784659e+00 4.534931327964244e+00 9.292946135902224e+03 + 28700 1.003736244790102e+00 -6.097267775338383e+00 -5.968121216652726e+00 3.195649300450119e+00 4.937228825788532e+00 9.119473398849879e+03 + 28720 9.442625855946347e-01 -6.041835538140989e+00 -5.977170492226622e+00 3.497452610467303e+00 4.868769310991110e+00 9.147122045588860e+03 + 28740 1.015082221146194e+00 -6.163957545319789e+00 -5.993746367494998e+00 2.845622818281639e+00 4.823001741446235e+00 9.197879630050962e+03 + 28760 9.104563098689363e-01 -6.018176239315316e+00 -5.993001290902773e+00 3.662826782378291e+00 4.807385231973795e+00 9.195560842005887e+03 + 28780 9.122648914929119e-01 -6.021339052461146e+00 -6.019252079121465e+00 3.587519538940595e+00 4.599503262815123e+00 9.276248418813222e+03 + 28800 1.003372044495901e+00 -6.151577808476957e+00 -5.983498703909965e+00 2.891933278384125e+00 4.857069506965166e+00 9.166476875633647e+03 + 28820 9.429574513384952e-01 -6.053670728286849e+00 -5.956768508973053e+00 3.411288723919823e+00 4.967716262789613e+00 9.084812315389205e+03 + 28840 9.480859221182297e-01 -6.047522096996349e+00 -5.941228819754128e+00 3.465253518931908e+00 5.075605965688231e+00 9.037501196425725e+03 + 28860 9.472116155482816e-01 -6.025512454457528e+00 -5.969639562541344e+00 3.601183143968295e+00 4.922013935653110e+00 9.124070582127155e+03 + 28880 9.671014616215816e-01 -6.030693133646931e+00 -5.974570564484338e+00 3.513662832011605e+00 4.835927309082723e+00 9.139152066444691e+03 + 28900 9.770588402967516e-01 -6.018377805957166e+00 -5.990375336739723e+00 3.621807749149450e+00 4.782602260764114e+00 9.187515994790996e+03 + 28920 1.035616370661924e+00 -6.078490496909573e+00 -5.988415834871935e+00 3.314300911714150e+00 4.831523560143171e+00 9.181526541961126e+03 + 28940 9.491971774355233e-01 -5.926178500753046e+00 -6.025293659801177e+00 4.120891359949992e+00 4.551756778674332e+00 9.294866949345924e+03 + 28960 1.033935039014248e+00 -6.030280063405661e+00 -6.019302133053879e+00 3.557387999015804e+00 4.620424973924969e+00 9.276418957034575e+03 + 28980 1.012469200161009e+00 -5.980678987188339e+00 -6.052467649255548e+00 3.789740507983740e+00 4.377518901134275e+00 9.378840645589566e+03 + 29000 1.039229273147462e+00 -6.009985378535291e+00 -6.030622913009718e+00 3.667521219237972e+00 4.549017302637679e+00 9.311304780431741e+03 + 29020 9.940428342105773e-01 -5.936367897972060e+00 -6.038752538767909e+00 4.011677966831653e+00 4.423769515409929e+00 9.336398118557219e+03 + 29040 1.039154057154783e+00 -6.000566193658575e+00 -5.996516036746157e+00 3.674201572893957e+00 4.697458200644817e+00 9.206362897862971e+03 + 29060 1.003710369183082e+00 -5.948421168557061e+00 -5.977492471042664e+00 3.965260509286568e+00 4.798328591644715e+00 9.148093363825397e+03 + 29080 9.916429014819774e-01 -5.930349056897279e+00 -6.002040980132275e+00 4.067126491995129e+00 4.655460374490523e+00 9.223300273872988e+03 + 29100 9.799211090333384e-01 -5.913472626627630e+00 -6.024999847938425e+00 4.139255345260670e+00 4.498848781712367e+00 9.293963480786231e+03 + 29120 1.026025723674986e+00 -5.985171742370088e+00 -6.026124832567447e+00 3.756427594080039e+00 4.521268612696575e+00 9.297440914169099e+03 + 29140 1.022219624055486e+00 -5.987621609881398e+00 -5.974722985169983e+00 3.792505200402652e+00 4.866571099551321e+00 9.139628555360920e+03 + 29160 1.052387705248464e+00 -6.042422308623889e+00 -6.004384567987289e+00 3.465206646212253e+00 4.683625239268952e+00 9.230518478773460e+03 + 29180 1.016427767906759e+00 -6.002295393820535e+00 -6.018250867888380e+00 3.663576739582612e+00 4.571957938383419e+00 9.273165464046380e+03 + 29200 1.000476376337306e+00 -5.999622911537353e+00 -6.033179180940850e+00 3.702164097074232e+00 4.509478805343444e+00 9.319185750107512e+03 + 29220 9.839503613690523e-01 -6.007935016486848e+00 -5.997549321622817e+00 3.739459206351355e+00 4.799095473441714e+00 9.209525374872695e+03 + 29240 1.004007021076176e+00 -6.083469977951813e+00 -5.983975370243266e+00 3.273217755780128e+00 4.844531189983382e+00 9.167933346910781e+03 + 29260 9.091551367261101e-01 -5.999881931511410e+00 -6.006019570465801e+00 3.699025932701849e+00 4.663782660029183e+00 9.235538866713792e+03 + 29280 9.594079972001835e-01 -6.124413350585823e+00 -5.963092229158951e+00 3.071860313595195e+00 4.998191157191153e+00 9.104115353094019e+03 + 29300 9.595321996780790e-01 -6.160997752978748e+00 -5.977258875805189e+00 2.885638481247295e+00 4.940695547477222e+00 9.147374547002168e+03 + 29320 9.302480648443420e-01 -6.138927453540776e+00 -5.965019401375105e+00 2.939619249110190e+00 4.938226196829575e+00 9.109992071116918e+03 + 29340 9.289291493535927e-01 -6.143307946040633e+00 -5.975228464738281e+00 2.932036847680652e+00 4.897175239534430e+00 9.141176914673510e+03 + 29360 9.291833826444947e-01 -6.140747600119308e+00 -5.981031145357315e+00 2.937839785186445e+00 4.854956384471304e+00 9.158925549106540e+03 + 29380 9.292966845038206e-01 -6.129710721956912e+00 -5.991007081969789e+00 3.004652658723091e+00 4.801110423848072e+00 9.189460163332262e+03 + 29400 9.768173862043977e-01 -6.182643942610514e+00 -5.929774188258957e+00 2.777555306365860e+00 5.229572567320520e+00 9.002724688096831e+03 + 29420 9.194485869094577e-01 -6.074182938895403e+00 -5.946473230707915e+00 3.308709926347311e+00 5.042038833773335e+00 9.053443401710787e+03 + 29440 9.264850276097462e-01 -6.055825046403605e+00 -5.941783616905163e+00 3.408231931059003e+00 5.063075467093233e+00 9.039204448829045e+03 + 29460 9.647846537354453e-01 -6.080617386000093e+00 -5.989661164711574e+00 3.213144058912824e+00 4.735428756981255e+00 9.185321819303432e+03 + 29480 9.316116939198328e-01 -6.001616588168545e+00 -5.960497492898179e+00 3.720874666307239e+00 4.956986874509109e+00 9.096173476795615e+03 + 29500 9.615749834331291e-01 -6.018655833144447e+00 -5.940178992719386e+00 3.608717219662444e+00 5.059343381634948e+00 9.034296283672522e+03 + 29520 1.010567055003395e+00 -6.066031693919716e+00 -5.970989781186073e+00 3.310648035344226e+00 4.856393405949268e+00 9.128206496703693e+03 + 29540 1.007382809001170e+00 -6.039154168295874e+00 -6.013664780075091e+00 3.472336259273290e+00 4.618700270907108e+00 9.259029673879510e+03 + 29560 1.029653614398049e+00 -6.055431884247001e+00 -5.995128727169735e+00 3.420710960322135e+00 4.766981020143195e+00 9.202120096900653e+03 + 29580 9.930004286526326e-01 -5.986907872560453e+00 -6.045605271411086e+00 3.787684939320902e+00 4.450635391727450e+00 9.357574192207718e+03 + 29600 9.601848837335871e-01 -5.927198760472017e+00 -6.035449343063726e+00 4.083981941866107e+00 4.462390344900997e+00 9.326149032990899e+03 + 29620 1.028921410121415e+00 -6.020083270322323e+00 -5.960637121908235e+00 3.594893114764522e+00 4.936242098219954e+00 9.096598395920297e+03 + 29640 9.841158721318056e-01 -5.943791295950724e+00 -6.004245407055859e+00 4.002896918360663e+00 4.655760057151515e+00 9.230080533840544e+03 + 29660 1.040529024557767e+00 -6.018991177640114e+00 -5.990938924275782e+00 3.584675194279003e+00 4.745755574169175e+00 9.189251060640077e+03 + 29680 1.038583733314649e+00 -6.009800524800676e+00 -5.962895641199461e+00 3.642110804696944e+00 4.911445904842397e+00 9.103504333564508e+03 + 29700 9.727129859576313e-01 -5.906887569735638e+00 -6.006539418065318e+00 4.180807926024784e+00 4.608591591842066e+00 9.237124360749694e+03 + 29720 1.088064610240070e+00 -6.073040020877345e+00 -6.000834298323051e+00 3.285984685649953e+00 4.700601118356166e+00 9.219621751457958e+03 + 29740 1.010753860320679e+00 -5.956520647393255e+00 -6.004830000887360e+00 3.922161765679869e+00 4.644761982068429e+00 9.231871619370186e+03 + 29760 9.556620787961384e-01 -5.874179373804996e+00 -6.007186984604858e+00 4.397248285179978e+00 4.633498001105917e+00 9.239101860985860e+03 + 29780 1.064893928215669e+00 -6.037516055685689e+00 -5.977574562494152e+00 3.471566160222460e+00 4.815759490044357e+00 9.148347744654138e+03 + 29800 1.082429378625356e+00 -6.067558490301071e+00 -6.023632791115030e+00 3.319761289116024e+00 4.571989451322251e+00 9.289741451423108e+03 + 29820 1.015099993145585e+00 -5.979693098377298e+00 -6.057916147197689e+00 3.759481119899784e+00 4.310312268595412e+00 9.395696908233151e+03 + 29840 1.033230709094984e+00 -6.027653144067885e+00 -5.977255445900206e+00 3.583200813749030e+00 4.872592195646428e+00 9.147363206260507e+03 + 29860 9.865277944317782e-01 -5.984689891165687e+00 -6.010150006367759e+00 3.797226019476292e+00 4.651030098045900e+00 9.248236181027289e+03 + 29880 9.781873267525094e-01 -6.005385203595621e+00 -6.027470244401562e+00 3.642690325763378e+00 4.515874603806644e+00 9.301565755019396e+03 + 29900 9.990547361673093e-01 -6.072773144892266e+00 -5.997251919760524e+00 3.301378806525804e+00 4.735033368104082e+00 9.208621688394602e+03 + 29920 9.635061326460844e-01 -6.054333202066925e+00 -6.011267843939825e+00 3.377141310922637e+00 4.624429261631073e+00 9.251682558346976e+03 + 29940 9.350153255330449e-01 -6.042698237497649e+00 -5.998232213136991e+00 3.462791738776661e+00 4.718122531750589e+00 9.211628300733253e+03 + 29960 9.382875725274081e-01 -6.070009473268530e+00 -5.992275994244865e+00 3.321321961195985e+00 4.767679626966870e+00 9.193354664819073e+03 + 29980 9.422557706053847e-01 -6.089361594900179e+00 -5.983229993374704e+00 3.210352374215130e+00 4.819776453986664e+00 9.165661848050731e+03 + 30000 1.022391449429286e+00 -6.214075592005614e+00 -5.954910684987923e+00 2.578972732632215e+00 5.067137734367540e+00 9.079177299533281e+03 + 30020 9.238490186906688e-01 -6.067887427603596e+00 -5.986449747586651e+00 3.365997450092951e+00 4.833625211190504e+00 9.175508257690031e+03 + 30040 9.472912610344750e-01 -6.094243684930203e+00 -5.987174620928259e+00 3.216806862439307e+00 4.831613996822572e+00 9.177735838955829e+03 + 30060 9.689703031633105e-01 -6.111575405333681e+00 -5.968750744326022e+00 3.086793435502849e+00 4.906914741053685e+00 9.121382794874358e+03 + 30080 8.995618470596503e-01 -5.986042904348183e+00 -6.004493360783048e+00 3.812497793020399e+00 4.706552416972499e+00 9.230850850522918e+03 + 30100 9.766439126441808e-01 -6.069300661903761e+00 -5.974315039627736e+00 3.317780925405669e+00 4.863203067492143e+00 9.138370118482186e+03 + 30120 9.901172095771245e-01 -6.051670367913637e+00 -5.956112297045035e+00 3.404118220205249e+00 4.952827450696438e+00 9.082783619672038e+03 + 30140 1.022010846394023e+00 -6.057766403102042e+00 -5.944044484854148e+00 3.415819108832165e+00 5.068827961821542e+00 9.046050020217983e+03 + 30160 1.022671341714951e+00 -6.020729217691068e+00 -5.954490433411739e+00 3.648005557842121e+00 5.028358907592768e+00 9.077863759422518e+03 + 30180 1.018378799120894e+00 -5.986000673104643e+00 -6.017317845091376e+00 3.750503251185134e+00 4.570675203320612e+00 9.270273812343232e+03 + 30200 9.864145509336422e-01 -5.921933709753805e+00 -5.986850843745072e+00 4.145407239712068e+00 4.772643010440193e+00 9.176730372895401e+03 + 30220 1.001854322823047e+00 -5.933844907628597e+00 -6.002666504638748e+00 4.056391268617152e+00 4.661207008477147e+00 9.225229177299816e+03 + 30240 1.059076188454696e+00 -6.013297552912073e+00 -6.000089564068858e+00 3.612925379657900e+00 4.688767695525305e+00 9.217323705706765e+03 + 30260 1.052578449896820e+00 -6.003025696803585e+00 -6.014835032323607e+00 3.699992077857413e+00 4.632181045812684e+00 9.262646097555946e+03 + 30280 9.487884039497202e-01 -5.853904519685701e+00 -6.059965791825375e+00 4.427445339391960e+00 4.244209626887142e+00 9.402045857004236e+03 + 30300 1.029336234147462e+00 -5.979948628286467e+00 -6.020813318925252e+00 3.835592561059904e+00 4.600941183621561e+00 9.281011191349724e+03 + 30320 1.065690372222909e+00 -6.041704626731780e+00 -5.984313227761977e+00 3.466313289063323e+00 4.795863583238217e+00 9.168952372575235e+03 + 30340 1.032416374191723e+00 -6.000696153589132e+00 -5.976851852455646e+00 3.727073219598943e+00 4.863990886601091e+00 9.146132334900771e+03 + 30360 9.981943200735881e-01 -5.961650672648489e+00 -6.030074311057464e+00 3.927117858135076e+00 4.534218737866921e+00 9.309604582734561e+03 + 30380 9.888959284789413e-01 -5.962411666848608e+00 -6.037248040212175e+00 3.848885590596351e+00 4.419163553851398e+00 9.331760442885723e+03 + 30400 9.893577908986471e-01 -5.982004096747366e+00 -6.067566207457588e+00 3.731121882934517e+00 4.239811002542576e+00 9.425634488435704e+03 + 30420 1.023803102890519e+00 -6.054199729506687e+00 -5.986788106434324e+00 3.397842735832353e+00 4.784930707428814e+00 9.176539039142150e+03 + 30440 9.618260976643903e-01 -5.983228649776845e+00 -6.002764714051875e+00 3.842093690897518e+00 4.729914586634124e+00 9.225520088586947e+03 + 30460 9.652164611632372e-01 -6.008125604218619e+00 -6.002750416499278e+00 3.689739275287688e+00 4.720604434979757e+00 9.225489429091020e+03 + 30480 9.580226843545530e-01 -6.017255456648518e+00 -6.027629875818532e+00 3.571414832042392e+00 4.511843311731995e+00 9.302064622169515e+03 + 30500 9.943038114712486e-01 -6.090490150033225e+00 -5.966376619274175e+00 3.268965369961810e+00 4.981644470087083e+00 9.114130080097597e+03 + 30520 9.304874222095311e-01 -6.013824711378987e+00 -6.014790626497451e+00 3.579221875370232e+00 4.573675441285133e+00 9.262513991505772e+03 + 30540 9.783584372657665e-01 -6.100647668845115e+00 -5.990444678111096e+00 3.148273078964318e+00 4.781075705616751e+00 9.187739654603578e+03 + 30560 9.176177371097133e-01 -6.023710030989118e+00 -6.001774540832473e+00 3.550594279530800e+00 4.676551258516388e+00 9.222519046058780e+03 + 30580 8.778656169155760e-01 -5.976214210869851e+00 -6.002429324501506e+00 3.818421367783736e+00 4.667890128535052e+00 9.224522542062394e+03 + 30600 9.872162122335556e-01 -6.146267102188688e+00 -5.947138317975973e+00 2.990018529834972e+00 5.133446823864144e+00 9.055492486181309e+03 + 30620 9.318690978437534e-01 -6.065678041864406e+00 -5.980810435487806e+00 3.401601524023612e+00 4.888924453057692e+00 9.158238771435459e+03 + 30640 9.762464302644114e-01 -6.124762564948807e+00 -5.990673571493650e+00 3.078272206705188e+00 4.848231957329377e+00 9.188450216495972e+03 + 30660 9.526746118959963e-01 -6.075704926377758e+00 -5.993694503945165e+00 3.301615804147225e+00 4.772532340827027e+00 9.197705014930802e+03 + 30680 9.507119809359119e-01 -6.048179460137290e+00 -6.017000968781529e+00 3.453970419378655e+00 4.633002141599379e+00 9.269299552083950e+03 + 30700 9.752873055783660e-01 -6.051077545516756e+00 -6.002799563612088e+00 3.429251457192257e+00 4.706471100282418e+00 9.225638360935051e+03 + 30720 9.488750535890192e-01 -5.969895143580631e+00 -6.023343784428681e+00 3.878561537221091e+00 4.571651170321153e+00 9.288853101897590e+03 + 30740 1.030053142813441e+00 -6.047545336307401e+00 -6.012849410536223e+00 3.396575333698316e+00 4.595804708653581e+00 9.256560495884221e+03 + 30760 1.065508088103261e+00 -6.063088466597174e+00 -6.020473620991427e+00 3.388580386747530e+00 4.633281424841772e+00 9.280010405881187e+03 + 30780 1.025662986552197e+00 -5.976784246276273e+00 -6.034455046263975e+00 3.874813504510093e+00 4.543658846453255e+00 9.323111024558364e+03 + 30800 1.036392414434614e+00 -5.973020518739437e+00 -6.009214651418420e+00 3.850018535764266e+00 4.642186224897619e+00 9.245374583549519e+03 + 30820 1.109262716241106e+00 -6.066338968433568e+00 -6.002774361973263e+00 3.394903708073044e+00 4.759901514959179e+00 9.225551616357032e+03 + 30840 1.006318555309201e+00 -5.906725465884383e+00 -5.999150185469699e+00 4.219909990727194e+00 4.689192948189179e+00 9.214423920511816e+03 + 30860 9.868633211823782e-01 -5.874174890867751e+00 -5.999041150969393e+00 4.370866045434269e+00 4.653864656939341e+00 9.214083943549473e+03 + 30880 1.000837286275815e+00 -5.893315376548657e+00 -6.014113488093660e+00 4.254425930880663e+00 4.560784480941911e+00 9.260429901872551e+03 + 30900 1.050095759729751e+00 -5.970026701057205e+00 -5.973591716771170e+00 3.873171702791572e+00 4.852700830877584e+00 9.136128799380684e+03 + 30920 9.946703889043410e-01 -5.894667071620474e+00 -5.983252910475333e+00 4.355103801036861e+00 4.846430205718002e+00 9.165683298183008e+03 + 30940 1.045266271997797e+00 -5.978715013998176e+00 -6.004307928398388e+00 3.906512931213734e+00 4.759554456237015e+00 9.230281330819133e+03 + 30960 1.072975249847492e+00 -6.035261687772687e+00 -6.009549215421002e+00 3.534313013221960e+00 4.681958008457570e+00 9.246388037861461e+03 + 30980 1.028150911408279e+00 -5.991792902416377e+00 -5.964682442936535e+00 3.767956903397340e+00 4.923629357060635e+00 9.108945762788499e+03 + 31000 9.780792858873378e-01 -5.946930146284266e+00 -6.016483161340927e+00 3.940819686001421e+00 4.541435510251772e+00 9.267706398098047e+03 + 31020 9.747071814544598e-01 -5.975066107394660e+00 -5.993380992110841e+00 3.846419971878860e+00 4.741253069619304e+00 9.196734792240015e+03 + 31040 9.611223939463616e-01 -5.989449667834206e+00 -5.983910388873211e+00 3.757157498373922e+00 4.788964895368605e+00 9.167707324705199e+03 + 31060 9.746653768288451e-01 -6.042733143213880e+00 -5.957098753859750e+00 3.520778517597718e+00 5.012504433148058e+00 9.085821905216753e+03 + 31080 9.629410059637241e-01 -6.053500316147198e+00 -5.988083871777354e+00 3.415234642397118e+00 4.790865989130814e+00 9.180499437732762e+03 + 31100 9.271141112203976e-01 -6.023129546636375e+00 -6.021787410931914e+00 3.602113184336791e+00 4.609819935246636e+00 9.284034313310201e+03 + 31120 9.214205882075878e-01 -6.028808549588240e+00 -5.970123839607056e+00 3.544151692734612e+00 4.881128378876088e+00 9.125564414896737e+03 + 31140 9.173372047681599e-01 -6.028167080498715e+00 -5.937139158071414e+00 3.570041576851312e+00 5.092737993954344e+00 9.025064997360038e+03 + 31160 9.027283175335558e-01 -6.003422078394667e+00 -5.968943032078411e+00 3.730200041482977e+00 4.928184061046093e+00 9.121903976984209e+03 + 31180 9.206551675007310e-01 -6.019441222178425e+00 -5.991736326669456e+00 3.586156478703371e+00 4.745242276034595e+00 9.191689078966736e+03 + 31200 9.568823836717990e-01 -6.058508586790410e+00 -5.991603325108525e+00 3.374908917332005e+00 4.759089283465173e+00 9.191279499104474e+03 + 31220 1.026157313591186e+00 -6.143469050045558e+00 -5.964238213414087e+00 2.934634287348274e+00 4.963805487168508e+00 9.107596993353189e+03 + 31240 9.445418433114563e-01 -5.999588751504112e+00 -5.996894238822117e+00 3.728397262335786e+00 4.743869571130285e+00 9.207528199190974e+03 + 31260 9.666469883300745e-01 -6.006964590137052e+00 -6.035108192060314e+00 3.623191486609150e+00 4.461586569157456e+00 9.325143019976338e+03 + 31280 9.946660318626865e-01 -6.025351233924083e+00 -6.014253494746576e+00 3.629602543279481e+00 4.693327479006314e+00 9.260854404733966e+03 + 31300 1.037528001219882e+00 -6.072865970338513e+00 -6.015662127650454e+00 3.269594692881536e+00 4.598068009862418e+00 9.265199556733678e+03 + 31320 1.037098546660028e+00 -6.063953380848192e+00 -5.963259204225578e+00 3.386200511838446e+00 4.964402056378967e+00 9.104596709750644e+03 + 31340 9.400833722817629e-01 -5.913713967190469e+00 -5.975724559362115e+00 4.219363994210710e+00 4.863289577852994e+00 9.142648055379241e+03 + 31360 1.005693473818706e+00 -6.003236941627807e+00 -5.966587405244079e+00 3.734398435813316e+00 4.944845745226111e+00 9.114746030971854e+03 + 31380 9.898172129004118e-01 -5.973630616044302e+00 -5.976825335545577e+00 3.833303107607502e+00 4.814958533849933e+00 9.146039562334137e+03 + 31400 9.916239883756244e-01 -5.972147794349388e+00 -6.022310809769923e+00 3.826613234368332e+00 4.538569437122073e+00 9.285670527821061e+03 + 31420 9.853010009460182e-01 -5.960257259779558e+00 -6.031051253930139e+00 3.876336637618378e+00 4.469826567870554e+00 9.312621158119779e+03 + 31440 1.008612864025714e+00 -5.992411241760644e+00 -6.032357876271757e+00 3.740748304259344e+00 4.511368547174822e+00 9.316659181754541e+03 + 31460 1.029298588630407e+00 -6.025227336699452e+00 -5.984430718024970e+00 3.582662681289156e+00 4.816923178974368e+00 9.169314977940734e+03 + 31480 9.334042655857491e-01 -5.886380538653455e+00 -5.959570579725227e+00 4.326493315647035e+00 4.906224773690670e+00 9.093325369022054e+03 + 31500 9.460788782783096e-01 -5.903840838207413e+00 -5.968914622411247e+00 4.199169505233701e+00 4.825505766199730e+00 9.121811894688415e+03 + 31520 9.921020168749236e-01 -5.966852224109777e+00 -5.977478865136757e+00 3.836594761640741e+00 4.775574944396443e+00 9.148035895433137e+03 + 31540 1.086757747524241e+00 -6.100875052171105e+00 -5.981749757419360e+00 3.159684679096285e+00 4.843720556140588e+00 9.161128620478910e+03 + 31560 1.012403641202399e+00 -5.985660090819247e+00 -6.066771533357364e+00 3.762922367121042e+00 4.297167912112005e+00 9.423178512264898e+03 + 31580 9.908953084462823e-01 -5.955755178057959e+00 -5.991854202921882e+00 3.955597934415209e+00 4.748311747340519e+00 9.192064265012976e+03 + 31600 1.012841705393386e+00 -5.988797347830026e+00 -6.021614436983182e+00 3.801713003081584e+00 4.613272198736034e+00 9.283524853063835e+03 + 31620 9.856905510286146e-01 -5.952090613452732e+00 -6.024505009133660e+00 3.896304658929429e+00 4.480489992838022e+00 9.292440100127540e+03 + 31640 9.808957590746398e-01 -5.950020068753343e+00 -6.038990859668990e+00 3.950614651381570e+00 4.439730601758526e+00 9.337151397295907e+03 + 31660 1.036074195414344e+00 -6.041258506455786e+00 -6.019883376935107e+00 3.476726351844587e+00 4.599465653342928e+00 9.278182697456441e+03 + 31680 9.670405573675283e-01 -5.953493427104958e+00 -5.982809413201300e+00 3.933682456718242e+00 4.765345527918863e+00 9.164347801399234e+03 + 31700 1.014695035878167e+00 -6.039065744398288e+00 -5.954212363858595e+00 3.482383566716590e+00 4.969624808793706e+00 9.077024378753564e+03 + 31720 1.013536511776796e+00 -6.053840881400317e+00 -5.990882304821087e+00 3.400441149979272e+00 4.761959039505451e+00 9.189085760277419e+03 + 31740 1.021979526902668e+00 -6.086641612640392e+00 -5.970761335804376e+00 3.204987839714851e+00 4.870390321722142e+00 9.127517956010952e+03 + 31760 9.625281939923827e-01 -6.021074911137812e+00 -5.979439065050901e+00 3.544914527181159e+00 4.783993998538560e+00 9.154035476879892e+03 + 31780 9.433311087288180e-01 -6.011521020668876e+00 -6.011932715149804e+00 3.582099868263241e+00 4.579735854844234e+00 9.253705730109961e+03 + 31800 9.713133409274932e-01 -6.072328735202534e+00 -5.978045087721832e+00 3.331249955513237e+00 4.872641249694722e+00 9.149778865828997e+03 + 31820 1.006863498808756e+00 -6.141223073159639e+00 -5.987275143263989e+00 2.948497418537118e+00 4.832490255363100e+00 9.178035202542562e+03 + 31840 9.423011273421551e-01 -6.059547892687362e+00 -6.009496939492481e+00 3.361322583131522e+00 4.648722901736505e+00 9.246230445165669e+03 + 31860 9.127143952960304e-01 -6.025446779067460e+00 -6.020233055099549e+00 3.527815078077888e+00 4.557753087922807e+00 9.279282767049472e+03 + 31880 9.473592356355940e-01 -6.081742316663823e+00 -5.968995517558610e+00 3.284746388583849e+00 4.932155956556758e+00 9.122126152124119e+03 + 31900 9.832930107977065e-01 -6.133433064179410e+00 -5.971055609207422e+00 2.979672147180035e+00 4.912068621459143e+00 9.128430679032603e+03 + 31920 9.464064454723948e-01 -6.069842917104076e+00 -6.008705349468276e+00 3.314464258362032e+00 4.665525632734810e+00 9.243799680474718e+03 + 31940 9.661712321742398e-01 -6.082367210269844e+00 -5.959745721492487e+00 3.276834758924533e+00 4.980946323098177e+00 9.093904524762322e+03 + 31960 8.916185121037674e-01 -5.944174559311961e+00 -6.024889680359971e+00 4.031509252464100e+00 4.568030536781811e+00 9.293602126324888e+03 + 31980 1.049254255374969e+00 -6.139678611145657e+00 -5.964004648252089e+00 2.989105870870239e+00 4.997852951263006e+00 9.106862384414973e+03 + 32000 9.648630518522827e-01 -5.969066050823690e+00 -5.995257358219771e+00 3.908484457171912e+00 4.758089917011895e+00 9.202478955826555e+03 + 32020 1.035519382210412e+00 -6.028345384113827e+00 -6.007814996720794e+00 3.561257097964957e+00 4.679145759442934e+00 9.241005328725218e+03 + 32040 1.020060088930005e+00 -5.968813682842733e+00 -6.015766815454856e+00 3.895951900260616e+00 4.626339746828021e+00 9.265513689069707e+03 + 32060 1.016144172652651e+00 -5.937081273559006e+00 -6.036823881807451e+00 4.030575455558656e+00 4.457837963877341e+00 9.330439467542916e+03 + 32080 1.027101018171872e+00 -5.937029292729678e+00 -5.989872507742119e+00 4.059003181113642e+00 4.755569263051113e+00 9.185995438387132e+03 + 32100 1.098238670337370e+00 -6.034255968716942e+00 -5.986866072223750e+00 3.471553706038074e+00 4.743673825264770e+00 9.176783597021233e+03 + 32120 1.039299429612162e+00 -5.945641544423541e+00 -5.946628756525702e+00 3.979436721702043e+00 4.973767997040855e+00 9.053932521117311e+03 + 32140 1.031130516924966e+00 -5.932976143097507e+00 -5.989265046009744e+00 4.053595729791855e+00 4.730376138590216e+00 9.184055983665565e+03 + 32160 1.139155226263383e+00 -6.095400981284398e+00 -5.953960516519396e+00 3.240597499213794e+00 5.052770535735624e+00 9.076247284515312e+03 + 32180 1.003924065243859e+00 -5.903984596137155e+00 -6.002263549261220e+00 4.205961633158488e+00 4.641628675701264e+00 9.223972431943394e+03 + 32200 9.838592422111661e-01 -5.887876087738622e+00 -5.989580992885031e+00 4.298560807389586e+00 4.714555503255702e+00 9.185064722790390e+03 + 32220 1.035817097242756e+00 -5.979570910226701e+00 -5.977438051020608e+00 3.802679390304572e+00 4.814926597924853e+00 9.147912576397115e+03 + 32240 1.032477654928390e+00 -5.991149175051049e+00 -6.046992318322081e+00 3.708864850764085e+00 4.388204880403325e+00 9.361879499324319e+03 + 32260 1.033578953706297e+00 -6.015769207772049e+00 -6.042219809275434e+00 3.576601800893749e+00 4.424718353843958e+00 9.347128820924871e+03 + 32280 1.067674078544079e+00 -6.096164385183002e+00 -5.987912396511006e+00 3.184549397123628e+00 4.806149068019337e+00 9.179994814015727e+03 + 32300 9.600677799837047e-01 -5.968901963777469e+00 -5.985894939884998e+00 3.866803406245334e+00 4.769227107781349e+00 9.173788708514339e+03 + 32320 9.792961305609984e-01 -6.026018193882752e+00 -5.966433870789189e+00 3.537755844627505e+00 4.879898248474949e+00 9.114286785628126e+03 + 32340 9.595377858193996e-01 -6.021384946979783e+00 -5.968743914919930e+00 3.626845458350680e+00 4.929118410611744e+00 9.121326179560865e+03 + 32360 1.001193724710751e+00 -6.101354758689940e+00 -5.945732778314581e+00 3.146844205895582e+00 5.040449699634523e+00 9.051204181712123e+03 + 32380 9.575576228320468e-01 -6.049902923346330e+00 -5.964037241913340e+00 3.432127163606471e+00 4.925181194065961e+00 9.106969035773889e+03 + 32400 9.023020581377768e-01 -5.973090694523596e+00 -5.999337801846899e+00 3.833452581197614e+00 4.682737629220478e+00 9.215010351646695e+03 + 32420 9.855948418331900e-01 -6.097012678993829e+00 -5.995187820381417e+00 3.193820700957353e+00 4.778514796455772e+00 9.202290988927707e+03 + 32440 9.202134795407484e-01 -5.995784093958020e+00 -6.055229322860793e+00 3.676824510772164e+00 4.335480807293002e+00 9.387365564567015e+03 + 32460 9.484172171834941e-01 -6.031879505956519e+00 -5.967284221333651e+00 3.535815044791318e+00 4.906731165183817e+00 9.116879620168371e+03 + 32480 9.209294232122592e-01 -5.978709581045299e+00 -5.965196705152297e+00 3.806712134281354e+00 4.884305158769760e+00 9.110509967208889e+03 + 32500 1.024461330984595e+00 -6.112183617043517e+00 -5.945881189124943e+00 3.063094297239821e+00 5.018028573565820e+00 9.051657604680375e+03 + 32520 9.966409426591925e-01 -6.039748047813636e+00 -5.977745828779042e+00 3.460327616955541e+00 4.816353953464565e+00 9.148856252643993e+03 + 32540 1.026618816040524e+00 -6.040466235205651e+00 -5.995258831462336e+00 3.514057555346632e+00 4.773645463463867e+00 9.202497325675286e+03 + 32560 9.905758101902901e-01 -5.927188620491699e+00 -6.042688727157232e+00 4.018455344370301e+00 4.355235858313066e+00 9.348555905552337e+03 + 32580 1.028368927400855e+00 -5.914786810730197e+00 -5.999098683408372e+00 4.114438121664387e+00 4.630306301526177e+00 9.214257875462297e+03 + 32600 1.057310847934023e+00 -5.895817861392816e+00 -5.962282607285801e+00 4.328810748762721e+00 4.947159892459013e+00 9.101607544051960e+03 + 32620 1.141385783244919e+00 -5.983634184961108e+00 -6.016315979428166e+00 3.833221223798258e+00 4.645557302477066e+00 9.267184456782659e+03 + 32640 1.096183332990647e+00 -5.907131105956358e+00 -6.055679590897610e+00 4.182758762756150e+00 4.329770374419728e+00 9.388749440970971e+03 + 32660 1.091101886439529e+00 -5.903872653265998e+00 -6.050135155551454e+00 4.140773736207813e+00 4.300911814035641e+00 9.371609747317354e+03 + 32680 1.032194298541337e+00 -5.829471544651454e+00 -6.065635593769994e+00 4.607630255012726e+00 4.251539738705584e+00 9.419641797930819e+03 + 32700 1.075315466144440e+00 -5.915705158689086e+00 -6.051224522903864e+00 4.084596246122968e+00 4.306423085247879e+00 9.374973442034276e+03 + 32720 9.963322877603308e-01 -5.828216475422855e+00 -6.006125483673920e+00 4.578146053082372e+00 4.556564996374713e+00 9.235820741236295e+03 + 32740 1.050732333244374e+00 -5.939170299697100e+00 -5.966693673923902e+00 4.052716784854010e+00 4.894673310815318e+00 9.115033934738623e+03 + 32760 1.033896724924840e+00 -5.944528228688386e+00 -5.949862543570422e+00 4.090809839460754e+00 5.060179377925544e+00 9.063749233000704e+03 + 32780 1.052354141675206e+00 -6.003336167272537e+00 -5.972596449875436e+00 3.647360915249126e+00 4.823873129499175e+00 9.133135430752021e+03 + 32800 1.073910284282166e+00 -6.067910448272880e+00 -5.985262887691782e+00 3.345056255769394e+00 4.819631338294726e+00 9.171875597900711e+03 + 32820 9.775292864607289e-01 -5.957955990602545e+00 -6.015194298174450e+00 3.945630672349052e+00 4.616959452671707e+00 9.263723346914752e+03 + 32840 1.014515311767048e+00 -6.041426416253023e+00 -5.959381575458423e+00 3.543893316844824e+00 5.015007489085500e+00 9.092782528398398e+03 + 32860 9.771236431353149e-01 -6.008856482436970e+00 -5.995242488775076e+00 3.702961246201155e+00 4.781134904566464e+00 9.202431836787793e+03 + 32880 9.359581615015365e-01 -5.966502448541487e+00 -6.005303330236169e+00 3.880142985563565e+00 4.657342318455666e+00 9.233327057078899e+03 + 32900 1.024506818194436e+00 -6.113398823141142e+00 -5.976705007758179e+00 3.086691234929837e+00 4.871608276158380e+00 9.145689710194485e+03 + 32920 9.821760689870432e-01 -6.064576136998426e+00 -5.986085596386804e+00 3.322327498603504e+00 4.773032329167342e+00 9.174399142940540e+03 + 32940 8.885101122037949e-01 -5.934182331659972e+00 -6.031714083559933e+00 3.997619216459932e+00 4.437576804060526e+00 9.314680141672854e+03 + 32960 1.007291991370197e+00 -6.114243354177791e+00 -5.996434017789137e+00 3.095434838450671e+00 4.771914278930209e+00 9.206115344588678e+03 + 32980 8.837907016866648e-01 -5.931861855604391e+00 -6.020070328385952e+00 4.101422870375446e+00 4.594916169446682e+00 9.278761965753825e+03 + 33000 9.948842658827406e-01 -6.093352508498851e+00 -5.973747827408593e+00 3.217488351926971e+00 4.904276939511819e+00 9.136640442796572e+03 + 33020 9.418261903321993e-01 -6.004828833759782e+00 -6.040295020325962e+00 3.650864488095325e+00 4.447212156457685e+00 9.341156693958288e+03 + 33040 1.014473396684694e+00 -6.098423682562371e+00 -5.977205046854983e+00 3.174403127292389e+00 4.870459292047467e+00 9.147228921025095e+03 + 33060 9.682723288612470e-01 -6.012235497394471e+00 -6.000007985472951e+00 3.628739295580145e+00 4.698951561234862e+00 9.217076843382387e+03 + 33080 9.512570486546017e-01 -5.959705420307958e+00 -6.024249286226297e+00 3.908181828162455e+00 4.537560961928381e+00 9.291649760971495e+03 + 33100 9.825182054977213e-01 -5.972253178626399e+00 -6.009181189193534e+00 3.906170491042190e+00 4.694124139774537e+00 9.245264065071027e+03 + 33120 1.011290548760544e+00 -5.977962705130107e+00 -6.025429825485927e+00 3.783023881418418e+00 4.510460330822164e+00 9.295247991989161e+03 + 33140 1.035904693017966e+00 -5.979489384586565e+00 -6.017401148220385e+00 3.776679967247988e+00 4.558984753636135e+00 9.270501659271957e+03 + 33160 1.017901586083734e+00 -5.921197717117971e+00 -5.986110637303543e+00 4.115655429637096e+00 4.742915396689603e+00 9.174444653200930e+03 + 33180 1.016590461602418e+00 -5.891796800494371e+00 -6.035454600750389e+00 4.210844144645867e+00 4.385938824603069e+00 9.326190827814897e+03 + 33200 1.007686314752772e+00 -5.859288615973827e+00 -6.053563130694391e+00 4.411009338219636e+00 4.295455010810165e+00 9.382206704543649e+03 + 33220 1.045583787113886e+00 -5.905406374921379e+00 -6.041839773191807e+00 4.166560506332933e+00 4.383138820463991e+00 9.345887845468880e+03 + 33240 1.092803625455598e+00 -5.975996715480321e+00 -5.950072279409630e+00 3.836522296491449e+00 4.985384420202870e+00 9.064394525730564e+03 + 33260 1.064106900951517e+00 -5.936705484660184e+00 -5.977362237154084e+00 4.077796013622888e+00 4.844338649190799e+00 9.147660980068391e+03 + 33280 1.056509770396473e+00 -5.933676998977393e+00 -6.039612083656045e+00 4.014096649392327e+00 4.405800999766137e+00 9.339039460162605e+03 + 33300 1.058596255873486e+00 -5.954547039099587e+00 -6.054347829353620e+00 3.899822438001336e+00 4.326750856240304e+00 9.384634138077206e+03 + 33320 9.995426027020912e-01 -5.887102604814530e+00 -5.998361390906485e+00 4.311264598194397e+00 4.672399431212884e+00 9.212015321195044e+03 + 33340 1.024144071306599e+00 -5.944226230215479e+00 -6.036343301732938e+00 4.019560779534546e+00 4.490610299810554e+00 9.328915862952545e+03 + 33360 9.826533498148270e-01 -5.900776968505179e+00 -6.009856306709564e+00 4.227861454000090e+00 4.601511014057474e+00 9.247291781576072e+03 + 33380 1.026112055344811e+00 -5.981694239757505e+00 -6.026690339317030e+00 3.828267171528675e+00 4.569892604733983e+00 9.299161338812304e+03 + 33400 1.027338008836794e+00 -5.999389544555160e+00 -6.005385859909287e+00 3.742750503138875e+00 4.708318732448671e+00 9.233588696974635e+03 + 33420 9.544292799922232e-01 -5.903454059310048e+00 -5.991969118408907e+00 4.174774041289961e+00 4.666506874283187e+00 9.192426741593867e+03 + 33440 1.035032992942500e+00 -6.029752220853137e+00 -5.993148512680112e+00 3.551357327907769e+00 4.761541484642809e+00 9.196008155137468e+03 + 33460 1.016590397158726e+00 -6.008240778025461e+00 -6.009264392142864e+00 3.606265774375109e+00 4.600388023709211e+00 9.245504358895059e+03 + 33480 9.909190943424009e-01 -5.975561778125635e+00 -6.015255731992795e+00 3.779233624441518e+00 4.551304798716775e+00 9.263943693369867e+03 + 33500 1.010956066002677e+00 -6.011375588047036e+00 -5.992561036770310e+00 3.641250325718497e+00 4.749286390691863e+00 9.194243303248837e+03 + 33520 9.526404549532858e-01 -5.931040139373117e+00 -6.019384726986587e+00 4.069755421049404e+00 4.562467127692109e+00 9.276627152561616e+03 + 33540 1.006134251844858e+00 -6.014614251276910e+00 -5.967185196317343e+00 3.651483996661675e+00 4.923828969862043e+00 9.116584873078042e+03 + 33560 9.909320351893766e-01 -5.994478561367085e+00 -5.994567216989907e+00 3.696900051063310e+00 4.696390976757652e+00 9.200381257334860e+03 + 33580 1.011566286102446e+00 -6.026766243119209e+00 -5.954209957902540e+00 3.570878489717851e+00 4.987507907480815e+00 9.077018494720029e+03 + 33600 1.040060362239749e+00 -6.068739464177391e+00 -5.983131675898788e+00 3.346362583125976e+00 4.837935751184133e+00 9.165340318650027e+03 + 33620 9.832521546667217e-01 -5.984850037498007e+00 -6.019411865553304e+00 3.770092880875098e+00 4.571633515755979e+00 9.276754615967526e+03 + 33640 9.493099287588730e-01 -5.936010863621783e+00 -6.055380962785319e+00 4.063298400917445e+00 4.377856819057278e+00 9.387830338545773e+03 + 33660 1.002562288935810e+00 -6.015995386458849e+00 -6.022751294404843e+00 3.553025583885832e+00 4.514232114986559e+00 9.287039017849323e+03 + 33680 1.000181367334738e+00 -6.013357538221198e+00 -5.987790535275792e+00 3.684341817160987e+00 4.831151504554430e+00 9.179613643877510e+03 + 33700 1.062918946824490e+00 -6.109056105876714e+00 -5.939613721737357e+00 3.129512882245945e+00 5.102477273098335e+00 9.032614834795060e+03 + 33720 1.077163601037068e+00 -6.132454079361533e+00 -5.988201193570820e+00 2.958358374260867e+00 4.786680767533074e+00 9.180831563423428e+03 + 33740 9.591824694565974e-01 -5.960513209100872e+00 -6.029970134017470e+00 3.864132888424566e+00 4.465300477129068e+00 9.309286688892425e+03 + 33760 9.655813243360327e-01 -5.972241625418071e+00 -6.044301501602399e+00 3.819244848016882e+00 4.405465887736669e+00 9.353562337694311e+03 + 33780 1.019414928031936e+00 -6.056648959119066e+00 -5.991213325013362e+00 3.443029397414395e+00 4.818770934580998e+00 9.190083719055110e+03 + 33800 1.005107492149035e+00 -6.040296425515112e+00 -5.996648450536793e+00 3.534158802565248e+00 4.784792229393052e+00 9.206777562010311e+03 + 33820 9.538142411856483e-01 -5.968929879236429e+00 -6.046819329010555e+00 3.836025278025104e+00 4.388772004068676e+00 9.361330812722548e+03 + 33840 9.745456844589168e-01 -6.004652603716979e+00 -6.017659746890974e+00 3.670393714886937e+00 4.595704685932956e+00 9.271348599098543e+03 + 33860 9.963599992953553e-01 -6.041293836410584e+00 -5.973431075777169e+00 3.475517312208405e+00 4.865195785493738e+00 9.135666734808550e+03 + 33880 9.790545822294348e-01 -6.018663584038736e+00 -5.975827627523983e+00 3.573338346844414e+00 4.819309037994973e+00 9.142996389690232e+03 + 33900 9.934181969223480e-01 -6.038828460402913e+00 -5.993828262365979e+00 3.474594052086680e+00 4.732992152972892e+00 9.198109785679690e+03 + 33920 9.566232117186738e-01 -5.980872954862074e+00 -6.003149635533500e+00 3.785335169897340e+00 4.657419022176818e+00 9.226719425663878e+03 + 33940 9.782705328487138e-01 -6.008203452463043e+00 -6.006349345703946e+00 3.629520169416007e+00 4.640166737348839e+00 9.236535449240409e+03 + 33960 9.730603987823262e-01 -5.991707730102409e+00 -6.013035035646773e+00 3.722969327804267e+00 4.600504638978659e+00 9.257119134562827e+03 + 33980 1.008031210947094e+00 -6.031005822362550e+00 -6.022645688184949e+00 3.536983854793231e+00 4.584989038967599e+00 9.286712156844713e+03 + 34000 1.007501051246186e+00 -6.016598825950767e+00 -5.993139477018829e+00 3.606913073101392e+00 4.741620284991095e+00 9.195986222618165e+03 + 34020 1.009104436615456e+00 -6.003384737074439e+00 -5.967296160078469e+00 3.763566378079996e+00 4.970792571880101e+00 9.116911820149629e+03 + 34040 1.020820333454005e+00 -6.002514337378292e+00 -5.978831193917095e+00 3.775572081178466e+00 4.911564355887261e+00 9.152126091840531e+03 + 34060 1.046977347263103e+00 -6.021077909640837e+00 -5.970594694005288e+00 3.630793767153293e+00 4.920676203584988e+00 9.126964309891086e+03 + 34080 1.024875014848771e+00 -5.966043589459263e+00 -6.020631923614909e+00 3.880299391636407e+00 4.566844729397279e+00 9.280491812406413e+03 + 34100 1.047799409307451e+00 -5.976950233080183e+00 -6.029235608948322e+00 3.820214260622688e+00 4.519983541252071e+00 9.307006442654818e+03 + 34120 1.023358103227549e+00 -5.921843887064405e+00 -6.024100370473327e+00 4.123603945725957e+00 4.536431393852260e+00 9.291160401261010e+03 + 34140 1.015922610594815e+00 -5.896425782045777e+00 -5.959073139826788e+00 4.283233288741465e+00 4.923502465715619e+00 9.091820100159292e+03 + 34160 9.916638807138434e-01 -5.845651034995084e+00 -6.020712995902945e+00 4.547398807107962e+00 4.542165936824131e+00 9.280713714564941e+03 + 34180 1.051971084059533e+00 -5.922571250115865e+00 -6.017513860652743e+00 4.114656361896693e+00 4.569481199872443e+00 9.270911168831601e+03 + 34200 1.106068215116996e+00 -5.995222626473003e+00 -6.034518513134090e+00 3.755779783645032e+00 4.530136721418264e+00 9.323313715433773e+03 + 34220 1.079899896113379e+00 -5.958102279494822e+00 -6.031292670657513e+00 3.940007057169679e+00 4.519736504937079e+00 9.313368331626587e+03 + 34240 1.040530389145295e+00 -5.912713241731042e+00 -6.020994864698386e+00 4.155612304230641e+00 4.533842468625159e+00 9.281611392195828e+03 + 34260 1.038385502735221e+00 -5.934455962771482e+00 -5.990650190747715e+00 4.032600633072958e+00 4.709924680004757e+00 9.188351781956970e+03 + 34280 9.816802809609201e-01 -5.886618645405675e+00 -6.022051440453660e+00 4.293792621342572e+00 4.516116554019744e+00 9.284852890799824e+03 + 34300 1.008242184330661e+00 -5.969505421377512e+00 -5.989468312127256e+00 3.872069033939700e+00 4.757439026007315e+00 9.184737041974673e+03 + 34320 1.049726087307255e+00 -6.078501493940418e+00 -5.963419357180076e+00 3.265677514126256e+00 4.926496952307247e+00 9.105114148665427e+03 + 34340 9.723770826981074e-01 -6.007187451933721e+00 -5.961854506551731e+00 3.643808598822742e+00 4.904117386456750e+00 9.100285536805990e+03 + 34360 9.694093608996591e-01 -6.033295905971626e+00 -5.951356660526777e+00 3.526241155558596e+00 4.996748982960172e+00 9.068296289882323e+03 + 34380 9.557441849690711e-01 -6.032550573792705e+00 -5.966200653462914e+00 3.527830410387740e+00 4.908821920538392e+00 9.113590537486827e+03 + 34400 9.661267272647774e-01 -6.058926567957526e+00 -5.969054751427723e+00 3.380206435372358e+00 4.896264313505148e+00 9.122287998863536e+03 + 34420 9.020497339132060e-01 -5.969203013717589e+00 -5.974054538724513e+00 3.869734327888060e+00 4.841876120527235e+00 9.137540553005716e+03 + 34440 9.453643581845979e-01 -6.030080413734153e+00 -5.947370069625577e+00 3.559837076375358e+00 5.034772671631186e+00 9.056192528030157e+03 + 34460 9.605017398627637e-01 -6.042125172673115e+00 -6.019578947764553e+00 3.489347025223586e+00 4.618810937665579e+00 9.277247346662491e+03 + 34480 8.667454545876117e-01 -5.890069269701408e+00 -6.054370625260697e+00 4.226265117121395e+00 4.282821307947361e+00 9.384702974533697e+03 + 34500 9.667324717481441e-01 -6.023775852015619e+00 -6.042757795044354e+00 3.586163766087604e+00 4.477166511770422e+00 9.348774180131521e+03 + 34520 9.828617966496069e-01 -6.031885281962625e+00 -6.035867863194475e+00 3.450014354126718e+00 4.427145756390980e+00 9.327503661049588e+03 + 34540 1.025224687555036e+00 -6.078032885983578e+00 -6.001706255430841e+00 3.281142016681364e+00 4.719421340823086e+00 9.222307007059961e+03 + 34560 9.515827488377635e-01 -5.951093580304645e+00 -6.023075579934879e+00 3.879901444550216e+00 4.466569663494971e+00 9.288000812847880e+03 + 34580 9.254710715132071e-01 -5.892137676379655e+00 -6.003242868211235e+00 4.319130572519630e+00 4.681147367549836e+00 9.226998845068720e+03 + 34600 1.028780970708773e+00 -6.023337720739420e+00 -6.023577773530921e+00 3.536260684024431e+00 4.534882263747579e+00 9.289589552084472e+03 + 34620 1.023680481024618e+00 -5.995164083917780e+00 -5.996616836867778e+00 3.734248580175923e+00 4.725906647924241e+00 9.206680704835122e+03 + 34640 1.041495537971289e+00 -6.003796954859683e+00 -5.990264366610287e+00 3.733922625690060e+00 4.811628841579359e+00 9.187179734565141e+03 + 34660 9.955663553817961e-01 -5.919990413854217e+00 -5.983262117465539e+00 4.100429290565231e+00 4.737113377164529e+00 9.165736890928216e+03 + 34680 1.013947706321502e+00 -5.931515284001444e+00 -5.999743416884854e+00 4.045626903089211e+00 4.653850405803230e+00 9.216265471077868e+03 + 34700 1.099043546120746e+00 -6.041435768858401e+00 -6.015145364394257e+00 3.414520521422550e+00 4.565484092282604e+00 9.263621766710867e+03 + 34720 1.070244974300127e+00 -5.986006103255457e+00 -6.035740332354205e+00 3.755219502523077e+00 4.469637862690985e+00 9.327114563653928e+03 + 34740 9.762089024696813e-01 -5.839924298871928e+00 -6.080039847748727e+00 4.483207159635066e+00 4.104426520223385e+00 9.464380798389469e+03 + 34760 9.895705831263665e-01 -5.856632866073813e+00 -6.045011604899007e+00 4.465455171018823e+00 4.383755301168941e+00 9.355733234776131e+03 + 34780 1.126911748955256e+00 -6.061192222049099e+00 -5.971015261928007e+00 3.319649506086400e+00 4.837459565941193e+00 9.128295876529504e+03 + 34800 1.023743464365290e+00 -5.917310536904900e+00 -6.007460236702479e+00 4.068825908092984e+00 4.551172381234330e+00 9.239960142122145e+03 + 34820 1.011939358212453e+00 -5.919685254584234e+00 -6.007675986906934e+00 4.083882291662787e+00 4.578625890144023e+00 9.240628281583078e+03 + 34840 9.776361263010142e-01 -5.894254870356567e+00 -6.031236316463588e+00 4.253253459732388e+00 4.466684798375597e+00 9.313168334875332e+03 + 34860 1.011614925279996e+00 -5.976190196065733e+00 -5.982365679544357e+00 3.846635598065020e+00 4.811175016277780e+00 9.162989527938806e+03 + 34880 1.030663168647257e+00 -6.037727136007128e+00 -6.005082222016327e+00 3.474678550261223e+00 4.662130698180515e+00 9.232675854604468e+03 + 34900 9.615131270545991e-01 -5.970550852425270e+00 -6.065990989308089e+00 3.831150561966386e+00 4.283118526671790e+00 9.420748999587729e+03 + 34920 9.582194095786187e-01 -5.999517597939873e+00 -6.025604405418504e+00 3.666378216794398e+00 4.516583731331689e+00 9.295813282973575e+03 + 34940 9.591793317933317e-01 -6.028434515064667e+00 -5.985743755458351e+00 3.500854515364196e+00 4.745991463397360e+00 9.173337498065292e+03 + 34960 9.528382792416653e-01 -6.036725263022418e+00 -5.992203731268289e+00 3.541260963669013e+00 4.796910488685990e+00 9.193127549673922e+03 + 34980 9.098862616852088e-01 -5.986796738569259e+00 -6.063047567619219e+00 3.751548439277189e+00 4.313704379094657e+00 9.411630989365538e+03 + 35000 9.946128171486417e-01 -6.123069083603966e+00 -6.014319459491903e+00 3.077583542535138e+00 4.702040713136546e+00 9.261079636348179e+03 + 35020 9.386597653974768e-01 -6.047007927321903e+00 -6.005349037099489e+00 3.499504007068639e+00 4.738715801418169e+00 9.233474257289656e+03 + 35040 9.525044259563686e-01 -6.070378946277703e+00 -5.975453071350080e+00 3.358403959726223e+00 4.903483023292305e+00 9.141844419771909e+03 + 35060 9.708767237379334e-01 -6.092874282600277e+00 -5.942564128966005e+00 3.210155887368002e+00 5.073260049957089e+00 9.041580827483553e+03 + 35080 9.620292402261388e-01 -6.065894776057851e+00 -5.984434296877148e+00 3.332415334647071e+00 4.800174012071081e+00 9.169322805206582e+03 + 35100 9.633828217828498e-01 -6.047792242674332e+00 -5.969625045998292e+00 3.464090779595137e+00 4.912938919243548e+00 9.124039799294724e+03 + 35120 9.651560149585100e-01 -6.023435614507056e+00 -6.004345763615860e+00 3.570539524235282e+00 4.680156402197408e+00 9.230394337601212e+03 + 35140 9.829858487790532e-01 -6.016270159665145e+00 -5.988818738133913e+00 3.609355863913366e+00 4.766986174439450e+00 9.182766338163943e+03 + 35160 1.035554988678442e+00 -6.059835571795576e+00 -6.023232999831624e+00 3.361812770625831e+00 4.571990403072551e+00 9.288504479763618e+03 + 35180 1.021937597628327e+00 -6.005989437394526e+00 -6.033916144653193e+00 3.673538259000266e+00 4.513178784277017e+00 9.321471000862713e+03 + 35200 1.009887627307424e+00 -5.964284445018313e+00 -6.008096039141128e+00 3.896271349730603e+00 4.644698396455121e+00 9.241894629431230e+03 + 35220 1.046293874052755e+00 -5.997090321820147e+00 -5.987756970571938e+00 3.728712162675501e+00 4.782305709874150e+00 9.179512023004947e+03 + 35240 1.035532479400028e+00 -5.966922393249788e+00 -5.944654736533561e+00 3.908245926674538e+00 5.036110257447851e+00 9.047908547811123e+03 + 35260 1.055910471537084e+00 -5.985794980536277e+00 -5.966366971749410e+00 3.757860817102530e+00 4.869419450031367e+00 9.114041287972956e+03 + 35280 9.914118944035317e-01 -5.882636340272437e+00 -5.955341253761432e+00 4.362651872784332e+00 4.945169008481516e+00 9.080410211868437e+03 + 35300 9.980277251952221e-01 -5.887868759599275e+00 -5.926655862811823e+00 4.326186556963624e+00 5.103465008032349e+00 8.993190609108990e+03 + 35320 1.008895982719608e+00 -5.898429163431519e+00 -5.973566295852499e+00 4.280649657842436e+00 4.849200616047505e+00 9.136027814065830e+03 + 35340 9.959755945210601e-01 -5.877509368121739e+00 -6.026923636931192e+00 4.291175622844934e+00 4.433215769557683e+00 9.299869276951040e+03 + 35360 1.019084390411524e+00 -5.914289462138371e+00 -6.003512183652201e+00 4.122029291185329e+00 4.609698617081389e+00 9.227833754767153e+03 + 35380 1.061972754544876e+00 -5.984052329833881e+00 -5.979860993472045e+00 3.776489085673686e+00 4.800556387670555e+00 9.155335191928541e+03 + 35400 1.048804680807730e+00 -5.976178500522182e+00 -6.031579602916313e+00 3.814338633541412e+00 4.496216930301423e+00 9.314231151488093e+03 + 35420 1.062867717287666e+00 -6.014846747319091e+00 -6.000582120008563e+00 3.681429904249789e+00 4.763339601710785e+00 9.218829654429912e+03 + 35440 9.809606251252622e-01 -5.919993962061801e+00 -6.027828705111792e+00 4.186165976818756e+00 4.566962194853144e+00 9.302661459632822e+03 + 35460 1.036798418834628e+00 -6.034977298837317e+00 -5.983173367487371e+00 3.578184102045912e+00 4.875650292489768e+00 9.165473176168489e+03 + 35480 1.019815420802907e+00 -6.051459735852447e+00 -6.003439553470780e+00 3.453160003917524e+00 4.728899322252266e+00 9.227598678745309e+03 + 35500 9.607458567618672e-01 -6.015146515225867e+00 -5.966977138932953e+00 3.659146178202568e+00 4.935742191063367e+00 9.115945259084616e+03 + 35520 9.562125210559344e-01 -6.054425898275792e+00 -5.961694010328486e+00 3.386505619062743e+00 4.918986469869451e+00 9.099817996047137e+03 + 35540 8.918510136247597e-01 -5.994836132420174e+00 -6.019821536132795e+00 3.799720145926223e+00 4.656250091329621e+00 9.277972624783231e+03 + 35560 1.000482276871838e+00 -6.177360456615081e+00 -5.975629566171635e+00 2.769748833268951e+00 4.928118823949620e+00 9.142411374504662e+03 + 35580 9.097533839281328e-01 -6.053908814008033e+00 -6.032485236795029e+00 3.391250431509040e+00 4.514267927153968e+00 9.317052613884085e+03 + 35600 9.601877247751737e-01 -6.129493751189758e+00 -5.968291005417062e+00 3.031539157802362e+00 4.957190270073466e+00 9.119977081449520e+03 + 35620 9.555725811313868e-01 -6.117516520927241e+00 -5.985087692226357e+00 3.109010262623836e+00 4.869437090319321e+00 9.171322759403305e+03 + 35640 9.169578486952911e-01 -6.050556026980540e+00 -6.007607728800874e+00 3.434470091567802e+00 4.681085865943105e+00 9.240427349650261e+03 + 35660 9.307392864578254e-01 -6.056108881585850e+00 -6.010896825684288e+00 3.417970048713266e+00 4.677584670243076e+00 9.250547752035618e+03 + 35680 9.858352344426721e-01 -6.120115131976210e+00 -6.004386614924458e+00 3.029984141412531e+00 4.694515195253823e+00 9.230536903139633e+03 + 35700 9.327334071094726e-01 -6.022304036349039e+00 -5.976629285282776e+00 3.636026127755157e+00 4.898297616522527e+00 9.145426069394476e+03 + 35720 9.531010314672712e-01 -6.030758170577888e+00 -5.993587504186452e+00 3.525827079583606e+00 4.739266798145268e+00 9.197344074541288e+03 + 35740 9.713905374034917e-01 -6.031283503175597e+00 -5.976226928867836e+00 3.614056295776205e+00 4.930199665428708e+00 9.144190437432826e+03 + 35760 1.065653059851730e+00 -6.141540626365792e+00 -5.947598234896963e+00 2.980278549536746e+00 5.093925773838842e+00 9.056898573427747e+03 + 35780 9.804852678280199e-01 -5.985457274497887e+00 -6.025809443385143e+00 3.715849376166921e+00 4.484140977938345e+00 9.296468917838916e+03 + 35800 1.043490076887030e+00 -6.053570969427625e+00 -6.003208710898681e+00 3.409540989956799e+00 4.698728871964311e+00 9.226907255141899e+03 + 35820 9.938965861699721e-01 -5.959295043315155e+00 -6.017226801237561e+00 3.878241016796418e+00 4.545587897895398e+00 9.270001918471326e+03 + 35840 1.038581218403012e+00 -6.007516585158622e+00 -6.033518691419539e+00 3.608020829269039e+00 4.458712711305909e+00 9.320221334396218e+03 + 35860 1.000389459159008e+00 -5.937797660585527e+00 -6.006204915298842e+00 4.024828136563793e+00 4.632023094011484e+00 9.236115026854794e+03 + 35880 1.042936386004096e+00 -5.990237673815015e+00 -6.027988481979564e+00 3.717746669978362e+00 4.500975687578838e+00 9.303160545081646e+03 + 35900 9.888978588205806e-01 -5.902899529958122e+00 -5.990493551640425e+00 4.266660783030538e+00 4.763682355399713e+00 9.187878626183161e+03 + 35920 1.109328539521271e+00 -6.076380352429560e+00 -5.973844762072792e+00 3.272306351876713e+00 4.861081579036602e+00 9.136952059717394e+03 + 35940 9.564274624713118e-01 -5.849042282182857e+00 -6.060861972883242e+00 4.437679389978301e+00 4.221377946985499e+00 9.404819766948887e+03 + 35960 1.049059400554185e+00 -5.990144933074261e+00 -6.023917409411082e+00 3.701198396030199e+00 4.507271610630354e+00 9.290615814368259e+03 + 35980 1.061727444737271e+00 -6.016145957788103e+00 -6.001386181233673e+00 3.604992080535981e+00 4.689745001579563e+00 9.221298752087894e+03 + 36000 1.041694249354959e+00 -5.999927088804181e+00 -5.995774730346033e+00 3.637323950394936e+00 4.661167435237020e+00 9.204101778558950e+03 + 36020 9.999932450460217e-01 -5.961137517492225e+00 -5.974399043340182e+00 3.951424010060776e+00 4.875274276427316e+00 9.138621820334072e+03 + 36040 9.291113475564650e-01 -5.885128396956406e+00 -5.964723733474901e+00 4.337526611606163e+00 4.880477871978445e+00 9.109041352341699e+03 + 36060 1.009484295289598e+00 -6.039566309861691e+00 -5.979378756430004e+00 3.449329611340735e+00 4.794935857139274e+00 9.153857144464098e+03 + 36080 9.868910620571015e-01 -6.047664467595260e+00 -6.005550577263872e+00 3.431779784924051e+00 4.673604260310356e+00 9.234096849059344e+03 + 36100 9.842469562837179e-01 -6.088258045490166e+00 -5.984777678818226e+00 3.219158188083253e+00 4.813358467048523e+00 9.170376457281685e+03 + 36120 9.042853380671673e-01 -6.004984938186954e+00 -5.991046113576280e+00 3.736448293222622e+00 4.816487181163250e+00 9.189568058216119e+03 + 36140 9.240331957304573e-01 -6.060198097971647e+00 -5.997383147832123e+00 3.367552626235236e+00 4.728245790518503e+00 9.209036455754913e+03 + 36160 8.969633598540711e-01 -6.033539137057288e+00 -6.027713888332804e+00 3.510722948619303e+00 4.544172428249619e+00 9.302322441011665e+03 + 36180 9.558817703353707e-01 -6.127288123827435e+00 -6.007867038043665e+00 3.051444603622930e+00 4.737178958546636e+00 9.241238187399777e+03 + 36200 9.781394195028803e-01 -6.160993986576017e+00 -5.943647915907953e+00 2.856917685378749e+00 5.104952457350504e+00 9.044892285326312e+03 + 36220 8.892470969520102e-01 -6.020863375392894e+00 -6.002712428499690e+00 3.609133191822459e+00 4.713358737733189e+00 9.225375779079082e+03 + 36240 9.470212690967177e-01 -6.091957279444939e+00 -6.003653487877813e+00 3.174343607335062e+00 4.681397643481081e+00 9.228267174470249e+03 + 36260 9.016759552754020e-01 -6.006819746154422e+00 -5.969444152009059e+00 3.648679453016545e+00 4.863295898453723e+00 9.123486836127357e+03 + 36280 9.356929831420231e-01 -6.034434659420729e+00 -5.957011866291777e+00 3.473630847250770e+00 4.918204506535726e+00 9.085554806270011e+03 + 36300 9.619273916898522e-01 -6.046701084722867e+00 -5.954858282914077e+00 3.457110774501563e+00 4.984486355115284e+00 9.078981139164547e+03 + 36320 9.803044543300830e-01 -6.048344084328718e+00 -6.014615658242633e+00 3.430800476324524e+00 4.624474318367893e+00 9.261968359315633e+03 + 36340 9.912451987597901e-01 -6.045724136074467e+00 -5.988103560022954e+00 3.404898669245116e+00 4.735764933688232e+00 9.180588017351794e+03 + 36360 9.902229891393663e-01 -6.030507004005695e+00 -5.935864706661328e+00 3.590604834175040e+00 5.134055551374572e+00 9.021190796362984e+03 + 36380 9.310481522486064e-01 -5.929820885204958e+00 -5.966992437264178e+00 4.080195851821055e+00 4.866751047617921e+00 9.115938315293737e+03 + 36400 9.985475570531214e-01 -6.015103531424840e+00 -5.952523338578578e+00 3.637767470406357e+00 4.997112621983140e+00 9.071864474010314e+03 + 36420 1.016484211146562e+00 -6.027443948388774e+00 -6.023353066395481e+00 3.517766747397592e+00 4.541257224865017e+00 9.288878316050448e+03 + 36440 1.037380433477882e+00 -6.049679928161706e+00 -5.998759887406450e+00 3.409728136294339e+00 4.702118890161859e+00 9.213258850792061e+03 + 36460 9.704407030229057e-01 -5.944442178276158e+00 -5.983132363063341e+00 4.011408040776685e+00 4.789243012441937e+00 9.165321036096295e+03 + 36480 1.026050687129477e+00 -6.018821580862799e+00 -5.963260827084270e+00 3.648780717349004e+00 4.967819163544181e+00 9.104601961396493e+03 + 36500 1.087917593982701e+00 -6.102685720304233e+00 -5.968323965704185e+00 3.177951653762675e+00 4.949477641090477e+00 9.120086100274646e+03 + 36520 9.927169562230097e-01 -5.954980981894696e+00 -6.023613025524071e+00 3.899512437619582e+00 4.505416622325281e+00 9.289679659272329e+03 + 36540 9.995328487126918e-01 -5.961499956775050e+00 -6.037862317475771e+00 3.871470887960126e+00 4.432986395779460e+00 9.333651144803298e+03 + 36560 1.034483902221955e+00 -6.011654657382843e+00 -6.018655592448040e+00 3.670058832143372e+00 4.629858379607811e+00 9.274405047165465e+03 + 36580 1.007350795222262e+00 -5.972837939853731e+00 -6.016514734523767e+00 3.808459566290458e+00 4.557660652332980e+00 9.267798391934339e+03 + 36600 1.018105316141292e+00 -5.991265013371356e+00 -5.980467213263136e+00 3.792861842854502e+00 4.854864482030066e+00 9.157191625605883e+03 + 36620 9.643435525887120e-01 -5.916350269394099e+00 -6.043087681811779e+00 4.140346166778670e+00 4.412600332125161e+00 9.349782321602641e+03 + 36640 1.016218330234107e+00 -6.001322754277966e+00 -5.993779638481492e+00 3.696093917117202e+00 4.739407655313959e+00 9.197977985499607e+03 + 36660 9.747618635628658e-01 -5.951044982615234e+00 -6.045591348470236e+00 3.940953881680341e+00 4.398054017938087e+00 9.357525159393757e+03 + 36680 1.029035710775141e+00 -6.048447076825759e+00 -6.005403895565370e+00 3.412960898764991e+00 4.660121506472917e+00 9.233625902247020e+03 + 36700 8.864145123232360e-01 -5.861287509058068e+00 -6.041176706369254e+00 4.457526836076211e+00 4.424575227352064e+00 9.343854016477411e+03 + 36720 9.677306402723989e-01 -6.007840931666443e+00 -5.981033976751776e+00 3.706127403875692e+00 4.860057087358576e+00 9.158910636307630e+03 + 36740 9.740972125805725e-01 -6.046007064960842e+00 -6.038398254327985e+00 3.443810689434842e+00 4.487501657548346e+00 9.335291112895491e+03 + 36760 9.448963633700656e-01 -6.034279198917861e+00 -6.012532385421869e+00 3.530101401967793e+00 4.654974970370295e+00 9.255541116141178e+03 + 36780 9.053371913546797e-01 -6.002158871640652e+00 -5.991248855777734e+00 3.677206589000821e+00 4.739853588405192e+00 9.190178354386195e+03 + 36800 9.684273374800685e-01 -6.116755351671876e+00 -5.954407329375104e+00 3.090463960342100e+00 5.022691427645421e+00 9.077646099931722e+03 + 36820 9.501611216237112e-01 -6.105055131407257e+00 -5.957574432707720e+00 3.141282314332368e+00 4.988139308829478e+00 9.087278991465109e+03 + 36840 9.499355253899543e-01 -6.113781855354995e+00 -5.932861834528682e+00 3.084641982132317e+00 5.123512738999752e+00 9.012099608310649e+03 + 36860 9.184264155526949e-01 -6.065429341320918e+00 -5.974544929408846e+00 3.371258991227139e+00 4.893131348743549e+00 9.139057068801410e+03 + 36880 9.457983288334333e-01 -6.095173549102192e+00 -6.009608523671254e+00 3.159638751829856e+00 4.650966368999196e+00 9.246575984712861e+03 + 36900 9.806099696538672e-01 -6.128234075393941e+00 -6.003371212934768e+00 2.991867815122089e+00 4.708849693828176e+00 9.227395039732761e+03 + 36920 9.354824298648817e-01 -6.033964062242945e+00 -6.021865954583839e+00 3.522519356426266e+00 4.591988562780966e+00 9.284277176816426e+03 + 36940 9.162770165711012e-01 -5.970011427280911e+00 -5.994008513383607e+00 3.905266713547546e+00 4.767471731608797e+00 9.198663075518762e+03 + 36960 9.872528726327354e-01 -6.030549163539524e+00 -5.994840595933615e+00 3.567793066982634e+00 4.772837188058739e+00 9.201194394545919e+03 + 36980 1.058165496126749e+00 -6.090299812514143e+00 -6.016667895513450e+00 3.212213213849245e+00 4.635019075769554e+00 9.268294985055660e+03 + 37000 1.053006862859185e+00 -6.045990690165004e+00 -5.994148825018681e+00 3.495170928923083e+00 4.792854941095976e+00 9.199097472867845e+03 + 37020 1.041262525458457e+00 -6.007004836800759e+00 -5.994704029153477e+00 3.675929497600003e+00 4.746562638654524e+00 9.200783884848248e+03 + 37040 9.948903957503364e-01 -5.924639235522253e+00 -6.022107171765211e+00 4.073304347983240e+00 4.513628374961789e+00 9.285046075150069e+03 + 37060 9.945372993882234e-01 -5.916184963702372e+00 -5.991343687021478e+00 4.129150655321685e+00 4.697577635248535e+00 9.190493133483644e+03 + 37080 1.051055156328336e+00 -5.995087613855917e+00 -5.980077580721732e+00 3.679938752161978e+00 4.766128685213592e+00 9.156002782577787e+03 + 37100 1.083863485674150e+00 -6.042644494060104e+00 -5.963169231166909e+00 3.475920076590495e+00 4.932279334880404e+00 9.104339719231437e+03 + 37120 1.027152204070001e+00 -5.961984110768216e+00 -6.000224510842475e+00 3.869606902091157e+00 4.650024607181972e+00 9.217726994083187e+03 + 37140 1.019421358526143e+00 -5.957267252497020e+00 -5.983589776686563e+00 3.937686651565228e+00 4.786538644271419e+00 9.166711462570445e+03 + 37160 1.075288523183712e+00 -6.047310762663072e+00 -5.954340195194860e+00 3.493848823271604e+00 5.027700208822893e+00 9.077394071011106e+03 + 37180 1.008021790206270e+00 -5.957118963900235e+00 -5.967379204491071e+00 3.969306273702706e+00 4.910390384463026e+00 9.117156574263372e+03 + 37200 1.002617696903565e+00 -5.959322897673909e+00 -5.989098554157448e+00 3.908609098523722e+00 4.737632671227290e+00 9.183601469692561e+03 + 37220 1.057609568076640e+00 -6.053280714317420e+00 -5.976156412526080e+00 3.401831042326616e+00 4.844690718159619e+00 9.143997437608225e+03 + 37240 9.875216577022590e-01 -5.962710057327586e+00 -6.017302505631137e+00 3.925207084166698e+00 4.611728797853636e+00 9.270219926347441e+03 + 37260 1.018447425985427e+00 -6.026664775048282e+00 -6.014904692172953e+00 3.563323107557954e+00 4.630851323295031e+00 9.262846185707805e+03 + 37280 9.966956792327294e-01 -6.017681420473824e+00 -5.976636087230855e+00 3.606685445172878e+00 4.842374100398796e+00 9.145476530151702e+03 + 37300 9.747667544641906e-01 -6.007609546902249e+00 -6.021371481583427e+00 3.651430055682078e+00 4.572406897090247e+00 9.282767419335436e+03 + 37320 9.761190776002098e-01 -6.035113003283525e+00 -5.986793976497696e+00 3.504136395001583e+00 4.781591724151038e+00 9.176568372969461e+03 + 37340 9.747516422557589e-01 -6.060252404993716e+00 -5.967843276357588e+00 3.356220395640892e+00 4.886847912535982e+00 9.118600415079029e+03 + 37360 9.414122759306732e-01 -6.039129935463077e+00 -5.980790666787613e+00 3.518537420539227e+00 4.853530529246390e+00 9.158143038810487e+03 + 37380 9.330899214100103e-01 -6.055234979476404e+00 -5.986873012396266e+00 3.444321021425292e+00 4.836866015379663e+00 9.176795642838448e+03 + 37400 9.247484753712178e-01 -6.069015446439321e+00 -5.974379687022763e+00 3.302857231822222e+00 4.846270407228539e+00 9.138585699983334e+03 + 37420 9.488419226070716e-01 -6.127605300795120e+00 -5.979458198394792e+00 3.040653467474010e+00 4.891337055146697e+00 9.154097022972775e+03 + 37440 9.293942954402463e-01 -6.117539777926696e+00 -5.990887128628598e+00 3.056283147067139e+00 4.783542258770956e+00 9.189095052095114e+03 + 37460 9.417694807474862e-01 -6.150505614390154e+00 -5.997594398201096e+00 2.868256119141016e+00 4.746295985432812e+00 9.209698697824766e+03 + 37480 9.546522524561809e-01 -6.180433797541570e+00 -5.984614836683111e+00 2.702847628359175e+00 4.827270404494702e+00 9.169911423100793e+03 + 37500 9.048255686974820e-01 -6.112253178534859e+00 -5.957300763689194e+00 3.118900541129979e+00 5.008661285982487e+00 9.086450341939126e+03 + 37520 8.825711422084065e-01 -6.074630142009887e+00 -5.939050953272343e+00 3.331437822969737e+00 5.109954505512371e+00 9.030889064708894e+03 + 37540 9.276954877199886e-01 -6.120780064179211e+00 -5.945973642646427e+00 3.057644312162079e+00 5.061409835809629e+00 9.051940447662215e+03 + 37560 9.238576991993074e-01 -6.074519567823113e+00 -5.995759314735142e+00 3.280282142604245e+00 4.732535703945155e+00 9.204049468929717e+03 + 37580 9.476122230065523e-01 -6.057304566770451e+00 -6.000624842602932e+00 3.416964022668367e+00 4.742427769997231e+00 9.218957508747044e+03 + 37600 1.021449231359665e+00 -6.113777002400935e+00 -5.977648218627500e+00 3.088684585714609e+00 4.870357128002880e+00 9.148546658877918e+03 + 37620 9.492103712949311e-01 -5.962806629202774e+00 -6.018867532752456e+00 3.893549194503265e+00 4.571638810924206e+00 9.275041825656623e+03 + 37640 9.426671916172155e-01 -5.919768038391574e+00 -5.997149007532183e+00 4.161952679313755e+00 4.717619179842104e+00 9.208272726561416e+03 + 37660 1.022871240141234e+00 -6.013613387335719e+00 -5.959115755647658e+00 3.659649203166817e+00 4.972583037800915e+00 9.091960075204692e+03 + 37680 1.064017900156335e+00 -6.052393358712745e+00 -5.977576768718851e+00 3.433038997570888e+00 4.862647435145711e+00 9.148334267497537e+03 + 37700 1.053320781142675e+00 -6.019046108002756e+00 -5.967077214004064e+00 3.576282793393422e+00 4.874696224894266e+00 9.116260750420581e+03 + 37720 1.046098943185696e+00 -5.994953110383792e+00 -5.987983368112436e+00 3.738210215591895e+00 4.778231554278149e+00 9.180183461668668e+03 + 37740 1.034381795963629e+00 -5.966317948778673e+00 -6.047471554826252e+00 3.821998654310634e+00 4.356002089905484e+00 9.363326907444667e+03 + 37760 9.846376876210567e-01 -5.885486949865316e+00 -6.061648736896110e+00 4.305484541922857e+00 4.293936299843597e+00 9.407279124269302e+03 + 37780 1.072774781977715e+00 -6.013854227687370e+00 -5.994504587237158e+00 3.631533827436592e+00 4.742642457248891e+00 9.200205474601897e+03 + 37800 1.054305398670348e+00 -5.989193506590672e+00 -6.036784554871160e+00 3.736414191550979e+00 4.463139027633501e+00 9.330292399143513e+03 + 37820 1.028209103477028e+00 -5.959783128467869e+00 -6.028844876686716e+00 3.914140802579186e+00 4.517577557035568e+00 9.305790534392776e+03 + 37840 1.076092709481768e+00 -6.046226857990375e+00 -5.987548625270054e+00 3.462790210355032e+00 4.799729703062280e+00 9.178847883332422e+03 + 37860 9.523786175789140e-01 -5.880797832679383e+00 -6.069577086957159e+00 4.294142144925759e+00 4.210142453367578e+00 9.431839648540075e+03 + 37880 1.052054965812987e+00 -6.051661686774793e+00 -5.989612857598940e+00 3.446117962078143e+00 4.802411941231172e+00 9.185171200170653e+03 + 37900 9.504644507944292e-01 -5.926918014014129e+00 -6.054010840434845e+00 4.025072311410702e+00 4.295285634551624e+00 9.383568492934222e+03 + 37920 9.832313109071007e-01 -6.004372740773937e+00 -6.010821650558474e+00 3.682585422916940e+00 4.645554784968569e+00 9.250307613516430e+03 + 37940 8.800378974701606e-01 -5.879963381462147e+00 -6.069243321831846e+00 4.291226064468493e+00 4.204351355889576e+00 9.430843416602940e+03 + 37960 1.003058596617729e+00 -6.088626247932789e+00 -5.989136695481532e+00 3.197469968350557e+00 4.768754374484157e+00 9.183746332947569e+03 + 37980 9.878784971384852e-01 -6.089854988344440e+00 -5.978529594405481e+00 3.180990885928947e+00 4.820238525475485e+00 9.151250699538776e+03 + 38000 9.458762634304554e-01 -6.045792994996969e+00 -5.973987642246472e+00 3.459279211807419e+00 4.871596659143199e+00 9.137372314381388e+03 + 38020 9.550373875306964e-01 -6.071219089576978e+00 -5.991536034626494e+00 3.286300052754914e+00 4.743852485193498e+00 9.191084384827367e+03 + 38040 9.109405928526811e-01 -6.010833904576853e+00 -5.990516330673879e+00 3.660742602966368e+00 4.777409256451648e+00 9.187959838865931e+03 + 38060 9.197270901397637e-01 -6.022766515853551e+00 -6.008542896847720e+00 3.574444412098114e+00 4.656118633527526e+00 9.243299772475397e+03 + 38080 9.926696387412721e-01 -6.124072766120490e+00 -6.019713799091924e+00 3.027890142951853e+00 4.627135481127827e+00 9.277665226124256e+03 + 38100 9.931168066502366e-01 -6.112792966489424e+00 -5.974835958130928e+00 3.106420081345524e+00 4.898590572118060e+00 9.139986979661891e+03 + 38120 9.518293409796095e-01 -6.030382264537055e+00 -5.978258862982274e+00 3.563363411192443e+00 4.862664048990314e+00 9.150396185863767e+03 + 38140 1.011061736840916e+00 -6.078871417451543e+00 -5.979946104610945e+00 3.276979236004268e+00 4.845023690977669e+00 9.155588546079176e+03 + 38160 9.996496600000792e-01 -6.001971108337878e+00 -5.992519450393097e+00 3.719767436292150e+00 4.774040318850428e+00 9.194114474490170e+03 + 38180 1.037437876624693e+00 -5.995426052242607e+00 -6.003059821268190e+00 3.738640333787669e+00 4.694806050720834e+00 9.226448683737159e+03 + 38200 9.900417731175458e-01 -5.874021187809513e+00 -6.051489488771066e+00 4.356348975597927e+00 4.337298528345872e+00 9.375784835409531e+03 + 38220 9.822654968468778e-01 -5.832679057035014e+00 -6.038645232192112e+00 4.551005634180668e+00 4.368315983266011e+00 9.336054176920492e+03 + 38240 1.093227053636404e+00 -5.983144716966978e+00 -5.947354728794617e+00 3.803854117165730e+00 5.009365767734193e+00 9.056121283055783e+03 + 38260 1.025109425168660e+00 -5.876113783543842e+00 -6.025548572126089e+00 4.306433626540428e+00 4.448355945542366e+00 9.295636555960502e+03 + 38280 1.049355549243571e+00 -5.912433342296191e+00 -5.980491581529758e+00 4.158435916334406e+00 4.767634974676779e+00 9.157257954584093e+03 + 38300 1.051261076482578e+00 -5.923419762298023e+00 -5.971740964856460e+00 4.149626175422407e+00 4.872158352649929e+00 9.130487055227979e+03 + 38320 1.062104753341277e+00 -5.951854933356495e+00 -5.946945025910154e+00 3.964602360570864e+00 4.992795808933481e+00 9.054877614924824e+03 + 38340 9.724047080634836e-01 -5.831976619199812e+00 -5.995608124198839e+00 4.568349390138925e+00 4.628751966540957e+00 9.203522447183204e+03 + 38360 1.072966687954136e+00 -5.996344441925022e+00 -6.023293713119961e+00 3.722269115667285e+00 4.567522230079709e+00 9.288678621732592e+03 + 38380 1.028623376207440e+00 -5.953331121886213e+00 -6.044919721489635e+00 3.942982976327441e+00 4.417067064114605e+00 9.355463601655338e+03 + 38400 9.826666775750345e-01 -5.913612112977154e+00 -6.038991213229062e+00 4.204824275542841e+00 4.484878079543326e+00 9.337129385477985e+03 + 38420 1.051595058012267e+00 -6.045774495562344e+00 -5.987565144056749e+00 3.540525367496647e+00 4.874772471709810e+00 9.178924212490256e+03 + 38440 1.015369469695447e+00 -6.021382627186632e+00 -6.044058511858788e+00 3.553879675220589e+00 4.423671236351257e+00 9.352808577128797e+03 + 38460 9.894078464662757e-01 -6.012631871394085e+00 -6.008213727750897e+00 3.665285880772372e+00 4.690655545277070e+00 9.242287008032958e+03 + 38480 9.493155662306634e-01 -5.977811067174793e+00 -6.002459209155272e+00 3.833381142413645e+00 4.691847696874090e+00 9.224598097694619e+03 + 38500 1.028111986299228e+00 -6.112456263925607e+00 -5.954593285675182e+00 3.097615861124870e+00 5.004089511455739e+00 9.078195775384102e+03 + 38520 9.150926371139090e-01 -5.959229418040367e+00 -5.990763310140355e+00 3.950986895945561e+00 4.769914407653401e+00 9.188693251696364e+03 + 38540 9.332432506099096e-01 -5.993533167941466e+00 -6.006113599240728e+00 3.740346057501451e+00 4.668107274165639e+00 9.235779316696700e+03 + 38560 9.891386763139318e-01 -6.077367563276564e+00 -6.004769946556236e+00 3.267254103373453e+00 4.684120853026458e+00 9.231705614636203e+03 + 38580 9.882855181913691e-01 -6.073804745030918e+00 -6.010832098189491e+00 3.312958442338593e+00 4.674557125487670e+00 9.250339794538299e+03 + 38600 9.251721770771483e-01 -5.977264189937594e+00 -5.979654875122190e+00 3.810901648009707e+00 4.797173963722423e+00 9.154676031383298e+03 + 38620 9.253776330203459e-01 -5.969275788185508e+00 -5.997103592043974e+00 3.825844727941907e+00 4.666053171847861e+00 9.208151199093110e+03 + 38640 1.055052529177415e+00 -6.149011178947287e+00 -5.972117257518901e+00 2.854072487904779e+00 4.869824758992440e+00 9.131678020299923e+03 + 38660 9.688809800695355e-01 -6.008784231381574e+00 -6.008456914890004e+00 3.622466125520467e+00 4.624345627467124e+00 9.243033321555871e+03 + 38680 1.001353043748229e+00 -6.041770624039511e+00 -5.971724732429438e+00 3.439082348203054e+00 4.841296697394786e+00 9.130455352673014e+03 + 38700 9.563744772228119e-01 -5.957592857522434e+00 -5.982205069187955e+00 3.943119772248560e+00 4.801792644137687e+00 9.162464190386654e+03 + 38720 1.034826550142536e+00 -6.053479272572883e+00 -5.995224471452122e+00 3.378771268406918e+00 4.713279351343661e+00 9.202375956077443e+03 + 38740 1.037241600025850e+00 -6.035865158617405e+00 -5.984536056758255e+00 3.554846125979586e+00 4.849585772007662e+00 9.169609322981925e+03 + 38760 1.003107244317321e+00 -5.964741087605548e+00 -5.974881429227493e+00 3.940733225433137e+00 4.882505814627138e+00 9.140093574788709e+03 + 38780 9.836875330311200e-01 -5.913600219513177e+00 -5.989957406223106e+00 4.282424684965789e+00 4.843969902640920e+00 9.186216076215711e+03 + 38800 1.098770014661096e+00 -6.057843933839727e+00 -5.956721223558123e+00 3.436738544739169e+00 5.017400795864985e+00 9.084670938817357e+03 + 38820 1.084006465601478e+00 -6.006202349134434e+00 -5.980430035757689e+00 3.643264723258219e+00 4.791253334920103e+00 9.157063814178902e+03 + 38840 1.096222326669355e+00 -5.987279004291063e+00 -5.993242210385090e+00 3.801997441657786e+00 4.767755789462718e+00 9.196302714380932e+03 + 38860 1.061067306931096e+00 -5.884968984155845e+00 -6.055214015847896e+00 4.283591670591502e+00 4.306018353282237e+00 9.387311964740380e+03 + 38880 1.099641831584355e+00 -5.874144526817987e+00 -6.008711341460479e+00 4.383756794916055e+00 4.611053321091600e+00 9.243798338510092e+03 + 38900 1.157300871704767e+00 -5.890242375196009e+00 -6.012301222357539e+00 4.251575236297207e+00 4.550694447350151e+00 9.254841389539504e+03 + 38920 1.114541868726751e+00 -5.774660291742436e+00 -6.050910130972183e+00 4.883611176497981e+00 4.297341850116314e+00 9.373997213007475e+03 + 38940 1.162323073404610e+00 -5.824046752315723e+00 -6.008732493086081e+00 4.634279822149461e+00 4.573785718620047e+00 9.243834707686212e+03 + 38960 1.158092508452047e+00 -5.816536858132422e+00 -6.020635477883572e+00 4.620755987269009e+00 4.448790128498575e+00 9.280480060172762e+03 + 38980 1.122834729458094e+00 -5.781846390836762e+00 -6.017287389492683e+00 4.870765435577336e+00 4.518826786918243e+00 9.270154203530572e+03 + 39000 1.177818754306817e+00 -5.893532749942179e+00 -6.007102188746041e+00 4.243628225141769e+00 4.591494932716139e+00 9.238815434133056e+03 + 39020 1.161323891663267e+00 -5.908948359689923e+00 -5.951402827494760e+00 4.205085328628554e+00 4.961305204685522e+00 9.068445670645533e+03 + 39040 1.016530897774236e+00 -5.735723016989963e+00 -5.989339107149104e+00 5.122883475967102e+00 4.666580639310206e+00 9.184274062773316e+03 + 39060 1.052693885446022e+00 -5.823005461779347e+00 -5.984978991874822e+00 4.605001682117559e+00 4.674924606986567e+00 9.170961780767750e+03 + 39080 1.096938961981560e+00 -5.920737517533599e+00 -5.971573969144344e+00 4.142462533097337e+00 4.850551761032980e+00 9.129982478701113e+03 + 39100 1.093986061287647e+00 -5.949775174875866e+00 -6.009242521026019e+00 3.898308116037166e+00 4.556837411900910e+00 9.245440072584715e+03 + 39120 1.079316505351835e+00 -5.961774257502536e+00 -5.992976221509720e+00 3.883307810799386e+00 4.704141304981814e+00 9.195480485855525e+03 + 39140 1.050617558642280e+00 -5.951334045860754e+00 -5.954493272746759e+00 3.981453063574802e+00 4.963312293906584e+00 9.077862554693400e+03 + 39160 9.932491395809119e-01 -5.893810091761956e+00 -5.997194058598588e+00 4.199291090869059e+00 4.605644354675963e+00 9.208417310113075e+03 + 39180 1.025716423572176e+00 -5.969568235598132e+00 -5.961579934170830e+00 3.839095549212522e+00 4.884965612193741e+00 9.099460084220907e+03 + 39200 9.325734788149230e-01 -5.855240028330083e+00 -6.054151161056870e+00 4.401656217802245e+00 4.259477712286722e+00 9.384011835378367e+03 + 39220 9.839838833748541e-01 -5.954310489753702e+00 -6.015012601255920e+00 3.874241047746582e+00 4.525680129879452e+00 9.263183025841032e+03 + 39240 1.037965578497535e+00 -6.055065194889058e+00 -5.974622768600879e+00 3.402115980607791e+00 4.864028840779751e+00 9.139290934532291e+03 + 39260 1.014769498014900e+00 -6.040492493810840e+00 -5.997571758122318e+00 3.468270773493916e+00 4.714728279779788e+00 9.209591422606427e+03 + 39280 9.699746353998464e-01 -5.992149493590869e+00 -5.990903227786914e+00 3.776152881058427e+00 4.783309132163743e+00 9.189129180435915e+03 + 39300 9.600492697622333e-01 -5.992382373552416e+00 -6.035374846141613e+00 3.747348027157746e+00 4.500478596486946e+00 9.325954950821511e+03 + 39320 9.323235075682385e-01 -5.966440185302880e+00 -6.005351925062818e+00 3.829469647438894e+00 4.606032416165063e+00 9.233492413174621e+03 + 39340 9.424249349125009e-01 -5.990922113648294e+00 -6.019592020958987e+00 3.728921457227996e+00 4.564294412796178e+00 9.277260556381127e+03 + 39360 9.951827632624004e-01 -6.075110875529315e+00 -5.977493254856153e+00 3.270322361516663e+00 4.830857845699940e+00 9.148074468799945e+03 + 39380 1.032793100993733e+00 -6.135438541119099e+00 -5.979476431289070e+00 2.957432438476266e+00 4.852991008178792e+00 9.154163912330241e+03 + 39400 9.474534676280297e-01 -6.012317748246142e+00 -5.999801687639831e+00 3.616159160244618e+00 4.688028317100173e+00 9.216450452383142e+03 + 39420 9.216433963852435e-01 -5.972151287686815e+00 -5.995689746482021e+00 3.816253967681406e+00 4.681092494714609e+00 9.203807097239576e+03 + 39440 9.457472149219108e-01 -5.999312757972534e+00 -5.983214301830738e+00 3.718118648667213e+00 4.810558475061443e+00 9.165588454116058e+03 + 39460 9.457367505698968e-01 -5.981534937007549e+00 -6.006836705663521e+00 3.757482497773009e+00 4.612195826714371e+00 9.238054317932076e+03 + 39480 9.579770569747527e-01 -5.973744937792716e+00 -6.015000065662374e+00 3.855502978802340e+00 4.618609650364359e+00 9.263149901913028e+03 + 39500 1.049051838339108e+00 -6.073891230223492e+00 -5.988719144604667e+00 3.271084430606410e+00 4.760155726567356e+00 9.182462903963467e+03 + 39520 1.016212208727127e+00 -5.984232075703513e+00 -6.020357042179807e+00 3.752470633939576e+00 4.545035486112202e+00 9.279642898377646e+03 + 39540 1.025776420202663e+00 -5.955661624612953e+00 -6.042132332740266e+00 3.946169911700568e+00 4.449641724334695e+00 9.346856729076684e+03 + 39560 1.072809417459248e+00 -5.986830600774184e+00 -6.025924752812872e+00 3.806714002609173e+00 4.582229331802546e+00 9.296820070988295e+03 + 39580 1.012372815999787e+00 -5.870000725823250e+00 -6.069903495116039e+00 4.405761549515960e+00 4.257888913383198e+00 9.432863799530111e+03 + 39600 1.023174958390502e+00 -5.871339202684463e+00 -6.023835875821351e+00 4.384570333276320e+00 4.508910837340405e+00 9.290343654850001e+03 + 39620 1.173970417933402e+00 -6.088039722790834e+00 -5.938789451455836e+00 3.260862967152977e+00 5.117881121563379e+00 9.030114252896477e+03 + 39640 1.038753927521937e+00 -5.888381851876491e+00 -6.028036534118174e+00 4.274860614914857e+00 4.472941817990881e+00 9.303282933438808e+03 + 39660 1.056155102968091e+00 -5.921943846212725e+00 -5.953995416356713e+00 4.085676729583942e+00 4.901631653852712e+00 9.076338248676262e+03 + 39680 1.027445313526099e+00 -5.889269517531873e+00 -6.013588132139026e+00 4.274613560194352e+00 4.560756836876641e+00 9.258809525766272e+03 + 39700 1.048463510324615e+00 -5.938692791271670e+00 -6.002839497722007e+00 3.987870175338830e+00 4.619529860230255e+00 9.225737639949433e+03 + 39720 1.048211470168058e+00 -5.960016437940664e+00 -5.939910531396431e+00 3.926195775827704e+00 5.041647002583669e+00 9.033462272263809e+03 + 39740 1.011299167778082e+00 -5.926321456001872e+00 -5.955801678521906e+00 4.166222798656241e+00 4.996942798896511e+00 9.081836416380287e+03 + 39760 9.864590392197067e-01 -5.909505033508147e+00 -6.002940952616207e+00 4.170907403915833e+00 4.634383897235598e+00 9.226057486736234e+03 + 39780 1.024747522521816e+00 -5.986946308866632e+00 -6.009759217733103e+00 3.741708663340988e+00 4.610713410343475e+00 9.247026187530237e+03 + 39800 1.070696225035710e+00 -6.072943511418069e+00 -5.962373941319374e+00 3.402068977471273e+00 5.036976559563653e+00 9.101906728667385e+03 + 39820 1.065715563509477e+00 -6.084079758033790e+00 -6.001199514075861e+00 3.258277571392031e+00 4.734188757874765e+00 9.220756203379267e+03 + 39840 9.587133383888075e-01 -5.940701635457771e+00 -6.034749038273034e+00 3.989797071748706e+00 4.449762330994913e+00 9.324041258239122e+03 + 39860 1.000186073379294e+00 -6.012873100410734e+00 -6.015446821582156e+00 3.601689233296980e+00 4.586910528048612e+00 9.264532476764110e+03 + 39880 9.746726168981310e-01 -5.980328158818024e+00 -6.011273543523744e+00 3.738466027023819e+00 4.560772839260765e+00 9.251715568849053e+03 + 39900 9.928926083191441e-01 -6.009330421564483e+00 -6.033146444107637e+00 3.642205921907731e+00 4.505450634947364e+00 9.319090890319138e+03 + 39920 1.010800524483252e+00 -6.038965690903647e+00 -6.001876914277874e+00 3.479360570470891e+00 4.692330065325716e+00 9.222807555504036e+03 + 39940 9.773692342174731e-01 -5.992974746781816e+00 -5.965785905381520e+00 3.738711865682666e+00 4.894834400462775e+00 9.112288544504283e+03 + 39960 9.898484417027990e-01 -6.011011455477171e+00 -5.965953847154770e+00 3.593763974639785e+00 4.852491734269359e+00 9.112806106412683e+03 + 39980 9.841486027573987e-01 -5.998787587907533e+00 -5.979107956265645e+00 3.715600162334668e+00 4.828603652635537e+00 9.152984214005193e+03 + 40000 9.482720541741739e-01 -5.939412370084104e+00 -6.019205495866089e+00 4.025423293243215e+00 4.567238817056747e+00 9.276057179881340e+03 + 40020 1.023050232798368e+00 -6.041668774412496e+00 -6.050904901054274e+00 3.420208053625955e+00 4.367172785162884e+00 9.373975787205971e+03 + 40040 9.900036765521283e-01 -5.986118454653941e+00 -5.997178482694135e+00 3.778857584444568e+00 4.715349191903966e+00 9.208392223378216e+03 + 40060 9.651506598889374e-01 -5.944877064525965e+00 -5.993773109913757e+00 4.019994204154664e+00 4.739225544899393e+00 9.197920478372274e+03 + 40080 1.039054198402698e+00 -6.046149136689051e+00 -5.951758391713673e+00 3.484587314199518e+00 5.026593578768717e+00 9.069558224684921e+03 + 40100 9.871971970952442e-01 -5.957191672067843e+00 -6.048085318536035e+00 3.910842968524797e+00 4.388917584758103e+00 9.365261679135592e+03 + 40120 1.008698918380450e+00 -5.979143964701026e+00 -6.015691065840143e+00 3.836290135754145e+00 4.626431025367710e+00 9.265289452583409e+03 + 40140 1.051577218862978e+00 -6.032757136876275e+00 -5.993988360954697e+00 3.598244527029238e+00 4.820860837819621e+00 9.198600451826442e+03 + 40160 1.012856221793394e+00 -5.965169085765140e+00 -6.014245813749283e+00 3.904949430763758e+00 4.623143264079697e+00 9.260826380154755e+03 + 40180 1.048736242634835e+00 -6.007232252434408e+00 -6.018216188612149e+00 3.613927920099592e+00 4.550856458808375e+00 9.273055468657563e+03 + 40200 9.915575126262502e-01 -5.911319435994634e+00 -6.005676161199150e+00 4.204174520915129e+00 4.662363603134760e+00 9.234484444386140e+03 + 40220 9.981198526971157e-01 -5.909995866017157e+00 -5.988195144241368e+00 4.207565389035707e+00 4.758533032173089e+00 9.180850787759116e+03 + 40240 1.035214738782100e+00 -5.951747820587875e+00 -5.982258268674232e+00 3.967042685173260e+00 4.791846970784817e+00 9.162661441873293e+03 + 40260 1.144806605446995e+00 -6.099408074630976e+00 -5.993469416277566e+00 3.155277468111492e+00 4.763593638331165e+00 9.197037695364723e+03 + 40280 1.021027574264459e+00 -5.905977352807255e+00 -6.033722948885301e+00 4.177269393124679e+00 4.443734411877434e+00 9.320865062010540e+03 + 40300 1.087505809081725e+00 -6.000990718486668e+00 -5.997851632994742e+00 3.674041859889846e+00 4.692066974556397e+00 9.210462312252212e+03 + 40320 1.036172532566935e+00 -5.927267913107668e+00 -6.017057272330179e+00 4.029698089061268e+00 4.514113693547178e+00 9.269464580706544e+03 + 40340 1.018346314960064e+00 -5.909640970949287e+00 -5.951277274110188e+00 4.222472346904915e+00 4.983390250957930e+00 9.068058593073918e+03 + 40360 1.026287940885864e+00 -5.934267270407916e+00 -5.971335786884405e+00 4.101143392726252e+00 4.888290234783864e+00 9.129201355033856e+03 + 40380 1.050519294423998e+00 -5.988167575145003e+00 -5.973175718791381e+00 3.747264112079882e+00 4.833349671244648e+00 9.134867543405169e+03 + 40400 9.975958582176956e-01 -5.932774144668173e+00 -5.983153981746498e+00 4.075705731470380e+00 4.786416910712044e+00 9.165399705319289e+03 + 40420 1.006640932190740e+00 -5.973500240902635e+00 -6.002904675033092e+00 3.842661134165865e+00 4.673816323067306e+00 9.225964804201767e+03 + 40440 9.925493574988186e-01 -5.983430677655832e+00 -6.001331208068637e+00 3.783373807059941e+00 4.680586191331491e+00 9.221129367633228e+03 + 40460 1.001580902276464e+00 -6.027215129551037e+00 -6.001922491594167e+00 3.539322659395163e+00 4.684556900566585e+00 9.222949090971604e+03 + 40480 9.529802942998165e-01 -5.985468042243087e+00 -6.027109785005500e+00 3.756874533115858e+00 4.517761202135219e+00 9.300459896871880e+03 + 40500 9.957173200375995e-01 -6.074806569928226e+00 -6.003656409621514e+00 3.271983688353239e+00 4.680538919286104e+00 9.228295666806396e+03 + 40520 9.705171214849178e-01 -6.057927486713487e+00 -6.030272176904083e+00 3.360279396929245e+00 4.519080465500208e+00 9.310231456468769e+03 + 40540 9.770363340674247e-01 -6.085739565927646e+00 -5.999013833544507e+00 3.264808243788642e+00 4.762800819896341e+00 9.214041117976019e+03 + 40560 9.696485225984908e-01 -6.087165796270344e+00 -5.990017556165686e+00 3.270477586993292e+00 4.828317815315808e+00 9.186446089450761e+03 + 40580 9.717259175085311e-01 -6.096906562843945e+00 -6.018225670877203e+00 3.149838953633265e+00 4.601636811134982e+00 9.273100958428333e+03 + 40600 9.688613024392033e-01 -6.094351707454911e+00 -5.983955292732156e+00 3.194623825594557e+00 4.828537122722585e+00 9.167868613334964e+03 + 40620 9.920048254180076e-01 -6.125356561430753e+00 -5.989072070634789e+00 3.005607689777964e+00 4.788174325885178e+00 9.183560210419662e+03 + 40640 9.544350239095466e-01 -6.059774143972422e+00 -6.014651411806879e+00 3.356985410678378e+00 4.616087121493162e+00 9.262094677667361e+03 + 40660 9.458161034285784e-01 -6.031812673747662e+00 -6.017211987850578e+00 3.500189934058775e+00 4.584029331928670e+00 9.269971686140352e+03 + 40680 9.544819692943259e-01 -6.020050319818411e+00 -6.026235758018074e+00 3.578667096447576e+00 4.543149353111643e+00 9.297770976551761e+03 + 40700 9.916586197152992e-01 -6.043253081350107e+00 -5.978112258344694e+00 3.448491649973318e+00 4.822540336180176e+00 9.149970686682655e+03 + 40720 9.794421822343667e-01 -5.979901668131604e+00 -5.967601271032805e+00 3.825246852692517e+00 4.895877636314123e+00 9.117848348482261e+03 + 40740 1.002537670831281e+00 -5.960560106760758e+00 -6.003400041170114e+00 3.861739485307127e+00 4.615745952470182e+00 9.227473806532931e+03 + 40760 1.066566342176865e+00 -6.003958964648861e+00 -6.007229759430125e+00 3.664290486646077e+00 4.645509076858207e+00 9.239209235342836e+03 + 40780 1.047520694849016e+00 -5.939300433491710e+00 -6.017845369971590e+00 4.050454270619939e+00 4.599437090562836e+00 9.271904716597168e+03 + 40800 1.037185643444162e+00 -5.905538441942295e+00 -6.029144318725025e+00 4.198199238756580e+00 4.488435166322534e+00 9.306756284800380e+03 + 40820 1.049877028438687e+00 -5.918973511806076e+00 -6.032072687230372e+00 4.108339652140284e+00 4.458906684813144e+00 9.315763708935538e+03 + 40840 1.062780715659392e+00 -5.940512919206860e+00 -5.996823597658039e+00 3.992293281200060e+00 4.668948651484064e+00 9.207275022118647e+03 + 40860 1.033563378081269e+00 -5.904817554112634e+00 -5.971622727592412e+00 4.224854300855688e+00 4.841248656667619e+00 9.130102677363591e+03 + 40880 1.071485808244854e+00 -5.969589895106303e+00 -5.994687665577660e+00 3.866514063363472e+00 4.722398781449513e+00 9.200758496247327e+03 + 40900 1.090886540124907e+00 -6.013504288475625e+00 -6.014006926569678e+00 3.623676776201101e+00 4.620790550482052e+00 9.260072891098629e+03 + 40920 1.044617381622178e+00 -5.964963583286458e+00 -6.005921943323803e+00 3.896521503645979e+00 4.661332262025815e+00 9.235208301783288e+03 + 40940 1.048024691751375e+00 -5.993946423417706e+00 -6.015744749558008e+00 3.669837061009006e+00 4.544667699031327e+00 9.265436066984073e+03 + 40960 1.086172708261702e+00 -6.076881946367907e+00 -5.960102305370468e+00 3.290648316631386e+00 4.961215086829716e+00 9.094968109858810e+03 + 40980 9.905055517430740e-01 -5.961022887318354e+00 -5.999953074069705e+00 3.891044538769695e+00 4.667501382016510e+00 9.216890275287824e+03 + 41000 9.796026525916424e-01 -5.969829335559584e+00 -5.972070894823998e+00 3.869077085208850e+00 4.856205705032410e+00 9.131495069884260e+03 + 41020 1.028205885222987e+00 -6.062839171982683e+00 -5.944984390656108e+00 3.354009361886640e+00 5.030749754232296e+00 9.048927431711945e+03 + 41040 9.797560257536749e-01 -6.006687402679683e+00 -6.010611831458855e+00 3.606818595400734e+00 4.584283918047340e+00 9.249634333007481e+03 + 41060 1.030196185630203e+00 -6.094053372263473e+00 -5.951604792142309e+00 3.229001127777726e+00 5.046962918679986e+00 9.069088184745726e+03 + 41080 9.720676038113055e-01 -6.018699373812893e+00 -5.984235934009615e+00 3.552667742082485e+00 4.750562146632983e+00 9.168728048253455e+03 + 41100 9.870678552377534e-01 -6.050108554501752e+00 -5.979121028875332e+00 3.402909019173769e+00 4.810530376604755e+00 9.153036853336536e+03 + 41120 9.712957994092769e-01 -6.031472273490918e+00 -5.973724413300503e+00 3.461485878555698e+00 4.793083028221543e+00 9.136566364278207e+03 + 41140 9.661342366400655e-01 -6.022883424535045e+00 -6.006761506343716e+00 3.550589605997023e+00 4.643164155110405e+00 9.237827904142367e+03 + 41160 9.719070299913287e-01 -6.028122700028727e+00 -6.003806552917019e+00 3.551600191179134e+00 4.691227270806169e+00 9.228736300504681e+03 + 41180 9.935634632127555e-01 -6.053491209249371e+00 -5.991911781750261e+00 3.422980957122264e+00 4.776579559207764e+00 9.192241673361881e+03 + 41200 9.603556167048766e-01 -5.991015064109736e+00 -6.042937006999196e+00 3.663404553904283e+00 4.365260722938308e+00 9.349357294837338e+03 + 41220 9.864845339565242e-01 -6.012084038592826e+00 -5.992954778056669e+00 3.613874436096151e+00 4.723717610338269e+00 9.195461494272144e+03 + 41240 9.230700664653255e-01 -5.890019940208351e+00 -5.982995388828128e+00 4.298549527868360e+00 4.764670113989431e+00 9.164893429629241e+03 + 41260 9.981932586888228e-01 -5.958754803850280e+00 -5.949622985490696e+00 3.919723848023600e+00 4.972160162188658e+00 9.062984730993947e+03 + 41280 1.060971229646532e+00 -5.993685039669203e+00 -5.983028389057045e+00 3.748147266814406e+00 4.809339403740768e+00 9.165000850712013e+03 + 41300 1.049768256319500e+00 -5.921445591524184e+00 -6.017922968816661e+00 4.071978248144255e+00 4.517990217904963e+00 9.272155896399516e+03 + 41320 1.109749949733657e+00 -5.974241994285975e+00 -5.983421692933668e+00 3.823901013141732e+00 4.771189762952908e+00 9.166201641980451e+03 + 41340 1.089605549384979e+00 -5.923348021165127e+00 -5.997970989398964e+00 4.096652334188386e+00 4.668155702722681e+00 9.210792359426059e+03 + 41360 1.036574174039727e+00 -5.834433443010338e+00 -6.039215143558831e+00 4.533248227939707e+00 4.357360013524523e+00 9.337782791203765e+03 + 41380 1.136443649216289e+00 -5.984097837672807e+00 -5.996704488869412e+00 3.764968020249360e+00 4.692578678205487e+00 9.206910399884855e+03 + 41400 1.057828287888791e+00 -5.877785893055563e+00 -5.964017887208103e+00 4.359547212958205e+00 4.864389758176357e+00 9.106893870072912e+03 + 41420 1.055314191523820e+00 -5.890074434903321e+00 -6.014931333643668e+00 4.265934149832463e+00 4.548986515722752e+00 9.262942058173991e+03 + 41440 1.056686364718221e+00 -5.916154312876202e+00 -6.034172928625757e+00 4.132722719563358e+00 4.455041564607649e+00 9.322251146859859e+03 + 41460 1.034981057448354e+00 -5.914876218857642e+00 -6.012841672767065e+00 4.178718002193763e+00 4.616185205740860e+00 9.256502229196738e+03 + 41480 1.027031314080232e+00 -5.937497054682225e+00 -6.031657849254664e+00 3.979349160389250e+00 4.438663306618444e+00 9.314501709647100e+03 + 41500 1.042342036214515e+00 -5.995752223848504e+00 -5.990949224515953e+00 3.755227148413341e+00 4.782806713842594e+00 9.189274452754540e+03 + 41520 9.711857432044605e-01 -5.923136954820414e+00 -6.008057766543764e+00 4.105796625189694e+00 4.618168182821072e+00 9.241764584510374e+03 + 41540 9.550212274632899e-01 -5.921039925467043e+00 -5.965283719636440e+00 4.150839766293850e+00 4.896785053468155e+00 9.110718031769360e+03 + 41560 9.850780843427117e-01 -5.978095997626388e+00 -5.945924730066029e+00 3.819483755793590e+00 5.004216152612740e+00 9.051785769460195e+03 + 41580 1.014302567156776e+00 -6.030050807208439e+00 -6.000265678596564e+00 3.532269724066435e+00 4.703300541789575e+00 9.217849060828345e+03 + 41600 9.627452546984072e-01 -5.961400226346727e+00 -5.994469073791080e+00 3.930253188117983e+00 4.740366748704902e+00 9.200079434022709e+03 + 41620 1.044679238887409e+00 -6.089218824778237e+00 -5.973877349354145e+00 3.188382517508409e+00 4.850691118429174e+00 9.137039552234894e+03 + 41640 1.004022342109738e+00 -6.034333046863875e+00 -5.983443484437945e+00 3.459316619802592e+00 4.751532362386618e+00 9.166317842818511e+03 + 41660 1.044877517196799e+00 -6.099183199534624e+00 -5.952745051110485e+00 3.190854714861737e+00 5.031725224343369e+00 9.072552444294006e+03 + 41680 9.975258553503771e-01 -6.030244666105307e+00 -5.967458191742750e+00 3.555809171660968e+00 4.916338823626271e+00 9.117412593821255e+03 + 41700 1.008362692940627e+00 -6.045996061906804e+00 -5.964792621702442e+00 3.428751329397293e+00 4.895034049242503e+00 9.109269679935887e+03 + 41720 9.518538919256299e-01 -5.959385818987940e+00 -5.987701170917576e+00 3.887797267719998e+00 4.725206135153480e+00 9.179310165034152e+03 + 41740 9.788070773569778e-01 -5.993317525559167e+00 -5.948906061665340e+00 3.779981922884098e+00 5.034999421214279e+00 9.060869680976431e+03 + 41760 9.546496176875435e-01 -5.946125236236587e+00 -6.015937417501862e+00 3.964544134050008e+00 4.563671785824669e+00 9.266039448105323e+03 + 41780 9.756821535906730e-01 -5.964180345407149e+00 -6.028855584439330e+00 3.831343703661434e+00 4.459968472677756e+00 9.305852698634975e+03 + 41800 1.009718221067306e+00 -5.997316272576850e+00 -6.002817245970013e+00 3.699918435598378e+00 4.668330995101955e+00 9.225714039266966e+03 + 41820 1.014085210617851e+00 -5.982389985033539e+00 -6.028170165965667e+00 3.783352291260766e+00 4.520475407888381e+00 9.303729289588409e+03 + 41840 9.926776433536969e-01 -5.923172862139123e+00 -6.047595071447286e+00 4.127900715916697e+00 4.413449135794563e+00 9.363716174337320e+03 + 41860 1.026736378798209e+00 -5.936827267077670e+00 -6.034015905423079e+00 3.987311714979321e+00 4.429239513706805e+00 9.321750608601234e+03 + 41880 1.020201896607275e+00 -5.886529472483418e+00 -5.982335594764439e+00 4.332322965597723e+00 4.782189385510594e+00 9.162838746632346e+03 + 41900 1.030653820313612e+00 -5.858196937827208e+00 -6.014728128277675e+00 4.410931268678573e+00 4.512104949988555e+00 9.262268923802652e+03 + 41920 1.113139046610511e+00 -5.940217549110979e+00 -5.990320982742208e+00 3.979212678677376e+00 4.691511009285567e+00 9.187376383043238e+03 + 41940 1.169927639975069e+00 -5.992933776836654e+00 -6.029992088872360e+00 3.717869209954620e+00 4.505074647490340e+00 9.309356409963457e+03 + 41960 1.102589231426763e+00 -5.881664479547374e+00 -6.075683548693411e+00 4.260021007457938e+00 4.145933488067476e+00 9.450837779572204e+03 + 41980 1.098089816239254e+00 -5.881713464108240e+00 -6.045885157939411e+00 4.325978800590716e+00 4.383279529124620e+00 9.358369115632007e+03 + 42000 1.014130296850902e+00 -5.773754101459457e+00 -5.946662440822411e+00 4.989532614890624e+00 4.996666172789502e+00 9.054010119562336e+03 + 42020 1.115234781621623e+00 -5.945750703276803e+00 -5.955294023635772e+00 3.981891834939495e+00 4.927092612614245e+00 9.080282488008805e+03 + 42040 1.046309862816272e+00 -5.871525666890436e+00 -5.991350335637182e+00 4.336094330378478e+00 4.648042539627105e+00 9.190462583841858e+03 + 42060 1.131937925520272e+00 -6.033312220142301e+00 -5.940905979757462e+00 3.532992843398486e+00 5.063603775507721e+00 9.036529272929680e+03 + 42080 1.041773785077297e+00 -5.935935344171328e+00 -5.999084958620294e+00 4.096071130568028e+00 4.733456272030810e+00 9.214224608571722e+03 + 42100 1.052301704073485e+00 -5.986316751377207e+00 -5.991697874703776e+00 3.777277715633439e+00 4.746378472766132e+00 9.191579173522352e+03 + 42120 9.773314725366022e-01 -5.903437904723610e+00 -6.007152439372128e+00 4.201199761522557e+00 4.605654853798403e+00 9.238995023702961e+03 + 42140 9.092528838027251e-01 -5.819576598948462e+00 -6.026898207090846e+00 4.638659252700817e+00 4.448186495832077e+00 9.299792376619622e+03 + 42160 1.045735930044150e+00 -6.032355661311123e+00 -6.010508737322633e+00 3.553236510602245e+00 4.678684928944714e+00 9.249327401182120e+03 + 42180 9.983106425020157e-01 -5.972601585475750e+00 -6.071199783156326e+00 3.821114537775507e+00 4.254948428671865e+00 9.436918046360270e+03 + 42200 1.041951043838867e+00 -6.049794878186697e+00 -6.043055176065359e+00 3.393176115606594e+00 4.431876528152848e+00 9.349716722794323e+03 + 42220 9.773230412439644e-01 -5.966758386407828e+00 -6.032021933427817e+00 3.867252604124375e+00 4.492499217634337e+00 9.315613137919943e+03 + 42240 1.013278648299591e+00 -6.031140889917081e+00 -6.008995637301402e+00 3.526808662959975e+00 4.653970130445968e+00 9.244681237915252e+03 + 42260 9.597486827834335e-01 -5.961492823573055e+00 -6.009471300824395e+00 3.853904731940564e+00 4.578404890918010e+00 9.246152533192282e+03 + 42280 9.746920974863563e-01 -5.990614087491510e+00 -6.016433801189764e+00 3.769208492898536e+00 4.620947701255374e+00 9.267558968164936e+03 + 42300 1.024937830917936e+00 -6.071871406963625e+00 -5.991456173574136e+00 3.312944826094509e+00 4.774701540434108e+00 9.190849134803384e+03 + 42320 9.637924537954357e-01 -5.989384812551391e+00 -6.010141293062793e+00 3.677584796229362e+00 4.558397873077913e+00 9.248211427314784e+03 + 42340 9.863205026886791e-01 -6.029178446562106e+00 -5.959150824741782e+00 3.563330397497203e+00 4.965439838728964e+00 9.092047372481626e+03 + 42360 8.858424687537718e-01 -5.881500338329091e+00 -6.008245277164047e+00 4.297500008723066e+00 4.569710956216855e+00 9.242347789625266e+03 + 42380 1.008674706676510e+00 -6.059102242594683e+00 -5.989759321429535e+00 3.395654796846682e+00 4.793832580959335e+00 9.185634393770290e+03 + 42400 9.895430675208226e-01 -6.022787933396328e+00 -6.010689518147565e+00 3.577124509955490e+00 4.646595482537601e+00 9.249894349071390e+03 + 42420 9.673373976393089e-01 -5.982751751843269e+00 -5.981117252687039e+00 3.773630919043970e+00 4.783016466136970e+00 9.159170889210325e+03 + 42440 9.437176720732248e-01 -5.934451870203412e+00 -6.005558827795886e+00 4.044460292722517e+00 4.636153138460410e+00 9.234111590699595e+03 + 42460 1.037201134089287e+00 -6.053011277464931e+00 -5.970032805036439e+00 3.447140035213572e+00 4.923615264775080e+00 9.125283349107589e+03 + 42480 1.041539322021710e+00 -6.032819864891585e+00 -5.968450389615150e+00 3.487239796449451e+00 4.856859284630849e+00 9.120437437307733e+03 + 42500 1.060176761684903e+00 -6.027869702173631e+00 -5.953901335130238e+00 3.505865432203717e+00 4.930603242334683e+00 9.076080240993144e+03 + 42520 1.000008876939715e+00 -5.898927217088021e+00 -6.010130057315816e+00 4.260780457772888e+00 4.622236540600980e+00 9.248185890714038e+03 + 42540 1.063123074318301e+00 -5.956318013686573e+00 -6.021848691137871e+00 3.908992297987298e+00 4.532705007222385e+00 9.284232823520899e+03 + 42560 1.099138663220627e+00 -5.978102116296883e+00 -6.016567691465347e+00 3.830978738935476e+00 4.610103453789634e+00 9.267979196301307e+03 + 42580 1.065088104980157e+00 -5.905827321456213e+00 -6.053496952055626e+00 4.173146344428190e+00 4.325204473724882e+00 9.382000606709933e+03 + 42600 1.110726849030516e+00 -5.963482258473928e+00 -5.987768878407851e+00 3.872240737099930e+00 4.732783207097051e+00 9.179551944580515e+03 + 42620 1.016998793480920e+00 -5.822541413171299e+00 -6.071338753578992e+00 4.713017637532401e+00 4.284384807647430e+00 9.437335832875357e+03 + 42640 1.066244752559505e+00 -5.903895602348185e+00 -6.019248021202545e+00 4.247335254874660e+00 4.584963815083802e+00 9.276239700431386e+03 + 42660 1.081027945633833e+00 -5.942630700996448e+00 -6.031077445789465e+00 4.018714810026780e+00 4.510839914335754e+00 9.312685871615528e+03 + 42680 1.038063292140795e+00 -5.908983643964589e+00 -6.028002942312501e+00 4.211670447247101e+00 4.528243217956503e+00 9.303204358762274e+03 + 42700 1.082031923265650e+00 -6.014082045535000e+00 -5.982598932460260e+00 3.605764532970253e+00 4.786545440241409e+00 9.163706557541716e+03 + 42720 1.011859896809016e+00 -5.954250211172510e+00 -5.992452149923464e+00 3.976368186317063e+00 4.757006742278168e+00 9.193876066203089e+03 + 42740 1.027390251000291e+00 -6.016577719853741e+00 -5.997011822201324e+00 3.586777800312452e+00 4.699128212445505e+00 9.207875567660867e+03 + 42760 9.697578997095955e-01 -5.967398366347776e+00 -5.985271192173927e+00 3.942466793647224e+00 4.839838261942605e+00 9.171875532656077e+03 + 42780 9.633067978390820e-01 -5.978439089115927e+00 -5.983592336111089e+00 3.788002424318587e+00 4.758411682609971e+00 9.166727194400304e+03 + 42800 1.008996867402660e+00 -6.057265702962754e+00 -5.947484060659531e+00 3.382816984329076e+00 5.013200163088423e+00 9.056537845278130e+03 + 42820 1.018911092620731e+00 -6.075662191764621e+00 -6.000098374786870e+00 3.229967102013245e+00 4.663866232562378e+00 9.217375340561861e+03 + 42840 1.003105890662450e+00 -6.055117060275528e+00 -6.001047582897177e+00 3.408234328311061e+00 4.718709634642129e+00 9.220274730983625e+03 + 42860 9.672615644019225e-01 -6.004220101297392e+00 -6.001532311045519e+00 3.701219235402391e+00 4.716652942962838e+00 9.221740065193364e+03 + 42880 1.015683503043844e+00 -6.075310216958385e+00 -5.956781677650515e+00 3.298624148276561e+00 4.979233363214530e+00 9.084856608137448e+03 + 42900 1.009808615391457e+00 -6.062412694494778e+00 -5.976068028161517e+00 3.382221184095955e+00 4.878025619975473e+00 9.143717614111993e+03 + 42920 9.794227381019880e-01 -6.011515402940459e+00 -5.984747595585061e+00 3.683217858332802e+00 4.836922750472301e+00 9.170282117097307e+03 + 42940 1.052916159042598e+00 -6.112167943302873e+00 -5.969128496820080e+00 3.065382084793408e+00 4.886736721780418e+00 9.122539095326887e+03 + 42960 9.213120803418349e-01 -5.907659712131211e+00 -6.061781026341553e+00 4.117009997219257e+00 4.232021560827181e+00 9.407676871916061e+03 + 42980 9.417225819421294e-01 -5.926749276414959e+00 -6.058442559676235e+00 4.082244203920906e+00 4.326040991964937e+00 9.397322455333873e+03 + 43000 9.855884166263618e-01 -5.979520749275801e+00 -6.054085180366934e+00 3.782435190498028e+00 4.354274688364325e+00 9.383823894952056e+03 + 43020 9.857353844287875e-01 -5.966426902199837e+00 -6.043584696804329e+00 3.854368215945723e+00 4.411316219196603e+00 9.351322822945382e+03 + 43040 9.612942445836413e-01 -5.918388786996005e+00 -5.994720116888835e+00 4.151530525164696e+00 4.713224216684940e+00 9.200849917356105e+03 + 43060 1.039562901610203e+00 -6.019734400897181e+00 -5.954687362556194e+00 3.634412637742421e+00 5.007922797893023e+00 9.078468225207473e+03 + 43080 1.028872213108818e+00 -5.984616136580172e+00 -5.985206805469916e+00 3.734225381481463e+00 4.730833669310837e+00 9.171693531039129e+03 + 43100 9.714447703549064e-01 -5.878022917037397e+00 -6.027774578111709e+00 4.303063327019473e+00 4.443166115136115e+00 9.302511529595580e+03 + 43120 1.009363265081748e+00 -5.908735893642821e+00 -6.024151956299955e+00 4.175634104053409e+00 4.512897211698177e+00 9.291330841132378e+03 + 43140 1.011733658622763e+00 -5.887040898675773e+00 -6.028169448786929e+00 4.302339863077477e+00 4.491957888766673e+00 9.303717524590909e+03 + 43160 1.069889562765957e+00 -5.949567922296512e+00 -6.032960340836541e+00 3.952649898285121e+00 4.473797726093212e+00 9.318483084978807e+03 + 43180 1.054764798901262e+00 -5.903452160733655e+00 -6.013089788421342e+00 4.295986196545803e+00 4.666429971995053e+00 9.257255028094562e+03 + 43200 1.089718437014268e+00 -5.933969131944338e+00 -6.058016651890862e+00 3.988972761462446e+00 4.276672705637831e+00 9.395984590348708e+03 + 43220 1.099042537694096e+00 -5.933603085653615e+00 -6.044812251606356e+00 4.027365824086425e+00 4.388785583622972e+00 9.355128098225330e+03 + 43240 1.007905482674210e+00 -5.793162921171949e+00 -6.054843696653620e+00 4.868276490550345e+00 4.365664982765462e+00 9.386178830559598e+03 + 43260 1.120354232311159e+00 -5.965976458340519e+00 -6.049047936515929e+00 3.840967278123198e+00 4.363957995170294e+00 9.368225166893584e+03 + 43280 1.092929659085414e+00 -5.946500764579333e+00 -6.012742888412458e+00 3.958688845812282e+00 4.578316319826945e+00 9.256195765499962e+03 + 43300 9.765694001562393e-01 -5.809644083543629e+00 -6.039086324940750e+00 4.783774908858677e+00 4.466282052684305e+00 9.337398358450255e+03 + 43320 1.070229397839350e+00 -5.996067673363084e+00 -5.986490013944049e+00 3.733504175930114e+00 4.788500578452215e+00 9.175616139461574e+03 + 43340 1.007028008092816e+00 -5.954772546450101e+00 -5.986172412755456e+00 4.022984331027210e+00 4.842681439588256e+00 9.174645220745235e+03 + 43360 1.048487453247661e+00 -6.063787044919310e+00 -6.001423795738981e+00 3.335145777199364e+00 4.693245204674430e+00 9.221434412610854e+03 + 43380 9.924203262144021e-01 -6.018557912106583e+00 -5.992268880595923e+00 3.571682179778982e+00 4.722637866927673e+00 9.193335711314427e+03 + 43400 9.651766953882126e-01 -6.001937323645488e+00 -5.956824977154562e+00 3.750156503289786e+00 5.009198577953742e+00 9.084942091482477e+03 + 43420 9.788610416019633e-01 -6.035846476638532e+00 -5.989593853092829e+00 3.513150765765783e+00 4.778740487735577e+00 9.185126673935620e+03 + 43440 9.466708375159891e-01 -5.996693161448647e+00 -6.037953005938412e+00 3.692104096433871e+00 4.455183684433337e+00 9.333933826074028e+03 + 43460 1.006344577411656e+00 -6.091069321135167e+00 -5.952086699431738e+00 3.240196502523280e+00 5.038256223835571e+00 9.070570298816740e+03 + 43480 9.284671864802571e-01 -5.977216466226848e+00 -5.994955941822984e+00 3.806273845637731e+00 4.704411031589738e+00 9.201540473174287e+03 + 43500 9.658948653008970e-01 -6.030383517797573e+00 -6.002348192544491e+00 3.513158230343595e+00 4.674141406399356e+00 9.224256921645891e+03 + 43520 1.041033807531266e+00 -6.134278156520400e+00 -5.985261242065360e+00 3.033377133328295e+00 4.889055316422120e+00 9.171859536005655e+03 + 43540 9.780576303976380e-01 -6.032556472591097e+00 -5.988811637812262e+00 3.552872273415776e+00 4.804061884207149e+00 9.182736019074624e+03 + 43560 9.720885132391266e-01 -6.011957944334600e+00 -5.973775267045681e+00 3.689685999195297e+00 4.908936840938484e+00 9.136703832413843e+03 + 43580 9.581185088526128e-01 -5.974837162565745e+00 -6.000335544300717e+00 3.887444532255123e+00 4.741028878471090e+00 9.218075589733788e+03 + 43600 1.003208982563209e+00 -6.020713217299353e+00 -5.980020962141674e+00 3.565813277698870e+00 4.799474503920393e+00 9.155840524360072e+03 + 43620 1.043527526031882e+00 -6.057263023530650e+00 -5.949241374232569e+00 3.366202523352245e+00 4.986479549918029e+00 9.061880064299476e+03 + 43640 9.916185881538689e-01 -5.952811067569514e+00 -5.990981379873100e+00 3.956599927260279e+00 4.737420087176352e+00 9.189347686972453e+03 + 43660 1.005824587246789e+00 -5.941851412377247e+00 -6.022217049216708e+00 4.011251695548215e+00 4.549779772273923e+00 9.285384907293694e+03 + 43680 9.802469276624316e-01 -5.871508953760397e+00 -6.066604975921496e+00 4.383590383436105e+00 4.263318833175220e+00 9.422620003360018e+03 + 43700 1.064809773952180e+00 -5.970362271231091e+00 -5.999603255298528e+00 3.804641602580992e+00 4.636735347038105e+00 9.215822494598775e+03 + 43720 1.064757846544776e+00 -5.949161496153861e+00 -5.974213339129503e+00 3.964158039756744e+00 4.820306480630437e+00 9.138034631238736e+03 + 43740 9.405526236814010e-01 -5.747426783700574e+00 -6.056924909407880e+00 5.079914710424430e+00 4.302728577932912e+00 9.392590205644945e+03 + 43760 1.044001702577005e+00 -5.885668834235420e+00 -6.086100459012591e+00 4.234850119673330e+00 4.083940713509125e+00 9.483249291687025e+03 + 43780 1.163958302514048e+00 -6.059025509508929e+00 -5.965693810791828e+00 3.406828990168780e+00 4.942754047236075e+00 9.112049615852229e+03 + 43800 1.069578753618162e+00 -5.924309108727151e+00 -6.045664181960880e+00 4.046620251571325e+00 4.349780641426364e+00 9.357750784486801e+03 + 43820 9.620457549383710e-01 -5.781669773650566e+00 -6.070139940575446e+00 4.829145864380186e+00 4.172705525283460e+00 9.433582842283002e+03 + 43840 1.089844858159639e+00 -6.004982845300430e+00 -5.978569070317329e+00 3.661455074409039e+00 4.813127057880467e+00 9.151367200883018e+03 + 43860 1.006140403513889e+00 -5.936888316438480e+00 -6.005804277306826e+00 4.083025243613914e+00 4.687299131597399e+00 9.234868798007254e+03 + 43880 9.857843612052664e-01 -5.978124608208429e+00 -6.021489459527226e+00 3.872964419383463e+00 4.623956732421874e+00 9.283109277801921e+03 + 43900 1.022738189727191e+00 -6.093964597019404e+00 -5.981376735025766e+00 3.183331379486783e+00 4.829828305969592e+00 9.159965366697843e+03 + 43920 9.362141829411478e-01 -6.005394381027607e+00 -6.009460843950357e+00 3.668690125420588e+00 4.645339866035055e+00 9.246101499301567e+03 + 43940 9.685563455477814e-01 -6.073268383308911e+00 -5.946388715814756e+00 3.330981311556140e+00 5.059543996872662e+00 9.053201937517855e+03 + 43960 9.582888756498057e-01 -6.065096604206874e+00 -5.966937668651051e+00 3.404695912093398e+00 4.968339710101127e+00 9.115835140409694e+03 + 43980 9.948721632052105e-01 -6.121878076756802e+00 -6.003525923991470e+00 3.014139296121567e+00 4.693735672236558e+00 9.227881019462431e+03 + 44000 8.812858276267961e-01 -5.951208890310696e+00 -6.016288098644089e+00 4.032854663208322e+00 4.659159777983039e+00 9.267111095408794e+03 + 44020 9.663925747396327e-01 -6.068769760164962e+00 -5.982080585712612e+00 3.369519278046887e+00 4.867301932858670e+00 9.162128784886012e+03 + 44040 9.473539398936086e-01 -6.025455408593505e+00 -6.014184973843987e+00 3.562498704057485e+00 4.627215284483359e+00 9.260644668329374e+03 + 44060 9.645504427941417e-01 -6.033389883668572e+00 -6.026293562999927e+00 3.545802170324095e+00 4.586550341755529e+00 9.297936422098312e+03 + 44080 9.391670525371489e-01 -5.975219014311142e+00 -6.034115028793831e+00 3.837462510864262e+00 4.499272481575876e+00 9.322067825334711e+03 + 44100 9.858386589854530e-01 -6.019562695395479e+00 -6.013256327582117e+00 3.619229421012079e+00 4.655441560903668e+00 9.257792112720650e+03 + 44120 9.742495657799140e-01 -5.977262087216030e+00 -6.010749447821178e+00 3.874079463747125e+00 4.681789857000064e+00 9.250048926096901e+03 + 44140 9.894787686991104e-01 -5.973553283072056e+00 -5.997159716524340e+00 3.853865744955732e+00 4.718313950988950e+00 9.208309572573469e+03 + 44160 1.074636634353342e+00 -6.071948002018575e+00 -5.983400403547649e+00 3.334731425298190e+00 4.843185438414822e+00 9.166162975091784e+03 + 44180 1.070749408182293e+00 -6.040929769143416e+00 -5.999699840561383e+00 3.474843430876004e+00 4.711592061104864e+00 9.216131226961439e+03 + 44200 9.964267126522937e-01 -5.913569371791747e+00 -6.049811834586341e+00 4.162746807702041e+00 4.380421502882506e+00 9.370588034073644e+03 + 44220 1.051931151642445e+00 -5.982390447766749e+00 -6.038465168608285e+00 3.856617670713463e+00 4.534627946106357e+00 9.335492925427960e+03 + 44240 1.016642713952556e+00 -5.921726043395908e+00 -6.046212058135279e+00 4.091694410446729e+00 4.376876449664736e+00 9.359461358869670e+03 + 44260 9.845303047950128e-01 -5.871439821091347e+00 -6.075488456481746e+00 4.362297796998889e+00 4.190618956162946e+00 9.450246258460640e+03 + 44280 1.080285169510756e+00 -6.015978497011445e+00 -6.002740492067423e+00 3.648104032780537e+00 4.724118705743758e+00 9.225473262072785e+03 + 44300 1.057007101838462e+00 -5.988876935096083e+00 -5.982589574925147e+00 3.790251150491378e+00 4.826354145558731e+00 9.163663587278197e+03 + 44320 1.051795615660847e+00 -5.995887512553033e+00 -6.005913283423994e+00 3.707813404616350e+00 4.650243876792262e+00 9.235217173633077e+03 + 44340 1.067825004250726e+00 -6.042960720101517e+00 -5.968973666929173e+00 3.503431900439403e+00 4.928277009214479e+00 9.122035744020388e+03 + 44360 9.345108827749478e-01 -5.879135270754245e+00 -6.022071170464722e+00 4.312611003947030e+00 4.491850948550484e+00 9.284900409287862e+03 + 44380 9.580392495788697e-01 -5.952747997575289e+00 -5.981802754423112e+00 3.906417996530034e+00 4.739581086500737e+00 9.161262921427840e+03 + 44400 9.692811804215858e-01 -6.011680292817529e+00 -6.025265214116546e+00 3.575896413106912e+00 4.497889692748176e+00 9.294778858620964e+03 + 44420 9.862943249235504e-01 -6.083992945386333e+00 -5.999474733696709e+00 3.263519937757733e+00 4.748836588430541e+00 9.215447857950710e+03 + 44440 9.180248520107875e-01 -6.022330053161623e+00 -5.950145247484567e+00 3.570126974094315e+00 4.984623298854546e+00 9.064608422525127e+03 + 44460 9.075042992485742e-01 -6.029206980190381e+00 -5.936951873371823e+00 3.590159269252150e+00 5.119902369035948e+00 9.024483376685599e+03 + 44480 8.787914153045366e-01 -5.995562435694159e+00 -5.991862833610344e+00 3.724480174594780e+00 4.745723862271623e+00 9.192095630350386e+03 + 44500 9.412915603594164e-01 -6.089498574883559e+00 -5.972910825570800e+00 3.254101728303159e+00 4.923566626752922e+00 9.134077948399818e+03 + 44520 9.466368086470168e-01 -6.091498045231331e+00 -5.963513718378957e+00 3.208919803552279e+00 4.943825613849187e+00 9.105399999621393e+03 + 44540 9.753666376690198e-01 -6.124081091865690e+00 -5.997624275761602e+00 3.041843075196632e+00 4.767977682395355e+00 9.209741607866175e+03 + 44560 8.970753642493564e-01 -5.995132491193459e+00 -5.982459923854775e+00 3.793224498253251e+00 4.865992340985430e+00 9.163293611479568e+03 + 44580 9.666043113935887e-01 -6.082063922425714e+00 -6.018582361114783e+00 3.288857303793943e+00 4.653378252581176e+00 9.274178417064819e+03 + 44600 9.468609768333022e-01 -6.034507858740603e+00 -6.024091045916951e+00 3.493604374034903e+00 4.553419325264889e+00 9.291164512147703e+03 + 44620 9.958381614922389e-01 -6.089514192029075e+00 -5.975600424970306e+00 3.203384114631825e+00 4.857494593181758e+00 9.142311797430650e+03 + 44640 9.233974615673123e-01 -5.965890922835316e+00 -5.967924618866277e+00 3.864135944110019e+00 4.852458146786796e+00 9.118807111953023e+03 + 44660 9.898214237033504e-01 -6.046321825790858e+00 -5.927052039407196e+00 3.403571137162535e+00 5.088436707517312e+00 8.994474223419640e+03 + 44680 1.002724541416857e+00 -6.042798102702641e+00 -5.980703485180562e+00 3.493306014563168e+00 4.849862917485952e+00 9.157894205902281e+03 + 44700 1.017978788304509e+00 -6.043260438459244e+00 -5.976539277138976e+00 3.473955363401504e+00 4.857078596768835e+00 9.145161332342421e+03 + 44720 1.000917203147050e+00 -5.998676550566827e+00 -5.980365534164418e+00 3.664019636236721e+00 4.769164326039989e+00 9.156854297766882e+03 + 44740 1.034640999756745e+00 -6.030340068901805e+00 -5.991491589630547e+00 3.518541523901922e+00 4.741615503660223e+00 9.190946137304223e+03 + 44760 1.052876454679555e+00 -6.043168042149782e+00 -5.975606019365843e+00 3.453917029734435e+00 4.841868619749046e+00 9.142333488094706e+03 + 44780 1.062035385166670e+00 -6.047538733711193e+00 -5.965813528672947e+00 3.448941634711743e+00 4.918220408975960e+00 9.112380358249826e+03 + 44800 1.028427290644999e+00 -5.990256810801812e+00 -5.973176840462040e+00 3.719023581663994e+00 4.817099414471830e+00 9.134876028247245e+03 + 44820 1.021143156304588e+00 -5.972040408855851e+00 -6.024370424327754e+00 3.842167697432964e+00 4.541680650549579e+00 9.292005167600269e+03 + 44840 9.797831565956688e-01 -5.907718647100344e+00 -6.046522808885214e+00 4.154322892563817e+00 4.357287915720474e+00 9.360414851469333e+03 + 44860 1.047207738342289e+00 -6.008408722014805e+00 -6.004259783059863e+00 3.585669347864028e+00 4.609493197389527e+00 9.230126253655106e+03 + 44880 1.032885068059796e+00 -5.989309320781781e+00 -5.964012206992233e+00 3.756887859617767e+00 4.902147801713054e+00 9.106906953868765e+03 + 44900 9.742137276748365e-01 -5.906187235908261e+00 -6.004276113258017e+00 4.181737758243695e+00 4.618496245296682e+00 9.230168737628552e+03 + 44920 1.018927414665056e+00 -5.978199525017322e+00 -5.996888920725350e+00 3.874705745423971e+00 4.767388343093831e+00 9.207482985054476e+03 + 44940 1.015246911976009e+00 -5.982315768873700e+00 -5.984580411971868e+00 3.760613236060390e+00 4.747609304938325e+00 9.169756896038012e+03 + 44960 1.000256293987012e+00 -5.974341711315319e+00 -6.006303332250539e+00 3.791710004283465e+00 4.608181430828576e+00 9.236415713138043e+03 + 44980 9.688163352953100e-01 -5.950858863487516e+00 -6.039397263101238e+00 3.996091334914468e+00 4.487690143059422e+00 9.338383399861024e+03 + 45000 1.012490814208620e+00 -6.052480556378592e+00 -5.994549665325588e+00 3.380536226654416e+00 4.713184367857185e+00 9.200354806722326e+03 + 45020 9.384397688144034e-01 -5.990292865176651e+00 -5.966286855327747e+00 3.868108227539600e+00 5.005954451010030e+00 9.113840852834359e+03 + 45040 9.937071823285228e-01 -6.121849851099979e+00 -5.967411616358513e+00 3.073143990549654e+00 4.959952233674739e+00 9.117287546768328e+03 + 45060 9.241818290028179e-01 -6.060636907994091e+00 -5.989700191011669e+00 3.389288516265629e+00 4.796618122600176e+00 9.185453211267561e+03 + 45080 9.180556172202337e-01 -6.079246325312653e+00 -5.986428904232179e+00 3.315798041362240e+00 4.848770036655815e+00 9.175447308122473e+03 + 45100 9.146967023012197e-01 -6.090126142908416e+00 -6.009479573837732e+00 3.172785652362198e+00 4.635870731982302e+00 9.246195044017228e+03 + 45120 8.790110674681033e-01 -6.043310564796167e+00 -6.005907097981031e+00 3.454466998650526e+00 4.669243493270822e+00 9.235195073673145e+03 + 45140 8.990805665922766e-01 -6.069567187973347e+00 -6.016512685890336e+00 3.282302754978150e+00 4.586949916096462e+00 9.267822561500690e+03 + 45160 9.534327503543956e-01 -6.139046697256854e+00 -5.979630007921754e+00 2.947763008790535e+00 4.863158308605620e+00 9.154628169732496e+03 + 45180 9.386456963401496e-01 -6.098586737077786e+00 -5.982857897407317e+00 3.229892701862753e+00 4.894425608230649e+00 9.164497392388686e+03 + 45200 9.471612112431129e-01 -6.084200984017709e+00 -5.994972231933249e+00 3.287301289258857e+00 4.799666591832586e+00 9.201617726127912e+03 + 45220 9.545434700718303e-01 -6.065750783026310e+00 -5.945561520674956e+00 3.365368500067442e+00 5.055513843717156e+00 9.050689041048025e+03 + 45240 9.412207448961252e-01 -6.013312804178008e+00 -5.960951425553833e+00 3.641999549141528e+00 4.942666688098695e+00 9.097551293446386e+03 + 45260 9.440863842385909e-01 -5.983741830988457e+00 -6.014577454858655e+00 3.728155193885210e+00 4.551092269825158e+00 9.261860516371100e+03 + 45280 9.869658441355642e-01 -6.018859352098182e+00 -5.971963124362786e+00 3.606652905413969e+00 4.875938302238403e+00 9.131189071781915e+03 + 45300 9.878299611509158e-01 -5.999099001241337e+00 -6.034001511616307e+00 3.704682773476352e+00 4.504267157757252e+00 9.321711960510256e+03 + 45320 1.031415799924680e+00 -6.047823451453051e+00 -6.000569035341492e+00 3.438366307212902e+00 4.709708477122735e+00 9.218797438172247e+03 + 45340 1.010914675123077e+00 -6.005728016171169e+00 -5.993233454076048e+00 3.652816160420864e+00 4.724561869498284e+00 9.196297913249677e+03 + 45360 9.975160797140851e-01 -5.977272740356423e+00 -6.022890737260060e+00 3.781394172747194e+00 4.519448575164301e+00 9.287442029450287e+03 + 45380 1.082728471838291e+00 -6.097563413507556e+00 -5.965368341916173e+00 3.166528089933184e+00 4.925612648132118e+00 9.111057729508904e+03 + 45400 9.755272569129608e-01 -5.934311682427934e+00 -5.967657443750031e+00 4.104115285458045e+00 4.912638763706675e+00 9.118025490303109e+03 + 45420 9.391839371617032e-01 -5.876842294057242e+00 -6.013118521249432e+00 4.314603746123105e+00 4.532084560907554e+00 9.257360199842173e+03 + 45440 1.033320989479615e+00 -6.011232704797253e+00 -6.003901973462219e+00 3.638868029890878e+00 4.680962223643649e+00 9.229027972481143e+03 + 45460 9.563045951833427e-01 -5.894000746230800e+00 -6.023031399095570e+00 4.352318628444947e+00 4.611404652266436e+00 9.287879129089550e+03 + 45480 9.792533089199749e-01 -5.926414000856242e+00 -6.033206556373838e+00 4.110054899142852e+00 4.496835519266262e+00 9.319270458012255e+03 + 45500 1.006767306387336e+00 -5.967567606658127e+00 -5.997453025343203e+00 3.901932168028996e+00 4.730325469185693e+00 9.209221919057627e+03 + 45520 1.045431379468022e+00 -6.026236867411924e+00 -5.978857168032363e+00 3.592884867991921e+00 4.864946433814145e+00 9.152263437509448e+03 + 45540 1.063508748461823e+00 -6.057348118821127e+00 -6.006286427335123e+00 3.399541534722139e+00 4.692745669005996e+00 9.236359969647974e+03 + 45560 1.051730673850795e+00 -6.049379654135849e+00 -5.996302908938295e+00 3.425646528686637e+00 4.730421413210764e+00 9.205709139730800e+03 + 45580 1.012158087849991e+00 -6.005367775858308e+00 -5.979639567766746e+00 3.646690702777690e+00 4.794426055066771e+00 9.154644193466054e+03 + 45600 9.641342206059555e-01 -5.953872165778787e+00 -6.007493941899318e+00 3.980266536469649e+00 4.672362000042526e+00 9.240048323655557e+03 + 45620 9.078641938389592e-01 -5.895874323974700e+00 -6.037757267559245e+00 4.211121801379113e+00 4.396407983002102e+00 9.333311948713354e+03 + 45640 1.029236124369201e+00 -6.106627490681957e+00 -6.001490368124148e+00 3.125294852778225e+00 4.729008480422292e+00 9.221640486755805e+03 + 45660 9.594873779953137e-01 -6.040940636588982e+00 -5.997509947113625e+00 3.489167625051121e+00 4.738553364896093e+00 9.209410790955992e+03 + 45680 9.229579082320878e-01 -6.020188191222548e+00 -5.995453390887203e+00 3.605267449957891e+00 4.747298501181426e+00 9.203088576243485e+03 + 45700 9.419180263000987e-01 -6.075607732277621e+00 -5.983335401542961e+00 3.335818095320405e+00 4.865660097495859e+00 9.165940527168745e+03 + 45720 9.883207622807989e-01 -6.163588820060426e+00 -5.957848250433922e+00 2.885443120645865e+00 5.066837309691505e+00 9.088109346751047e+03 + 45740 9.671820414472504e-01 -6.145297972705142e+00 -5.984417749810165e+00 2.921493552356378e+00 4.845292688353373e+00 9.169283233715141e+03 + 45760 9.256196733108053e-01 -6.089818405445142e+00 -5.969834475767723e+00 3.267656999285820e+00 4.956623290946668e+00 9.124664716577508e+03 + 45780 9.118956976146638e-01 -6.066981782586877e+00 -5.947557274097925e+00 3.354570381595945e+00 5.040324390222467e+00 9.056759679772733e+03 + 45800 9.457176407747767e-01 -6.104275191926196e+00 -5.983711252844587e+00 3.119069080228171e+00 4.811365875644039e+00 9.167111425202595e+03 + 45820 8.672888030658787e-01 -5.964675298039786e+00 -6.018966085109875e+00 3.881123883320145e+00 4.569377782491546e+00 9.275364643142202e+03 + 45840 9.319206186037998e-01 -6.026685518017505e+00 -5.969289965256503e+00 3.548362561726094e+00 4.877936707612852e+00 9.122994827038228e+03 + 45860 9.999444371690510e-01 -6.083415173254644e+00 -5.995530204679047e+00 3.260144207489703e+00 4.764793297205715e+00 9.203341744709260e+03 + 45880 9.873639001703219e-01 -6.020957341017670e+00 -6.032501518188918e+00 3.552025963425794e+00 4.485737511652842e+00 9.317102841770158e+03 + 45900 9.526490890931942e-01 -5.936037978399916e+00 -6.025237821973733e+00 4.028218817954316e+00 4.516019512522271e+00 9.294697219705924e+03 + 45920 1.004520561569255e+00 -5.986284490530764e+00 -6.002307637550048e+00 3.774801545209757e+00 4.682794155451035e+00 9.224144274326036e+03 + 45940 9.762030993382927e-01 -5.928795711847954e+00 -5.972617575583434e+00 4.087082334600895e+00 4.835450411620275e+00 9.133167602222009e+03 + 45960 9.540690831396690e-01 -5.884338191508696e+00 -6.022403118576884e+00 4.347023285159613e+00 4.554233108455665e+00 9.285919407591409e+03 + 45980 1.062739777398188e+00 -6.037089448320698e+00 -6.017177498227081e+00 3.502757512089262e+00 4.617095010891124e+00 9.269858974749017e+03 + 46000 1.020963022017415e+00 -5.972748834570328e+00 -6.040429840506185e+00 3.862944273255102e+00 4.474309463569588e+00 9.341575830699074e+03 + 46020 1.027963784569119e+00 -5.985740554848860e+00 -6.010283498574060e+00 3.755359224508638e+00 4.614429843630278e+00 9.248646775011934e+03 + 46040 1.048956103242619e+00 -6.021995274815933e+00 -5.989392378783410e+00 3.609845618287060e+00 4.797056492587661e+00 9.184503167807448e+03 + 46060 1.005356645796176e+00 -5.964069636436132e+00 -6.000928314473772e+00 3.919737515338084e+00 4.708089282183961e+00 9.219875522840550e+03 + 46080 9.323918296339031e-01 -5.862882305775512e+00 -6.009504758880304e+00 4.464767627691593e+00 4.622838812212589e+00 9.246215929008975e+03 + 46100 9.973349805006587e-01 -5.965407420334003e+00 -5.998639421608392e+00 3.886520345569196e+00 4.695697051616074e+00 9.212868862201372e+03 + 46120 1.068157054576131e+00 -6.078236209236966e+00 -6.003683008484436e+00 3.270378667565696e+00 4.698474683357255e+00 9.228347903997574e+03 + 46140 1.093878429736254e+00 -6.128084809187810e+00 -5.967000226911114e+00 3.004067770831234e+00 4.929040370022566e+00 9.116021686894592e+03 + 46160 9.406423084938089e-01 -5.914781159740396e+00 -6.040601005182938e+00 4.159330502393846e+00 4.436853479304611e+00 9.342113268594985e+03 + 46180 9.909501269202274e-01 -6.006352308262564e+00 -5.979203285519281e+00 3.692856304650706e+00 4.848750194540333e+00 9.153324715002755e+03 + 46200 9.763754215758450e-01 -6.003016644003488e+00 -5.966022954520849e+00 3.681584856072269e+00 4.894008345836527e+00 9.113019647935504e+03 + 46220 9.871506804335261e-01 -6.037559822916059e+00 -5.982228187457708e+00 3.436322200531989e+00 4.754045013876754e+00 9.162592328479370e+03 + 46240 1.026124339759903e+00 -6.113076825044221e+00 -5.990444262352725e+00 3.102815577564309e+00 4.806990729866623e+00 9.187751278846728e+03 + 46260 9.795726000966996e-01 -6.065037040581744e+00 -5.990747444372520e+00 3.346693606725991e+00 4.773275964437214e+00 9.188665064374978e+03 + 46280 9.732041528505415e-01 -6.080400196326169e+00 -5.994575508667040e+00 3.237876011692217e+00 4.730694649558426e+00 9.200408824626300e+03 + 46300 9.535864791615533e-01 -6.076032081169933e+00 -5.966233780580316e+00 3.243825685060262e+00 4.874304518277945e+00 9.113697206338329e+03 + 46320 9.831477007789183e-01 -6.143027151958571e+00 -5.987764004403665e+00 2.858425824191525e+00 4.749970844346224e+00 9.179543857571201e+03 + 46340 8.840794537074395e-01 -6.017162732002744e+00 -6.011200815302601e+00 3.566731516670454e+00 4.600965764966300e+00 9.251465951247434e+03 + 46360 9.215831641171551e-01 -6.087780677171402e+00 -5.973639562928353e+00 3.189925088598067e+00 4.845341029862000e+00 9.136300636941236e+03 + 46380 9.413285646055011e-01 -6.125852613752862e+00 -5.955657122401188e+00 3.034813958227390e+00 5.012102807235870e+00 9.081446363294686e+03 + 46400 9.467807511163978e-01 -6.137087727582617e+00 -5.945042294976322e+00 2.980339020428794e+00 5.083093613388787e+00 9.049128469448957e+03 + 46420 9.041692148956698e-01 -6.069464709411212e+00 -5.965744862335880e+00 3.318095838629630e+00 4.913671251130653e+00 9.112174294181776e+03 + 46440 9.034911155704513e-01 -6.050697040588094e+00 -5.953959287943753e+00 3.432792336058834e+00 4.988275481861482e+00 9.076264538618645e+03 + 46460 9.953827332168000e-01 -6.148896708649717e+00 -5.995934810765988e+00 2.922815800807355e+00 4.801146689232931e+00 9.204591302435196e+03 + 46480 9.343110376999673e-01 -6.009995390809857e+00 -6.027668286870279e+00 3.627808934827486e+00 4.526328430776720e+00 9.302183219583019e+03 + 46500 1.015940851905577e+00 -6.082639199772971e+00 -6.005172293184331e+00 3.268806740112848e+00 4.713633705709871e+00 9.232946175046844e+03 + 46520 1.015648480414979e+00 -6.038688530112188e+00 -6.004531990356327e+00 3.506547715368419e+00 4.702679852354018e+00 9.230983955130196e+03 + 46540 9.811057273684646e-01 -5.954752608204160e+00 -5.984956557308050e+00 3.966178048633707e+00 4.792742298833151e+00 9.170942977065766e+03 + 46560 1.047135335624176e+00 -6.028647046293909e+00 -6.020569577027071e+00 3.544252664715519e+00 4.590634743230033e+00 9.280279880335143e+03 + 46580 1.045014339727521e+00 -6.009616662029691e+00 -5.966742692746122e+00 3.680737863739039e+00 4.926926830090594e+00 9.115237599151318e+03 + 46600 1.006401248211502e+00 -5.942494787424208e+00 -5.989417904250526e+00 4.029918617473870e+00 4.760478819328289e+00 9.184551857896256e+03 + 46620 1.082801420777409e+00 -6.046729960712536e+00 -5.978367111575920e+00 3.419005142280340e+00 4.811555201139500e+00 9.150746983682458e+03 + 46640 1.046440370234582e+00 -5.989150303563857e+00 -5.983135197551691e+00 3.778418870748603e+00 4.812958540305108e+00 9.165358084843499e+03 + 46660 9.977993408414125e-01 -5.916217559683911e+00 -5.975323403247982e+00 4.240328303286638e+00 4.900933402942011e+00 9.141414814707767e+03 + 46680 1.040231228089488e+00 -5.979337037411538e+00 -5.981770410078218e+00 3.828092246301369e+00 4.814119443886090e+00 9.161181330048090e+03 + 46700 1.007139961581707e+00 -5.932853574630323e+00 -6.002666311257356e+00 4.077866955468509e+00 4.676991418270009e+00 9.225253569344341e+03 + 46720 9.866841240158226e-01 -5.910072038234613e+00 -5.991904834001801e+00 4.137927202599899e+00 4.668030625720489e+00 9.192221374563449e+03 + 46740 1.024419933595225e+00 -5.976636776749624e+00 -5.987727326644626e+00 3.828612212800123e+00 4.764928559045971e+00 9.179417284881796e+03 + 46760 1.022621456720817e+00 -5.988650543676046e+00 -5.975043229984429e+00 3.760890125403921e+00 4.839025426346177e+00 9.140593528661237e+03 + 46780 1.013342617052789e+00 -5.993967388018976e+00 -5.998254504249125e+00 3.689151739729316e+00 4.664534454906701e+00 9.211649173226680e+03 + 46800 9.406972013630015e-01 -5.910732258738662e+00 -5.957608704686020e+00 4.269900103361152e+00 5.000728296624859e+00 9.087304988841794e+03 + 46820 9.253991189727901e-01 -5.911817463941821e+00 -5.997474068725601e+00 4.135801527985884e+00 4.643948048000671e+00 9.209189207540836e+03 + 46840 9.495499289997092e-01 -5.971583739505072e+00 -5.962008792206369e+00 3.848381341847178e+00 4.903362170954635e+00 9.100769085574173e+03 + 46860 9.835402830064687e-01 -6.045193549429879e+00 -5.979914763813802e+00 3.433950840834594e+00 4.808791729701530e+00 9.155497486859567e+03 + 46880 1.006480657200789e+00 -6.105291528359811e+00 -5.983883379966617e+00 3.135387995339076e+00 4.832532371263041e+00 9.167642756992263e+03 + 46900 1.005989799082645e+00 -6.130553249582472e+00 -5.969959870887336e+00 3.001229962906092e+00 4.923381995118600e+00 9.125076082263080e+03 + 46920 9.354942900297968e-01 -6.051369676001597e+00 -5.989340727694563e+00 3.409708369150042e+00 4.765888189277762e+00 9.184350499019432e+03 + 46940 9.571759278278926e-01 -6.107399849658945e+00 -5.944734646744908e+00 3.184792080378379e+00 5.118840847869578e+00 9.048166831767099e+03 + 46960 8.884410813723453e-01 -6.023337042973017e+00 -5.994088395308106e+00 3.545063365142646e+00 4.713013626248165e+00 9.198914290974157e+03 + 46980 9.994209576959663e-01 -6.200916551139206e+00 -5.942383555079437e+00 2.623733078463889e+00 5.108269549690923e+00 9.041034989969448e+03 + 47000 9.048924344896305e-01 -6.068198848036551e+00 -5.982710947087128e+00 3.333789602119106e+00 4.824674358580615e+00 9.164060064489571e+03 + 47020 9.022082676976292e-01 -6.064315326273661e+00 -6.004078382003197e+00 3.300439011585763e+00 4.646328867223768e+00 9.229587873110451e+03 + 47040 9.094386568524275e-01 -6.065104956806762e+00 -5.986712481817070e+00 3.379280771807575e+00 4.829422494394683e+00 9.176292255497148e+03 + 47060 9.372806943697500e-01 -6.082224632527324e+00 -5.958533026988959e+00 3.219996297905577e+00 4.930252638120964e+00 9.090205987137957e+03 + 47080 1.005825018442195e+00 -6.139227153474851e+00 -5.965559823927262e+00 2.968175348598013e+00 4.965400029792663e+00 9.111632140354877e+03 + 47100 9.602690126834865e-01 -6.016470349030674e+00 -5.998943226787715e+00 3.588140037087828e+00 4.688783485320300e+00 9.213811092607086e+03 + 47120 1.077369802040138e+00 -6.136313415437977e+00 -5.994754531609552e+00 2.965686640562286e+00 4.778539657671575e+00 9.200974089976511e+03 + 47140 1.022360364285776e+00 -6.014484514312829e+00 -6.038747628258127e+00 3.622180266487102e+00 4.482857711508451e+00 9.336402481985124e+03 + 47160 9.750054539400601e-01 -5.918939839122796e+00 -5.997986344740263e+00 4.145960521433231e+00 4.692063253770526e+00 9.210844082905645e+03 + 47180 9.770425299249131e-01 -5.902240173505994e+00 -6.016485832554844e+00 4.171120175053873e+00 4.515103921336775e+00 9.267716727361012e+03 + 47200 1.042880643382362e+00 -5.984786437799109e+00 -6.019214878265588e+00 3.776056148970479e+00 4.578362716028010e+00 9.276118861080357e+03 + 47220 1.049966726563626e+00 -5.985731268311301e+00 -5.994940330978475e+00 3.805394409305115e+00 4.752514546372356e+00 9.201521299452243e+03 + 47240 1.046729562768386e+00 -5.975784707670146e+00 -6.012150665523056e+00 3.829236461148441e+00 4.620417503543243e+00 9.254383057825149e+03 + 47260 9.885622821095597e-01 -5.888166610602957e+00 -6.022276938579101e+00 4.382975609395660e+00 4.612893352650455e+00 9.285551479891023e+03 + 47280 1.007395386992249e+00 -5.920363874256920e+00 -6.033090773719228e+00 4.104835112712472e+00 4.457539811568588e+00 9.318904927161173e+03 + 47300 1.105250273399454e+00 -6.072108888440662e+00 -6.028826513677112e+00 3.309981251301874e+00 4.558515345120023e+00 9.305730392774934e+03 + 47320 1.019643868359667e+00 -5.958694198494824e+00 -6.042734853322168e+00 3.895753142021983e+00 4.413178696754066e+00 9.348703379795275e+03 + 47340 1.018901844016925e+00 -5.977439389102992e+00 -5.979694276889362e+00 3.828839934908886e+00 4.815892020296798e+00 9.154821670475381e+03 + 47360 1.002497852038758e+00 -5.975169378143097e+00 -6.023041299554956e+00 3.813313063089951e+00 4.538425082187155e+00 9.287917118401121e+03 + 47380 9.969815058293452e-01 -5.994275500505179e+00 -6.024247417506624e+00 3.689792532491452e+00 4.517689146929989e+00 9.291647317097661e+03 + 47400 9.795687999842789e-01 -5.998353769878118e+00 -5.990710330428561e+00 3.749393741391908e+00 4.793283553529696e+00 9.188536709405673e+03 + 47420 9.769866577145389e-01 -6.018717153286136e+00 -5.990835138627098e+00 3.574225467214259e+00 4.734328310114280e+00 9.188936979984312e+03 + 47440 1.063172253302256e+00 -6.172196493171925e+00 -5.974919964633603e+00 2.797443558861278e+00 4.930235914172451e+00 9.140247735584557e+03 + 47460 9.903920403112663e-01 -6.089655469505608e+00 -5.997173219407301e+00 3.181145446837796e+00 4.712192838484224e+00 9.208377972953915e+03 + 47480 9.782945869619735e-01 -6.093812767214379e+00 -5.965551183264351e+00 3.174681180970379e+00 4.911179044427406e+00 9.111584480296448e+03 + 47500 9.286992735093607e-01 -6.035056952410013e+00 -5.943302157798513e+00 3.503543397912994e+00 5.030413627580801e+00 9.043803750429672e+03 + 47520 9.739906559981634e-01 -6.107913650382809e+00 -5.961320597142355e+00 3.164515405292881e+00 5.006275402201242e+00 9.098699659012667e+03 + 47540 9.904432276151047e-01 -6.131762705598763e+00 -6.013410340247582e+00 2.970483781792212e+00 4.650081378608037e+00 9.258265853956960e+03 + 47560 9.261446561691918e-01 -6.033043256406757e+00 -5.983615441243993e+00 3.557447079894920e+00 4.841269243489194e+00 9.166806477704189e+03 + 47580 9.289477494024367e-01 -6.024625695380096e+00 -5.984669464417010e+00 3.596078142013695e+00 4.825513003410498e+00 9.170037175937663e+03 + 47600 1.000366366594155e+00 -6.107120322597730e+00 -5.959694507804146e+00 3.156739374236671e+00 5.003281216852535e+00 9.093735465981497e+03 + 47620 1.002796547002488e+00 -6.071494863645189e+00 -5.952591463865019e+00 3.335648553216884e+00 5.018410274996267e+00 9.072089968133110e+03 + 47640 9.373775504373838e-01 -5.914263483875070e+00 -6.013808689475193e+00 4.198110816315148e+00 4.626506841188462e+00 9.259448048776127e+03 + 47660 1.007748431883514e+00 -5.951334135508383e+00 -6.045264536716248e+00 3.870123486943938e+00 4.330760587525770e+00 9.356526032886404e+03 + 47680 1.022005068055484e+00 -5.918122679902829e+00 -6.030472401126179e+00 4.144301126603910e+00 4.499171641276268e+00 9.310803143206054e+03 + 47700 1.067105217600717e+00 -5.957266617592960e+00 -6.019871478304047e+00 3.889974613457970e+00 4.530487815184018e+00 9.278152146674389e+03 + 47720 1.054149277701265e+00 -5.926651415342807e+00 -6.036910140895960e+00 4.078250512337079e+00 4.445127847728236e+00 9.330610861090601e+03 + 47740 1.058220972448187e+00 -5.928699046505205e+00 -6.027203243087479e+00 4.047226099020934e+00 4.481599758770361e+00 9.300727299279804e+03 + 47760 9.963685687881559e-01 -5.839878499833597e+00 -6.094957752583306e+00 4.496651858965694e+00 4.031947316290077e+00 9.510854025027411e+03 + 47780 1.050761807344330e+00 -5.931915254025816e+00 -6.044607444086711e+00 4.060071772051559e+00 4.412975777661846e+00 9.354509743271803e+03 + 47800 9.877276688890052e-01 -5.859950378180331e+00 -6.046912537721312e+00 4.380960340616179e+00 4.307394688231187e+00 9.361629033539761e+03 + 47820 1.069685900751422e+00 -6.005214606730344e+00 -5.999545340657246e+00 3.673867325278940e+00 4.706421128386760e+00 9.215591986955926e+03 + 47840 9.882713189805953e-01 -5.910171544416615e+00 -6.017529900525689e+00 4.179678530860320e+00 4.563210236430101e+00 9.270900921354114e+03 + 47860 9.854241588984639e-01 -5.932095107778496e+00 -6.010433117871860e+00 4.070586299076745e+00 4.620757322352767e+00 9.249102124739755e+03 + 47880 1.005352433022166e+00 -5.989648877612485e+00 -6.006252992100376e+00 3.778773945933656e+00 4.683430551065770e+00 9.236253319586222e+03 + 47900 1.020500891272819e+00 -6.039576917173575e+00 -6.008712618956436e+00 3.489166766846865e+00 4.666394343444388e+00 9.243806099825093e+03 + 47920 9.789809318956370e-01 -6.001456026827020e+00 -6.032199767323288e+00 3.682014688839706e+00 4.505479373331667e+00 9.316165977747123e+03 + 47940 9.613373996530664e-01 -5.997282214069291e+00 -6.049028852447599e+00 3.673248158307167e+00 4.376110952972507e+00 9.368184202133260e+03 + 47960 9.247583417472751e-01 -5.963388635293611e+00 -6.023001713506212e+00 3.863641367986834e+00 4.521333847796037e+00 9.287785287729701e+03 + 47980 9.377691817699972e-01 -5.997439821192891e+00 -5.948722285391337e+00 3.711680087008733e+00 4.991423716595561e+00 9.060307898080857e+03 + 48000 9.789455327289253e-01 -6.066492609161951e+00 -6.005033992573453e+00 3.273858586483679e+00 4.626763473625015e+00 9.232512814284797e+03 + 48020 9.773074730916494e-01 -6.068637679546150e+00 -5.967640908594759e+00 3.334626969261021e+00 4.914566057263700e+00 9.117973237519871e+03 + 48040 9.862237022550798e-01 -6.081036250597179e+00 -5.967153463017617e+00 3.285099611454668e+00 4.939032201040936e+00 9.116490844501639e+03 + 48060 9.521682271228036e-01 -6.022418473374762e+00 -6.029612625622993e+00 3.545597093178410e+00 4.504287157677606e+00 9.308187555094994e+03 + 48080 9.671558942355183e-01 -6.034799232417035e+00 -5.987890160853269e+00 3.528729157335678e+00 4.798088305410189e+00 9.179915250772046e+03 + 48100 9.313570624955759e-01 -5.964967316259814e+00 -6.033863798240884e+00 3.862257494132238e+00 4.466643232900800e+00 9.321294848784506e+03 + 48120 9.711197845805525e-01 -6.000656197293629e+00 -6.026230309756020e+00 3.691437160374510e+00 4.544586649034346e+00 9.297734511157796e+03 + 48140 9.668363590740046e-01 -5.964171539616084e+00 -5.999510842744844e+00 3.912156074013493e+00 4.709232326708670e+00 9.215549953339205e+03 + 48160 1.071114434870050e+00 -6.077241187353293e+00 -6.005316453788482e+00 3.266410461203798e+00 4.679413411649489e+00 9.233383873798797e+03 + 48180 1.038998733096230e+00 -5.977992802359612e+00 -6.043990537501496e+00 3.804294911617921e+00 4.425325703316719e+00 9.352566322152876e+03 + 48200 1.060923315758901e+00 -5.965021391475852e+00 -5.967966597515814e+00 3.901317254262877e+00 4.884405425412250e+00 9.118964754390076e+03 + 48220 1.069960773950398e+00 -5.941561905899140e+00 -5.956644040686034e+00 4.038453460855237e+00 4.951849508956075e+00 9.084401105198032e+03 + 48240 1.089184720986777e+00 -5.942789461072636e+00 -5.986566220322276e+00 3.974478341004466e+00 4.723105414961427e+00 9.175807752151057e+03 + 48260 1.056375559350045e+00 -5.878942594114434e+00 -5.995240766414669e+00 4.292109718432346e+00 4.624307616000401e+00 9.202371278779530e+03 + 48280 1.073629990481018e+00 -5.898929202008398e+00 -5.984404649360690e+00 4.263341138775310e+00 4.772527892795722e+00 9.169207601889122e+03 + 48300 1.013068830404988e+00 -5.810836281739135e+00 -6.048262894245259e+00 4.693273177330182e+00 4.329932826670482e+00 9.365789340659814e+03 + 48320 1.099975564998793e+00 -5.951300108693943e+00 -6.039553134129390e+00 3.923501509092767e+00 4.416738979930877e+00 9.338868367032142e+03 + 48340 1.125103392283386e+00 -6.006739901393161e+00 -5.987557397212748e+00 3.654578101764347e+00 4.764727009251207e+00 9.178916426407364e+03 + 48360 1.070012527721169e+00 -5.947172969228235e+00 -5.998721205603058e+00 3.955741698146908e+00 4.659743747818878e+00 9.213137371648090e+03 + 48380 1.089613057432444e+00 -5.999793479150708e+00 -5.978547201459069e+00 3.672101295741073e+00 4.794100710097313e+00 9.151299144000877e+03 + 48400 1.015937857496142e+00 -5.912417878270271e+00 -6.020846303400292e+00 4.136896224268228e+00 4.514283427927088e+00 9.281151604960432e+03 + 48420 1.038285722576586e+00 -5.967534443997772e+00 -6.049617009569692e+00 3.795452013338419e+00 4.324121219588486e+00 9.370014163566349e+03 + 48440 1.042898313739251e+00 -5.996958585805450e+00 -6.022352029645937e+00 3.661846747853254e+00 4.516033663698439e+00 9.285799237935433e+03 + 48460 9.991874927672434e-01 -5.953623946423537e+00 -6.028600705265013e+00 3.909496318394155e+00 4.478968166510467e+00 9.305033643477473e+03 + 48480 1.013759406732738e+00 -5.996684139950926e+00 -5.998591000076900e+00 3.706379280292615e+00 4.695429794363616e+00 9.212700937211202e+03 + 48500 9.634863855410132e-01 -5.941402823303851e+00 -5.978228868386131e+00 4.015692717708855e+00 4.804231868034345e+00 9.150307372286896e+03 + 48520 9.763192877657830e-01 -5.973825935296019e+00 -5.988451033393000e+00 3.821595517142257e+00 4.737615940642780e+00 9.181618805808946e+03 + 48540 1.030211458987731e+00 -6.065065768097087e+00 -5.982258682263177e+00 3.336767711859940e+00 4.812258813073367e+00 9.162661579073230e+03 + 48560 9.558054866338821e-01 -5.962403959264303e+00 -6.015963094398620e+00 3.882904870926470e+00 4.575360028735844e+00 9.266105313479649e+03 + 48580 1.022165679007984e+00 -6.067252532145616e+00 -5.995213171545805e+00 3.351901486258240e+00 4.765562642877384e+00 9.202346708176998e+03 + 48600 1.010074616943558e+00 -6.056722103528778e+00 -5.985168810607775e+00 3.373826961927055e+00 4.784697042715746e+00 9.171585656849114e+03 + 48620 9.171132021579763e-01 -5.923541785139012e+00 -6.043307867488946e+00 4.100571731350541e+00 4.412856352755871e+00 9.350472427993327e+03 + 48640 1.022916220408237e+00 -6.084563563191187e+00 -5.979124232836077e+00 3.232791344132866e+00 4.838240295715547e+00 9.153093884471213e+03 + 48660 9.571871237588693e-01 -5.989369931799873e+00 -6.009255754130242e+00 3.757419929729714e+00 4.643232460587670e+00 9.245461515601026e+03 + 48680 9.724661029238494e-01 -6.011514939497109e+00 -5.991831536592228e+00 3.641905439859587e+00 4.754930585336171e+00 9.192013100757964e+03 + 48700 9.832200668013626e-01 -6.022177523275072e+00 -5.984023204755506e+00 3.599483006666567e+00 4.818571007967622e+00 9.168081429394608e+03 + 48720 9.829823181573463e-01 -6.012288804264655e+00 -5.994706405473179e+00 3.667934902300130e+00 4.768895757028202e+00 9.200800961835039e+03 + 48740 9.673730344858398e-01 -5.975421882973269e+00 -5.999272494191190e+00 3.832366521242892e+00 4.695412620759432e+00 9.214818962899251e+03 + 48760 1.049595832598912e+00 -6.075105035723462e+00 -5.986520388296342e+00 3.314534248626944e+00 4.823201002583350e+00 9.175720587619715e+03 + 48780 1.048813643720626e+00 -6.039615767399648e+00 -5.995198263839571e+00 3.507502211794955e+00 4.762554390823380e+00 9.202304014861400e+03 + 48800 1.051803135445691e+00 -6.005636812417128e+00 -5.977089407054936e+00 3.693085267478820e+00 4.857008886765231e+00 9.146866288073366e+03 + 48820 1.063966977263228e+00 -5.984605613442156e+00 -5.978469096541673e+00 3.744147423494073e+00 4.779384253159565e+00 9.151083818378125e+03 + 48840 1.032548995308832e+00 -5.902720619877512e+00 -6.007012055484598e+00 4.166741564842092e+00 4.567884002538699e+00 9.238593011431445e+03 + 48860 1.062559858448828e+00 -5.920200978210653e+00 -6.004231471297702e+00 4.110120534187006e+00 4.627604439204391e+00 9.230031853164099e+03 + 48880 1.087618885725373e+00 -5.939978582773488e+00 -5.968076697908153e+00 4.043902730516084e+00 4.882559005243579e+00 9.119264172280604e+03 + 48900 1.060211188984174e+00 -5.887528602500774e+00 -5.991144520587442e+00 4.310625561926997e+00 4.715646925761849e+00 9.189782608448626e+03 + 48920 1.055254098239748e+00 -5.876695572825818e+00 -5.947971501263234e+00 4.340995135489948e+00 4.931717724488022e+00 9.058014771331938e+03 + 48940 1.020686418594559e+00 -5.827054744678257e+00 -6.067134468379332e+00 4.604231650397571e+00 4.225656724688830e+00 9.424235627463440e+03 + 48960 1.144507285262668e+00 -6.022558312043504e+00 -6.007867634128017e+00 3.573708856049284e+00 4.658065002015072e+00 9.241222091327973e+03 + 48980 1.096970107843541e+00 -5.978244748053082e+00 -6.004087754475483e+00 3.824973787915995e+00 4.676579245846248e+00 9.229598648488385e+03 + 49000 1.012527068741598e+00 -5.890040687041521e+00 -6.011035410540455e+00 4.294152398437221e+00 4.599381972233391e+00 9.250933478953641e+03 + 49020 9.935929650225196e-01 -5.900824054034792e+00 -6.017412105621597e+00 4.217414927559551e+00 4.547948293405443e+00 9.270518034458953e+03 + 49040 1.041997049238116e+00 -6.009241948718646e+00 -5.995474805654112e+00 3.674636426139629e+00 4.753689492074688e+00 9.203167820420093e+03 + 49060 9.914783642958981e-01 -5.971099633619185e+00 -6.040974920822455e+00 3.829744352537540e+00 4.428509640250617e+00 9.343250981602183e+03 + 49080 1.024074201686398e+00 -6.048984311124375e+00 -5.989376817327453e+00 3.399231639505648e+00 4.741507093117428e+00 9.184478038877180e+03 + 49100 9.758479521277481e-01 -5.997507038862329e+00 -6.028163850709108e+00 3.653100391793332e+00 4.477064234042830e+00 9.303719428393080e+03 + 49120 9.938348704148550e-01 -6.038942739851130e+00 -6.002001194919662e+00 3.523546173408057e+00 4.735670241090151e+00 9.223149892728452e+03 + 49140 9.481433008944662e-01 -5.979225752319042e+00 -6.014702231505764e+00 3.794373992182780e+00 4.590662558725214e+00 9.262251318591507e+03 + 49160 1.011763744726122e+00 -6.077368852088505e+00 -6.017629416253049e+00 3.216901522279021e+00 4.559934607494026e+00 9.271257487806426e+03 + 49180 1.011054172467822e+00 -6.078032435449289e+00 -5.966682123667100e+00 3.306905873881898e+00 4.946296595540286e+00 9.115056318868865e+03 + 49200 9.046297287952977e-01 -5.918876570610314e+00 -5.996370475791669e+00 4.148513557186748e+00 4.703531561492337e+00 9.205887798990574e+03 + 49220 1.024035113351049e+00 -6.090527564551678e+00 -5.966612697420079e+00 3.229294671242912e+00 4.940833014076269e+00 9.114836717064920e+03 + 49240 9.986491175341013e-01 -6.044944528508131e+00 -5.961933877702370e+00 3.507136402394239e+00 4.983796405177610e+00 9.100562304598900e+03 + 49260 1.013553997607692e+00 -6.057770955163029e+00 -5.979377045092468e+00 3.376294874187471e+00 4.826444837231012e+00 9.153844316532633e+03 + 49280 9.751157020655733e-01 -5.989306566518621e+00 -6.034454993451243e+00 3.764492285653079e+00 4.505243031509474e+00 9.323086224212509e+03 + 49300 1.034355694043237e+00 -6.064062966714511e+00 -5.983275822967880e+00 3.349366492981825e+00 4.813258774145071e+00 9.165788351256842e+03 + 49320 1.018617272389194e+00 -6.025780999625737e+00 -6.011644041432897e+00 3.558095771507596e+00 4.639272373138097e+00 9.252838041800525e+03 + 49340 9.725035854895139e-01 -5.943589066062019e+00 -6.007907002694482e+00 3.973366967042218e+00 4.604043421730091e+00 9.241338860346837e+03 + 49360 1.000242369001744e+00 -5.969123734130342e+00 -6.032078255634618e+00 3.822918581051109e+00 4.461423976392840e+00 9.315770147941092e+03 + 49380 1.053157187352196e+00 -6.030069356594044e+00 -5.965161018191509e+00 3.488024307993937e+00 4.860738031634202e+00 9.110394159793201e+03 + 49400 1.014606354663133e+00 -5.949642223740406e+00 -6.018919893509042e+00 3.918068320442826e+00 4.520265219946565e+00 9.275212387967173e+03 + 49420 1.064540647382888e+00 -5.997040242314904e+00 -5.980849221067505e+00 3.755479644060958e+00 4.848450993615963e+00 9.158351141749599e+03 + 49440 1.038547979293805e+00 -5.929623894992941e+00 -6.017722694097873e+00 4.055301788618365e+00 4.549424850912740e+00 9.271526249753633e+03 + 49460 1.044072470807429e+00 -5.905311745003074e+00 -5.958873653174746e+00 4.203480422220796e+00 4.895919656820553e+00 9.091183532551597e+03 + 49480 1.016954215063829e+00 -5.828426692669380e+00 -6.007550706516209e+00 4.643162914923321e+00 4.614605108063270e+00 9.240167902569796e+03 + 49500 1.137154843142273e+00 -5.968709185988518e+00 -5.986857083512485e+00 3.909372588935197e+00 4.805164552974507e+00 9.176734452829882e+03 + 49520 1.135952801967156e+00 -5.936754427822423e+00 -6.039646897967922e+00 4.054013573847472e+00 4.463189087713723e+00 9.339135688949738e+03 + 49540 1.150783255546644e+00 -5.938946988661366e+00 -6.010312228695952e+00 4.019120173291430e+00 4.609329921277631e+00 9.248700304299538e+03 + 49560 1.050228209669332e+00 -5.782735799200578e+00 -6.065563954338760e+00 4.874504399741295e+00 4.250461365422300e+00 9.419384825138444e+03 + 49580 1.127674130921874e+00 -5.905290861823771e+00 -6.017542821998989e+00 4.189006489750810e+00 4.544438363490013e+00 9.270971221460954e+03 + 49600 1.114827278580270e+00 -5.909448516413911e+00 -6.003914723240321e+00 4.175430347313975e+00 4.632990769118469e+00 9.229049461384124e+03 + 49620 1.090396785668773e+00 -5.916395967293002e+00 -6.042358066184894e+00 4.121959746387029e+00 4.398665881977981e+00 9.347528967720147e+03 + 49640 1.114164227199572e+00 -6.015998033320295e+00 -5.968106152191415e+00 3.614602488472110e+00 4.889605081158792e+00 9.119390333653031e+03 + 49660 9.417374485665990e-01 -5.817967872287070e+00 -6.058520712354371e+00 4.655835212889777e+00 4.274543579791648e+00 9.397524386091347e+03 + 49680 1.025869623178057e+00 -5.987973768926933e+00 -6.015961442802249e+00 3.750068432405233e+00 4.589358877934634e+00 9.266099133680160e+03 + 49700 1.017654687612581e+00 -6.003389714529505e+00 -5.999202382877844e+00 3.656363623413950e+00 4.680407929745264e+00 9.214602624070938e+03 + 49720 9.783192254494399e-01 -5.962747126955856e+00 -6.003052989686314e+00 3.905812676657132e+00 4.674370175546744e+00 9.226408232545233e+03 + 49740 1.054099926571247e+00 -6.089951868954307e+00 -5.985793503936616e+00 3.180001425914201e+00 4.778094876300676e+00 9.173503101299857e+03 + 49760 9.727667166231042e-01 -5.981712686656447e+00 -6.027834960300500e+00 3.757384053242268e+00 4.492542820579336e+00 9.302693950702031e+03 + 49780 1.013117382460341e+00 -6.050816919882966e+00 -6.005976150794142e+00 3.469933183992781e+00 4.727415819187398e+00 9.235412020430802e+03 + 49800 9.914800174203161e-01 -6.027190529238491e+00 -6.034215493079862e+00 3.537952686606397e+00 4.497614257119606e+00 9.322377849761915e+03 + 49820 1.000147999585971e+00 -6.048455422863871e+00 -6.009135446051403e+00 3.434612912399033e+00 4.660394304002966e+00 9.245121080197208e+03 + 49840 1.017594638191775e+00 -6.082321884707825e+00 -5.975365161228743e+00 3.224464030962392e+00 4.838626088678746e+00 9.141585378380485e+03 + 49860 9.340877768654877e-01 -5.964763213739747e+00 -5.947219043138820e+00 3.879867054234962e+00 4.980608396777113e+00 9.055716709267163e+03 + 49880 9.815503769016821e-01 -6.034885301993913e+00 -5.954278830070364e+00 3.488447595201891e+00 4.951302430798129e+00 9.077205468289758e+03 + 49900 9.620694185841348e-01 -5.999865448972621e+00 -6.021264215108019e+00 3.737304812660795e+00 4.614429786062985e+00 9.282430453333296e+03 + 49920 1.017270357372918e+00 -6.074247339968013e+00 -5.994332318940695e+00 3.310195520386661e+00 4.769079937935055e+00 9.199668772600247e+03 + 49940 9.644867997417870e-01 -5.986823762607635e+00 -6.017398938608448e+00 3.732922376079968e+00 4.557354983990107e+00 9.270525844135260e+03 + 49960 9.496631994455978e-01 -5.951087331273335e+00 -5.977915397027783e+00 3.990067475603719e+00 4.836016570411920e+00 9.149392948930636e+03 + 49980 1.063394283649475e+00 -6.101196173287700e+00 -5.947548913477619e+00 3.141644999374150e+00 5.023911342040247e+00 9.056739690471932e+03 + 50000 1.052988486690462e+00 -6.063301612644598e+00 -5.955570271754626e+00 3.367525464807656e+00 4.986135495569004e+00 9.081152247905831e+03 + 50020 1.017060322505321e+00 -5.982470720262481e+00 -5.980529097697806e+00 3.802399315311658e+00 4.813548412543144e+00 9.157387975624883e+03 + 50040 9.885279172761343e-01 -5.913980687793387e+00 -6.048388710106975e+00 4.096333449875275e+00 4.324541786176424e+00 9.366129232106216e+03 + 50060 1.045919515760703e+00 -5.972036910761823e+00 -5.951029112339035e+00 3.891212082446847e+00 5.011842111936793e+00 9.067282242356650e+03 + 50080 1.016978023841858e+00 -5.902068464243120e+00 -5.980491850579196e+00 4.192576958160357e+00 4.742257737838796e+00 9.157229295052268e+03 + 50100 1.040028910678636e+00 -5.909029665520309e+00 -6.030611122266823e+00 4.137417177730834e+00 4.439277638422722e+00 9.311253508971840e+03 + 50120 1.069435448902011e+00 -5.931005974486188e+00 -6.042591058139167e+00 4.020687210169939e+00 4.379948392098647e+00 9.348262815492490e+03 + 50140 1.100521334647910e+00 -5.963194028687300e+00 -6.050161255276593e+00 3.866761861275246e+00 4.367382588064708e+00 9.371656274088273e+03 + 50160 1.034088269885145e+00 -5.863468616735697e+00 -6.061028282306509e+00 4.372422351011094e+00 4.238004179044053e+00 9.405314132403675e+03 + 50180 1.014623044392881e+00 -5.842898314370677e+00 -5.995568553865336e+00 4.572929831164657e+00 4.696273690343116e+00 9.203405733717298e+03 + 50200 1.006663595699954e+00 -5.844260162873728e+00 -6.019238219565987e+00 4.525664231587811e+00 4.520913152294098e+00 9.276162517345505e+03 + 50220 1.095641213758475e+00 -6.002926023457995e+00 -5.939347192282780e+00 3.730714805155416e+00 5.095794292555831e+00 9.031774699763251e+03 + 50240 1.002110620462234e+00 -5.905632428438254e+00 -5.968306027207629e+00 4.186609661039210e+00 4.826728158197398e+00 9.119986271030231e+03 + 50260 1.003263971406204e+00 -5.960262744860986e+00 -5.983153488839660e+00 3.879975058249937e+00 4.748532863993210e+00 9.165372542402934e+03 + 50280 1.038656132459080e+00 -6.069343982862084e+00 -5.915435810438570e+00 3.384834518064813e+00 5.268599061333338e+00 8.959265050034744e+03 + 50300 9.610655821220688e-01 -5.999241133003093e+00 -5.984182417538288e+00 3.687217080444988e+00 4.773686554972588e+00 9.168554022385439e+03 + 50320 9.299477457502798e-01 -5.982376614717568e+00 -5.984127900726913e+00 3.787449639613587e+00 4.777393484337294e+00 9.168411450755364e+03 + 50340 9.804770542591964e-01 -6.073615783753481e+00 -5.999933475859608e+00 3.333352953159809e+00 4.756448167386727e+00 9.216853691106911e+03 + 50360 1.003475481253926e+00 -6.116945556920822e+00 -5.993701272112721e+00 3.081485125599145e+00 4.789172880958695e+00 9.197734147178093e+03 + 50380 9.308618362409343e-01 -6.012685826065781e+00 -6.030997735326499e+00 3.625656178938537e+00 4.520506362204687e+00 9.312481575186765e+03 + 50400 9.552835452368441e-01 -6.049052036597573e+00 -6.051917936156596e+00 3.380725253102563e+00 4.364268814338126e+00 9.377115489222999e+03 + 50420 9.770171299232536e-01 -6.078404335675518e+00 -5.994584942632588e+00 3.273384140462016e+00 4.754688066323677e+00 9.200449513310421e+03 + 50440 9.246625413774001e-01 -5.994281130162920e+00 -5.992349752942854e+00 3.738606177523638e+00 4.749696444400916e+00 9.193585789944227e+03 + 50460 1.008056177611684e+00 -6.105581583358671e+00 -5.982476212574205e+00 3.167683189315242e+00 4.874573278854207e+00 9.163342795741881e+03 + 50480 9.652953933862722e-01 -6.026504628638878e+00 -5.997508878563067e+00 3.554822101731693e+00 4.721320185744821e+00 9.209415691545379e+03 + 50500 9.749076415946732e-01 -6.021555275847931e+00 -6.003099499377981e+00 3.606236990925223e+00 4.712212915437854e+00 9.226589122545867e+03 + 50520 1.021623349910509e+00 -6.067552378832900e+00 -5.987855553001614e+00 3.338904701408217e+00 4.796536208375404e+00 9.179815424743025e+03 + 50540 1.002613260870035e+00 -6.017069727014923e+00 -5.963081804476839e+00 3.597979204181001e+00 4.907986209998693e+00 9.104061699140952e+03 + 50560 1.029485293280510e+00 -6.030527714751125e+00 -5.961690431589606e+00 3.487485306832014e+00 4.882759639280602e+00 9.099816933138125e+03 + 50580 9.736639529321434e-01 -5.920360486771211e+00 -5.987185841720663e+00 4.102565577409005e+00 4.718844048098993e+00 9.177718823093946e+03 + 50600 1.014593729165727e+00 -5.955182139771768e+00 -5.988876194281500e+00 3.936423232315238e+00 4.742946757182278e+00 9.182904821646205e+03 + 50620 1.034808892394675e+00 -5.960360688185126e+00 -6.021281885947449e+00 3.897629099407380e+00 4.547810154331241e+00 9.282495397995584e+03 + 50640 1.052986122995764e+00 -5.966289654657979e+00 -5.998944548326160e+00 3.922617304177735e+00 4.735107851406574e+00 9.213814792966270e+03 + 50660 1.092586435139793e+00 -6.013270408241366e+00 -6.024509778189916e+00 3.577985596837367e+00 4.513447395305915e+00 9.292456118362601e+03 + 50680 1.089377852424100e+00 -6.003223211311298e+00 -5.993834607273922e+00 3.727704435649399e+00 4.781615252913788e+00 9.198136040468346e+03 + 50700 1.034575720838540e+00 -5.925074197570121e+00 -6.045238419166401e+00 4.061770348701360e+00 4.371768792942325e+00 9.356456420450315e+03 + 50720 1.040595946260573e+00 -5.942903936864893e+00 -6.024368179237555e+00 4.034125996171375e+00 4.566345709916780e+00 9.291988738988724e+03 + 50740 1.048993313641607e+00 -5.969621146884366e+00 -6.031109219855200e+00 3.812129491242440e+00 4.459055460995371e+00 9.312799389178062e+03 + 50760 1.038250320781049e+00 -5.971932248406710e+00 -5.998138984716016e+00 3.868362311594116e+00 4.717879176226743e+00 9.211323315346601e+03 + 50780 9.819874390279469e-01 -5.908760433248531e+00 -5.974810895655994e+00 4.219411872782763e+00 4.840139896363088e+00 9.139863257412368e+03 + 50800 1.025403688860931e+00 -5.992771691793715e+00 -6.012417849444306e+00 3.721735035546982e+00 4.608923758084219e+00 9.255211359255001e+03 + 50820 1.013616777798780e+00 -5.996919778826246e+00 -5.997850758822203e+00 3.737360018768967e+00 4.732014187563495e+00 9.210448588964911e+03 + 50840 9.710624454843466e-01 -5.952995039365134e+00 -6.024338623830792e+00 3.932711920537576e+00 4.523046018151750e+00 9.291907159680479e+03 + 50860 1.009287886905208e+00 -6.025796581444041e+00 -6.001985711589588e+00 3.572714420967866e+00 4.709440120392339e+00 9.223142609171899e+03 + 50880 9.745591953103792e-01 -5.985996498178314e+00 -5.981821806219127e+00 3.786479514249993e+00 4.810451241511136e+00 9.161327143602999e+03 + 50900 1.000272914477071e+00 -6.029111987527846e+00 -5.995420168758488e+00 3.501127749811665e+00 4.694591386977422e+00 9.202954638703452e+03 + 50920 9.588288658963835e-01 -5.967258956861270e+00 -5.999356729099581e+00 3.894244793217068e+00 4.709934417910487e+00 9.215053251278603e+03 + 50940 9.711391877638915e-01 -5.983477867954389e+00 -6.042553335588553e+00 3.753360211743438e+00 4.414139734688995e+00 9.348150247837273e+03 + 50960 1.009736731108754e+00 -6.041823709636098e+00 -5.994494880898068e+00 3.487287622021882e+00 4.759057080748230e+00 9.200170383149883e+03 + 50980 9.845775502224848e-01 -6.004264305466813e+00 -5.997405089592519e+00 3.762908569962831e+00 4.802295248973252e+00 9.209066075249666e+03 + 51000 9.561252150665012e-01 -5.960264897848953e+00 -5.981871155940734e+00 3.861316538274482e+00 4.737250060753841e+00 9.161417138521665e+03 + 51020 9.668938453609424e-01 -5.971298652811747e+00 -5.993814395408807e+00 3.826143770652811e+00 4.696854892360589e+00 9.198023291678053e+03 + 51040 1.010992476163919e+00 -6.028552544327317e+00 -5.972126749342545e+00 3.507208731550671e+00 4.831214378216784e+00 9.131658340872978e+03 + 51060 9.320530876725446e-01 -5.903756143063610e+00 -5.996228031626167e+00 4.180358048111433e+00 4.649370154006728e+00 9.205425732055257e+03 + 51080 9.837922050434701e-01 -5.969742676671604e+00 -5.972017680042562e+00 3.839131695502755e+00 4.826068274091082e+00 9.131324207807756e+03 + 51100 1.051425684233195e+00 -6.054952579847925e+00 -5.971980610117756e+00 3.415989082996404e+00 4.892426973057860e+00 9.131236186455590e+03 + 51120 1.000086279741786e+00 -5.963035924008405e+00 -6.023415994719148e+00 3.867657793935463e+00 4.520946084128632e+00 9.289075900664018e+03 + 51140 9.891904254914978e-01 -5.932283566119903e+00 -6.013684276801518e+00 4.093075346290671e+00 4.625659868837571e+00 9.259093564340988e+03 + 51160 9.550358851010687e-01 -5.867487064093909e+00 -6.039743243473866e+00 4.348958626163314e+00 4.359836987605984e+00 9.339453998706786e+03 + 51180 1.047542588906664e+00 -5.991997843137881e+00 -6.016280614468040e+00 3.745540054320824e+00 4.606104623596331e+00 9.267091617856146e+03 + 51200 1.038577775411625e+00 -5.968395626879443e+00 -6.029309056109056e+00 3.858049821017988e+00 4.508275484058840e+00 9.307258137521643e+03 + 51220 1.031043611666961e+00 -5.950295892545887e+00 -6.038103373770490e+00 3.952792116384190e+00 4.448587971028715e+00 9.334385363062775e+03 + 51240 1.076868841100275e+00 -6.018347651183937e+00 -6.010020983386713e+00 3.565449314047786e+00 4.613262329087121e+00 9.247825637857784e+03 + 51260 1.009903777942480e+00 -5.922822067099664e+00 -5.985790349022620e+00 4.172490277004709e+00 4.810916657892959e+00 9.173461182853138e+03 + 51280 1.044149108212520e+00 -5.980839947677783e+00 -5.969552864157194e+00 3.846055086625706e+00 4.910867266871460e+00 9.123831673833720e+03 + 51300 1.046169401893434e+00 -5.996455481350647e+00 -6.003170640347486e+00 3.725862747192321e+00 4.687303265064976e+00 9.226766907949848e+03 + 51320 9.632018546262066e-01 -5.892410030888836e+00 -6.053321764028688e+00 4.251461258394625e+00 4.327481185695373e+00 9.381460438495844e+03 + 51340 1.010698290639885e+00 -5.991559898205845e+00 -6.018613978355993e+00 3.744584567448013e+00 4.589235852620492e+00 9.274251881937476e+03 + 51360 9.875453402510629e-01 -5.989331129955029e+00 -6.033931746893873e+00 3.768350542749367e+00 4.512246898363360e+00 9.321467998401953e+03 + 51380 9.808414966529938e-01 -6.017154442247923e+00 -6.039499074868358e+00 3.593651803295428e+00 4.465345464968168e+00 9.338717150411107e+03 + 51400 1.007087635532953e+00 -6.096315511977391e+00 -6.003212343372617e+00 3.208561646601799e+00 4.743174448399190e+00 9.226914115111227e+03 + 51420 9.475716993805000e-01 -6.041861522818579e+00 -5.967606011339962e+00 3.479827704111028e+00 4.906214342024512e+00 9.117881133116436e+03 + 51440 9.659196850974784e-01 -6.091459399071401e+00 -5.936331013665537e+00 3.272479835749761e+00 5.163251030790292e+00 9.022631491043721e+03 + 51460 9.597079646563760e-01 -6.095239647232932e+00 -6.007311775002814e+00 3.155408008657928e+00 4.660303457797526e+00 9.239524935721440e+03 + 51480 9.352386071682678e-01 -6.066142879330449e+00 -5.996832651601752e+00 3.376833464251408e+00 4.774823517592668e+00 9.207320345256434e+03 + 51500 9.293395195005899e-01 -6.057151215942869e+00 -6.005252504009890e+00 3.426655985817841e+00 4.724666421036723e+00 9.233163708110294e+03 + 51520 9.263054132741437e-01 -6.045070977216383e+00 -5.966540021778671e+00 3.533570876000383e+00 4.984507774749808e+00 9.114612114782305e+03 + 51540 9.372208002755118e-01 -6.047414394583146e+00 -5.999408562783639e+00 3.407469201307904e+00 4.683126116379129e+00 9.215225671234630e+03 + 51560 9.779373289034876e-01 -6.088067037100443e+00 -6.003584258929093e+00 3.212818671384834e+00 4.697931857312394e+00 9.228072723355872e+03 + 51580 9.309248932784088e-01 -5.995691983073225e+00 -6.005166995357677e+00 3.733480079565397e+00 4.679073092774661e+00 9.232923317294482e+03 + 51600 9.525636388193668e-01 -6.001988989587987e+00 -5.996840744926695e+00 3.691741933674976e+00 4.721303951208403e+00 9.207350775729790e+03 + 51620 9.261325705967085e-01 -5.934602021168686e+00 -6.038819206178265e+00 4.003692853481866e+00 4.405261649599605e+00 9.336585666105208e+03 + 51640 9.740806934084083e-01 -5.978867764296895e+00 -5.978317150289671e+00 3.822883165408368e+00 4.826044876245092e+00 9.150605185339202e+03 + 51660 1.031535151448340e+00 -6.042268950784621e+00 -5.971600618493595e+00 3.493606257901029e+00 4.899394757805175e+00 9.130051474101798e+03 + 51680 1.019789386521798e+00 -6.007943288604864e+00 -5.998077131800821e+00 3.674882014253479e+00 4.731535013405118e+00 9.211141628942998e+03 + 51700 1.049499670321196e+00 -6.043511452247168e+00 -5.985551366660943e+00 3.452368240985203e+00 4.785184021715570e+00 9.172745469466745e+03 + 51720 1.056316319094630e+00 -6.048685620754164e+00 -5.980571616984676e+00 3.415715292372900e+00 4.806836442625320e+00 9.157492240471856e+03 + 51740 9.329320203304647e-01 -5.863530091915575e+00 -6.021415899283412e+00 4.369579976080926e+00 4.462975237425078e+00 9.282899365429161e+03 + 51760 1.033912404391399e+00 -6.011384725184674e+00 -5.964272767796312e+00 3.633345270906431e+00 4.903869420782248e+00 9.107689365295228e+03 + 51780 9.946598624286955e-01 -5.950412534782044e+00 -5.988067702882372e+00 4.068688888087953e+00 4.852467085737434e+00 9.180440745087833e+03 + 51800 1.026247620432821e+00 -5.997234472597834e+00 -5.984191998137401e+00 3.678794666002742e+00 4.753686572670952e+00 9.168575183246499e+03 + 51820 1.067302842646300e+00 -6.060160095427313e+00 -5.970225473058106e+00 3.362618293278536e+00 4.879036812260358e+00 9.125877772535134e+03 + 51840 1.032506036848079e+00 -6.014397683687925e+00 -5.935886403466512e+00 3.655507447271172e+00 5.106331367883874e+00 9.021270593657087e+03 + 51860 1.030841944221699e+00 -6.016279497294695e+00 -5.965980682266549e+00 3.588493376213090e+00 4.877316955821174e+00 9.112890329371410e+03 + 51880 9.501184042336110e-01 -5.900491236062376e+00 -6.015331660156436e+00 4.231716005160878e+00 4.572284518514592e+00 9.264155558576387e+03 + 51900 9.460959169062167e-01 -5.898215291876091e+00 -6.039925721437051e+00 4.206159315141658e+00 4.392436098984525e+00 9.339999011190679e+03 + 51920 1.025007489268924e+00 -6.021683495824298e+00 -6.024309860037608e+00 3.549060927771493e+00 4.533979938030119e+00 9.291814391446251e+03 + 51940 9.265137907258935e-01 -5.884109708308078e+00 -5.999064910105389e+00 4.283391289654666e+00 4.623300731674520e+00 9.214182317889674e+03 + 51960 1.002493584348304e+00 -6.004924149349415e+00 -6.009357649099931e+00 3.676757400821912e+00 4.651299559172585e+00 9.245794338149917e+03 + 51980 9.582970279852687e-01 -5.949198461858032e+00 -6.022164669459812e+00 3.965386556871215e+00 4.546403301337659e+00 9.285219587812957e+03 + 52000 9.909502881836171e-01 -6.009679278680629e+00 -6.024259823946867e+00 3.627042675652803e+00 4.543318928401973e+00 9.291682106310200e+03 + 52020 1.003361848456077e+00 -6.045028885901727e+00 -6.006935915318179e+00 3.453947298993576e+00 4.672683030952461e+00 9.238363277821483e+03 + 52040 9.740731664761513e-01 -6.025819322114829e+00 -6.004177386427912e+00 3.578654537748307e+00 4.702925881541308e+00 9.229883646025934e+03 + 52060 9.742471394665350e-01 -6.052068927273470e+00 -5.987757404029301e+00 3.457730373096642e+00 4.827017091740715e+00 9.179503688061281e+03 + 52080 9.463451179445561e-01 -6.038033430304551e+00 -5.996153564215494e+00 3.478556787387038e+00 4.719037459358734e+00 9.205241692057753e+03 + 52100 9.881670936267023e-01 -6.125679997013039e+00 -5.960507386331237e+00 3.036770775352787e+00 4.985217466266590e+00 9.096216413721279e+03 + 52120 9.466671338253831e-01 -6.086172192076737e+00 -5.959504248485920e+00 3.221245149252387e+00 4.948592083151780e+00 9.093155006857354e+03 + 52140 9.664890338031638e-01 -6.132702267246268e+00 -5.967114933900572e+00 2.975197251800903e+00 4.926025344428909e+00 9.116377812978324e+03 + 52160 9.258931952915568e-01 -6.083615065493734e+00 -5.959947686820191e+00 3.263203380908054e+00 4.973320606716532e+00 9.094509334545730e+03 + 52180 8.942985724125339e-01 -6.038923836201985e+00 -5.996689461264268e+00 3.480147797837664e+00 4.722664114478436e+00 9.206902718752843e+03 + 52200 9.877878112981743e-01 -6.171032079726776e+00 -5.980454235737962e+00 2.741893978372425e+00 4.836221450382242e+00 9.157138681042516e+03 + 52220 9.192931318319111e-01 -6.053267619785935e+00 -5.982285955435418e+00 3.455626488663215e+00 4.863214189740946e+00 9.162741838738593e+03 + 52240 9.413479029754978e-01 -6.058721034130621e+00 -5.969426044842614e+00 3.432512289063899e+00 4.945257935910574e+00 9.123433157158230e+03 + 52260 9.770918194581182e-01 -6.072658330651400e+00 -6.018359637494052e+00 3.302895222598999e+00 4.614686721404105e+00 9.273493895965616e+03 + 52280 9.520577704604374e-01 -5.989025165259984e+00 -5.989259145304832e+00 3.726759241805768e+00 4.725415692179957e+00 9.184107514681758e+03 + 52300 9.649008029884539e-01 -5.964500104746922e+00 -5.954722162836647e+00 3.871740044755205e+00 4.927886500335629e+00 9.078561486990884e+03 + 52320 9.498656643692558e-01 -5.902147763883232e+00 -6.005854188910671e+00 4.188523977619841e+00 4.593025636594882e+00 9.235032951708858e+03 + 52340 1.035560948549149e+00 -5.999958396234753e+00 -6.053466824634366e+00 3.631692587255869e+00 4.324438910982756e+00 9.381920697784864e+03 + 52360 1.051932456077838e+00 -6.007684065414647e+00 -5.993696421800500e+00 3.670071005682373e+00 4.750390219895662e+00 9.197734390564754e+03 + 52380 1.026047004687271e+00 -5.961316968285990e+00 -6.020855886678342e+00 3.928321299841042e+00 4.586439616814311e+00 9.281188187379930e+03 + 52400 1.029258223278297e+00 -5.963329927484951e+00 -6.057615430189834e+00 3.867589234767173e+00 4.326187287601345e+00 9.394775807190785e+03 + 52420 1.061882869737478e+00 -6.014444626499560e+00 -6.032437480659435e+00 3.590866748295415e+00 4.487548995324232e+00 9.316899079821387e+03 + 52440 1.028453749837974e+00 -5.972262645814344e+00 -5.964951056773761e+00 3.858831272476359e+00 4.900815548212135e+00 9.109769961805066e+03 + 52460 1.038171734712304e+00 -5.993770716391235e+00 -6.005293129032902e+00 3.705959990583370e+00 4.639796514107328e+00 9.233328228255781e+03 + 52480 9.917587494441780e-01 -5.937311296742801e+00 -6.009934717942760e+00 4.045856844072683e+00 4.628841921104413e+00 9.247560016998234e+03 + 52500 9.982479883649287e-01 -5.960438025955839e+00 -5.983042696437499e+00 3.922701941471278e+00 4.792902425504136e+00 9.165016520173976e+03 + 52520 1.012575930093152e+00 -5.996125083886216e+00 -5.980543865103319e+00 3.757341604287057e+00 4.846811373724269e+00 9.157389478588684e+03 + 52540 9.889159315980348e-01 -5.975722860894620e+00 -5.953654425490580e+00 3.817107230117199e+00 4.943827601286534e+00 9.075313998407353e+03 + 52560 9.759310745864992e-01 -5.969733888326114e+00 -6.014099056746931e+00 3.865114561832676e+00 4.610362899272719e+00 9.260380515025710e+03 + 52580 1.004368830123272e+00 -6.028012450794599e+00 -5.963040686519982e+00 3.535041430615813e+00 4.908119355428695e+00 9.103955048248055e+03 + 52600 9.803289396932537e-01 -6.009285790119675e+00 -5.969402783170088e+00 3.638392302466992e+00 4.867406700246903e+00 9.123342578394137e+03 + 52620 9.616055365220445e-01 -5.997369837633524e+00 -5.998164920731814e+00 3.700746972196170e+00 4.696181482007080e+00 9.211394431271417e+03 + 52640 1.020246252057012e+00 -6.100357607960150e+00 -5.960867192730168e+00 3.179336051227536e+00 4.980311601550091e+00 9.097300739835831e+03 + 52660 9.887273677633861e-01 -6.071136982986689e+00 -5.992888842134834e+00 3.258401495073917e+00 4.707714428705939e+00 9.195252343068441e+03 + 52680 9.661911086501185e-01 -6.059032568857302e+00 -5.992362808885911e+00 3.434261509287022e+00 4.817089588154761e+00 9.193616857404340e+03 + 52700 9.288923810114150e-01 -6.024886692102264e+00 -5.991574826285329e+00 3.569271154756934e+00 4.760553043272349e+00 9.191204812826378e+03 + 52720 9.500499139606653e-01 -6.078188786957843e+00 -6.012424812297954e+00 3.261088155463156e+00 4.638715074902430e+00 9.255215746702130e+03 + 52740 9.324265057572809e-01 -6.074128180381742e+00 -5.998384436843262e+00 3.280202980324993e+00 4.715135277029379e+00 9.212086677557305e+03 + 52760 9.625294627244371e-01 -6.139013145041465e+00 -5.957738136088665e+00 2.981342511306279e+00 5.022251664930236e+00 9.087767190534078e+03 + 52780 9.421180304247097e-01 -6.123480671523660e+00 -5.991617781624489e+00 2.966729963843154e+00 4.723907083360452e+00 9.191347806251410e+03 + 52800 9.017439956058222e-01 -6.071684516028905e+00 -6.000328419889358e+00 3.314900897680652e+00 4.724638644034120e+00 9.218058462909357e+03 + 52820 8.809311069732020e-01 -6.043051817701015e+00 -6.025253351158183e+00 3.434107977987476e+00 4.536309527180215e+00 9.294747337371980e+03 + 52840 9.192406504414496e-01 -6.093518050583311e+00 -6.020493958007533e+00 3.173658600520727e+00 4.592974240532651e+00 9.280061045684397e+03 + 52860 9.751891665855824e-01 -6.160017795697319e+00 -5.930475145776480e+00 2.838928181315891e+00 5.156997598771624e+00 9.004852764968229e+03 + 52880 9.220654058090462e-01 -6.051319690493046e+00 -5.932331955811561e+00 3.446257089189106e+00 5.129503075022630e+00 9.010486110627520e+03 + 52900 9.206411203608600e-01 -6.005960868694213e+00 -6.004654296414610e+00 3.664871132752228e+00 4.672373672973114e+00 9.231339341449991e+03 + 52920 9.923873427094940e-01 -6.062311296919027e+00 -6.010122635801002e+00 3.332445728483347e+00 4.632121096792257e+00 9.248169452478895e+03 + 52940 9.476312003974895e-01 -5.952308137914286e+00 -6.031099401616057e+00 3.955626020313908e+00 4.503194391229686e+00 9.312757663994498e+03 + 52960 9.785085847541517e-01 -5.964785443787379e+00 -5.976642239047610e+00 3.881398835487755e+00 4.813315282270371e+00 9.145466359134802e+03 + 52980 9.858943497234987e-01 -5.949545845245770e+00 -6.002713135362418e+00 3.965914236451569e+00 4.660619428990223e+00 9.225389634980178e+03 + 53000 1.047158013943823e+00 -6.020599823591636e+00 -5.970450449716902e+00 3.590268842237373e+00 4.878234307616625e+00 9.126551874946761e+03 + 53020 9.967117148527351e-01 -5.932623100185481e+00 -5.969483541026657e+00 4.077395915882134e+00 4.865737560437315e+00 9.123599112000404e+03 + 53040 1.045628106864340e+00 -5.993832056289270e+00 -5.984734165726517e+00 3.691121319533543e+00 4.743362815038880e+00 9.170253392119659e+03 + 53060 1.077581061485628e+00 -6.032221099981737e+00 -5.974564387659302e+00 3.518849587103792e+00 4.849923351606612e+00 9.139146369852333e+03 + 53080 1.033567968359189e+00 -5.962748206447381e+00 -5.995652377861083e+00 3.929547367926685e+00 4.740606523765142e+00 9.203676149047122e+03 + 53100 1.020182769541902e+00 -5.943664161463576e+00 -6.036452909032116e+00 3.963381791478610e+00 4.430574443927771e+00 9.329289792424681e+03 + 53120 1.035781421330477e+00 -5.971907486484643e+00 -5.986642821887978e+00 3.817980555684817e+00 4.733367979513083e+00 9.176095697870913e+03 + 53140 1.024051817070492e+00 -5.963279753665712e+00 -5.977307326212846e+00 3.950605756686849e+00 4.870057264361371e+00 9.147481161018057e+03 + 53160 1.006167006264120e+00 -5.947602533448166e+00 -5.965080567657208e+00 3.995946339380642e+00 4.895584762235274e+00 9.110188422122790e+03 + 53180 1.059112404441435e+00 -6.040347245447826e+00 -5.985621004172021e+00 3.541299447919948e+00 4.855545994184086e+00 9.172953395966946e+03 + 53200 9.833126318823051e-01 -5.947672475682264e+00 -5.995469749256512e+00 3.990510469415224e+00 4.716051127947713e+00 9.203119088425196e+03 + 53220 1.042686456548896e+00 -6.057698888500708e+00 -5.975898963392876e+00 3.380447609745609e+00 4.850155438212280e+00 9.143200648351438e+03 + 53240 9.919192437292238e-01 -6.009196042828121e+00 -5.981129887291858e+00 3.622868245879336e+00 4.784028454192092e+00 9.159214207365809e+03 + 53260 9.142078239177923e-01 -5.924379603297807e+00 -5.995808417736106e+00 4.090773366240192e+00 4.680618060162170e+00 9.204185701013372e+03 + 53280 9.681979357621973e-01 -6.033844684301380e+00 -5.981820075250809e+00 3.500043860521825e+00 4.798777216472432e+00 9.161305386507163e+03 + 53300 9.824100414042479e-01 -6.079851224906208e+00 -5.966786468546174e+00 3.298615396975175e+00 4.947850724708989e+00 9.115376267895206e+03 + 53320 9.880498905452690e-01 -6.110552025348452e+00 -6.007293846140247e+00 3.082606717820407e+00 4.675531161985511e+00 9.239452075205132e+03 + 53340 9.654876739908574e-01 -6.099573162647946e+00 -5.983800138221674e+00 3.132376798158012e+00 4.797163420231298e+00 9.167396662133422e+03 + 53360 9.005732988080296e-01 -6.020089630290336e+00 -5.978046846679827e+00 3.593882281595968e+00 4.835298451187247e+00 9.149763235346920e+03 + 53380 9.350862921986435e-01 -6.082359437207558e+00 -5.954543538964186e+00 3.251900931533116e+00 4.985839598692881e+00 9.078017706695866e+03 + 53400 9.324403204851189e-01 -6.082045364795309e+00 -5.959174425194975e+00 3.238124321898261e+00 4.943668271299829e+00 9.092128918619945e+03 + 53420 9.581983523622181e-01 -6.114919197799741e+00 -5.983537251636580e+00 3.020462884950990e+00 4.774878351110321e+00 9.166584575749115e+03 + 53440 9.682066613723298e-01 -6.113963755732841e+00 -5.981487288046214e+00 3.120894319046757e+00 4.881594697170485e+00 9.160307800905675e+03 + 53460 9.763051598658974e-01 -6.093701808954003e+00 -5.976411562397990e+00 3.198850683559711e+00 4.872349429891328e+00 9.144758856605968e+03 + 53480 9.748037827520839e-01 -6.040320643105482e+00 -5.973688142182439e+00 3.496305020644622e+00 4.878919152290927e+00 9.136430735330161e+03 + 53500 1.024332202353656e+00 -6.050630409221091e+00 -5.973706010587501e+00 3.439648005825598e+00 4.881359806791886e+00 9.136510244009511e+03 + 53520 9.934718692083070e-01 -5.952602788615796e+00 -5.967052868060925e+00 4.022237547259326e+00 4.939262954942824e+00 9.116175123881863e+03 + 53540 1.045735854252092e+00 -5.992352480397367e+00 -5.968329221644729e+00 3.738656333504130e+00 4.876601602849052e+00 9.120075820685188e+03 + 53560 1.012329952903900e+00 -5.915937117550793e+00 -5.987500835056214e+00 4.115783878357375e+00 4.704853937991754e+00 9.178705022749013e+03 + 53580 1.090512062805645e+00 -6.015101616661603e+00 -6.006124124904158e+00 3.620381652429128e+00 4.671931799362735e+00 9.235860578731346e+03 + 53600 1.066058284550854e+00 -5.969248832077673e+00 -5.983099796756106e+00 3.936670916211769e+00 4.857136533598352e+00 9.165235543972061e+03 + 53620 1.031500973242662e+00 -5.915852294965583e+00 -6.021215058808542e+00 4.135934570618623e+00 4.530925275797344e+00 9.282291802998590e+03 + 53640 1.036320740712101e+00 -5.926879519476611e+00 -6.016150435204389e+00 4.093286814689945e+00 4.580679401951481e+00 9.266689296332012e+03 + 53660 1.019796614328845e+00 -5.912466298103427e+00 -6.018295764400843e+00 4.217358382962037e+00 4.609669210425289e+00 9.273301884639866e+03 + 53680 1.049509278586028e+00 -5.972354553518539e+00 -6.025478908635984e+00 3.920678081251549e+00 4.615629813199790e+00 9.295426838492001e+03 + 53700 1.015827063620542e+00 -5.941884181154537e+00 -6.067512330111875e+00 3.932439294942653e+00 4.211063022736395e+00 9.425454356826285e+03 + 53720 1.066317268870032e+00 -6.041787755924706e+00 -6.016121967021018e+00 3.449333495657972e+00 4.596710427310947e+00 9.266607951690019e+03 + 53740 1.009152285426432e+00 -5.988404333453033e+00 -5.977817387056385e+00 3.754007193963482e+00 4.814799078497697e+00 9.149074946491934e+03 + 53760 1.005888533900545e+00 -6.013515969048251e+00 -6.014359567197319e+00 3.621929300519763e+00 4.617085229401426e+00 9.261154819981715e+03 + 53780 9.740195738397511e-01 -5.993037600894319e+00 -6.003908486189179e+00 3.734666622824311e+00 4.672244317197166e+00 9.229059589308286e+03 + 53800 9.888211201948007e-01 -6.039301239101434e+00 -5.989606432202445e+00 3.442586026005416e+00 4.727941297465923e+00 9.185191683476667e+03 + 53820 9.366781357172129e-01 -5.981494995247095e+00 -5.972926192691637e+00 3.794266829553238e+00 4.843470219844585e+00 9.134100706232966e+03 + 53840 9.985257261976814e-01 -6.086776515579849e+00 -5.944926228174154e+00 3.266643417445768e+00 5.081169718990298e+00 9.048737280272417e+03 + 53860 9.161384630146986e-01 -5.972279508706477e+00 -5.947659552217059e+00 3.892344737757261e+00 5.033716337845449e+00 9.057066013278098e+03 + 53880 9.504933689056781e-01 -6.024183799456113e+00 -5.965513917442823e+00 3.590990584678122e+00 4.927882126333334e+00 9.111480138415120e+03 + 53900 1.021503263531397e+00 -6.125090896729225e+00 -5.989162409781778e+00 3.039081931395035e+00 4.819604338312653e+00 9.183818011675961e+03 + 53920 9.293409675632341e-01 -5.981538146678229e+00 -6.033153582629820e+00 3.814303365438758e+00 4.517919544741821e+00 9.319098227903422e+03 + 53940 9.547529800794669e-01 -6.009369630434335e+00 -5.983335958344538e+00 3.692553371142227e+00 4.842042744979574e+00 9.165974546384066e+03 + 53960 9.640786502973677e-01 -6.006611310227600e+00 -5.995812043066360e+00 3.647755022481939e+00 4.709766085702973e+00 9.204196727849705e+03 + 53980 9.828590500359659e-01 -6.010517641453788e+00 -6.044763327006184e+00 3.621591277069554e+00 4.424947251124982e+00 9.354968477078628e+03 + 54000 9.542817800543673e-01 -5.937200463836628e+00 -6.048595446985419e+00 3.989740260810167e+00 4.350093029251879e+00 9.366812732474069e+03 + 54020 1.033713508276771e+00 -6.015401212962604e+00 -6.006494502154199e+00 3.614622913610508e+00 4.665766625381413e+00 9.236985238388419e+03 + 54040 1.036699406649471e+00 -5.969406364322110e+00 -6.021572122008326e+00 3.810240959313572e+00 4.510697106054406e+00 9.283384181863556e+03 + 54060 1.058003150381767e+00 -5.946392934740738e+00 -5.987569918431102e+00 3.995725023571098e+00 4.759280411103399e+00 9.178921213822821e+03 + 54080 1.045489089997446e+00 -5.880201647116905e+00 -6.069670710326415e+00 4.273160525107251e+00 4.185199843915476e+00 9.432158563524681e+03 + 54100 1.126789782916441e+00 -5.970599098605202e+00 -6.016700892311624e+00 3.801607883002057e+00 4.536884249310265e+00 9.268394934206884e+03 + 54120 1.055950701133109e+00 -5.853505281017144e+00 -5.994158397538452e+00 4.477141497077053e+00 4.669489536012263e+00 9.199130649279681e+03 + 54140 1.031905892686318e+00 -5.817831323058218e+00 -6.036116217178905e+00 4.643195071419272e+00 4.389769429900094e+00 9.328218845367408e+03 + 54160 1.093846693865381e+00 -5.917720629738016e+00 -6.026639180864027e+00 4.088060656756259e+00 4.462633481099386e+00 9.298991791049375e+03 + 54180 1.040180597238881e+00 -5.851046729352469e+00 -6.058043556102183e+00 4.492099437049617e+00 4.303491625197342e+00 9.396059035135466e+03 + 54200 1.079979498538350e+00 -5.929437673723467e+00 -6.040825200477803e+00 4.075372491735781e+00 4.435768075948328e+00 9.342778873832707e+03 + 54220 1.103988771413004e+00 -5.991141939199633e+00 -5.958875123116957e+00 3.782344810306861e+00 4.967625861527235e+00 9.091220649102326e+03 + 54240 9.850477770929047e-01 -5.838188436444661e+00 -5.965336079812483e+00 4.617425385817635e+00 4.887323941565380e+00 9.110924809627688e+03 + 54260 1.060312439210135e+00 -5.972413846739126e+00 -5.976974101701881e+00 3.874430576139957e+00 4.848244886446645e+00 9.146467604601825e+03 + 54280 1.039796427072599e+00 -5.963775235762218e+00 -6.021020354960616e+00 3.878514043386912e+00 4.549803710296147e+00 9.281687537981750e+03 + 54300 1.042200490152169e+00 -5.994630698587713e+00 -6.004774365083728e+00 3.695990705982782e+00 4.637744203235346e+00 9.231719290192761e+03 + 54320 9.936228400616660e-01 -5.947668161796854e+00 -5.995827901903258e+00 3.969126748960974e+00 4.692586068574311e+00 9.204220942932227e+03 + 54340 9.994455718171762e-01 -5.979037065815650e+00 -5.995044165302458e+00 3.765304645017273e+00 4.673389402673382e+00 9.201825450587108e+03 + 54360 1.023558470885400e+00 -6.034870890013749e+00 -5.971311988939481e+00 3.499489934107431e+00 4.864454979784029e+00 9.129191643738573e+03 + 54380 1.009769062490763e+00 -6.030416999039778e+00 -6.018979252975029e+00 3.526745517661889e+00 4.592422825551161e+00 9.275382468118903e+03 + 54400 1.008936878668633e+00 -6.043384428318426e+00 -5.974448251142420e+00 3.496870809488237e+00 4.892713006671808e+00 9.138795631339106e+03 + 54420 1.004159214485255e+00 -6.048321033931861e+00 -5.982262553053785e+00 3.460069319300547e+00 4.839387339019342e+00 9.162700172077946e+03 + 54440 1.022098899461534e+00 -6.086000864210757e+00 -5.996984311856679e+00 3.240301955565487e+00 4.751448774449555e+00 9.207795916528401e+03 + 54460 9.669256446890889e-01 -6.012404404036343e+00 -5.984400840165597e+00 3.628654612045816e+00 4.789455409329149e+00 9.169230489981876e+03 + 54480 9.488636706479081e-01 -5.990376893415181e+00 -6.022236427978559e+00 3.806289925912975e+00 4.623347548203024e+00 9.285428962524944e+03 + 54500 9.487049495179799e-01 -5.993127515865922e+00 -6.084496769546400e+00 3.686542018878511e+00 4.161885624898898e+00 9.478258982167739e+03 + 54520 9.684836135732350e-01 -6.024646412199617e+00 -6.021802158728037e+00 3.561008615939149e+00 4.577340759519767e+00 9.284105451298017e+03 + 54540 1.010972370845267e+00 -6.087545798748540e+00 -6.015999864728256e+00 3.206634550886089e+00 4.617462375728067e+00 9.266237517060004e+03 + 54560 9.072906522979783e-01 -5.931512107495578e+00 -5.972449427792554e+00 4.077884482410949e+00 4.842816054235867e+00 9.132663021812137e+03 + 54580 1.013258391744621e+00 -6.078494879820542e+00 -5.984519516586408e+00 3.323801924336489e+00 4.863423002667346e+00 9.169599555253109e+03 + 54600 1.007048713817384e+00 -6.051542756564180e+00 -5.996744671169080e+00 3.404251783221054e+00 4.718910869536024e+00 9.207049129474808e+03 + 54620 9.739597160247053e-01 -5.975478440834744e+00 -5.981274135605397e+00 3.812106955517787e+00 4.778827179263828e+00 9.159635155451602e+03 + 54640 9.885595975631052e-01 -5.956265705142274e+00 -5.983863310722824e+00 3.940607573950969e+00 4.782137851991794e+00 9.167549434342114e+03 + 54660 1.048652475769583e+00 -5.995318542665142e+00 -6.017355765739199e+00 3.705173562225474e+00 4.578632417084995e+00 9.270385289108230e+03 + 54680 1.067934562053304e+00 -5.975173726532505e+00 -6.002497289947861e+00 3.833820570722007e+00 4.676924441283259e+00 9.224702882243444e+03 + 54700 1.067856696534770e+00 -5.939403616652037e+00 -6.010622536800279e+00 3.999620581874733e+00 4.590670521291252e+00 9.249685727164921e+03 + 54720 1.070134708261087e+00 -5.920110063541051e+00 -6.012913795526518e+00 4.158335160256127e+00 4.625441769864467e+00 9.256711757315463e+03 + 54740 1.093017340973719e+00 -5.941472120875195e+00 -6.062182597968621e+00 3.985025628350265e+00 4.291887388993853e+00 9.408921775146819e+03 + 54760 1.064547972941710e+00 -5.900049220961904e+00 -6.022800225759704e+00 4.204477334762029e+00 4.499622069556461e+00 9.287158028543708e+03 + 54780 1.091316590018926e+00 -5.948511122951268e+00 -5.984770116228481e+00 3.958939135541713e+00 4.750734385082877e+00 9.170336377290851e+03 + 54800 1.095390699352464e+00 -5.970244653732164e+00 -5.979171772007548e+00 3.832328924262097e+00 4.781068029657751e+00 9.153212071460603e+03 + 54820 1.038658548615393e+00 -5.908855857906299e+00 -6.001430147588261e+00 4.219467072525084e+00 4.687891175346231e+00 9.221415147822556e+03 + 54840 1.067002225214245e+00 -5.979896107607225e+00 -6.018066678994483e+00 3.763879882759383e+00 4.544698554976913e+00 9.272610304890330e+03 + 54860 1.028021292575066e+00 -5.954849696436385e+00 -5.990418746859473e+00 3.930299003253635e+00 4.726056011431504e+00 9.187666865891502e+03 + 54880 9.944301961955102e-01 -5.938318243869601e+00 -6.034122801510027e+00 4.031731813619949e+00 4.481607217941241e+00 9.322065155728695e+03 + 54900 9.696066971873122e-01 -5.930387545021663e+00 -6.039248700920651e+00 4.014604627112691e+00 4.389507023731270e+00 9.337920572078605e+03 + 54920 1.008829824317309e+00 -6.016067761888137e+00 -6.024558054456929e+00 3.603748125070688e+00 4.554995551272160e+00 9.292601941897912e+03 + 54940 1.017815995347930e+00 -6.052043929901189e+00 -5.970727772781490e+00 3.415540799595846e+00 4.882470757411808e+00 9.127411577998113e+03 + 54960 9.198074710167056e-01 -5.921409705978636e+00 -5.979154995206325e+00 4.101891399446464e+00 4.770309012646449e+00 9.153153650089633e+03 + 54980 9.285353959960526e-01 -5.940660953829389e+00 -5.994310856781295e+00 3.993595964073992e+00 4.685529919028497e+00 9.199591122457834e+03 + 55000 1.017294981616800e+00 -6.074854332169742e+00 -6.002314913447890e+00 3.310284466013174e+00 4.726817033752813e+00 9.224147208875169e+03 + 55020 9.498205676961138e-01 -5.975639998750500e+00 -6.079314714855811e+00 3.789667824332950e+00 4.194351560845789e+00 9.462135902386499e+03 + 55040 9.461729098551501e-01 -5.970936894531246e+00 -6.072557305089658e+00 3.806543798529042e+00 4.223023675394925e+00 9.441131036875513e+03 + 55060 9.337477258236849e-01 -5.953001256718920e+00 -6.030869887190547e+00 3.928731787382902e+00 4.481598061083203e+00 9.312064005024293e+03 + 55080 1.056674794888727e+00 -6.132429517887268e+00 -6.002393166202086e+00 3.032411148705231e+00 4.779100003141933e+00 9.224396448887705e+03 + 55100 1.000271890196097e+00 -6.045248058573978e+00 -6.022306179235710e+00 3.470333496023810e+00 4.602069317428495e+00 9.285655434977065e+03 + 55120 9.985034313765137e-01 -6.038213568048285e+00 -6.004911730829888e+00 3.482001347336144e+00 4.673225650086831e+00 9.232154467795275e+03 + 55140 9.674092330321477e-01 -5.988445136760769e+00 -6.028133794722922e+00 3.714599214139536e+00 4.486700798320882e+00 9.303604826012745e+03 + 55160 9.472965820390548e-01 -5.953562660505895e+00 -5.959952764327043e+00 3.970872781472152e+00 4.934179816465752e+00 9.094507440766622e+03 + 55180 9.831413338772073e-01 -5.996515999398680e+00 -6.010926595340568e+00 3.716586905028739e+00 4.633839033097900e+00 9.250597854800999e+03 + 55200 1.022932063234721e+00 -6.042260132103272e+00 -5.948091430959963e+00 3.499188618560086e+00 5.039919873084377e+00 9.058376620517478e+03 + 55220 9.757458458560104e-01 -5.954292452735425e+00 -6.011179630911383e+00 3.900687110733684e+00 4.574032130384962e+00 9.251361420952138e+03 + 55240 9.389649213523840e-01 -5.874140103945586e+00 -6.033319059406761e+00 4.298764354131391e+00 4.384734159009579e+00 9.319601239366635e+03 + 55260 9.946657597009888e-01 -5.922339478330656e+00 -6.038766369377173e+00 4.019102565512342e+00 4.350561340120081e+00 9.336432358150641e+03 + 55280 1.003719620372902e+00 -5.890714058554066e+00 -5.987451573450800e+00 4.289769854373478e+00 4.734288073754383e+00 9.178533761435941e+03 + 55300 1.050497913464824e+00 -5.905530937036614e+00 -6.024943988755128e+00 4.117169829904961e+00 4.431481607827222e+00 9.293766085160343e+03 + 55320 1.112526671971221e+00 -5.948367231417799e+00 -5.980672161725514e+00 3.936704279960938e+00 4.751204370962229e+00 9.157780324115078e+03 + 55340 1.016488154602651e+00 -5.771073711879894e+00 -5.987595836630696e+00 4.912957651850943e+00 4.669654104841324e+00 9.178992888509098e+03 + 55360 1.105611828822873e+00 -5.880475598691084e+00 -6.014110082729380e+00 4.308703877871091e+00 4.541353990653623e+00 9.260402622250651e+03 + 55380 1.089980409436933e+00 -5.849580734757785e+00 -6.047324238803346e+00 4.432728315479078e+00 4.297254514541114e+00 9.362905238681187e+03 + 55400 1.097075063278465e+00 -5.866890546706975e+00 -6.036525779544235e+00 4.386364301712217e+00 4.412292543793226e+00 9.329505279566192e+03 + 55420 1.156385398999602e+00 -5.971583433138955e+00 -6.015968299563276e+00 3.795896826138697e+00 4.541032054594366e+00 9.266132231199490e+03 + 55440 1.124125805405444e+00 -5.952429483686296e+00 -6.010160664398855e+00 3.970964883794006e+00 4.639463510271151e+00 9.248266180271212e+03 + 55460 1.084730616358355e+00 -5.925355026669000e+00 -6.013644109129942e+00 4.107280211759968e+00 4.600310637577887e+00 9.258956938090307e+03 + 55480 1.042071564802017e+00 -5.894735566860745e+00 -6.039219353097935e+00 4.210162146066237e+00 4.380513886698632e+00 9.337818467100195e+03 + 55500 1.088584166860195e+00 -5.990132025178116e+00 -6.012086596631864e+00 3.733941824554420e+00 4.607875277808050e+00 9.254191220850749e+03 + 55520 1.061617716597617e+00 -5.975868640789428e+00 -6.047548502808436e+00 3.780379743758998e+00 4.368782883623060e+00 9.363598324419467e+03 + 55540 1.034121915376424e+00 -5.959283875638091e+00 -6.008456345762722e+00 3.912623106705584e+00 4.630267173834794e+00 9.243025501960459e+03 + 55560 1.093859992234341e+00 -6.070580067656937e+00 -5.980007397065632e+00 3.337672564106120e+00 4.857754854716863e+00 9.155759791247579e+03 + 55580 9.566203413833300e-01 -5.887531972194019e+00 -6.037963592697292e+00 4.252954855630685e+00 4.389153211482850e+00 9.333960550969021e+03 + 55600 1.025480205622033e+00 -6.007681018618406e+00 -5.999278889688592e+00 3.645061854153735e+00 4.693308178693976e+00 9.214829863611423e+03 + 55620 9.513038289856632e-01 -5.913230795278197e+00 -6.033666116684616e+00 4.063462268589619e+00 4.371904015768207e+00 9.320721088537837e+03 + 55640 1.020012619693743e+00 -6.030985173723627e+00 -5.991087301259124e+00 3.554355207188761e+00 4.783454965055747e+00 9.189727604227030e+03 + 55660 9.955084976156965e-01 -6.009609723541578e+00 -6.013743522741241e+00 3.614308072157878e+00 4.590571157450053e+00 9.259300975532864e+03 + 55680 9.734126186978457e-01 -5.991450905440539e+00 -5.974970560861168e+00 3.790911455737395e+00 4.885544144637227e+00 9.140375517365046e+03 + 55700 1.017463561659404e+00 -6.068633190370437e+00 -5.974167564515071e+00 3.334161740157576e+00 4.876597982327446e+00 9.137924059292682e+03 + 55720 9.016848687903686e-01 -5.907412272007081e+00 -6.044157383348771e+00 4.175857516686893e+00 4.390645926125321e+00 9.353065338421307e+03 + 55740 9.316667071629132e-01 -5.959013416466711e+00 -6.002395104993873e+00 3.925452789562032e+00 4.676348420744459e+00 9.224400588417364e+03 + 55760 9.816967471595023e-01 -6.037058022086589e+00 -6.056485922305524e+00 3.412453721465548e+00 4.300895711950579e+00 9.391279121786994e+03 + 55780 1.050826436263069e+00 -6.143519535916854e+00 -5.999571041252516e+00 2.897027608413515e+00 4.723602140733705e+00 9.215763582231033e+03 + 55800 9.343570623732697e-01 -5.975632599346230e+00 -6.016620454024102e+00 3.832099339246892e+00 4.596740734836540e+00 9.268143109914625e+03 + 55820 8.920063680650064e-01 -5.915688413919550e+00 -6.006113624394009e+00 4.114076848809161e+00 4.594841297008720e+00 9.235842715184852e+03 + 55840 1.018585199258887e+00 -6.100168250479660e+00 -5.995918808549498e+00 3.155658339531565e+00 4.754274767643558e+00 9.204530856727113e+03 + 55860 1.027978787203595e+00 -6.106059380222162e+00 -5.965319799814040e+00 3.155703645541824e+00 4.963852095624945e+00 9.110908513294151e+03 + 55880 9.633849779374750e-01 -5.998530771623769e+00 -5.965098972454284e+00 3.747359767868500e+00 4.939330332253889e+00 9.110227169874686e+03 + 55900 9.655536608310907e-01 -5.981104058979021e+00 -5.982636216164012e+00 3.793151594231217e+00 4.784353710574440e+00 9.163810563161089e+03 + 55920 9.823924119874227e-01 -5.974510960398534e+00 -5.985313642262334e+00 3.818212715053187e+00 4.756182044081633e+00 9.172015432099062e+03 + 55940 1.032656885261784e+00 -6.011215459175149e+00 -5.976073850368974e+00 3.660861567971334e+00 4.862650123882776e+00 9.143746804605693e+03 + 55960 9.939667533199624e-01 -5.913112993646610e+00 -6.016688773488377e+00 4.181961101695908e+00 4.587212945544356e+00 9.268323804607100e+03 + 55980 9.983141832414656e-01 -5.880698794450320e+00 -6.042952651298353e+00 4.326256037608383e+00 4.394569282883784e+00 9.349353386667161e+03 + 56000 1.039149018701382e+00 -5.913084977086940e+00 -6.054488903224580e+00 4.146310074314796e+00 4.334346848245617e+00 9.385077244215072e+03 + 56020 1.025451422798633e+00 -5.873116958264387e+00 -6.052089726505939e+00 4.347904218908828e+00 4.320214887719460e+00 9.377672502415082e+03 + 56040 1.021208319214640e+00 -5.857100326995289e+00 -6.035330016219193e+00 4.475947618407144e+00 4.452525161928213e+00 9.325812549814656e+03 + 56060 1.030858021307608e+00 -5.869880559313112e+00 -6.021892795614305e+00 4.380976252301828e+00 4.508098467642837e+00 9.284387117811446e+03 + 56080 1.065852500831557e+00 -5.927300597434035e+00 -6.076238924764858e+00 4.058357306633727e+00 4.203130382968475e+00 9.452550266989369e+03 + 56100 1.074075861116391e+00 -5.955924391731622e+00 -6.030868297415966e+00 3.908348853706138e+00 4.478009349734716e+00 9.312026788604937e+03 + 56120 1.025670796687410e+00 -5.906532867536681e+00 -6.042144879774038e+00 4.168021381435588e+00 4.389316221277615e+00 9.346863565357722e+03 + 56140 1.054818571698804e+00 -5.980082417718068e+00 -5.992762015454076e+00 3.807986750527896e+00 4.735178538166328e+00 9.194814605547002e+03 + 56160 9.409868717810627e-01 -5.845145403813857e+00 -6.010183019715241e+00 4.564794814707497e+00 4.617123284713230e+00 9.248300628329036e+03 + 56180 1.055596169298405e+00 -6.049438716939580e+00 -5.968341160540373e+00 3.483142603507695e+00 4.948817322158234e+00 9.120093940126502e+03 + 56200 1.045716103145949e+00 -6.064447490145087e+00 -5.968478415029199e+00 3.350172839431433e+00 4.901242119913240e+00 9.120550001926709e+03 + 56220 9.755951976669409e-01 -5.985229544020561e+00 -6.046303361110106e+00 3.775967413321307e+00 4.425272104450487e+00 9.359733138495430e+03 + 56240 1.026079325251729e+00 -6.079483167986101e+00 -6.017662865518167e+00 3.299141869187946e+00 4.654123612619711e+00 9.271362393128948e+03 + 56260 9.945850069097829e-01 -6.047616465830705e+00 -6.029298684258867e+00 3.472515564667849e+00 4.577699101120877e+00 9.307232902222595e+03 + 56280 9.988156772943324e-01 -6.064912080539905e+00 -6.022754365581736e+00 3.340456937985919e+00 4.582533061161027e+00 9.287055085978363e+03 + 56300 9.823705468889617e-01 -6.047699836042675e+00 -6.003558300431317e+00 3.460867563241248e+00 4.714335091602222e+00 9.227978900589800e+03 + 56320 1.033589837614554e+00 -6.125765140487413e+00 -5.988513581527479e+00 2.973265320312772e+00 4.761385011470823e+00 9.181844810621227e+03 + 56340 9.417874200101379e-01 -5.989156383444662e+00 -5.979039338247480e+00 3.828400792981507e+00 4.886494432111414e+00 9.152823359135948e+03 + 56360 9.334070013992690e-01 -5.971421609174882e+00 -6.043305268954916e+00 3.879016956373971e+00 4.466249857956610e+00 9.350459522516427e+03 + 56380 1.015515181904099e+00 -6.086605856452263e+00 -5.997282120100904e+00 3.223500323506606e+00 4.736411040439638e+00 9.208714137453064e+03 + 56400 9.755823923099267e-01 -6.020370895600933e+00 -5.998850826841504e+00 3.584727384905610e+00 4.708298949942129e+00 9.213512619284733e+03 + 56420 9.851843191454546e-01 -6.025115211275429e+00 -6.011267639750456e+00 3.530935112416006e+00 4.610450011017167e+00 9.251681900666053e+03 + 56440 1.028269649981075e+00 -6.078692816190651e+00 -5.996338665471120e+00 3.296845437013372e+00 4.769735714708560e+00 9.205820374717281e+03 + 56460 9.089466572814471e-01 -5.892000696594678e+00 -6.021070986374909e+00 4.264845658933549e+00 4.523704081452676e+00 9.281857097538981e+03 + 56480 1.013110233826326e+00 -6.034863100746683e+00 -5.993118663296807e+00 3.486262069885783e+00 4.725965089653786e+00 9.195911844526729e+03 + 56500 9.886702349680662e-01 -5.983879248454703e+00 -5.984045134981699e+00 3.768288006784778e+00 4.767335460675914e+00 9.168132227536606e+03 + 56520 1.013906284555558e+00 -6.004329475575982e+00 -5.990091341160653e+00 3.616110556309172e+00 4.697868127466169e+00 9.186674374135604e+03 + 56540 9.855105038844005e-01 -5.943464012966727e+00 -6.020479963063310e+00 4.025168299469722e+00 4.582930795835384e+00 9.280016678033686e+03 + 56560 1.043172397299196e+00 -6.008598965030396e+00 -6.010197905886804e+00 3.673385395858497e+00 4.664204030025711e+00 9.248368710278683e+03 + 56580 1.023343623017774e+00 -5.958142121203055e+00 -6.039819234337847e+00 3.907255434347916e+00 4.438252811235531e+00 9.339688247693217e+03 + 56600 1.042007764319347e+00 -5.963496501934392e+00 -6.052569335342199e+00 3.888074089360232e+00 4.376604095956186e+00 9.379122786065747e+03 + 56620 1.063884652389014e+00 -5.973364932364444e+00 -6.017332654570086e+00 3.831074014335827e+00 4.578604549448007e+00 9.270324883452928e+03 + 56640 1.062321971838475e+00 -5.946057846264555e+00 -5.998338722768922e+00 3.988828803320648e+00 4.688623919993076e+00 9.211900223358711e+03 + 56660 1.022872875248082e+00 -5.858963800993803e+00 -5.991219871799985e+00 4.480941777114355e+00 4.721506951984446e+00 9.190059317487283e+03 + 56680 1.069754767079086e+00 -5.892087251754068e+00 -5.984355488514542e+00 4.295032096131870e+00 4.765213602189740e+00 9.169045797722283e+03 + 56700 1.042928382003904e+00 -5.811732267379496e+00 -6.031865657083053e+00 4.716461373367831e+00 4.452421384158042e+00 9.315121193834564e+03 + 56720 1.080094737627312e+00 -5.831886472625617e+00 -6.013165925960132e+00 4.631589328185113e+00 4.590654654233581e+00 9.257495152200509e+03 + 56740 1.109163808771727e+00 -5.849771890585469e+00 -6.017473815503898e+00 4.493429985222420e+00 4.530459580551795e+00 9.270761738506430e+03 + 56760 1.122903417993812e+00 -5.856923770969502e+00 -6.045075800221126e+00 4.430027111029858e+00 4.349629042634603e+00 9.355925115914017e+03 + 56780 1.151342591475217e+00 -5.902947549290310e+00 -6.012452976940498e+00 4.254494423834729e+00 4.625697312357187e+00 9.255298072410498e+03 + 56800 1.080357677372354e+00 -5.818592401894030e+00 -6.034483987144625e+00 4.656992975203304e+00 4.417310083579545e+00 9.323226527761772e+03 + 56820 1.096327290881824e+00 -5.881215646890295e+00 -6.020525808963447e+00 4.437635145363696e+00 4.637694636561755e+00 9.280145874786576e+03 + 56840 1.160402640937940e+00 -6.029348992004258e+00 -6.009935094157372e+00 3.547569445520745e+00 4.659047051248545e+00 9.247581332670306e+03 + 56860 1.059281607146096e+00 -5.934349560421052e+00 -6.034831366130899e+00 4.047995915223286e+00 4.471013837328162e+00 9.324284288998719e+03 + 56880 1.052277321125191e+00 -5.972654259348827e+00 -6.025917387038327e+00 3.884107363450663e+00 4.578262241815182e+00 9.296802837442336e+03 + 56900 1.044680114938570e+00 -5.996633305663630e+00 -6.037916108184477e+00 3.763585143706204e+00 4.526532903138454e+00 9.333799790540577e+03 + 56920 1.007494265013524e+00 -5.967378117126358e+00 -6.033166539086237e+00 3.939001680100704e+00 4.561234380481684e+00 9.319132072026696e+03 + 56940 1.036802536818388e+00 -6.029765513772059e+00 -6.029008850832159e+00 3.557888680597914e+00 4.562233556292036e+00 9.306303674225164e+03 + 56960 1.023911873511651e+00 -6.030893610476424e+00 -6.019342415759006e+00 3.547069041608787e+00 4.613397789217809e+00 9.276513347194441e+03 + 56980 9.817072566260552e-01 -5.984067445975617e+00 -6.017582310939507e+00 3.843938495012968e+00 4.651490953981719e+00 9.271108315011519e+03 + 57000 9.881310994650196e-01 -6.007637502929379e+00 -6.056292028966869e+00 3.616005428426002e+00 4.336623610655167e+00 9.390686429850237e+03 + 57020 9.932271150371151e-01 -6.030434013677722e+00 -6.000643093010705e+00 3.536701420034531e+00 4.707765496634615e+00 9.219027618904131e+03 + 57040 9.944474163092226e-01 -6.046335931354329e+00 -5.952004167152108e+00 3.458789126862821e+00 5.000456714705307e+00 9.070286975695562e+03 + 57060 9.583185620949127e-01 -6.001959682413293e+00 -5.961575805638782e+00 3.684676203445138e+00 4.916566673269116e+00 9.099440008091991e+03 + 57080 9.287422651177679e-01 -5.962847244577373e+00 -5.977009729309587e+00 3.918750699609405e+00 4.837427520639608e+00 9.146619273705972e+03 + 57100 1.049001310260238e+00 -6.142087480980150e+00 -5.963581505621869e+00 2.938581897679294e+00 4.963590831896952e+00 9.105610851167437e+03 + 57120 9.353906422856642e-01 -5.972667092302700e+00 -6.002778608932171e+00 3.820552664312164e+00 4.647647676083604e+00 9.225586775977030e+03 + 57140 1.017356441202684e+00 -6.089020286966928e+00 -5.977212437047312e+00 3.240259563641431e+00 4.882277540088723e+00 9.147220691358563e+03 + 57160 9.428899367323355e-01 -5.968490377358701e+00 -6.032484266455948e+00 3.859636782058146e+00 4.492173967839420e+00 9.317054517648134e+03 + 57180 9.899462962479102e-01 -6.026099141188388e+00 -6.027557761752623e+00 3.551842720385166e+00 4.543467095384520e+00 9.301842031793221e+03 + 57200 9.633362094653253e-01 -5.971626179262657e+00 -6.009738510388729e+00 3.849751340378201e+00 4.630904437188113e+00 9.246954035107818e+03 + 57220 9.855941318345693e-01 -5.984141230139588e+00 -5.980930765114614e+00 3.812147007925950e+00 4.830581994917205e+00 9.158595257489025e+03 + 57240 9.924719117544981e-01 -5.970521169475893e+00 -5.968321467264085e+00 3.831176395825086e+00 4.843807426328107e+00 9.120031065975980e+03 + 57260 1.012245615897856e+00 -5.968733817272671e+00 -5.981840224525186e+00 3.853518201688188e+00 4.778259183034283e+00 9.161360148450523e+03 + 57280 1.059622582346316e+00 -6.003984260960687e+00 -5.972144965366938e+00 3.664441527663695e+00 4.847267690078072e+00 9.131726165004691e+03 + 57300 1.057054458241929e+00 -5.967348296094404e+00 -5.955631902390244e+00 3.901245638874953e+00 4.968522984630303e+00 9.081322466063792e+03 + 57320 1.064254416556010e+00 -5.947339031076265e+00 -6.014480716611390e+00 3.941125156420452e+00 4.555587207935502e+00 9.261534830670427e+03 + 57340 1.044770959759344e+00 -5.895053069737464e+00 -6.033097933827868e+00 4.239085076468349e+00 4.446410104487569e+00 9.318895841940406e+03 + 57360 9.737701922261436e-01 -5.775944253237927e+00 -6.012805673177283e+00 4.845670450349269e+00 4.485575522871218e+00 9.256371885669823e+03 + 57380 1.107727648014548e+00 -5.965879532501098e+00 -5.988350372405630e+00 3.849266304574293e+00 4.720235264491235e+00 9.181280771435897e+03 + 57400 1.008694420225550e+00 -5.817132338480546e+00 -6.034744079716493e+00 4.698923861160863e+00 4.449363567675932e+00 9.323999093606748e+03 + 57420 1.105811393643516e+00 -5.969307673847702e+00 -6.013720910759660e+00 3.896340700518366e+00 4.641313021243700e+00 9.259202886070319e+03 + 57440 1.023618517384799e+00 -5.865914725180268e+00 -5.989594445565833e+00 4.446760138263000e+00 4.736572044434211e+00 9.185122623150686e+03 + 57460 1.062407034581622e+00 -5.952668616727086e+00 -6.004526511973320e+00 3.952167924999910e+00 4.654391865512683e+00 9.230949903871113e+03 + 57480 1.040886785353600e+00 -5.963029953947366e+00 -6.032563233604392e+00 3.865598482252332e+00 4.466327630221438e+00 9.317237323479048e+03 + 57500 9.790417855937503e-01 -5.922453568029830e+00 -6.069954425287847e+00 4.119591844033165e+00 4.272619095973744e+00 9.433008044887905e+03 + 57520 9.930817501617136e-01 -5.999308353778441e+00 -5.993705556230679e+00 3.688881443198354e+00 4.721053573747724e+00 9.197752725467595e+03 + 57540 9.876007018779281e-01 -6.034489428738645e+00 -5.991819320263332e+00 3.458217780975893e+00 4.703236147019089e+00 9.191968558355142e+03 + 57560 9.418113112230918e-01 -5.992578461623830e+00 -6.023310553550764e+00 3.727930972665919e+00 4.551462545045609e+00 9.288760697526192e+03 + 57580 1.004916956782298e+00 -6.098771133345769e+00 -6.003911592017036e+00 3.197577641938295e+00 4.742275807714464e+00 9.229073127371828e+03 + 57600 9.766607406040632e-01 -6.063090098960552e+00 -5.975426064675958e+00 3.370480900614292e+00 4.873861351441887e+00 9.141781752892832e+03 + 57620 9.545924470277579e-01 -6.031495924674497e+00 -5.988531779944429e+00 3.521457261600491e+00 4.768164029320451e+00 9.181869645858384e+03 + 57640 9.496310113316316e-01 -6.019649148273940e+00 -6.019078602903575e+00 3.561269130591984e+00 4.564545290400227e+00 9.275727725825323e+03 + 57660 9.662756568821931e-01 -6.036515837542882e+00 -6.020375784318530e+00 3.496159518074748e+00 4.588838201354143e+00 9.279720538069540e+03 + 57680 9.226061635702377e-01 -5.961195641010880e+00 -6.026249904950273e+00 3.933104573931325e+00 4.559552923276526e+00 9.297813879920295e+03 + 57700 9.728989657045495e-01 -6.023092392790147e+00 -6.013904586164516e+00 3.609250778579567e+00 4.662008586032417e+00 9.259780057112965e+03 + 57720 1.026857242939699e+00 -6.088064748481124e+00 -6.011892174236086e+00 3.218736023691536e+00 4.656130732674319e+00 9.253600034595955e+03 + 57740 9.616087958023901e-01 -5.974460289279401e+00 -6.018605149236064e+00 3.801944647927724e+00 4.548458030661565e+00 9.274251840686180e+03 + 57760 9.017365243110744e-01 -5.866155905888709e+00 -6.033897158540556e+00 4.414552523697464e+00 4.451356293095597e+00 9.321383147639672e+03 + 57780 1.009215416296311e+00 -6.001802484354576e+00 -6.048649601867689e+00 3.694891694523993e+00 4.425888296195692e+00 9.367008483551388e+03 + 57800 9.869540637013344e-01 -5.945129032735177e+00 -6.071369214271328e+00 3.967426448886344e+00 4.242535790900805e+00 9.437427182036952e+03 + 57820 1.079090528691349e+00 -6.063825653289923e+00 -5.975056177806851e+00 3.378637936292284e+00 4.888366001548018e+00 9.140633119438402e+03 + 57840 1.062168712706210e+00 -6.020752659478207e+00 -6.001054130768228e+00 3.611837708778588e+00 4.724949708968755e+00 9.220298538661389e+03 + 57860 1.012113268904240e+00 -5.933479122859675e+00 -6.023264783187129e+00 4.063021964185730e+00 4.547458808299463e+00 9.288603133355393e+03 + 57880 1.014029989602518e+00 -5.924458642866226e+00 -6.048437339494821e+00 4.103909568412108e+00 4.392004706729417e+00 9.366293338756879e+03 + 57900 1.034737059630698e+00 -5.946133345673997e+00 -5.991005235231488e+00 3.997775051975111e+00 4.740113718233530e+00 9.189442532993209e+03 + 57920 9.975769829732444e-01 -5.883932848960004e+00 -6.069157497684501e+00 4.267161889852428e+00 4.203573293454613e+00 9.430560822783234e+03 + 57940 1.056391573893178e+00 -5.970316289306072e+00 -5.993788590249609e+00 3.840423249348042e+00 4.705641665003421e+00 9.197965389400451e+03 + 57960 1.036136278117523e+00 -5.945496148064346e+00 -6.036434046227596e+00 3.937427514806779e+00 4.415248030959138e+00 9.329212612449717e+03 + 57980 1.055780350997631e+00 -5.988918749066907e+00 -5.951832263041441e+00 3.763980084153280e+00 4.976936426026670e+00 9.069774636076416e+03 + 58000 9.722186201223897e-01 -5.887921648978491e+00 -6.011406272439043e+00 4.284792441992179e+00 4.575724624897971e+00 9.252047334889430e+03 + 58020 9.892753563998048e-01 -5.944391353217111e+00 -5.958400841359021e+00 3.955493096255382e+00 4.875048447383253e+00 9.089755457590072e+03 + 58040 1.017090349879364e+00 -6.024261669526604e+00 -6.012492836787780e+00 3.583328741638772e+00 4.650907200446078e+00 9.255398206846623e+03 + 58060 9.609413814686971e-01 -5.987279903011562e+00 -5.985015657255357e+00 3.800995555038156e+00 4.813997204561188e+00 9.171082730402439e+03 + 58080 9.250515872857171e-01 -5.971300390703504e+00 -5.983791213497279e+00 3.850403997080369e+00 4.778679759649938e+00 9.167331015935142e+03 + 58100 1.028957759710241e+00 -6.156428038550610e+00 -5.960499631742572e+00 2.887147123536221e+00 5.012198355250941e+00 9.096194610195207e+03 + 58120 9.465074714557951e-01 -6.055516448960569e+00 -6.009353197949639e+00 3.372196236461099e+00 4.637272767505864e+00 9.245788737572311e+03 + 58140 9.009981557394455e-01 -6.000583998162687e+00 -6.011482039995545e+00 3.653772374838282e+00 4.591194132167493e+00 9.252347170197800e+03 + 58160 9.548890324936343e-01 -6.087497140621374e+00 -5.982368381751807e+00 3.213745511631184e+00 4.817411113683093e+00 9.163028007857531e+03 + 58180 9.345650586721894e-01 -6.057741609827429e+00 -5.985198312733669e+00 3.414879053632714e+00 4.831433891584032e+00 9.171670251939116e+03 + 58200 9.405401305137778e-01 -6.060977105640050e+00 -6.039589953910495e+00 3.301774842930443e+00 4.424583177812584e+00 9.338998112873498e+03 + 58220 9.626561454899512e-01 -6.084293176519750e+00 -5.969664768592448e+00 3.265293986804427e+00 4.923508043811789e+00 9.124160053826417e+03 + 58240 9.270180032990346e-01 -6.014741347393427e+00 -5.977841745455129e+00 3.618561246200657e+00 4.830444470725308e+00 9.149136326793328e+03 + 58260 9.463769950971712e-01 -6.018013687787561e+00 -5.995199538896647e+00 3.623873048097875e+00 4.754875421507637e+00 9.202304735408723e+03 + 58280 1.015795560186022e+00 -6.089140625158183e+00 -5.983081467365432e+00 3.228884303306965e+00 4.837892399954571e+00 9.165188960611073e+03 + 58300 9.735466747341770e-01 -5.993139092488436e+00 -6.039437567003294e+00 3.707200482835068e+00 4.441347477504975e+00 9.338511681890948e+03 + 58320 1.010679302683683e+00 -6.017902124342816e+00 -6.044744987872637e+00 3.520556012845598e+00 4.366420136537662e+00 9.354920242271317e+03 + 58340 9.862955960414929e-01 -5.957438907562468e+00 -6.029152647246574e+00 3.924506670394020e+00 4.512715279462530e+00 9.306749301335758e+03 + 58360 1.015716838369209e+00 -5.980523933430026e+00 -6.008644091437125e+00 3.824032900892910e+00 4.662562602035759e+00 9.243599075085338e+03 + 58380 1.000953129245683e+00 -5.944295554798329e+00 -6.047164505604340e+00 3.978475599436746e+00 4.387786164989943e+00 9.362399003050972e+03 + 58400 1.036237408123727e+00 -5.989256607088601e+00 -6.035462718770937e+00 3.739343585984721e+00 4.474020942332073e+00 9.326243935908011e+03 + 58420 1.049575671852772e+00 -6.008574264300758e+00 -6.013571430175532e+00 3.666446439310009e+00 4.637751939548137e+00 9.258763597952779e+03 + 58440 9.848895708128661e-01 -5.916241870635173e+00 -6.088689485486416e+00 4.089582052074520e+00 4.099361161416531e+00 9.491303864278783e+03 + 58460 9.997794403643350e-01 -5.944423608522742e+00 -6.006878710635573e+00 4.033470899491953e+00 4.674844038264260e+00 9.238152055147159e+03 + 58480 1.029745252334780e+00 -5.994204035883075e+00 -5.973477628551382e+00 3.754758900632710e+00 4.873773138932457e+00 9.135783552294077e+03 + 58500 9.824239811942896e-01 -5.927680904779300e+00 -6.005382219732033e+00 4.106446888337884e+00 4.660273913639661e+00 9.233554385645566e+03 + 58520 1.013785266788580e+00 -5.978359796179875e+00 -6.057679390289384e+00 3.808500461927653e+00 4.353035077883332e+00 9.394945204191306e+03 + 58540 1.020223915108273e+00 -5.995000101969616e+00 -6.034675127843400e+00 3.759027280633647e+00 4.531207142375971e+00 9.323810228861088e+03 + 58560 1.049820671769805e+00 -6.049538490087009e+00 -6.013435151050794e+00 3.452549896899854e+00 4.659860856619462e+00 9.258358882050312e+03 + 58580 1.023817606463530e+00 -6.025000183342135e+00 -5.979100938761216e+00 3.548228647283965e+00 4.811789212552741e+00 9.153007014583156e+03 + 58600 1.001786694671557e+00 -6.004001405144667e+00 -5.989820972987230e+00 3.687196579816750e+00 4.768622815679538e+00 9.185806519772372e+03 + 58620 9.760881353313391e-01 -5.979401440291658e+00 -6.052215553407965e+00 3.745134136918197e+00 4.327024231456778e+00 9.378023097258596e+03 + 58640 1.041041770283404e+00 -6.091352135929243e+00 -5.976831283966371e+00 3.168558675902915e+00 4.826155129918286e+00 9.146067276572352e+03 + 58660 8.907696890373128e-01 -5.880241590152331e+00 -6.040898313887606e+00 4.374932233941744e+00 4.452416464706151e+00 9.342999180858635e+03 + 58680 1.042110042844660e+00 -6.116891263112340e+00 -5.970412315760102e+00 3.068964151075133e+00 4.910068934315525e+00 9.126450842405946e+03 + 58700 9.564147636154118e-01 -6.000206546084813e+00 -5.992272859454530e+00 3.718103563471132e+00 4.763660019836260e+00 9.193319454168653e+03 + 58720 9.493533028151828e-01 -6.001615373072302e+00 -5.993906429687677e+00 3.674705604802272e+00 4.718971550671920e+00 9.198325514506814e+03 + 58740 9.778723369098564e-01 -6.057575189122179e+00 -5.978671594160485e+00 3.354849510727234e+00 4.807926163289142e+00 9.151680828292765e+03 + 58760 9.834853128029232e-01 -6.081419096241451e+00 -5.987781691200472e+00 3.219503922854200e+00 4.757184392941101e+00 9.179587018023905e+03 + 58780 9.232993974664780e-01 -6.008118864559579e+00 -6.038410195288225e+00 3.561699901435518e+00 4.387762392823354e+00 9.335360113518809e+03 + 58800 9.110415095794894e-01 -6.009812515306396e+00 -5.997068416983981e+00 3.663861854574672e+00 4.737040439284820e+00 9.208052963196506e+03 + 58820 9.171905442024617e-01 -6.038226507333606e+00 -5.953344046210603e+00 3.483919084406133e+00 4.971327311692824e+00 9.074372511507287e+03 + 58840 9.367233628599629e-01 -6.079964248527479e+00 -5.962563225052993e+00 3.295792494421328e+00 4.969927338961492e+00 9.102491936766615e+03 + 58860 9.490390579347927e-01 -6.105172693985501e+00 -6.002904290649671e+00 3.094225379504029e+00 4.681466377442635e+00 9.225992817715623e+03 + 58880 9.174405511196609e-01 -6.061021541710738e+00 -5.995624345518920e+00 3.324769962496906e+00 4.700290783213729e+00 9.203638699259171e+03 + 58900 9.326461484994001e-01 -6.079713223268204e+00 -5.961488583842024e+00 3.274276633133124e+00 4.953140807922074e+00 9.099202310953411e+03 + 58920 9.107726089232026e-01 -6.032820528488055e+00 -5.997525652005759e+00 3.544328132470887e+00 4.746996775096717e+00 9.209459443762575e+03 + 58940 9.484697630993920e-01 -6.062971743756291e+00 -6.032085452377691e+00 3.326591841704096e+00 4.503945706438163e+00 9.315820168886823e+03 + 58960 9.578025802011089e-01 -6.047473089778261e+00 -5.949978583372001e+00 3.445800540362444e+00 5.005629083373298e+00 9.064120104169011e+03 + 58980 9.324328469124796e-01 -5.973860725138090e+00 -5.979152487261608e+00 3.832670399513826e+00 4.802284282503045e+00 9.153134848223955e+03 + 59000 9.770465612525301e-01 -5.998081855298754e+00 -6.001402246666762e+00 3.649133619328003e+00 4.630067418263993e+00 9.221332833053100e+03 + 59020 9.690529917751355e-01 -5.949282382277953e+00 -5.975399660343177e+00 3.927877626563679e+00 4.777908174277447e+00 9.141694267949115e+03 + 59040 9.607198335883824e-01 -5.906335927435333e+00 -6.000766188161747e+00 4.164338615885382e+00 4.622105445758694e+00 9.219386821307584e+03 + 59060 9.714203768033525e-01 -5.896326777417968e+00 -6.052121065529901e+00 4.276731485878347e+00 4.382136574451459e+00 9.377749950615229e+03 + 59080 1.036719879096489e+00 -5.974027622621298e+00 -6.010333264044967e+00 3.825268702143613e+00 4.616796090809050e+00 9.248792131102942e+03 + 59100 1.009437856584863e+00 -5.921752542342842e+00 -6.008039599674184e+00 4.125439207453054e+00 4.629965571377524e+00 9.241724674575711e+03 + 59120 1.064047069353855e+00 -5.996074529125561e+00 -6.023325356042254e+00 3.711306045477918e+00 4.554827580270433e+00 9.288750641498613e+03 + 59140 1.049637957546836e+00 -5.974113174287741e+00 -6.017543930393512e+00 3.829027547174884e+00 4.579641424727757e+00 9.270979826588762e+03 + 59160 1.018443655585699e+00 -5.932516656195644e+00 -5.984004217109235e+00 4.027181295732369e+00 4.731531753292229e+00 9.168006894355121e+03 + 59180 1.013066231459751e+00 -5.933141750402662e+00 -5.995323797841847e+00 4.074008683216666e+00 4.716949744180121e+00 9.202651583414037e+03 + 59200 1.020371451201160e+00 -5.952854377219450e+00 -6.004750241920226e+00 3.921436656178513e+00 4.623442570207553e+00 9.231611043780409e+03 + 59220 9.400231403723474e-01 -5.846871115518299e+00 -6.004101566023746e+00 4.546626704136605e+00 4.643785126000746e+00 9.229644703297890e+03 + 59240 1.019175951535978e+00 -5.980260359986271e+00 -5.973638901098907e+00 3.829780716447849e+00 4.867802158046546e+00 9.136305954977397e+03 + 59260 1.050038092042660e+00 -6.046307093560191e+00 -5.985506266464984e+00 3.492217051380323e+00 4.841344809458585e+00 9.172611256263888e+03 + 59280 1.008644728926918e+00 -6.008098933173460e+00 -6.013669339736386e+00 3.694749307556707e+00 4.662763171054755e+00 9.259067365774032e+03 + 59300 1.025178838465051e+00 -6.061681506729784e+00 -6.004221662217742e+00 3.362014822830067e+00 4.691958141900408e+00 9.230021293322692e+03 + 59320 1.009999596539260e+00 -6.074111188253026e+00 -6.009601375003241e+00 3.307565166167515e+00 4.677990496709119e+00 9.246551387740146e+03 + 59340 9.571529198653401e-01 -6.032016587211084e+00 -5.959309814924160e+00 3.537453480594878e+00 4.954947018403041e+00 9.092559681131092e+03 + 59360 9.730176158996492e-01 -6.086479840587167e+00 -5.995548438274640e+00 3.254842929349143e+00 4.776985113016702e+00 9.203377713571293e+03 + 59380 9.422490241251077e-01 -6.069310340203559e+00 -5.999325151090934e+00 3.319405393992802e+00 4.721271180050508e+00 9.214984378986424e+03 + 59400 8.998180077430101e-01 -6.027697213675223e+00 -6.007077183445922e+00 3.594513659950045e+00 4.712917064466057e+00 9.238767494097203e+03 + 59420 9.283716461808557e-01 -6.082639440284149e+00 -5.971608666823439e+00 3.312745776276151e+00 4.950301659444214e+00 9.130078818810061e+03 + 59440 8.650928054087145e-01 -5.993012559235851e+00 -5.978882759084366e+00 3.739022569572030e+00 4.820158068621367e+00 9.152330564534343e+03 + 59460 9.271127993966845e-01 -6.080465765863948e+00 -5.940846669217246e+00 3.289057879848301e+00 5.090772338779047e+00 9.036352077727162e+03 + 59480 9.327592697897629e-01 -6.073082435670546e+00 -5.966136647441862e+00 3.339297754929326e+00 4.953397020745673e+00 9.113385467163474e+03 + 59500 9.489087681937811e-01 -6.071925329641404e+00 -6.007135973492290e+00 3.333708247400490e+00 4.705738756529163e+00 9.238981572497831e+03 + 59520 1.049537194971701e+00 -6.185191701009839e+00 -5.960710469084625e+00 2.746777958129803e+00 5.035783930202754e+00 9.096850926565003e+03 + 59540 9.918911676847204e-01 -6.058541227235890e+00 -5.992207536761911e+00 3.367235915385579e+00 4.748134231192592e+00 9.193137105638227e+03 + 59560 9.299704039608901e-01 -5.920906621461212e+00 -6.034284225865150e+00 4.165931851281940e+00 4.514900101666948e+00 9.322585897197956e+03 + 59580 9.962039681197576e-01 -5.979156580076983e+00 -6.005555770294974e+00 3.801576497415016e+00 4.649988261921830e+00 9.234122523699627e+03 + 59600 9.925396140775055e-01 -5.947039222818939e+00 -6.019673924090196e+00 3.967771845668251e+00 4.550692150785006e+00 9.277546202765519e+03 + 59620 1.049828763370723e+00 -6.019256482919420e+00 -5.992194816583073e+00 3.610960701454307e+00 4.766352977336942e+00 9.193099288463351e+03 + 59640 1.026193966706725e+00 -5.979146024444496e+00 -6.072350604850524e+00 3.732157809527806e+00 4.196962685474189e+00 9.440474347348141e+03 + 59660 9.812451572079391e-01 -5.912009138192795e+00 -6.035483743724102e+00 4.147093161249686e+00 4.438082868655472e+00 9.326307032059536e+03 + 59680 1.054008849222161e+00 -6.022918866306718e+00 -6.024655093687268e+00 3.579199205384703e+00 4.569229519085265e+00 9.292897829485279e+03 + 59700 1.097691374778930e+00 -6.095928785413954e+00 -6.004636740247515e+00 3.211884095587965e+00 4.736097146331987e+00 9.231308553133722e+03 + 59720 9.649649211003423e-01 -5.910083010300154e+00 -6.017181033064592e+00 4.175703458586566e+00 4.560730038507704e+00 9.269860339638544e+03 + 59740 1.017694556757348e+00 -6.000361721176006e+00 -5.974641598734785e+00 3.701608733675957e+00 4.849297656909538e+00 9.139364178665923e+03 + 59760 1.068763034483956e+00 -6.088926211299348e+00 -5.948739070476043e+00 3.240579371179659e+00 5.045555627677004e+00 9.060350919707487e+03 + 59780 9.928050003212269e-01 -5.987501683076895e+00 -6.005960981907740e+00 3.732515535823041e+00 4.626519385369070e+00 9.235377231819260e+03 + 59800 9.972606190020818e-01 -6.007385378181562e+00 -5.977126276687540e+00 3.661333564392177e+00 4.835086007751674e+00 9.146960868619482e+03 + 59820 9.718024577862364e-01 -5.982968338981941e+00 -6.041952094670615e+00 3.714267580554281e+00 4.375573727683225e+00 9.346273115332533e+03 + 59840 9.773207509236299e-01 -6.003801888793769e+00 -6.010312159843920e+00 3.662573296641228e+00 4.625190312810067e+00 9.248747227750526e+03 + 59860 1.050650717314819e+00 -6.123942101180395e+00 -5.963042498502828e+00 3.021650297059060e+00 4.945560714766693e+00 9.103955717885674e+03 + 59880 1.024674214855225e+00 -6.096581652866909e+00 -5.977956362299416e+00 3.147689338141797e+00 4.828854113784729e+00 9.149512241975426e+03 + 59900 9.304978070163682e-01 -5.968145472557999e+00 -5.948252070193631e+00 3.874384019858534e+00 4.988615014728803e+00 9.058871658143815e+03 + 59920 9.821434165550241e-01 -6.050363128219010e+00 -5.999785005895893e+00 3.451744776141788e+00 4.742172181460259e+00 9.216383771453568e+03 + 59940 9.834417200027225e-01 -6.056789615698548e+00 -5.979365147298608e+00 3.358308356081999e+00 4.802891635032219e+00 9.153821410350085e+03 + 59960 9.010491803828863e-01 -5.934876171215766e+00 -6.020640005049570e+00 4.003312858019507e+00 4.510843652235413e+00 9.280498005108017e+03 + 59980 9.690452672105401e-01 -6.030508043114470e+00 -5.970228865956464e+00 3.538443615542470e+00 4.884575978956253e+00 9.125885808505822e+03 + 60000 9.792381169541542e-01 -6.034751237862288e+00 -5.983096174736600e+00 3.552081089490495e+00 4.848692455553380e+00 9.165202854529103e+03 + 60020 9.548227516055019e-01 -5.981247466664838e+00 -5.994726304508069e+00 3.821688320127290e+00 4.744290747388048e+00 9.200855732182981e+03 + 60040 9.979527318874679e-01 -6.020634287683200e+00 -6.002072250127325e+00 3.546580302127317e+00 4.653166394239182e+00 9.223407830809057e+03 + 60060 9.985033154936550e-01 -5.990409367849090e+00 -6.005134909552597e+00 3.744657925246870e+00 4.660101586015127e+00 9.232830278076048e+03 + 60080 1.003067708535689e+00 -5.963590367700278e+00 -6.012646064949436e+00 3.866237030038262e+00 4.584551625088980e+00 9.255917759904125e+03 + 60100 1.039270235986645e+00 -5.983957752547511e+00 -5.959136776300924e+00 3.808606913142085e+00 4.951132799783646e+00 9.092021955211525e+03 + 60120 1.004922349870197e+00 -5.900627041618872e+00 -5.989785639144635e+00 4.226171483712165e+00 4.714209019470856e+00 9.185711212574932e+03 + 60140 1.116034624702739e+00 -6.035564755738976e+00 -5.996202134777989e+00 3.507938625061452e+00 4.733964885965348e+00 9.205401351321241e+03 + 60160 1.062322547961327e+00 -5.935779131173446e+00 -6.036085822892444e+00 4.004272295647070e+00 4.428295749386206e+00 9.328144822588676e+03 + 60180 1.057893635779811e+00 -5.919284229888382e+00 -5.961648108770857e+00 4.103807998337169e+00 4.860548050004926e+00 9.099708498175036e+03 + 60200 9.748560885129710e-01 -5.792233099321571e+00 -6.049048916596278e+00 4.759663285874439e+00 4.284987120963788e+00 9.368181588047355e+03 + 60220 9.494807721140246e-01 -5.755502452100460e+00 -6.094995377963203e+00 4.911676229656985e+00 3.962255312992633e+00 9.510957019835512e+03 + 60240 1.127967930151936e+00 -6.028807417451349e+00 -5.963752663535212e+00 3.543855050797900e+00 4.917409514974986e+00 9.106120673892225e+03 + 60260 1.012856649063352e+00 -5.874253113070846e+00 -6.036246795348310e+00 4.369594725178610e+00 4.439401933100100e+00 9.328641437095515e+03 + 60280 1.099011325657470e+00 -6.027386822475330e+00 -6.003367199971078e+00 3.534024184355423e+00 4.671948573799405e+00 9.227368295864970e+03 + 60300 9.852177145575878e-01 -5.892417339376038e+00 -6.044359308391131e+00 4.269462342128125e+00 4.396988043099749e+00 9.353708528428149e+03 + 60320 1.018985787282739e+00 -5.982526383550416e+00 -6.015077729936632e+00 3.756331762446513e+00 4.569416894192292e+00 9.263396435323310e+03 + 60340 9.897738465928323e-01 -5.984957416050903e+00 -5.990424352556690e+00 3.821899981614300e+00 4.790507986192380e+00 9.187661850442728e+03 + 60360 9.842374109992664e-01 -6.014569366289045e+00 -5.977213323282850e+00 3.641877038054353e+00 4.856381217824900e+00 9.147195798214496e+03 + 60380 9.907865090611933e-01 -6.049343604455718e+00 -5.966617815175850e+00 3.409752350715614e+00 4.884776634535136e+00 9.114875553835702e+03 + 60400 1.032105636957626e+00 -6.126717269635181e+00 -5.977985729021436e+00 3.035461722573926e+00 4.889501244909573e+00 9.149609049905668e+03 + 60420 9.771762255801024e-01 -6.054158480868370e+00 -5.994651073951631e+00 3.396392257669266e+00 4.738092996926644e+00 9.200642749607810e+03 + 60440 9.031762377939777e-01 -5.946680915494948e+00 -6.031760646233129e+00 3.893261781962646e+00 4.404720802018232e+00 9.314789654392420e+03 + 60460 9.388292718965763e-01 -5.996534727594168e+00 -6.010677745527714e+00 3.682733688091846e+00 4.601522290492470e+00 9.249856179857614e+03 + 60480 9.873627427179477e-01 -6.063133338478625e+00 -5.987900193740066e+00 3.343922368069780e+00 4.775922727450110e+00 9.179946513406374e+03 + 60500 9.370560782276102e-01 -5.980311267746004e+00 -6.005273045864255e+00 3.804205833589085e+00 4.660871440811404e+00 9.233237680831988e+03 + 60520 9.864765489939564e-01 -6.041914265441079e+00 -6.012446990843739e+00 3.478306384346034e+00 4.647512035129967e+00 9.255280256539812e+03 + 60540 9.326923661394546e-01 -5.949700351775981e+00 -6.001604042494281e+00 3.917980113984412e+00 4.619941089809748e+00 9.221989860013951e+03 + 60560 9.970234961616862e-01 -6.029285495676776e+00 -6.006098734346889e+00 3.534762767101518e+00 4.667904738797450e+00 9.235777197239040e+03 + 60580 9.940548889875369e-01 -6.009163445049239e+00 -5.964183412777984e+00 3.677644769921884e+00 4.935927075860927e+00 9.107424332804623e+03 + 60600 1.007146094020540e+00 -6.009531698598634e+00 -6.006001910714903e+00 3.620633909298536e+00 4.640902497559830e+00 9.235481109277813e+03 + 60620 1.069602061730301e+00 -6.082618459807985e+00 -5.993352104430206e+00 3.217816424605439e+00 4.730397651108489e+00 9.196658495219208e+03 + 60640 1.006650009157978e+00 -5.970609021872706e+00 -5.990071495507388e+00 3.861167337119631e+00 4.749410801701226e+00 9.186611010544573e+03 + 60660 1.005227828344915e+00 -5.950959067603270e+00 -6.008654136144559e+00 3.936463294842549e+00 4.605169282995465e+00 9.243628219609025e+03 + 60680 1.066582331049393e+00 -6.025528292841015e+00 -5.991019025785428e+00 3.583998910075301e+00 4.782156461800302e+00 9.189503917892309e+03 + 60700 1.117092348006975e+00 -6.088157060598327e+00 -5.939413761200118e+00 3.255319489259864e+00 5.109426532355569e+00 9.031996575744522e+03 + 60720 9.625956845734682e-01 -5.848589657197572e+00 -6.001309347295468e+00 4.510397566093252e+00 4.633457472255471e+00 9.221036613344224e+03 + 60740 1.044336167894014e+00 -5.959810663420306e+00 -5.973060575799828e+00 3.883834983855806e+00 4.807751936555283e+00 9.134525576274162e+03 + 60760 1.059695795975601e+00 -5.972380785556971e+00 -5.982012728209041e+00 3.806016915248799e+00 4.750708810002308e+00 9.161902853821541e+03 + 60780 1.055664797979835e+00 -5.957674587342302e+00 -6.030007144556853e+00 3.879104531388129e+00 4.463759794435123e+00 9.309402160326657e+03 + 60800 1.069816866277536e+00 -5.976586612145033e+00 -6.023304957502297e+00 3.804703642498488e+00 4.536439673816496e+00 9.288742986466101e+03 + 60820 1.062399476041358e+00 -5.971377993451959e+00 -6.044660621699075e+00 3.812441846816844e+00 4.391641654971833e+00 9.354671110984058e+03 + 60840 1.030151148547479e+00 -5.941656545636704e+00 -6.032160811080040e+00 3.995587231840990e+00 4.475897734175540e+00 9.316039944154305e+03 + 60860 1.002194306715984e+00 -5.928823785041410e+00 -6.024714434158351e+00 4.022775230193277e+00 4.472156283933811e+00 9.293077712145256e+03 + 60880 1.016163647544101e+00 -5.989169687206058e+00 -5.977939496252956e+00 3.768585335724272e+00 4.833070830043414e+00 9.149449495707766e+03 + 60900 9.994709456385514e-01 -6.006795951104308e+00 -5.967397431450641e+00 3.724017947105854e+00 4.950250343858417e+00 9.117234160601323e+03 + 60920 9.663820711266167e-01 -5.996811115649066e+00 -6.044946342532825e+00 3.687287045879680e+00 4.410887124210847e+00 9.355566324412746e+03 + 60940 1.038629516177633e+00 -6.143238297816589e+00 -5.992780070404690e+00 2.908649708630718e+00 4.772604133765292e+00 9.194920335132474e+03 + 60960 9.409447798703757e-01 -6.026441553907702e+00 -6.025880451294283e+00 3.523568775119218e+00 4.526790713155822e+00 9.296668941049915e+03 + 60980 9.161091875284963e-01 -6.008204018811431e+00 -6.045780121907536e+00 3.594303053199751e+00 4.378535254338752e+00 9.358136795974515e+03 + 61000 9.404640611654228e-01 -6.055943371085851e+00 -5.997783641996533e+00 3.432801395375576e+00 4.766763559995425e+00 9.210259864537036e+03 + 61020 9.599047657803804e-01 -6.089217354468517e+00 -6.001468480695396e+00 3.194239741510166e+00 4.698107353809761e+00 9.221571128010715e+03 + 61040 9.363109466619237e-01 -6.053073461651056e+00 -5.988950033009683e+00 3.392337623898882e+00 4.760544274226159e+00 9.183174540948299e+03 + 61060 9.468843179242923e-01 -6.062203950736469e+00 -5.993478175476405e+00 3.339855210975870e+00 4.734489247798512e+00 9.197047075835977e+03 + 61080 9.254280787390773e-01 -6.016051775186869e+00 -6.029507036881855e+00 3.526034206429098e+00 4.448772011581473e+00 9.307855635808994e+03 + 61100 1.039004291442854e+00 -6.165515527969873e+00 -5.973311425285971e+00 2.828690471019324e+00 4.932356172119059e+00 9.135320950635514e+03 + 61120 9.594959663539009e-01 -6.024361794236742e+00 -5.996879920463199e+00 3.572574759638818e+00 4.730379931652723e+00 9.207477677052811e+03 + 61140 1.007581561662352e+00 -6.069680199972549e+00 -5.990115400904527e+00 3.338359159865723e+00 4.795232548727172e+00 9.186736517631556e+03 + 61160 9.485937097594010e-01 -5.950863867520932e+00 -6.026824484704687e+00 3.993448246558033e+00 4.557270627821386e+00 9.299576312302102e+03 + 61180 9.944136862052958e-01 -5.989060783777992e+00 -6.006290567860121e+00 3.749665195698111e+00 4.650729109198052e+00 9.236351574160662e+03 + 61200 9.984887612195634e-01 -5.966814287731852e+00 -6.007668106307779e+00 3.884134660623560e+00 4.649545712252594e+00 9.240596839098775e+03 + 61220 1.040807427699743e+00 -6.005258145185499e+00 -5.985942422903285e+00 3.677064826200536e+00 4.787978692643366e+00 9.173940232929590e+03 + 61240 1.089414784366308e+00 -6.060090801225584e+00 -6.007082181327001e+00 3.373893873118884e+00 4.678277571633968e+00 9.238787440009199e+03 + 61260 1.046411786180701e+00 -5.985240352229604e+00 -6.030274068416206e+00 3.817413535158887e+00 4.558822967870365e+00 9.310190443775948e+03 + 61280 1.056035978912185e+00 -5.995959241522528e+00 -6.027415047340622e+00 3.745531696052654e+00 4.564907591274943e+00 9.301422745368667e+03 + 61300 1.033156974770224e+00 -5.965141774874835e+00 -6.039410480917681e+00 3.945910442428725e+00 4.519448039285590e+00 9.338431388439487e+03 + 61320 1.013312180328338e+00 -5.941551462691994e+00 -6.044411352501586e+00 4.021472605571063e+00 4.430835200767878e+00 9.353882963391035e+03 + 61340 1.037598281110481e+00 -5.983954260842314e+00 -6.064012964460832e+00 3.750651476967456e+00 4.290942011745580e+00 9.414617692818625e+03 + 61360 1.004998317508862e+00 -5.945428885874893e+00 -6.085228230945821e+00 3.980961834751506e+00 4.178212361475509e+00 9.480537194400116e+03 + 61380 1.018498702157547e+00 -5.978309606784621e+00 -6.040685374907138e+00 3.826226516739375e+00 4.468055203560963e+00 9.342372809802431e+03 + 61400 1.007716173671424e+00 -5.975462018777636e+00 -6.003514039234251e+00 3.853859666460119e+00 4.692780623962099e+00 9.227840060418508e+03 + 61420 9.880656526509789e-01 -5.956926822752814e+00 -6.042720833059705e+00 3.898191510991679e+00 4.405549027229331e+00 9.348666215615733e+03 + 61440 9.874291487349396e-01 -5.967071512064733e+00 -6.039586042098338e+00 3.883802295978281e+00 4.467412642938063e+00 9.338959027710413e+03 + 61460 9.924733247488995e-01 -5.985493713578509e+00 -5.996881111113571e+00 3.778586339306887e+00 4.713198140466488e+00 9.207471323719788e+03 + 61480 9.631281098509382e-01 -5.950982340350132e+00 -6.001048120617838e+00 3.937292676363648e+00 4.649807218412020e+00 9.220259219041198e+03 + 61500 9.361042557513533e-01 -5.918616241918593e+00 -6.013710878955661e+00 4.084007775800443e+00 4.537959654086078e+00 9.259196738327104e+03 + 61520 1.009468985185843e+00 -6.033395656617728e+00 -5.987169519466180e+00 3.514338262576454e+00 4.779775895572249e+00 9.177693111382318e+03 + 61540 9.556579681725801e-01 -5.957172580295218e+00 -6.017298306528891e+00 3.904178258574752e+00 4.558927034114937e+00 9.270215413067812e+03 + 61560 9.493016130907036e-01 -5.951123769430280e+00 -6.020912843343474e+00 3.938270706976001e+00 4.537531044742161e+00 9.281327491324368e+03 + 61580 1.037133609177831e+00 -6.083773028666744e+00 -5.961337793561862e+00 3.227619683112565e+00 4.930661749876199e+00 9.098745281281510e+03 + 61600 9.209993876193883e-01 -5.912683875298553e+00 -6.002464343208392e+00 4.129167001124174e+00 4.613633660903372e+00 9.224595407017185e+03 + 61620 1.012222573951757e+00 -6.047183087064413e+00 -5.965112585669097e+00 3.436039060176421e+00 4.907300579557374e+00 9.110253947074481e+03 + 61640 9.664280932335220e-01 -5.973504711746660e+00 -5.986885508384360e+00 3.774597786567704e+00 4.697763181602450e+00 9.176829978170630e+03 + 61660 1.036531160506776e+00 -6.065130922450602e+00 -6.007152881282404e+00 3.343551953980373e+00 4.676470838441042e+00 9.239031127924982e+03 + 61680 1.014199404011539e+00 -6.014874229730343e+00 -6.027816433136993e+00 3.614197544157571e+00 4.539881409397086e+00 9.302650967495252e+03 + 61700 1.016295471701983e+00 -5.997420507484690e+00 -6.000594426829979e+00 3.713019977643822e+00 4.694794841600741e+00 9.218873357462166e+03 + 61720 1.060831796567663e+00 -6.035962188316041e+00 -5.985337403125397e+00 3.497339565054176e+00 4.788034915779042e+00 9.172084354306195e+03 + 61740 1.035991851464412e+00 -5.967014161010237e+00 -6.006532667371546e+00 3.875933199721967e+00 4.649011820726231e+00 9.237119818548326e+03 + 61760 1.080023941157050e+00 -6.000579166758146e+00 -6.034217350568420e+00 3.696632132375853e+00 4.503476475445142e+00 9.322368273422075e+03 + 61780 1.062602893011554e+00 -5.950961623579061e+00 -6.009858696879664e+00 3.968022687923110e+00 4.629826578738411e+00 9.247323719914541e+03 + 61800 1.118335344043172e+00 -6.015475846394401e+00 -5.980909432842675e+00 3.599413862162734e+00 4.797899557911956e+00 9.158488227975347e+03 + 61820 9.610002317869664e-01 -5.768557617158664e+00 -6.024690141942383e+00 4.951543759679800e+00 4.480791165991579e+00 9.292980825482138e+03 + 61840 1.098420872777274e+00 -5.964453910789782e+00 -6.054651850838824e+00 3.853128526932120e+00 4.335197997084409e+00 9.385587797816775e+03 + 61860 1.119415722735803e+00 -5.998990463036236e+00 -5.989918173227140e+00 3.691034930448727e+00 4.743129422464862e+00 9.186124315691568e+03 + 61880 1.001699767413489e+00 -5.836786097264923e+00 -5.977728184221703e+00 4.560488750339738e+00 4.751177476316445e+00 9.148778409895034e+03 + 61900 1.101105259157638e+00 -6.002350162134237e+00 -5.994388917414124e+00 3.684674353016960e+00 4.730389052198491e+00 9.199804330202260e+03 + 61920 1.039551142340384e+00 -5.940931384539250e+00 -5.976452180464294e+00 4.057764312329887e+00 4.853798405302881e+00 9.144875624319682e+03 + 61940 1.037405410506732e+00 -5.972682296274963e+00 -5.964697660482469e+00 3.839291942830466e+00 4.885140957169362e+00 9.108958826526086e+03 + 61960 1.043446167178061e+00 -6.019473090481974e+00 -5.956644510137300e+00 3.582769076996329e+00 4.943540508026832e+00 9.084420124386215e+03 + 61980 9.589419657618914e-01 -5.928355678297665e+00 -5.991438818023042e+00 4.098911166457329e+00 4.736678016069892e+00 9.190768453901737e+03 + 62000 9.821405620457598e-01 -5.992649620525007e+00 -6.006455700600505e+00 3.702573201448218e+00 4.623296553170721e+00 9.236896578024307e+03 + 62020 9.842293825081374e-01 -6.020439686979874e+00 -6.005505616664406e+00 3.610226137823618e+00 4.695979880614947e+00 9.233972563026253e+03 + 62040 1.000551788281075e+00 -6.064314678382662e+00 -5.985112643750659e+00 3.400438728845703e+00 4.855229068177914e+00 9.171393246754955e+03 + 62060 9.593068364601743e-01 -6.015030097043269e+00 -5.996061753521810e+00 3.608884926969083e+00 4.717804090810970e+00 9.204948673939070e+03 + 62080 1.023472256985552e+00 -6.116734315578851e+00 -5.984083782340442e+00 3.041016604804892e+00 4.802716494263512e+00 9.168277009890386e+03 + 62100 9.762887797877424e-01 -6.050965579699074e+00 -5.998078885214180e+00 3.466713601933390e+00 4.770397185855176e+00 9.211161761834483e+03 + 62120 9.447407732966406e-01 -6.004985256120595e+00 -5.999653336523449e+00 3.688132561703374e+00 4.718749269142074e+00 9.215975014772112e+03 + 62140 9.933132964820502e-01 -6.072519951410456e+00 -5.977780611571165e+00 3.318984350281193e+00 4.862992300503858e+00 9.148981168243648e+03 + 62160 1.009551985966084e+00 -6.088909984053010e+00 -5.985461198268279e+00 3.230840174528006e+00 4.824859111151795e+00 9.172483647851468e+03 + 62180 9.763340907078902e-01 -6.031322237201060e+00 -5.986546614788339e+00 3.555813514048211e+00 4.812922066947229e+00 9.175795971341797e+03 + 62200 9.323589307472874e-01 -5.956211193106879e+00 -5.975315632102532e+00 3.979437486727563e+00 4.869736841612140e+00 9.141401099590341e+03 + 62220 9.921276796266080e-01 -6.032010190942015e+00 -5.953483249220325e+00 3.519514096861025e+00 4.970427948231929e+00 9.074806502756534e+03 + 62240 1.031795470403309e+00 -6.073394737109822e+00 -5.975621310147115e+00 3.363814138061624e+00 4.925244286070406e+00 9.142351020155264e+03 + 62260 9.536112681182901e-01 -5.941010123343466e+00 -6.017098952205382e+00 3.990864012669904e+00 4.553950182636570e+00 9.269579131694525e+03 + 62280 9.726710372682733e-01 -5.951866606819493e+00 -6.064821691377742e+00 3.904137240938172e+00 4.255531665661865e+00 9.417112208307291e+03 + 62300 1.041694028801626e+00 -6.040611859169137e+00 -6.016182569229875e+00 3.494766937278481e+00 4.635043700530121e+00 9.266816534616410e+03 + 62320 9.925665925326822e-01 -5.959190845944978e+00 -6.014172567323170e+00 3.908856189388596e+00 4.593142636841126e+00 9.260606731811275e+03 + 62340 1.013881059759537e+00 -5.981518206312482e+00 -6.024099340382332e+00 3.795905825467764e+00 4.551398364229489e+00 9.291175801670208e+03 + 62360 1.092360232183733e+00 -6.092675483993644e+00 -5.989566658670199e+00 3.232684683346760e+00 4.824751514393130e+00 9.185062222362441e+03 + 62380 9.552773004690862e-01 -5.888134196823943e+00 -6.078204050171570e+00 4.304062659803792e+00 4.212652148666976e+00 9.458679765310550e+03 + 62400 1.041221254466387e+00 -6.016961725408295e+00 -6.043056347443240e+00 3.556368285361887e+00 4.406528927507516e+00 9.349704430984682e+03 + 62420 9.881448993843789e-01 -5.941758463387218e+00 -6.028034201348557e+00 4.042513925707521e+00 4.547105287206215e+00 9.303283867627364e+03 + 62440 9.500091774352003e-01 -5.889110561049678e+00 -6.017635532659334e+00 4.332753172385853e+00 4.594742896228135e+00 9.271266324650172e+03 + 62460 1.045942099718244e+00 -6.034245581843242e+00 -5.990229476258861e+00 3.537263342832827e+00 4.790010632568669e+00 9.187108585145739e+03 + 62480 1.041267220510514e+00 -6.031799315898267e+00 -6.027085624843991e+00 3.568428332643041e+00 4.595495076118024e+00 9.300386961457316e+03 + 62500 1.015133324984090e+00 -5.997820906667676e+00 -6.034237312335010e+00 3.694762993830391e+00 4.485654357067993e+00 9.322444632233706e+03 + 62520 9.207585674399991e-01 -5.860863511680568e+00 -6.090763760628489e+00 4.420798014465952e+00 4.100675208058444e+00 9.497787003394165e+03 + 62540 9.799539536238322e-01 -5.953868800956807e+00 -6.025698070383503e+00 3.952119446535373e+00 4.539664665943770e+00 9.296106783440324e+03 + 62560 9.372357321256375e-01 -5.894654046886115e+00 -6.008913748105241e+00 4.262498999102810e+00 4.606402113070970e+00 9.244440377281002e+03 + 62580 1.004186675686261e+00 -5.996378856047244e+00 -5.997579892353412e+00 3.700146688628436e+00 4.693250152298653e+00 9.209609285987284e+03 + 62600 1.040755370728585e+00 -6.052610281810900e+00 -6.010377526584991e+00 3.434816672454946e+00 4.677323688459865e+00 9.248953849754813e+03 + 62620 9.496097883184544e-01 -5.921682269888001e+00 -6.085800819651408e+00 4.041137723039439e+00 4.098743613034460e+00 9.482330451516749e+03 + 62640 9.592711431186796e-01 -5.943179388812210e+00 -6.061478695649934e+00 3.938753673982306e+00 4.259460747361524e+00 9.406710323590094e+03 + 62660 9.505408697433528e-01 -5.936494254727672e+00 -6.004397087838798e+00 4.000724585280537e+00 4.610816009626987e+00 9.230547362491641e+03 + 62680 9.887608235021672e-01 -5.998039340307594e+00 -6.017020620553342e+00 3.629426255856961e+00 4.520432807342253e+00 9.269351089308431e+03 + 62700 9.535806300321217e-01 -5.951850506030696e+00 -6.026946260041028e+00 3.896256415330833e+00 4.465044974773135e+00 9.299956913181539e+03 + 62720 9.808653147112377e-01 -5.997834057687443e+00 -6.008898614797507e+00 3.669925498687258e+00 4.606391099526594e+00 9.244375769524222e+03 + 62740 9.939728060248710e-01 -6.021753472098739e+00 -6.004400870221325e+00 3.548416611570156e+00 4.648057936856735e+00 9.230564747109578e+03 + 62760 9.595626938313674e-01 -5.973989163775299e+00 -6.009209130175025e+00 3.847928156272395e+00 4.645689658932979e+00 9.245331499691067e+03 + 62780 1.038785530553660e+00 -6.094584750102364e+00 -5.982504882782291e+00 3.164588096572888e+00 4.808168039028162e+00 9.163427375525582e+03 + 62800 9.362208326602719e-01 -5.946202125227282e+00 -6.039942907344392e+00 3.982785769765413e+00 4.444511692509819e+00 9.340065965558764e+03 + 62820 9.802561974215329e-01 -6.015291345013821e+00 -6.032126282063255e+00 3.603209994133666e+00 4.506541180397724e+00 9.315938717151310e+03 + 62840 9.987509292056388e-01 -6.045058385066110e+00 -5.988875647776164e+00 3.485997207807608e+00 4.808607179576970e+00 9.182932591413235e+03 + 62860 9.968972976531207e-01 -6.044519275761417e+00 -5.972100256397201e+00 3.479877608147384e+00 4.895718824143745e+00 9.131564951422504e+03 + 62880 9.410044164211975e-01 -5.960201620236342e+00 -6.048849208050574e+00 3.854980487598586e+00 4.345952320199388e+00 9.367579203903319e+03 + 62900 9.309919540800997e-01 -5.942293960720907e+00 -6.009035903909819e+00 4.070177470257694e+00 4.686934904184629e+00 9.244773300186718e+03 + 62920 9.736347080751713e-01 -5.999049941115906e+00 -6.020748707029274e+00 3.690740800340071e+00 4.566143128592342e+00 9.280850188032719e+03 + 62940 9.723019485041715e-01 -5.985435939799022e+00 -6.008116200602258e+00 3.786045678251211e+00 4.655812110960015e+00 9.241985054443574e+03 + 62960 9.978929919981180e-01 -6.009337047123116e+00 -6.016034759536017e+00 3.640130496073930e+00 4.601671194931407e+00 9.266345357027192e+03 + 62980 1.019254025808548e+00 -6.025497904822311e+00 -5.987632241920867e+00 3.574885881588319e+00 4.792316377660808e+00 9.179100573120139e+03 + 63000 1.003169487026040e+00 -5.984122517482056e+00 -6.015452414939256e+00 3.754620831267056e+00 4.574719711781853e+00 9.264568342013066e+03 + 63020 9.676497819301970e-01 -5.912168855664488e+00 -6.047561826805097e+00 4.167440308500272e+00 4.389992916216324e+00 9.363624335001488e+03 + 63040 9.565425859529111e-01 -5.875982530335513e+00 -6.051408215110659e+00 4.366569811268846e+00 4.359248382252974e+00 9.375513406673968e+03 + 63060 1.067958257163999e+00 -6.021539261015828e+00 -5.980105855404756e+00 3.573404204162423e+00 4.811321230979996e+00 9.156056027586314e+03 + 63080 9.946599876636927e-01 -5.893957774742841e+00 -6.002282050612820e+00 4.291372390887616e+00 4.669357635714687e+00 9.224048738478006e+03 + 63100 1.089792442288648e+00 -6.017314007357442e+00 -5.979538346426750e+00 3.604474397393449e+00 4.821388088222113e+00 9.154350467366530e+03 + 63120 9.726452535579506e-01 -5.830765797444119e+00 -6.028357959621006e+00 4.636799562528878e+00 4.502194790020919e+00 9.304272590268925e+03 + 63140 9.735416466033833e-01 -5.822192481342206e+00 -6.024443646176032e+00 4.650996432021056e+00 4.489638945278620e+00 9.292188498274985e+03 + 63160 1.040035838520288e+00 -5.913879234620955e+00 -6.012294952823289e+00 4.060206572220924e+00 4.495088288519949e+00 9.254821057572992e+03 + 63180 1.067757413991905e+00 -5.952724203773219e+00 -5.957719729293175e+00 3.932977267674838e+00 4.904292187084172e+00 9.087696331810041e+03 + 63200 1.051236325078422e+00 -5.926754604541784e+00 -6.033236953731983e+00 4.083209543603873e+00 4.471771416463470e+00 9.319344456860643e+03 + 63220 1.035818133964888e+00 -5.911957496109834e+00 -6.042981958410058e+00 4.134838891773693e+00 4.382476153275797e+00 9.349473552506204e+03 + 63240 1.051097994216533e+00 -5.955218303861476e+00 -6.009131101455588e+00 4.020426590160113e+00 4.710850963396256e+00 9.245095004205272e+03 + 63260 1.051797539763915e+00 -5.988528570141257e+00 -6.017313130916915e+00 3.798827532460122e+00 4.633542130089904e+00 9.270256465046643e+03 + 63280 1.045175748241166e+00 -6.020585374904222e+00 -5.992258460238016e+00 3.622080871775229e+00 4.784738399364461e+00 9.193285966299331e+03 + 63300 1.035767515172722e+00 -6.054268053079390e+00 -5.959903248695666e+00 3.452035464448127e+00 4.993892774125758e+00 9.094373632438879e+03 + 63320 1.015026330337664e+00 -6.066835330791643e+00 -5.990318466121378e+00 3.358706176848615e+00 4.798077854731818e+00 9.187335266131149e+03 + 63340 9.970555028671690e-01 -6.074119722210478e+00 -5.991716586439683e+00 3.311886740136526e+00 4.785058297576477e+00 9.191643695491806e+03 + 63360 9.810017783266233e-01 -6.073658010202093e+00 -5.977892498282251e+00 3.349616434848223e+00 4.899516823957035e+00 9.149305590387963e+03 + 63380 9.412007876030098e-01 -6.028918703487610e+00 -6.015412211857866e+00 3.591688980111608e+00 4.669245345172426e+00 9.264425484014357e+03 + 63400 9.890615074255076e-01 -6.108043531385909e+00 -5.988648164586844e+00 3.166007308553706e+00 4.851593981087235e+00 9.182241638504895e+03 + 63420 9.341778757365110e-01 -6.030709756497517e+00 -6.006700611111914e+00 3.568556570728206e+00 4.706420798935578e+00 9.237614734038303e+03 + 63440 9.431517301872006e-01 -6.041912704524960e+00 -5.990189815162839e+00 3.459911971415075e+00 4.756912806223631e+00 9.186968925129273e+03 + 63460 9.724030191485896e-01 -6.077376288847645e+00 -6.030741523769957e+00 3.256717672097245e+00 4.524501709879904e+00 9.311671067761585e+03 + 63480 9.587000731377060e-01 -6.045475629840449e+00 -6.019802962996493e+00 3.495917176932145e+00 4.643333602782495e+00 9.277955724409121e+03 + 63500 9.758082618513113e-01 -6.055732366197238e+00 -6.037686743345152e+00 3.409396185721070e+00 4.513016944688863e+00 9.333116046426883e+03 + 63520 1.018554661161589e+00 -6.103709348471432e+00 -6.002403619862657e+00 3.133215493447401e+00 4.714928664129824e+00 9.224421320409414e+03 + 63540 9.578367941351583e-01 -5.995780988326104e+00 -5.959428345930609e+00 3.747924371305220e+00 4.956666869493375e+00 9.092900932048427e+03 + 63560 9.836339129491385e-01 -6.011622960492484e+00 -5.936206395847993e+00 3.662026562922744e+00 5.095080147787073e+00 9.022209492959721e+03 + 63580 1.033412068905945e+00 -6.054295168389799e+00 -5.946349270318334e+00 3.422230277243330e+00 5.042072328543416e+00 9.053062157580473e+03 + 63600 9.633518663308341e-01 -5.917994813366662e+00 -5.974590427552318e+00 4.165277041592708e+00 4.840296266795684e+00 9.139151289261952e+03 + 63620 1.079082895628374e+00 -6.057917503651106e+00 -5.988445387321409e+00 3.395420855696954e+00 4.794340498437334e+00 9.181602977145136e+03 + 63640 1.066937998134108e+00 -6.012031543523505e+00 -6.015986834747791e+00 3.647865266392897e+00 4.625153372103705e+00 9.266177275782313e+03 + 63660 9.590676294688957e-01 -5.835152013036339e+00 -6.015161639498864e+00 4.547121023721136e+00 4.513477892173653e+00 9.263641765780701e+03 + 63680 1.050004058555014e+00 -5.960081826383608e+00 -5.966087868823276e+00 3.908938302113195e+00 4.874450676992555e+00 9.113249083698343e+03 + 63700 9.970490695695864e-01 -5.875049817588802e+00 -6.056023678900576e+00 4.323227444074279e+00 4.284047526807540e+00 9.389839982689407e+03 + 63720 1.083089367344297e+00 -6.003965415036575e+00 -6.012463110061224e+00 3.645671099011806e+00 4.596876019166213e+00 9.255356971774141e+03 + 63740 1.051153336589059e+00 -5.961332354006992e+00 -6.040388512163151e+00 3.878079666453758e+00 4.424126972420159e+00 9.341444740003302e+03 + 63760 1.083365784035015e+00 -6.019219517544811e+00 -6.014347335876942e+00 3.620314324462615e+00 4.648291145567196e+00 9.261150429711006e+03 + 63780 1.032685919531419e+00 -5.957346737645543e+00 -5.971003760027084e+00 3.959490343707411e+00 4.881069607775220e+00 9.128251382842845e+03 + 63800 1.031562011414852e+00 -5.966715971027805e+00 -5.992356140146033e+00 3.847877141665916e+00 4.700647322785697e+00 9.193560409605112e+03 + 63820 9.826097130509681e-01 -5.905540093673393e+00 -5.967192268765917e+00 4.284850139611770e+00 4.930833809587237e+00 9.116584118599885e+03 + 63840 1.100853739646476e+00 -6.089504480569790e+00 -5.960360254057188e+00 3.205962216755573e+00 4.947528350395399e+00 9.095765532755844e+03 + 63860 9.849448545436508e-01 -5.928847265594642e+00 -6.022574632366561e+00 4.085189858624841e+00 4.546992814357351e+00 9.286470362955388e+03 + 63880 9.720291663615844e-01 -5.921380308032722e+00 -5.996957249363682e+00 4.164720457036360e+00 4.730745964420116e+00 9.207685268601112e+03 + 63900 1.047401620420432e+00 -6.045451087206579e+00 -6.009815172994442e+00 3.469849536443568e+00 4.674476470489564e+00 9.247174315891651e+03 + 63920 9.809733085804676e-01 -5.960149789772365e+00 -6.023239982916328e+00 3.884324132360903e+00 4.522050480152428e+00 9.288483149847350e+03 + 63940 1.053199632197324e+00 -6.080106765712756e+00 -6.013735751855746e+00 3.248032434096804e+00 4.629145066544958e+00 9.259248799059511e+03 + 63960 9.877683868624596e-01 -5.997542995359620e+00 -6.061201055691757e+00 3.675353555461201e+00 4.309819121981071e+00 9.405887542931845e+03 + 63980 1.023412254304517e+00 -6.068572196595353e+00 -6.037023337804508e+00 3.316363935803186e+00 4.497522365150341e+00 9.331051454147302e+03 + 64000 9.999428493318253e-01 -6.052234124500551e+00 -6.000743982801942e+00 3.464495468062789e+00 4.760159829769878e+00 9.219330110785777e+03 + 64020 9.788109166119257e-01 -6.038694633809921e+00 -5.990272997322874e+00 3.515270643167516e+00 4.793315173100173e+00 9.187228767440844e+03 + 64040 9.431802059214314e-01 -6.002256265297605e+00 -6.013522833961148e+00 3.743658299423639e+00 4.678963918661708e+00 9.258620186988923e+03 + 64060 9.959410490842744e-01 -6.097752835463974e+00 -5.961518996163914e+00 3.195947535217797e+00 4.978223322597238e+00 9.099306205061061e+03 + 64080 9.991437026211243e-01 -6.116395563626105e+00 -5.995673910249413e+00 3.068946390236556e+00 4.762148805541004e+00 9.203772492950140e+03 + 64100 9.012918200693659e-01 -5.986037504265739e+00 -6.012068394990893e+00 3.767635637969929e+00 4.618162235158776e+00 9.254126152055987e+03 + 64120 9.536172658211376e-01 -6.076830493393514e+00 -5.971744228244576e+00 3.313155259410928e+00 4.916576855943102e+00 9.130516818798313e+03 + 64140 9.284630465325070e-01 -6.050797924434632e+00 -5.984877701408317e+00 3.412095194996383e+00 4.790619316735028e+00 9.170695536385090e+03 + 64160 9.998991724579729e-01 -6.168173788979657e+00 -5.949919739300433e+00 2.749653268815461e+00 5.002901796778601e+00 9.063971633579207e+03 + 64180 9.439124970492788e-01 -6.092913662317181e+00 -5.956767015278292e+00 3.199348662237875e+00 4.981123778160713e+00 9.084813368912364e+03 + 64200 9.385852828956505e-01 -6.086118753526614e+00 -5.950661854440766e+00 3.247689945587998e+00 5.025504422026325e+00 9.066207414032049e+03 + 64220 9.148537615345610e-01 -6.042122505993161e+00 -5.973313163090566e+00 3.435077419313483e+00 4.830191314471584e+00 9.135273165151502e+03 + 64240 9.245475844427506e-01 -6.037806175121528e+00 -5.971605332050583e+00 3.568477932646315e+00 4.948613418107036e+00 9.130085711074324e+03 + 64260 9.848795098625867e-01 -6.099719151414170e+00 -6.010500232468728e+00 3.111559733132043e+00 4.623868572299852e+00 9.249320210605580e+03 + 64280 9.700409506299921e-01 -6.041682246506971e+00 -5.959574771135442e+00 3.489743346097691e+00 4.961217175771765e+00 9.093373406328697e+03 + 64300 9.737872241227268e-01 -6.008814554034523e+00 -6.016241951943336e+00 3.646814762793901e+00 4.604165494615392e+00 9.266969253243387e+03 + 64320 1.016064463553220e+00 -6.032558577175618e+00 -6.023308201655522e+00 3.520882209802991e+00 4.573999297530371e+00 9.288729412547880e+03 + 64340 1.037315711666094e+00 -6.031541456443989e+00 -6.007600111893867e+00 3.534835978147906e+00 4.672310883465808e+00 9.240404949706241e+03 + 64360 9.649142831509903e-01 -5.896972552677491e+00 -6.058551598388345e+00 4.215769125099045e+00 4.287957240350813e+00 9.397654582782283e+03 + 64380 1.025117706058997e+00 -5.966809639269153e+00 -5.986917515032474e+00 3.903565426230929e+00 4.788102891914217e+00 9.176928187464478e+03 + 64400 1.020933410005892e+00 -5.944262583515158e+00 -6.017443361356163e+00 4.037029147961219e+00 4.616813796909401e+00 9.270652578499083e+03 + 64420 1.027090491795923e+00 -5.941823694277510e+00 -6.030347418546517e+00 4.034122480802441e+00 4.525805557047749e+00 9.310429711275696e+03 + 64440 1.046640420097573e+00 -5.965068629878888e+00 -6.013342041069015e+00 3.819155700362068e+00 4.541962303022121e+00 9.258041950422437e+03 + 64460 1.034303980051276e+00 -5.945071456550881e+00 -6.007806346454960e+00 3.984747330179707e+00 4.624513884157647e+00 9.241021943580852e+03 + 64480 1.069040529355787e+00 -5.998658381675496e+00 -5.999314586795114e+00 3.690671452692228e+00 4.686903421347968e+00 9.214930940993607e+03 + 64500 1.050366223289714e+00 -5.979657760768457e+00 -6.012513298911346e+00 3.813499654857318e+00 4.624838070462753e+00 9.255478066821985e+03 + 64520 1.024220389518448e+00 -5.955721172545180e+00 -6.000350051796507e+00 3.939363493846116e+00 4.683097562888252e+00 9.218115310327361e+03 + 64540 9.686638425223425e-01 -5.893148984685073e+00 -5.969162556883545e+00 4.247731096008412e+00 4.811249401382502e+00 9.122599340269107e+03 + 64560 1.007566538529166e+00 -5.970480128273235e+00 -5.978455103265956e+00 3.899439408644982e+00 4.853645868113384e+00 9.150994555630596e+03 + 64580 1.061777414370436e+00 -6.074375128553481e+00 -5.997358452317220e+00 3.249049970713299e+00 4.691291643954038e+00 9.208941176148834e+03 + 64600 1.018431868111114e+00 -6.042026754401425e+00 -6.021148991222343e+00 3.471563606481154e+00 4.591446953478852e+00 9.282072800452497e+03 + 64620 1.029262285182320e+00 -6.096637947101426e+00 -5.946683812199510e+00 3.153458579688695e+00 5.014518427622882e+00 9.054096920132217e+03 + 64640 9.134714978100078e-01 -5.960016390640591e+00 -5.979065629924038e+00 3.886339670086495e+00 4.776955990260692e+00 9.152871573913413e+03 + 64660 9.420054659269362e-01 -6.031307049847252e+00 -5.989908942815747e+00 3.563332386623765e+00 4.801046723535025e+00 9.186075635613020e+03 + 64680 9.537796330940300e-01 -6.073486171931947e+00 -5.975957093140080e+00 3.259896325208257e+00 4.819923388207326e+00 9.143390278421350e+03 + 64700 9.000014209250177e-01 -6.008927568786804e+00 -5.996907326681081e+00 3.617032139815997e+00 4.686054230113515e+00 9.207533603663083e+03 + 64720 9.391145902626992e-01 -6.073534241902999e+00 -5.950645542947768e+00 3.268666940564259e+00 4.974312866929900e+00 9.066133227863767e+03 + 64740 9.146288719772045e-01 -6.035370666309253e+00 -5.975463930218833e+00 3.465042715376859e+00 4.809036464545505e+00 9.141859643353882e+03 + 64760 9.076184985577325e-01 -6.016356531816990e+00 -6.001078497550845e+00 3.571243151386206e+00 4.658971988410569e+00 9.220340560702023e+03 + 64780 9.500738065128423e-01 -6.065818570151616e+00 -5.971159900293564e+00 3.330284273328868e+00 4.873829004035618e+00 9.128726214208580e+03 + 64800 9.672868602691956e-01 -6.070252257671067e+00 -5.973831144058171e+00 3.310312532916163e+00 4.863977488400518e+00 9.136894988586977e+03 + 64820 9.664753299124628e-01 -6.043320016496931e+00 -6.012980407392427e+00 3.529458946498544e+00 4.703673677015943e+00 9.256930189246999e+03 + 64840 1.009254894978494e+00 -6.083905402931973e+00 -5.979721831199498e+00 3.291163401801165e+00 4.889401593044656e+00 9.154903732138358e+03 + 64860 9.163804821305365e-01 -5.927712742811967e+00 -6.043538323884180e+00 4.053852975147618e+00 4.388764564680229e+00 9.351162529101835e+03 + 64880 1.004335754429459e+00 -6.046168460384418e+00 -6.012922561121409e+00 3.395966662462893e+00 4.586869760817377e+00 9.256756406300470e+03 + 64900 9.785601404543814e-01 -5.998079173769749e+00 -5.996594971584521e+00 3.681360492122154e+00 4.689883010749279e+00 9.206583683093564e+03 + 64920 9.418083124871265e-01 -5.936704586594055e+00 -5.962354565768304e+00 4.069989736517211e+00 4.922703586777225e+00 9.101806072650708e+03 + 64940 1.012619760062547e+00 -6.033709330558290e+00 -5.942335565745022e+00 3.547634779361724e+00 5.072317076963913e+00 9.040851269551256e+03 + 64960 9.779389512979354e-01 -5.973677078602233e+00 -6.021578174883611e+00 3.868243757715872e+00 4.593188250197503e+00 9.283348066337887e+03 + 64980 1.026584869206489e+00 -6.037793852602053e+00 -5.968670948976789e+00 3.538189305087060e+00 4.935103714438090e+00 9.121132064253348e+03 + 65000 1.067320443101444e+00 -6.088564064523519e+00 -5.985956280975747e+00 3.235496913915009e+00 4.824686685549507e+00 9.174010163653107e+03 + 65020 1.029673062480023e+00 -6.027275475778575e+00 -6.027297861084548e+00 3.559551650318989e+00 4.559423110427975e+00 9.301027229893471e+03 + 65040 1.003843487973755e+00 -5.985678054646538e+00 -6.011318927153048e+00 3.753035770641685e+00 4.605801912797109e+00 9.251822818791636e+03 + 65060 9.384906951971138e-01 -5.885053660365489e+00 -6.034089932465076e+00 4.360484697480792e+00 4.504695359796398e+00 9.321997799160343e+03 + 65080 1.014985074561174e+00 -5.996578142215457e+00 -5.981380839725297e+00 3.761363707288488e+00 4.848628969961949e+00 9.159978894482419e+03 + 65100 1.006127457841999e+00 -5.982226365677290e+00 -6.005286813221590e+00 3.824396016630733e+00 4.691979358238637e+00 9.233255265620492e+03 + 65120 1.057079849448710e+00 -6.056032506821980e+00 -5.960761782739610e+00 3.448938388987679e+00 4.995997629765552e+00 9.096973977851269e+03 + 65140 9.903610856138942e-01 -5.955277711245982e+00 -6.010610842866301e+00 3.905726954719058e+00 4.587995550180739e+00 9.249657267387141e+03 + 65160 1.035476465765714e+00 -6.022076625451336e+00 -5.990924337993498e+00 3.593929009528255e+00 4.772810264912069e+00 9.189217584941072e+03 + 65180 1.024168478001474e+00 -6.007248065976556e+00 -6.007640659200170e+00 3.639812455979983e+00 4.637558124936384e+00 9.240512647310392e+03 + 65200 1.037538230851910e+00 -6.030355859083431e+00 -5.992645483484951e+00 3.539139371737331e+00 4.755678184085564e+00 9.194475911953839e+03 + 65220 9.709320167017754e-01 -5.936597078312797e+00 -6.025931880681961e+00 4.076361857974038e+00 4.563387598254309e+00 9.296814953241024e+03 + 65240 1.011848355317985e+00 -6.004868698169473e+00 -6.025245751577766e+00 3.670019131092265e+00 4.553010937083019e+00 9.294717432464824e+03 + 65260 1.003083360316010e+00 -6.005002877391429e+00 -6.001470092435295e+00 3.657537947055058e+00 4.677823744969885e+00 9.221577859794483e+03 + 65280 9.683333856162043e-01 -5.969752795817261e+00 -5.975427521017936e+00 3.885502785680778e+00 4.852917635417615e+00 9.141774253391281e+03 + 65300 1.038412366021512e+00 -6.091147939071012e+00 -5.956789767536760e+00 3.308143917381589e+00 5.079649330191115e+00 9.084871340500720e+03 + 65320 9.925924209430970e-01 -6.039985299828668e+00 -6.020393983662579e+00 3.496458617817496e+00 4.608954986989559e+00 9.279756171725643e+03 + 65340 1.010008596808134e+00 -6.086734220465566e+00 -5.996513120714971e+00 3.232162502072427e+00 4.750226018510409e+00 9.206368857462694e+03 + 65360 9.799924558539395e-01 -6.064151136444650e+00 -6.031023880036420e+00 3.291011859489346e+00 4.481233692211761e+00 9.312544276754390e+03 + 65380 9.012529040917340e-01 -5.968171219025514e+00 -6.043665424280020e+00 3.898135853912164e+00 4.464636444650285e+00 9.351598052723786e+03 + 65400 9.642036714007344e-01 -6.080606681974887e+00 -5.982343121207280e+00 3.258656819141077e+00 4.822901391305560e+00 9.162939028336295e+03 + 65420 9.039621025853570e-01 -6.005243006138436e+00 -6.023360700358520e+00 3.667862640113202e+00 4.563828036197359e+00 9.288912686773288e+03 + 65440 9.496784284127945e-01 -6.081372628716927e+00 -6.015455702074739e+00 3.296880524606193e+00 4.675385717997068e+00 9.264566402577902e+03 + 65460 9.560247752394526e-01 -6.097050538188340e+00 -5.984841481842047e+00 3.174785640158057e+00 4.819107405993822e+00 9.170596573162375e+03 + 65480 8.897071586753078e-01 -5.998160502356225e+00 -6.003138140084513e+00 3.688669631673723e+00 4.660087265550948e+00 9.226695077685928e+03 + 65500 9.236939524587462e-01 -6.040874936089637e+00 -5.958076305611851e+00 3.571311431775914e+00 5.046753981026018e+00 9.088777933226927e+03 + 65520 8.926273735148095e-01 -5.976039401548469e+00 -6.004281606456678e+00 3.870696670831116e+00 4.708525559781101e+00 9.230169476704792e+03 + 65540 1.004628263302945e+00 -6.109323879684482e+00 -5.978979818912937e+00 3.115000110958515e+00 4.863455878586937e+00 9.152638205697107e+03 + 65560 9.869444908529879e-01 -6.040084528575243e+00 -5.984210842090697e+00 3.499814479920748e+00 4.820649834140057e+00 9.168645807772566e+03 + 65580 9.873381112222560e-01 -5.995383254057569e+00 -5.991359297255277e+00 3.747231364349282e+00 4.770337547013346e+00 9.190510404304303e+03 + 65600 1.009087101763911e+00 -5.985141372284248e+00 -5.999489335263834e+00 3.792665629162518e+00 4.710277405393641e+00 9.215465285206836e+03 + 65620 1.006374393719334e+00 -5.945954033771187e+00 -5.964021731258882e+00 3.983479218716111e+00 4.879731703774622e+00 9.106920411561478e+03 + 65640 1.051625152358919e+00 -5.988803663372094e+00 -5.930860814378379e+00 3.795478350712310e+00 5.128195156261128e+00 9.006013941773670e+03 + 65660 1.027173570656162e+00 -5.935844075734046e+00 -6.008215015130796e+00 3.988209467142583e+00 4.572644333759770e+00 9.242254966231147e+03 + 65680 1.037263720448094e+00 -5.940491094624026e+00 -6.004130739484976e+00 4.020172792703154e+00 4.654744103708365e+00 9.229714471618590e+03 + 65700 1.084085947395097e+00 -6.005852054149685e+00 -5.975157787896073e+00 3.644440109079292e+00 4.820691335829882e+00 9.140948357116173e+03 + 65720 1.021761627670598e+00 -5.915823574383295e+00 -6.001769146410700e+00 4.171802136086452e+00 4.678289361470806e+00 9.222457120824361e+03 + 65740 1.033934755220310e+00 -5.940126940296423e+00 -5.976461440512929e+00 4.021786679448097e+00 4.813148356459184e+00 9.144898209822917e+03 + 65760 1.036441992390758e+00 -5.952787181425724e+00 -5.977604823172205e+00 3.898388226281408e+00 4.755881486855470e+00 9.148378541275106e+03 + 65780 1.030850235373520e+00 -5.954660149639988e+00 -5.991733005644645e+00 3.906453683794074e+00 4.693575607609407e+00 9.191667521652489e+03 + 65800 1.050284424259468e+00 -5.998288856097114e+00 -5.987344594279081e+00 3.681581368265392e+00 4.744425013243579e+00 9.178265888476664e+03 + 65820 1.048424297951453e+00 -6.014298556954945e+00 -5.994216516240106e+00 3.605839788498586e+00 4.721153973968944e+00 9.199306971269385e+03 + 65840 9.826398690321234e-01 -5.937806110113588e+00 -6.047868363229944e+00 4.007036953895847e+00 4.375042464423106e+00 9.364575751794138e+03 + 65860 9.507494460634326e-01 -5.918546221309120e+00 -6.045657876051258e+00 4.144769902491953e+00 4.414875110497596e+00 9.357744211436040e+03 + 65880 9.678010132556403e-01 -5.971177177239504e+00 -5.981712048091866e+00 3.832975320548464e+00 4.772482461848202e+00 9.160990161708822e+03 + 65900 9.806523536526537e-01 -6.016506413659373e+00 -6.018009402919178e+00 3.587640243152220e+00 4.579009846235585e+00 9.272376971936599e+03 + 65920 1.001996832718228e+00 -6.072640247923573e+00 -5.974638947129709e+00 3.307789107795037e+00 4.870527742605686e+00 9.139338706694680e+03 + 65940 8.362494505360685e-01 -5.845763840940982e+00 -6.033986838383822e+00 4.581840166405690e+00 4.501034587674185e+00 9.321634277470328e+03 + 65960 9.685513427013865e-01 -6.054775826518066e+00 -6.020480638600156e+00 3.411766486757421e+00 4.608694762945237e+00 9.280017166913136e+03 + 65980 1.000186941491519e+00 -6.111611955304877e+00 -6.017308216337502e+00 3.103497600416114e+00 4.645004263023223e+00 9.270279126783626e+03 + 66000 9.489219361313744e-01 -6.044266879635019e+00 -5.997940290008605e+00 3.463108118783460e+00 4.729122565434905e+00 9.210747325041646e+03 + 66020 9.086926446539003e-01 -5.989472255321003e+00 -6.000297832461674e+00 3.756564235457341e+00 4.694402096262952e+00 9.217968081998026e+03 + 66040 9.277615129053453e-01 -6.017352757286945e+00 -6.010038721248334e+00 3.635680278203657e+00 4.677678604980779e+00 9.247902358605816e+03 + 66060 9.794090038239940e-01 -6.086187501379802e+00 -5.987340074726680e+00 3.168441835601116e+00 4.736039056033186e+00 9.178243522210916e+03 + 66080 9.417669373413964e-01 -6.008690786281882e+00 -5.976708207053990e+00 3.678000555376230e+00 4.861649474590924e+00 9.145683887280740e+03 + 66100 1.000215049339553e+00 -6.052678144365359e+00 -5.993653542982336e+00 3.432429232489508e+00 4.771357627658372e+00 9.197577922340170e+03 + 66120 1.028825314580359e+00 -6.034443765971251e+00 -6.022993388571798e+00 3.470564400696274e+00 4.536314239664108e+00 9.287778826239575e+03 + 66140 1.059935851645271e+00 -6.023614309514848e+00 -5.999584225678230e+00 3.632705578667405e+00 4.770690038700721e+00 9.215777071489298e+03 + 66160 9.943458397351257e-01 -5.881515535691016e+00 -6.079259654071235e+00 4.302286561533712e+00 4.166809232991076e+00 9.461966536610344e+03 + 66180 1.038513027392710e+00 -5.918312898995234e+00 -6.030028781513463e+00 4.153125524339658e+00 4.511635638943038e+00 9.309445311974983e+03 + 66200 1.039159144016930e+00 -5.900715105194053e+00 -6.012811675723380e+00 4.270247900368642e+00 4.626572045501020e+00 9.256393245515907e+03 + 66220 1.017344842690053e+00 -5.856375271147563e+00 -6.078088269222683e+00 4.462091269866718e+00 4.188980924943811e+00 9.458293276741186e+03 + 66240 1.098874202506519e+00 -5.975904190827492e+00 -6.002415928529254e+00 3.775197110290220e+00 4.622962609728551e+00 9.224470784238101e+03 + 66260 1.021910740955346e+00 -5.868599591197086e+00 -6.033830672377805e+00 4.350607704021588e+00 4.401825266454720e+00 9.321172765028748e+03 + 66280 1.036896364342283e+00 -5.902700980366088e+00 -5.978564734365579e+00 4.264910292913122e+00 4.829288877570055e+00 9.151350441953069e+03 + 66300 1.056316060038446e+00 -5.950485955261097e+00 -6.009379716435562e+00 4.002631820567734e+00 4.664454730123869e+00 9.245855476495253e+03 + 66320 1.061106089337134e+00 -5.983950321191948e+00 -6.042194041750245e+00 3.776869866940574e+00 4.442425410308203e+00 9.347013184925141e+03 + 66340 1.028227756942927e+00 -5.966705195385762e+00 -6.039706573178593e+00 3.829236105727062e+00 4.410050897513921e+00 9.339320019430890e+03 + 66360 1.009642267512452e+00 -5.975541743516080e+00 -6.031870641667219e+00 3.778378275514280e+00 4.454929025461619e+00 9.315141589134480e+03 + 66380 1.001259269424995e+00 -5.999262095099518e+00 -5.962426830428608e+00 3.720313085744203e+00 4.931826875723354e+00 9.102069121245207e+03 + 66400 9.808064890756144e-01 -5.996607716908096e+00 -5.986143317378830e+00 3.712107937065821e+00 4.772196138523463e+00 9.174565021907893e+03 + 66420 1.021969614834881e+00 -6.078796615315443e+00 -5.960398230718621e+00 3.306158372626605e+00 4.986020219072358e+00 9.095875325393972e+03 + 66440 1.008992778473687e+00 -6.075740271776201e+00 -6.000497024864034e+00 3.265584124303698e+00 4.697642491928189e+00 9.218576962236022e+03 + 66460 9.707859594392138e-01 -6.031865596499809e+00 -5.993764792980953e+00 3.509778023369268e+00 4.728558733254836e+00 9.197912243302902e+03 + 66480 9.674582828572478e-01 -6.035874514306466e+00 -5.978438312000026e+00 3.523455593067601e+00 4.853263154934758e+00 9.150939056174198e+03 + 66500 1.011028275251947e+00 -6.104478554816213e+00 -5.957977229681997e+00 3.128481771363345e+00 4.969715051290809e+00 9.088497147669861e+03 + 66520 9.502387219030255e-01 -6.012459575134059e+00 -5.979313899490331e+00 3.650642406741583e+00 4.840970005564605e+00 9.153646469345460e+03 + 66540 9.812583064152390e-01 -6.053666709093042e+00 -5.974959501882983e+00 3.383037952630608e+00 4.834986916331717e+00 9.140359262247450e+03 + 66560 1.005096735630868e+00 -6.079169725195517e+00 -6.002865489373760e+00 3.242606654428866e+00 4.680757384559727e+00 9.225869155006754e+03 + 66580 9.856015989794916e-01 -6.037726468804369e+00 -5.988099357367100e+00 3.531486001132701e+00 4.816452554776172e+00 9.180564972122798e+03 + 66600 1.048041396884860e+00 -6.115813113591607e+00 -6.015858040122514e+00 3.057793715233170e+00 4.631751215090333e+00 9.265792308425380e+03 + 66620 9.515362309107479e-01 -5.955568073369918e+00 -6.001708506613787e+00 3.984684510038653e+00 4.719739002143386e+00 9.222293716203998e+03 + 66640 9.667443991818453e-01 -5.955054298416461e+00 -5.998908789975001e+00 3.953817882218950e+00 4.701998605229178e+00 9.213707138543801e+03 + 66660 1.049771411269174e+00 -6.046665160704982e+00 -6.007509090243469e+00 3.414495034433906e+00 4.639335250406230e+00 9.240129352248900e+03 + 66680 1.053909361415176e+00 -6.012327492144130e+00 -6.028049558773636e+00 3.627871876363014e+00 4.537593336794436e+00 9.303383837420297e+03 + 66700 1.095141144734686e+00 -6.025159775163508e+00 -6.014240101003487e+00 3.594268996625141e+00 4.656971455466095e+00 9.260811879148709e+03 + 66720 1.026965082676056e+00 -5.880312190285263e+00 -6.018750122208087e+00 4.339686530909246e+00 4.544754502607664e+00 9.274676773089766e+03 + 66740 1.010145147482338e+00 -5.815487937938616e+00 -6.005711378019738e+00 4.654569877237144e+00 4.562277447309124e+00 9.234555626392568e+03 + 66760 1.048762111081591e+00 -5.837736189181189e+00 -5.995657693440072e+00 4.621929162544646e+00 4.715119446816336e+00 9.203702238019401e+03 + 66780 1.115762964018743e+00 -5.911906356752661e+00 -6.015723986964097e+00 4.157036662960107e+00 4.560899764559687e+00 9.265375414561524e+03 + 66800 1.116268487657590e+00 -5.903186854658027e+00 -6.081795410689168e+00 4.176823700701704e+00 4.151225732386176e+00 9.469847933622794e+03 + 66820 1.095134352761502e+00 -5.880257532104053e+00 -6.020076811910725e+00 4.308386239376802e+00 4.505522297763269e+00 9.278795665326030e+03 + 66840 1.078127823531492e+00 -5.872742073277237e+00 -6.015611673989055e+00 4.323527317778314e+00 4.503147961491802e+00 9.265027402414187e+03 + 66860 1.137973816295192e+00 -5.981754680925326e+00 -5.989274338927561e+00 3.793762207374999e+00 4.750583167462853e+00 9.184135089951440e+03 + 66880 1.036874470606254e+00 -5.855342843920053e+00 -6.006138197315748e+00 4.447567942029046e+00 4.581677687325445e+00 9.235889011285606e+03 + 66900 1.070158445527667e+00 -5.926512521077340e+00 -5.972705181102745e+00 4.079373587288482e+00 4.814128185131570e+00 9.133409982798079e+03 + 66920 1.088564430202816e+00 -5.972142382717666e+00 -5.993601005026102e+00 3.805342506233287e+00 4.682123776227175e+00 9.197421557218202e+03 + 66940 1.006426755327136e+00 -5.869971822154353e+00 -6.028166440119970e+00 4.417048843452437e+00 4.508670866555851e+00 9.303719582091559e+03 + 66960 1.081900197157130e+00 -6.002306888112274e+00 -5.967119161378948e+00 3.675281130655204e+00 4.877334502841082e+00 9.116387924530405e+03 + 66980 1.088097451201461e+00 -6.031423165507640e+00 -5.968239967093509e+00 3.521331181368849e+00 4.884138884231144e+00 9.119794393217377e+03 + 67000 1.103228995250296e+00 -6.076021468861845e+00 -5.958982023074690e+00 3.336552354408358e+00 5.008610963913902e+00 9.091541335409187e+03 + 67020 1.027583359717498e+00 -5.986653485669094e+00 -5.997495118330890e+00 3.761345551983900e+00 4.699091219502638e+00 9.209339501114942e+03 + 67040 1.014706612148430e+00 -5.989934009189948e+00 -5.997156832530576e+00 3.754800494626177e+00 4.713325925275992e+00 9.208313116772029e+03 + 67060 1.040635173676036e+00 -6.050799484830972e+00 -5.991319681653319e+00 3.462073760722270e+00 4.803615995038147e+00 9.190419908470925e+03 + 67080 9.698011664835811e-01 -5.966980392218113e+00 -6.039105405882834e+00 3.866567646890093e+00 4.452414657117471e+00 9.337491527374495e+03 + 67100 1.016328484648592e+00 -6.055741912859453e+00 -6.001822375230550e+00 3.392924029959580e+00 4.702538359046229e+00 9.222650045968225e+03 + 67120 9.557520264875738e-01 -5.983660194742318e+00 -5.982653333450770e+00 3.838982628312434e+00 4.844764181659784e+00 9.163872304303752e+03 + 67140 1.019054589811699e+00 -6.091309016576842e+00 -5.990400483389245e+00 3.246341536623550e+00 4.825773949731774e+00 9.187597138523643e+03 + 67160 9.915328225313034e-01 -6.060778764218854e+00 -6.017977773498224e+00 3.371108377924387e+00 4.616878290074155e+00 9.272331784289152e+03 + 67180 9.797132048054482e-01 -6.054474270656016e+00 -5.967256539502397e+00 3.428317288122126e+00 4.929134997306477e+00 9.116816226790017e+03 + 67200 9.345195194065260e-01 -5.994812521895781e+00 -5.977431263349357e+00 3.760857023160169e+00 4.860662899474806e+00 9.147883485213832e+03 + 67220 1.003377521671321e+00 -6.097177291491713e+00 -5.993972075669360e+00 3.189320733829012e+00 4.781941054036496e+00 9.198569881132695e+03 + 67240 9.546442102043721e-01 -6.022419168833876e+00 -5.998959243423464e+00 3.618307026090377e+00 4.753017548208689e+00 9.213859248063514e+03 + 67260 9.678491396713700e-01 -6.036449700749381e+00 -6.006381804476407e+00 3.481589931986799e+00 4.654244445378132e+00 9.236661668033212e+03 + 67280 9.962405040836424e-01 -6.066228666249370e+00 -6.003467747661274e+00 3.382320103174941e+00 4.742703009928553e+00 9.227688911367388e+03 + 67300 1.020212172084835e+00 -6.082418223474006e+00 -5.970584510195091e+00 3.291506201502911e+00 4.933672689361639e+00 9.126942942537040e+03 + 67320 9.928949344478569e-01 -6.010845662997401e+00 -5.965180181310235e+00 3.594260160795600e+00 4.856478423353758e+00 9.110459511567657e+03 + 67340 9.856079590311468e-01 -5.958527608794398e+00 -5.990866575734909e+00 3.980608240359346e+00 4.794912887747974e+00 9.188971501080820e+03 + 67360 1.043283510469743e+00 -5.994222007634857e+00 -5.974063776096210e+00 3.738326097246118e+00 4.854077782217278e+00 9.137602572502101e+03 + 67380 1.043846087696103e+00 -5.946161940339536e+00 -6.037293512349077e+00 3.950551494149342e+00 4.427259905105365e+00 9.331893400728059e+03 + 67400 1.046429468372025e+00 -5.915281201213435e+00 -5.990180170725436e+00 4.147378769229214e+00 4.717297295713229e+00 9.186939907353528e+03 + 67420 1.122460512161498e+00 -6.005906514982960e+00 -5.970234743751491e+00 3.631020468335558e+00 4.835853298935407e+00 9.125890441610976e+03 + 67440 1.015434321342362e+00 -5.834627956780679e+00 -6.011704940725734e+00 4.561391755898439e+00 4.544588311511231e+00 9.252995649051925e+03 + 67460 1.147148237960281e+00 -6.026490566956131e+00 -5.966454008886611e+00 3.579036279715770e+00 4.923775486778290e+00 9.114338078953115e+03 + 67480 1.033007583873164e+00 -5.860699626104386e+00 -6.033297137646365e+00 4.464026272102960e+00 4.472944651450324e+00 9.319547125046794e+03 + 67500 1.115359567344386e+00 -5.997106790439982e+00 -6.038348068986302e+00 3.687757911132608e+00 4.450944107652409e+00 9.335172962432353e+03 + 67520 1.058842658628058e+00 -5.936201707375269e+00 -6.013652305122526e+00 4.033041940968732e+00 4.588308623262719e+00 9.258984225241795e+03 + 67540 1.062153755763514e+00 -5.967502297206039e+00 -6.012135286155704e+00 3.873764540860312e+00 4.617475011378618e+00 9.254325139448156e+03 + 67560 1.049341002572320e+00 -5.977159211308033e+00 -6.031683851280108e+00 3.789279926024648e+00 4.476191005644228e+00 9.314583206147710e+03 + 67580 1.063909873548825e+00 -6.030748851712305e+00 -5.998749483474892e+00 3.581583544413985e+00 4.765328868719441e+00 9.213203769125246e+03 + 67600 9.502053376032908e-01 -5.891028964519083e+00 -6.019843720721611e+00 4.242526487688874e+00 4.502852223554856e+00 9.278044793397996e+03 + 67620 9.857867079416553e-01 -5.964536552697289e+00 -5.946996709170900e+00 3.861980769119065e+00 4.962697264929600e+00 9.055047337029149e+03 + 67640 9.791265232352180e-01 -5.968344601761608e+00 -6.000088254803195e+00 3.842066437388822e+00 4.659789469309592e+00 9.217283121526945e+03 + 67660 1.031512721474458e+00 -6.055011082179217e+00 -5.995347503394845e+00 3.397648258671969e+00 4.740245760960813e+00 9.202773492549168e+03 + 67680 1.042123068972493e+00 -6.078713776765717e+00 -5.986340639852092e+00 3.237966004154443e+00 4.768386851009216e+00 9.175188758164808e+03 + 67700 9.985602200331072e-01 -6.021464447405358e+00 -6.012387087569607e+00 3.607892410868214e+00 4.660016015761993e+00 9.255107629751708e+03 + 67720 9.413736203299270e-01 -5.943062023041481e+00 -6.012037041248031e+00 3.966983100151617e+00 4.570917871760034e+00 9.254037109577019e+03 + 67740 9.921510289018264e-01 -6.021080464513977e+00 -5.969221090779202e+00 3.545066297682795e+00 4.842850846880022e+00 9.122798150870938e+03 + 67760 9.974063329813589e-01 -6.028001329406512e+00 -5.996339439210219e+00 3.534212931834238e+00 4.716020405003021e+00 9.205825543985573e+03 + 67780 1.032962702341072e+00 -6.080362005009950e+00 -5.978577798485661e+00 3.293601039821403e+00 4.878061704738924e+00 9.151402506680242e+03 + 67800 9.519916695852990e-01 -5.958124082027517e+00 -5.976242169769849e+00 3.923416111334643e+00 4.819379247753154e+00 9.144262943488986e+03 + 67820 9.915013753908322e-01 -6.011633899078660e+00 -6.017272558648113e+00 3.597637835776026e+00 4.565259779948484e+00 9.270130226149047e+03 + 67840 9.951634112675780e-01 -6.011021234212349e+00 -6.023434430733875e+00 3.661840969457292e+00 4.590562474094737e+00 9.289121021446930e+03 + 67860 1.008065062882461e+00 -6.023563897405602e+00 -6.013413359375927e+00 3.605617627789750e+00 4.663903587946825e+00 9.258274675899502e+03 + 67880 9.949580494254943e-01 -5.996859467459052e+00 -6.010301238899324e+00 3.694450576563940e+00 4.617265844846493e+00 9.248710938177252e+03 + 67900 1.001214805068908e+00 -5.998673085315211e+00 -6.008509596597096e+00 3.676515906484298e+00 4.620033136508513e+00 9.243186347842264e+03 + 67920 1.031106384927096e+00 -6.030830689585008e+00 -6.029955103643099e+00 3.490419883541358e+00 4.495447633516286e+00 9.309232410593648e+03 + 67940 1.012797806773031e+00 -5.990121606341085e+00 -5.983211310971291e+00 3.769554258934625e+00 4.809234244312735e+00 9.165558248004381e+03 + 67960 9.742241799612994e-01 -5.910424611627523e+00 -6.021950068905051e+00 4.171966035801468e+00 4.531569601605162e+00 9.284552042151807e+03 + 67980 1.058185621435930e+00 -6.000040282678182e+00 -6.014496215331213e+00 3.685599610040958e+00 4.602591407698910e+00 9.261614975452863e+03 + 68000 1.058759898933093e+00 -5.963224505708912e+00 -6.005436712512541e+00 3.922713673867777e+00 4.680324650083448e+00 9.233742396732931e+03 + 68020 1.112093547910427e+00 -6.005732109161148e+00 -6.016874254924848e+00 3.703881914262826e+00 4.639901989046175e+00 9.268927580710226e+03 + 68040 1.122271603299534e+00 -5.989599008918682e+00 -6.044128706592600e+00 3.729052294896074e+00 4.415934332408995e+00 9.352998171172463e+03 + 68060 1.025939157469000e+00 -5.827027338905353e+00 -6.050639975171610e+00 4.615310170150081e+00 4.331291808765603e+00 9.373124313656803e+03 + 68080 1.071387464770243e+00 -5.883874219742358e+00 -5.989770670213702e+00 4.354081946799395e+00 4.746008140770190e+00 9.185653654116059e+03 + 68100 1.129788265624405e+00 -5.966494135969281e+00 -6.022778717631950e+00 3.841718546299201e+00 4.518523768381295e+00 9.287128844478131e+03 + 68120 1.105852428360460e+00 -5.938551888920712e+00 -6.058719691963141e+00 3.991485700989631e+00 4.301463580012578e+00 9.398195115153696e+03 + 68140 1.117195446445403e+00 -5.980746644690299e+00 -6.010306360417205e+00 3.814719025770703e+00 4.644982563715585e+00 9.248728221621162e+03 + 68160 1.079094923508159e+00 -5.962258034166494e+00 -5.994935101414271e+00 3.928942620393838e+00 4.741305843497288e+00 9.201475303563087e+03 + 68180 1.022960723262422e+00 -5.923908053792106e+00 -5.960494292942165e+00 4.168366329812521e+00 4.958282482910667e+00 9.096133470962439e+03 + 68200 9.585438051985593e-01 -5.867967542309847e+00 -6.013710933027940e+00 4.395083836523036e+00 4.558202733302923e+00 9.259158090609058e+03 + 68220 1.070153856184508e+00 -6.068113338160353e+00 -5.968597846446791e+00 3.340033503998526e+00 4.911466857390373e+00 9.120880883758377e+03 + 68240 9.880069422610592e-01 -5.973087248170760e+00 -5.995407175437583e+00 3.846844886548975e+00 4.718680410185296e+00 9.202938534366311e+03 + 68260 1.007799367499914e+00 -6.021647088021457e+00 -6.019345769759562e+00 3.520861469671916e+00 4.534075995259570e+00 9.276552360491722e+03 + 68280 1.010667214230770e+00 -6.040521633712714e+00 -6.024177480165614e+00 3.539706111178801e+00 4.633556770095838e+00 9.291418110519568e+03 + 68300 9.704812877450659e-01 -5.993231819562112e+00 -6.039984524223462e+00 3.681069597082109e+00 4.412608331958971e+00 9.340237516812715e+03 + 68320 9.740335027287123e-01 -6.008506299437751e+00 -6.039262446732052e+00 3.632601115051928e+00 4.455994557789637e+00 9.337975402692264e+03 + 68340 1.041557829587395e+00 -6.115976208677132e+00 -5.968110044434072e+00 3.084359449581695e+00 4.933429846880310e+00 9.119425195244772e+03 + 68360 9.591470654452954e-01 -5.998425190807611e+00 -5.999072632852793e+00 3.685842266160392e+00 4.682124553745621e+00 9.214204913630194e+03 + 68380 9.147543554600593e-01 -5.933413316473539e+00 -6.013931243950524e+00 4.016690751102507e+00 4.554344351420650e+00 9.259860892415572e+03 + 68400 9.624910953020491e-01 -6.000419115996491e+00 -6.034493521770977e+00 3.666801941580529e+00 4.471141430626183e+00 9.323246278852652e+03 + 68420 9.652778807148510e-01 -6.000811497696446e+00 -6.016800220627139e+00 3.664732705372431e+00 4.572922984057520e+00 9.268686995953976e+03 + 68440 9.550755668895630e-01 -5.979311652092239e+00 -6.028409423805362e+00 3.761029133106871e+00 4.479102130074498e+00 9.304477893477066e+03 + 68460 1.041159215439323e+00 -6.097247953482685e+00 -6.034154993129718e+00 3.145535406712026e+00 4.507824948662820e+00 9.322207397598995e+03 + 68480 9.721095945884929e-01 -5.985553720229149e+00 -6.003058535721800e+00 3.701695714038815e+00 4.601180354618565e+00 9.226462787375773e+03 + 68500 9.667722008121157e-01 -5.964862365856964e+00 -5.965486234985314e+00 3.876788942489495e+00 4.873206589411075e+00 9.111379446124642e+03 + 68520 1.017862991400501e+00 -6.017864752707028e+00 -6.016096091225450e+00 3.556934887655836e+00 4.567090815582530e+00 9.266518865516362e+03 + 68540 1.028579212574062e+00 -6.006141758090282e+00 -6.001707558072829e+00 3.667614284118931e+00 4.693076146809381e+00 9.222304830623647e+03 + 68560 1.044070041902980e+00 -5.996127288765649e+00 -6.009839419928474e+00 3.733141097271058e+00 4.654403918188677e+00 9.247280860130231e+03 + 68580 1.056201068147089e+00 -5.974829711530926e+00 -5.999387311150238e+00 3.810025263625354e+00 4.669011726335002e+00 9.215151685520430e+03 + 68600 1.077268258386165e+00 -5.965960417919236e+00 -5.999857966284161e+00 3.868822324552526e+00 4.674177356212470e+00 9.216571930574552e+03 + 68620 1.022937887654411e+00 -5.845113263293216e+00 -6.016577649980578e+00 4.490148141050376e+00 4.505573098663464e+00 9.267992716838227e+03 + 68640 1.102924582639815e+00 -5.932357270652266e+00 -6.007767549684701e+00 4.026235496269465e+00 4.593218004362259e+00 9.240892775362829e+03 + 68660 1.063833538139233e+00 -5.853151871097818e+00 -6.023184893390062e+00 4.496051955946119e+00 4.519696029418895e+00 9.288325071753545e+03 + 68680 1.172491892356842e+00 -6.005782608356718e+00 -5.952373796700607e+00 3.666283947748714e+00 4.972965609264997e+00 9.071413601411577e+03 + 68700 1.031048135885724e+00 -5.798511284780354e+00 -5.963288118215153e+00 4.814330608866713e+00 4.868156532151538e+00 9.104660950449434e+03 + 68720 1.031969781898240e+00 -5.810004205158496e+00 -5.996203882140411e+00 4.746789710085814e+00 4.677602350548767e+00 9.205343112214834e+03 + 68740 1.106598265379271e+00 -5.939219394895012e+00 -5.969942363349176e+00 4.075854971292252e+00 4.899438932064439e+00 9.124958639171578e+03 + 68760 1.031143647261670e+00 -5.856648603940637e+00 -6.009945140710549e+00 4.472735589694690e+00 4.592483152999460e+00 9.247580725756978e+03 + 68780 1.113787694521319e+00 -6.020713644797879e+00 -5.963228585083110e+00 3.599040227607729e+00 4.929128336274170e+00 9.104510043767186e+03 + 68800 1.030959685684618e+00 -5.947121555494259e+00 -6.005457514968761e+00 3.957670855921745e+00 4.622696749158601e+00 9.233818949412806e+03 + 68820 1.047320899711323e+00 -6.020661544814970e+00 -5.994389378393421e+00 3.624582229434301e+00 4.775441074631448e+00 9.199825893821369e+03 + 68840 1.017275824761126e+00 -6.014838586466671e+00 -5.987004421084047e+00 3.587472000329516e+00 4.747300085279718e+00 9.177179532073966e+03 + 68860 1.011735645672689e+00 -6.029469475514320e+00 -5.983202095178306e+00 3.559418148104457e+00 4.825092605847821e+00 9.165541777403114e+03 + 68880 9.039255854469510e-01 -5.880603504826577e+00 -6.048154803535372e+00 4.345052933703627e+00 4.382947448038049e+00 9.365446658451310e+03 + 68900 1.064168037297821e+00 -6.124645769847694e+00 -5.973707631985236e+00 3.054046078688467e+00 4.920756223896051e+00 9.136529162824945e+03 + 68920 9.675957211968103e-01 -5.985366245032504e+00 -6.024620428451745e+00 3.809556106675948e+00 4.584152510917412e+00 9.292766708737408e+03 + 68940 9.761932849515360e-01 -6.000915652923100e+00 -5.978868236394590e+00 3.663667240243435e+00 4.790266917776823e+00 9.152292253078402e+03 + 68960 9.947124765534825e-01 -6.027720303903888e+00 -6.005074094475846e+00 3.554332651561972e+00 4.684370690587370e+00 9.232618487504471e+03 + 68980 9.906057004045660e-01 -6.020411971057026e+00 -6.041885876376416e+00 3.530922331174645e+00 4.407615843754600e+00 9.346084654755450e+03 + 69000 9.763293818763045e-01 -5.996610684776140e+00 -6.023769359011592e+00 3.739079572872795e+00 4.583130262621580e+00 9.290157458996417e+03 + 69020 9.553332442362521e-01 -5.963113664142963e+00 -6.030109120696441e+00 3.879581034914167e+00 4.494882755870702e+00 9.309711289148087e+03 + 69040 9.905965692528158e-01 -6.010250273679377e+00 -6.019074882482570e+00 3.620830552467076e+00 4.570158283115344e+00 9.275727617843337e+03 + 69060 1.014009329505017e+00 -6.040337137167427e+00 -6.020171579017079e+00 3.472817838459469e+00 4.588611593968803e+00 9.279089639608706e+03 + 69080 1.012275793212847e+00 -6.033106740344106e+00 -6.002902161810868e+00 3.523081250198133e+00 4.696520614279406e+00 9.225973955298950e+03 + 69100 1.028565802408747e+00 -6.049058695473033e+00 -6.021349190992324e+00 3.493085446907488e+00 4.652197709667675e+00 9.282707937539701e+03 + 69120 9.945157154226723e-01 -5.992390225114523e+00 -6.040482323287392e+00 3.737167392898005e+00 4.461015122961250e+00 9.341750005780248e+03 + 69140 1.038333255440966e+00 -6.051117268212847e+00 -6.004192447339080e+00 3.416638093764585e+00 4.686087676814315e+00 9.229942028695727e+03 + 69160 9.883890664940971e-01 -5.971726164455381e+00 -6.006988257236001e+00 3.916167956821527e+00 4.713687563283987e+00 9.238504651613111e+03 + 69180 1.057386555966456e+00 -6.068203481263609e+00 -5.979434834898930e+00 3.290323892418878e+00 4.800047196748492e+00 9.154030190014399e+03 + 69200 9.533693440535429e-01 -5.905556989868501e+00 -6.056559726487909e+00 4.151454872947294e+00 4.284373791680681e+00 9.391518643401398e+03 + 69220 1.040738134918848e+00 -6.027782722845318e+00 -6.038829499747291e+00 3.532434850757267e+00 4.469002548302937e+00 9.336662305077858e+03 + 69240 9.713037903605732e-01 -5.918993695912039e+00 -6.059745850353981e+00 4.071832468572653e+00 4.263611816441522e+00 9.401373667541577e+03 + 69260 1.046048801579955e+00 -6.025313467269189e+00 -5.995517501492674e+00 3.597325934507529e+00 4.768418980907084e+00 9.203299953190959e+03 + 69280 1.000497256900058e+00 -5.955059108042871e+00 -6.058987165753200e+00 3.908876720370353e+00 4.312105730182692e+00 9.399006937829910e+03 + 69300 1.011452198015059e+00 -5.971106928925900e+00 -6.051035660728070e+00 3.883820888896827e+00 4.424857741957489e+00 9.374385945518439e+03 + 69320 1.020563688904726e+00 -5.987845203591353e+00 -6.017543382453725e+00 3.768752021802991e+00 4.598220482996918e+00 9.271001934929609e+03 + 69340 1.045943242228663e+00 -6.033502117902223e+00 -6.006721333158722e+00 3.546307784777368e+00 4.700087195087599e+00 9.237695659279701e+03 + 69360 9.806687953149080e-01 -5.948641703923162e+00 -6.045261453173865e+00 3.931574878732899e+00 4.376769326677486e+00 9.356490705408236e+03 + 69380 9.857256539913615e-01 -5.971382391363642e+00 -6.010747401340799e+00 3.832545440674831e+00 4.606505461670391e+00 9.250076428298547e+03 + 69400 1.022409869359430e+00 -6.044027074030524e+00 -6.001708899923193e+00 3.425537261769976e+00 4.668534766210551e+00 9.222314647945832e+03 + 69420 1.035644291220285e+00 -6.087581175133526e+00 -5.958354065124738e+00 3.224902741263812e+00 4.966944804764913e+00 9.089647653689444e+03 + 69440 9.095007837062773e-01 -5.923743736473114e+00 -5.958374519506590e+00 4.132750713076492e+00 4.933895397801920e+00 9.089706482071162e+03 + 69460 1.027389157396801e+00 -6.120124126966548e+00 -5.956904618554155e+00 3.053114838543544e+00 4.990346513984798e+00 9.085238222539620e+03 + 69480 9.683497964535380e-01 -6.051763216451542e+00 -5.997284783304460e+00 3.414135583560245e+00 4.726959177201076e+00 9.208706735175516e+03 + 69500 9.212536250790382e-01 -5.997185319223476e+00 -6.011614979188901e+00 3.718076372814169e+00 4.635219032310035e+00 9.252716032455261e+03 + 69520 9.721843555603263e-01 -6.084044501838047e+00 -6.015748332395084e+00 3.205210678190241e+00 4.597377851929799e+00 9.265464249482458e+03 + 69540 9.590111536189274e-01 -6.073618444084130e+00 -6.010953032221784e+00 3.284581101136580e+00 4.644415593491315e+00 9.250718968163434e+03 + 69560 9.074528081860608e-01 -6.003511697475989e+00 -6.021107183515619e+00 3.605739801222620e+00 4.504703797490398e+00 9.281961481687993e+03 + 69580 9.627918049178775e-01 -6.085899804983935e+00 -5.982005752607584e+00 3.246873528130267e+00 4.843449254427920e+00 9.161898579351817e+03 + 69600 9.578933697392338e-01 -6.071459845416175e+00 -6.007711994427105e+00 3.345017152004345e+00 4.711067177331648e+00 9.240746692495073e+03 + 69620 9.162422527648463e-01 -5.995539496112285e+00 -6.032129723599314e+00 3.678608003307011e+00 4.468501254757083e+00 9.315954445399746e+03 + 69640 9.416143456138271e-01 -6.010515158476538e+00 -5.973266283913429e+00 3.662236788552766e+00 4.876125590538853e+00 9.135160880491110e+03 + 69660 1.027074588764636e+00 -6.100173537029955e+00 -5.973109037536418e+00 3.185278939114705e+00 4.914902958374341e+00 9.134661571271552e+03 + 69680 9.791875397304717e-01 -5.983851139923420e+00 -5.993850303412422e+00 3.821142840621260e+00 4.763726096501858e+00 9.198162543398916e+03 + 69700 9.697375462528828e-01 -5.922042522891428e+00 -5.963026793051449e+00 4.189162596669043e+00 4.953824575114895e+00 9.103881697766557e+03 + 69720 9.705280689973462e-01 -5.882312153407899e+00 -6.035165505383523e+00 4.345987591997969e+00 4.468279990974167e+00 9.325291757147959e+03 + 69740 1.070249888159113e+00 -5.998500338957355e+00 -5.977651785444197e+00 3.735347461609882e+00 4.855063082185666e+00 9.148582692650780e+03 + 69760 1.035725922480138e+00 -5.927823499787365e+00 -6.033416060720538e+00 4.037601983583679e+00 4.431273158309409e+00 9.319910245070272e+03 + 69780 1.085301734272217e+00 -5.990521970151159e+00 -5.997856704985521e+00 3.735857462943937e+00 4.693740280478481e+00 9.210461730390949e+03 + 69800 1.071316322451426e+00 -5.968649423321914e+00 -5.984772924585506e+00 3.884202954031527e+00 4.791619314672223e+00 9.170337491001463e+03 + 69820 1.034915375954556e+00 -5.919132923591999e+00 -6.022728640037766e+00 4.081414592968081e+00 4.486551957751177e+00 9.286893631276196e+03 + 69840 1.017085465824558e+00 -5.901541081957431e+00 -5.983557129569766e+00 4.196777016647249e+00 4.725828179314876e+00 9.166597123580881e+03 + 69860 1.067378374846961e+00 -5.987401345859645e+00 -5.987026055489959e+00 3.807615206262764e+00 4.809770181641498e+00 9.177257793025730e+03 + 69880 1.006665643882750e+00 -5.911918328804356e+00 -6.057418956341202e+00 4.095885398547504e+00 4.260398279081594e+00 9.394134204315485e+03 + 69900 1.043019348693840e+00 -5.986273419824903e+00 -5.991299533259530e+00 3.785403688681771e+00 4.756542967551603e+00 9.190345445302723e+03 + 69920 1.028027544765967e+00 -5.987390533070998e+00 -5.991722359386385e+00 3.776373834394545e+00 4.751499817343636e+00 9.191637105859843e+03 + 69940 1.015912278710633e+00 -5.997006573586981e+00 -5.986648840548153e+00 3.701864269887158e+00 4.761339975850117e+00 9.176092548530603e+03 + 69960 1.045185220598861e+00 -6.063541906188206e+00 -5.974751373127927e+00 3.363915204433888e+00 4.873764185556594e+00 9.139707294393138e+03 + 69980 9.477117614004495e-01 -5.943452371574800e+00 -6.026679157623763e+00 3.982193124407448e+00 4.504292039610784e+00 9.299127058796066e+03 + 70000 9.707915352604647e-01 -5.997467646211382e+00 -5.972020959127436e+00 3.707216247618308e+00 4.853335062716425e+00 9.131360425946097e+03 + 70020 1.015120481064699e+00 -6.078819356331223e+00 -5.983630767330641e+00 3.284250054209212e+00 4.830837662637096e+00 9.166847953507689e+03 + 70040 1.000672012097999e+00 -6.070211256449978e+00 -6.004674633853817e+00 3.340266284909391e+00 4.716587713616121e+00 9.231409250086712e+03 + 70060 9.686696512221833e-01 -6.032853416319805e+00 -6.019663257627252e+00 3.490397418024501e+00 4.566137350407597e+00 9.277522863225144e+03 + 70080 9.693827728203237e-01 -6.041044825893208e+00 -5.977113868821069e+00 3.588547553347973e+00 4.955649002139833e+00 9.146881744358072e+03 + 70100 9.967754524580520e-01 -6.083007609448023e+00 -5.945230989973715e+00 3.326064204642445e+00 5.117198874526879e+00 9.049670714756514e+03 + 70120 9.828767386894930e-01 -6.059066470857852e+00 -5.985857131303471e+00 3.372438585682287e+00 4.792817942512224e+00 9.173679575131982e+03 + 70140 9.660478922086816e-01 -6.027507503199844e+00 -5.988397179497724e+00 3.569471628738232e+00 4.794049159738837e+00 9.181449129958715e+03 + 70160 9.905858216119811e-01 -6.054146956497530e+00 -6.007541078146814e+00 3.415842135823104e+00 4.683460301549282e+00 9.240207099764941e+03 + 70180 8.950074121801050e-01 -5.903327348825036e+00 -6.039728002586196e+00 4.232624189947325e+00 4.449390528117786e+00 9.339417308997656e+03 + 70200 9.794185106957350e-01 -6.018914841736214e+00 -5.993811010639088e+00 3.579670079755907e+00 4.723820162720910e+00 9.198059380683255e+03 + 70220 1.078837683433257e+00 -6.156914232003524e+00 -5.961253571386543e+00 2.847060916209562e+00 4.970574707861644e+00 9.098498049056390e+03 + 70240 9.366281851987736e-01 -5.939655619514205e+00 -5.970678119956508e+00 4.043978709796065e+00 4.865842711539936e+00 9.127237668088896e+03 + 70260 9.752575082414875e-01 -5.990497852886199e+00 -5.992604915988102e+00 3.752548668981822e+00 4.740449586583734e+00 9.194338944782810e+03 + 70280 9.977503004211432e-01 -6.016864548592773e+00 -5.999224733959485e+00 3.638336004035229e+00 4.739626549412058e+00 9.214652885976906e+03 + 70300 1.046315509728615e+00 -6.083932480389105e+00 -5.963565114341437e+00 3.217506786386298e+00 4.908674829021706e+00 9.105543934919517e+03 + 70320 9.613133272941515e-01 -5.951631121426818e+00 -6.020672062458349e+00 3.953707572723203e+00 4.557263805269057e+00 9.280607438591614e+03 + 70340 1.036977662652044e+00 -6.059603673747147e+00 -5.978937081932203e+00 3.396796604012314e+00 4.859996657328457e+00 9.152523746240680e+03 + 70360 9.872912234407855e-01 -5.981937936786707e+00 -6.020763258120032e+00 3.867383395781342e+00 4.644442392486335e+00 9.280888369667431e+03 + 70380 1.008020251973274e+00 -6.009656073949808e+00 -6.000397112871131e+00 3.619545320007460e+00 4.672711707340818e+00 9.218270252549011e+03 + 70400 9.672419385395381e-01 -5.944746366645802e+00 -6.028716125285468e+00 3.968094807388925e+00 4.485927459001807e+00 9.305416550712849e+03 + 70420 1.039108528810288e+00 -6.047971162607112e+00 -5.973185045622053e+00 3.501634726434424e+00 4.931068183276834e+00 9.134909217872908e+03 + 70440 9.948620202841731e-01 -5.978934143725552e+00 -5.988820292240692e+00 3.854529551607751e+00 4.797761756957282e+00 9.182769192243308e+03 + 70460 1.012261133289885e+00 -6.000936856054676e+00 -6.018539852025659e+00 3.725906460470468e+00 4.624827333550267e+00 9.274047005882081e+03 + 70480 1.103871442853379e+00 -6.133849440238432e+00 -5.941750270228090e+00 2.979184411960951e+00 5.082247573410816e+00 9.039121992033910e+03 + 70500 9.653908683193807e-01 -5.925649498347066e+00 -6.034605815376758e+00 4.105814009384024e+00 4.480169976063963e+00 9.323598231267842e+03 + 70520 9.951999102107326e-01 -5.967997848100517e+00 -6.032156397354760e+00 3.869573695621772e+00 4.501165377300497e+00 9.316023326454024e+03 + 70540 1.002694821429421e+00 -5.979047797071523e+00 -6.018978029477211e+00 3.841215552995981e+00 4.611929979339029e+00 9.275397392270268e+03 + 70560 9.875572520475007e-01 -5.956519830569903e+00 -6.038585229625601e+00 3.910299574181157e+00 4.439067353223879e+00 9.335885177063705e+03 + 70580 1.014939997971462e+00 -6.001027241523534e+00 -6.019789987737560e+00 3.725736566909954e+00 4.617997974623425e+00 9.277900414774411e+03 + 70600 1.000818343697304e+00 -5.986433041409258e+00 -6.013303130518302e+00 3.736378894440388e+00 4.582086684643411e+00 9.257933365069375e+03 + 70620 9.740126506711496e-01 -5.956217898819240e+00 -5.962656686060202e+00 4.000065225531714e+00 4.963092712795004e+00 9.102763074815577e+03 + 70640 9.981058339661091e-01 -6.002167301288491e+00 -6.004026576407494e+00 3.661612031579891e+00 4.650935786124684e+00 9.229401136049866e+03 + 70660 9.965906771533984e-01 -6.012427642129120e+00 -5.958140479663692e+00 3.663359967809839e+00 4.975085255597566e+00 9.088988325179287e+03 + 70680 9.382838027365347e-01 -5.939089088221248e+00 -5.999087413120754e+00 4.048350072841886e+00 4.703830406558155e+00 9.214230502644094e+03 + 70700 1.023240153569715e+00 -6.076832120326600e+00 -5.973278143728370e+00 3.268182881565733e+00 4.862805840118853e+00 9.135216608553872e+03 + 70720 9.530975911293852e-01 -5.984648090030053e+00 -6.024151004207491e+00 3.773230103266596e+00 4.546398257003531e+00 9.291303613865319e+03 + 70740 9.992495439373592e-01 -6.067741907079502e+00 -5.979988340058652e+00 3.317441731645641e+00 4.821336293299969e+00 9.155716166945285e+03 + 70760 9.199984095504502e-01 -5.962595449051627e+00 -5.989150323659540e+00 3.946533265366682e+00 4.794051066014477e+00 9.183744982626557e+03 + 70780 9.617289887022529e-01 -6.032282293212178e+00 -5.978354666734342e+00 3.581601087280179e+00 4.891261863789141e+00 9.150720815830018e+03 + 70800 9.783795905178989e-01 -6.060038823915549e+00 -6.043090670015435e+00 3.344089601820642e+00 4.441408524233434e+00 9.349812523472539e+03 + 70820 9.503296099671792e-01 -6.022988382354976e+00 -6.014281410033853e+00 3.601177916992074e+00 4.651174699459578e+00 9.260943300505580e+03 + 70840 9.269698495274009e-01 -5.990169279207143e+00 -5.984208296283782e+00 3.758828763059255e+00 4.793057649464320e+00 9.168641562492510e+03 + 70860 9.502038762661766e-01 -6.019852626647474e+00 -5.980514248844599e+00 3.583575070135891e+00 4.809462123074290e+00 9.157326945480901e+03 + 70880 9.646639112807736e-01 -6.029823085837029e+00 -6.010592778601673e+00 3.508161176736802e+00 4.618584576762640e+00 9.249589621868949e+03 + 70900 1.038008729876569e+00 -6.119866899931527e+00 -5.955381058418338e+00 3.116701280165225e+00 5.061204436235668e+00 9.080587463363865e+03 + 70920 1.000887252368635e+00 -6.040786120019872e+00 -5.974226306834627e+00 3.485646288947786e+00 4.867843036355266e+00 9.138111997870850e+03 + 70940 9.950406566219961e-01 -6.002143253159398e+00 -5.991559806985427e+00 3.734741026954325e+00 4.795512812668273e+00 9.191151206731594e+03 + 70960 1.022482460129016e+00 -6.008666826086580e+00 -5.994843294251231e+00 3.645842485133266e+00 4.725219344116478e+00 9.201234446200129e+03 + 70980 1.057750807985447e+00 -6.026665060525588e+00 -5.971510130506083e+00 3.586058483713317e+00 4.902766627083153e+00 9.129721824753598e+03 + 71000 1.021041222926839e+00 -5.940230591509149e+00 -6.012411958396694e+00 4.004143202725475e+00 4.589666624026768e+00 9.255189507624971e+03 + 71020 1.070634466967631e+00 -5.987429807048340e+00 -6.026043142671919e+00 3.722429889830744e+00 4.500706141285777e+00 9.297179997588075e+03 + 71040 1.066945226785466e+00 -5.963862137476182e+00 -6.027828740851643e+00 3.864838998453726e+00 4.497532863071954e+00 9.302677691768688e+03 + 71060 1.055890863954758e+00 -5.938936219966685e+00 -6.014655210841430e+00 4.013409359351689e+00 4.578619196272935e+00 9.262066503781221e+03 + 71080 1.039855635137347e+00 -5.911400509930479e+00 -6.005082470121936e+00 4.192372071589639e+00 4.654435758933809e+00 9.232641040677694e+03 + 71100 1.053677967158585e+00 -5.934018991247677e+00 -6.036911032500970e+00 4.066469742196070e+00 4.475647718827738e+00 9.330706836157968e+03 + 71120 1.079192384974004e+00 -5.981496709035496e+00 -6.022169759484532e+00 3.776071191946868e+00 4.542520242134289e+00 9.285257127014582e+03 + 71140 1.046337587084948e+00 -5.952422353911435e+00 -6.022329251094123e+00 3.942178836425513e+00 4.540762614745137e+00 9.285735356084175e+03 + 71160 1.009567219050481e+00 -5.926498786025287e+00 -5.995357414956178e+00 4.073330344931237e+00 4.677933441771674e+00 9.202786527801039e+03 + 71180 1.014990170250464e+00 -5.965696261738615e+00 -6.007628315977416e+00 3.835945279178671e+00 4.595164934775055e+00 9.240471974228722e+03 + 71200 1.029173132532460e+00 -6.022011662890177e+00 -5.990208651027154e+00 3.559186033413883e+00 4.741803849031538e+00 9.187019307974540e+03 + 71220 1.012138071985217e+00 -6.033844609239373e+00 -6.011514953121693e+00 3.484155727752280e+00 4.612376068683117e+00 9.252434792298589e+03 + 71240 1.025917967794872e+00 -6.089231769136369e+00 -5.985025697996741e+00 3.217168782824900e+00 4.815536169146036e+00 9.171157539428934e+03 + 71260 9.809942674716783e-01 -6.052012306116996e+00 -5.989470348912601e+00 3.400728671118710e+00 4.759854267722943e+00 9.184750632348270e+03 + 71280 9.021656796980402e-01 -5.954258760076265e+00 -6.004869198070065e+00 3.959333838373098e+00 4.668720871472729e+00 9.232004297132007e+03 + 71300 9.497922217545449e-01 -6.033057306956294e+00 -5.962910687959932e+00 3.559307643167286e+00 4.962100384598612e+00 9.103542218241142e+03 + 71320 9.749837955733420e-01 -6.070326882077335e+00 -6.027363698450371e+00 3.298519424963276e+00 4.545220673880488e+00 9.301243138679869e+03 + 71340 9.660823418425656e-01 -6.055399562706856e+00 -6.027590255915229e+00 3.355539282573889e+00 4.515224625647727e+00 9.301949012358944e+03 + 71360 9.187606548944648e-01 -5.979929752717196e+00 -6.049734439273840e+00 3.781919954718389e+00 4.381090642269799e+00 9.370376242774466e+03 + 71380 1.024283947537621e+00 -6.129366491622552e+00 -6.026736133858835e+00 2.960834979253221e+00 4.550154375529022e+00 9.299334065604191e+03 + 71400 1.002137868858481e+00 -6.089800241413615e+00 -6.004566230915030e+00 3.233014673876009e+00 4.722441552079383e+00 9.231073648795107e+03 + 71420 9.695674030826034e-01 -6.033693207820598e+00 -5.999031680513342e+00 3.517424306674779e+00 4.716456160327053e+00 9.214084663559172e+03 + 71440 9.347608204037869e-01 -5.971319079686294e+00 -6.017244968010957e+00 3.928156929085375e+00 4.664443371316914e+00 9.270063452489039e+03 + 71460 9.885873963879660e-01 -6.036938991973262e+00 -6.008396850466092e+00 3.486755509419020e+00 4.650648902835319e+00 9.242844882882900e+03 + 71480 1.006250283318458e+00 -6.046978007860598e+00 -6.008171242234155e+00 3.432939106299894e+00 4.655773559854502e+00 9.242149331584393e+03 + 71500 9.633713759708148e-01 -5.965819070061725e+00 -5.995256800994655e+00 3.874017261051561e+00 4.704981254560535e+00 9.202488180353943e+03 + 71520 1.056067018329791e+00 -6.081989528969133e+00 -5.998926891446316e+00 3.264828825185319e+00 4.741787343742947e+00 9.213770728463212e+03 + 71540 9.778016502589417e-01 -5.945677647536491e+00 -6.007842032934904e+00 3.952163684048537e+00 4.595206163183301e+00 9.241159800734624e+03 + 71560 1.010022537433354e+00 -5.976759792983303e+00 -5.977544960694596e+00 3.805800442467798e+00 4.801291887965242e+00 9.148221496655919e+03 + 71580 1.001353899717096e+00 -5.944191141072666e+00 -6.001598713213761e+00 3.966863977589671e+00 4.637220814562427e+00 9.221948061761279e+03 + 71600 1.042614861595804e+00 -5.983834060640207e+00 -6.037929670151215e+00 3.719313132468340e+00 4.408687771387614e+00 9.333857102659678e+03 + 71620 1.014360341707726e+00 -5.923486040209365e+00 -6.015373949858654e+00 4.087071567636482e+00 4.559436970822202e+00 9.264272981369902e+03 + 71640 1.060092960321166e+00 -5.976268472739040e+00 -5.988224873490177e+00 3.829401340134444e+00 4.760745836774383e+00 9.180908657025637e+03 + 71660 1.101660772109465e+00 -6.025999638105516e+00 -5.963427114420098e+00 3.561851215342017e+00 4.921152329410431e+00 9.105109841800910e+03 + 71680 1.019476398754853e+00 -5.896646246523181e+00 -5.989380866768085e+00 4.262227235988544e+00 4.729730695906205e+00 9.184429530645475e+03 + 71700 1.013067314508968e+00 -5.880575580475333e+00 -6.009736614047698e+00 4.366492058620811e+00 4.624829416242942e+00 9.246933826535524e+03 + 71720 1.051359132139104e+00 -5.931087566622304e+00 -6.017182311054659e+00 4.027836432239109e+00 4.533467086589882e+00 9.269890314896569e+03 + 71740 1.054603422187828e+00 -5.937443699584298e+00 -6.044248870232007e+00 4.048216016550339e+00 4.434924198644455e+00 9.353374224651739e+03 + 71760 1.039660580793031e+00 -5.927883600115812e+00 -6.016908705301013e+00 4.048569758317579e+00 4.537373827753653e+00 9.269008116703695e+03 + 71780 1.025747930132632e+00 -5.928424739469065e+00 -6.007564996616503e+00 4.085248485645741e+00 4.630812882189934e+00 9.240247936630914e+03 + 71800 1.107578329825317e+00 -6.083312515958898e+00 -6.006293441696588e+00 3.266653212662347e+00 4.708908655739755e+00 9.236370946567660e+03 + 71820 1.016990557480097e+00 -5.995082823234838e+00 -6.023055097502324e+00 3.738706013150396e+00 4.578084885611040e+00 9.287939383405237e+03 + 71840 9.264024913368424e-01 -5.907588749760180e+00 -6.034039089548677e+00 4.148719289400604e+00 4.422621870208213e+00 9.321831661510323e+03 + 71860 1.033909187919626e+00 -6.104585291959766e+00 -5.946695712749326e+00 3.129267105378001e+00 5.035893502537766e+00 9.054149487456509e+03 + 71880 1.001354788509192e+00 -6.084727101703975e+00 -5.982498194001491e+00 3.232948738739945e+00 4.819962946639947e+00 9.163394372863633e+03 + 71900 9.835514598576397e-01 -6.079514307423918e+00 -5.963645123068739e+00 3.248542695858498e+00 4.913881483124266e+00 9.105800189567453e+03 + 71920 8.829928019528501e-01 -5.943089219554238e+00 -5.997490276429883e+00 3.961663549303919e+00 4.649284262187628e+00 9.209324646334553e+03 + 71940 9.627508206191743e-01 -6.068412788000298e+00 -5.961839794832189e+00 3.295080386661994e+00 4.907039005550669e+00 9.100280505853712e+03 + 71960 9.702505683692159e-01 -6.080883011773426e+00 -5.978208058793721e+00 3.282792833683917e+00 4.872368302591010e+00 9.150280517290556e+03 + 71980 8.779140154103519e-01 -5.938386417148360e+00 -6.052222931487897e+00 4.019626740990987e+00 4.365959859509704e+00 9.378057085114166e+03 + 72000 9.692840038197904e-01 -6.064069417931561e+00 -5.971123729960807e+00 3.378974529190282e+00 4.912683052817082e+00 9.128614748407430e+03 + 72020 9.885005812406391e-01 -6.076529438965784e+00 -5.978131809790245e+00 3.243379661361396e+00 4.808394075071244e+00 9.150048352967091e+03 + 72040 1.007114140287485e+00 -6.082095634505736e+00 -6.006816222712280e+00 3.315407309135362e+00 4.747673341104709e+00 9.238004237761434e+03 + 72060 9.436526799685707e-01 -5.961129074014891e+00 -6.069174796479659e+00 3.889357149440118e+00 4.268941891025908e+00 9.430654331575221e+03 + 72080 1.025446156098957e+00 -6.056560286085652e+00 -6.016222071584070e+00 3.380304561053606e+00 4.611932831040212e+00 9.266936970954433e+03 + 72100 9.673429470591209e-01 -5.942926359305398e+00 -6.006071616955257e+00 4.006821794380816e+00 4.644231953258286e+00 9.235687911210844e+03 + 72120 1.076109701708345e+00 -6.075492548551919e+00 -5.951437940083753e+00 3.372147805509516e+00 5.084488564722344e+00 9.068564740289754e+03 + 72140 1.052063419745957e+00 -6.011974858631113e+00 -6.002007187257209e+00 3.641997181415203e+00 4.699233092936321e+00 9.223181051277681e+03 + 72160 9.889327526422871e-01 -5.896777895197650e+00 -6.016254497282827e+00 4.226945622404854e+00 4.540892484287347e+00 9.266988935274836e+03 + 72180 1.030426696758700e+00 -5.941565784478201e+00 -5.975998700735959e+00 4.006227391298908e+00 4.808508257670298e+00 9.143499426995846e+03 + 72200 1.060346588740650e+00 -5.971354774290645e+00 -5.967719282569290e+00 3.835195911823096e+00 4.856071467877639e+00 9.118185723323058e+03 + 72220 1.004155716955443e+00 -5.877994572684685e+00 -6.024969063165532e+00 4.300528195844373e+00 4.456577927274452e+00 9.293835559863985e+03 + 72240 1.024295760753139e+00 -5.904135706042736e+00 -5.935521598883210e+00 4.300478893856221e+00 5.120256240214998e+00 9.020129012012143e+03 + 72260 1.056794444372592e+00 -5.950095911486052e+00 -5.963206819130766e+00 3.967748716473400e+00 4.892463855871050e+00 9.104416390393446e+03 + 72280 9.753259447096679e-01 -5.830845910769913e+00 -6.001928689152051e+00 4.615487269334664e+00 4.633103480890035e+00 9.222913718649555e+03 + 72300 1.024328505548032e+00 -5.909413017359982e+00 -6.048300169600111e+00 4.123846497902045e+00 4.326334977021872e+00 9.365884342484200e+03 + 72320 1.085568188852727e+00 -6.015137226153978e+00 -5.997392990391079e+00 3.616787134683953e+00 4.718677282346134e+00 9.209052618705000e+03 + 72340 1.065595641762248e+00 -6.015008101822858e+00 -5.993867705688645e+00 3.594330813413744e+00 4.715722239482124e+00 9.198223975579322e+03 + 72360 1.019416689152659e+00 -6.001685528748026e+00 -5.987128719805158e+00 3.713848098115320e+00 4.797435547724170e+00 9.177591508713300e+03 + 72380 9.905270035329032e-01 -6.032412090052161e+00 -6.003219528571488e+00 3.509740012945390e+00 4.677368218501700e+00 9.226938711663375e+03 + 72400 9.296240819384755e-01 -6.009041962058177e+00 -5.988165620669675e+00 3.656340740757732e+00 4.776215923613898e+00 9.180777368292824e+03 + 72420 9.328665435652380e-01 -6.051579303338874e+00 -5.987827404840168e+00 3.425846439736976e+00 4.791919706490960e+00 9.179709445583892e+03 + 72440 9.613782984246148e-01 -6.112660007703798e+00 -5.964117939541906e+00 3.083369340119873e+00 4.936320882316211e+00 9.107239036103767e+03 + 72460 9.604834131242277e-01 -6.118326196879747e+00 -5.985339608751298e+00 3.058491114850105e+00 4.822120683491663e+00 9.172110418675380e+03 + 72480 9.679405581378538e-01 -6.129614542692619e+00 -5.977851321883492e+00 3.006005752239879e+00 4.877453651408409e+00 9.149189633129146e+03 + 72500 9.150712450642432e-01 -6.044728725663223e+00 -5.976991795679017e+00 3.501072526666415e+00 4.890028460891764e+00 9.146550699383255e+03 + 72520 9.665448243271305e-01 -6.108039066141674e+00 -5.984367540168226e+00 3.127516779427391e+00 4.837657819673719e+00 9.169120388347383e+03 + 72540 9.183810617074951e-01 -6.017536439154661e+00 -6.014539778119937e+00 3.572982841884646e+00 4.590190133277821e+00 9.261757325341860e+03 + 72560 9.461344392215894e-01 -6.033336571275933e+00 -5.966321956735404e+00 3.547996782444740e+00 4.932805069614542e+00 9.113946458618715e+03 + 72580 9.173246130269320e-01 -5.960539493740429e+00 -6.004286651618675e+00 3.914256168791905e+00 4.663053218404214e+00 9.230191886583694e+03 + 72600 9.393550388652162e-01 -5.959128513907172e+00 -6.033142939610921e+00 3.896589513720402e+00 4.471587227634110e+00 9.319056824929668e+03 + 72620 9.850243104538540e-01 -5.993293763707370e+00 -5.984232442869025e+00 3.738941511217701e+00 4.790973017706341e+00 9.168699224166536e+03 + 72640 1.024325434842339e+00 -6.020519380405931e+00 -5.980483275282700e+00 3.560088519276019e+00 4.789982030460854e+00 9.157229032329880e+03 + 72660 1.015675733732020e+00 -5.980742664226510e+00 -6.019912245363479e+00 3.808606402237166e+00 4.583688605875601e+00 9.278273658364073e+03 + 72680 9.742259500825656e-01 -5.899507991734384e+00 -6.002106289781164e+00 4.195827051378737e+00 4.606691746958822e+00 9.223513298934795e+03 + 72700 1.055969606268226e+00 -6.006207806379660e+00 -5.951536330102525e+00 3.630286793610344e+00 4.944218870777266e+00 9.068868861803923e+03 + 72720 1.021595246853594e+00 -5.943295321379082e+00 -5.992003510911981e+00 3.981949725284911e+00 4.702259763419041e+00 9.192501946840819e+03 + 72740 1.037188966076422e+00 -5.958667751745817e+00 -5.976647656877137e+00 3.916817662971957e+00 4.813574265326590e+00 9.145496850070342e+03 + 72760 1.047833886900276e+00 -5.968758454973336e+00 -5.964551538967227e+00 3.857167827479551e+00 4.881324590204775e+00 9.108534511318219e+03 + 72780 9.658054618636885e-01 -5.846283266235456e+00 -5.969943808516325e+00 4.546419966044327e+00 4.836341995860511e+00 9.124891524893375e+03 + 72800 1.058002979624345e+00 -5.981803573160906e+00 -6.003887959413035e+00 3.776653025189787e+00 4.649841061782335e+00 9.228956293605293e+03 + 72820 1.053777964199003e+00 -5.979188793120241e+00 -5.994141247565545e+00 3.852432135262617e+00 4.766572827952836e+00 9.199054834048617e+03 + 72840 1.022364730638935e+00 -5.941322834362438e+00 -6.016845319761229e+00 4.010401969176714e+00 4.576740170950012e+00 9.268822543281320e+03 + 72860 1.037561485102724e+00 -5.979086308878691e+00 -6.012290618666830e+00 3.817982767730245e+00 4.627318482576417e+00 9.254805997212261e+03 + 72880 1.009164477343931e+00 -5.960241969863128e+00 -6.019878907357963e+00 3.887391883818386e+00 4.544947359936794e+00 9.278187541451096e+03 + 72900 1.066736862082941e+00 -6.080005472524819e+00 -5.975125118827476e+00 3.264824451125244e+00 4.867063672237672e+00 9.140846841802993e+03 + 72920 1.003399253080656e+00 -6.029514267911638e+00 -5.978707241909753e+00 3.509022454205784e+00 4.800764259870475e+00 9.151775325010045e+03 + 72940 9.535761167765118e-01 -6.001615836280941e+00 -5.954632160062701e+00 3.731703458704696e+00 5.001490998250222e+00 9.078290934050972e+03 + 72960 9.196298383619387e-01 -5.987269461269023e+00 -5.978560263851897e+00 3.805059703354952e+00 4.855069262668036e+00 9.151337730454492e+03 + 72980 1.020585762533329e+00 -6.167090803238928e+00 -5.954835678171033e+00 2.831065740004589e+00 5.049867514518892e+00 9.078944507191225e+03 + 73000 9.621241155304027e-01 -6.101125246511409e+00 -5.980738179444289e+00 3.097751160944852e+00 4.789032329882674e+00 9.158019567042968e+03 + 73020 9.090859665793796e-01 -6.032119407713447e+00 -5.978809183999481e+00 3.506135737145520e+00 4.812251291441573e+00 9.152120049149718e+03 + 73040 8.931885141968973e-01 -6.008852108101132e+00 -6.031736567598451e+00 3.592191671398244e+00 4.460785563605972e+00 9.314757023904172e+03 + 73060 9.624623816456107e-01 -6.105908641321625e+00 -6.029303866979906e+00 3.094868196543592e+00 4.534744665364256e+00 9.307232013232511e+03 + 73080 9.589855232223315e-01 -6.092052100563207e+00 -6.012355409949041e+00 3.174713604240505e+00 4.632344334770058e+00 9.255026730558202e+03 + 73100 9.513983614694118e-01 -6.069742644660746e+00 -5.965585402751850e+00 3.349465180483686e+00 4.947552181805662e+00 9.111705695140459e+03 + 73120 9.216360532766519e-01 -6.011555531518292e+00 -5.951396103555972e+00 3.633435605529262e+00 4.978880350530298e+00 9.068431151905388e+03 + 73140 9.081053927870062e-01 -5.972153949279168e+00 -5.994845181372799e+00 3.817844021358846e+00 4.687547455220395e+00 9.201225144622225e+03 + 73160 1.002279091406740e+00 -6.089720883028985e+00 -6.000236091409096e+00 3.208025968660132e+00 4.721861489868288e+00 9.217778013995548e+03 + 73180 9.673261717878381e-01 -6.018428204780073e+00 -6.027708050115123e+00 3.539136878443993e+00 4.485850570478709e+00 9.302321009617306e+03 + 73200 1.024808483069570e+00 -6.088650571211963e+00 -5.973827864871935e+00 3.267029007600742e+00 4.926358756161564e+00 9.136877476772252e+03 + 73220 9.858641202999791e-01 -6.016487656433947e+00 -6.011121119602571e+00 3.567101056749535e+00 4.597916541704189e+00 9.251228372612824e+03 + 73240 9.814061938662246e-01 -5.996627015684751e+00 -6.017187987657898e+00 3.670597748070839e+00 4.552533465200898e+00 9.269870380360822e+03 + 73260 9.223904082799604e-01 -5.896881345748175e+00 -6.030352983516607e+00 4.277463639517563e+00 4.511048840782040e+00 9.310425922711258e+03 + 73280 1.037227289119591e+00 -6.055534268629772e+00 -5.974550961430557e+00 3.504767143951465e+00 4.969785826015649e+00 9.139079517388138e+03 + 73300 1.050128691349970e+00 -6.063639043032901e+00 -6.018493700781201e+00 3.400403793144012e+00 4.659635334572403e+00 9.273915622794624e+03 + 73320 9.565537679956597e-01 -5.919066582445882e+00 -6.082128561031999e+00 4.114059549942152e+00 4.177732435141037e+00 9.470903868989584e+03 + 73340 9.536494504923420e-01 -5.912501590176619e+00 -6.065110791960501e+00 4.177822309905687e+00 4.301516657064988e+00 9.418022999433575e+03 + 73360 9.726176998146778e-01 -5.939386401072793e+00 -5.990000350520825e+00 4.031598440696006e+00 4.740965310482047e+00 9.186365816889293e+03 + 73380 1.010977450629653e+00 -5.993293501225906e+00 -5.974321773710351e+00 3.760093074312020e+00 4.869031669571682e+00 9.138370782448190e+03 + 73400 9.719934782163319e-01 -5.930561070974967e+00 -6.047650188750539e+00 4.033218560437811e+00 4.360874726688064e+00 9.363912091845508e+03 + 73420 1.020520366949907e+00 -6.000284264454055e+00 -6.026836640020360e+00 3.681977815455648e+00 4.529509965987089e+00 9.299645180281510e+03 + 73440 1.006110181453964e+00 -5.980374938229298e+00 -5.980521559818353e+00 3.812154098251699e+00 4.811312174397727e+00 9.157353353892939e+03 + 73460 9.295980156710294e-01 -5.869835617537896e+00 -5.994195610784443e+00 4.445061182457845e+00 4.730966856589410e+00 9.199208535107184e+03 + 73480 1.006779851724471e+00 -5.985638852642568e+00 -6.019184614123278e+00 3.770141649171733e+00 4.577516695559686e+00 9.276028164811356e+03 + 73500 1.080322651491789e+00 -6.095755477394412e+00 -5.977967927656576e+00 3.215581656810278e+00 4.891935994969343e+00 9.149544245588007e+03 + 73520 1.042399140691672e+00 -6.043479119791276e+00 -6.005633269013389e+00 3.533435351456823e+00 4.750752083249935e+00 9.234347564666839e+03 + 73540 9.419937645538990e-01 -5.905377665582979e+00 -6.045831205211638e+00 4.238433128929310e+00 4.431927169266539e+00 9.358241104489192e+03 + 73560 1.008266246960170e+00 -6.019587895413151e+00 -6.032911347174870e+00 3.562899600127392e+00 4.486394278314108e+00 9.318362358035660e+03 + 73580 1.017697861944102e+00 -6.056916279079955e+00 -6.020795597932734e+00 3.437820205151820e+00 4.645230745956508e+00 9.281006407327552e+03 + 73600 9.528381417543579e-01 -5.987310125229060e+00 -6.011506082236833e+00 3.818728210475375e+00 4.679791281024496e+00 9.252411770002522e+03 + 73620 9.897162234087546e-01 -6.069695282451325e+00 -5.987607518882977e+00 3.398423307974358e+00 4.869783949424168e+00 9.179054434023268e+03 + 73640 9.573086088792493e-01 -6.044944960108083e+00 -5.984677652632372e+00 3.493676974322121e+00 4.839741180183347e+00 9.170098310268995e+03 + 73660 9.671914427421177e-01 -6.081794593296113e+00 -5.964148115110261e+00 3.315945392752551e+00 4.991489676229378e+00 9.107318513455997e+03 + 73680 9.390865324405192e-01 -6.055261041865697e+00 -5.942310392565254e+00 3.428115301656125e+00 5.076695408995757e+00 9.040805230159187e+03 + 73700 1.009211813209879e+00 -6.166775701426771e+00 -5.940259775630715e+00 2.832580807951647e+00 5.133270307098836e+00 9.034570102592023e+03 + 73720 9.063290412548513e-01 -6.015951183371519e+00 -5.993448813660751e+00 3.596612841682744e+00 4.725824930792433e+00 9.196949432748070e+03 + 73740 9.028921735355224e-01 -6.006589862600302e+00 -5.972364442960016e+00 3.687328638291888e+00 4.883856294232983e+00 9.132400790806563e+03 + 73760 9.589026309378389e-01 -6.075255982313986e+00 -5.979549216841307e+00 3.289640830425925e+00 4.839203888344140e+00 9.154371203431461e+03 + 73780 9.345316043805485e-01 -6.017158950059915e+00 -5.986514049210983e+00 3.644508353653457e+00 4.820476116611104e+00 9.175684320450217e+03 + 73800 9.231559534117376e-01 -5.972274872762460e+00 -5.970893005163768e+00 3.816613163967305e+00 4.824548061562316e+00 9.127914202483094e+03 + 73820 9.705735591298116e-01 -6.008511345760110e+00 -5.975714046069624e+00 3.624088023084399e+00 4.812415193272894e+00 9.142620859156037e+03 + 73840 9.972819162596961e-01 -6.008389627377813e+00 -5.968518774103595e+00 3.635201492404540e+00 4.864146101899701e+00 9.120653456879274e+03 + 73860 9.817189284040141e-01 -5.949218718504712e+00 -5.976056036574786e+00 3.976773834825202e+00 4.822669801405288e+00 9.143679446530907e+03 + 73880 1.040166414937262e+00 -6.004919505676765e+00 -5.969685342630910e+00 3.679460581479818e+00 4.881780598158228e+00 9.124223152864846e+03 + 73900 1.079914675346431e+00 -6.040884731609309e+00 -6.002124527555193e+00 3.535944619586100e+00 4.758511709387030e+00 9.223569063949006e+03 + 73920 1.047829509588579e+00 -5.979487733011665e+00 -6.032549569633018e+00 3.781282157949619e+00 4.476592880777133e+00 9.317241153472331e+03 + 73940 1.019810193658677e+00 -5.932476392884114e+00 -6.075917325311146e+00 4.039195514559704e+00 4.215535483151132e+00 9.451563527228864e+03 + 73960 1.037729672454579e+00 -5.961426844547875e+00 -6.007704840816306e+00 3.869478786332632e+00 4.603743370262522e+00 9.240701439990828e+03 + 73980 1.102026119111210e+00 -6.061451296932031e+00 -5.953672421070395e+00 3.396197484600524e+00 5.015080468525175e+00 9.075367123104703e+03 + 74000 1.006672094511474e+00 -5.926467505986917e+00 -6.002406971215061e+00 4.095271284290035e+00 4.659215123355766e+00 9.224440497945985e+03 + 74020 1.056884738107506e+00 -6.009632082653363e+00 -6.011765403975296e+00 3.625905269189227e+00 4.613655408028276e+00 9.253209970679931e+03 + 74040 1.039636399233511e+00 -5.998278829677089e+00 -6.001560854848362e+00 3.699170887765238e+00 4.680324991340035e+00 9.221836785987163e+03 + 74060 9.688754430013009e-01 -5.908286021778902e+00 -6.009212893352297e+00 4.242043157154411e+00 4.662505442197076e+00 9.245344872767841e+03 + 74080 1.040483318226725e+00 -6.031770266090712e+00 -5.986843777372107e+00 3.475071136031926e+00 4.733045986605817e+00 9.176712530643745e+03 + 74100 9.645288998075801e-01 -5.937955009317080e+00 -6.008977019358065e+00 4.024033640297134e+00 4.616214268021268e+00 9.244630159261613e+03 + 74120 9.803070171406298e-01 -5.980843609629494e+00 -6.009911909613690e+00 3.803625088395291e+00 4.636710411581150e+00 9.247504755482591e+03 + 74140 9.999997113074159e-01 -6.030798533361322e+00 -5.997983766583035e+00 3.495907900029331e+00 4.684335368939005e+00 9.210857272552896e+03 + 74160 9.264525276868963e-01 -5.942125733020693e+00 -5.970562345907128e+00 4.075630905750844e+00 4.912343474005310e+00 9.126872718634690e+03 + 74180 9.180508610076498e-01 -5.945308621464712e+00 -5.943455882291880e+00 4.044326120048284e+00 5.054964835089151e+00 9.044267248308415e+03 + 74200 9.822562377756259e-01 -6.053687427702259e+00 -5.994404109993441e+00 3.372367880472150e+00 4.712781864819949e+00 9.199869006592580e+03 + 74220 9.485140274067376e-01 -6.018207944563933e+00 -5.967141174133536e+00 3.596376329164537e+00 4.889609627533062e+00 9.116478001217803e+03 + 74240 9.623867966372879e-01 -6.055213430180357e+00 -5.988939693589677e+00 3.373948730077733e+00 4.754502781409008e+00 9.183145481648467e+03 + 74260 9.585272131675899e-01 -6.068527526050202e+00 -5.992391176609820e+00 3.321143495477575e+00 4.758330196026249e+00 9.193725211683433e+03 + 74280 9.196119465426698e-01 -6.036674130672638e+00 -6.017429096414313e+00 3.533322536836802e+00 4.643830501707531e+00 9.270627390581209e+03 + 74300 9.357129504306640e-01 -6.089750562043562e+00 -5.992196571528278e+00 3.190429748988795e+00 4.750599858958802e+00 9.193138774969077e+03 + 74320 9.054852053433827e-01 -6.073520136401093e+00 -6.009740008190021e+00 3.322745827227579e+00 4.688981193358500e+00 9.246972467195035e+03 + 74340 9.627120106480778e-01 -6.182961160617626e+00 -5.947872911458736e+00 2.779982140037472e+00 5.129895246496801e+00 9.057741214538777e+03 + 74360 8.851872224222322e-01 -6.085246424963919e+00 -6.001031785758791e+00 3.220131911266630e+00 4.703705401755777e+00 9.220185250074148e+03 + 74380 8.460306141218816e-01 -6.034933062541751e+00 -5.962794647628597e+00 3.545861187821419e+00 4.960091129636380e+00 9.103155731831766e+03 + 74400 8.821771276803232e-01 -6.083960514819410e+00 -5.946327737813338e+00 3.231417820616046e+00 5.021726524788317e+00 9.053004871906396e+03 + 74420 9.186679364848320e-01 -6.120687508885935e+00 -5.961099991514843e+00 2.987252890226940e+00 4.903629111060251e+00 9.098007552959249e+03 + 74440 9.367573541293815e-01 -6.117978660265644e+00 -5.939682084807707e+00 3.095847103167368e+00 5.119653630752725e+00 9.032803410251776e+03 + 74460 9.159588617796250e-01 -6.046055643208772e+00 -5.981136831691625e+00 3.444249084659588e+00 4.817022946544663e+00 9.159240345208824e+03 + 74480 9.789491483887546e-01 -6.096142293300542e+00 -5.978103552855586e+00 3.194306499672160e+00 4.872103213743146e+00 9.149951415732172e+03 + 74500 9.766268254907194e-01 -6.053118022779135e+00 -5.966927551735280e+00 3.421112342520206e+00 4.916031365186312e+00 9.115796295156959e+03 + 74520 9.787978868597506e-01 -6.022748002520350e+00 -5.985726188705568e+00 3.610194682313442e+00 4.822779666345094e+00 9.173276749880035e+03 + 74540 9.681277366746442e-01 -5.978780734654702e+00 -6.016478609731580e+00 3.759555968043839e+00 4.543088935625092e+00 9.267696902322177e+03 + 74560 9.664053462108696e-01 -5.954560344029079e+00 -6.015148252516609e+00 3.934284866975612e+00 4.586379720491674e+00 9.263594529280615e+03 + 74580 1.020760381627576e+00 -6.016891155567022e+00 -6.001335523185948e+00 3.584228670792708e+00 4.673551519151165e+00 9.221150061831795e+03 + 74600 1.022121115268821e+00 -6.003170132822634e+00 -6.006893670733271e+00 3.659515655526804e+00 4.638134524628292e+00 9.238247565085869e+03 + 74620 1.030144663821612e+00 -6.004008252392195e+00 -5.988346371278444e+00 3.670520968339323e+00 4.760453913362751e+00 9.181291989193436e+03 + 74640 1.013050515429063e+00 -5.969065498348031e+00 -5.965481799243464e+00 3.897376209352586e+00 4.917954364186656e+00 9.111378579113883e+03 + 74660 1.022617120339047e+00 -5.973786728425058e+00 -5.956941673304435e+00 3.848822780665006e+00 4.945549693931481e+00 9.085347157083586e+03 + 74680 1.007914393451495e+00 -5.943951653503214e+00 -6.016348972920043e+00 3.984896380438069e+00 4.569179768897667e+00 9.267283602500569e+03 + 74700 9.986802449413656e-01 -5.923986178274326e+00 -6.016126700048874e+00 4.044904963953804e+00 4.515819829224692e+00 9.266607958886227e+03 + 74720 1.005886916511639e+00 -5.931122117685076e+00 -6.006153544338350e+00 4.054383017028403e+00 4.623540954109557e+00 9.235939919845003e+03 + 74740 1.028329530845373e+00 -5.964032754698774e+00 -6.022562978593945e+00 3.861041022236075e+00 4.524951419107128e+00 9.286410702605079e+03 + 74760 9.803145559323311e-01 -5.896512907028589e+00 -6.008043692727307e+00 4.201627827211692e+00 4.561200796396343e+00 9.241752286097399e+03 + 74780 1.050448019390488e+00 -6.006849466827832e+00 -5.964229877028570e+00 3.674704412337950e+00 4.919432692325519e+00 9.107562003843244e+03 + 74800 1.079249698980009e+00 -6.059677305946659e+00 -5.984593427073376e+00 3.325709555183013e+00 4.756852806866105e+00 9.169823458012339e+03 + 74820 9.799916835240782e-01 -5.929631655063591e+00 -6.001980596002301e+00 4.077363101655057e+00 4.661924286822559e+00 9.223130476131559e+03 + 74840 9.859467339506287e-01 -5.960359460496969e+00 -6.018513611396257e+00 3.929788156432520e+00 4.595858022643043e+00 9.273953206138536e+03 + 74860 1.033635826269025e+00 -6.060767619824266e+00 -6.017822274484399e+00 3.399355091867636e+00 4.645953910579863e+00 9.271863945455072e+03 + 74880 9.759721785558156e-01 -6.013229162277334e+00 -6.053383192980586e+00 3.647891779961840e+00 4.417321121847592e+00 9.381660483482174e+03 + 74900 9.714687453810785e-01 -6.047452204960190e+00 -5.965001404946334e+00 3.455326756932231e+00 4.928772009831857e+00 9.109932519930268e+03 + 74920 9.145583147103661e-01 -5.995908172418925e+00 -6.015023393295445e+00 3.701933716315916e+00 4.592171159972068e+00 9.263217256916281e+03 + 74940 9.653273851456586e-01 -6.096428436032460e+00 -5.985841554844472e+00 3.236334610854196e+00 4.871341595900179e+00 9.173647519578228e+03 + 74960 9.424963885077904e-01 -6.080469848322861e+00 -5.996300981389869e+00 3.353135343584635e+00 4.836446002603942e+00 9.205690801787901e+03 + 74980 9.506503164090532e-01 -6.104357127865349e+00 -5.960936668558809e+00 3.170102272240164e+00 4.993644743822664e+00 9.097503244613514e+03 + 75000 8.700904293810257e-01 -5.987458303524590e+00 -6.010619711951475e+00 3.721728973462096e+00 4.588732582058554e+00 9.249665665565244e+03 + 75020 9.109249801658880e-01 -6.041616508048135e+00 -6.013570361604731e+00 3.451909150539392e+00 4.612954463544551e+00 9.258772582208532e+03 + 75040 9.933322068281094e-01 -6.149541974964728e+00 -6.007680433773741e+00 2.882601495519751e+00 4.697192418040948e+00 9.240679661976419e+03 + 75060 9.609513030287639e-01 -6.082523143000262e+00 -6.027742168932669e+00 3.229558844043006e+00 4.544119674467460e+00 9.302432561895517e+03 + 75080 9.449910725191065e-01 -6.037272041552976e+00 -6.018417057081827e+00 3.507258180847169e+00 4.615526419479927e+00 9.273676977975101e+03 + 75100 9.491350982879939e-01 -6.018734955585298e+00 -6.001417919326830e+00 3.583420173141896e+00 4.682857275140719e+00 9.221403143323339e+03 + 75120 9.535680026247864e-01 -5.995239583519211e+00 -5.937812097532492e+00 3.742362995962986e+00 5.072120507373468e+00 9.027126647794794e+03 + 75140 9.942484227699008e-01 -6.022018546408974e+00 -5.960944055624526e+00 3.603825964486139e+00 4.954525141817343e+00 9.097527379321546e+03 + 75160 1.027873631379090e+00 -6.037984826370608e+00 -6.014628130455152e+00 3.518315957475176e+00 4.652433719858738e+00 9.262003524501955e+03 + 75180 9.962045495131849e-01 -5.968625199310502e+00 -6.095706266078723e+00 3.803277386555143e+00 4.073558235440487e+00 9.513169474446655e+03 + 75200 1.005485192065467e+00 -5.972095288743114e+00 -6.024462460911707e+00 3.831942033980300e+00 4.531241627594541e+00 9.292281309877082e+03 + 75220 9.639440305854408e-01 -5.904765452569521e+00 -6.042682077053646e+00 4.139088241842245e+00 4.347149641525733e+00 9.348546171238233e+03 + 75240 1.100348312849856e+00 -6.105214989262095e+00 -5.964343507400673e+00 3.146828763849312e+00 4.955734612488966e+00 9.107914207085378e+03 + 75260 1.056228523516504e+00 -6.039575006170219e+00 -5.967016735483449e+00 3.521745798166965e+00 4.938386616806499e+00 9.116055523900181e+03 + 75280 1.028838265900209e+00 -6.000037471681031e+00 -6.008139818689394e+00 3.675760589673192e+00 4.629235659317025e+00 9.242072454129033e+03 + 75300 1.018865487876142e+00 -5.989129081903224e+00 -6.048353767935232e+00 3.750205996587058e+00 4.410128684400721e+00 9.366093892289990e+03 + 75320 1.017782367439038e+00 -5.995538006422554e+00 -6.008318703742540e+00 3.749651007813259e+00 4.676262265995383e+00 9.242610486061058e+03 + 75340 1.071290944018869e+00 -6.084598345371083e+00 -5.956463019506284e+00 3.230477810068202e+00 4.966250680061470e+00 9.083892865203470e+03 + 75360 9.877491482691030e-01 -5.971185820990510e+00 -5.971756603105517e+00 3.846847198281965e+00 4.843569679049351e+00 9.130529648337855e+03 + 75380 9.808452817333607e-01 -5.971352607742769e+00 -5.981138097856833e+00 3.894796024025719e+00 4.838606225491058e+00 9.159211078145969e+03 + 75400 1.037038295316925e+00 -6.064265249728187e+00 -5.949850864363729e+00 3.346781622734711e+00 5.003766729066347e+00 9.063731573688070e+03 + 75420 9.840219089987409e-01 -5.993678390346595e+00 -5.973200831648965e+00 3.760001388235666e+00 4.877586699169426e+00 9.134926175657400e+03 + 75440 9.948334277117568e-01 -6.017392759569398e+00 -5.938807060731495e+00 3.615381099452960e+00 5.066632343277792e+00 9.030130276400947e+03 + 75460 9.896458641573308e-01 -6.015972047806883e+00 -5.967456517945833e+00 3.605985471387829e+00 4.884569151603962e+00 9.117398429097395e+03 + 75480 9.934613001299268e-01 -6.025510613901039e+00 -5.970354230591690e+00 3.553212218220808e+00 4.869928706605823e+00 9.126256412388377e+03 + 75500 1.002793901060188e+00 -6.041588045741925e+00 -5.980432002989019e+00 3.481903121725062e+00 4.833070583079277e+00 9.157062131920951e+03 + 75520 9.558324051356426e-01 -5.973735917190573e+00 -5.998751254103208e+00 3.801190804632830e+00 4.657548868969602e+00 9.213244215413853e+03 + 75540 9.856201869383434e-01 -6.017123277830004e+00 -6.022670514561842e+00 3.553919604419966e+00 4.522066512673646e+00 9.286780915758225e+03 + 75560 9.539124603872683e-01 -5.968159645067333e+00 -6.050608970972844e+00 3.865644433700548e+00 4.392207645359153e+00 9.373061011720489e+03 + 75580 9.431429554037259e-01 -5.949508230117665e+00 -6.063763285413580e+00 3.930384795060713e+00 4.274314586638908e+00 9.413828371855889e+03 + 75600 1.034053647388524e+00 -6.080879903000408e+00 -5.981950159149587e+00 3.269247744205254e+00 4.837317642725052e+00 9.161726533907262e+03 + 75620 1.004190179090731e+00 -6.029021373549702e+00 -6.009415077515493e+00 3.595222935501313e+00 4.707805321394249e+00 9.245969720949764e+03 + 75640 9.718085322803021e-01 -5.971874941066882e+00 -5.998909240844970e+00 3.829077901226786e+00 4.673842768356635e+00 9.213697081999937e+03 + 75660 9.730190163301217e-01 -5.960155139837681e+00 -6.040333335692218e+00 3.841720549647667e+00 4.381324941515206e+00 9.341266010075447e+03 + 75680 1.012869534048571e+00 -6.002747971882565e+00 -5.973591583223703e+00 3.705479803676918e+00 4.872900299292669e+00 9.136155279166231e+03 + 75700 1.023855579712104e+00 -6.000208912667226e+00 -6.008372568227969e+00 3.688902714402673e+00 4.642025740851272e+00 9.242749438761124e+03 + 75720 1.041769066119272e+00 -6.006764978630788e+00 -6.035015498849567e+00 3.636503418039051e+00 4.474284559188940e+00 9.324874003337341e+03 + 75740 9.584135189899680e-01 -5.865192773132172e+00 -6.063090906379620e+00 4.409265943954011e+00 4.272904238210019e+00 9.411738152032245e+03 + 75760 1.002279077437801e+00 -5.914305647717590e+00 -6.041233079982685e+00 4.163685211749369e+00 4.434848253726529e+00 9.344074540587113e+03 + 75780 1.059619457402267e+00 -5.985624395891827e+00 -6.038748500824565e+00 3.788756047672038e+00 4.483709216219589e+00 9.336387436068724e+03 + 75800 1.001152575729453e+00 -5.890488791627259e+00 -6.105338308884127e+00 4.249146039746309e+00 4.015446863802031e+00 9.543251916526711e+03 + 75820 1.002694792806448e+00 -5.891353014514380e+00 -6.068105747318249e+00 4.303260862136042e+00 4.288319317979222e+00 9.427300828426283e+03 + 75840 1.060172212791630e+00 -5.982208807021923e+00 -5.978453729784905e+00 3.804545700669832e+00 4.826107935261118e+00 9.151037981985064e+03 + 75860 1.001891310047016e+00 -5.905333660527308e+00 -6.038829661548118e+00 4.203047381384064e+00 4.436492685083180e+00 9.336612782716425e+03 + 75880 1.056839936818774e+00 -6.003078416065223e+00 -6.011501353209184e+00 3.625578885876592e+00 4.577213077350655e+00 9.252382743846909e+03 + 75900 1.036454381224847e+00 -5.998323619011718e+00 -5.966704740524631e+00 3.680800874826888e+00 4.862361368105377e+00 9.115115829592716e+03 + 75920 9.308545586627783e-01 -5.870946164710370e+00 -6.042481757755157e+00 4.395105320588135e+00 4.410121400277737e+00 9.347878252505283e+03 + 75940 9.685868991514517e-01 -5.961776544641721e+00 -6.026809342915873e+00 3.884293556842776e+00 4.510865165359585e+00 9.299528939809330e+03 + 75960 9.432709371698157e-01 -5.961260649655257e+00 -6.028060791513147e+00 3.885047172826419e+00 4.501470420989876e+00 9.303382943355517e+03 + 75980 9.478989028861291e-01 -6.000584462762107e+00 -6.004712975991136e+00 3.696454038647478e+00 4.672747476801037e+00 9.231524987642879e+03 + 76000 9.970805418490873e-01 -6.100005093039072e+00 -6.023827395257143e+00 3.159532416669891e+00 4.596956545794359e+00 9.290325003757849e+03 + 76020 9.307165834568024e-01 -6.023602742724633e+00 -5.992871600527642e+00 3.565116144470216e+00 4.741579118594224e+00 9.195204294598163e+03 + 76040 1.035133617364431e+00 -6.193660547859423e+00 -5.965520092636967e+00 2.614139164365656e+00 4.924156962874343e+00 9.111518630276571e+03 + 76060 9.189639013834705e-01 -6.028719124581639e+00 -5.972871572918073e+00 3.561535542966884e+00 4.882220826999765e+00 9.133965785951170e+03 + 76080 9.039653159019446e-01 -6.006107969407191e+00 -6.006886498564500e+00 3.677520562380957e+00 4.673050127482695e+00 9.238199199890127e+03 + 76100 9.816044131330260e-01 -6.115375541095547e+00 -5.981101084475158e+00 3.061168142632209e+00 4.832192851451490e+00 9.159132247586693e+03 + 76120 9.917282157104250e-01 -6.119952364895518e+00 -5.987866042806566e+00 3.032194841162021e+00 4.790654942889068e+00 9.179848548233413e+03 + 76140 9.866683166815886e-01 -6.096782918954821e+00 -5.990411198123923e+00 3.172624339474438e+00 4.783427221456058e+00 9.187652564717142e+03 + 76160 1.016286866592405e+00 -6.121962609910415e+00 -5.989310646649686e+00 3.009595116474608e+00 4.771303217342686e+00 9.184278300601125e+03 + 76180 9.073114366156748e-01 -5.939094771659452e+00 -6.011830012918007e+00 4.033663372352329e+00 4.616006361303500e+00 9.253389745876337e+03 + 76200 9.272607892783477e-01 -5.943457650205709e+00 -6.034038738651557e+00 3.963349395170041e+00 4.443218767935848e+00 9.321846380787791e+03 + 76220 9.797688687292769e-01 -5.993923800528484e+00 -6.025374403658489e+00 3.802918524110440e+00 4.622324293972848e+00 9.295102978187904e+03 + 76240 1.068949210828011e+00 -6.102751839550146e+00 -5.989361331632303e+00 3.136913512792053e+00 4.788019356380704e+00 9.184423482739288e+03 + 76260 1.032941179821768e+00 -6.032260146230769e+00 -5.964606067763217e+00 3.531540387455571e+00 4.920020575451062e+00 9.108730019293786e+03 + 76280 1.010422647037766e+00 -5.987230551271983e+00 -5.975248957347688e+00 3.829518554361889e+00 4.898318720820861e+00 9.141202766395769e+03 + 76300 9.826665999466337e-01 -5.938329619151382e+00 -5.995993466059112e+00 4.043963769276472e+00 4.712849036880820e+00 9.204734552133135e+03 + 76320 1.038975357599377e+00 -6.016212792170080e+00 -6.006202006382857e+00 3.637623246159619e+00 4.695106727313947e+00 9.236099355224593e+03 + 76340 1.035566086715203e+00 -6.010323195699391e+00 -6.016081781540890e+00 3.634419243299490e+00 4.601352552259319e+00 9.266493131598751e+03 + 76360 1.037550475135629e+00 -6.016540715284439e+00 -6.038028048718242e+00 3.566676184169583e+00 4.443292590438585e+00 9.334175145317326e+03 + 76380 9.909138773456484e-01 -5.952862123002911e+00 -6.020140843316710e+00 3.955034674384347e+00 4.568709850994191e+00 9.278986144962013e+03 + 76400 1.011861820493628e+00 -5.991083348276138e+00 -5.962437852511718e+00 3.759912806094825e+00 4.924399675650275e+00 9.102106940913922e+03 + 76420 1.022021304405100e+00 -6.011338113971354e+00 -5.976782612171760e+00 3.636218604654656e+00 4.834641643434547e+00 9.145877102323833e+03 + 76440 9.414676351261720e-01 -5.896822642094934e+00 -6.023361350568062e+00 4.200200346630318e+00 4.473595500775767e+00 9.288918895120643e+03 + 76460 1.006478598724460e+00 -5.997119061904542e+00 -6.027839507201659e+00 3.685123662747557e+00 4.508722111877965e+00 9.302712258571783e+03 + 76480 1.031694968442922e+00 -6.040604022557227e+00 -6.024623088477257e+00 3.476603660239339e+00 4.568368656768086e+00 9.292801370289211e+03 + 76500 9.624381201586054e-01 -5.947227611602189e+00 -6.060315138924301e+00 4.005376349955112e+00 4.356010267833255e+00 9.403140002497948e+03 + 76520 9.778285260878747e-01 -5.981747265498200e+00 -6.022602841750017e+00 3.812721431268407e+00 4.578122390050478e+00 9.286570984818478e+03 + 76540 9.679030458269198e-01 -5.979190053950963e+00 -5.998795838165444e+00 3.867606476229402e+00 4.755027029284553e+00 9.213326925149458e+03 + 76560 1.023878453132180e+00 -6.074288374033142e+00 -5.970087285798999e+00 3.293356744763868e+00 4.891695518470611e+00 9.125450135002930e+03 + 76580 9.842978815665397e-01 -6.024663970855451e+00 -6.024761520816134e+00 3.533590490874299e+00 4.533030343904251e+00 9.293219360648667e+03 + 76600 9.935504345598720e-01 -6.052369800641815e+00 -5.976084401691383e+00 3.470770565811327e+00 4.908813131712044e+00 9.143771660127029e+03 + 76620 1.008605568746383e+00 -6.088169372154105e+00 -5.961671382026655e+00 3.240731408844999e+00 4.967102443657531e+00 9.099762038200355e+03 + 76640 1.001510717045568e+00 -6.090334289765228e+00 -5.979687391292297e+00 3.217942792821951e+00 4.853294406405725e+00 9.154804744287936e+03 + 76660 9.732512587642480e-01 -6.061787389935800e+00 -5.963240688526579e+00 3.385358593990081e+00 4.951229003534588e+00 9.104543546314215e+03 + 76680 9.604090261013933e-01 -6.053089554960540e+00 -5.988864863648185e+00 3.353289087716155e+00 4.722077203970557e+00 9.182901355375647e+03 + 76700 9.345753650146791e-01 -6.021502345435197e+00 -5.966072163346588e+00 3.671563980322076e+00 4.989852663667822e+00 9.113192111774759e+03 + 76720 9.658598868509626e-01 -6.071572278476234e+00 -6.011075539483307e+00 3.278388840438405e+00 4.625770477575893e+00 9.251095622911058e+03 + 76740 9.242725953504218e-01 -6.009810742278886e+00 -6.029097414876126e+00 3.651246792089217e+00 4.540499733432925e+00 9.306588190395401e+03 + 76760 9.432580747690660e-01 -6.031846918418294e+00 -5.990117591761117e+00 3.519893145858240e+00 4.759509397116179e+00 9.186745839769685e+03 + 76780 9.929383171070868e-01 -6.090675382790504e+00 -6.003359943367769e+00 3.188942249037066e+00 4.690321014222993e+00 9.227381993143721e+03 + 76800 9.512423481561035e-01 -6.007941843120177e+00 -6.043160579896435e+00 3.590986856285561e+00 4.388755419634384e+00 9.350034257514497e+03 + 76820 1.030017380644078e+00 -6.097852273708975e+00 -5.990397493063930e+00 3.129948737393463e+00 4.746970716430875e+00 9.187609386484237e+03 + 76840 9.014301950337887e-01 -5.874824226311594e+00 -6.016750181116633e+00 4.418086928309100e+00 4.603126132848044e+00 9.268556364947779e+03 + 76860 1.059641074422038e+00 -6.073350272459393e+00 -6.010551293563649e+00 3.278751569498670e+00 4.639353024428608e+00 9.249481379358254e+03 + 76880 1.073141595340660e+00 -6.057175771755169e+00 -5.981912793133798e+00 3.397960491043853e+00 4.830132161196063e+00 9.161620118422265e+03 + 76900 9.960642417247977e-01 -5.914974620016306e+00 -6.017160770177630e+00 4.133535145274797e+00 4.546766457792845e+00 9.269779364894697e+03 + 76920 9.998858227000335e-01 -5.898519377431553e+00 -6.022812168229408e+00 4.202083583711725e+00 4.488375144703226e+00 9.287157737108979e+03 + 76940 1.049200594823602e+00 -5.954218654048367e+00 -6.003446477029344e+00 3.942293830653328e+00 4.659620053115568e+00 9.227640210484751e+03 + 76960 1.076997850088828e+00 -5.983166272066539e+00 -6.011182485390131e+00 3.765810415667917e+00 4.604936983268850e+00 9.251415540349350e+03 + 76980 1.046313525807467e+00 -5.932794538243369e+00 -6.033928638756063e+00 4.025290436567843e+00 4.444562780972486e+00 9.321474514059821e+03 + 77000 1.070218571873248e+00 -5.971988986186425e+00 -6.001966085807163e+00 3.870038617211882e+00 4.697905472248435e+00 9.223065679919426e+03 + 77020 1.040367491223628e+00 -5.936908002350227e+00 -6.028230102709736e+00 4.062043300852292e+00 4.537657668538636e+00 9.303893037376198e+03 + 77040 1.030935905723028e+00 -5.938004684832507e+00 -6.006803802815046e+00 4.034249846264656e+00 4.639194664179820e+00 9.237934859465682e+03 + 77060 9.818232820172352e-01 -5.884163213933947e+00 -6.013509802876924e+00 4.342765509325186e+00 4.600037379294661e+00 9.258548940883838e+03 + 77080 1.052890937622306e+00 -6.015308955999066e+00 -5.992379725893143e+00 3.618952748292556e+00 4.750615935847657e+00 9.193664292157426e+03 + 77100 1.000695741104531e+00 -5.969450293300017e+00 -5.996618768199244e+00 3.862766134083425e+00 4.706760546904164e+00 9.206658063263250e+03 + 77120 9.810953773368571e-01 -5.974029890115113e+00 -6.015382847371840e+00 3.804500568002720e+00 4.567045488085140e+00 9.264323310523459e+03 + 77140 9.738470342731991e-01 -5.998905391792707e+00 -6.031828547204700e+00 3.723100234015637e+00 4.534050380798143e+00 9.315005395966811e+03 + 77160 1.077665471789641e+00 -6.190872450679098e+00 -5.938367534322178e+00 2.716682841818992e+00 5.166605146549951e+00 9.028840906547242e+03 + 77180 9.117984638462541e-01 -5.976129095854976e+00 -6.032183680895669e+00 3.796443251533684e+00 4.474569149811026e+00 9.316114569743175e+03 + 77200 8.968290412047899e-01 -5.976796748734516e+00 -6.054221869553881e+00 3.832571044636072e+00 4.387984019392556e+00 9.384234217592500e+03 + 77220 9.542175354742580e-01 -6.074838968198442e+00 -6.029844805097509e+00 3.296669776464889e+00 4.555033223814684e+00 9.308907415975911e+03 + 77240 9.869319200610509e-01 -6.128386911683827e+00 -5.989263632612101e+00 3.036979550349304e+00 4.835846948037015e+00 9.184137856371819e+03 + 77260 9.020075899348160e-01 -6.002087552723443e+00 -6.018939955998020e+00 3.710535747079130e+00 4.613766639575527e+00 9.275300086894984e+03 + 77280 9.811304812337647e-01 -6.115531072428597e+00 -6.006379620394696e+00 3.089308545848877e+00 4.716073074560151e+00 9.236658539063654e+03 + 77300 9.154856231678089e-01 -6.011307939290251e+00 -6.020312901899822e+00 3.653728875762927e+00 4.602020986945312e+00 9.279499555776621e+03 + 77320 9.088646359801265e-01 -5.990875384721905e+00 -6.020940960193702e+00 3.737419922237067e+00 4.564778735245239e+00 9.281449789462811e+03 + 77340 9.617580495484664e-01 -6.055293314466826e+00 -6.020453387388024e+00 3.427216952413656e+00 4.627273205161430e+00 9.279958938866881e+03 + 77360 9.918622494114218e-01 -6.085771288375033e+00 -6.015323047638994e+00 3.249167163685519e+00 4.653691863821882e+00 9.264143519956750e+03 + 77380 9.878430369076583e-01 -6.066049339052080e+00 -5.984609637129328e+00 3.343498989353615e+00 4.811138360547205e+00 9.169868907666480e+03 + 77400 9.881055693255767e-01 -6.049696724138380e+00 -6.029784691044545e+00 3.398505766286097e+00 4.512843741688060e+00 9.308701006247833e+03 + 77420 9.442380569343753e-01 -5.967892521588066e+00 -6.044063971309662e+00 3.871653930749631e+00 4.434265678954483e+00 9.352799284775991e+03 + 77440 9.635302367626096e-01 -5.978097309494858e+00 -5.976516352698919e+00 3.809318551631544e+00 4.818396650206101e+00 9.145095411823604e+03 + 77460 1.031071569587829e+00 -6.057656574983576e+00 -5.956341965539268e+00 3.373677298506261e+00 4.955441464320614e+00 9.083513768963112e+03 + 77480 9.561783210016561e-01 -5.925689405622222e+00 -5.991289881508632e+00 4.146382080806897e+00 4.769693996626294e+00 9.190304699357481e+03 + 77500 9.875461942006877e-01 -5.948762602922740e+00 -6.009947882320335e+00 3.966599929615583e+00 4.615264586923201e+00 9.247613070232639e+03 + 77520 1.011987223196080e+00 -5.965030148313156e+00 -6.016512998064790e+00 3.905044081345964e+00 4.609421591126831e+00 9.267810875947282e+03 + 77540 9.828437310988670e-01 -5.905267705646450e+00 -6.030277334249933e+00 4.156407641238356e+00 4.438583008619652e+00 9.310227962311310e+03 + 77560 1.031844168249039e+00 -5.963551695360975e+00 -6.013748120198509e+00 3.859393563926826e+00 4.571157924638064e+00 9.259299902743554e+03 + 77580 1.025344712619901e+00 -5.943603078798919e+00 -6.001479321445190e+00 3.989168879522360e+00 4.656834537927866e+00 9.221598692723452e+03 + 77600 9.876858960331456e-01 -5.878521182742517e+00 -6.057233169864478e+00 4.373423279690803e+00 4.347231394045875e+00 9.393557726678064e+03 + 77620 1.048405377269466e+00 -5.965283697591902e+00 -6.043820423204854e+00 3.837933183406482e+00 4.386963151417897e+00 9.351969485223646e+03 + 77640 1.049955522935665e+00 -5.970416280113805e+00 -6.004421453615732e+00 3.815161984956450e+00 4.619899016424793e+00 9.230606844709877e+03 + 77660 1.016012943430498e+00 -5.929341770299764e+00 -5.970832653725770e+00 4.094919028946958e+00 4.856671955621375e+00 9.127713636099425e+03 + 77680 1.075730305499723e+00 -6.033618318249268e+00 -5.981874097317982e+00 3.537572920289043e+00 4.834696244268795e+00 9.161474450526517e+03 + 77700 1.003903577665351e+00 -5.957388514035513e+00 -6.018971590985894e+00 3.882014493859845e+00 4.528394936060398e+00 9.275362638712924e+03 + 77720 1.001423546409892e+00 -5.997831458287514e+00 -5.971801816688876e+00 3.724728599868541e+00 4.874194830001944e+00 9.130693350045449e+03 + 77740 9.701279831440369e-01 -6.005169724464868e+00 -6.028549520737738e+00 3.595423176941391e+00 4.461172768730792e+00 9.304917555972950e+03 + 77760 9.037146612667915e-01 -5.960351562793937e+00 -6.063517714322702e+00 3.869888730442883e+00 4.277492723454358e+00 9.413077780618514e+03 + 77780 9.056387633003206e-01 -6.004177817156937e+00 -6.044579374924515e+00 3.635713005101290e+00 4.403721008279000e+00 9.354414398153249e+03 + 77800 9.894580800366596e-01 -6.154292053483897e+00 -5.977088926144186e+00 2.883779277732085e+00 4.901307057012045e+00 9.146869257715724e+03 + 77820 9.276545718061032e-01 -6.075786898284290e+00 -6.016539776362106e+00 3.297559295049870e+00 4.637765437589540e+00 9.267889982641193e+03 + 77840 9.031435911169059e-01 -6.044319129697051e+00 -6.031435691308593e+00 3.422134257207110e+00 4.496112954139288e+00 9.313822246417190e+03 + 77860 9.304128498381903e-01 -6.083465664409365e+00 -5.983680664859659e+00 3.265807380532507e+00 4.838788289625693e+00 9.167028448351466e+03 + 77880 8.966850248779551e-01 -6.025209185929398e+00 -5.984858124352200e+00 3.605387593113622e+00 4.837089632996497e+00 9.170607331043226e+03 + 77900 9.662730650492308e-01 -6.111241630646713e+00 -5.981737843583330e+00 3.062651850535675e+00 4.806282636499903e+00 9.161086712124938e+03 + 77920 9.124033851557393e-01 -6.007066174020688e+00 -6.007644014182054e+00 3.672637988384815e+00 4.669319940757773e+00 9.240520913100581e+03 + 77940 9.433469773732464e-01 -6.025429101271422e+00 -6.014134140360269e+00 3.552608638110908e+00 4.617466051552298e+00 9.260478697458148e+03 + 77960 9.471660061161816e-01 -6.000295273194393e+00 -6.009031366903246e+00 3.732733950107298e+00 4.682569948124932e+00 9.244740220369367e+03 + 77980 9.583237299776859e-01 -5.985520496793974e+00 -6.026397477118721e+00 3.771325309501922e+00 4.536603362784964e+00 9.298273375083591e+03 + 78000 9.822443607144675e-01 -5.994084185622157e+00 -5.990173665022997e+00 3.747826540653387e+00 4.770281355084866e+00 9.186922753955916e+03 + 78020 1.000549554755738e+00 -5.999050137171565e+00 -5.998020982392176e+00 3.679669405921632e+00 4.685578971926073e+00 9.210978037261983e+03 + 78040 9.825939859159107e-01 -5.953431332958740e+00 -6.023834239652474e+00 3.951961590988343e+00 4.547697205938323e+00 9.290361900106423e+03 + 78060 1.027101771833677e+00 -6.003964232450689e+00 -6.009809411093721e+00 3.711772305892965e+00 4.678208385586207e+00 9.247178785062517e+03 + 78080 1.069617088928239e+00 -6.057174288999921e+00 -5.984238791008398e+00 3.412723163734705e+00 4.831530079933869e+00 9.168735239574766e+03 + 78100 1.032931399494156e+00 -5.997870301633825e+00 -6.010926505817864e+00 3.704233028722928e+00 4.629262283857107e+00 9.250623786278969e+03 + 78120 9.990932970363942e-01 -5.947444446628786e+00 -6.044726018402647e+00 3.915198220830202e+00 4.356592381430115e+00 9.354835443281314e+03 + 78140 9.903117753514266e-01 -5.935960214073454e+00 -5.990173628242962e+00 3.969802758347145e+00 4.658500944687098e+00 9.186925646487325e+03 + 78160 9.977142655170520e-01 -5.947548690932602e+00 -6.019109846805618e+00 3.943205430325067e+00 4.532290199249127e+00 9.275813635654033e+03 + 78180 1.061246196682019e+00 -6.043446506513968e+00 -5.957087236284449e+00 3.473468350913270e+00 4.969356644625044e+00 9.085776701744828e+03 + 78200 1.005371703488933e+00 -5.965038839699390e+00 -5.985410284265660e+00 3.935621546664635e+00 4.818645559494254e+00 9.172289322955903e+03 + 78220 1.044507016004814e+00 -6.028994953498604e+00 -5.992003633241251e+00 3.551231967651003e+00 4.763641852957037e+00 9.192494234607775e+03 + 78240 9.705534101886567e-01 -5.927988745686074e+00 -6.011607544835702e+00 4.122688107526733e+00 4.642536022842219e+00 9.252708209183909e+03 + 78260 1.000624460206580e+00 -5.983489532146212e+00 -6.050778853150732e+00 3.738358953341983e+00 4.351973259145254e+00 9.373581434547184e+03 + 78280 9.557989149634782e-01 -5.932252413917265e+00 -6.011991752438707e+00 4.010915216982305e+00 4.553039595569427e+00 9.253901762299187e+03 + 78300 9.459404437062641e-01 -5.936592057873725e+00 -6.004854765275988e+00 4.025714690587525e+00 4.633739661063895e+00 9.231945453136545e+03 + 78320 1.043106579113228e+00 -6.104206618906877e+00 -5.963148331373988e+00 3.138553134941259e+00 4.948531650654555e+00 9.104274402655548e+03 + 78340 9.947840069746099e-01 -6.066715597726089e+00 -6.001840658093563e+00 3.339124872512799e+00 4.711646815247229e+00 9.222715450411288e+03 + 78360 9.603038667107582e-01 -6.060645831723562e+00 -5.977660942267663e+00 3.373144660514535e+00 4.849656737640450e+00 9.148588666718559e+03 + 78380 9.436095248178937e-01 -6.083643291185696e+00 -6.001451077685974e+00 3.193636310179499e+00 4.665596719298840e+00 9.221491694599892e+03 + 78400 9.101945306451855e-01 -6.073358506023091e+00 -5.936509451354990e+00 3.277651655699111e+00 5.063460104926116e+00 9.023161517878330e+03 + 78420 8.898257787199445e-01 -6.066782905595899e+00 -5.903882661858805e+00 3.393592712056678e+00 5.328991120326318e+00 8.924326605064518e+03 + 78440 8.954246888115581e-01 -6.083877341621532e+00 -5.941981781899617e+00 3.278004437190987e+00 5.092790699381125e+00 9.039778252080689e+03 + 78460 9.481381666289637e-01 -6.159163501861797e+00 -5.981107807106949e+00 2.838263825689257e+00 4.860687179001308e+00 9.159146387911785e+03 + 78480 9.411206466284182e-01 -6.137352341169860e+00 -5.995539940113520e+00 2.984783117544954e+00 4.799091869808599e+00 9.203370689247566e+03 + 78500 9.506610438566124e-01 -6.134377798490855e+00 -5.982160552669639e+00 3.006297720229315e+00 4.880352701277397e+00 9.162388881689225e+03 + 78520 9.226601224909358e-01 -6.070160403870820e+00 -5.969137680224539e+00 3.349089851708784e+00 4.929177964101690e+00 9.122566544115467e+03 + 78540 9.350130673781817e-01 -6.060243460879107e+00 -5.986181655315741e+00 3.399993259964893e+00 4.825267608537110e+00 9.174684621282766e+03 + 78560 9.650144846402954e-01 -6.071696093122321e+00 -6.003266095761548e+00 3.390218422333436e+00 4.783154056686861e+00 9.227077553884892e+03 + 78580 9.604910303162029e-01 -6.034092826172119e+00 -6.024613307196831e+00 3.546322036255746e+00 4.600754901162666e+00 9.292756295738118e+03 + 78600 9.686794808081647e-01 -6.021766343567298e+00 -5.977275716772505e+00 3.589974437310432e+00 4.845446501268380e+00 9.147415168214486e+03 + 78620 9.790638855032975e-01 -6.017079485234357e+00 -5.982659144929070e+00 3.628753021305816e+00 4.826399941869219e+00 9.163881743461079e+03 + 78640 9.635405966946655e-01 -5.977130747501815e+00 -6.025142041184683e+00 3.814290538040150e+00 4.538602259989435e+00 9.294379934463390e+03 + 78660 9.707454470410779e-01 -5.974418552402655e+00 -6.025444292159965e+00 3.828578880147194e+00 4.535581186253014e+00 9.295326545242200e+03 + 78680 9.911583826870468e-01 -5.993693794148694e+00 -6.025621108406230e+00 3.755451121332038e+00 4.572119542129353e+00 9.295859183455761e+03 + 78700 9.986527167138837e-01 -5.997600496545068e+00 -6.009593085558130e+00 3.706881924570941e+00 4.638018622610789e+00 9.246516691242879e+03 + 78720 1.026115132203620e+00 -6.031128199173386e+00 -6.012317781529495e+00 3.498664985632630e+00 4.606677314646578e+00 9.254890630268450e+03 + 78740 9.816313985852830e-01 -5.958218054730507e+00 -6.013528870665908e+00 3.912158523236141e+00 4.594555258813961e+00 9.258643861241966e+03 + 78760 1.033620182847291e+00 -6.031627959023227e+00 -5.956249364553392e+00 3.534786418184695e+00 4.967621972430289e+00 9.083234424136646e+03 + 78780 9.830286204954115e-01 -5.951758298407527e+00 -5.993886409160242e+00 3.988301041459746e+00 4.746394910213591e+00 9.198286235509540e+03 + 78800 1.000258120334726e+00 -5.971249567948878e+00 -6.020768879016869e+00 3.825286689582233e+00 4.540939142341202e+00 9.280907900890526e+03 + 78820 9.864972939353344e-01 -5.946243439661701e+00 -6.017824338783822e+00 3.990878233141380e+00 4.579849633273819e+00 9.271846291834496e+03 + 78840 1.021859006135012e+00 -5.995468529602100e+00 -6.001936475707494e+00 3.747306807373122e+00 4.710166859924521e+00 9.222978263265690e+03 + 78860 9.882568805799498e-01 -5.942577623793076e+00 -6.030864900302477e+00 4.001677853742455e+00 4.494718649613587e+00 9.312017305215872e+03 + 78880 9.771441179677272e-01 -5.925778263224009e+00 -5.997743118022825e+00 4.087553837958024e+00 4.674320505177930e+00 9.210126729893587e+03 + 78900 1.015066568996722e+00 -5.979994330427906e+00 -6.010524750307205e+00 3.763688570078540e+00 4.588378174564395e+00 9.249390491771201e+03 + 78920 1.018739460242896e+00 -5.986789341636689e+00 -6.012039733536547e+00 3.771919862252372e+00 4.626928204477868e+00 9.254033481816645e+03 + 78940 1.004836582510179e+00 -5.969766681587550e+00 -5.989581405251473e+00 3.897587970790249e+00 4.783808761193428e+00 9.185084777862216e+03 + 78960 1.000915367395484e+00 -5.969396837968292e+00 -5.998386169842300e+00 3.863985857272187e+00 4.697524627567022e+00 9.212082208171083e+03 + 78980 1.011097346139345e+00 -5.992593794250812e+00 -5.978853168859705e+00 3.755021533955431e+00 4.833922331306077e+00 9.152231479871780e+03 + 79000 1.059666254547746e+00 -6.075228378317800e+00 -5.949276757245159e+00 3.302772307519212e+00 5.026006006668686e+00 9.062012326248185e+03 + 79020 9.404329904009793e-01 -5.912418498441657e+00 -6.022127545440677e+00 4.200550887308586e+00 4.570584562020053e+00 9.285100828118733e+03 + 79040 9.848581356870563e-01 -5.995749291628560e+00 -5.950319121540778e+00 3.770773996085144e+00 5.031641063025294e+00 9.065157216419613e+03 + 79060 9.608603747923385e-01 -5.975710424122484e+00 -5.991968912277589e+00 3.876364743899228e+00 4.783005988919707e+00 9.192405688069553e+03 + 79080 9.762292981095760e-01 -6.013582321367158e+00 -6.020082158499417e+00 3.624525748921560e+00 4.587202678261587e+00 9.278803852728182e+03 + 79100 9.968077163779366e-01 -6.060067062195587e+00 -5.998288605730000e+00 3.336803585265185e+00 4.691545042475827e+00 9.211816924103132e+03 + 79120 9.529428875274224e-01 -6.010522734970114e+00 -5.974924022157747e+00 3.663670102253345e+00 4.868083420104956e+00 9.140240841576147e+03 + 79140 9.873690817848273e-01 -6.074700664243276e+00 -5.987370156791362e+00 3.244204633224945e+00 4.745669921366193e+00 9.178340289386322e+03 + 79160 9.130881549992070e-01 -5.973833669404494e+00 -6.030780650675930e+00 3.822882500084973e+00 4.495884121107514e+00 9.311779785569635e+03 + 79180 9.130059993031368e-01 -5.982160469712809e+00 -6.049699357839504e+00 3.764013437411514e+00 4.376194690178869e+00 9.370240987068373e+03 + 79200 9.144915391394658e-01 -5.989863774478316e+00 -5.996351292292557e+00 3.783542019016778e+00 4.746289687787270e+00 9.205827462468909e+03 + 79220 9.162392675107899e-01 -5.990783865313929e+00 -6.020396209652485e+00 3.687540813334715e+00 4.517502149647247e+00 9.279754746233712e+03 + 79240 9.235177618171081e-01 -5.993583822311699e+00 -5.991157638784288e+00 3.722027338034579e+00 4.735958859299659e+00 9.189928927008819e+03 + 79260 9.122072343294187e-01 -5.960147639003375e+00 -6.017354682230184e+00 3.939842341817747e+00 4.611350646848075e+00 9.270383322164405e+03 + 79280 9.464530382076917e-01 -5.985066495056913e+00 -6.049603975101954e+00 3.736198910912617e+00 4.365614713351233e+00 9.369966592766663e+03 + 79300 1.058102145576381e+00 -6.118124074882580e+00 -5.985462856214184e+00 3.111493438629915e+00 4.873254685481086e+00 9.172484563610771e+03 + 79320 9.953261731051044e-01 -5.990762207761407e+00 -5.966468802080260e+00 3.791395229966537e+00 4.930891724780066e+00 9.114398898363157e+03 + 79340 9.992972109940355e-01 -5.961723229258709e+00 -5.994031798503905e+00 3.928603952261779e+00 4.743083147920930e+00 9.198725379131081e+03 + 79360 9.926349647139661e-01 -5.915070630550414e+00 -6.011796810038751e+00 4.149267309094780e+00 4.593850618144844e+00 9.253295758662978e+03 + 79380 1.037321676282260e+00 -5.948510655240105e+00 -6.047489058921755e+00 3.947058702396041e+00 4.378709391597541e+00 9.363409109803762e+03 + 79400 1.073554589102331e+00 -5.980993106816110e+00 -6.033464135983314e+00 3.789565228428210e+00 4.488268459084602e+00 9.320063210492326e+03 + 79420 1.016620402774436e+00 -5.886967006135101e+00 -6.020426988457193e+00 4.262292675040978e+00 4.495944803682008e+00 9.279841377628121e+03 + 79440 1.068403542474359e+00 -5.960438953669618e+00 -6.006390438935841e+00 3.868462736741713e+00 4.604602197373694e+00 9.236687061558874e+03 + 79460 9.874269650080266e-01 -5.842593843709981e+00 -6.054890823069911e+00 4.549197988529999e+00 4.330155880193897e+00 9.386302095136112e+03 + 79480 1.017759587682552e+00 -5.894621021086714e+00 -6.033039891771820e+00 4.291344042132524e+00 4.496521466407633e+00 9.318743561586927e+03 + 79500 1.105846470791628e+00 -6.036755426472809e+00 -6.017208669404104e+00 3.517414095775697e+00 4.629654599715089e+00 9.269967576930499e+03 + 79520 1.086894678355959e+00 -6.027120172015224e+00 -6.014100530719969e+00 3.533845370601539e+00 4.608606165701871e+00 9.260404330473939e+03 + 79540 1.049454254284310e+00 -5.994584829837050e+00 -6.011042174487166e+00 3.761334105949868e+00 4.666833486203054e+00 9.250999407055326e+03 + 79560 1.030069716704877e+00 -5.991172669794780e+00 -5.984594332761020e+00 3.763498997698880e+00 4.801272826941096e+00 9.169811743421678e+03 + 79580 1.028925048212893e+00 -6.012828622395782e+00 -5.970669021180692e+00 3.659255478289710e+00 4.901342432643959e+00 9.127210901884571e+03 + 79600 9.944584734349552e-01 -5.980683481626457e+00 -5.960911784614881e+00 3.820979842968632e+00 4.934511986869324e+00 9.097417679516766e+03 + 79620 9.901706812860336e-01 -5.987544470704947e+00 -5.987143215339533e+00 3.781052302697437e+00 4.783356373099715e+00 9.177573862144696e+03 + 79640 9.246167639896486e-01 -5.898438492136320e+00 -5.986236757283998e+00 4.267403810189261e+00 4.763252584973672e+00 9.174811103240676e+03 + 79660 9.916679381978120e-01 -6.000523303854512e+00 -6.022122174521691e+00 3.702740003652233e+00 4.578715945866861e+00 9.285052279835410e+03 + 79680 9.845988297280789e-01 -5.990509847177464e+00 -6.040834177254060e+00 3.730551225574747e+00 4.441581134610021e+00 9.342845329404190e+03 + 79700 1.012103464704459e+00 -6.035439240602013e+00 -6.028021986269549e+00 3.442340611003453e+00 4.484931633196864e+00 9.303278711208271e+03 + 79720 1.015763565165914e+00 -6.044095272153485e+00 -5.993496414538418e+00 3.454193648501328e+00 4.744740119074952e+00 9.197082781862344e+03 + 79740 9.222818700668998e-01 -5.906833461994591e+00 -5.985664802016244e+00 4.229068492670546e+00 4.776406739155771e+00 9.173089251397545e+03 + 79760 9.597870572140947e-01 -5.960718976870643e+00 -5.977189763390419e+00 3.844068322181662e+00 4.749490517139135e+00 9.147165028539104e+03 + 79780 9.522985703267357e-01 -5.945043840197743e+00 -6.033792705183500e+00 3.960293430182864e+00 4.450683713592172e+00 9.321040393839516e+03 + 79800 9.833275714694408e-01 -5.986134330689360e+00 -5.992010910363025e+00 3.788435245758111e+00 4.754691015874160e+00 9.192526612755901e+03 + 79820 9.988231391725373e-01 -6.002387319931682e+00 -6.001299313579232e+00 3.724469615070988e+00 4.730717115915194e+00 9.221015132285953e+03 + 79840 1.024379288003904e+00 -6.033932660189155e+00 -5.992003567042530e+00 3.503221755406675e+00 4.743985096760791e+00 9.192521594308335e+03 + 79860 9.827181494933237e-01 -5.965889220469361e+00 -6.043897883407553e+00 3.844590998537356e+00 4.396653184144686e+00 9.352308119905227e+03 + 79880 9.705938199892743e-01 -5.942608933405355e+00 -6.006729211590787e+00 4.010776237453497e+00 4.642587677531767e+00 9.237720442481392e+03 + 79900 9.989592388664118e-01 -5.981314239385885e+00 -5.930071112743315e+00 3.831441066158048e+00 5.125687029187906e+00 9.003625830083804e+03 + 79920 9.509828765130268e-01 -5.903474650230136e+00 -5.959567595188465e+00 4.199545177000271e+00 4.877450806694363e+00 9.093302296884925e+03 + 79940 1.008660626273198e+00 -5.975206559142093e+00 -5.973249874015888e+00 3.852131261379689e+00 4.863366850170403e+00 9.135085691382848e+03 + 79960 1.034057738351715e+00 -5.993540037212778e+00 -5.981668704255794e+00 3.691299380901082e+00 4.759466411822924e+00 9.160865262674994e+03 + 79980 1.002622890907336e+00 -5.922972181137649e+00 -5.998275900307460e+00 4.077008223773470e+00 4.644602615087531e+00 9.211738305864092e+03 + 80000 1.002534478236392e+00 -5.893540385663340e+00 -6.026169635517707e+00 4.283656440432240e+00 4.522078763458380e+00 9.297540298519638e+03 + 80020 1.094687085530008e+00 -5.993440939835718e+00 -5.989813159942677e+00 3.764577229969778e+00 4.785408503512746e+00 9.185780164415793e+03 + 80040 1.055082100139671e+00 -5.898909722028495e+00 -6.025321495774995e+00 4.219677073728563e+00 4.493801106717396e+00 9.294917553481977e+03 + 80060 1.085583131184937e+00 -5.913580248815832e+00 -5.995051811128758e+00 4.192783551086773e+00 4.724961232602432e+00 9.201841630477857e+03 + 80080 1.090025280436168e+00 -5.894810926655870e+00 -6.034197483346787e+00 4.226381129079512e+00 4.426001950560326e+00 9.322316172175941e+03 + 80100 1.047457605914503e+00 -5.819409458044511e+00 -6.024690075875109e+00 4.691037192552955e+00 4.512284117896722e+00 9.292948853051041e+03 + 80120 1.127652005637097e+00 -5.934003334918287e+00 -6.024570493283049e+00 3.995991733415875e+00 4.475941094862951e+00 9.292604433306064e+03 + 80140 1.104842672427734e+00 -5.909465117880103e+00 -6.032670192464904e+00 4.178638676803430e+00 4.471176072613829e+00 9.317603653038059e+03 + 80160 1.054685386192829e+00 -5.861471499217983e+00 -6.053524088219884e+00 4.431970594065964e+00 4.329174907974951e+00 9.382081453747751e+03 + 80180 1.035297912196663e+00 -5.871013411255056e+00 -6.078486687471992e+00 4.326344205160282e+00 4.135000546736907e+00 9.459568903120788e+03 + 80200 1.039432343452146e+00 -5.928553381094001e+00 -6.067840343920899e+00 3.999433392885801e+00 4.199626097745917e+00 9.426493171449256e+03 + 80220 1.020980129054669e+00 -5.954851935059028e+00 -6.027304359714914e+00 3.984153646438417e+00 4.568120612087840e+00 9.301040824812659e+03 + 80240 1.028248837015344e+00 -6.008051184400480e+00 -5.980029095212903e+00 3.666505959114474e+00 4.827413131633823e+00 9.155839579876905e+03 + 80260 1.016907947689166e+00 -6.019854239883813e+00 -5.957577663570278e+00 3.563580640392458e+00 4.921182378853813e+00 9.087269307231058e+03 + 80280 9.097418901123862e-01 -5.877951742464337e+00 -5.983392699645973e+00 4.328354486090709e+00 4.722896193018360e+00 9.166116685071396e+03 + 80300 1.009663701932018e+00 -6.035852982966083e+00 -5.978466560213853e+00 3.532381221631197e+00 4.861902941594719e+00 9.151061221238029e+03 + 80320 9.285183626925706e-01 -5.921999020192650e+00 -6.002108198353142e+00 4.147670149667457e+00 4.687670851814656e+00 9.223509460299141e+03 + 80340 1.007831994203929e+00 -6.043601103086168e+00 -5.977780352600639e+00 3.517883857678721e+00 4.895836792694848e+00 9.148937113911612e+03 + 80360 9.642957607884645e-01 -5.980897211629611e+00 -5.982532881003374e+00 3.826812674468522e+00 4.817420407805358e+00 9.163417897459703e+03 + 80380 1.033425115073918e+00 -6.081161832987428e+00 -5.944446244238369e+00 3.326901110527948e+00 5.111943177794029e+00 9.047286377227612e+03 + 80400 1.027875708381550e+00 -6.067876130161433e+00 -6.003086441082604e+00 3.353305542149515e+00 4.725337963012134e+00 9.226518691529565e+03 + 80420 9.674887958443071e-01 -5.973286478717758e+00 -6.065208317777971e+00 3.846530442086685e+00 4.318701017344315e+00 9.418279230056989e+03 + 80440 9.998988992298777e-01 -6.018633120308276e+00 -6.011400263835027e+00 3.581905373355749e+00 4.623437554506067e+00 9.252071754397144e+03 + 80460 1.004933198700895e+00 -6.021110434000995e+00 -5.989321590057112e+00 3.588034866536607e+00 4.770571327770085e+00 9.184301942079575e+03 + 80480 9.976532533953327e-01 -6.004673382259777e+00 -6.003060639131224e+00 3.642142665363094e+00 4.651403285978436e+00 9.226408371484842e+03 + 80500 9.798480950375431e-01 -5.971116530358305e+00 -5.945787064917397e+00 3.840649288570114e+00 4.986094998853921e+00 9.051365099854220e+03 + 80520 9.898055193963495e-01 -5.973401523394545e+00 -5.987976996693258e+00 3.878651720367064e+00 4.794957097138647e+00 9.180163957994317e+03 + 80540 1.050801412019621e+00 -6.047657297213751e+00 -6.005025064170906e+00 3.439579529413368e+00 4.684380408862127e+00 9.232475198752469e+03 + 80560 1.041895089673064e+00 -6.018026754737074e+00 -5.973835113844153e+00 3.581206497066169e+00 4.834961737707649e+00 9.136912039481398e+03 + 80580 1.075090983815789e+00 -6.046315556615985e+00 -6.010278416441178e+00 3.464119663737547e+00 4.671050499350711e+00 9.248628756520144e+03 + 80600 1.053159998455167e+00 -5.990768187085731e+00 -6.039041567089806e+00 3.693251331109284e+00 4.416058112844473e+00 9.337289001771140e+03 + 80620 1.007437463709463e+00 -5.902097178535293e+00 -6.006333475673088e+00 4.302016993559189e+00 4.703476044879118e+00 9.236494514575365e+03 + 80640 1.080360867172413e+00 -5.990347910656498e+00 -6.039898798100485e+00 3.762741750211048e+00 4.478212886532621e+00 9.339939250690915e+03 + 80660 1.052821680553730e+00 -5.933423739896924e+00 -6.016158862093036e+00 4.089272539094425e+00 4.614194664225566e+00 9.266743212173586e+03 + 80680 1.114786955517762e+00 -6.013250391362781e+00 -6.018128894662110e+00 3.591361164115531e+00 4.563348043224838e+00 9.272794487838173e+03 + 80700 1.082988455053263e+00 -5.961540066326007e+00 -5.987187476722777e+00 3.908364959159268e+00 4.761093559737082e+00 9.177750320377618e+03 + 80720 1.018898805515524e+00 -5.867717667599978e+00 -6.044793834692135e+00 4.408967022727404e+00 4.392168268835941e+00 9.355061661676011e+03 + 80740 1.078535505632103e+00 -5.965057255115155e+00 -6.041002391506717e+00 3.872766586177249e+00 4.436677860545026e+00 9.343339451356544e+03 + 80760 1.122763021347808e+00 -6.052795303069532e+00 -6.006742519703213e+00 3.378097112029223e+00 4.642539320763824e+00 9.237785587126256e+03 + 80780 1.011186157889471e+00 -5.922607857192942e+00 -6.009155469933456e+00 4.102263689982693e+00 4.605293904426870e+00 9.245164321278171e+03 + 80800 1.012676335665791e+00 -5.969998909856515e+00 -5.969015267058977e+00 3.842727275531674e+00 4.848375504693367e+00 9.122162612919192e+03 + 80820 9.839291033142596e-01 -5.970925365618903e+00 -5.961130671494203e+00 3.896228134556838e+00 4.952470783944881e+00 9.098100625334013e+03 + 80840 9.703262031256962e-01 -5.985669552021039e+00 -6.017795474468260e+00 3.758638467439156e+00 4.574166449276784e+00 9.271758987431505e+03 + 80860 9.860307020865687e-01 -6.039540886349507e+00 -6.017438500335203e+00 3.478093158526607e+00 4.605008479353925e+00 9.270667990367545e+03 + 80880 9.493660487190138e-01 -6.007464672391607e+00 -5.977203752048952e+00 3.667988434541938e+00 4.841751322011753e+00 9.147210070761919e+03 + 80900 9.411803354878033e-01 -6.008670311518920e+00 -6.008303553769675e+00 3.633818434487520e+00 4.635924414239258e+00 9.242557081332734e+03 + 80920 9.562927239983039e-01 -6.040237509250625e+00 -5.986487338932350e+00 3.513190510640249e+00 4.821832306419760e+00 9.175612393213398e+03 + 80940 9.391222144072718e-01 -6.018039973091003e+00 -6.013153616723916e+00 3.651819905722478e+00 4.679878120143496e+00 9.257452384859767e+03 + 80960 9.962900101017992e-01 -6.100773704611004e+00 -5.960896700160498e+00 3.160383928109457e+00 4.963579333560741e+00 9.097409582381813e+03 + 80980 9.497343258144788e-01 -6.023199853090263e+00 -6.021134194005993e+00 3.620213444521876e+00 4.632074778643462e+00 9.282052807849825e+03 + 81000 9.591025418906647e-01 -6.026455855685898e+00 -6.065256481137539e+00 3.524178024527893e+00 4.301378828807182e+00 9.418479539948283e+03 + 81020 1.001990028660329e+00 -6.077534127037405e+00 -6.021240361340688e+00 3.282007639689934e+00 4.605255153752570e+00 9.282388103225949e+03 + 81040 9.966016185348995e-01 -6.055363997114036e+00 -6.013132139043764e+00 3.371627171695458e+00 4.614129036093873e+00 9.257419537291769e+03 + 81060 9.659692754691518e-01 -5.992538068302758e+00 -6.004632470471654e+00 3.750914600299199e+00 4.681466671442708e+00 9.231272701576272e+03 + 81080 9.691829504854111e-01 -5.974490335592261e+00 -6.018024527710942e+00 3.850699258365816e+00 4.600719190325892e+00 9.272470340610080e+03 + 81100 1.003573479230278e+00 -5.998331342676080e+00 -6.028882462700820e+00 3.711859255152203e+00 4.536429996199598e+00 9.305931270102272e+03 + 81120 9.652038612407686e-01 -5.913090084011630e+00 -6.032846986355366e+00 4.162974002716716e+00 4.475311337138238e+00 9.318139945958466e+03 + 81140 9.966998233310604e-01 -5.929979100262118e+00 -5.987371099498042e+00 4.028287233705730e+00 4.698733492709875e+00 9.178316486711472e+03 + 81160 9.804020724797735e-01 -5.869939224845761e+00 -5.998623418088206e+00 4.364546399268137e+00 4.625621847855474e+00 9.212795182111613e+03 + 81180 1.126184741962428e+00 -6.047964278793083e+00 -6.006159092705674e+00 3.398152128404014e+00 4.638203976249550e+00 9.235955440699909e+03 + 81200 9.899612490535551e-01 -5.811348463827199e+00 -6.061800894530588e+00 4.637657909690657e+00 4.199521295203407e+00 9.407730864339252e+03 + 81220 1.151403160611242e+00 -6.022118671138731e+00 -5.980063185279393e+00 3.598535440400098e+00 4.840024548269824e+00 9.155959277935875e+03 + 81240 1.067219841122242e+00 -5.877373726253977e+00 -6.004808208624930e+00 4.409997452595479e+00 4.678248934399053e+00 9.231793070179991e+03 + 81260 1.127695639210377e+00 -5.957308129270547e+00 -6.036038080045511e+00 3.954573383865618e+00 4.502493823095270e+00 9.327982579786789e+03 + 81280 1.103028274947716e+00 -5.923413750088998e+00 -6.033437472139344e+00 4.109392321773495e+00 4.477619083644450e+00 9.319956428209549e+03 + 81300 9.469324782446774e-01 -5.708014671570099e+00 -6.087656680911923e+00 5.312427897099631e+00 4.132464730047806e+00 9.488044984776521e+03 + 81320 1.095960453556355e+00 -5.962941065130249e+00 -5.981563294094487e+00 3.884138894529285e+00 4.777207174036013e+00 9.160555130944156e+03 + 81340 9.871654323815087e-01 -5.864591779611393e+00 -6.010560505658964e+00 4.463085211610327e+00 4.624910198057822e+00 9.249510421422576e+03 + 81360 9.991419644136911e-01 -5.968435540664949e+00 -6.023131166643513e+00 3.841009523089968e+00 4.526938774600286e+00 9.288201209487406e+03 + 81380 9.841981835773045e-01 -6.016394145035136e+00 -6.005892497406464e+00 3.663636985831985e+00 4.723939071640539e+00 9.235149739072316e+03 + 81400 9.377169216155408e-01 -5.984331702590624e+00 -6.009919031453745e+00 3.793692120277228e+00 4.646765718318846e+00 9.247522920451795e+03 + 81420 9.400508964306854e-01 -6.006417987786693e+00 -5.985081075780034e+00 3.660709506883469e+00 4.783229357502169e+00 9.171298836560509e+03 + 81440 9.699313219880838e-01 -6.058502217893892e+00 -5.973919960684958e+00 3.395756690421595e+00 4.881441100377295e+00 9.137162347086463e+03 + 81460 9.952068072926994e-01 -6.098024106266205e+00 -6.025599703083651e+00 3.092386996336173e+00 4.508259127050570e+00 9.295823085602729e+03 + 81480 9.716843809594646e-01 -6.064040414707251e+00 -6.004068320993178e+00 3.331259416743575e+00 4.675628459501291e+00 9.229528876136948e+03 + 81500 9.973697415567517e-01 -6.098995123461590e+00 -5.987990150078407e+00 3.131363910149934e+00 4.768771645280289e+00 9.180221700530825e+03 + 81520 9.363162329557408e-01 -6.000394687731413e+00 -6.010277762884474e+00 3.706335535412770e+00 4.649585388482955e+00 9.248637468922027e+03 + 81540 1.013715851668724e+00 -6.102670727235536e+00 -6.012984549917034e+00 3.116204155939033e+00 4.631196064992952e+00 9.256972066950684e+03 + 81560 9.510302311325567e-01 -5.994672440513835e+00 -6.013574746603648e+00 3.744624109953838e+00 4.636084143263719e+00 9.258771042960105e+03 + 81580 9.708791169434510e-01 -6.004990242564016e+00 -6.041103793930236e+00 3.648293076755405e+00 4.440923476256562e+00 9.343675324845555e+03 + 81600 1.021428169911760e+00 -6.059476600844403e+00 -5.998202382908654e+00 3.359272897199406e+00 4.711118938741055e+00 9.211526895989089e+03 + 81620 9.305148611195859e-01 -5.902648955072580e+00 -6.033518732798856e+00 4.210010048227591e+00 4.458535532490664e+00 9.320215109178078e+03 + 81640 1.014309398886776e+00 -6.003115197292328e+00 -6.029667877865016e+00 3.682157316764738e+00 4.529687715902319e+00 9.308349178024167e+03 + 81660 1.006696638584483e+00 -5.968125765168169e+00 -6.020330951914127e+00 3.912362383898142e+00 4.612592122876308e+00 9.279575894128000e+03 + 81680 1.026034166389092e+00 -5.977191967072605e+00 -6.014982134725362e+00 3.873463389942985e+00 4.656466399271307e+00 9.263076324966902e+03 + 81700 1.094026462459199e+00 -6.060979078274961e+00 -5.950776163987039e+00 3.422521797817875e+00 5.055323985504993e+00 9.066556189874063e+03 + 81720 1.048137457130594e+00 -5.979532805375181e+00 -5.984750120562851e+00 3.845341466656847e+00 4.815382835472327e+00 9.170259136790282e+03 + 81740 1.010877405861114e+00 -5.912420587581036e+00 -6.015239526747630e+00 4.123957872404739e+00 4.533555612530746e+00 9.263857837267307e+03 + 81760 1.063602355671527e+00 -5.981784965975486e+00 -5.961487023376864e+00 3.795656960333152e+00 4.912210887830908e+00 9.099205750929392e+03 + 81780 1.027459067509863e+00 -5.921163145430532e+00 -6.023673648014620e+00 4.058302636557103e+00 4.469671467270263e+00 9.289860839464147e+03 + 81800 1.047298626464901e+00 -5.948950629059860e+00 -5.964630498270545e+00 3.988479046460120e+00 4.898442811000447e+00 9.108806831015394e+03 + 81820 1.053501232817847e+00 -5.960230760917948e+00 -6.041431241123340e+00 3.870567163714580e+00 4.404301440641517e+00 9.344676488532747e+03 + 81840 1.017758804170032e+00 -5.918853993517171e+00 -6.028272775372802e+00 4.135177599842575e+00 4.506878021925773e+00 9.304041707423426e+03 + 81860 1.065378349480214e+00 -6.011029377961174e+00 -5.955644283412063e+00 3.656811158679218e+00 4.974840942395896e+00 9.081369206171317e+03 + 81880 9.530192865981795e-01 -5.874220383036375e+00 -5.969743058835002e+00 4.392900279869866e+00 4.844394293347848e+00 9.124360388499763e+03 + 81900 9.574720746808550e-01 -5.916960493551010e+00 -5.939744405874496e+00 4.072727612640648e+00 4.941898862280157e+00 9.032968447348794e+03 + 81920 9.529318163724900e-01 -5.946802134618535e+00 -5.972181862330102e+00 3.934181160248690e+00 4.788446836228703e+00 9.131801220611655e+03 + 81940 1.019255599760301e+00 -6.079390441300234e+00 -5.946349913216288e+00 3.217190862036480e+00 4.981130162249682e+00 9.053053841282081e+03 + 81960 9.963100258212420e-01 -6.076261456517344e+00 -5.922084484074006e+00 3.267929873460421e+00 5.153237908039445e+00 8.979394036684227e+03 + 81980 9.321940921579160e-01 -6.004237872716229e+00 -5.956115850930159e+00 3.672947579610751e+00 4.949271675565172e+00 9.082785007174825e+03 + 82000 9.259020011273168e-01 -6.008560241790538e+00 -5.979530918034305e+00 3.649740939747136e+00 4.816431809028757e+00 9.154312158358503e+03 + 82020 9.926786283717718e-01 -6.116727747828016e+00 -5.988422832370484e+00 3.059525164023740e+00 4.796271843702390e+00 9.181567362273785e+03 + 82040 9.828871294915399e-01 -6.108037307599804e+00 -5.976347622865276e+00 3.122740172608594e+00 4.878922721267100e+00 9.144587367836979e+03 + 82060 9.332089275121657e-01 -6.035190225336102e+00 -5.973657550289307e+00 3.495536034698211e+00 4.848866176967599e+00 9.136365890371884e+03 + 82080 9.348812100568609e-01 -6.031463456902424e+00 -5.965944501090468e+00 3.558135708621652e+00 4.934355691919547e+00 9.112776588740764e+03 + 82100 9.042623824465174e-01 -5.972021615429910e+00 -6.014946941476416e+00 3.796225191740366e+00 4.549741326908593e+00 9.262985345315630e+03 + 82120 9.440190703979477e-01 -6.010011374202128e+00 -5.988159562051030e+00 3.645149472465161e+00 4.770625959393770e+00 9.180738259821084e+03 + 82140 1.011393339427639e+00 -6.080227709102102e+00 -5.961488893125361e+00 3.243112839117767e+00 4.924929495228602e+00 9.099214545140130e+03 + 82160 1.026503718694735e+00 -6.064944977731278e+00 -5.993468428427674e+00 3.350980699018414e+00 4.761410106079966e+00 9.197008429326948e+03 + 82180 1.006157932273557e+00 -5.990239157559158e+00 -5.970433960016605e+00 3.709373784718790e+00 4.823098293852542e+00 9.126514077081361e+03 + 82200 1.016726882499973e+00 -5.960533970645779e+00 -6.014397243383137e+00 3.912150227734968e+00 4.602858980362544e+00 9.261293779520003e+03 + 82220 9.979775544152479e-01 -5.893027751377255e+00 -6.069221251694980e+00 4.212070857692677e+00 4.200340513012240e+00 9.430757019027582e+03 + 82240 1.054341292935148e+00 -5.952133271901108e+00 -6.028138300356474e+00 3.959034853333704e+00 4.522602218202850e+00 9.303626688837259e+03 + 82260 1.086997289403144e+00 -5.988753152456590e+00 -6.013076335256356e+00 3.770394539776795e+00 4.630727060140167e+00 9.257241533574917e+03 + 82280 9.930301270538908e-01 -5.849295966728095e+00 -6.014262164276999e+00 4.557997760641574e+00 4.610736325879201e+00 9.260862944527180e+03 + 82300 1.052704167888893e+00 -5.941650218359268e+00 -6.061094917913366e+00 3.918227059446591e+00 4.232357110599438e+00 9.405546981787807e+03 + 82320 1.035475766103420e+00 -5.925586028161403e+00 -6.009739267844735e+00 4.106886085685982e+00 4.623665160752541e+00 9.246951713316425e+03 + 82340 1.059930091496441e+00 -5.973064455901590e+00 -5.982995502455424e+00 3.844160028408986e+00 4.787134422272385e+00 9.164905895347836e+03 + 82360 1.055375561443872e+00 -5.980016403835411e+00 -5.994561134237355e+00 3.790468925824066e+00 4.706950833066347e+00 9.200351231154134e+03 + 82380 1.021943690518623e+00 -5.945473845969684e+00 -5.998256626271318e+00 4.009937131181599e+00 4.706850238580766e+00 9.211672906131917e+03 + 82400 1.060955343739208e+00 -6.020882436619464e+00 -6.015629788290397e+00 3.532014829274395e+00 4.562176348824597e+00 9.265117486401068e+03 + 82420 1.025085119426230e+00 -5.990890568948218e+00 -6.030370186696810e+00 3.745718874076666e+00 4.519020799513146e+00 9.310516771307657e+03 + 82440 1.034160948772676e+00 -6.030455026508863e+00 -5.984256441678343e+00 3.507182693757268e+00 4.772462117062009e+00 9.168786953885985e+03 + 82460 9.669831020702148e-01 -5.955570659970894e+00 -6.024859108725444e+00 3.907088469367947e+00 4.509223474266530e+00 9.293502499893486e+03 + 82480 9.677544578647109e-01 -5.979622822096868e+00 -5.987621114589913e+00 3.824472741134358e+00 4.778545307907529e+00 9.179071304884421e+03 + 82500 1.000624017605016e+00 -6.047706445230441e+00 -6.003804533381391e+00 3.475564904079214e+00 4.727656475715362e+00 9.228739162402349e+03 + 82520 9.834867481801457e-01 -6.039855188751357e+00 -6.010631886338153e+00 3.568915395297044e+00 4.736720120045091e+00 9.249713937781315e+03 + 82540 9.200750851948417e-01 -5.960130077415306e+00 -6.058719697671354e+00 3.875622144634004e+00 4.309505288429348e+00 9.398189475973371e+03 + 82560 1.015142155413174e+00 -6.113233090351068e+00 -6.014244303187169e+00 3.095668895392885e+00 4.664077829753301e+00 9.260848481965104e+03 + 82580 9.651283856148998e-01 -6.050630456495955e+00 -5.994736860064145e+00 3.459877045518359e+00 4.780826725735905e+00 9.200931563201901e+03 + 82600 9.343478073029360e-01 -6.013896740798929e+00 -5.996300339084693e+00 3.679259350695470e+00 4.780300612372982e+00 9.205716424906679e+03 + 82620 9.805046819622550e-01 -6.086987815585871e+00 -5.998250725993623e+00 3.235972956523999e+00 4.745515056982916e+00 9.211669040801013e+03 + 82640 9.579135776566627e-01 -6.052322091838229e+00 -5.975536083805047e+00 3.455128158427278e+00 4.896045299150146e+00 9.142100696801939e+03 + 82660 9.217363216217590e-01 -5.991623039091014e+00 -6.014127404238494e+00 3.720654568638975e+00 4.591431021422895e+00 9.260445479676475e+03 + 82680 9.200823190905971e-01 -5.973331691857776e+00 -6.012939503868029e+00 3.843812133394743e+00 4.616377947542769e+00 9.256821354123618e+03 + 82700 9.181080846874173e-01 -5.940608261060464e+00 -6.046039584483639e+00 3.992827268280853e+00 4.387424293740414e+00 9.358905391108510e+03 + 82720 9.550676461486908e-01 -5.954477499278572e+00 -6.027071500783741e+00 3.859329371181869e+00 4.442483380653761e+00 9.300322958644376e+03 + 82740 1.051212191232689e+00 -6.043816203611694e+00 -5.964240093459852e+00 3.451319988211083e+00 4.908258327066211e+00 9.107607716343658e+03 + 82760 1.080527458671875e+00 -6.034858787241326e+00 -5.975857016935064e+00 3.514908116887699e+00 4.853705412480707e+00 9.143094409974112e+03 + 82780 1.065867721802160e+00 -5.972207196800955e+00 -6.000939279506110e+00 3.884414564356550e+00 4.719430499188123e+00 9.219905982670060e+03 + 82800 1.052523272866169e+00 -5.926939223415161e+00 -6.010736142715393e+00 4.111207548600879e+00 4.630032670447594e+00 9.250034565973976e+03 + 82820 9.790761495021265e-01 -5.805091854200137e+00 -6.030112461776572e+00 4.713968435861663e+00 4.421865285331293e+00 9.309675124563544e+03 + 82840 1.072317842162483e+00 -5.938347373547508e+00 -6.028438988758931e+00 3.966622329384520e+00 4.449302333208129e+00 9.304549295530356e+03 + 82860 1.098032465784719e+00 -5.976847204493138e+00 -6.029621297466610e+00 3.779956291351105e+00 4.476919282732938e+00 9.308214571702654e+03 + 82880 1.031168314826700e+00 -5.888127731024447e+00 -6.045441663690371e+00 4.329926914296673e+00 4.426605968676536e+00 9.357056401387648e+03 + 82900 1.098124145072300e+00 -6.005107938762134e+00 -6.018898281185869e+00 3.641413284292229e+00 4.562227004046543e+00 9.275154118266630e+03 + 82920 9.772339319791201e-01 -5.849137279902993e+00 -6.099097626583569e+00 4.479894784466588e+00 4.044583792588084e+00 9.523744104256293e+03 + 82940 1.016284127512851e+00 -5.935190976043092e+00 -6.003945305268794e+00 4.088658300341645e+00 4.693860302229603e+00 9.229136237507797e+03 + 82960 1.011590184554013e+00 -5.956104559287598e+00 -6.010599615589779e+00 3.983519312527072e+00 4.670600266157239e+00 9.249577881850169e+03 + 82980 1.019635523430355e+00 -5.994231561974869e+00 -5.977817061969596e+00 3.742812197757780e+00 4.837066796923726e+00 9.149068327652612e+03 + 83000 1.023163973459624e+00 -6.023851710258988e+00 -5.986938804452557e+00 3.553207797951957e+00 4.765167415346193e+00 9.176996183295178e+03 + 83020 1.016000058486344e+00 -6.032735539924692e+00 -5.980069571500186e+00 3.548795249512327e+00 4.851211390238117e+00 9.155959861413776e+03 + 83040 1.055286889144455e+00 -6.109420291545003e+00 -5.921842426374081e+00 3.189105314991783e+00 5.266206444384043e+00 8.978685859894013e+03 + 83060 9.921693802123008e-01 -6.027804127261330e+00 -5.966662590909072e+00 3.562322375169651e+00 4.913406538526488e+00 9.114991642283796e+03 + 83080 1.004513599239578e+00 -6.052576113504093e+00 -5.996800757401754e+00 3.390180146647830e+00 4.710450872595926e+00 9.207238259038486e+03 + 83100 1.011557073208864e+00 -6.067817175105558e+00 -5.996800231397925e+00 3.368347004177421e+00 4.776137284783172e+00 9.207212391906281e+03 + 83120 9.863542858744674e-01 -6.033382933104475e+00 -6.005643490935316e+00 3.491556726831327e+00 4.650840896431443e+00 9.234389091230565e+03 + 83140 1.007968701325409e+00 -6.066710845416040e+00 -6.018792916473425e+00 3.334907248560115e+00 4.610059411824151e+00 9.274810667852491e+03 + 83160 9.454306578277356e-01 -5.973902273167461e+00 -6.008122113649366e+00 3.813481212058842e+00 4.616985592508549e+00 9.242003424773871e+03 + 83180 9.393345218205708e-01 -5.960205312923350e+00 -6.000875430014376e+00 3.915380123803668e+00 4.681846017786715e+00 9.219733949563484e+03 + 83200 9.342837444881428e-01 -5.946678756006410e+00 -6.027762128251698e+00 3.970178004178680e+00 4.504584733134928e+00 9.302459913196921e+03 + 83220 1.002391371332529e+00 -6.039827216977188e+00 -5.982543935289373e+00 3.459256465148587e+00 4.788185933159212e+00 9.163541719853587e+03 + 83240 1.042012832966301e+00 -6.089270615827140e+00 -5.979625027698048e+00 3.233279526021895e+00 4.862881460659072e+00 9.154618413327004e+03 + 83260 9.411776881371352e-01 -5.931121394763776e+00 -5.980408474344442e+00 4.103359056679516e+00 4.820345018576424e+00 9.156992998395635e+03 + 83280 9.990019456534729e-01 -6.008486604331204e+00 -5.984935470351600e+00 3.691009907367030e+00 4.826244163204120e+00 9.170828149950803e+03 + 83300 1.005890894000541e+00 -6.007282532360395e+00 -5.971430991704674e+00 3.725489229634081e+00 4.931354324087215e+00 9.129560756978364e+03 + 83320 1.066331977764432e+00 -6.085778020151919e+00 -5.991899075653709e+00 3.214392996351001e+00 4.753460423379432e+00 9.192204775181423e+03 + 83340 9.952108255693745e-01 -5.971132132138619e+00 -5.992297216404512e+00 3.867050504723726e+00 4.745517315582766e+00 9.193421084102025e+03 + 83360 1.042637261523889e+00 -6.031738320200724e+00 -6.023409425351056e+00 3.550699589797229e+00 4.598525392916340e+00 9.289055074179605e+03 + 83380 1.057991142794505e+00 -6.049273279768072e+00 -6.004321316473352e+00 3.433493109904442e+00 4.691614239436566e+00 9.230317634534364e+03 + 83400 1.018374480229375e+00 -5.989304615874483e+00 -6.010388803782011e+00 3.745965744666484e+00 4.624897074933922e+00 9.248958329614681e+03 + 83420 1.017310267047913e+00 -5.988250806869074e+00 -5.985475692732642e+00 3.770572628824862e+00 4.786507763643774e+00 9.172502599298221e+03 + 83440 1.027109972170316e+00 -6.001867248164055e+00 -6.011046661930910e+00 3.681527723586982e+00 4.628818109228011e+00 9.250997838884088e+03 + 83460 1.051378757212570e+00 -6.039581557052643e+00 -6.004920153848638e+00 3.475280814825332e+00 4.674311955857540e+00 9.232172353426446e+03 + 83480 1.003196982796949e+00 -5.975153730610701e+00 -6.025299069025753e+00 3.822340404142767e+00 4.534398110997499e+00 9.294866215746399e+03 + 83500 1.044714500666520e+00 -6.054451207779666e+00 -5.996335515637911e+00 3.430023114122890e+00 4.763732411775136e+00 9.205818174827999e+03 + 83520 1.077244992578740e+00 -6.141394613836490e+00 -5.971603169493544e+00 2.959526222010450e+00 4.934494970568743e+00 9.130103626703087e+03 + 83540 9.443193519269766e-01 -5.996530282640169e+00 -6.013393366789217e+00 3.710071782779368e+00 4.613241344041700e+00 9.258209558317174e+03 + 83560 9.637349492046307e-01 -6.073843518410907e+00 -5.987380354605710e+00 3.285744638178265e+00 4.782229504879066e+00 9.178359718067331e+03 + 83580 9.009769571844768e-01 -6.020391476635952e+00 -6.019930309946843e+00 3.594460742609467e+00 4.597108833103647e+00 9.278359375037706e+03 + 83600 9.362952394413917e-01 -6.101206490490265e+00 -5.995722657667994e+00 3.145523041026657e+00 4.751227532662513e+00 9.203954581620897e+03 + 83620 9.772607442320609e-01 -6.181099077707755e+00 -5.994311150428404e+00 2.679607572364967e+00 4.752172756141329e+00 9.199618930151602e+03 + 83640 9.052637071157447e-01 -6.084731056994480e+00 -6.021283084808514e+00 3.203229992996955e+00 4.567558067830731e+00 9.282515849714093e+03 + 83660 9.006043932541995e-01 -6.080552089727663e+00 -6.018655969396368e+00 3.209331188755729e+00 4.564748290091693e+00 9.274404754380226e+03 + 83680 8.703930845953498e-01 -6.028773389407351e+00 -5.973023351381444e+00 3.567052815358150e+00 4.887178160993410e+00 9.134417272587318e+03 + 83700 9.577399392663924e-01 -6.140307512277412e+00 -5.968476502973881e+00 2.944683077317322e+00 4.931363323500948e+00 9.120527731315104e+03 + 83720 8.831280135331040e-01 -6.001309658417304e+00 -6.009969226355889e+00 3.682968565989415e+00 4.633243986822256e+00 9.247684530130793e+03 + 83740 9.531656179047132e-01 -6.073126105727603e+00 -6.006790616660993e+00 3.269659579265585e+00 4.650568222869818e+00 9.237913325525917e+03 + 83760 8.797505208143744e-01 -5.924426616752845e+00 -6.041538566203128e+00 4.080016935084467e+00 4.407541998325336e+00 9.345008750229359e+03 + 83780 1.013551321721806e+00 -6.084710376592703e+00 -5.988673597310109e+00 3.246928741110128e+00 4.798386789394345e+00 9.182330317288212e+03 + 83800 1.031117109386899e+00 -6.077189895226326e+00 -5.966029469213874e+00 3.311457058011087e+00 4.949757426194918e+00 9.113059764357653e+03 + 83820 9.811642691953243e-01 -5.973857743013602e+00 -5.988433291407279e+00 3.991437404386761e+00 4.907742349951446e+00 9.181561063983538e+03 + 83840 1.050232721456639e+00 -6.050901051881089e+00 -5.999304702367316e+00 3.382241723433187e+00 4.678515946850557e+00 9.214922009461579e+03 + 83860 1.010195364143056e+00 -5.971661184227782e+00 -5.943191608387906e+00 3.914866705025556e+00 5.078343415150748e+00 9.043465534167453e+03 + 83880 9.538048805608106e-01 -5.870380964658287e+00 -5.998328815644672e+00 4.390128391842755e+00 4.655432031612981e+00 9.211830439570662e+03 + 83900 1.015885132620475e+00 -5.944072892922219e+00 -6.017772079576145e+00 4.005174485742621e+00 4.581982351063504e+00 9.271649891609259e+03 + 83920 1.016023662818928e+00 -5.930076541973777e+00 -6.027069700576364e+00 4.118073208854836e+00 4.561123482515995e+00 9.300324817719189e+03 + 83940 1.039503947318992e+00 -5.955498356897070e+00 -6.054604100984171e+00 3.900409478553727e+00 4.331328959441261e+00 9.385442103957863e+03 + 83960 1.038232833167707e+00 -5.950559270931944e+00 -6.044912979057866e+00 4.040488743171514e+00 4.498695149923322e+00 9.355428090045247e+03 + 83980 9.459637991559319e-01 -5.817938875060586e+00 -6.020034548504183e+00 4.752457378126773e+00 4.591992747009246e+00 9.278628862728083e+03 + 84000 1.044124099682572e+00 -5.968659686960271e+00 -5.988741296764168e+00 3.847945948209775e+00 4.732634237096727e+00 9.182497869539066e+03 + 84020 1.052900947778804e+00 -5.991777500751278e+00 -6.004736396169752e+00 3.732311191466001e+00 4.657899208590540e+00 9.231599472620073e+03 + 84040 1.041928028819528e+00 -5.991492437231734e+00 -6.008704682744217e+00 3.740494417065642e+00 4.641659039746582e+00 9.243778197803338e+03 + 84060 1.042197713597477e+00 -6.015339685702970e+00 -5.984052268796393e+00 3.648425681569691e+00 4.828082871159376e+00 9.168144833581171e+03 + 84080 1.066729856049291e+00 -6.081450282889223e+00 -5.945523706999144e+00 3.234044370047186e+00 5.014555803377659e+00 9.050572208489319e+03 + 84100 9.982259380287439e-01 -6.014882571121378e+00 -5.974107139991982e+00 3.602711728459995e+00 4.836850563982563e+00 9.137727878943129e+03 + 84120 9.448923410865665e-01 -5.972379532932701e+00 -5.989138828381384e+00 3.839895137866479e+00 4.743660669907554e+00 9.183727452094992e+03 + 84140 9.834104122094413e-01 -6.062426887293068e+00 -5.968164133748138e+00 3.344068581450542e+00 4.885339899419499e+00 9.119600243128642e+03 + 84160 9.095635405466753e-01 -5.982046139309189e+00 -5.999992770010598e+00 3.760782766289582e+00 4.657730435569961e+00 9.217021453836081e+03 + 84180 9.666085130773859e-01 -6.085678223529118e+00 -5.957397718021419e+00 3.191539357357197e+00 4.928145871326480e+00 9.086736328410279e+03 + 84200 9.464513493500615e-01 -6.065433228178954e+00 -6.001150705023589e+00 3.341372417380562e+00 4.710492613026974e+00 9.220580627138466e+03 + 84220 9.800516048780994e-01 -6.120607680203458e+00 -6.004264079963592e+00 3.005523860737963e+00 4.673586817429220e+00 9.230162459015934e+03 + 84240 9.289433720816179e-01 -6.045720553875345e+00 -6.028380469387901e+00 3.443839296417994e+00 4.543408744914300e+00 9.304378039546980e+03 + 84260 9.860583349935106e-01 -6.125634006899578e+00 -5.991917688615159e+00 3.034294978923614e+00 4.802114771046123e+00 9.192262534093094e+03 + 84280 9.073210128866678e-01 -5.997739524517145e+00 -6.017181394584211e+00 3.675309212069344e+00 4.563670985524579e+00 9.269891668550816e+03 + 84300 9.743929590715711e-01 -6.082687870102610e+00 -5.981973134090258e+00 3.228653608495410e+00 4.806973208233365e+00 9.161806008165528e+03 + 84320 9.754984196399766e-01 -6.066959956529859e+00 -5.967490305824530e+00 3.341352453611830e+00 4.912522580840527e+00 9.117522788400578e+03 + 84340 9.519406145280928e-01 -6.011329084296095e+00 -5.958945150292056e+00 3.590538752256505e+00 4.891335407695284e+00 9.091449115848001e+03 + 84360 9.651181222089166e-01 -6.006911624190101e+00 -5.970954610796798e+00 3.688776937776117e+00 4.895247673010303e+00 9.128078885046772e+03 + 84380 9.373409626689938e-01 -5.944748563312649e+00 -5.938225668163006e+00 4.054846991663009e+00 5.092302465027020e+00 9.028363585984651e+03 + 84400 1.020056721533188e+00 -6.049251329340729e+00 -5.941041383981572e+00 3.496917318620134e+00 5.118275570307337e+00 9.036913376694534e+03 + 84420 1.003408769926105e+00 -6.011559886117978e+00 -5.967688806283824e+00 3.602451668128482e+00 4.854366197563854e+00 9.118104258315914e+03 + 84440 9.913041937059999e-01 -5.986896237484064e+00 -5.953260754871947e+00 3.790751793382264e+00 4.983891939615158e+00 9.074109789574955e+03 + 84460 9.714101737203035e-01 -5.950882426715223e+00 -6.000859377619379e+00 3.944623712257990e+00 4.657648326258173e+00 9.219619022614919e+03 + 84480 1.020137501536982e+00 -6.014688026667517e+00 -5.969415646555902e+00 3.611765675167401e+00 4.871726687646472e+00 9.123387585673048e+03 + 84500 1.031487898943804e+00 -6.023431488993948e+00 -6.002623245240948e+00 3.549268746153614e+00 4.668752901848653e+00 9.225125904188435e+03 + 84520 1.046821732652058e+00 -6.042233900540487e+00 -6.020495834466696e+00 3.480752709445125e+00 4.605576048795684e+00 9.280100578965830e+03 + 84540 1.019533214941164e+00 -6.001118874361193e+00 -6.024406615751128e+00 3.755172941156812e+00 4.621451126329473e+00 9.292146504990120e+03 + 84560 1.018640993004492e+00 -6.002831281599828e+00 -6.041591622223049e+00 3.651070735209070e+00 4.428502861207212e+00 9.345182786381194e+03 + 84580 9.754619855741278e-01 -5.945244836785481e+00 -6.012388175608156e+00 3.972182215164664e+00 4.586634773246757e+00 9.255101355404604e+03 + 84600 1.002049560804454e+00 -5.991087759816677e+00 -5.972072535687470e+00 3.794279430770098e+00 4.903467790316428e+00 9.131498755425549e+03 + 84620 1.035211422633986e+00 -6.045299705420483e+00 -5.970901632780364e+00 3.466387896293617e+00 4.893593142457715e+00 9.127932787214615e+03 + 84640 9.838960174773487e-01 -5.973468080658742e+00 -6.007830685813532e+00 3.873711984124071e+00 4.676396587729306e+00 9.241101994889386e+03 + 84660 1.020746036897684e+00 -6.036249570059355e+00 -5.988475601127885e+00 3.502796904106389e+00 4.777122426708695e+00 9.181699222024667e+03 + 84680 1.023018153678763e+00 -6.048426279762470e+00 -5.977496932890238e+00 3.446938111040121e+00 4.854225397061434e+00 9.148100893217461e+03 + 84700 9.904069332703888e-01 -6.007655891348171e+00 -6.002840717553000e+00 3.633221535120394e+00 4.660871008198001e+00 9.225744906943140e+03 + 84720 9.617155027752946e-01 -5.973091286248380e+00 -6.000808069082042e+00 3.869925908743951e+00 4.710771852554776e+00 9.219531236639490e+03 + 84740 9.598283987216493e-01 -5.977827886871006e+00 -6.030861355932215e+00 3.815862638277824e+00 4.511336252025549e+00 9.312013517548472e+03 + 84760 9.615179546135877e-01 -5.989041580333941e+00 -6.025692883563925e+00 3.768835685142471e+00 4.558378230225061e+00 9.296079875414351e+03 + 84780 9.724046706631891e-01 -6.014804468887688e+00 -5.988749381817067e+00 3.635526031260907e+00 4.785138373232112e+00 9.182538300734232e+03 + 84800 9.630556102420048e-01 -6.008490732540599e+00 -5.958568304109759e+00 3.717109533490069e+00 5.003771843010785e+00 9.090284924025902e+03 + 84820 9.501450460427124e-01 -5.994837512649916e+00 -5.970548095419467e+00 3.681650617658569e+00 4.821124210170973e+00 9.126877019010688e+03 + 84840 9.750808570589353e-01 -6.034732821054461e+00 -5.982594454947055e+00 3.487911229140004e+00 4.787297795714806e+00 9.163696483298034e+03 + 84860 1.003224300854488e+00 -6.073971138159021e+00 -6.007559356044354e+00 3.304845433194199e+00 4.686192163286689e+00 9.240291228220258e+03 + 84880 9.415768848847114e-01 -5.978121839821540e+00 -6.033156719796853e+00 3.809719854572960e+00 4.493701057134563e+00 9.319121708864039e+03 + 84900 1.002542084280613e+00 -6.062354800836006e+00 -5.973331665704523e+00 3.365948221893009e+00 4.877132840103628e+00 9.135358283086322e+03 + 84920 9.967964468740868e-01 -6.040431996604574e+00 -6.024712492098899e+00 3.472293773255735e+00 4.562557600712777e+00 9.293070555238517e+03 + 84940 1.042009006475382e+00 -6.089374775488833e+00 -5.998485012112412e+00 3.225584497145897e+00 4.747487583598735e+00 9.212416335689999e+03 + 84960 1.009334758208098e+00 -6.021989401121097e+00 -5.997574557246512e+00 3.601332674488382e+00 4.741526486201126e+00 9.209608060746627e+03 + 84980 1.023695923169529e+00 -6.022045823157714e+00 -6.003702242423251e+00 3.640920935104671e+00 4.746252614341903e+00 9.228406397020610e+03 + 85000 1.025140912498226e+00 -5.999955955395373e+00 -6.020272276305761e+00 3.679439771025399e+00 4.562780312417458e+00 9.279342530925025e+03 + 85020 1.049712888297047e+00 -6.010990260513758e+00 -5.956083120001693e+00 3.658764256778189e+00 4.974049554450998e+00 9.082714322792730e+03 + 85040 1.067135619630734e+00 -6.011190660371485e+00 -5.995963073788410e+00 3.620165959911706e+00 4.707605118533129e+00 9.204649320427958e+03 + 85060 1.012621018824054e+00 -5.906377789020186e+00 -6.033194662985345e+00 4.236217825365406e+00 4.508015710209645e+00 9.319229849520594e+03 + 85080 1.104965638185645e+00 -6.025952377511055e+00 -5.976892676815587e+00 3.619815308300068e+00 4.901523701657590e+00 9.146239782585486e+03 + 85100 1.060883339490869e+00 -5.948439435383001e+00 -6.019719638032241e+00 3.989908804460604e+00 4.580606850272961e+00 9.277662045214192e+03 + 85120 1.035198419222132e+00 -5.903572998782171e+00 -6.022849069339911e+00 4.238961621501373e+00 4.554059966446572e+00 9.287319441961199e+03 + 85140 1.032766570409841e+00 -5.900207756610824e+00 -6.006161071934569e+00 4.189036326252777e+00 4.580635993441278e+00 9.235964851776045e+03 + 85160 1.052683898234607e+00 -5.936734167712669e+00 -5.992964626821974e+00 4.003200295560973e+00 4.680316297719922e+00 9.195427776924500e+03 + 85180 1.091730497749301e+00 -6.010240723096389e+00 -5.931040345789839e+00 3.633061587378881e+00 5.087842410091875e+00 9.006542663415106e+03 + 85200 1.055200692173876e+00 -5.976761496284578e+00 -5.963131092901229e+00 3.795400663511414e+00 4.873668549036712e+00 9.104203219031710e+03 + 85220 1.010380908542570e+00 -5.942364520394688e+00 -5.972134188675652e+00 4.046681755258039e+00 4.875739713147467e+00 9.131684424548157e+03 + 85240 1.071649187169908e+00 -6.074593223984648e+00 -5.972715346927812e+00 3.301747754828176e+00 4.886746290439052e+00 9.133462533412825e+03 + 85260 9.645271463270677e-01 -5.963756905951239e+00 -6.055130311922111e+00 3.892955126126217e+00 4.368274889052595e+00 9.387050770149219e+03 + 85280 9.896218866744900e-01 -6.049590660161531e+00 -5.998434917740892e+00 3.467730597829813e+00 4.761474787134678e+00 9.212258717266024e+03 + 85300 1.006119761154299e+00 -6.110714910396021e+00 -5.972453228622769e+00 3.132003830221241e+00 4.925923802889367e+00 9.132692242370897e+03 + 85320 9.389083554610906e-01 -6.035453817879366e+00 -6.004132074974864e+00 3.521667167096321e+00 4.701521461878023e+00 9.229750433269321e+03 + 85340 8.956827525166451e-01 -5.984655961640948e+00 -6.020333936415890e+00 3.800464353862167e+00 4.595595901555702e+00 9.279555921767676e+03 + 85360 9.489316750843187e-01 -6.068485379590001e+00 -5.979942201982908e+00 3.386120897797123e+00 4.894549525629506e+00 9.155574508034588e+03 + 85380 9.962593595932140e-01 -6.136364321397270e+00 -5.973247534300667e+00 2.995963334877548e+00 4.932605168627466e+00 9.135114569067833e+03 + 85400 9.328451405234977e-01 -6.034995650636074e+00 -6.003847464600062e+00 3.555352609039218e+00 4.734210313424210e+00 9.228880306235573e+03 + 85420 9.696502842013216e-01 -6.078410000828127e+00 -6.007029707833505e+00 3.295217757528854e+00 4.705094445968615e+00 9.238645017716421e+03 + 85440 9.845809272958985e-01 -6.085882474075352e+00 -5.993161494531241e+00 3.254615494841687e+00 4.787033707909188e+00 9.196069507275037e+03 + 85460 9.604913012346068e-01 -6.034448168213229e+00 -5.951056897729219e+00 3.485515878661954e+00 4.964361458538540e+00 9.067406415323030e+03 + 85480 9.557087458850798e-01 -6.006609898883384e+00 -5.905626942143614e+00 3.667026396830642e+00 5.246886161492450e+00 8.929592283779679e+03 + 85500 9.421055707656014e-01 -5.959262167360376e+00 -5.929225056995897e+00 3.932459240536193e+00 5.104936976476843e+00 9.001048728066760e+03 + 85520 1.019604941482433e+00 -6.042820253677595e+00 -6.002059056219830e+00 3.454414884012872e+00 4.688471987590283e+00 9.223379967143777e+03 + 85540 1.014193874497937e+00 -6.006067629265862e+00 -6.070236675219164e+00 3.630793647086720e+00 4.262325055095096e+00 9.433934585922538e+03 + 85560 1.028025490372003e+00 -6.008609398803022e+00 -6.029598052943678e+00 3.669944842189591e+00 4.549424742130214e+00 9.308143003113220e+03 + 85580 9.874908934521838e-01 -5.936238344228870e+00 -6.038742798213747e+00 4.010856097041822e+00 4.422259659747666e+00 9.336358056314652e+03 + 85600 1.040852649233886e+00 -6.008479617579724e+00 -5.972247036818793e+00 3.690993492327545e+00 4.899046578030561e+00 9.132026284578316e+03 + 85620 1.024907171199845e+00 -5.979310040853572e+00 -6.002295214845894e+00 3.778022026422577e+00 4.646037600414482e+00 9.224082682806866e+03 + 85640 1.011182903426163e+00 -5.956420915668329e+00 -6.001986740408489e+00 3.927416129065548e+00 4.665770112118965e+00 9.223165949602258e+03 + 85660 1.031805407933575e+00 -5.987980010423803e+00 -6.010811535849584e+00 3.759740034334038e+00 4.628637882172065e+00 9.250264045216632e+03 + 85680 1.065570521660756e+00 -6.041648266922348e+00 -5.952726324152756e+00 3.579438794110779e+00 5.090042350119948e+00 9.072499499002621e+03 + 85700 9.899735219045209e-01 -5.933528699249290e+00 -6.061000975066772e+00 4.030008283618877e+00 4.298042749603970e+00 9.405274915404152e+03 + 85720 1.010790626029513e+00 -5.972076795808787e+00 -6.027043519367846e+00 3.877412986491084e+00 4.561785553741992e+00 9.300253781256333e+03 + 85740 1.012140737560350e+00 -5.982476189801347e+00 -6.021064981656902e+00 3.820558123610719e+00 4.598975309179880e+00 9.281813653763733e+03 + 85760 9.904063765070888e-01 -5.961796574243785e+00 -6.002646527748602e+00 3.902286166860453e+00 4.667719412325920e+00 9.225170823336512e+03 + 85780 9.654416174899025e-01 -5.936139244387406e+00 -6.012030456101350e+00 3.970270996268574e+00 4.534491914480053e+00 9.254023754082400e+03 + 85800 9.220834415892797e-01 -5.879272726113687e+00 -5.999549110366408e+00 4.383723352312729e+00 4.693077741223300e+00 9.215654979503835e+03 + 85820 1.070137575664450e+00 -6.102577013871278e+00 -5.976284734301817e+00 3.120766173941174e+00 4.845955986896117e+00 9.144398814460979e+03 + 85840 1.039410271348715e+00 -6.063000622900189e+00 -6.022926925285347e+00 3.350537430565623e+00 4.580646803654711e+00 9.287560566625649e+03 + 85860 9.788127798733348e-01 -5.981833084669034e+00 -5.969571903376481e+00 3.823396779730797e+00 4.893802380124312e+00 9.123870549459747e+03 + 85880 9.445548474732267e-01 -5.937066231269744e+00 -5.984159618135680e+00 4.039127215112964e+00 4.768709700050688e+00 9.168496594687653e+03 + 85900 9.737440479807421e-01 -5.982473623396023e+00 -6.010519044792919e+00 3.722693431703459e+00 4.561652282027547e+00 9.249370515332750e+03 + 85920 1.021098086207686e+00 -6.053817750533587e+00 -5.981599629422113e+00 3.437064163333184e+00 4.851751790473392e+00 9.160653100599147e+03 + 85940 1.014101077044705e+00 -6.043965310085871e+00 -5.979253873910154e+00 3.459206481764523e+00 4.830789562347872e+00 9.153472697978115e+03 + 85960 9.653543937438015e-01 -5.972749768217161e+00 -5.951829561621254e+00 3.894478438630314e+00 5.014605502295517e+00 9.069767749689345e+03 + 85980 9.574381067900577e-01 -5.958453921377498e+00 -6.028546605264420e+00 3.858587416397727e+00 4.456104378711245e+00 9.304891494146275e+03 + 86000 1.049607449972652e+00 -6.088781783659104e+00 -5.970646440578390e+00 3.227502122724974e+00 4.905853544079688e+00 9.127158456076246e+03 + 86020 9.664643232313821e-01 -5.953129026560147e+00 -5.986792823865769e+00 3.929057446115663e+00 4.735754712530985e+00 9.176542953694781e+03 + 86040 9.737164578932404e-01 -5.946233524655065e+00 -5.984588270478945e+00 3.950261783719589e+00 4.730022897821133e+00 9.169790870680776e+03 + 86060 1.012026336580907e+00 -5.978600059532317e+00 -6.048111007508549e+00 3.837907466328589e+00 4.438764846264628e+00 9.365333401235195e+03 + 86080 9.614888213375391e-01 -5.879777112101827e+00 -6.059722044321640e+00 4.321875243686666e+00 4.288603596492240e+00 9.401286284634536e+03 + 86100 1.006086240972491e+00 -5.926691814202258e+00 -5.992325996576662e+00 4.149981481201238e+00 4.773099849150509e+00 9.193480796803986e+03 + 86120 1.078132187567753e+00 -6.015223000881882e+00 -5.997832116495305e+00 3.617854860790825e+00 4.717716010169214e+00 9.210389864857209e+03 + 86140 1.021442794089578e+00 -5.917290608909196e+00 -6.037396235921623e+00 4.151922307165769e+00 4.462257210574708e+00 9.332201326015384e+03 + 86160 9.454245755677048e-01 -5.795884868436961e+00 -6.021780464842474e+00 4.842451556420145e+00 4.545324084629121e+00 9.283988169030357e+03 + 86180 1.058461500597337e+00 -5.957750064064178e+00 -5.994366665517806e+00 3.911745399718176e+00 4.701487207770680e+00 9.199749779982867e+03 + 86200 1.072211055472916e+00 -5.974644985227602e+00 -5.988087095502099e+00 3.831255205840026e+00 4.754068528484029e+00 9.180507254636017e+03 + 86220 1.061638477029515e+00 -5.960799568384579e+00 -5.993626499145146e+00 3.913926078811438e+00 4.725428762433149e+00 9.197508460806974e+03 + 86240 1.032320568444570e+00 -5.925957504938902e+00 -6.051849832343381e+00 4.090314847967745e+00 4.367421622236524e+00 9.376898420064575e+03 + 86260 1.108259509434101e+00 -6.056484675227417e+00 -5.992360021826116e+00 3.411004846243407e+00 4.779218529331725e+00 9.193613960170289e+03 + 86280 1.021868733516462e+00 -5.955217786226994e+00 -5.987948739349999e+00 3.977296704056950e+00 4.789350506126027e+00 9.180079343736648e+03 + 86300 9.804512159896710e-01 -5.925052994469805e+00 -6.008775912370965e+00 4.038306642545137e+00 4.557556691877008e+00 9.244003430848863e+03 + 86320 9.241534768425457e-01 -5.871063897013840e+00 -5.990498170249738e+00 4.343584653330950e+00 4.657774574016370e+00 9.187863991624641e+03 + 86340 9.898099109054631e-01 -5.993045067327929e+00 -5.906021391233983e+00 3.776234304280840e+00 5.275937719282632e+00 8.930755367665701e+03 + 86360 1.021950021320191e+00 -6.059180130695131e+00 -5.954950281281357e+00 3.413359977032663e+00 5.011863901883626e+00 9.079251950406753e+03 + 86380 9.936442162250293e-01 -6.034597453780576e+00 -5.997221210832190e+00 3.494103046937694e+00 4.708723217902229e+00 9.208525477463329e+03 + 86400 1.008499978027216e+00 -6.073886892019775e+00 -5.963373455668958e+00 3.397043258812694e+00 5.031628512238090e+00 9.104946038093700e+03 + 86420 1.000279607226334e+00 -6.077294341502080e+00 -5.995031486714201e+00 3.290620589906557e+00 4.762986632234193e+00 9.201812692322279e+03 + 86440 9.794215144218869e-01 -6.058146975212030e+00 -5.959582488651546e+00 3.442922385467994e+00 5.008894920103296e+00 9.093381390998034e+03 + 86460 1.002932650655497e+00 -6.100818261849855e+00 -5.967026064770546e+00 3.153494188968733e+00 4.921749688873712e+00 9.116087090705820e+03 + 86480 9.629298035610349e-01 -6.045336114006879e+00 -5.951805452026864e+00 3.493550690552838e+00 5.030618225465251e+00 9.069690537198843e+03 + 86500 9.570375941095383e-01 -6.036345044848684e+00 -5.986533015759589e+00 3.519175459306585e+00 4.805203838722755e+00 9.175735959337488e+03 + 86520 9.626350413571247e-01 -6.038376526649987e+00 -5.971117939646562e+00 3.506602722656396e+00 4.892811937462765e+00 9.128592448150932e+03 + 86540 9.175111776165882e-01 -5.957332650679302e+00 -6.010531402453550e+00 3.903168818296687e+00 4.597693353128721e+00 9.249399731695861e+03 + 86560 9.770515861888720e-01 -6.019579585926222e+00 -5.984871680511342e+00 3.623325635954485e+00 4.822623799877727e+00 9.170650703304313e+03 + 86580 9.666516101448205e-01 -5.963561513317231e+00 -6.029356782415494e+00 3.837813692709877e+00 4.460007075762661e+00 9.307379059293407e+03 + 86600 1.029541239450564e+00 -6.007569271796314e+00 -6.008807891315628e+00 3.625485319348004e+00 4.618372974392349e+00 9.244124238329729e+03 + 86620 1.045315166900856e+00 -5.979538962150380e+00 -5.975697300780869e+00 3.790437690607364e+00 4.812497104686276e+00 9.142607326290525e+03 + 86640 1.045462029899829e+00 -5.938813153908774e+00 -5.987636283807338e+00 4.070424991811309e+00 4.790075024578822e+00 9.179128910916364e+03 + 86660 1.100561383914405e+00 -5.990658734931927e+00 -6.002933530515918e+00 3.737389462362055e+00 4.666905686600296e+00 9.226053008397457e+03 + 86680 1.079488701503597e+00 -5.944112847658735e+00 -5.980500234702088e+00 4.001716477871843e+00 4.792774470538962e+00 9.157266642784129e+03 + 86700 1.091377158890260e+00 -5.954328628779661e+00 -6.001016509314276e+00 3.985236457106538e+00 4.717147422150613e+00 9.220130598473295e+03 + 86720 1.101927305951296e+00 -5.972063416625788e+00 -5.996942550687863e+00 3.843991072690577e+00 4.701131234872586e+00 9.207646121847187e+03 + 86740 1.010636652455776e+00 -5.845479198419683e+00 -6.029712371932505e+00 4.511548740372252e+00 4.453653348070167e+00 9.308476878288988e+03 + 86760 1.124883505593846e+00 -6.029743008157395e+00 -5.991335758575483e+00 3.545875825976158e+00 4.766416196578159e+00 9.190456048938011e+03 + 86780 1.089272446289295e+00 -5.997865796936573e+00 -5.991497067631965e+00 3.690918344941565e+00 4.727488574166301e+00 9.190954458965760e+03 + 86800 1.031320727733791e+00 -5.936358794310585e+00 -5.986188020113010e+00 4.050301650343911e+00 4.764174524738611e+00 9.174695850197331e+03 + 86820 1.061310228842444e+00 -6.007039566209550e+00 -6.011056160916388e+00 3.698208964473271e+00 4.675145056100587e+00 9.251014079436603e+03 + 86840 1.065573659251426e+00 -6.040117381307926e+00 -6.009398719742183e+00 3.480312793345074e+00 4.656704101753083e+00 9.245935885557396e+03 + 86860 9.906169701874008e-01 -5.954873783224105e+00 -6.040596049146923e+00 3.884937499517226e+00 4.392706983110630e+00 9.342091046219573e+03 + 86880 9.901194360364229e-01 -5.976593417966445e+00 -6.006475509797045e+00 3.830706183226233e+00 4.659118587696157e+00 9.236940345642724e+03 + 86900 9.694155181104880e-01 -5.963982091147281e+00 -6.042801586461973e+00 3.840354349493828e+00 4.387760610119388e+00 9.348900138720595e+03 + 86920 1.033607645485485e+00 -6.072309055213420e+00 -5.964350765453144e+00 3.279706431496943e+00 4.899619637791798e+00 9.107927154594216e+03 + 86940 9.620740932282194e-01 -5.974751949279804e+00 -6.035081216024483e+00 3.830865653458031e+00 4.484445667886233e+00 9.325056783270584e+03 + 86960 9.416335866062691e-01 -5.951783973841451e+00 -6.029139200939296e+00 3.909959362541208e+00 4.465773677862678e+00 9.306715163426219e+03 + 86980 9.701089384768642e-01 -5.999077669360892e+00 -5.947056653483918e+00 3.765773978459433e+00 5.064486701851212e+00 9.055225778731905e+03 + 87000 9.855619610342466e-01 -6.019691399706589e+00 -6.004490368333856e+00 3.544888743815253e+00 4.632175418309485e+00 9.230828260867109e+03 + 87020 1.005485939356948e+00 -6.047004482314472e+00 -6.012380032943681e+00 3.407014552845204e+00 4.605833499248513e+00 9.255101230564464e+03 + 87040 1.039726136701127e+00 -6.095161728692049e+00 -5.996835567097877e+00 3.177476284794248e+00 4.742080320592313e+00 9.207357841458339e+03 + 87060 9.755812494814868e-01 -5.998025713819947e+00 -6.022057220825758e+00 3.743346821483694e+00 4.605354189392642e+00 9.284881777742274e+03 + 87080 9.792420814155268e-01 -6.001043776553102e+00 -5.999147876883485e+00 3.735377393884364e+00 4.746263943176833e+00 9.214427588133245e+03 + 87100 9.904919284402425e-01 -6.012260377392130e+00 -6.030762468384287e+00 3.599849744411870e+00 4.493607874745583e+00 9.311732994139586e+03 + 87120 1.041108729138819e+00 -6.080648079593712e+00 -5.981778648740228e+00 3.321345598510230e+00 4.889069170465914e+00 9.161207031126265e+03 + 87140 9.810266546063025e-01 -5.985687539429438e+00 -5.996855063460988e+00 3.789247228782733e+00 4.725121577624812e+00 9.207395473165701e+03 + 87160 9.931645839218823e-01 -5.995391755850245e+00 -5.994532894029733e+00 3.745209416249917e+00 4.750141133731734e+00 9.200279096150816e+03 + 87180 1.068191719899646e+00 -6.095121342896608e+00 -5.980627637323411e+00 3.223872951299079e+00 4.881313526544050e+00 9.157682438958793e+03 + 87200 9.994240349550974e-01 -5.978840889165111e+00 -6.020966468576994e+00 3.792681771969165e+00 4.550790176073789e+00 9.281509867105569e+03 + 87220 1.098737715105727e+00 -6.106746793709878e+00 -5.962989220209625e+00 3.104856646321728e+00 4.930334879772781e+00 9.103791555250842e+03 + 87240 9.743929238433158e-01 -5.892419633538895e+00 -6.010108546930813e+00 4.212734593004964e+00 4.536946640008084e+00 9.248111057241251e+03 + 87260 1.038437066214709e+00 -5.948009171828121e+00 -5.988197886474595e+00 3.973706614635315e+00 4.742936795951763e+00 9.180836330114249e+03 + 87280 1.064394453455502e+00 -5.940301750498324e+00 -5.949848393868467e+00 4.028481973630079e+00 4.973663670060429e+00 9.063726152523703e+03 + 87300 1.028235289934293e+00 -5.840730104757843e+00 -5.994919789682199e+00 4.546754944196573e+00 4.661373912584294e+00 9.201454321528790e+03 + 87320 1.098003489934703e+00 -5.907483809124360e+00 -6.020323829785401e+00 4.162056543786532e+00 4.514111683214074e+00 9.279530292132480e+03 + 87340 1.080052091478396e+00 -5.855498171808327e+00 -6.033360433663347e+00 4.492065304109422e+00 4.470752672441827e+00 9.319722545344102e+03 + 87360 1.185718450684636e+00 -6.002139578696011e+00 -6.019521086397042e+00 3.671483005864709e+00 4.571675698865770e+00 9.277075954316944e+03 + 87380 1.063307304000342e+00 -5.826077583394437e+00 -6.057293218445481e+00 4.619163086853419e+00 4.291487129886442e+00 9.393769948680909e+03 + 87400 1.081903271360594e+00 -5.872278225676268e+00 -6.019615857297940e+00 4.405142834480008e+00 4.559107353283564e+00 9.277352556664273e+03 + 87420 1.120687733459538e+00 -5.958239705478081e+00 -5.994854031909878e+00 3.920234768618709e+00 4.709989640198625e+00 9.201252316864273e+03 + 87440 9.767452828527707e-01 -5.781613256669887e+00 -6.019205540418785e+00 4.829090045962376e+00 4.464798385389123e+00 9.276091055960769e+03 + 87460 1.070604057053881e+00 -5.956096229281000e+00 -6.029554651441989e+00 3.937340669661768e+00 4.515531041959276e+00 9.307984310503936e+03 + 87480 1.102766890945027e+00 -6.046210863513027e+00 -6.072432351709704e+00 3.376049544134260e+00 4.225481701146757e+00 9.440766512635804e+03 + 87500 9.883364426916296e-01 -5.917984939155740e+00 -6.029586460660076e+00 4.142253199794916e+00 4.501419993037389e+00 9.308088700449496e+03 + 87520 9.938560467008314e-01 -5.954078828453053e+00 -5.987654196659008e+00 3.969777936395116e+00 4.776982976385079e+00 9.179175457162126e+03 + 87540 9.376810252954405e-01 -5.887932442066313e+00 -6.018722535776892e+00 4.312225571698859e+00 4.561208613911128e+00 9.274584473413728e+03 + 87560 1.017023053619591e+00 -6.018156731617259e+00 -5.979626679807117e+00 3.626699874397654e+00 4.847945394397738e+00 9.154593214481638e+03 + 87580 1.019763415254892e+00 -6.033072714343209e+00 -5.987097340342457e+00 3.517090772471723e+00 4.781088484650179e+00 9.177486946972494e+03 + 87600 1.032086922016970e+00 -6.058684871303665e+00 -6.017422183484295e+00 3.371250864776802e+00 4.608187603615930e+00 9.270623469580598e+03 + 87620 1.002342363372543e+00 -6.023471787098549e+00 -5.997285444219530e+00 3.590650654545577e+00 4.741016687680368e+00 9.208717875422559e+03 + 87640 1.023962130146442e+00 -6.063929588694057e+00 -5.925244715467689e+00 3.351974914765064e+00 5.148324918245644e+00 8.988985179842024e+03 + 87660 9.426849686415408e-01 -5.948347946413624e+00 -6.001302881486541e+00 3.905273612678665e+00 4.601198180740253e+00 9.221051861000869e+03 + 87680 9.433837386567213e-01 -5.951943417717841e+00 -6.016854088222513e+00 3.912226514076841e+00 4.539499399145216e+00 9.268845382637981e+03 + 87700 9.185573441488417e-01 -5.913795476897024e+00 -6.043812973900074e+00 4.127400763832975e+00 4.380820175898820e+00 9.352017293361330e+03 + 87720 1.031470006786479e+00 -6.077512849350993e+00 -5.983044609121443e+00 3.303667542685393e+00 4.846118796996401e+00 9.165084951606474e+03 + 87740 1.037918622998474e+00 -6.081382304309732e+00 -6.009196926877458e+00 3.303577783777720e+00 4.718077391644893e+00 9.245309982033919e+03 + 87760 1.010216182808845e+00 -6.035345614092986e+00 -5.990411564475682e+00 3.553906144771418e+00 4.811924411195684e+00 9.187648314248903e+03 + 87780 9.779723079411894e-01 -5.981910070564151e+00 -6.051590255827199e+00 3.747961289976455e+00 4.347846883222214e+00 9.376094615194474e+03 + 87800 1.009509693008653e+00 -6.021485364816083e+00 -6.016770220846404e+00 3.562507971338724e+00 4.589583057678799e+00 9.268597185588011e+03 + 87820 9.892667139631877e-01 -5.981174884315873e+00 -6.010436422154455e+00 3.781236207480657e+00 4.613211929003173e+00 9.249114869479732e+03 + 87840 1.046847128148843e+00 -6.053118776592689e+00 -5.954233536767850e+00 3.471197381918711e+00 5.039011731434345e+00 9.077066255642838e+03 + 87860 9.554116842456905e-01 -5.900291638628477e+00 -5.976976944554920e+00 4.249125050266577e+00 4.808786156624206e+00 9.146492175127405e+03 + 87880 1.021292379501556e+00 -5.975558685841905e+00 -5.968274048262773e+00 3.844138159175177e+00 4.885967675448578e+00 9.119906901895449e+03 + 87900 9.931899925782079e-01 -5.901975386050038e+00 -6.036688532120677e+00 4.160212852955652e+00 4.386669121426063e+00 9.330005841505406e+03 + 87920 1.068627480747506e+00 -5.983152613730168e+00 -6.000545590900871e+00 3.739534938425708e+00 4.639661771957011e+00 9.218731577408797e+03 + 87940 1.114107330683832e+00 -6.021331162173616e+00 -6.033623673311300e+00 3.544902430903551e+00 4.474316929691023e+00 9.320581398431421e+03 + 87960 1.068641053150055e+00 -5.934209407403129e+00 -6.063956398092085e+00 3.975188954558745e+00 4.230161655740845e+00 9.414458746494622e+03 + 87980 9.920919027925906e-01 -5.811175323922484e+00 -6.030926052399545e+00 4.727728494132732e+00 4.465885804902118e+00 9.312227350342862e+03 + 88000 1.139653846797910e+00 -6.024430322470007e+00 -6.003582190481590e+00 3.533435979572522e+00 4.653149179688009e+00 9.228058754477084e+03 + 88020 1.099798586894049e+00 -5.968770280846300e+00 -6.036249714995082e+00 3.830739501407201e+00 4.443262148116212e+00 9.328654220145472e+03 + 88040 1.031265553988053e+00 -5.882369938773733e+00 -6.045400733301227e+00 4.324068950080375e+00 4.387920898969591e+00 9.356928446633203e+03 + 88060 1.064556472837362e+00 -5.958011326533017e+00 -6.012031120525530e+00 3.941483465228973e+00 4.631293448587855e+00 9.254002161774555e+03 + 88080 9.691622757832288e-01 -5.852962011133539e+00 -6.008082256169258e+00 4.509637178497927e+00 4.618912726722493e+00 9.241822905599580e+03 + 88100 1.068956313778761e+00 -6.040563795665296e+00 -5.996583107147465e+00 3.476196025534931e+00 4.728739944993866e+00 9.206550326267476e+03 + 88120 9.843913416396393e-01 -5.958877028924325e+00 -6.001830467747716e+00 3.951279225237192e+00 4.704633932490104e+00 9.222671059649711e+03 + 88140 1.023673236249217e+00 -6.056961313113266e+00 -6.015596247436732e+00 3.339324472804074e+00 4.576849081141959e+00 9.265004402417928e+03 + 88160 1.000611996918333e+00 -6.054272032854122e+00 -6.003210546148085e+00 3.418476418171049e+00 4.711679376576646e+00 9.226921910229847e+03 + 88180 1.005192078222208e+00 -6.082931932148595e+00 -5.996273338815759e+00 3.253389392578082e+00 4.750996445869205e+00 9.205632529962299e+03 + 88200 9.290167058131290e-01 -5.984326471723317e+00 -6.025331007420515e+00 3.789934055945123e+00 4.554479666540418e+00 9.294979668216942e+03 + 88220 9.516883114789758e-01 -6.024310540507553e+00 -5.985529208890915e+00 3.620027486724467e+00 4.842715894258875e+00 9.172681859169972e+03 + 88240 1.004731276240237e+00 -6.103927875696463e+00 -5.960152297704725e+00 3.199853742711092e+00 5.025435360738438e+00 9.095136135566852e+03 + 88260 9.926659864236113e-01 -6.083874822827923e+00 -5.955601421906887e+00 3.294438292642492e+00 5.031004010975719e+00 9.081256927125814e+03 + 88280 9.757146796055489e-01 -6.050976490782602e+00 -5.990455724417666e+00 3.481783780075792e+00 4.829303386101582e+00 9.187790603997033e+03 + 88300 1.026599206131546e+00 -6.117088138839598e+00 -5.984150311818936e+00 3.087092223047155e+00 4.850441797862045e+00 9.168465012924249e+03 + 88320 9.959500379792751e-01 -6.060990303142972e+00 -5.998702628992168e+00 3.390136974862183e+00 4.747802438822522e+00 9.213053506853699e+03 + 88340 9.639005829310554e-01 -6.000639961912147e+00 -5.965334124934460e+00 3.679700110413886e+00 4.882431689900384e+00 9.110940801666005e+03 + 88360 1.009830494772786e+00 -6.052774510706263e+00 -5.942327239497365e+00 3.440913413539031e+00 5.075118736480508e+00 9.040836079821560e+03 + 88380 9.827677703557557e-01 -5.993533953794765e+00 -5.971616027217805e+00 3.790131661989318e+00 4.915987788182400e+00 9.130081092429949e+03 + 88400 9.863357831186433e-01 -5.975837626961129e+00 -6.010935044182528e+00 3.817298597453188e+00 4.615763796460151e+00 9.250601590483288e+03 + 88420 1.022797964711116e+00 -6.006055753257874e+00 -5.997366337242936e+00 3.642044837386653e+00 4.691940808827208e+00 9.208977758041070e+03 + 88440 1.007852546971939e+00 -5.961457412479761e+00 -6.000293729544374e+00 3.905157834698996e+00 4.682153692213344e+00 9.217945343884627e+03 + 88460 1.019827198428751e+00 -5.957575321813730e+00 -6.038928189285718e+00 3.902388237329301e+00 4.435247482989591e+00 9.336928144021371e+03 + 88480 1.058705366067213e+00 -5.999991422110526e+00 -6.024070413822935e+00 3.658403073639277e+00 4.520137777014702e+00 9.291086559473364e+03 + 88500 1.042467963243668e+00 -5.964207420497758e+00 -6.004658095810543e+00 3.936646522889638e+00 4.704372485521856e+00 9.231337218298673e+03 + 88520 1.000216310004870e+00 -5.893245992925927e+00 -6.019794635804672e+00 4.310346785086947e+00 4.583684894337995e+00 9.277912297486433e+03 + 88540 1.004953437088703e+00 -5.896657235885146e+00 -5.982405215851580e+00 4.268208600259834e+00 4.775830429835557e+00 9.163083255767737e+03 + 88560 1.017868746837943e+00 -5.912969661958693e+00 -6.003055934958522e+00 4.089558590356763e+00 4.572269269986053e+00 9.226394643453426e+03 + 88580 1.063780659232309e+00 -5.980526076687880e+00 -6.003406252424225e+00 3.789026426926977e+00 4.657644917153135e+00 9.227496002644621e+03 + 88600 1.063418887084190e+00 -5.987045572887839e+00 -5.970365549923864e+00 3.786583357795255e+00 4.882362630879610e+00 9.126279642283471e+03 + 88620 1.008944119140215e+00 -5.922928897714257e+00 -6.021480587715984e+00 4.104738273557393e+00 4.538839218742739e+00 9.283080719681378e+03 + 88640 1.014436237957769e+00 -5.961145123957735e+00 -6.004874781617540e+00 3.905986048301517e+00 4.654883586876270e+00 9.232017428194307e+03 + 88660 1.007816616794463e+00 -5.990051130913432e+00 -6.049334925917770e+00 3.725452327060121e+00 4.385035602007585e+00 9.369121240741029e+03 + 88680 9.777241883307218e-01 -5.991275058641246e+00 -6.040175301174655e+00 3.764189909588552e+00 4.483397149673642e+00 9.340785058066474e+03 + 88700 9.402566822340124e-01 -5.977178516934332e+00 -6.012945559554204e+00 3.783207958404343e+00 4.577828064749084e+00 9.256828284157484e+03 + 88720 9.859510970306447e-01 -6.078175361036213e+00 -5.985134229105450e+00 3.289483005838663e+00 4.823739583453742e+00 9.171485906471011e+03 + 88740 9.566750592182246e-01 -6.059619503565356e+00 -5.992136120332607e+00 3.373206981932115e+00 4.760707011474365e+00 9.192929250897309e+03 + 88760 9.723846578848524e-01 -6.100243381561183e+00 -5.951331892050180e+00 3.185785050337162e+00 5.040857867087871e+00 9.068248654009667e+03 + 88780 9.160547825553692e-01 -6.025572161004696e+00 -6.007835598763481e+00 3.553212663278649e+00 4.655058748391839e+00 9.241124041917183e+03 + 88800 9.221373066194983e-01 -6.038905601691775e+00 -5.994649950149300e+00 3.447324582133140e+00 4.701447381829974e+00 9.200632548380030e+03 + 88820 9.111602895749087e-01 -6.020279644544123e+00 -5.958841671222450e+00 3.580397026685465e+00 4.933183376994158e+00 9.091132652581084e+03 + 88840 9.447638986200360e-01 -6.058593425096966e+00 -5.994782291110129e+00 3.378675813222752e+00 4.745089219316242e+00 9.201038928100284e+03 + 88860 9.621686963095208e-01 -6.064128128103943e+00 -6.014130305647388e+00 3.335945203949383e+00 4.623040437632944e+00 9.260500710913224e+03 + 88880 9.533823188433425e-01 -6.027700071112174e+00 -6.027061638903783e+00 3.501365879886273e+00 4.505031856423924e+00 9.300306325463851e+03 + 88900 9.286886453447538e-01 -5.963797874565456e+00 -6.052421764986242e+00 3.847848663223206e+00 4.338956569924334e+00 9.378672666080338e+03 + 88920 1.034486605810206e+00 -6.089522673173873e+00 -5.981180124712253e+00 3.241089021467134e+00 4.863208700688945e+00 9.159377028948153e+03 + 88940 9.333694007430071e-01 -5.906685620385778e+00 -6.030761515455120e+00 4.155092290708149e+00 4.442629300537283e+00 9.311732770428722e+03 + 88960 9.745406744811306e-01 -5.938845615109351e+00 -6.023616845535398e+00 3.991823776115460e+00 4.505054252703586e+00 9.289702653666138e+03 + 88980 1.050847995976898e+00 -6.026019748515243e+00 -5.992268658872719e+00 3.544165345897158e+00 4.737969325588778e+00 9.193351144761345e+03 + 89000 1.091194783546845e+00 -6.066317379388865e+00 -6.022715600296324e+00 3.326744669633388e+00 4.577112832536262e+00 9.286915208787890e+03 + 89020 1.025376651790601e+00 -5.954878706941137e+00 -6.050664857611599e+00 3.897675955486730e+00 4.347657055478027e+00 9.373238364876617e+03 + 89040 1.034449329454733e+00 -5.961296604181987e+00 -6.041612576074671e+00 3.901733917022659e+00 4.440547177558386e+00 9.345238011718004e+03 + 89060 1.053578683597306e+00 -5.987497930043870e+00 -6.052186399747031e+00 3.789913535366977e+00 4.418462331823090e+00 9.377969444520131e+03 + 89080 1.088609789857573e+00 -6.045277679408265e+00 -6.025607809505185e+00 3.445110472132076e+00 4.558057909018097e+00 9.295827633899828e+03 + 89100 1.014354804333683e+00 -5.945907708767368e+00 -6.014663476287125e+00 4.006140856863784e+00 4.611334599844701e+00 9.262104208138006e+03 + 89120 1.030694599901340e+00 -5.982662575084519e+00 -6.002558161612559e+00 3.814919183720523e+00 4.700675647044454e+00 9.224927327084970e+03 + 89140 1.035832615351562e+00 -6.005389610471985e+00 -6.034598283850535e+00 3.655099512101111e+00 4.487378789533881e+00 9.323577518700882e+03 + 89160 1.001223666780861e+00 -5.973648013701814e+00 -6.032037621218685e+00 3.863076059522212e+00 4.527793897397774e+00 9.315679349590542e+03 + 89180 1.056301502242269e+00 -6.080082903675033e+00 -5.996317896797932e+00 3.237679397896343e+00 4.718671029977575e+00 9.205740963457252e+03 + 89200 9.864695799530404e-01 -5.999553203051855e+00 -5.985478091748534e+00 3.738917793248354e+00 4.819739260468461e+00 9.172507528271042e+03 + 89220 9.958121220599762e-01 -6.035595086620949e+00 -5.972789306695220e+00 3.537320578977160e+00 4.897961086473729e+00 9.133686886392228e+03 + 89240 9.827534786273694e-01 -6.035374447653136e+00 -6.006733957232120e+00 3.452195106410916e+00 4.616653234509961e+00 9.237726656988443e+03 + 89260 9.978457561454224e-01 -6.076252793848736e+00 -5.991876712304973e+00 3.328246636640744e+00 4.812747154021453e+00 9.192135934996903e+03 + 89280 1.000984539935491e+00 -6.096722040792721e+00 -5.973346934586663e+00 3.209902927235905e+00 4.918341879307075e+00 9.135434092226424e+03 + 89300 9.726734108396369e-01 -6.070787689172133e+00 -6.003298867146075e+00 3.380896828786059e+00 4.768428088721139e+00 9.227175045275522e+03 + 89320 8.980039786302488e-01 -5.977982402640011e+00 -6.022857905124383e+00 3.794791837880529e+00 4.537109758153703e+00 9.287364668066552e+03 + 89340 9.124569275158166e-01 -6.021610000751577e+00 -6.036857196918711e+00 3.613821791664993e+00 4.526270031777330e+00 9.330547199884744e+03 + 89360 9.505677002071273e-01 -6.112980829208274e+00 -5.981023367613975e+00 3.097143086269987e+00 4.854863251095637e+00 9.158919754334762e+03 + 89380 8.835754802828850e-01 -6.056607432459284e+00 -6.014480142209756e+00 3.380851226184566e+00 4.622752645974453e+00 9.261565619570036e+03 + 89400 9.311868182314267e-01 -6.173113810427619e+00 -5.995850449778006e+00 2.766860893841996e+00 4.784734542108479e+00 9.204341308670015e+03 + 89420 8.926379618709972e-01 -6.153158704387931e+00 -5.989113241486306e+00 2.878928678228287e+00 4.820903112162757e+00 9.183688275647113e+03 + 89440 9.034645844263177e-01 -6.192378040816404e+00 -5.997189083601254e+00 2.639125139623150e+00 4.759930337346049e+00 9.208442968366977e+03 + 89460 8.078497650344366e-01 -6.058995853015265e+00 -5.994436374700137e+00 3.447855430633417e+00 4.818565945665863e+00 9.199990477736916e+03 + 89480 8.687383238017418e-01 -6.144804281244188e+00 -6.039771105992886e+00 2.886279527615725e+00 4.489396273740045e+00 9.339557377746825e+03 + 89500 8.795539161275706e-01 -6.144799908121779e+00 -6.031580123276200e+00 2.907787985399958e+00 4.557913510688357e+00 9.314277348924295e+03 + 89520 9.185742895547041e-01 -6.175384874103182e+00 -6.012872513468366e+00 2.818457024166792e+00 4.751628147638439e+00 9.256632176442701e+03 + 89540 9.121185615716081e-01 -6.128205981132044e+00 -5.995234885741868e+00 3.047687698266629e+00 4.811228305207531e+00 9.202447682877231e+03 + 89560 8.981567693419910e-01 -6.068285652204358e+00 -5.969624632481840e+00 3.401116792165927e+00 4.967643635156085e+00 9.124028324578945e+03 + 89580 9.538965925454703e-01 -6.109192300880643e+00 -5.957562741751687e+00 3.124704680412757e+00 4.995385073529663e+00 9.087243591682311e+03 + 89600 9.568076348206799e-01 -6.076694532985515e+00 -5.979774505956331e+00 3.268471076937542e+00 4.825000870464826e+00 9.155067673702104e+03 + 89620 9.344364078527727e-01 -6.010450810794744e+00 -6.023962651303363e+00 3.673601463054395e+00 4.596014383903341e+00 9.290749255004304e+03 + 89640 9.559476826108811e-01 -6.015844585295693e+00 -6.015841893130399e+00 3.602388068989919e+00 4.602403527819650e+00 9.265744535080750e+03 + 89660 9.432722675544823e-01 -5.972968778008971e+00 -6.031571561291647e+00 3.862701284047002e+00 4.526195033686472e+00 9.314198168393923e+03 + 89680 1.038452115999587e+00 -6.092947996748592e+00 -5.976524512955755e+00 3.248131947402253e+00 4.916653607816615e+00 9.145122645292628e+03 + 89700 9.364344226334796e-01 -5.922435376029928e+00 -6.009280198302424e+00 4.106082184308841e+00 4.607405775627362e+00 9.245541273794595e+03 + 89720 1.020321246207636e+00 -6.026909758922693e+00 -6.005567733635488e+00 3.528658576100155e+00 4.651207787967025e+00 9.234136289426204e+03 + 89740 1.002997369555049e+00 -5.982397307305829e+00 -5.990870955338476e+00 3.841754080776325e+00 4.793097082480065e+00 9.189041523320402e+03 + 89760 1.019875429605953e+00 -5.991287178700564e+00 -5.976151128059742e+00 3.735935496491687e+00 4.822849041567556e+00 9.143949043183098e+03 + 89780 9.659417653348009e-01 -5.893837676796616e+00 -5.956872284020286e+00 4.292880156405480e+00 4.930925687153223e+00 9.085116825867419e+03 + 89800 1.067507889278141e+00 -6.026141591996270e+00 -5.979135879594249e+00 3.543506739336222e+00 4.813420814059109e+00 9.153104213330065e+03 + 89820 1.016461110703808e+00 -5.934070160417384e+00 -6.036441062550446e+00 4.058463945039723e+00 4.470634383145775e+00 9.329241778731342e+03 + 89840 1.021545955440491e+00 -5.932135223209783e+00 -6.003733951869499e+00 4.054997464015811e+00 4.643866484184266e+00 9.228477708299912e+03 + 89860 1.012304368667983e+00 -5.912724258238515e+00 -5.945923090471743e+00 4.160423190546240e+00 4.969790358360355e+00 9.051766412415578e+03 + 89880 1.009349571373608e+00 -5.902327221719281e+00 -6.015274060152491e+00 4.221780483867496e+00 4.573222259117249e+00 9.263951173272742e+03 + 89900 1.059877415356628e+00 -5.973515902865451e+00 -6.007460153793547e+00 3.858080892425451e+00 4.663167750740469e+00 9.239957886128546e+03 + 89920 1.028721827151096e+00 -5.929312685382344e+00 -6.036465367994974e+00 4.041416676193671e+00 4.426129390807907e+00 9.329291008781787e+03 + 89940 1.061769778903416e+00 -5.987465629507965e+00 -6.007947063290040e+00 3.748887936865745e+00 4.631280374597433e+00 9.241463946916585e+03 + 89960 1.026749455500877e+00 -5.952631914293434e+00 -6.030550613504949e+00 3.935343414929964e+00 4.487922186177713e+00 9.311101392939647e+03 + 89980 9.985306537835112e-01 -5.939324593249129e+00 -6.037223797102552e+00 4.079062898990722e+00 4.516910520611536e+00 9.331667924698937e+03 + 90000 1.024303461225930e+00 -6.014003663076107e+00 -6.041073625141481e+00 3.558345087648665e+00 4.402905176406196e+00 9.343568497326509e+03 + 90020 1.034646635005719e+00 -6.075793244695015e+00 -6.000487977137082e+00 3.318832051186078e+00 4.751246550956226e+00 9.218555286443061e+03 + 90040 9.375046994042263e-01 -5.977239213613165e+00 -6.049672648706040e+00 3.785392775058697e+00 4.369468781717556e+00 9.370181969928688e+03 + 90060 9.393414498017124e-01 -6.016843478693740e+00 -6.001552595482736e+00 3.613208568478016e+00 4.701011186132132e+00 9.221810259070193e+03 + 90080 9.886237650923341e-01 -6.114128435244209e+00 -5.956724725060896e+00 3.132921990849318e+00 5.036758452867325e+00 9.084698226607288e+03 + 90100 9.359396230650860e-01 -6.051916224030545e+00 -5.973167836693648e+00 3.408733294059551e+00 4.860918720421568e+00 9.134891986675006e+03 + 90120 9.213030224778741e-01 -6.036342143192512e+00 -6.034484141908981e+00 3.508563262908007e+00 4.519232193802811e+00 9.323201754677382e+03 + 90140 9.691750381032378e-01 -6.107333655313258e+00 -5.975626793386009e+00 3.150960841903280e+00 4.907242024660560e+00 9.142394246533255e+03 + 90160 9.362748039393037e-01 -6.051258500808715e+00 -6.031631368143954e+00 3.367197432783759e+00 4.479899465833785e+00 9.314430916088635e+03 + 90180 1.023606393051084e+00 -6.171646432815560e+00 -5.988386613595773e+00 2.743361808738928e+00 4.795668050064318e+00 9.181452092393200e+03 + 90200 8.965202306255557e-01 -5.971019738654689e+00 -6.002450495134086e+00 3.873981909839267e+00 4.693501642240723e+00 9.224548233663478e+03 + 90220 9.912407083363978e-01 -6.094866784876505e+00 -5.964981433786996e+00 3.222985721536100e+00 4.968807507185179e+00 9.109851652106971e+03 + 90240 9.194210484907953e-01 -5.965725785216926e+00 -5.993672774669414e+00 3.873569387962822e+00 4.713093449743996e+00 9.197647683556110e+03 + 90260 1.022942669029790e+00 -6.094966474552622e+00 -5.990352770187380e+00 3.131776230468857e+00 4.732484309852506e+00 9.187470389686348e+03 + 90280 9.598475915345579e-01 -5.976255996391490e+00 -6.004487721291891e+00 3.828637738272987e+00 4.666526805049576e+00 9.230855472693691e+03 + 90300 9.833697929842095e-01 -5.988335819990033e+00 -6.046079266650390e+00 3.702951203812830e+00 4.371379397319562e+00 9.359052056094628e+03 + 90320 9.716107664810937e-01 -5.953275285592254e+00 -5.987038183066653e+00 4.003697529177051e+00 4.809825747087554e+00 9.177283581746125e+03 + 90340 1.074137082751893e+00 -6.089271367959201e+00 -5.972302772085334e+00 3.217541817676433e+00 4.889193596015888e+00 9.132211328451316e+03 + 90360 1.016098966118460e+00 -5.991043144588276e+00 -6.032480985601726e+00 3.685672958653950e+00 4.447730463069550e+00 9.317015734702367e+03 + 90380 1.066354097378106e+00 -6.058743083030161e+00 -6.010953691976561e+00 3.411118319337729e+00 4.685532398151865e+00 9.250729187760386e+03 + 90400 1.038109655528592e+00 -6.014432751399296e+00 -6.016741375495410e+00 3.619585622284778e+00 4.606329145466468e+00 9.268538362628660e+03 + 90420 1.089347194063812e+00 -6.092073657066365e+00 -6.014723606648991e+00 3.170904447444652e+00 4.615060406822835e+00 9.262288607536695e+03 + 90440 9.826186260511475e-01 -5.938384338412805e+00 -5.995889022931433e+00 3.951858764523008e+00 4.621657967195876e+00 9.204426624219728e+03 + 90460 9.198887365815542e-01 -5.849296312317502e+00 -5.984405633989783e+00 4.549944800429930e+00 4.774126167287736e+00 9.169178489224554e+03 + 90480 1.028947568384534e+00 -6.011569668234668e+00 -5.959061489303172e+00 3.642869914782858e+00 4.944380003821938e+00 9.091783006664045e+03 + 90500 1.010528638888283e+00 -5.983811687595216e+00 -6.007007533651207e+00 3.778590322060214e+00 4.645396184461136e+00 9.238566667421910e+03 + 90520 1.002408396060063e+00 -5.973760658444693e+00 -5.994266762339804e+00 3.860058983941145e+00 4.742309762066096e+00 9.199451853213550e+03 + 90540 9.967592781390170e-01 -5.969626766562801e+00 -6.023465663720730e+00 3.829834810233811e+00 4.520683531210577e+00 9.289215368435285e+03 + 90560 1.030820743992002e+00 -6.025369105495912e+00 -5.960364888234058e+00 3.553619307486540e+00 4.926883582374217e+00 9.095766288132856e+03 + 90580 1.036072530321406e+00 -6.038286635051412e+00 -5.951358604065693e+00 3.556396243673162e+00 5.055550449662476e+00 9.068310582701370e+03 + 90600 9.786182808608902e-01 -5.956211803264342e+00 -5.996027288802871e+00 3.939763719021178e+00 4.711137039632466e+00 9.204802290152973e+03 + 90620 9.933191744009828e-01 -5.980640519197610e+00 -5.950337010762839e+00 3.777100451367684e+00 4.951107886252910e+00 9.065179984237908e+03 + 90640 9.292807142561006e-01 -5.886262797702089e+00 -6.021866744387946e+00 4.243948031208909e+00 4.465289184695788e+00 9.284262428896407e+03 + 90660 9.650406299661355e-01 -5.936715820262868e+00 -6.032496484010139e+00 4.015923589793119e+00 4.465936196546479e+00 9.317055713567006e+03 + 90680 1.050531218000932e+00 -6.061433032555496e+00 -5.992403215462777e+00 3.383005512875396e+00 4.779385404951462e+00 9.193752020066768e+03 + 90700 9.762284701414574e-01 -5.951754705111686e+00 -6.000157909987371e+00 3.931935954215656e+00 4.653997261447728e+00 9.217555510920278e+03 + 90720 9.730865813932369e-01 -5.948880800967653e+00 -6.025619160412798e+00 3.927005467679864e+00 4.486361932523092e+00 9.295880851512205e+03 + 90740 9.945257205188874e-01 -5.982835100906126e+00 -6.026010291386668e+00 3.802181931863123e+00 4.554263306784716e+00 9.297060779986454e+03 + 90760 1.003163360540065e+00 -6.001579051181630e+00 -5.993541523582849e+00 3.659338245549965e+00 4.705490972825547e+00 9.197234312114146e+03 + 90780 1.022994571594771e+00 -6.039165815664402e+00 -5.965713930067644e+00 3.506573025569127e+00 4.928345119308272e+00 9.112075349175429e+03 + 90800 1.031568195074431e+00 -6.060641228513947e+00 -5.954791949693937e+00 3.368726095672284e+00 4.976529034779740e+00 9.078777212796940e+03 + 90820 9.535186460432611e-01 -5.952597048968745e+00 -5.968770270006238e+00 3.947014892194285e+00 4.854145754199132e+00 9.121408641374748e+03 + 90840 9.966719899217524e-01 -6.022660567783614e+00 -6.011710669426211e+00 3.552785453887374e+00 4.615661464746873e+00 9.253029987229671e+03 + 90860 1.037424376896555e+00 -6.088843965813568e+00 -5.986203331087665e+00 3.254851104158999e+00 4.844229512342025e+00 9.174747438043267e+03 + 90880 1.001718706217761e+00 -6.042627792282501e+00 -5.967607978419724e+00 3.491719063943326e+00 4.922494444422069e+00 9.117888053499082e+03 + 90900 9.924692716293966e-01 -6.033610777954717e+00 -5.977645768426397e+00 3.513448550490725e+00 4.834808295759574e+00 9.148542975709381e+03 + 90920 1.002788082742014e+00 -6.051497853248558e+00 -5.978965518657393e+00 3.451612022956298e+00 4.868103912521272e+00 9.152590919323518e+03 + 90940 9.346567080226954e-01 -5.951801617345334e+00 -6.040881076863970e+00 3.978165170593372e+00 4.466657129035554e+00 9.342966969865483e+03 + 90960 1.006417257920964e+00 -6.057665043052575e+00 -5.989971989840886e+00 3.412489402347643e+00 4.801193389355287e+00 9.186271242194092e+03 + 90980 9.266025958710231e-01 -5.936020686059566e+00 -5.991389145592128e+00 4.061488349360757e+00 4.743554086483365e+00 9.190605902782412e+03 + 91000 9.561958998031014e-01 -5.974519251844402e+00 -5.956189554119632e+00 3.850913763691556e+00 4.956165724538738e+00 9.083015930900578e+03 + 91020 1.006852190472304e+00 -6.037081447093894e+00 -5.962668031196943e+00 3.531574720697960e+00 4.958868070217147e+00 9.102790517107829e+03 + 91040 1.084064826833417e+00 -6.132348484506089e+00 -6.004966882630202e+00 2.984770815770680e+00 4.716215685981204e+00 9.232289876528643e+03 + 91060 1.050857770853919e+00 -6.063940961956239e+00 -6.034379179636496e+00 3.333886126915298e+00 4.503634455666290e+00 9.322899491753331e+03 + 91080 9.689402016060198e-01 -5.926426947085247e+00 -6.013112282870818e+00 4.057269111283589e+00 4.559508498690482e+00 9.257359685365214e+03 + 91100 1.007965309000966e+00 -5.966556789630864e+00 -5.992836106043260e+00 3.894247906854662e+00 4.743348005303618e+00 9.195056557191579e+03 + 91120 1.049055006324135e+00 -6.008017048108677e+00 -6.013893635287411e+00 3.728330988203850e+00 4.694586715224629e+00 9.259752322142920e+03 + 91140 9.708688039707143e-01 -5.874894590971385e+00 -6.017748717768360e+00 4.369681659830153e+00 4.549391157157249e+00 9.271602265881009e+03 + 91160 1.075868852834864e+00 -6.013511951470724e+00 -5.943496308037179e+00 3.627686640786177e+00 5.029727300267395e+00 9.044406061664933e+03 + 91180 1.059319613823336e+00 -5.970374829123527e+00 -6.007194875593621e+00 3.827100509626887e+00 4.615674104911827e+00 9.239133060243434e+03 + 91200 9.997601957782097e-01 -5.866630201576225e+00 -6.052331262586438e+00 4.342801355900750e+00 4.276477126433784e+00 9.378388746015207e+03 + 91220 1.074106812823795e+00 -5.966594803735809e+00 -6.014972928835885e+00 3.907571773378381e+00 4.629777092563080e+00 9.263087883080078e+03 + 91240 1.056563043890102e+00 -5.937453390433897e+00 -6.041432124368221e+00 4.025601854678577e+00 4.428539873770617e+00 9.344673596646817e+03 + 91260 9.673927464386137e-01 -5.809442555762791e+00 -6.038172687854384e+00 4.686600052808972e+00 4.373196238465504e+00 9.334569801943591e+03 + 91280 1.026314689320599e+00 -5.905831243445156e+00 -5.996893489639968e+00 4.183908739826203e+00 4.661015230338535e+00 9.207521791541851e+03 + 91300 1.075276707207644e+00 -5.997378313117030e+00 -5.986383127298366e+00 3.694841340481710e+00 4.757977398951993e+00 9.175277527548546e+03 + 91320 9.988504266107781e-01 -5.915992641816494e+00 -5.989278107552175e+00 4.104210173041773e+00 4.683393687898326e+00 9.184119393641327e+03 + 91340 1.027768691818412e+00 -5.998893877758062e+00 -5.900131971693922e+00 3.688312023937532e+00 5.255418171913394e+00 8.912989294768950e+03 + 91360 9.621798808142551e-01 -5.939150759731340e+00 -5.957055683937511e+00 4.008713963514596e+00 4.905901117944697e+00 9.085676786077009e+03 + 91380 9.701896576178528e-01 -5.989742803372113e+00 -6.028941954315830e+00 3.743368877094144e+00 4.518281286326319e+00 9.306105387359406e+03 + 91400 1.001984311149583e+00 -6.072489784536085e+00 -5.962077002593810e+00 3.314401881251693e+00 4.948409161487016e+00 9.100973175128822e+03 + 91420 9.859174001244723e-01 -6.073820146560882e+00 -5.937568957392716e+00 3.329441269446448e+00 5.111816682453437e+00 9.026347145188178e+03 + 91440 9.614124904150658e-01 -6.053462822048669e+00 -5.942861831048573e+00 3.386120940573419e+00 5.021208946344016e+00 9.042475675901069e+03 + 91460 9.670103158555130e-01 -6.070743619162544e+00 -5.933648690613020e+00 3.377184830711050e+00 5.164405125814044e+00 9.014454027048561e+03 + 91480 9.008382474990118e-01 -5.973793782350654e+00 -5.965319368512162e+00 3.870672255563362e+00 4.919333651235287e+00 9.110823025508298e+03 + 91500 9.591219989821808e-01 -6.051956740980719e+00 -5.989926500521300e+00 3.454309897787438e+00 4.810497137654110e+00 9.186135087441180e+03 + 91520 9.661131503252161e-01 -6.050833822001569e+00 -5.999840865148419e+00 3.405118848500883e+00 4.697928297886243e+00 9.216578363011289e+03 + 91540 8.937297703054529e-01 -5.930071244251935e+00 -6.005635740337473e+00 4.108619775042314e+00 4.674716744951181e+00 9.234347328500715e+03 + 91560 9.799969067742539e-01 -6.040599909445302e+00 -5.960662099820501e+00 3.550566202096759e+00 5.009581475298425e+00 9.096695714667492e+03 + 91580 9.873750124112767e-01 -6.028086772819733e+00 -6.004834183589754e+00 3.566751265155697e+00 4.700271230840789e+00 9.231877289496391e+03 + 91600 1.082632929639991e+00 -6.146293663484569e+00 -5.958830991443607e+00 2.951395790626668e+00 5.027835463240614e+00 9.091102476907727e+03 + 91620 9.835509437271127e-01 -5.975751598991893e+00 -5.969112693998621e+00 3.852004637136334e+00 4.890126256974927e+00 9.122462405839829e+03 + 91640 9.868240085701721e-01 -5.957581419746098e+00 -5.960406298230106e+00 3.942764533184067e+00 4.926543643780357e+00 9.095895630875255e+03 + 91660 1.012945680557856e+00 -5.974648853481462e+00 -5.927285781176846e+00 3.795729037087928e+00 5.067695127672782e+00 8.995189848180058e+03 + 91680 9.546830236004079e-01 -5.866722181878935e+00 -5.963377877854162e+00 4.401831388010221e+00 4.846819424299855e+00 9.104928451371828e+03 + 91700 1.079924212094383e+00 -6.032660971653055e+00 -5.961297462761236e+00 3.525292780679866e+00 4.935073092204003e+00 9.098595157602878e+03 + 91720 1.031800682623850e+00 -5.948899907625007e+00 -5.973379201170015e+00 3.997689673204156e+00 4.857125781510284e+00 9.135481286946795e+03 + 91740 1.030513265118737e+00 -5.940465379478386e+00 -5.966055473714219e+00 4.100670935634315e+00 4.953728654477877e+00 9.113104069212050e+03 + 91760 1.025659166762495e+00 -5.929237322324334e+00 -5.984286292107209e+00 4.115330665787295e+00 4.799230962493486e+00 9.168851386259792e+03 + 91780 1.082557069659960e+00 -6.014303931103578e+00 -6.033960978152489e+00 3.623495632975875e+00 4.510621826902828e+00 9.321602238036563e+03 + 91800 1.003182078429742e+00 -5.904348839074922e+00 -6.083437548805012e+00 4.143724379518756e+00 4.115369294360315e+00 9.474981902139245e+03 + 91820 9.611591244775244e-01 -5.851466200615871e+00 -6.078095881418850e+00 4.442491979451584e+00 4.141149281451120e+00 9.458348791893108e+03 + 91840 9.810486751939274e-01 -5.890567718779295e+00 -6.085071166864841e+00 4.249877633311333e+00 4.133008735092811e+00 9.480054024793450e+03 + 91860 9.883088496339950e-01 -5.914244610631100e+00 -6.053519294110114e+00 4.174736001773017e+00 4.374999216548903e+00 9.382066005516232e+03 + 91880 1.046456369649532e+00 -6.014665267085565e+00 -5.999080695837783e+00 3.633901326500908e+00 4.723390346310278e+00 9.214230545791019e+03 + 91900 1.003776303236456e+00 -5.965143480697046e+00 -5.986415647417244e+00 3.913922335079033e+00 4.791774261914493e+00 9.175380504169860e+03 + 91920 1.064365487704923e+00 -6.069948955234690e+00 -5.975454615829983e+00 3.360725095415205e+00 4.903326215228793e+00 9.141856980291406e+03 + 91940 1.020622467044614e+00 -6.022539869167445e+00 -5.972929856418884e+00 3.634157531301558e+00 4.919025901628455e+00 9.134132134932875e+03 + 91960 1.002008659821900e+00 -6.009604760262583e+00 -5.969346953543777e+00 3.688955577157066e+00 4.920122133211905e+00 9.123155455847071e+03 + 91980 9.620608637716673e-01 -5.962030452242761e+00 -5.972232974649442e+00 3.986652094855626e+00 4.928067632361225e+00 9.131979172402664e+03 + 92000 9.914508885804711e-01 -6.017435245408493e+00 -5.981991827347139e+00 3.578992770346881e+00 4.782514361706397e+00 9.161851054016628e+03 + 92020 1.031219940656133e+00 -6.085829395199574e+00 -6.033983065883395e+00 3.190367268346120e+00 4.488076914473152e+00 9.321673188200464e+03 + 92040 9.470023919509970e-01 -5.972753671237058e+00 -5.997485987713207e+00 3.858853465576396e+00 4.716836677056742e+00 9.209348324127055e+03 + 92060 9.901459853025222e-01 -6.048000802730856e+00 -5.981190643469706e+00 3.422826614678641e+00 4.806460887994896e+00 9.159381719379762e+03 + 92080 9.892625123402107e-01 -6.055392400985992e+00 -5.973320323005632e+00 3.367959388874767e+00 4.839229961251017e+00 9.135339614918730e+03 + 92100 9.942251885664569e-01 -6.070677519711635e+00 -6.001276655692319e+00 3.293982321284305e+00 4.692492822232216e+00 9.220983811836993e+03 + 92120 9.796059744273041e-01 -6.055755330437749e+00 -6.004633721839086e+00 3.391641265565771e+00 4.685189453182660e+00 9.231274349706462e+03 + 92140 9.685389496695308e-01 -6.044966066203763e+00 -5.994043456214458e+00 3.478417308377974e+00 4.770822815184996e+00 9.198773874562114e+03 + 92160 9.971058381255139e-01 -6.091809112638843e+00 -6.016945108530072e+00 3.178159259498971e+00 4.608039956258724e+00 9.269161814159248e+03 + 92180 9.102040642184176e-01 -5.965636140109127e+00 -6.050264327981040e+00 3.846624573986456e+00 4.360676423056182e+00 9.372010871053008e+03 + 92200 9.730694102239341e-01 -6.059255562482457e+00 -5.990610316435148e+00 3.360945076094699e+00 4.755116701715846e+00 9.188251090837746e+03 + 92220 9.609250597398966e-01 -6.035963045762831e+00 -5.979068352225161e+00 3.503246585878892e+00 4.829944720597560e+00 9.152908732737411e+03 + 92240 9.813965926657627e-01 -6.054134460459643e+00 -5.972166447653731e+00 3.342777759032568e+00 4.813450773073109e+00 9.131791451236755e+03 + 92260 9.280162330166271e-01 -5.957532816981169e+00 -5.953826002984674e+00 3.902383816210753e+00 4.923668915806235e+00 9.075828653247287e+03 + 92280 9.276172502440352e-01 -5.929887980095666e+00 -6.022015056763373e+00 4.082572940004829e+00 4.553565009159814e+00 9.284731896026764e+03 + 92300 9.532012165194542e-01 -5.936769699618371e+00 -5.998184009909230e+00 4.023056060451045e+00 4.670405586927133e+00 9.211477219230410e+03 + 92320 1.035297502321760e+00 -6.023670599102213e+00 -5.968854561391465e+00 3.523865146010526e+00 4.838627317300062e+00 9.121696063774549e+03 + 92340 9.856225451581494e-01 -5.917368365205769e+00 -5.987591351253808e+00 4.095005020139521e+00 4.691773767279712e+00 9.178990063114532e+03 + 92360 9.691883179731632e-01 -5.864828783200910e+00 -5.959137490817533e+00 4.406758809293646e+00 4.865223615933657e+00 9.092026176295782e+03 + 92380 1.057793465691297e+00 -5.969967109448820e+00 -6.006931047649975e+00 3.813145727914197e+00 4.600893074612214e+00 9.238305700574771e+03 + 92400 1.062288448715253e+00 -5.956778217032518e+00 -6.043859746744644e+00 3.904384651686155e+00 4.404349032255956e+00 9.352174319457506e+03 + 92420 1.074105156625377e+00 -5.962983204051115e+00 -5.996901182428162e+00 3.864130784450694e+00 4.669368503819502e+00 9.207538184806213e+03 + 92440 1.084904983887666e+00 -5.975856102539982e+00 -6.020229734883625e+00 3.751885715027536e+00 4.497085451312927e+00 9.279260459996854e+03 + 92460 1.034021344767965e+00 -5.903174899802647e+00 -6.049696432717321e+00 4.175661950376023e+00 4.334312634246023e+00 9.370238141193653e+03 + 92480 1.067401439056052e+00 -5.963642759268620e+00 -6.078606051808658e+00 3.876557776984852e+00 4.216420760707932e+00 9.459920775778599e+03 + 92500 1.023907973367928e+00 -5.920663506537450e+00 -6.067634871328995e+00 4.142090295535436e+00 4.298157975157189e+00 9.425835203450679e+03 + 92520 1.036924266254340e+00 -5.970059120876485e+00 -6.038171330775089e+00 3.802624853796866e+00 4.411514004228666e+00 9.334610240732705e+03 + 92540 1.007045049981141e+00 -5.960328298647221e+00 -6.011890966317067e+00 3.845408823536443e+00 4.549328006479155e+00 9.253567831747245e+03 + 92560 9.838734240716901e-01 -5.961448090100680e+00 -6.009349373720204e+00 3.854907023388519e+00 4.579850440145528e+00 9.245751494776272e+03 + 92580 9.896419899321607e-01 -6.001569749707246e+00 -5.979484809670014e+00 3.668201920259528e+00 4.795017063586745e+00 9.154171920371640e+03 + 92600 1.004953484233613e+00 -6.049931156844298e+00 -6.035085567842809e+00 3.407124136140154e+00 4.492369805534183e+00 9.325083308415107e+03 + 92620 1.006391128945778e+00 -6.072982017498060e+00 -6.011929041190021e+00 3.302594879288017e+00 4.653170517166328e+00 9.253736328540872e+03 + 92640 9.789972764932645e-01 -6.047957336862297e+00 -6.032114929293050e+00 3.414582345778536e+00 4.505551901645800e+00 9.315923290693889e+03 + 92660 9.461626952171051e-01 -6.009811360169687e+00 -5.986296767545719e+00 3.653738205978938e+00 4.788762635697214e+00 9.175037327993236e+03 + 92680 9.446613473371800e-01 -6.010331109198454e+00 -5.972037738558966e+00 3.650516188170057e+00 4.870402648261949e+00 9.131395204911447e+03 + 92700 9.823425347821416e-01 -6.063107602293886e+00 -5.992104752822645e+00 3.331030040657935e+00 4.738739389977246e+00 9.192829059814656e+03 + 92720 9.602452118350174e-01 -6.025867822711992e+00 -5.994702749447457e+00 3.540540591297925e+00 4.719495264762381e+00 9.200796138729072e+03 + 92740 1.004653529516145e+00 -6.083319586523846e+00 -5.987313702650987e+00 3.215602691843601e+00 4.766883333904076e+00 9.178157071553222e+03 + 92760 1.001404297490927e+00 -6.068820810355640e+00 -5.991717531857198e+00 3.366944765417203e+00 4.809683722249048e+00 9.191632911101067e+03 + 92780 9.854829547446791e-01 -6.036219387797411e+00 -5.977417204510067e+00 3.530851334411929e+00 4.868502570456318e+00 9.147851885449112e+03 + 92800 9.803022170092226e-01 -6.017489782344901e+00 -5.983101038282072e+00 3.630600932105565e+00 4.828066422155274e+00 9.165231746551121e+03 + 92820 9.187937000228594e-01 -5.913335123656370e+00 -5.987638666854830e+00 4.214431597518744e+00 4.787769154037034e+00 9.179125958015618e+03 + 92840 1.033554831101026e+00 -6.068014248616664e+00 -6.013870602471871e+00 3.340711654570892e+00 4.651612849436454e+00 9.259661903948772e+03 + 92860 1.012463189341645e+00 -6.021264061468067e+00 -6.045012652053485e+00 3.611974694134386e+00 4.475606611910396e+00 9.355735463173278e+03 + 92880 1.004581296136471e+00 -5.996420075218349e+00 -6.025471997185194e+00 3.714439346099119e+00 4.547618714395096e+00 9.295417032892747e+03 + 92900 9.857759685137046e-01 -5.958355182615852e+00 -6.007690993371544e+00 3.985792778795400e+00 4.702498918744176e+00 9.240692014260994e+03 + 92920 1.028490960699423e+00 -6.010366106247150e+00 -6.035132698076771e+00 3.667103915665133e+00 4.524890312761752e+00 9.325213936434031e+03 + 92940 1.008777562154422e+00 -5.972312690938340e+00 -6.041380854379961e+00 3.887137668210854e+00 4.490537585465317e+00 9.344525328648004e+03 + 92960 9.645013787449147e-01 -5.901485973172925e+00 -6.057494986382956e+00 4.188991752329789e+00 4.293163856161018e+00 9.394393394723327e+03 + 92980 1.017737129263546e+00 -5.976809937320182e+00 -5.990106953089164e+00 3.850448897997735e+00 4.774095375745697e+00 9.186710367695368e+03 + 93000 1.060557420600062e+00 -6.039003252470741e+00 -5.965990396013435e+00 3.504455698721114e+00 4.923706819201985e+00 9.112931808621568e+03 + 93020 1.008544236252714e+00 -5.961418514771606e+00 -5.965642033655620e+00 3.882597631934705e+00 4.858345532915264e+00 9.111842481642607e+03 + 93040 9.889182144054177e-01 -5.933186804756262e+00 -5.969071457597715e+00 4.052111079942732e+00 4.846055850195028e+00 9.122339723130011e+03 + 93060 9.874320732284468e-01 -5.930984139632502e+00 -6.016297112883140e+00 4.029786398054670e+00 4.539906103509568e+00 9.267144882185665e+03 + 93080 1.010553254956684e+00 -5.967405115991503e+00 -6.008184730274350e+00 3.861365986358572e+00 4.627203130521546e+00 9.242181388737819e+03 + 93100 9.949077152686254e-01 -5.950695818262894e+00 -6.000764218335084e+00 4.003529954183826e+00 4.716029452909440e+00 9.219387102489603e+03 + 93120 9.806806702284475e-01 -5.937266367213281e+00 -6.014194539276016e+00 4.048052758725163e+00 4.606319290144788e+00 9.260685179103317e+03 + 93140 1.085502879589544e+00 -6.104242871097636e+00 -5.984350706046457e+00 3.115851637767196e+00 4.804291002743647e+00 9.169097938548062e+03 + 93160 9.364837461390464e-01 -5.899020269933563e+00 -6.045497340631674e+00 4.187820284196234e+00 4.346726276994248e+00 9.357245069991197e+03 + 93180 1.006060642316559e+00 -6.019687445639095e+00 -6.004186869886926e+00 3.571344804286159e+00 4.660351508961458e+00 9.229913357892499e+03 + 93200 1.042261952283367e+00 -6.092914355581375e+00 -5.953310930736250e+00 3.237812462605878e+00 5.039436931626764e+00 9.074282106460301e+03 + 93220 1.010187627501127e+00 -6.064732524429517e+00 -5.974343292551766e+00 3.349294254578739e+00 4.868323211709212e+00 9.138464660046033e+03 + 93240 9.392010788669113e-01 -5.977105221764491e+00 -6.004591798316635e+00 3.825233456104951e+00 4.667401280008569e+00 9.231150324293574e+03 + 93260 9.880598977792002e-01 -6.062370786700685e+00 -6.000804069337345e+00 3.331134065731672e+00 4.684659684250685e+00 9.219519721955521e+03 + 93280 1.002683785064957e+00 -6.095715971502671e+00 -5.977673831980426e+00 3.175351514162174e+00 4.853167746260960e+00 9.148664366211286e+03 + 93300 9.815373579779166e-01 -6.073400532892467e+00 -6.000841468632671e+00 3.268373140636519e+00 4.685018516095178e+00 9.219655981412256e+03 + 93320 8.967628851499602e-01 -5.953934275475033e+00 -6.065844436522685e+00 3.963517493467271e+00 4.320912030690204e+00 9.420282818370406e+03 + 93340 9.650180367388053e-01 -6.059272703553784e+00 -6.036237890524257e+00 3.382277637554544e+00 4.514547098595887e+00 9.328639852471500e+03 + 93360 9.133997723522039e-01 -5.984956820553462e+00 -5.988804431726927e+00 3.804813142490417e+00 4.782719563716476e+00 9.182711311763796e+03 + 93380 9.672006771156521e-01 -6.060785326890991e+00 -5.933937686714906e+00 3.412879207130940e+00 5.141257986630896e+00 9.015365199943333e+03 + 93400 9.573483861332684e-01 -6.031713644240075e+00 -5.952259374441527e+00 3.599280777037767e+00 5.055519489729541e+00 9.071066947218089e+03 + 93420 9.499737207554377e-01 -5.997131071455014e+00 -6.015658916148940e+00 3.673980439165735e+00 4.567590687758512e+00 9.265166972664352e+03 + 93440 9.764756422570998e-01 -6.007307395956436e+00 -6.009324617091266e+00 3.612238898664493e+00 4.600655702744334e+00 9.245692799792647e+03 + 93460 1.008345926130646e+00 -6.019633373060527e+00 -5.985669771897202e+00 3.594215903322761e+00 4.789240157052868e+00 9.173104844678172e+03 + 93480 1.016067136227089e+00 -5.996182907934360e+00 -5.983540850052537e+00 3.744190434331495e+00 4.816783087041053e+00 9.166564274083956e+03 + 93500 9.639178344841115e-01 -5.884671582674844e+00 -6.032183454472926e+00 4.282753629477626e+00 4.435717634224658e+00 9.316077537595034e+03 + 93520 1.021339919419579e+00 -5.938087428679887e+00 -5.982737938406218e+00 4.045016750230607e+00 4.788626613737969e+00 9.164147677557643e+03 + 93540 1.017593858473686e+00 -5.907272136866909e+00 -6.068488318229424e+00 4.157490325339080e+00 4.231762063832078e+00 9.428470705432443e+03 + 93560 1.111032182066220e+00 -6.031543101164891e+00 -6.024818480530904e+00 3.543548589356551e+00 4.582162401668587e+00 9.293387268730783e+03 + 93580 1.102723318277440e+00 -6.015145159211359e+00 -5.977036746210840e+00 3.615359789113062e+00 4.834184193819898e+00 9.146710876775605e+03 + 93600 9.785106251226479e-01 -5.832026394304383e+00 -6.029574733162384e+00 4.604330222744467e+00 4.469977090515186e+00 9.308045623371896e+03 + 93620 1.062984092690238e+00 -5.964161719894604e+00 -5.982365150770706e+00 3.924900586355180e+00 4.820373669292780e+00 9.162983848112208e+03 + 93640 1.034313750645376e+00 -5.932503837522007e+00 -6.030733424128543e+00 4.028725575413942e+00 4.464676088139815e+00 9.311628708554819e+03 + 93660 1.044351244001436e+00 -5.962528526770371e+00 -6.015857109202439e+00 3.877600882722589e+00 4.571379909826196e+00 9.265786385459918e+03 + 93680 1.004465231840153e+00 -5.920592027122138e+00 -6.063092552582151e+00 4.083742355781609e+00 4.265482286705173e+00 9.411728894233258e+03 + 93700 1.030319899136181e+00 -5.978023774666565e+00 -6.029318553072333e+00 3.770949173198617e+00 4.476406617751391e+00 9.307275569122856e+03 + 93720 9.788290854771141e-01 -5.922266435427655e+00 -6.037064040407643e+00 4.063991507060271e+00 4.404805894393228e+00 9.331181651633300e+03 + 93740 9.915383753129791e-01 -5.961158374336235e+00 -6.014568272938178e+00 3.935249936125309e+00 4.628562033197857e+00 9.261813793929745e+03 + 93760 1.011449278162475e+00 -6.007006427059477e+00 -6.001390035132625e+00 3.675189039265247e+00 4.707439230843077e+00 9.221240408761621e+03 + 93780 1.014790404783228e+00 -6.023971860774200e+00 -6.028350490761887e+00 3.552629684671025e+00 4.527486913690927e+00 9.304268717897232e+03 + 93800 1.046614046781856e+00 -6.081679149296868e+00 -6.001319474200984e+00 3.206909262096045e+00 4.668346952116141e+00 9.221091027981227e+03 + 93820 1.046023004379359e+00 -6.087299208035068e+00 -5.997389816169339e+00 3.206453289014628e+00 4.722726930541066e+00 9.209042370149880e+03 + 93840 9.772373250310857e-01 -5.990134985587213e+00 -6.030548076353883e+00 3.788309160689592e+00 4.556250939601790e+00 9.311067232641157e+03 + 93860 9.809324447601825e-01 -5.999660836190475e+00 -6.019477668181596e+00 3.676042421305477e+00 4.562251105367620e+00 9.276963773550537e+03 + 93880 9.853275113382277e-01 -6.008927126538873e+00 -5.994575274057046e+00 3.661236347140911e+00 4.743646905033554e+00 9.200406204128070e+03 + 93900 1.012100023492402e+00 -6.049522687916141e+00 -5.978525321410533e+00 3.417051231619836e+00 4.824729096901996e+00 9.151239810160350e+03 + 93920 9.764252869264854e-01 -5.995041333094542e+00 -6.008734208729933e+00 3.715957551656625e+00 4.637330940792553e+00 9.243866746492851e+03 + 93940 1.011385456122951e+00 -6.046491112548694e+00 -5.966629320718687e+00 3.411348163774456e+00 4.869926931034702e+00 9.114885620366760e+03 + 93960 1.004416562619594e+00 -6.032641163506442e+00 -5.943489795657912e+00 3.510647631426788e+00 5.022568581742636e+00 9.044364212980436e+03 + 93980 1.001429908145562e+00 -6.019868053518668e+00 -5.999754152813995e+00 3.568171557313691e+00 4.683668687775998e+00 9.216272971675413e+03 + 94000 9.728678188962449e-01 -5.966881359812236e+00 -6.028114008809513e+00 3.874348986519525e+00 4.522741640255353e+00 9.303556615469761e+03 + 94020 9.918112137080495e-01 -5.985866641874364e+00 -6.014201277273963e+00 3.752615030827087e+00 4.589913169591934e+00 9.260701724888344e+03 + 94040 9.896254362014468e-01 -5.974041342177318e+00 -6.054984098271758e+00 3.798945171760830e+00 4.334159340415536e+00 9.386610836310836e+03 + 94060 1.022763837253207e+00 -6.015961929024996e+00 -6.014485352515462e+00 3.618301860534385e+00 4.626780591351610e+00 9.261571871083170e+03 + 94080 9.515572412162119e-01 -5.901723297763431e+00 -6.058047238173947e+00 4.225339544013002e+00 4.327703287124225e+00 9.396110948344436e+03 + 94100 1.072019058640124e+00 -6.071585055608249e+00 -6.049114608462965e+00 3.260636070689591e+00 4.389664855488272e+00 9.368466866203395e+03 + 94120 1.001397925424088e+00 -5.959418943801853e+00 -6.031495701013929e+00 3.909373197605045e+00 4.495497303851170e+00 9.313985093982144e+03 + 94140 9.788474840834627e-01 -5.919482205330343e+00 -6.004742104303174e+00 4.064075543588864e+00 4.574500009760141e+00 9.231619009202115e+03 + 94160 1.038202240263828e+00 -5.996728530117174e+00 -6.002940464626946e+00 3.703944492213195e+00 4.668274602964324e+00 9.226068644177172e+03 + 94180 1.011872704362228e+00 -5.944855544627819e+00 -6.013472657295749e+00 3.949340509722868e+00 4.555330430319744e+00 9.258470361489417e+03 + 94200 1.001791239388623e+00 -5.917284993207785e+00 -6.049218403057685e+00 4.078172612568047e+00 4.320590556580732e+00 9.368724141612915e+03 + 94220 1.043178995812027e+00 -5.966398986393271e+00 -5.999258776818891e+00 3.865035012354586e+00 4.676349010694541e+00 9.214783871604774e+03 + 94240 1.086759865886004e+00 -6.020117286902556e+00 -5.987968004398911e+00 3.592256566682601e+00 4.776862721903917e+00 9.180132575569392e+03 + 94260 1.037409286681439e+00 -5.938214465042046e+00 -6.027811291774354e+00 4.017338596589564e+00 4.502859752428530e+00 9.302609591450613e+03 + 94280 1.006244579173458e+00 -5.890132426275022e+00 -6.011595900499476e+00 4.311320644292730e+00 4.613858578884028e+00 9.252657117102544e+03 + 94300 1.029522848004898e+00 -5.927171002268328e+00 -6.032980102930266e+00 3.985071509163999e+00 4.377499279257742e+00 9.318558373777050e+03 + 94320 1.023544182138387e+00 -5.924717343666801e+00 -6.041894128843563e+00 4.068948520460923e+00 4.396101286927052e+00 9.346077228467935e+03 + 94340 1.078854758397992e+00 -6.019726137322836e+00 -5.995568721008902e+00 3.582891502528263e+00 4.721607125350964e+00 9.203453336809507e+03 + 94360 9.985238791073830e-01 -5.921506085190272e+00 -6.018089360145955e+00 4.132191033707734e+00 4.577594922698708e+00 9.272643823945167e+03 + 94380 9.425208596321482e-01 -5.863109071815867e+00 -6.065508489315847e+00 4.412485586938010e+00 4.250276810444491e+00 9.419229674071976e+03 + 94400 1.001743486341775e+00 -5.979264956257833e+00 -6.066205505899714e+00 3.768599920585533e+00 4.269373830535280e+00 9.421412841717603e+03 + 94420 1.031921166007715e+00 -6.058579054819293e+00 -6.000515174456029e+00 3.379120276154951e+00 4.712532062557259e+00 9.218636872328767e+03 + 94440 9.905093473382831e-01 -6.028945090391421e+00 -6.008677717469581e+00 3.568926018220313e+00 4.685304409903338e+00 9.243685438939354e+03 + 94460 9.294371777339961e-01 -5.965491218618029e+00 -6.020200501926816e+00 3.871230725834621e+00 4.557081554841334e+00 9.279169227645616e+03 + 94480 9.472144937987326e-01 -6.014230898766314e+00 -6.017870722272560e+00 3.594423942914407e+00 4.573523513080674e+00 9.272016302957793e+03 + 94500 9.748169850549315e-01 -6.072608100625501e+00 -5.991962442897343e+00 3.329591679334465e+00 4.792671525884749e+00 9.192403459146100e+03 + 94520 9.620379858628038e-01 -6.064340346875277e+00 -6.002818994525913e+00 3.334288804140582e+00 4.687553929729137e+00 9.225716808472484e+03 + 94540 1.035317349450902e+00 -6.178428628079831e+00 -5.975123952930877e+00 2.733328801400037e+00 4.900735707402129e+00 9.140854361170754e+03 + 94560 9.172924431458014e-01 -6.005983284445609e+00 -5.990613066904086e+00 3.626390335741632e+00 4.714648503398537e+00 9.188265732898246e+03 + 94580 9.274456650364127e-01 -6.018389185879064e+00 -5.977254456028000e+00 3.586214308287167e+00 4.822416292670848e+00 9.147345331496610e+03 + 94600 9.961123587525400e-01 -6.110148313454233e+00 -5.955230930849533e+00 3.121352688651858e+00 5.010912272955527e+00 9.080135087760751e+03 + 94620 9.538771160146013e-01 -6.029410723299195e+00 -5.985345966632163e+00 3.564575435066573e+00 4.817602086847725e+00 9.172117615145145e+03 + 94640 9.779537144416087e-01 -6.037970838132346e+00 -5.973346809956356e+00 3.512280225691014e+00 4.883361396013592e+00 9.135417457612421e+03 + 94660 9.635853560374307e-01 -5.982475012442880e+00 -6.011765630285341e+00 3.810955236276111e+00 4.642763975916235e+00 9.253218133551483e+03 + 94680 9.693421350540625e-01 -5.952025182920138e+00 -6.012626229819808e+00 3.954493622178805e+00 4.606513032899207e+00 9.255859295174210e+03 + 94700 9.561330647882303e-01 -5.889270784246356e+00 -6.053006098260979e+00 4.282355296158923e+00 4.342161785129004e+00 9.380470447549880e+03 + 94720 1.032725461190824e+00 -5.960776704406916e+00 -6.028078712527181e+00 3.917070561430096e+00 4.530612015851439e+00 9.303450285368790e+03 + 94740 1.072160929804251e+00 -5.987009713109087e+00 -6.024909791452223e+00 3.771250297655964e+00 4.553622182791509e+00 9.293679652671661e+03 + 94760 9.917107198905897e-01 -5.851161038555856e+00 -6.049583291631942e+00 4.505859042114409e+00 4.366487759207095e+00 9.369906207074793e+03 + 94780 1.147636839547698e+00 -6.077004237170510e+00 -6.014495382618255e+00 3.259364836612838e+00 4.618300352665862e+00 9.261627269304825e+03 + 94800 1.036387654386307e+00 -5.914877233977522e+00 -6.041469325940072e+00 4.125969127330555e+00 4.399057745218666e+00 9.344798622833641e+03 + 94820 1.052439569556804e+00 -5.946641727485394e+00 -6.024919258550104e+00 4.000988497730486e+00 4.551506800948141e+00 9.293698459604888e+03 + 94840 1.036874989651425e+00 -5.933914666385353e+00 -6.037101302460485e+00 4.041603634476481e+00 4.449090002052750e+00 9.331270320626674e+03 + 94860 1.067849834427632e+00 -5.995137510371341e+00 -6.018259092406034e+00 3.701959516609794e+00 4.569191814513334e+00 9.273176708559560e+03 + 94880 1.043929809828987e+00 -5.975735665044814e+00 -6.025796091708722e+00 3.809822479867700e+00 4.522367763137550e+00 9.296410581336824e+03 + 94900 1.033030929757794e+00 -5.979223642442232e+00 -6.009979234668259e+00 3.778318536020670e+00 4.601715166046302e+00 9.247718979320069e+03 + 94920 9.788936375586953e-01 -5.918835795865558e+00 -6.008334636619677e+00 4.117883322104674e+00 4.603967128593677e+00 9.242651123768170e+03 + 94940 1.034157341192838e+00 -6.022820593995579e+00 -5.978191823333714e+00 3.609235022929854e+00 4.865500330350224e+00 9.150207111642912e+03 + 94960 9.868032327305877e-01 -5.973066782528702e+00 -5.991717766445730e+00 3.828640713537504e+00 4.721543877655498e+00 9.191637587111290e+03 + 94980 9.950923982998496e-01 -6.001538518876497e+00 -6.024172847422872e+00 3.687179719443317e+00 4.557209902279013e+00 9.291413758839033e+03 + 95000 1.039191951800178e+00 -6.084505603083398e+00 -5.994709922818307e+00 3.183733715922463e+00 4.699354407841225e+00 9.200838071726108e+03 + 95020 9.863695273168366e-01 -6.024459764177291e+00 -5.945118670618758e+00 3.544889954988026e+00 5.000478792195667e+00 9.049342013819447e+03 + 95040 9.790148159532771e-01 -6.027516899664356e+00 -5.961072045012925e+00 3.536891845309338e+00 4.918428483025884e+00 9.097928440629410e+03 + 95060 1.004889348844278e+00 -6.074347669288915e+00 -5.984493475811060e+00 3.320268573842368e+00 4.836225257683715e+00 9.169500873203346e+03 + 95080 9.061042588698062e-01 -5.933258231058335e+00 -6.053076455004544e+00 4.046985597534553e+00 4.358970813825192e+00 9.380688149533045e+03 + 95100 1.037378973413142e+00 -6.131613280288347e+00 -6.010288374640857e+00 2.977350191323140e+00 4.674016574519499e+00 9.248677494698519e+03 + 95120 1.005298875399645e+00 -6.087745632956051e+00 -5.992495358826131e+00 3.250941696619717e+00 4.797883510606003e+00 9.194033717980783e+03 + 95140 9.653588661105028e-01 -6.032255676168957e+00 -5.954921848063564e+00 3.550252288356263e+00 4.994315096708654e+00 9.079186131461272e+03 + 95160 9.522317342758853e-01 -6.009511608566700e+00 -6.011325426688872e+00 3.630727993247413e+00 4.620312768902450e+00 9.251831405178051e+03 + 95180 1.045199464152538e+00 -6.138327558149761e+00 -5.995999677295883e+00 2.897477077823053e+00 4.714745794854407e+00 9.204775997384124e+03 + 95200 9.551809145867169e-01 -5.989093750676144e+00 -5.993229404865721e+00 3.700100177312520e+00 4.676352610965552e+00 9.196258813482867e+03 + 95220 9.410490095545608e-01 -5.940425664606339e+00 -5.995090126259727e+00 4.072279176510538e+00 4.758387378398682e+00 9.201969992232518e+03 + 95240 9.682540518272019e-01 -5.941867037146875e+00 -6.049832054294100e+00 3.975683917925386e+00 4.355732081933615e+00 9.370653768522094e+03 + 95260 1.068435663851634e+00 -6.043754687462051e+00 -6.001264701639419e+00 3.434470092944612e+00 4.678454166842219e+00 9.220926054986119e+03 + 95280 9.786386851305784e-01 -5.868767366149328e+00 -6.066063838431948e+00 4.368876502160305e+00 4.235969626783089e+00 9.420936242365991e+03 + 95300 1.041037302887100e+00 -5.927539251995333e+00 -6.006392803145202e+00 4.039219185155776e+00 4.586429891905631e+00 9.236686875606947e+03 + 95320 1.118274628454253e+00 -6.016295467428438e+00 -5.996689324288653e+00 3.585641680956781e+00 4.698223188906268e+00 9.206917133084335e+03 + 95340 1.124925968656815e+00 -6.011180936624387e+00 -6.027984223892525e+00 3.649927073081644e+00 4.553439997287698e+00 9.303163287906407e+03 + 95360 9.720434139152967e-01 -5.781372901193830e+00 -6.126898294354184e+00 4.787077720048082e+00 3.803017442639544e+00 9.610700490974899e+03 + 95380 1.049329956308732e+00 -5.902293258533724e+00 -6.060882456581475e+00 4.157635002630157e+00 4.246991285840891e+00 9.404891574693022e+03 + 95400 1.077875246277396e+00 -5.958437235491025e+00 -6.008668215506995e+00 3.962424870596290e+00 4.673990810125548e+00 9.243669454586088e+03 + 95420 1.077299865771007e+00 -5.979820739514517e+00 -6.000853401772934e+00 3.799761961586347e+00 4.678989160104552e+00 9.219670038185126e+03 + 95440 1.024540620446329e+00 -5.928331256459124e+00 -6.019028265014335e+00 4.112793930292657e+00 4.591997671851923e+00 9.275551668494671e+03 + 95460 1.072162651932844e+00 -6.032905155369787e+00 -6.005618601667746e+00 3.477579635757002e+00 4.634263249694659e+00 9.234321802145927e+03 + 95480 9.806286197902236e-01 -5.931598482288509e+00 -6.013367629821518e+00 4.081817325969507e+00 4.612286227100284e+00 9.258130196598277e+03 + 95500 9.780690369306915e-01 -5.959892800965847e+00 -6.059878489868689e+00 3.922981752452380e+00 4.348848454036903e+00 9.401770360463137e+03 + 95520 9.655444264650130e-01 -5.968886499450543e+00 -6.000062521579284e+00 3.887621736290389e+00 4.708604192753319e+00 9.217245271376476e+03 + 95540 1.014113167698260e+00 -6.061376583478824e+00 -5.970835304362754e+00 3.411263440270162e+00 4.931165476172297e+00 9.127740253120219e+03 + 95560 9.292153531448616e-01 -5.949142238855487e+00 -6.040167308204596e+00 3.964134965918020e+00 4.441454931631478e+00 9.340741883655019e+03 + 95580 9.818243273530214e-01 -6.035564715343057e+00 -6.003631154887648e+00 3.556738689396817e+00 4.740106135234286e+00 9.228181918064023e+03 + 95600 9.627800891964690e-01 -6.011327826427614e+00 -6.005866053169965e+00 3.644628913891322e+00 4.675991261143426e+00 9.235067609965072e+03 + 95620 9.427010220003110e-01 -5.982197290405413e+00 -6.015830512539170e+00 3.771583957287501e+00 4.578456791071169e+00 9.265705770397371e+03 + 95640 9.837814802647419e-01 -6.040199131622237e+00 -6.002689305453639e+00 3.478452185282878e+00 4.693839411769805e+00 9.225315495372311e+03 + 95660 1.016578520366641e+00 -6.084842951086799e+00 -5.999832159632719e+00 3.238128575479884e+00 4.726273695386669e+00 9.216527488210011e+03 + 95680 9.762944923418237e-01 -6.019817344320343e+00 -5.990313580554903e+00 3.626914361133613e+00 4.796329538367454e+00 9.187334712890060e+03 + 95700 1.012177672306904e+00 -6.065734852790095e+00 -5.974083915110039e+00 3.385240366684378e+00 4.911514233780034e+00 9.137664393981908e+03 + 95720 9.425560359464528e-01 -5.952731647587663e+00 -6.026221154341216e+00 3.982791564305317e+00 4.560803444062004e+00 9.297720652206268e+03 + 95740 9.979401853299903e-01 -6.023905230125738e+00 -6.004404451474244e+00 3.601484047074389e+00 4.713460535827011e+00 9.230582429014166e+03 + 95760 9.634143189579236e-01 -5.961337417072567e+00 -6.036739083676999e+00 3.938341836829431e+00 4.505373798816589e+00 9.330190359369341e+03 + 95780 1.008713068530625e+00 -6.016996510765132e+00 -6.032736948262961e+00 3.626133884309534e+00 4.535749856372168e+00 9.317836082540394e+03 + 95800 1.008128839453141e+00 -6.007070877083601e+00 -5.999691450972664e+00 3.655731583702186e+00 4.698105390393683e+00 9.216126699368675e+03 + 95820 1.047121236382580e+00 -6.053996196693452e+00 -5.995751728255827e+00 3.407515859804413e+00 4.741964610875622e+00 9.204018055290413e+03 + 95840 1.021668218090751e+00 -6.003596510350438e+00 -6.010831539535216e+00 3.666614850562204e+00 4.625070193366062e+00 9.250356542787096e+03 + 95860 9.857684318457050e-01 -5.937464815740464e+00 -6.033366553680223e+00 4.079233758092036e+00 4.528551138095958e+00 9.319760690190664e+03 + 95880 1.055620730429537e+00 -6.024201849827714e+00 -6.041191329584417e+00 3.612207349385387e+00 4.514651127508900e+00 9.343925660345541e+03 + 95900 1.030114000574381e+00 -5.965097063103602e+00 -6.032494583619762e+00 3.898440542777303e+00 4.511433550240923e+00 9.317077082142714e+03 + 95920 1.008959998299059e+00 -5.903538653123416e+00 -6.001139575016886e+00 4.265103460602575e+00 4.704663863396421e+00 9.220553962293936e+03 + 95940 1.004743523254807e+00 -5.859652052594926e+00 -6.022808881706647e+00 4.484913196547193e+00 4.548041435349991e+00 9.287172927004727e+03 + 95960 1.109113814757201e+00 -5.971975813589350e+00 -6.019762642003853e+00 3.861959446638521e+00 4.587560082894651e+00 9.277786156496422e+03 + 95980 1.081809098172053e+00 -5.894121166286050e+00 -5.991155903634440e+00 4.311652379939859e+00 4.754463902008330e+00 9.189887147745361e+03 + 96000 1.078221948216349e+00 -5.862935280021825e+00 -5.996995129601537e+00 4.454945251415989e+00 4.685152849434607e+00 9.207802917640440e+03 + 96020 1.081558862217963e+00 -5.851515743419196e+00 -6.006215295944041e+00 4.496055155182158e+00 4.607746384906114e+00 9.236091251744854e+03 + 96040 1.127401528394117e+00 -5.913445651057885e+00 -6.014190640726810e+00 4.147258014350912e+00 4.568764693435181e+00 9.260659512598462e+03 + 96060 1.055552559828204e+00 -5.812002525491085e+00 -6.064880627073704e+00 4.671521957703023e+00 4.219456765655880e+00 9.417279930679077e+03 + 96080 1.130972306601564e+00 -5.945616944664599e+00 -6.000552345122031e+00 3.980416286614548e+00 4.664968715962229e+00 9.218761958735084e+03 + 96100 1.111369182245397e+00 -5.953103123369417e+00 -6.024395165472960e+00 3.924786258293592e+00 4.515416320127192e+00 9.292024362689079e+03 + 96120 9.893885185556904e-01 -5.815520610055524e+00 -6.042106530355704e+00 4.658733868547314e+00 4.357642450125836e+00 9.346729852098082e+03 + 96140 1.051862670634859e+00 -5.956117731704899e+00 -5.984065128270547e+00 3.905400625793188e+00 4.744922349867595e+00 9.168195215259211e+03 + 96160 9.283417119796045e-01 -5.811985173621415e+00 -6.043834808258894e+00 4.691986564880271e+00 4.360670084176862e+00 9.352068254927903e+03 + 96180 1.011294722281205e+00 -5.963869350915296e+00 -5.998688155480031e+00 3.919537752669737e+00 4.719602788666434e+00 9.213024955758414e+03 + 96200 9.703717620576815e-01 -5.926332332660968e+00 -6.031045785173411e+00 4.080969921371239e+00 4.479689072690385e+00 9.312588550650691e+03 + 96220 1.096409739541277e+00 -6.132196394081985e+00 -5.976031664987493e+00 3.019054808267827e+00 4.915776849142121e+00 9.143586934124427e+03 + 96240 1.016072688623592e+00 -6.029608472800293e+00 -6.008054794185927e+00 3.510769294602604e+00 4.634533852627277e+00 9.241808268025679e+03 + 96260 9.924840700020298e-01 -6.009041925827677e+00 -6.016677877062117e+00 3.583424052180489e+00 4.539577238532702e+00 9.268331975725370e+03 + 96280 9.854048387739255e-01 -6.010461964639181e+00 -6.014308052653753e+00 3.612770708668936e+00 4.590685876109067e+00 9.261042655056835e+03 + 96300 9.935288714490729e-01 -6.032829058820046e+00 -6.033625313102533e+00 3.451186155617016e+00 4.446613940307025e+00 9.320581943287052e+03 + 96320 9.727182388539276e-01 -6.010512266359568e+00 -6.017634812663887e+00 3.566413728502408e+00 4.525514965412525e+00 9.271296543129289e+03 + 96340 9.754224458997623e-01 -6.022893267152931e+00 -5.961991447253067e+00 3.616714909074529e+00 4.966422583465717e+00 9.100724955625717e+03 + 96360 9.889236694517072e-01 -6.046747594583627e+00 -5.940097363868242e+00 3.491684953807612e+00 5.104087082645215e+00 9.034056801828579e+03 + 96380 9.449063748631743e-01 -5.981338173071087e+00 -5.996427031719628e+00 3.793477111783008e+00 4.706834550429761e+00 9.206057707116455e+03 + 96400 9.739044768494231e-01 -6.019338370139322e+00 -5.968221769211402e+00 3.629262923866241e+00 4.922782356662792e+00 9.119738979966711e+03 + 96420 1.054933501009952e+00 -6.130452753808795e+00 -5.964301627751158e+00 2.978088551992480e+00 4.932154029619086e+00 9.107797616472986e+03 + 96440 1.017794073321612e+00 -6.062517610428988e+00 -5.961314866214977e+00 3.426776756622980e+00 5.007898574973888e+00 9.098691779731053e+03 + 96460 1.020797792913761e+00 -6.049434416534933e+00 -5.986890382699793e+00 3.468155064811289e+00 4.827292585750622e+00 9.176840220674856e+03 + 96480 1.001257765520505e+00 -5.995769825578696e+00 -6.030511492070175e+00 3.774912354743128e+00 4.575420329493543e+00 9.310921851294508e+03 + 96500 1.038434276025251e+00 -6.022367719352156e+00 -6.003529013883140e+00 3.590299657939265e+00 4.698474420022603e+00 9.227884671547487e+03 + 96520 1.025504808314756e+00 -5.969783753447263e+00 -5.973076464228741e+00 3.921966100608751e+00 4.903058845756163e+00 9.134574378493195e+03 + 96540 1.072677968577667e+00 -6.000831304256262e+00 -5.998558585937626e+00 3.710702815315893e+00 4.723753115603522e+00 9.212618602103285e+03 + 96560 1.095302786296916e+00 -5.994270455011972e+00 -5.987816838719159e+00 3.720835585826972e+00 4.757893249274200e+00 9.179688470991663e+03 + 96580 1.028358007370847e+00 -5.863480039842547e+00 -5.982980577682591e+00 4.424124301747113e+00 4.737933720821117e+00 9.164858998354910e+03 + 96600 9.832347912817819e-01 -5.772420010579295e+00 -6.051448693028664e+00 4.891625063070288e+00 4.289399188896954e+00 9.375618255688505e+03 + 96620 1.107453068532686e+00 -5.938322601650185e+00 -6.025725456581798e+00 4.055310023663555e+00 4.553429305098145e+00 9.296195269618338e+03 + 96640 1.112449606997082e+00 -5.939676455317764e+00 -6.035724930240765e+00 4.002986913323099e+00 4.451461706861769e+00 9.327031873052316e+03 + 96660 1.059897499091523e+00 -5.866489016852025e+00 -6.066235285695525e+00 4.372734960255665e+00 4.225760973921086e+00 9.421475014513901e+03 + 96680 1.120820480877841e+00 -5.974265044685089e+00 -6.001014714226912e+00 3.805947726624349e+00 4.652346984617225e+00 9.220161407145495e+03 + 96700 1.089454279627355e+00 -5.956148261151749e+00 -6.023309216789858e+00 3.882040091616202e+00 4.496391491217883e+00 9.288722134482839e+03 + 96720 1.069906729559895e+00 -5.965580098406054e+00 -6.005436717012084e+00 3.870426030712698e+00 4.641563158885078e+00 9.233737807438496e+03 + 96740 1.043508990247900e+00 -5.969424900092102e+00 -6.004017278529783e+00 3.884667918125683e+00 4.686033127983260e+00 9.229381427574233e+03 + 96760 1.011166632010569e+00 -5.964075263382282e+00 -6.009592820816739e+00 3.926722554276737e+00 4.665353695668840e+00 9.246525310595189e+03 + 96780 9.586079153103102e-01 -5.919719719475662e+00 -6.028594408180943e+00 4.151017650994562e+00 4.525842340145214e+00 9.305024289706682e+03 + 96800 1.040330631363890e+00 -6.062523332883125e+00 -5.985210514649765e+00 3.330101038906620e+00 4.774043205322528e+00 9.171722552264686e+03 + 96820 9.729421581900336e-01 -5.973832736935395e+00 -5.977264430677341e+00 3.834472823282517e+00 4.814767506763376e+00 9.147407358582348e+03 + 96840 9.396369078315503e-01 -5.929189973707880e+00 -6.011180833887651e+00 4.091853752154607e+00 4.621049544957756e+00 9.251404771070864e+03 + 96860 1.034843812281773e+00 -6.072618259731017e+00 -5.973592602503372e+00 3.336193266022911e+00 4.904813913994984e+00 9.136173734598786e+03 + 96880 9.824158884151885e-01 -5.997502573147915e+00 -5.976224287605893e+00 3.719725617280395e+00 4.841908825666730e+00 9.144231739903169e+03 + 96900 1.001156834173335e+00 -6.026033411458516e+00 -5.977253685496342e+00 3.631268040693720e+00 4.911368775806726e+00 9.147344090686816e+03 + 96920 1.007891931345409e+00 -6.034538358038922e+00 -5.998003397012369e+00 3.525233771653590e+00 4.735023171635013e+00 9.210918988877731e+03 + 96940 1.007098407954526e+00 -6.030943524984806e+00 -6.000617847623023e+00 3.527028981600580e+00 4.701163713895347e+00 9.218956593683050e+03 + 96960 9.612808908110361e-01 -5.959574551992004e+00 -6.068529014987766e+00 3.874793824714617e+00 4.249160437544299e+00 9.428598359808277e+03 + 96980 1.031954993589612e+00 -6.061832144342191e+00 -6.021467899171175e+00 3.388213007478790e+00 4.619990749597512e+00 9.283082166906346e+03 + 97000 1.036378726145275e+00 -6.066357424520712e+00 -6.015845743474706e+00 3.280751495493969e+00 4.570797384717513e+00 9.265774129637794e+03 + 97020 1.036029069822864e+00 -6.065230580902940e+00 -6.005779771987640e+00 3.335942593203881e+00 4.677318337978482e+00 9.234816597357743e+03 + 97040 9.404101531081076e-01 -5.924167157382690e+00 -6.019035687023232e+00 4.084470857802613e+00 4.539721079749104e+00 9.275590987945481e+03 + 97060 9.900406563156293e-01 -5.994442726360379e+00 -6.026985796925365e+00 3.746934623753522e+00 4.560067276545478e+00 9.300087571943115e+03 + 97080 9.742864723688642e-01 -5.968657448451583e+00 -6.023622690596067e+00 3.824926368290273e+00 4.509307442052915e+00 9.289714019549088e+03 + 97100 1.022132105445313e+00 -6.037219643008910e+00 -5.991226185174514e+00 3.478256712942751e+00 4.742358265292452e+00 9.190149498008097e+03 + 97120 9.812514404447160e-01 -5.973659582967019e+00 -6.045485675862284e+00 3.822958043417093e+00 4.410521502960531e+00 9.357201081528792e+03 + 97140 1.038060528129217e+00 -6.056559679630459e+00 -5.983167029282018e+00 3.355925713035497e+00 4.777357668812177e+00 9.165466984157683e+03 + 97160 9.486416620830903e-01 -5.920284819171554e+00 -6.009603644766901e+00 4.141146017503357e+00 4.628263498891285e+00 9.246548226387198e+03 + 97180 9.918684509515497e-01 -5.978028571109824e+00 -6.016035058391356e+00 3.829568921679187e+00 4.611329790223725e+00 9.266344306936999e+03 + 97200 1.015582348394983e+00 -6.007479928152397e+00 -6.001617982446771e+00 3.624432541685052e+00 4.658092741059921e+00 9.222026375495512e+03 + 97220 9.759961853380476e-01 -5.943682930474230e+00 -6.003948633124224e+00 3.910373598727062e+00 4.564318608023446e+00 9.229179659776757e+03 + 97240 1.028089000485561e+00 -6.014236979297579e+00 -5.977667904246795e+00 3.620672743978099e+00 4.830658031965771e+00 9.148600125899056e+03 + 97260 1.002093439087336e+00 -5.965351848760878e+00 -6.044985620611719e+00 3.832152038637391e+00 4.374882597383493e+00 9.355642721938633e+03 + 97280 1.055828253952275e+00 -6.036427711806555e+00 -5.979352309325706e+00 3.483094812137192e+00 4.810830605572217e+00 9.153790033075797e+03 + 97300 1.023354125046505e+00 -5.980251610050233e+00 -6.001405852215700e+00 3.815915380293631e+00 4.694444448171122e+00 9.221370340040978e+03 + 97320 1.005950163656505e+00 -5.948411879680398e+00 -5.976277172322472e+00 3.976986312121758e+00 4.816979489630867e+00 9.144372528188876e+03 + 97340 9.954983593950929e-01 -5.927436962315335e+00 -5.993310719773792e+00 4.072075267137376e+00 4.693817957879900e+00 9.196497594856270e+03 + 97360 9.663805927182868e-01 -5.878260411315221e+00 -6.020621712488904e+00 4.298792096950613e+00 4.481331475271172e+00 9.280445677996198e+03 + 97380 1.039135458487506e+00 -5.981257475991699e+00 -5.988154942498057e+00 3.801553965073036e+00 4.761947645014036e+00 9.180735612853032e+03 + 97400 1.016387446067543e+00 -5.944997099156629e+00 -6.027993304463122e+00 3.937383321130092e+00 4.460806266638953e+00 9.303199044757770e+03 + 97420 1.025608874154870e+00 -5.958827589938553e+00 -6.000925159988955e+00 3.941048678233263e+00 4.699317916425940e+00 9.219903931442599e+03 + 97440 1.009805214369022e+00 -5.940459251688383e+00 -6.046987179062455e+00 3.978504472440545e+00 4.366804628315138e+00 9.361850269449236e+03 + 97460 1.023363340709830e+00 -5.971588209489104e+00 -6.033979060337178e+00 3.827578268323989e+00 4.469320347801381e+00 9.321641447354290e+03 + 97480 1.041720873108652e+00 -6.016967350926728e+00 -6.001489243547574e+00 3.564215237478492e+00 4.653092925278965e+00 9.221623165121218e+03 + 97500 1.013422150903371e+00 -5.999322544671985e+00 -5.963788065538863e+00 3.695291314310045e+00 4.899335792435305e+00 9.106214044651455e+03 + 97520 9.342291070871626e-01 -5.905889380027936e+00 -6.003907733382897e+00 4.188296303695276e+00 4.625459750439929e+00 9.229033847413806e+03 + 97540 1.016855663514936e+00 -6.053414009425374e+00 -5.952100957309972e+00 3.427174480985132e+00 5.008929704375916e+00 9.070600243675637e+03 + 97560 1.024767104611865e+00 -6.090417561292053e+00 -5.970984307193294e+00 3.169353827671107e+00 4.855158054942524e+00 9.128204245286728e+03 + 97580 1.000260272975639e+00 -6.078688688849730e+00 -5.964563834877937e+00 3.279613063122573e+00 4.934935635392685e+00 9.108585177015744e+03 + 97600 9.304725346149983e-01 -5.997545415305487e+00 -5.953875276335522e+00 3.752465992388611e+00 5.003226688286320e+00 9.076004979783796e+03 + 97620 9.169796653952378e-01 -5.993365187425329e+00 -6.000094026160820e+00 3.725504903658204e+00 4.686866870354588e+00 9.217333161902599e+03 + 97640 1.025821932406502e+00 -6.167258060775763e+00 -5.986142985693388e+00 2.773195305405374e+00 4.813186093995661e+00 9.174584387795068e+03 + 97660 9.453599854273633e-01 -6.057219609415547e+00 -6.021970078219187e+00 3.354485856202717e+00 4.556894119179539e+00 9.284632954096322e+03 + 97680 9.670182214891927e-01 -6.094867799649061e+00 -6.002921010888423e+00 3.195201786644938e+00 4.723174476428099e+00 9.226033745756424e+03 + 97700 9.573803154574950e-01 -6.080853997330145e+00 -5.978699733257242e+00 3.321351592138779e+00 4.907937184766661e+00 9.151790597057106e+03 + 97720 8.997219277259076e-01 -5.989816807575658e+00 -6.007511956577875e+00 3.766115152088827e+00 4.664506868202642e+00 9.240117374272781e+03 + 97740 9.092542263205626e-01 -5.988786692745581e+00 -6.046519713980961e+00 3.776807724202730e+00 4.445295782113011e+00 9.360397999471821e+03 + 97760 9.943108871719148e-01 -6.086909512643415e+00 -5.985170219394599e+00 3.205511061924518e+00 4.789713827863970e+00 9.171596922350278e+03 + 97780 9.741282935597191e-01 -6.016969029707860e+00 -6.000588341043747e+00 3.598455722395959e+00 4.692516171608668e+00 9.218831083666322e+03 + 97800 1.004833120805028e+00 -6.011898567644868e+00 -5.974151326902432e+00 3.631839843337761e+00 4.848590341047456e+00 9.137863259055479e+03 + 97820 1.056163825903645e+00 -6.034557638207314e+00 -6.006733258593833e+00 3.505821816262699e+00 4.665593709812137e+00 9.237737140057623e+03 + 97840 1.054733105380857e+00 -5.990187367172522e+00 -5.995084792977376e+00 3.769629717524261e+00 4.741507940678599e+00 9.201953993149038e+03 + 97860 1.013268255992315e+00 -5.900822688481121e+00 -6.032659106531721e+00 4.136661301354537e+00 4.379636187288235e+00 9.317580801327644e+03 + 97880 1.032726419221796e+00 -5.913086618844668e+00 -6.029078998494480e+00 4.232733031329884e+00 4.566686837617925e+00 9.306529560024870e+03 + 97900 1.080020602257417e+00 -5.977082692947832e+00 -6.018776446877732e+00 3.819858778503597e+00 4.580446791350542e+00 9.274788662196926e+03 + 97920 1.024354983874592e+00 -5.896051419985939e+00 -5.977951404107788e+00 4.250556435546633e+00 4.780274052737396e+00 9.149450678008354e+03 + 97940 1.011721189972254e+00 -5.882865579186493e+00 -5.982734179778094e+00 4.310288203705797e+00 4.736827244492830e+00 9.164068891005500e+03 + 97960 1.032120649162857e+00 -5.921344383637122e+00 -5.998492506956529e+00 4.100382539905482e+00 4.657386077171947e+00 9.212397663085736e+03 + 97980 1.058130449404922e+00 -5.971364654642876e+00 -6.018950878014544e+00 3.833026023014181e+00 4.559778564469797e+00 9.275328397215368e+03 + 98000 1.086241297103687e+00 -6.031482933205994e+00 -5.999808588500024e+00 3.517361493379726e+00 4.699240482270408e+00 9.216461113288373e+03 + 98020 1.035048605066627e+00 -5.978908522875317e+00 -6.014422500389925e+00 3.863711148803680e+00 4.659784394144546e+00 9.261390084200510e+03 + 98040 1.000747049994686e+00 -5.957052386290765e+00 -6.024724609371027e+00 3.950686418407725e+00 4.562102041238183e+00 9.293106318749455e+03 + 98060 1.009892016307315e+00 -6.001715208576660e+00 -6.019720403776851e+00 3.655617388726736e+00 4.552228771592284e+00 9.277684230724462e+03 + 98080 9.892178546983000e-01 -5.999912412806907e+00 -6.002815504241202e+00 3.700196268793599e+00 4.683526268525935e+00 9.225693041294609e+03 + 98100 9.777042262457334e-01 -6.006902449413445e+00 -5.985819898570648e+00 3.676751994124003e+00 4.797811263577547e+00 9.173568583566599e+03 + 98120 1.021917104519383e+00 -6.091735907327273e+00 -5.956314341909967e+00 3.241063898824307e+00 5.018675483870000e+00 9.083427662058895e+03 + 98140 9.654364768872122e-01 -6.021881467193346e+00 -5.994918198476523e+00 3.595878542952968e+00 4.750705804477319e+00 9.201457204795652e+03 + 98160 9.383185861281028e-01 -5.990029823192927e+00 -6.020782224132443e+00 3.715459478720731e+00 4.538874433607367e+00 9.280973891482708e+03 + 98180 9.558743401397163e-01 -6.020008030079822e+00 -6.043439778345689e+00 3.581375353388922e+00 4.446826628794990e+00 9.350890199371897e+03 + 98200 9.166454988889265e-01 -5.963588976646081e+00 -6.020444834499007e+00 3.876206197532130e+00 4.549731063325059e+00 9.279921554442937e+03 + 98220 9.941934652382416e-01 -6.076732609604775e+00 -5.974982428886404e+00 3.325448278890172e+00 4.909713562364635e+00 9.140404200020299e+03 + 98240 9.560982347201821e-01 -6.013896624158678e+00 -6.030708542546655e+00 3.578665664197303e+00 4.482129027177570e+00 9.311556441575831e+03 + 98260 9.180798101032112e-01 -5.949788755356236e+00 -6.047451210296520e+00 3.922043447545532e+00 4.361250518062365e+00 9.363306365094897e+03 + 98280 1.011677565853188e+00 -6.080323865163775e+00 -5.995348934304009e+00 3.253705757133587e+00 4.741644959958416e+00 9.202777199217830e+03 + 98300 1.015279689861760e+00 -6.077377682161002e+00 -5.964768830542696e+00 3.296863792085935e+00 4.943481244241713e+00 9.109212408891106e+03 + 98320 9.347986949512265e-01 -5.949678684120199e+00 -5.967414472218403e+00 3.960870383425382e+00 4.859028743561161e+00 9.117279062497752e+03 + 98340 9.803084712194277e-01 -6.006612706188418e+00 -6.004864566937673e+00 3.677180226884425e+00 4.687218312985874e+00 9.231980410676390e+03 + 98360 1.016486201970173e+00 -6.052934301087515e+00 -5.976857341623308e+00 3.411511700474517e+00 4.848357374589422e+00 9.146139826526825e+03 + 98380 1.018034409026686e+00 -6.048116394973777e+00 -5.946472563686092e+00 3.439041285706209e+00 5.022695894292150e+00 9.053462244238783e+03 + 98400 1.006579204881909e+00 -6.022043226259854e+00 -5.983437765972235e+00 3.599368008405599e+00 4.821046535552773e+00 9.166270582270599e+03 + 98420 1.001960338544776e+00 -6.007841311456181e+00 -5.996798358973331e+00 3.655626031230433e+00 4.719036373278331e+00 9.207224264470082e+03 + 98440 1.023173175049365e+00 -6.033903117643932e+00 -6.011214177019870e+00 3.475899691742694e+00 4.606183099908279e+00 9.251521320908010e+03 + 98460 1.032064887024564e+00 -6.044188034693698e+00 -6.016021791008096e+00 3.467691467747521e+00 4.629426397702371e+00 9.266310583296148e+03 + 98480 9.838649092937497e-01 -5.971110518674235e+00 -6.046238118586615e+00 3.870776927680893e+00 4.439382623025491e+00 9.359538476989213e+03 + 98500 1.062977796188171e+00 -6.088573549397275e+00 -5.988330403100729e+00 3.242808862960995e+00 4.818420521572520e+00 9.181280154654934e+03 + 98520 9.688415151358940e-01 -5.950206158801372e+00 -6.023893124155618e+00 3.930494192415849e+00 4.507372234330735e+00 9.290521037461427e+03 + 98540 9.731938621291863e-01 -5.956984171497677e+00 -5.988019825056993e+00 3.968891148847415e+00 4.790679623357958e+00 9.180315016524335e+03 + 98560 1.025279243158647e+00 -6.033344135429354e+00 -6.022340076777047e+00 3.536399404618086e+00 4.599586412272204e+00 9.285751820189274e+03 + 98580 9.889443800818339e-01 -5.979764063390302e+00 -6.035225380937530e+00 3.801660915840567e+00 4.483193447873230e+00 9.325506084268114e+03 + 98600 1.109117721324901e+00 -6.160022430573275e+00 -5.937477564817668e+00 2.828365429752642e+00 5.106252487628016e+00 9.026125675403640e+03 + 98620 1.011477476738488e+00 -6.018533954274060e+00 -6.020683476060125e+00 3.554482887767085e+00 4.542140001034085e+00 9.280644339621796e+03 + 98640 9.713926328542308e-01 -5.964035622650325e+00 -6.001767505006172e+00 3.888333264851116e+00 4.671670957373919e+00 9.222464502890740e+03 + 98660 1.009774659165376e+00 -6.025222776966777e+00 -5.989725659947472e+00 3.571317836634397e+00 4.775147775720351e+00 9.185540797784803e+03 + 98680 1.026127126548551e+00 -6.055558882801074e+00 -6.051617505956560e+00 3.429673698996872e+00 4.452305694764171e+00 9.376207206549667e+03 + 98700 1.008889353842767e+00 -6.043077543416180e+00 -6.006291711750006e+00 3.419456152875053e+00 4.630686090891275e+00 9.236406216502153e+03 + 98720 9.569590893644143e-01 -5.983805666743640e+00 -6.023593683663442e+00 3.857299957048384e+00 4.628831006719163e+00 9.289622756118846e+03 + 98740 9.764601836113681e-01 -6.035633968324732e+00 -6.021698634575593e+00 3.450611467495096e+00 4.530630310368585e+00 9.283796444207037e+03 + 98760 9.304880850891646e-01 -5.992819039784822e+00 -6.026123770010968e+00 3.705741104608923e+00 4.514500189760044e+00 9.297413515795582e+03 + 98780 9.914145825476826e-01 -6.106875530365093e+00 -5.985359078872954e+00 3.069677051601227e+00 4.767443320679183e+00 9.172168613566726e+03 + 98800 9.398019906108321e-01 -6.050047591734813e+00 -5.964545779867475e+00 3.448618534775630e+00 4.939583169880512e+00 9.108526863033694e+03 + 98820 9.399723877516333e-01 -6.063114740046742e+00 -5.994635390498774e+00 3.427658349292085e+00 4.820877371541607e+00 9.200577284727487e+03 + 98840 1.011397549967698e+00 -6.178412494135690e+00 -5.972177331274970e+00 2.773839762780090e+00 4.958073982714651e+00 9.131853960781244e+03 + 98860 9.552732162407155e-01 -6.099642036485355e+00 -6.013198940132094e+00 3.218143102352305e+00 4.714512738638656e+00 9.257620856952559e+03 + 98880 9.834698449498362e-01 -6.141370783699291e+00 -5.977877053390548e+00 2.977619637214818e+00 4.916425937220612e+00 9.149275766112363e+03 + 98900 9.359947995476768e-01 -6.063524623163916e+00 -6.004728172962272e+00 3.364913748162338e+00 4.702532063941439e+00 9.231563398098811e+03 + 98920 9.533481654789383e-01 -6.073496107505829e+00 -6.008180482671216e+00 3.351318393725427e+00 4.726370819086051e+00 9.242181391787384e+03 + 98940 9.693821374461716e-01 -6.073120674234650e+00 -6.028141928414927e+00 3.308705656860747e+00 4.566980575796016e+00 9.303632682308049e+03 + 98960 9.333691044770499e-01 -5.989156438382777e+00 -6.013948475502481e+00 3.781007062376775e+00 4.638647348680085e+00 9.259920622347607e+03 + 98980 9.546576982955435e-01 -5.983648159822955e+00 -6.019341289240465e+00 3.780862410193710e+00 4.575906937584441e+00 9.276501147878176e+03 + 99000 1.018439629242023e+00 -6.041480580309550e+00 -5.983521991842025e+00 3.466799179263270e+00 4.799606363306378e+00 9.166525518643779e+03 + 99020 9.863488100968217e-01 -5.956794143984110e+00 -6.015554692586876e+00 3.969559274498756e+00 4.632147111256169e+00 9.264845420579577e+03 + 99040 9.516775855365567e-01 -5.876726472218452e+00 -6.022043583847335e+00 4.322361634513771e+00 4.487928291790380e+00 9.284829973038497e+03 + 99060 1.033613013563563e+00 -5.975425594641683e+00 -6.013299576338454e+00 3.798924569872923e+00 4.581446305990334e+00 9.257895731208357e+03 + 99080 1.049984179185843e+00 -5.983628870446120e+00 -5.991126311728619e+00 3.810386635555044e+00 4.767335167485644e+00 9.189836143322880e+03 + 99100 1.042008482197529e+00 -5.963073166024972e+00 -6.038403955745011e+00 3.847092187449437e+00 4.414531135474938e+00 9.335322343273265e+03 + 99120 1.075674875929916e+00 -6.010775418098726e+00 -6.008433732229475e+00 3.634650941539628e+00 4.648097264175583e+00 9.242980697833813e+03 + 99140 9.646655243879321e-01 -5.850270166653583e+00 -6.008140637907883e+00 4.484103444506678e+00 4.577586768188021e+00 9.242056467078224e+03 + 99160 1.072342082965299e+00 -6.017103570000937e+00 -5.950896853096074e+00 3.647177721345496e+00 5.027346935269547e+00 9.066913947087336e+03 + 99180 1.037737491505471e+00 -5.973173706418223e+00 -5.998958406089165e+00 3.896621267197399e+00 4.748561531517471e+00 9.213805266073405e+03 + 99200 1.027433843080161e+00 -5.969437554815718e+00 -5.993596830141030e+00 3.862249135718316e+00 4.723522838164599e+00 9.197380704990412e+03 + 99220 9.846170484161580e-01 -5.920742453461324e+00 -5.970730720650545e+00 4.180111931310949e+00 4.893071565451097e+00 9.127364727531796e+03 + 99240 9.895934382872804e-01 -5.939548397415880e+00 -5.978416166312192e+00 4.014227851670335e+00 4.791043107899914e+00 9.150856411870680e+03 + 99260 1.041022485854301e+00 -6.028422371271283e+00 -5.953881005370402e+00 3.602207361892394e+00 5.030235420134344e+00 9.075991580577260e+03 + 99280 9.792232012530421e-01 -5.950859183757307e+00 -5.983256548624174e+00 4.026216267507900e+00 4.840185584966342e+00 9.165715806762391e+03 + 99300 9.821865589147838e-01 -5.970589095443183e+00 -5.985675029354387e+00 3.889853776697830e+00 4.803228009638968e+00 9.173135459615794e+03 + 99320 9.689637035943613e-01 -5.967254762436105e+00 -6.043444744256401e+00 3.854955984489136e+00 4.417461318515414e+00 9.350901723513800e+03 + 99340 1.012457554894574e+00 -6.053410241202108e+00 -6.037709930756126e+00 3.390319752935341e+00 4.480473365131355e+00 9.333191332352697e+03 + 99360 9.848320747893614e-01 -6.043981835951585e+00 -6.030821240369866e+00 3.428810506439684e+00 4.504380682865497e+00 9.311902090165106e+03 + 99380 9.289315747228593e-01 -6.001801786827794e+00 -5.948792679237060e+00 3.726045038570493e+00 5.030431537489372e+00 9.060497751970619e+03 + 99400 9.832856144495494e-01 -6.125391013778289e+00 -5.928341386363908e+00 3.111268351044263e+00 5.242757804988935e+00 8.998366115150327e+03 + 99420 9.229085108338503e-01 -6.080169105957109e+00 -5.969378208910173e+00 3.275363215748874e+00 4.911541691428289e+00 9.123285065993838e+03 + 99440 9.676131680357130e-01 -6.183709504425654e+00 -5.957893914227633e+00 2.718186345827899e+00 5.014854409594583e+00 9.088252429156388e+03 + 99460 8.470242386520049e-01 -6.032024597081533e+00 -5.982730988547097e+00 3.519099763431526e+00 4.802151291797532e+00 9.164128284797434e+03 + 99480 9.375728200385016e-01 -6.179385710587024e+00 -5.942653052889482e+00 2.752111802565556e+00 5.111467357325223e+00 9.041839345920534e+03 + 99500 9.230289450261584e-01 -6.157856929154686e+00 -5.963149460779490e+00 2.850340934820891e+00 4.968381349114622e+00 9.104263603668136e+03 + 99520 8.644103461956270e-01 -6.060802825647688e+00 -5.977187989515356e+00 3.406241104045022e+00 4.886370432470947e+00 9.147152237251901e+03 + 99540 1.023420106567433e+00 -6.278289065314835e+00 -5.919143092517972e+00 2.242627034187699e+00 5.304898787646961e+00 8.970509526300491e+03 + 99560 9.435993826731099e-01 -6.135537611855659e+00 -5.958474095705769e+00 3.016770390492985e+00 5.033496500716224e+00 9.090004595709341e+03 + 99580 9.065196310521605e-01 -6.056443740449343e+00 -5.952394114295688e+00 3.412801416916210e+00 5.010270471918105e+00 9.071474449723557e+03 + 99600 9.002181599584330e-01 -6.022093884574368e+00 -5.970686056404075e+00 3.535107738969026e+00 4.830299443658547e+00 9.127282500799365e+03 + 99620 9.491513108036221e-01 -6.071305638715417e+00 -5.984253689658770e+00 3.284188227190291e+00 4.784053989919138e+00 9.168786508465229e+03 + 99640 1.037491260037351e+00 -6.182416157464623e+00 -5.967934144753496e+00 2.701140930929527e+00 4.932729838901016e+00 9.118910969250155e+03 + 99660 9.883595317496171e-01 -6.093586996888038e+00 -5.989435944826707e+00 3.202196000247847e+00 4.800247458507229e+00 9.184657783372773e+03 + 99680 9.763674946575179e-01 -6.060717661582409e+00 -5.975190304962585e+00 3.386631472979597e+00 4.877742790006284e+00 9.141046845082537e+03 + 99700 9.179109881816536e-01 -5.957781746552671e+00 -5.959524114113943e+00 4.018369948034296e+00 5.008365003866964e+00 9.093194510515801e+03 + 99720 9.188808026055826e-01 -5.939502891706711e+00 -5.990994473617492e+00 4.014224504053912e+00 4.718551872425655e+00 9.189415838096182e+03 + 99740 1.024683736701595e+00 -6.071821253232845e+00 -5.967791395113461e+00 3.293303719638292e+00 4.890659263528312e+00 9.118451332961002e+03 + 99760 9.819498392664172e-01 -5.982504899077096e+00 -6.035991311279027e+00 3.756642031608098e+00 4.449514775749070e+00 9.327877236368000e+03 + 99780 9.997821708094877e-01 -5.986194105923122e+00 -6.011097188303387e+00 3.731617048518482e+00 4.588619695751459e+00 9.251162800153634e+03 + 99800 1.024245285853939e+00 -6.003374220481877e+00 -5.978043535905368e+00 3.694055390855346e+00 4.839508101604430e+00 9.149783710889216e+03 + 99820 1.071870604990866e+00 -6.056917850869024e+00 -5.974441675459739e+00 3.437525864194666e+00 4.911116826541671e+00 9.138735318413077e+03 + 99840 1.080585962653374e+00 -6.055020344708323e+00 -5.969847357662749e+00 3.407112492240884e+00 4.896188964333717e+00 9.124730211591563e+03 + 99860 9.948774790052167e-01 -5.916724131353305e+00 -6.000332859748397e+00 4.116423026973928e+00 4.636328770120412e+00 9.218067217463598e+03 + 99880 9.809240766969762e-01 -5.887570293302043e+00 -6.009656143719923e+00 4.322533898716941e+00 4.621498052893187e+00 9.246699510198116e+03 + 99900 1.047960298437937e+00 -5.979785348453349e+00 -6.004660433010118e+00 3.784556771529712e+00 4.641720186597854e+00 9.231360849205670e+03 + 99920 9.491438232482513e-01 -5.827580878121333e+00 -6.062551541954725e+00 4.607477634025312e+00 4.258239720701268e+00 9.410043469910279e+03 + 99940 1.035680305374418e+00 -5.954232437019303e+00 -5.974280499630940e+00 3.964436979538566e+00 4.849317901594889e+00 9.138264798347460e+03 + 99960 1.079823252796725e+00 -6.021992986434533e+00 -5.973915986796042e+00 3.623728368154147e+00 4.899793939970010e+00 9.137107593449897e+03 + 99980 1.034413408897987e+00 -5.963172288366274e+00 -6.022476536129452e+00 3.858483228189965e+00 4.517949060231115e+00 9.286160394321949e+03 + 100000 1.041207184364491e+00 -5.988325168921166e+00 -6.001447071139587e+00 3.718904485222335e+00 4.643556492076350e+00 9.221507329915157e+03 + 100020 1.022348321133684e+00 -5.984531686920860e+00 -5.964030148315187e+00 3.755977026048429e+00 4.873700033325055e+00 9.106952201848933e+03 + 100040 9.494709868764378e-01 -5.909385921835007e+00 -5.986199300672633e+00 4.156473336513010e+00 4.715399028395405e+00 9.174695908655187e+03 + 100060 9.552362754020651e-01 -5.954181179590964e+00 -5.952515552864179e+00 3.947265264491965e+00 4.956829550912066e+00 9.071837855241440e+03 + 100080 9.576640860223434e-01 -5.995450705437397e+00 -6.010303577597016e+00 3.691549961681881e+00 4.606262471266813e+00 9.248685237753740e+03 + 100100 9.546069367674995e-01 -6.025759841550142e+00 -6.019928069851500e+00 3.554146477063239e+00 4.587633412620598e+00 9.278323576733506e+03 + 100120 1.021162330940387e+00 -6.156097944634729e+00 -5.998904872956183e+00 2.861393704337067e+00 4.764020647464504e+00 9.213696645106451e+03 + 100140 9.127286409704853e-01 -6.019566623678919e+00 -6.007302767943694e+00 3.618584438286073e+00 4.689005395743280e+00 9.239477272204920e+03 + 100160 9.672505282522870e-01 -6.116300109043177e+00 -5.967011015517226e+00 3.077911087937123e+00 4.935152165375696e+00 9.116058469146552e+03 + 100180 9.767787122327640e-01 -6.137654833093974e+00 -5.980725346335312e+00 2.968148277011130e+00 4.869261674738956e+00 9.157998228646351e+03 + 100200 8.862431902802509e-01 -6.003634622454971e+00 -6.029366184915851e+00 3.676042558150514e+00 4.528287944553719e+00 9.307433878232479e+03 + 100220 9.310894656424905e-01 -6.064804108911623e+00 -5.999364237017378e+00 3.365109807351475e+00 4.740875678555678e+00 9.215098897185258e+03 + 100240 9.261790683031853e-01 -6.045323937586662e+00 -5.988180954322764e+00 3.473337347816106e+00 4.801461200565493e+00 9.180810741135667e+03 + 100260 1.035722596857402e+00 -6.190445102667603e+00 -5.951821251452474e+00 2.680982811306113e+00 5.051197891905018e+00 9.069741652847726e+03 + 100280 9.302069900803720e-01 -6.009329750935526e+00 -5.974446861998006e+00 3.624120415879041e+00 4.824423362267902e+00 9.138775984705879e+03 + 100300 1.003159853886130e+00 -6.089793841735156e+00 -5.959049992551279e+00 3.231347168248717e+00 4.982098582807811e+00 9.091737324833688e+03 + 100320 9.360791089747031e-01 -5.957474788065740e+00 -6.001127296159565e+00 3.944780537170216e+00 4.694121080491680e+00 9.220496522220108e+03 + 100340 9.713979019986416e-01 -5.978380220088479e+00 -5.980601351785847e+00 3.821300168544986e+00 4.808546086619677e+00 9.157595934443465e+03 + 100360 1.009346031850552e+00 -6.009535435875813e+00 -5.976044612365881e+00 3.630865973412589e+00 4.823175464694812e+00 9.143675327450466e+03 + 100380 1.020385120993425e+00 -6.005692622041028e+00 -6.010874602876418e+00 3.688950840733790e+00 4.659195104868040e+00 9.250447836091249e+03 + 100400 9.675196126101391e-01 -5.917010245237988e+00 -5.991122244942927e+00 4.131090023544649e+00 4.705527452444001e+00 9.189788495238974e+03 + 100420 1.012712470525639e+00 -5.978665649181520e+00 -5.969669550165827e+00 3.830097700768075e+00 4.881754693458001e+00 9.124136608938616e+03 + 100440 1.024555908066439e+00 -5.991253018589271e+00 -5.997777020949138e+00 3.734847294445896e+00 4.697385463309440e+00 9.210222505632204e+03 + 100460 1.001058985431365e+00 -5.953661443697609e+00 -6.030819610881124e+00 3.970294162174649e+00 4.527240026019125e+00 9.311904659785929e+03 + 100480 9.965409722110948e-01 -5.947567796381205e+00 -6.035831053839189e+00 3.953550390677042e+00 4.446729107658350e+00 9.327363046615499e+03 + 100500 1.019531831148716e+00 -5.985416760398266e+00 -6.006388806199202e+00 3.742488310296382e+00 4.622063577893808e+00 9.236678731158428e+03 + 100520 9.686265208747582e-01 -5.914349471576263e+00 -6.028177987660484e+00 4.099858645857575e+00 4.446237691596046e+00 9.303728860586480e+03 + 100540 9.991991037323487e-01 -5.964970291152945e+00 -6.021201151565627e+00 3.856796053500410e+00 4.533909751313263e+00 9.282230029971422e+03 + 100560 1.055770651779741e+00 -6.057562036625112e+00 -5.958893541889578e+00 3.394234321919237e+00 4.960804087590882e+00 9.091281564767047e+03 + 100580 9.528416349981925e-01 -5.913790603966494e+00 -6.007614071535003e+00 4.143374274662492e+00 4.604625404749434e+00 9.240432139431956e+03 + 100600 1.063340165556967e+00 -6.085911621436664e+00 -5.956312199020678e+00 3.244711718260656e+00 4.988891657219051e+00 9.083432957739478e+03 + 100620 9.556914152180930e-01 -5.935515979324164e+00 -6.023244936355621e+00 4.002096490616372e+00 4.498343243329523e+00 9.288548886130329e+03 + 100640 9.910977621910929e-01 -5.998300223472199e+00 -6.029185819067926e+00 3.706008276989412e+00 4.528658407548281e+00 9.306878835646454e+03 + 100660 1.046120672779060e+00 -6.094519698972517e+00 -6.004686425419096e+00 3.193147061385962e+00 4.708983619783861e+00 9.231473901550362e+03 + 100680 9.758419824082297e-01 -6.008239921372698e+00 -6.002782131093825e+00 3.682519223039108e+00 4.713858699410714e+00 9.225592398940364e+03 + 100700 9.627234239416229e-01 -6.009561925318659e+00 -5.999306308063094e+00 3.659575105290434e+00 4.718464446623530e+00 9.214915527475910e+03 + 100720 9.256857817885412e-01 -5.974661764186345e+00 -6.013904506427108e+00 3.849535889551638e+00 4.624197990810437e+00 9.259760809151632e+03 + 100740 9.662812947742361e-01 -6.054014563571669e+00 -6.025129737241236e+00 3.442482660353172e+00 4.608343803054947e+00 9.294351523207959e+03 + 100760 9.210246700371897e-01 -6.008571042252274e+00 -6.028135888635472e+00 3.652520125237358e+00 4.540175749654844e+00 9.303616602991498e+03 + 100780 9.404074580917622e-01 -6.058182843204968e+00 -5.995689157972770e+00 3.360432645908134e+00 4.719281057377955e+00 9.203784084772571e+03 + 100800 9.645549645652095e-01 -6.110416695600677e+00 -5.967628653146507e+00 3.159989029779607e+00 4.979900065929613e+00 9.117937227834778e+03 + 100820 9.402680513652617e-01 -6.088012683307513e+00 -6.000388938185334e+00 3.241624717279698e+00 4.744773821501985e+00 9.218253664613865e+03 + 100840 8.767945419562222e-01 -6.004105597471897e+00 -5.977960686518763e+00 3.616078749338293e+00 4.766206873943082e+00 9.149533296680347e+03 + 100860 9.254859406422815e-01 -6.078558879391219e+00 -5.959273242860528e+00 3.242923764837246e+00 4.927880349189070e+00 9.092459200831026e+03 + 100880 9.405244365861735e-01 -6.094992975314524e+00 -5.945252343660373e+00 3.168202857905694e+00 5.028036737151686e+00 9.049739707017350e+03 + 100900 9.578699414557837e-01 -6.102335614339848e+00 -5.946149244124996e+00 3.104210445287207e+00 5.001056752823571e+00 9.052460410268694e+03 + 100920 9.388507852816931e-01 -6.042303920617139e+00 -5.938851008647887e+00 3.501676949361337e+00 5.095719579175162e+00 9.030279500674193e+03 + 100940 9.409266990560816e-01 -5.999117434220943e+00 -5.982950585577962e+00 3.677899957775336e+00 4.770732504495076e+00 9.164793867840744e+03 + 100960 9.884077981781987e-01 -6.018809495624783e+00 -5.988334945373238e+00 3.616139390640699e+00 4.791128974106487e+00 9.181273704878469e+03 + 100980 1.017507092451332e+00 -6.016815298606163e+00 -6.002871316493534e+00 3.587602291816578e+00 4.667670794931551e+00 9.225880923203606e+03 + 101000 9.778716542663625e-01 -5.927013705404904e+00 -6.029675590679608e+00 4.084163639905897e+00 4.494663207783149e+00 9.308389589205621e+03 + 101020 9.972275875896273e-01 -5.932890122860426e+00 -6.072589091493946e+00 3.999031569122879e+00 4.196858472883683e+00 9.441208149905924e+03 + 101040 1.075577846317902e+00 -6.034746471689515e+00 -6.041623894025109e+00 3.480032845748368e+00 4.440541622419724e+00 9.345278580546701e+03 + 101060 1.050547986501148e+00 -5.991640786851642e+00 -6.024459374446158e+00 3.708082287878821e+00 4.519632879251092e+00 9.292305752050112e+03 + 101080 1.000229225500147e+00 -5.917583464997133e+00 -5.991043075197593e+00 4.247420104932469e+00 4.825603655323487e+00 9.189558201209102e+03 + 101100 9.556060059994539e-01 -5.854508362419913e+00 -6.012166862793714e+00 4.458813196840723e+00 4.553513690120274e+00 9.254392976090381e+03 + 101120 1.026480755099830e+00 -5.961283565508754e+00 -5.995604018342526e+00 3.896992766720401e+00 4.699919415475977e+00 9.203529334148372e+03 + 101140 1.040768731417746e+00 -5.987304336350205e+00 -5.993911527006718e+00 3.762114729176772e+00 4.724175217967630e+00 9.198364920270264e+03 + 101160 1.049215557843379e+00 -6.007923151618461e+00 -6.024375014171662e+00 3.645225445367191e+00 4.550756304669203e+00 9.292015490960233e+03 + 101180 1.032833808021148e+00 -5.996620294487396e+00 -6.024779789720190e+00 3.676553008750127e+00 4.514856829455621e+00 9.293291872071213e+03 + 101200 1.030105758376669e+00 -6.011669400018858e+00 -6.039363388250905e+00 3.633752103797697e+00 4.474728937738456e+00 9.338278033086610e+03 + 101220 1.055278779035816e+00 -6.074736193368164e+00 -6.001842904161145e+00 3.337778586345041e+00 4.756343133171793e+00 9.222716226152059e+03 + 101240 9.982509060564314e-01 -6.019309380211361e+00 -6.003508616852596e+00 3.604478963515815e+00 4.695209391882070e+00 9.227812453510120e+03 + 101260 9.734106892519498e-01 -6.013048833908670e+00 -6.000190152317533e+00 3.640144534120899e+00 4.713981073691754e+00 9.217632023031672e+03 + 101280 9.590710966190135e-01 -6.021688603862037e+00 -6.007842673228378e+00 3.565929805137581e+00 4.645435281486889e+00 9.241150871535910e+03 + 101300 9.282799370537971e-01 -6.002045596407217e+00 -6.032851704535552e+00 3.651840574922210e+00 4.474947134819484e+00 9.318161286717352e+03 + 101320 9.173710272043901e-01 -6.007157086449578e+00 -5.980661378748843e+00 3.628837570717960e+00 4.780980024533092e+00 9.157791736874748e+03 + 101340 9.675200451290068e-01 -6.099228631177536e+00 -5.969334201782591e+00 3.217204440286755e+00 4.963078354970516e+00 9.123115688489856e+03 + 101360 9.276416470822580e-01 -6.049073300039749e+00 -5.933241691003042e+00 3.465546163168426e+00 5.130669187140767e+00 9.013249017306065e+03 + 101380 9.359439221692375e-01 -6.061417613429819e+00 -5.977137590409339e+00 3.369426290902069e+00 4.853375225377079e+00 9.146974931764038e+03 + 101400 9.235031183164275e-01 -6.034209756143017e+00 -5.990200072155032e+00 3.531500928440607e+00 4.784211344376203e+00 9.186967271292586e+03 + 101420 9.378794844345663e-01 -6.039578097808431e+00 -5.982539667691618e+00 3.524357420544069e+00 4.851880912943340e+00 9.163531282919741e+03 + 101440 1.013998135393958e+00 -6.124771690625905e+00 -5.983772191770639e+00 3.013583663027610e+00 4.823224605056481e+00 9.167316665170300e+03 + 101460 1.009875826010160e+00 -6.075706356621081e+00 -5.974200954270001e+00 3.303369446460396e+00 4.886229174670552e+00 9.138039416765994e+03 + 101480 9.814330969212192e-01 -5.975091738248711e+00 -6.028677540779501e+00 3.806718271738408e+00 4.499020301230471e+00 9.305295467413340e+03 + 101500 1.028544188263586e+00 -5.980922410534715e+00 -6.033683827717725e+00 3.764505623880129e+00 4.461541401612363e+00 9.320748965093346e+03 + 101520 1.023590946061820e+00 -5.924741813342534e+00 -6.006172399573021e+00 4.108639359200025e+00 4.641052331722072e+00 9.235973376661836e+03 + 101540 1.023587068762781e+00 -5.897514494897142e+00 -5.964094830136259e+00 4.285002491042430e+00 4.902687902825845e+00 9.107122505774658e+03 + 101560 1.064153751624140e+00 -5.946076563874168e+00 -5.972927618156721e+00 3.953669939555938e+00 4.799487030678302e+00 9.134110294208376e+03 + 101580 1.044248030803778e+00 -5.911285131881916e+00 -6.000532815248845e+00 4.177438452247864e+00 4.664964443320589e+00 9.218662993828262e+03 + 101600 1.097385986535176e+00 -5.990930833488832e+00 -5.993126546171341e+00 3.724810843648297e+00 4.712202721639893e+00 9.195969411703642e+03 + 101620 1.052996237384245e+00 -5.933551586461709e+00 -6.038435182766503e+00 4.009945335524128e+00 4.407687494857929e+00 9.335404834808711e+03 + 101640 1.097157992515703e+00 -6.014218694096678e+00 -5.966705987869021e+00 3.660433033637044e+00 4.933258345363777e+00 9.115131161407762e+03 + 101660 1.006633849161655e+00 -5.900040718581222e+00 -5.996830927722108e+00 4.319879163088270e+00 4.764094803964841e+00 9.207295130670431e+03 + 101680 1.050736694199744e+00 -5.989788756733670e+00 -5.955231938725676e+00 3.766655080912535e+00 4.965085677564741e+00 9.080141386704230e+03 + 101700 1.036251115463038e+00 -5.994723545775885e+00 -5.994930009203591e+00 3.737736382509174e+00 4.736550837557171e+00 9.201467470123620e+03 + 101720 9.648444674129945e-01 -5.915385236515382e+00 -6.006613683567605e+00 4.187954469513887e+00 4.664106608983468e+00 9.237334820954780e+03 + 101740 1.059481571748788e+00 -6.080584499431502e+00 -5.954935027136213e+00 3.242579954578750e+00 4.964078668691299e+00 9.079226215403429e+03 + 101760 1.012258724398190e+00 -6.033527902123264e+00 -5.965547000861017e+00 3.541177297551902e+00 4.931534152610199e+00 9.111564368160298e+03 + 101780 9.957231965811424e-01 -6.027790159890378e+00 -6.004882011039633e+00 3.591005348017766e+00 4.722547483743316e+00 9.232044468075566e+03 + 101800 9.737138259185678e-01 -6.014803675328157e+00 -6.054814891406533e+00 3.608685853924567e+00 4.378935259486854e+00 9.386069692502624e+03 + 101820 1.040091966183514e+00 -6.132303217670631e+00 -5.985079307618285e+00 2.985298670621598e+00 4.830681144968617e+00 9.171314615723510e+03 + 101840 9.672189405814190e-01 -6.039921993898893e+00 -6.000055268136643e+00 3.493563543143074e+00 4.722484451825780e+00 9.217228101699657e+03 + 101860 9.006165840812461e-01 -5.952696444758821e+00 -6.037006371843027e+00 3.939994914164436e+00 4.455874265927877e+00 9.330994046283002e+03 + 101880 9.754586089618118e-01 -6.071026909320604e+00 -5.973512703243737e+00 3.305233226472873e+00 4.865174888040865e+00 9.135929330973004e+03 + 101900 9.430053054853322e-01 -6.024231957708286e+00 -5.994578612004271e+00 3.618267090647351e+00 4.788541190520226e+00 9.200414655786139e+03 + 101920 9.613526349351434e-01 -6.048681543839590e+00 -5.967945484144638e+00 3.468366215725578e+00 4.931965164358850e+00 9.118896978334493e+03 + 101940 9.452230110491117e-01 -6.015544042695625e+00 -5.995420083379454e+00 3.591610408453808e+00 4.707165297019902e+00 9.202987502726213e+03 + 101960 1.030347513780783e+00 -6.124845572565430e+00 -5.978275492450869e+00 3.023403684186217e+00 4.865031765850619e+00 9.150496951678913e+03 + 101980 9.778282438294913e-01 -6.020308058382945e+00 -6.010099215173690e+00 3.585971592753805e+00 4.644592350274728e+00 9.248081974288141e+03 + 102000 9.818956271789786e-01 -5.989172483123881e+00 -5.974870981308037e+00 3.757933194663202e+00 4.840054631240035e+00 9.140075451597018e+03 + 102020 1.035936468243275e+00 -6.015863931789585e+00 -6.006052016267946e+00 3.605751705207827e+00 4.662093242522101e+00 9.235626186439200e+03 + 102040 1.057089294233649e+00 -5.991150114559504e+00 -6.005859781530422e+00 3.781990793565551e+00 4.697525609504938e+00 9.235052220856733e+03 + 102060 1.051347376504525e+00 -5.937419495905473e+00 -6.046196113768684e+00 4.044612094877625e+00 4.419999921979855e+00 9.359383191979805e+03 + 102080 1.084981875516398e+00 -5.959761527331171e+00 -5.995689298594645e+00 3.928487970289075e+00 4.722185147889570e+00 9.203797550903349e+03 + 102100 1.083631056836609e+00 -5.942782944882389e+00 -5.988263724727164e+00 4.013306706455163e+00 4.752149030458527e+00 9.181019598491292e+03 + 102120 1.082529553172992e+00 -5.935579280397475e+00 -5.982035708830551e+00 4.123485231354381e+00 4.856725230182592e+00 9.161951657359012e+03 + 102140 1.047996159208897e+00 -5.885577318949749e+00 -6.040230654997110e+00 4.261586185608338e+00 4.373542797497982e+00 9.340967356817308e+03 + 102160 1.104304036085869e+00 -5.980359227409762e+00 -6.025177805808021e+00 3.798174069721648e+00 4.540818856906253e+00 9.294524501320371e+03 + 102180 1.082583430345317e+00 -5.967253066268624e+00 -6.026792188548631e+00 3.870321413188171e+00 4.528438559406970e+00 9.299476548545019e+03 + 102200 9.841305042298184e-01 -5.845461581400166e+00 -6.002837665028740e+00 4.568037367464860e+00 4.664359541399350e+00 9.225767408509188e+03 + 102220 9.995182682556932e-01 -5.890928745946875e+00 -6.034236088316025e+00 4.228233658526382e+00 4.405340721903166e+00 9.322439611387555e+03 + 102240 1.011435872267556e+00 -5.934297955159959e+00 -6.037258214557503e+00 4.023869728376523e+00 4.432655985867179e+00 9.331763058513785e+03 + 102260 1.026334316876609e+00 -5.982604275669857e+00 -6.004532985601646e+00 3.767088160023281e+00 4.641170114138054e+00 9.230968267001044e+03 + 102280 1.032443488931104e+00 -6.016732232371707e+00 -5.987468716383765e+00 3.617017538124929e+00 4.785053175442156e+00 9.178625468506341e+03 + 102300 9.693442319713593e-01 -5.942959773709611e+00 -5.973836983252610e+00 3.997674296923653e+00 4.820372581495016e+00 9.136886397524288e+03 + 102320 9.025551197934787e-01 -5.857502221551396e+00 -5.973087043373868e+00 4.488703280691446e+00 4.824997347093447e+00 9.134574531533966e+03 + 102340 1.062979484522036e+00 -6.104241496519524e+00 -5.970550419891234e+00 3.140423611172107e+00 4.908098461798994e+00 9.126871249074404e+03 + 102360 9.836636181508149e-01 -5.993502057436785e+00 -6.051691358972201e+00 3.706024855001952e+00 4.371892880820280e+00 9.376401042634212e+03 + 102380 9.885447284289018e-01 -6.007935020711544e+00 -5.992890073089128e+00 3.668525324290169e+00 4.754915741736204e+00 9.195233739769241e+03 + 102400 1.039976166368926e+00 -6.088159695030552e+00 -5.987064029516945e+00 3.239098951444764e+00 4.819605907327569e+00 9.177385246608255e+03 + 102420 9.793048394408452e-01 -6.003143137072142e+00 -5.973266601781465e+00 3.707149240562441e+00 4.878704929580400e+00 9.135164775567515e+03 + 102440 9.960105032353902e-01 -6.030229242737156e+00 -5.992307661936399e+00 3.544159415457924e+00 4.761911000761536e+00 9.193432917753355e+03 + 102460 9.871004442492680e-01 -6.016201428120822e+00 -6.002061507311437e+00 3.631404640526550e+00 4.712598253959714e+00 9.223371669218874e+03 + 102480 1.020821733036069e+00 -6.063383559255508e+00 -6.050341931847321e+00 3.367343622826524e+00 4.442230665589648e+00 9.372237155531158e+03 + 102500 9.669820182883115e-01 -5.982000300349037e+00 -6.041433405780094e+00 3.813747750897432e+00 4.472473662268961e+00 9.344688594991154e+03 + 102520 9.675845867143908e-01 -5.981444970993582e+00 -5.971539890669462e+00 3.797850327579372e+00 4.854726831606699e+00 9.129914580650506e+03 + 102540 9.878283234899049e-01 -6.005916272363897e+00 -6.006081016703954e+00 3.642863574823491e+00 4.641917587328777e+00 9.235722560147991e+03 + 102560 9.889889218476040e-01 -6.000220045721592e+00 -5.988168868721012e+00 3.717702973693253e+00 4.786902696944194e+00 9.180771059645855e+03 + 102580 9.959711529345525e-01 -5.996417773801714e+00 -6.011134942077716e+00 3.723268444304157e+00 4.638760186588929e+00 9.251279756228063e+03 + 102600 1.042773284765454e+00 -6.040344299031713e+00 -5.975251161299990e+00 3.558766802184994e+00 4.932541672171057e+00 9.141221896902434e+03 + 102620 1.021781125007858e+00 -5.972771173452919e+00 -6.025501424075703e+00 3.881815893138791e+00 4.579030634082860e+00 9.295506583443468e+03 + 102640 1.083711708878293e+00 -6.016304371350754e+00 -6.031817968987445e+00 3.606537334271561e+00 4.517455855920208e+00 9.315001657412764e+03 + 102660 1.065835303228143e+00 -5.947190688664417e+00 -6.053875304787654e+00 3.980806543161708e+00 4.368206967991089e+00 9.383169727282711e+03 + 102680 1.169225889417918e+00 -6.065772496282318e+00 -5.997754119684111e+00 3.307828971155323e+00 4.698401015391990e+00 9.210171831795838e+03 + 102700 1.126781880665355e+00 -5.979399400858209e+00 -6.003892467705795e+00 3.861410725959914e+00 4.720767745831233e+00 9.228993301558516e+03 + 102720 1.075206261957840e+00 -5.891964884371550e+00 -6.000983042299200e+00 4.311329529034166e+00 4.685330395708185e+00 9.220051556256094e+03 + 102740 1.057289525430582e+00 -5.861683921681520e+00 -6.032701513393830e+00 4.411184551518983e+00 4.429175075020109e+00 9.317687375128469e+03 + 102760 1.134804181007357e+00 -5.984120571129761e+00 -6.010360504266322e+00 3.776210541977432e+00 4.625536785290772e+00 9.248890597823731e+03 + 102780 1.058148794018591e+00 -5.890067260847018e+00 -6.024185691903285e+00 4.300331191293499e+00 4.530202405408285e+00 9.291392162850390e+03 + 102800 1.077990353297650e+00 -5.948791061796524e+00 -6.029580482629828e+00 3.951095576914621e+00 4.487190220367324e+00 9.308086929171297e+03 + 102820 1.058611199826975e+00 -5.962213019102329e+00 -6.020573864566537e+00 3.962887171013837e+00 4.627770165046704e+00 9.280308128039464e+03 + 102840 9.820786336025932e-01 -5.890722350964804e+00 -6.005987609896519e+00 4.225618296640874e+00 4.563747342613794e+00 9.235428619212500e+03 + 102860 1.014632743683619e+00 -5.974503566291943e+00 -6.007775413215660e+00 3.780830747861697e+00 4.589778654024046e+00 9.240930110846548e+03 + 102880 1.006359299950356e+00 -5.991954000690792e+00 -6.024152485622160e+00 3.727170963602669e+00 4.542282280427314e+00 9.291333873990910e+03 + 102900 9.336938610123493e-01 -5.907745007490279e+00 -6.003661326972560e+00 4.192806918989044e+00 4.642040569519316e+00 9.228269722508967e+03 + 102920 9.769278533474995e-01 -5.986634462387810e+00 -5.984094714669865e+00 3.783431044911431e+00 4.798014669332558e+00 9.168270157701678e+03 + 102940 9.868477131402178e-01 -6.011272088071292e+00 -5.974835651755944e+00 3.696497517391585e+00 4.905721173234611e+00 9.139965883949488e+03 + 102960 9.740785923934330e-01 -5.998224018652767e+00 -6.018238319916687e+00 3.739952968698047e+00 4.625027753637509e+00 9.273133688769045e+03 + 102980 1.003390932263167e+00 -6.046330366646973e+00 -6.023543403445085e+00 3.443519446810506e+00 4.574365715786905e+00 9.289463245017643e+03 + 103000 1.048456808203557e+00 -6.117335419003452e+00 -5.970781442572803e+00 3.090486508088196e+00 4.932022119907542e+00 9.127580663879335e+03 + 103020 9.717675137604018e-01 -6.005032333235174e+00 -6.009572428684725e+00 3.695422920546460e+00 4.669352989897644e+00 9.246456933090058e+03 + 103040 9.650892979799111e-01 -5.995321626038420e+00 -6.035797446965621e+00 3.749517017523526e+00 4.517098590146498e+00 9.327283963019230e+03 + 103060 9.551831662111111e-01 -5.980692198774838e+00 -6.013382041799082e+00 3.825000492954367e+00 4.637290355572298e+00 9.258187206388813e+03 + 103080 9.944063050725600e-01 -6.035838799593939e+00 -6.002961592294723e+00 3.493669181280160e+00 4.682455193323642e+00 9.226157635995522e+03 + 103100 9.676090763087970e-01 -5.989873080171458e+00 -6.027331573808462e+00 3.761019678012448e+00 4.545927210865610e+00 9.301139921210133e+03 + 103120 9.930409915917640e-01 -6.020318072314565e+00 -6.049558515949376e+00 3.539776624888062e+00 4.371873472592949e+00 9.369798139998426e+03 + 103140 9.634960193435125e-01 -5.967499989299911e+00 -6.026611933373742e+00 3.844097069750231e+00 4.504667139334518e+00 9.298906659092363e+03 + 103160 1.017511280247289e+00 -6.035203560419198e+00 -5.988057727472556e+00 3.494072361732386e+00 4.764791030306074e+00 9.180427334248698e+03 + 103180 1.037748089590008e+00 -6.043392117956689e+00 -5.986337876062423e+00 3.509329297310170e+00 4.836943583382441e+00 9.175163629465984e+03 + 103200 1.017310264915153e+00 -5.987777607810710e+00 -5.985420852798715e+00 3.787019682650757e+00 4.800552534636292e+00 9.172349552718246e+03 + 103220 1.054549616867338e+00 -6.010764117242857e+00 -6.034751998506451e+00 3.624584234095394e+00 4.486842107767208e+00 9.324042027653282e+03 + 103240 1.060155131536222e+00 -5.979131685601505e+00 -6.020372741900596e+00 3.891287019603317e+00 4.654474492301098e+00 9.279690325859225e+03 + 103260 1.108773681805230e+00 -6.014052180301531e+00 -5.999738928054415e+00 3.607840671321150e+00 4.690029580692716e+00 9.216259911958703e+03 + 103280 1.073452186736946e+00 -5.928394572094545e+00 -6.024265770745577e+00 4.130752995731597e+00 4.580245737057324e+00 9.291685443296732e+03 + 103300 1.060801085500384e+00 -5.884402965742423e+00 -6.083624657585718e+00 4.342520183918455e+00 4.198558399897085e+00 9.475558847239563e+03 + 103320 1.084143637435305e+00 -5.906073813083468e+00 -6.041249176092317e+00 4.231308959585786e+00 4.455111106869154e+00 9.344123482655157e+03 + 103340 1.063866916097524e+00 -5.875540709956862e+00 -6.091781318808161e+00 4.360031572755338e+00 4.118344533605106e+00 9.500958280247118e+03 + 103360 1.058791109136880e+00 -5.878794326163305e+00 -6.065634864806523e+00 4.341676348710173e+00 4.268809062340910e+00 9.419642745989962e+03 + 103380 1.080372795180301e+00 -5.936087377793628e+00 -6.027376724028969e+00 4.073976880534168e+00 4.549779327470173e+00 9.301273450067960e+03 + 103400 1.051210837529179e+00 -5.928657098335469e+00 -5.986985235756267e+00 4.069473323245671e+00 4.734544131925356e+00 9.177113316957610e+03 + 103420 1.062944011698172e+00 -5.986828770580052e+00 -5.988204588793001e+00 3.727040819350595e+00 4.719140658264665e+00 9.180869749761030e+03 + 103440 9.771613898596031e-01 -5.901780912450828e+00 -6.054319472795598e+00 4.228891971915006e+00 4.352991953149416e+00 9.384547146257019e+03 + 103460 1.046644068516963e+00 -6.045559483206691e+00 -6.013610565668925e+00 3.430155377038450e+00 4.613611005619315e+00 9.258896302273346e+03 + 103480 9.768096091617940e-01 -5.974026993285950e+00 -6.008726073800950e+00 3.835997912189456e+00 4.636750422206969e+00 9.243864179970800e+03 + 103500 1.068325084821227e+00 -6.129840174833159e+00 -5.958868665488568e+00 3.016587125922736e+00 4.998331990334940e+00 9.091212763601767e+03 + 103520 9.338441806951159e-01 -5.942961687434636e+00 -6.042161416568965e+00 3.923022584163368e+00 4.353402388365577e+00 9.346924145145107e+03 + 103540 9.910314184955752e-01 -6.033434798192250e+00 -6.010624362030164e+00 3.480772080265404e+00 4.611753134611687e+00 9.249693534975968e+03 + 103560 1.054506776119491e+00 -6.130597522194338e+00 -5.966685517820096e+00 3.012730246250972e+00 4.953938340668570e+00 9.115074898234345e+03 + 103580 9.193068191471293e-01 -5.931641052091430e+00 -6.016880672596723e+00 4.098296335091719e+00 4.608837243361687e+00 9.268924256115819e+03 + 103600 1.034838180775984e+00 -6.101734849424806e+00 -5.971957082402476e+00 3.194963653116414e+00 4.940167674403177e+00 9.131150299198747e+03 + 103620 9.638566747064915e-01 -5.992364234300954e+00 -6.023716156862765e+00 3.738293509271219e+00 4.558265918226964e+00 9.290004103261297e+03 + 103640 1.008335283865236e+00 -6.054165027956544e+00 -5.993763967410720e+00 3.447680071503076e+00 4.794512308191110e+00 9.197923670251370e+03 + 103660 9.369335477749456e-01 -5.942428974360362e+00 -6.004431952438962e+00 4.037881873432100e+00 4.681851178374935e+00 9.230662540099080e+03 + 103680 1.000397751847341e+00 -6.028849143143697e+00 -5.992708452854998e+00 3.535498029279189e+00 4.743023465670642e+00 9.194662008354800e+03 + 103700 9.998274351679115e-01 -6.017025511623411e+00 -6.003588170235674e+00 3.574959841409691e+00 4.652119135079933e+00 9.228051353245775e+03 + 103720 9.882500866178275e-01 -5.987072418723219e+00 -5.969824681211004e+00 3.793158123705344e+00 4.892197301579238e+00 9.124640080461859e+03 + 103740 1.072332514603123e+00 -6.093898865661609e+00 -5.974314324469665e+00 3.208741182681638e+00 4.895414123853725e+00 9.138341480224704e+03 + 103760 1.036312685437181e+00 -6.020402318081159e+00 -5.974366487855130e+00 3.580621703205466e+00 4.844966564385027e+00 9.138532460075103e+03 + 103780 9.432848887278310e-01 -5.862389965330649e+00 -6.002692239229547e+00 4.374072520841302e+00 4.568435152407111e+00 9.225277784278092e+03 + 103800 1.092450645763077e+00 -6.058225824482392e+00 -5.969695533386615e+00 3.367392347776260e+00 4.875746979266484e+00 9.124253066693602e+03 + 103820 9.873630067521609e-01 -5.875544169532443e+00 -5.992571563324795e+00 4.339850894846473e+00 4.667861489760131e+00 9.194223100417566e+03 + 103840 1.040378715015674e+00 -5.925496382483080e+00 -6.016554276587552e+00 4.055798363095180e+00 4.532929843983728e+00 9.267910193914460e+03 + 103860 1.034047778373317e+00 -5.885428241794218e+00 -6.035194690420605e+00 4.276072290663445e+00 4.416090166367709e+00 9.325371068318675e+03 + 103880 1.123350971254179e+00 -5.992064295524901e+00 -6.017139412069475e+00 3.737668279529457e+00 4.593683079968766e+00 9.269724643700443e+03 + 103900 1.121179525072143e+00 -5.971886882326563e+00 -5.964576260731553e+00 3.868562777396125e+00 4.910541497909712e+00 9.108612522689313e+03 + 103920 1.047736687199056e+00 -5.851905425583020e+00 -5.999361044546006e+00 4.516787534011293e+00 4.670074551242535e+00 9.215032265267298e+03 + 103940 1.093219859365533e+00 -5.913986225891779e+00 -6.011320460892092e+00 4.152585288688567e+00 4.593677048892584e+00 9.251743280132341e+03 + 103960 1.116213031860014e+00 -5.951101210777447e+00 -5.993060974770392e+00 4.020526351699764e+00 4.779586893599775e+00 9.195735169687277e+03 + 103980 1.085582665433207e+00 -5.921795813764325e+00 -6.032403396506946e+00 4.098178877310032e+00 4.463053020733790e+00 9.316791680483000e+03 + 104000 1.090612384877555e+00 -5.965370675190580e+00 -6.012807157476891e+00 3.898240272316615e+00 4.625852650256706e+00 9.256386215951896e+03 + 104020 9.622510812979671e-01 -5.830761904604348e+00 -6.026662214012947e+00 4.634244917134068e+00 4.509355025034986e+00 9.299052719843938e+03 + 104040 9.833523403916149e-01 -5.920144239180239e+00 -6.009189384597978e+00 4.097243629105590e+00 4.585932624425213e+00 9.245272458804524e+03 + 104060 1.018473876045485e+00 -6.023067789770886e+00 -6.005636882274270e+00 3.552541209196473e+00 4.652632177466263e+00 9.234345296311993e+03 + 104080 9.849308483410752e-01 -6.008013677526687e+00 -5.989084915338987e+00 3.660583917191718e+00 4.769275798889973e+00 9.183565893908210e+03 + 104100 9.534566112345877e-01 -5.983791987296577e+00 -6.020831289378945e+00 3.783282907839578e+00 4.570597503469149e+00 9.281105193723228e+03 + 104120 9.538068341730618e-01 -6.000116496874760e+00 -6.097635304014512e+00 3.626868358716572e+00 4.066900277133487e+00 9.519208021675693e+03 + 104140 1.004018740404711e+00 -6.088509870718161e+00 -6.035351024107600e+00 3.188768753061436e+00 4.494015076604204e+00 9.325902063720559e+03 + 104160 9.438910516156069e-01 -6.010585573742055e+00 -5.981026833377885e+00 3.645735266194954e+00 4.815466127566305e+00 9.158902707758272e+03 + 104180 1.002521747532457e+00 -6.103059784370759e+00 -5.962648441725907e+00 3.150191058212241e+00 4.956454716264026e+00 9.102743854581626e+03 + 104200 1.000407402846631e+00 -6.100897667768255e+00 -5.972176966966805e+00 3.135424257396630e+00 4.874558440862630e+00 9.131863016706671e+03 + 104220 9.105942825081869e-01 -5.964120284046291e+00 -6.045102481626348e+00 3.957049946640324e+00 4.492037636181061e+00 9.356009509652296e+03 + 104240 9.896265856392805e-01 -6.075645112769908e+00 -5.956841501270954e+00 3.362254559053445e+00 5.044443281079901e+00 9.085022161196997e+03 + 104260 9.679778930342043e-01 -6.031300918152281e+00 -5.999453079005837e+00 3.553874701911431e+00 4.736749922727489e+00 9.215350745445403e+03 + 104280 1.053585733734527e+00 -6.140161838263530e+00 -5.962989428964613e+00 2.988483894469572e+00 5.005835286005681e+00 9.103793771604813e+03 + 104300 9.580762111134433e-01 -5.977763645369699e+00 -5.972268476551638e+00 3.821631754267906e+00 4.853185863995836e+00 9.132093570134548e+03 + 104320 9.614165447160054e-01 -5.955721859109301e+00 -6.010832012921746e+00 3.855125469316600e+00 4.538674437856802e+00 9.250327262687004e+03 + 104340 9.978707120370800e-01 -5.980809517192384e+00 -5.971756524593322e+00 3.760161849052813e+00 4.812145533502703e+00 9.130527259422997e+03 + 104360 1.003691390509842e+00 -5.956464642541532e+00 -5.979794582624180e+00 3.914131842882293e+00 4.780167716631166e+00 9.155098595244192e+03 + 104380 1.042812714673834e+00 -5.980999881164638e+00 -5.920075273706122e+00 3.787071617524109e+00 5.136910141603439e+00 8.973302812096053e+03 + 104400 1.004905878597538e+00 -5.897065314890249e+00 -5.929114917594756e+00 4.282586569243566e+00 5.098552790854293e+00 9.000665909144855e+03 + 104420 1.084200813207017e+00 -5.988792549362050e+00 -5.917343311928484e+00 3.780478436746594e+00 5.190751014823892e+00 8.965017256770576e+03 + 104440 1.067685041497781e+00 -5.943914695368707e+00 -5.975351999675030e+00 3.976766723117422e+00 4.796248856883399e+00 9.141512848823933e+03 + 104460 1.009072924834158e+00 -5.846753385055605e+00 -6.011698416380786e+00 4.450814484935847e+00 4.503674589905554e+00 9.252979237126265e+03 + 104480 1.090794891086835e+00 -5.963152355236291e+00 -6.000241935669346e+00 3.936362474234245e+00 4.723388363793619e+00 9.217783676058458e+03 + 104500 1.088892849189606e+00 -5.962223085349251e+00 -6.072367252350402e+00 3.918581558395295e+00 4.286116706719930e+00 9.440556083495328e+03 + 104520 1.101184786284804e+00 -5.996394886053793e+00 -6.026085071683825e+00 3.737038129210180e+00 4.566552488781157e+00 9.297296234432573e+03 + 104540 9.623491012058711e-01 -5.810879194267441e+00 -6.033442484199446e+00 4.774110335202463e+00 4.496117482855085e+00 9.319979948398275e+03 + 104560 1.063573826253906e+00 -5.980356912670027e+00 -6.002790882528508e+00 3.789228704055069e+00 4.660409377482053e+00 9.225612921817146e+03 + 104580 1.035063821151286e+00 -5.957023998347557e+00 -5.959083959936321e+00 3.924437941564540e+00 4.912609323343831e+00 9.091864011713787e+03 + 104600 9.963809883187791e-01 -5.913847680642217e+00 -5.966080652373138e+00 4.204434137890301e+00 4.904504331185099e+00 9.113186770600261e+03 + 104620 1.012643523545416e+00 -5.948921183550852e+00 -6.008174777717499e+00 3.915474491374991e+00 4.575231184206044e+00 9.242126190472427e+03 + 104640 1.025753905908384e+00 -5.976407155874959e+00 -6.003639718393119e+00 3.814428049348299e+00 4.658054461143597e+00 9.228211607302403e+03 + 104660 1.031587339127396e+00 -5.994384589112253e+00 -6.008823959663223e+00 3.727616766047110e+00 4.644703665858069e+00 9.244146308145506e+03 + 104680 9.991967926948347e-01 -5.956506118591316e+00 -6.035369424756711e+00 3.908463881404538e+00 4.455618573345657e+00 9.325934479426027e+03 + 104700 1.080504708143714e+00 -6.088748992601380e+00 -6.006138881719815e+00 3.175337058231030e+00 4.649697098786318e+00 9.235901976792880e+03 + 104720 9.496126061848341e-01 -5.905830493790978e+00 -6.022627672251643e+00 4.201179371503559e+00 4.530511898477467e+00 9.286628446139914e+03 + 104740 9.664466205338205e-01 -5.941128530675103e+00 -6.015342467752293e+00 4.017134401920572e+00 4.590986490653698e+00 9.264207473070075e+03 + 104760 1.029047466468659e+00 -6.044059419680616e+00 -6.017628658389008e+00 3.420360412963983e+00 4.572129934447487e+00 9.271257450331183e+03 + 104780 1.021504818927702e+00 -6.045042220829527e+00 -5.990631401192115e+00 3.481599733534822e+00 4.794035079939970e+00 9.188311584154346e+03 + 104800 9.708371211342164e-01 -5.980846312824614e+00 -5.948615147792021e+00 3.796534680762128e+00 4.981611018135942e+00 9.059958904487277e+03 + 104820 1.020522473914603e+00 -6.061333853422449e+00 -5.967579538394821e+00 3.368053524684610e+00 4.906405310006610e+00 9.117786523678797e+03 + 104840 1.036716278187460e+00 -6.091882076992208e+00 -5.959284958939668e+00 3.236235130392318e+00 4.997628301587705e+00 9.092474469028248e+03 + 104860 9.545077744712391e-01 -5.976090577747242e+00 -6.050175322412450e+00 3.781058210716403e+00 4.355652142271596e+00 9.371708240227716e+03 + 104880 9.402236063444048e-01 -5.959190233782132e+00 -6.040153117394100e+00 3.873378411053286e+00 4.408477004387617e+00 9.340740888112316e+03 + 104900 9.904408800758864e-01 -6.039042830690688e+00 -5.995023001320884e+00 3.491427017689710e+00 4.744195689977708e+00 9.201779293166681e+03 + 104920 9.778090112727499e-01 -6.025318624849101e+00 -5.967846554508566e+00 3.553226195437028e+00 4.883239717106522e+00 9.118584955328177e+03 + 104940 9.670483428968626e-01 -6.011011070305761e+00 -5.975724496959645e+00 3.595858322445496e+00 4.798479287178468e+00 9.142653821593969e+03 + 104960 1.029786244182199e+00 -6.101187895214689e+00 -6.015629719733400e+00 3.110451509342673e+00 4.601739793041105e+00 9.265094544888538e+03 + 104980 9.801875242909042e-01 -6.023857221851897e+00 -5.997273089344724e+00 3.580531632114801e+00 4.733181834852196e+00 9.208697622961316e+03 + 105000 9.646857924264594e-01 -5.993866190948970e+00 -6.008215574075187e+00 3.709736837284904e+00 4.627340458814305e+00 9.242300533978465e+03 + 105020 9.687318499764812e-01 -5.987953987877033e+00 -6.042579435184784e+00 3.774311666386286e+00 4.460643894684528e+00 9.348226753335814e+03 + 105040 1.012311504020663e+00 -6.036604230261915e+00 -6.032764170130305e+00 3.471829972900299e+00 4.493880192423393e+00 9.317901804312112e+03 + 105060 9.270745111230188e-01 -5.892772114293692e+00 -5.994665542845321e+00 4.305310243712978e+00 4.720222409012414e+00 9.200658494543341e+03 + 105080 1.033014156850607e+00 -6.028589276799807e+00 -5.969567384102916e+00 3.587374669486828e+00 4.926287510960750e+00 9.123834909171972e+03 + 105100 1.054176948128016e+00 -6.033594833394838e+00 -5.973103177585704e+00 3.545483374340964e+00 4.892835823050495e+00 9.134653768272405e+03 + 105120 1.039281137685686e+00 -5.988240549705806e+00 -5.982053724521271e+00 3.728277963115716e+00 4.763803670733416e+00 9.162043315712514e+03 + 105140 1.014898584661100e+00 -5.931653803498542e+00 -6.014534017516225e+00 4.067013184070718e+00 4.591102169509514e+00 9.261705648055080e+03 + 105160 9.982857438855486e-01 -5.888857036837893e+00 -6.010178227309966e+00 4.254460580624635e+00 4.557815530540446e+00 9.248327328857127e+03 + 105180 1.011202221953589e+00 -5.891955097468983e+00 -6.027678241286801e+00 4.254890988804073e+00 4.475547693913538e+00 9.302225718079066e+03 + 105200 1.014858533082630e+00 -5.883795723965315e+00 -6.040930699240269e+00 4.285117671243057e+00 4.382824326655436e+00 9.343150118834654e+03 + 105220 1.045719537505392e+00 -5.922255113984400e+00 -6.038937057780220e+00 4.123193170894916e+00 4.453187393146865e+00 9.336966609905021e+03 + 105240 1.043752320324015e+00 -5.919872882778542e+00 -6.025496462360366e+00 4.095619089919219e+00 4.489112150764274e+00 9.295484135444623e+03 + 105260 1.071380916330870e+00 -5.970149782964505e+00 -6.027543699387363e+00 3.825270252937836e+00 4.495705503157923e+00 9.301788075127948e+03 + 105280 1.004826558763849e+00 -5.888980981468689e+00 -6.002561036365729e+00 4.340232783547373e+00 4.688038531871878e+00 9.224894854216227e+03 + 105300 1.019711935595861e+00 -5.935162468038301e+00 -6.035102116531673e+00 4.050303532158432e+00 4.476434604898865e+00 9.325099272691565e+03 + 105320 1.022851179360183e+00 -5.972647152989670e+00 -6.003741584379099e+00 3.858013464985047e+00 4.679464428099242e+00 9.228525191493331e+03 + 105340 1.037891455942812e+00 -6.033002609438154e+00 -5.965892148951660e+00 3.529082812176280e+00 4.914441461599922e+00 9.112639362291173e+03 + 105360 1.065345556844006e+00 -6.113491915059083e+00 -5.957334302741281e+00 3.092379024048653e+00 4.989060199289879e+00 9.086560301736678e+03 + 105380 9.552382328475740e-01 -5.987539559216747e+00 -6.024332040487554e+00 3.767021549823100e+00 4.555753428748050e+00 9.291911276990621e+03 + 105400 9.954292747346277e-01 -6.080023340725983e+00 -6.034258219521531e+00 3.255247862154983e+00 4.518038270240567e+00 9.322503558053131e+03 + 105420 8.988636870073589e-01 -5.960208105435974e+00 -5.996017139219083e+00 3.923218242698733e+00 4.717597229286053e+00 9.204827161084382e+03 + 105440 9.536092069765210e-01 -6.051566608185607e+00 -6.001825378518753e+00 3.440036829310591e+00 4.725658667488078e+00 9.222666110106800e+03 + 105460 9.246393099890596e-01 -6.012930720009395e+00 -6.027408288706358e+00 3.560053393618048e+00 4.476920953763571e+00 9.301377571533081e+03 + 105480 9.340637518889190e-01 -6.027647488670615e+00 -5.988663013715501e+00 3.537302906001762e+00 4.761157794022028e+00 9.182289674432423e+03 + 105500 9.388277518277689e-01 -6.028888098425544e+00 -5.993482688337479e+00 3.524856655990587e+00 4.728159999685762e+00 9.197044511283280e+03 + 105520 9.638068054036103e-01 -6.056767855595536e+00 -5.998123349307123e+00 3.389296706825543e+00 4.726042537141622e+00 9.211308780844345e+03 + 105540 9.907884410405895e-01 -6.084128107283559e+00 -5.952604940912357e+00 3.276159722907576e+00 5.031386097355237e+00 9.072141084197983e+03 + 105560 9.367397583036409e-01 -5.988973543698677e+00 -6.031950322731853e+00 3.719454769334579e+00 4.472675453491021e+00 9.315383295042793e+03 + 105580 1.009146369511426e+00 -6.081228402968879e+00 -5.973223798289354e+00 3.331594814075327e+00 4.951773967803721e+00 9.135037468198947e+03 + 105600 9.810492558495509e-01 -6.022375182683032e+00 -6.027968079263451e+00 3.583361622446372e+00 4.551246344783655e+00 9.303098064401076e+03 + 105620 1.080816186022551e+00 -6.153706834447812e+00 -5.970106619991915e+00 2.857618141877368e+00 4.911878985324492e+00 9.125541638087827e+03 + 105640 1.004659507999043e+00 -6.026158022395069e+00 -6.013893486270311e+00 3.591046327549607e+00 4.661471191908802e+00 9.259755210281472e+03 + 105660 1.040317253916643e+00 -6.066915430384356e+00 -6.001989806536979e+00 3.331677027195162e+00 4.704490006534612e+00 9.223178887340839e+03 + 105680 9.868082663486133e-01 -5.977681417704098e+00 -6.012454309332540e+00 3.871628127180174e+00 4.671956802362073e+00 9.255326175679240e+03 + 105700 9.904778007155083e-01 -5.975548793012452e+00 -6.012594568246773e+00 3.801555516314234e+00 4.588832942103571e+00 9.255762706040892e+03 + 105720 1.011416571890045e+00 -5.999708558223542e+00 -5.975336336090459e+00 3.740485748454055e+00 4.880434819531405e+00 9.141475341956024e+03 + 105740 1.070663287284406e+00 -6.079650414573460e+00 -5.982060380657698e+00 3.288138956434668e+00 4.848516033187916e+00 9.162055965356260e+03 + 105760 9.873978366796070e-01 -5.952778292376298e+00 -6.028195384624786e+00 3.972487999332092e+00 4.539431384883966e+00 9.303815848730364e+03 + 105780 1.038112126011055e+00 -6.026465189661036e+00 -6.015595960013489e+00 3.556998867190234e+00 4.619411665834308e+00 9.264983418473385e+03 + 105800 9.883426412165701e-01 -5.951690243949207e+00 -6.033156925068426e+00 3.988304856690529e+00 4.520510566775813e+00 9.319113408557492e+03 + 105820 1.049490321168270e+00 -6.044209571470263e+00 -6.015285686945532e+00 3.483657996459218e+00 4.649743417356892e+00 9.264042592916163e+03 + 105840 9.669860557087495e-01 -5.926323276994959e+00 -6.038470019347025e+00 4.064796842842580e+00 4.420832893604727e+00 9.335550710578482e+03 + 105860 9.913297283522626e-01 -5.966248993167111e+00 -6.023603989462349e+00 3.968290792197301e+00 4.638949527813049e+00 9.289660785910095e+03 + 105880 1.025856615216100e+00 -6.022835674518021e+00 -6.001009072900041e+00 3.568885631314083e+00 4.694217355460207e+00 9.220141375278974e+03 + 105900 9.310106432921430e-01 -5.886362553663688e+00 -5.997026704109333e+00 4.392910613011570e+00 4.757459935930743e+00 9.207893943474799e+03 + 105920 1.002114825061734e+00 -5.993207875301201e+00 -6.016864368318915e+00 3.731083964779548e+00 4.595244721041371e+00 9.268888137091742e+03 + 105940 1.004535546904735e+00 -5.998515174476382e+00 -6.032619089653663e+00 3.703786816708285e+00 4.507956858196524e+00 9.317458714624845e+03 + 105960 9.704961728865152e-01 -5.951000497594798e+00 -6.041763831778325e+00 3.965185252047061e+00 4.444008141584677e+00 9.345684352876940e+03 + 105980 9.547050733941810e-01 -5.930522472157948e+00 -6.008597750037165e+00 4.050101491309179e+00 4.601781163616512e+00 9.243456013375860e+03 + 106000 1.030197515008515e+00 -6.043182128465009e+00 -6.013181700943112e+00 3.469410569392166e+00 4.641677666774055e+00 9.257556907309625e+03 + 106020 1.054648843293593e+00 -6.080666227117568e+00 -6.004542677255478e+00 3.307669800806388e+00 4.744783004195778e+00 9.230997125901400e+03 + 106040 9.820431790664990e-01 -5.975657366924267e+00 -6.031835035625956e+00 3.807666767939450e+00 4.485085900788220e+00 9.315023226177755e+03 + 106060 9.637519379507277e-01 -5.951052788163842e+00 -5.993857553857437e+00 3.970429097888548e+00 4.724637509259844e+00 9.198172630192268e+03 + 106080 1.036058453110102e+00 -6.058488273734226e+00 -5.997488818540092e+00 3.329110117441885e+00 4.679378428801785e+00 9.209310970261269e+03 + 106100 9.938361326076730e-01 -5.995695875129115e+00 -6.029427900262344e+00 3.761183602531482e+00 4.567489094202465e+00 9.307594603177789e+03 + 106120 9.884403149722286e-01 -5.988838455369597e+00 -6.061755416075568e+00 3.735094126038258e+00 4.316393653801370e+00 9.407579020905265e+03 + 106140 1.046991522935415e+00 -6.077896397997137e+00 -6.009706722820646e+00 3.285958599889592e+00 4.677514267071133e+00 9.246871573909664e+03 + 106160 1.022304590806801e+00 -6.044210941323505e+00 -5.965105545271301e+00 3.515500955099785e+00 4.969736380752012e+00 9.110236684367226e+03 + 106180 9.746870712848359e-01 -5.976501048606917e+00 -6.027258173431431e+00 3.772526282518800e+00 4.481071017136756e+00 9.300894347154832e+03 + 106200 1.006697876559975e+00 -6.026541308635800e+00 -5.997818798966025e+00 3.613114726237345e+00 4.778043821555194e+00 9.210341375407599e+03 + 106220 9.917649340656983e-01 -6.005379183840454e+00 -6.034777941613426e+00 3.601881217392561e+00 4.433069000817094e+00 9.324147627027842e+03 + 106240 9.823525429464952e-01 -5.996085134616224e+00 -5.994998003285888e+00 3.740223178528086e+00 4.746465654859904e+00 9.201693563369117e+03 + 106260 9.872817596452584e-01 -6.007883076430167e+00 -5.955948369254961e+00 3.654570497755134e+00 4.952787623225128e+00 9.082312950190484e+03 + 106280 9.444796671961722e-01 -5.947614457165768e+00 -6.008997976638307e+00 3.965424199052621e+00 4.612950531172367e+00 9.244659454683411e+03 + 106300 9.951661159584837e-01 -6.023672837148204e+00 -5.963506678081031e+00 3.540672094268674e+00 4.886155490315407e+00 9.105351742482240e+03 + 106320 1.010907387953909e+00 -6.043585038563597e+00 -5.986180815431410e+00 3.405200069026474e+00 4.734824001526313e+00 9.174688076584907e+03 + 106340 1.065493788765604e+00 -6.120099708978628e+00 -5.978294086690593e+00 3.032612794874071e+00 4.846882622401099e+00 9.150533840000335e+03 + 106360 1.003448986429121e+00 -6.021402655140225e+00 -6.016121061088942e+00 3.542951757159179e+00 4.573279487525681e+00 9.266614197549015e+03 + 106380 1.002641671974978e+00 -6.014264461372075e+00 -6.008535072180445e+00 3.563719731309110e+00 4.596618770667563e+00 9.243251607275828e+03 + 106400 9.279737268549614e-01 -5.895822523891109e+00 -5.975526871060284e+00 4.248793802027325e+00 4.791119106374060e+00 9.142050886966985e+03 + 106420 1.000511469415614e+00 -5.991984889029911e+00 -5.984288973032861e+00 3.727037483241496e+00 4.771228623835714e+00 9.168865631228966e+03 + 106440 9.835861777889852e-01 -5.949739384102334e+00 -6.005883194165015e+00 3.921691761428319e+00 4.599305315821880e+00 9.235108826196378e+03 + 106460 1.050662975312854e+00 -6.029188679902552e+00 -5.994911488469557e+00 3.519627951839515e+00 4.716452889426002e+00 9.201442797101881e+03 + 106480 1.030473782183092e+00 -5.981755171782851e+00 -6.028877163620118e+00 3.786853333650078e+00 4.516271564415817e+00 9.305904331851314e+03 + 106500 1.017453277908669e+00 -5.947790932210066e+00 -6.000924811388154e+00 4.003100947145302e+00 4.697997990463491e+00 9.219877593014953e+03 + 106520 1.053309832071358e+00 -5.987666597784955e+00 -6.011298139135475e+00 3.748891096535181e+00 4.613195129131291e+00 9.251764921732920e+03 + 106540 1.018222475911422e+00 -5.924562883877633e+00 -6.039652573788025e+00 4.061636749136019e+00 4.400773939598591e+00 9.339176789930914e+03 + 106560 1.013464965020376e+00 -5.909919474581240e+00 -6.041302000064256e+00 4.121479176995491e+00 4.367060384291902e+00 9.344256663350348e+03 + 106580 9.844133247863015e-01 -5.863233457603733e+00 -6.046448895862099e+00 4.413135065774862e+00 4.361083666797883e+00 9.360178556207748e+03 + 106600 1.125416983430933e+00 -6.075255138716305e+00 -5.999918356949862e+00 3.287025047531765e+00 4.719620506763979e+00 9.216795849454071e+03 + 106620 9.800715477619264e-01 -5.869947742509009e+00 -6.041206231557272e+00 4.453444727245820e+00 4.470051980965166e+00 9.343909836229263e+03 + 106640 1.029588968893795e+00 -5.959349476580119e+00 -6.004987079848184e+00 3.899596822081879e+00 4.637538641720369e+00 9.232344652929683e+03 + 106660 1.022254327582659e+00 -5.970233234101824e+00 -6.020706799327738e+00 3.832939726135303e+00 4.543112703849133e+00 9.280740237377804e+03 + 106680 9.965355126400648e-01 -5.965104866034972e+00 -5.941566216773464e+00 3.906658027104028e+00 5.041820593757807e+00 9.038533081418669e+03 + 106700 9.479628593460430e-01 -5.927678978703296e+00 -5.986089229611181e+00 4.052874109948442e+00 4.717473410278248e+00 9.174344544058591e+03 + 106720 9.878409278179748e-01 -6.021256381872699e+00 -5.971148482427555e+00 3.609341725776504e+00 4.897069038562901e+00 9.128663947215771e+03 + 106740 9.647110309369963e-01 -6.018001732827750e+00 -5.967821478471147e+00 3.642180237663950e+00 4.930323023548831e+00 9.118525483468955e+03 + 106760 9.604231182053869e-01 -6.036884988571060e+00 -5.963847823138037e+00 3.504041709011469e+00 4.923432415392709e+00 9.106371562011018e+03 + 106780 9.736867778859050e-01 -6.075594685329187e+00 -5.989027965507365e+00 3.207768120032773e+00 4.704847621406271e+00 9.183404580552089e+03 + 106800 9.795415132308126e-01 -6.096826615164590e+00 -5.962035909409321e+00 3.170790576249405e+00 4.944779667490458e+00 9.100858470586558e+03 + 106820 9.894382069230255e-01 -6.118007711210336e+00 -5.948688875928790e+00 3.097255843703330e+00 5.069510797895051e+00 9.060207518109615e+03 + 106840 9.057082121109746e-01 -5.994644186546645e+00 -5.998203036569234e+00 3.718495248821341e+00 4.698059781261373e+00 9.211527333998798e+03 + 106860 9.614243924928710e-01 -6.072036770849369e+00 -5.974693082391124e+00 3.287626659641437e+00 4.846589182655785e+00 9.139513090363642e+03 + 106880 8.971395128714829e-01 -5.963404945218473e+00 -5.995774060921979e+00 3.916889829849984e+00 4.731021358375988e+00 9.204072774653916e+03 + 106900 9.769633277999034e-01 -6.061600047073168e+00 -5.973592390015140e+00 3.380673213551451e+00 4.886026799519565e+00 9.136153269336550e+03 + 106920 9.996030982500095e-01 -6.067535171167483e+00 -5.992098081647992e+00 3.351345638054198e+00 4.784517079926990e+00 9.192809421459837e+03 + 106940 9.961132400025762e-01 -6.026717034631110e+00 -6.008191161989968e+00 3.565849814874314e+00 4.672228242449277e+00 9.242221262949888e+03 + 106960 9.927340165485766e-01 -5.985321353492718e+00 -5.986912034500752e+00 3.757245746205049e+00 4.748111809699827e+00 9.176884891120773e+03 + 106980 9.628829649058479e-01 -5.901797315336555e+00 -5.968719722633182e+00 4.256582835654033e+00 4.872304016747741e+00 9.121238303566755e+03 + 107000 1.035623542086244e+00 -5.969908569662390e+00 -5.973372281569028e+00 3.902069884983050e+00 4.882180715207451e+00 9.135469905314814e+03 + 107020 1.040463477715462e+00 -5.944795300796596e+00 -6.014082338694076e+00 3.994302165921851e+00 4.596445272180055e+00 9.260318213693703e+03 + 107040 1.028995969339478e+00 -5.908268852783031e+00 -6.036716175863561e+00 4.181015786146869e+00 4.443451379859461e+00 9.330113421030928e+03 + 107060 1.060418468978558e+00 -5.949454771801792e+00 -6.039644242617989e+00 3.979006525754543e+00 4.461124627552444e+00 9.339168239717023e+03 + 107080 1.067358594524347e+00 -5.963302441117300e+00 -6.003665256699011e+00 3.926532052373307e+00 4.694762519177596e+00 9.228292031604615e+03 + 107100 1.046465022092181e+00 -5.939672592289149e+00 -6.002337059283807e+00 4.014763247609567e+00 4.654934180831312e+00 9.224221157301861e+03 + 107120 1.012526109890912e+00 -5.899048751600215e+00 -6.000476171656149e+00 4.268979910145166e+00 4.686567968341466e+00 9.218480488088304e+03 + 107140 1.013402051815730e+00 -5.910525471916527e+00 -5.971011637610404e+00 4.202778568845876e+00 4.855457645227744e+00 9.128250324522200e+03 + 107160 1.034846485581101e+00 -5.953628305613922e+00 -5.994487762161349e+00 3.997696812884353e+00 4.763075490408559e+00 9.200116976089483e+03 + 107180 1.059853327314974e+00 -6.005348015070615e+00 -6.045234537827042e+00 3.625557561559181e+00 4.396522975472324e+00 9.356444694381333e+03 + 107200 1.033869496297085e+00 -5.987168763006242e+00 -6.016240679998546e+00 3.801000965824209e+00 4.634065519589781e+00 9.266981375848542e+03 + 107220 9.852244150515118e-01 -5.939489289226330e+00 -6.040916542744863e+00 4.008549137321374e+00 4.426138151801200e+00 9.343073555526300e+03 + 107240 1.013844090905629e+00 -6.008857860171679e+00 -5.983553359254072e+00 3.715828849111109e+00 4.861131209238866e+00 9.166637908325800e+03 + 107260 1.015559189931036e+00 -6.035360735605936e+00 -5.994304437294349e+00 3.520826830314026e+00 4.756578448660789e+00 9.199576716182648e+03 + 107280 9.562147035292888e-01 -5.968588261113394e+00 -6.033625385572699e+00 3.854368096584470e+00 4.480914863476655e+00 9.320572722588442e+03 + 107300 1.009645328328452e+00 -6.068435037275876e+00 -6.024569467333023e+00 3.284591085847819e+00 4.536473976634690e+00 9.292642273383301e+03 + 107320 9.146252495894051e-01 -5.946411693569997e+00 -6.029012087130187e+00 4.052107648116526e+00 4.577803405924326e+00 9.306320843688811e+03 + 107340 9.476124149439484e-01 -6.010584724572748e+00 -6.016102941683059e+00 3.650506054713292e+00 4.618819598124547e+00 9.266547995034764e+03 + 107360 9.352784354037491e-01 -6.003318496229932e+00 -6.032538833766646e+00 3.683883021338430e+00 4.516095321369999e+00 9.317216343516187e+03 + 107380 9.634289084022633e-01 -6.053840888385078e+00 -6.018440986004136e+00 3.426568221902289e+00 4.629839939490844e+00 9.273767404826822e+03 + 107400 9.286616300454092e-01 -6.005530579178171e+00 -6.064546627614265e+00 3.670727953204970e+00 4.331848670380941e+00 9.416259615791734e+03 + 107420 1.003215887418894e+00 -6.118017065181470e+00 -5.996675051953654e+00 3.074624094809851e+00 4.771388712379833e+00 9.206865297882930e+03 + 107440 9.301043708199275e-01 -6.007777323993952e+00 -6.006412330996461e+00 3.687172121661652e+00 4.695010122685237e+00 9.236736319724539e+03 + 107460 9.650008131171328e-01 -6.052008588259855e+00 -5.971562596233691e+00 3.477948026538123e+00 4.939881361729387e+00 9.129958725290144e+03 + 107480 9.746960505523785e-01 -6.050257981041791e+00 -5.969421910235493e+00 3.499743969490750e+00 4.963917197402044e+00 9.123404346540037e+03 + 107500 9.920305436186564e-01 -6.046119734494104e+00 -5.973195914828948e+00 3.454869391236356e+00 4.873609248678301e+00 9.134947107580472e+03 + 107520 1.031405704983468e+00 -6.057409273160842e+00 -6.005083320822831e+00 3.398500513232424e+00 4.698964228972237e+00 9.232673277378311e+03 + 107540 1.071977350332108e+00 -6.064342191566416e+00 -5.971543666842836e+00 3.416849296873112e+00 4.949712786361202e+00 9.129895876120519e+03 + 107560 1.002352092257063e+00 -5.913223360314874e+00 -6.013460574697477e+00 4.166259053181369e+00 4.590681456537669e+00 9.258409923093333e+03 + 107580 1.030913570804215e+00 -5.916236382028281e+00 -5.985331175677985e+00 4.107513815612239e+00 4.710760818090878e+00 9.172064529596386e+03 + 107600 1.046466238711180e+00 -5.913922853027607e+00 -5.984306943857719e+00 4.138891835809319e+00 4.734735494359957e+00 9.168884991490551e+03 + 107620 1.014335211593006e+00 -5.849535038273675e+00 -6.027108696228034e+00 4.521053558892397e+00 4.501398135483707e+00 9.300409904671216e+03 + 107640 1.031454396975159e+00 -5.866833433289541e+00 -6.021246994063081e+00 4.444031587363989e+00 4.557365025981018e+00 9.282368124664270e+03 + 107660 1.083358212918603e+00 -5.944721045353601e+00 -6.027302978494619e+00 3.950463129907367e+00 4.476264890298788e+00 9.301047140077728e+03 + 107680 1.065461499434571e+00 -5.928001078585021e+00 -6.003024927353788e+00 4.107923092915081e+00 4.677124543381741e+00 9.226327214814457e+03 + 107700 1.031908663640041e+00 -5.893742237687064e+00 -6.009339961454102e+00 4.192824955195509e+00 4.529044936635240e+00 9.245738277363249e+03 + 107720 1.009508188437826e+00 -5.881089222381855e+00 -6.016720155963278e+00 4.265727785875058e+00 4.486913976431391e+00 9.268416545387792e+03 + 107740 1.108133266194467e+00 -6.050570405648134e+00 -5.995267527915063e+00 3.406565747755403e+00 4.724123429791367e+00 9.202520161477692e+03 + 107760 1.017707733793472e+00 -5.943948198197571e+00 -6.037929609689355e+00 3.996844037950534e+00 4.457188229588285e+00 9.333828164800503e+03 + 107780 1.017219874802220e+00 -5.972735933065588e+00 -5.983061200777406e+00 3.783106700196357e+00 4.723817415165080e+00 9.165123974842425e+03 + 107800 9.511000185736797e-01 -5.899872904094328e+00 -6.002330140693330e+00 4.279358913037360e+00 4.691033605279765e+00 9.224192855585610e+03 + 107820 1.052768950401667e+00 -6.072052565842713e+00 -5.999445588483018e+00 3.344356035269695e+00 4.761276535162496e+00 9.215341682580869e+03 + 107840 9.831247658223491e-01 -5.989328049267282e+00 -6.016447045152260e+00 3.727336411617765e+00 4.571614940595170e+00 9.267599714195072e+03 + 107860 1.030649498516089e+00 -6.076911480382435e+00 -5.958101945504277e+00 3.331403401972862e+00 5.013626136959347e+00 9.088848716758030e+03 + 107880 9.670326495097444e-01 -5.993502047794760e+00 -5.987159575070494e+00 3.728231837077242e+00 4.764651296954453e+00 9.177657547700615e+03 + 107900 9.888016930385305e-01 -6.030899506786955e+00 -5.989985455488316e+00 3.501930440163577e+00 4.736865254149339e+00 9.186309039551335e+03 + 107920 9.377144814251274e-01 -5.956644639386639e+00 -5.983851575064303e+00 3.909684051777829e+00 4.753457616856986e+00 9.167528349413118e+03 + 107940 9.787994130944463e-01 -6.015486795063946e+00 -5.996247978634480e+00 3.614481959460570e+00 4.724954220595786e+00 9.205542765617138e+03 + 107960 9.843281532585626e-01 -6.020525992922789e+00 -6.037916112942096e+00 3.587887628327494e+00 4.488030868064256e+00 9.333813053910340e+03 + 107980 1.006577759305637e+00 -6.049906694269257e+00 -6.027051088687731e+00 3.416211189734049e+00 4.547451613876703e+00 9.300292467510315e+03 + 108000 1.007792624113868e+00 -6.051173229009590e+00 -5.975072988625884e+00 3.430511950858073e+00 4.867491307615452e+00 9.140698595960317e+03 + 108020 9.578872610042295e-01 -5.973400339117703e+00 -6.031913058730502e+00 3.809164602480075e+00 4.473175511649285e+00 9.315258989736814e+03 + 108040 1.035394544563628e+00 -6.082945044763728e+00 -5.970581747959491e+00 3.276589751924552e+00 4.921797190338468e+00 9.126969521424789e+03 + 108060 1.007928862634063e+00 -6.035159387982256e+00 -6.026269745332783e+00 3.477362094634328e+00 4.528407798395355e+00 9.297887202563712e+03 + 108080 9.762552055751421e-01 -5.983386764989389e+00 -6.017754570160534e+00 3.813788855095873e+00 4.616443599402495e+00 9.271628634960389e+03 + 108100 9.661842206673655e-01 -5.963424634231467e+00 -5.981938205644773e+00 3.898271788399441e+00 4.791963996378322e+00 9.161687185122346e+03 + 108120 9.983894343341578e-01 -6.003552826818973e+00 -5.974216255353281e+00 3.652919290565791e+00 4.821374423741561e+00 9.138069492753268e+03 + 108140 9.918204197366139e-01 -5.985365584028045e+00 -5.986631483767994e+00 3.788027504392182e+00 4.780758512188047e+00 9.176051185022587e+03 + 108160 1.044218242419497e+00 -6.053045906028509e+00 -5.936193665618321e+00 3.445424861284752e+00 5.116408508545818e+00 9.022218183525503e+03 + 108180 1.049795191774055e+00 -6.046370800901839e+00 -5.986225236722342e+00 3.409262810041716e+00 4.754627947056360e+00 9.174794689781587e+03 + 108200 1.046629344324322e+00 -6.023613088810496e+00 -5.975790030657677e+00 3.603843614739521e+00 4.878451015247338e+00 9.142873346873555e+03 + 108220 1.034026386291538e+00 -5.979832161037760e+00 -5.994817183108070e+00 3.876179207270677e+00 4.790132891618283e+00 9.201131592581303e+03 + 108240 1.042748650185279e+00 -5.954753689730257e+00 -5.972206388978856e+00 3.963363666901098e+00 4.863147567019165e+00 9.131916574201899e+03 + 108260 1.058552655046172e+00 -5.925916149635347e+00 -5.968381135918399e+00 4.118913424849318e+00 4.875072902176639e+00 9.120247407986039e+03 + 108280 1.121228639765208e+00 -5.960510866769003e+00 -6.007732073870708e+00 3.977343474804459e+00 4.706191996168288e+00 9.240791226624277e+03 + 108300 1.119809421473405e+00 -5.912040140189669e+00 -6.009281403595688e+00 4.212513482700720e+00 4.654139100186479e+00 9.245548574075301e+03 + 108320 1.113724628032877e+00 -5.877409984722402e+00 -6.036560791810801e+00 4.350624349947770e+00 4.436755787138385e+00 9.329587536322269e+03 + 108340 1.091997171550659e+00 -5.833247581331335e+00 -6.006654288138211e+00 4.625160148769142e+00 4.629432003682910e+00 9.237466576421702e+03 + 108360 1.136432382695131e+00 -5.901194085098821e+00 -6.067150422643287e+00 4.222657682757301e+00 4.269710710916736e+00 9.424334697421924e+03 + 108380 1.101512320390406e+00 -5.867636369883865e+00 -6.029342995790868e+00 4.425536591651806e+00 4.496992121674306e+00 9.307339610666639e+03 + 108400 1.085866092475554e+00 -5.874114241931119e+00 -6.039171865442360e+00 4.403011681691066e+00 4.455225264904833e+00 9.337643073105202e+03 + 108420 1.046459234034156e+00 -5.856012742676384e+00 -6.036026687931843e+00 4.466510506924799e+00 4.432842576199960e+00 9.327947018098650e+03 + 108440 1.072581349394894e+00 -5.936241393588887e+00 -6.025493230587949e+00 3.970342623407929e+00 4.457844763682177e+00 9.295482492300893e+03 + 108460 1.138263056712605e+00 -6.075177556874140e+00 -5.990105094531449e+00 3.247273241067393e+00 4.735772484760123e+00 9.186705115655610e+03 + 108480 1.043526813056567e+00 -5.970696228775783e+00 -5.958964684950148e+00 3.889321676191568e+00 4.956686016288907e+00 9.091481146536702e+03 + 108500 9.910369997116812e-01 -5.917734707118197e+00 -6.031770501755411e+00 4.163961445622183e+00 4.509150265833111e+00 9.314802584518116e+03 + 108520 1.066360228787311e+00 -6.050117812948556e+00 -5.972036919260441e+00 3.383589081591321e+00 4.831941656127720e+00 9.131436365403984e+03 + 108540 9.935929381917005e-01 -5.960118640667429e+00 -6.000595589085390e+00 3.990072758695040e+00 4.757647857091582e+00 9.218878231269160e+03 + 108560 9.871101838038556e-01 -5.966371144721142e+00 -6.035431255289570e+00 3.875120351084051e+00 4.478566509182566e+00 9.326128842770582e+03 + 108580 9.988027618260510e-01 -5.998485314575362e+00 -6.022675865347211e+00 3.668298895532763e+00 4.529393009525171e+00 9.286817660012268e+03 + 108600 1.008983452209837e+00 -6.028763334400829e+00 -6.022137754317967e+00 3.497072351847761e+00 4.535117457988763e+00 9.285137544068237e+03 + 108620 9.633432379768454e-01 -5.975871408905777e+00 -6.004077066724016e+00 3.878419761373265e+00 4.716458509369494e+00 9.229561802513781e+03 + 108640 9.940138688488573e-01 -6.032284649167714e+00 -5.982738335166887e+00 3.590930254809717e+00 4.875432857069775e+00 9.164132591002854e+03 + 108660 9.413470609314988e-01 -5.962446714797154e+00 -6.069148927231059e+00 3.824436095432274e+00 4.211735479522778e+00 9.430567418916084e+03 + 108680 9.802546471809676e-01 -6.029451730653774e+00 -6.033706477991654e+00 3.473468260914199e+00 4.449036843280070e+00 9.320821398572063e+03 + 108700 1.027725079374186e+00 -6.109278824852630e+00 -5.972851519729304e+00 3.131610960347440e+00 4.914997658422822e+00 9.133905948194630e+03 + 108720 9.490397030800369e-01 -5.998855324861219e+00 -5.980155114859347e+00 3.793680379794549e+00 4.901059879473443e+00 9.156226630644516e+03 + 108740 1.005533854165843e+00 -6.086167705023220e+00 -5.995261894382292e+00 3.290874282801161e+00 4.812869515130106e+00 9.202509299772290e+03 + 108760 1.010690249427180e+00 -6.094657833179383e+00 -5.987690738573860e+00 3.208530691728950e+00 4.822752302058256e+00 9.179294819702964e+03 + 108780 9.780972571275032e-01 -6.043566516002691e+00 -6.014143392552100e+00 3.468346843741565e+00 4.637298971808496e+00 9.260530247554118e+03 + 108800 1.042822132245270e+00 -6.134134434489585e+00 -5.958270316878821e+00 3.023645003871175e+00 5.033483982076431e+00 9.089385316166117e+03 + 108820 9.840846975343055e-01 -6.037083821250082e+00 -5.973136644837989e+00 3.524140168356381e+00 4.891334751108182e+00 9.134750210665215e+03 + 108840 1.039330307557075e+00 -6.101680175406879e+00 -5.950679513766199e+00 3.163229312769438e+00 5.030298479187097e+00 9.066252246320968e+03 + 108860 1.023164587913385e+00 -6.049128019023454e+00 -5.988820307536959e+00 3.445397096546722e+00 4.791693308490370e+00 9.182763730873607e+03 + 108880 1.035348253794887e+00 -6.031856360273241e+00 -5.975833578930996e+00 3.524655196024047e+00 4.846346675988609e+00 9.143027422128192e+03 + 108900 1.047849406190153e+00 -6.011071695086987e+00 -5.988407637742141e+00 3.652764058119518e+00 4.782904582645161e+00 9.181462733942742e+03 + 108920 9.939360892313033e-01 -5.895164686623943e+00 -5.959024703577869e+00 4.232749909249451e+00 4.866055809594319e+00 9.091680178126682e+03 + 108940 9.846035156576868e-01 -5.847345415963871e+00 -6.004547916312609e+00 4.533700038318650e+00 4.631018954307886e+00 9.230977732204572e+03 + 108960 1.131999404142116e+00 -6.035638888288033e+00 -5.992156619310638e+00 3.475027203863869e+00 4.724709121191450e+00 9.193013372943025e+03 + 108980 1.096017075806334e+00 -5.963665985471895e+00 -6.027486368214948e+00 3.926841347343595e+00 4.560374833460671e+00 9.301619228888563e+03 + 109000 1.071374861047102e+00 -5.921857948150428e+00 -6.015731018560206e+00 4.102416160704106e+00 4.563382463600457e+00 9.265394335857378e+03 + 109020 1.050562903862386e+00 -5.893751274170635e+00 -6.044277118128194e+00 4.272204753457613e+00 4.407862063654240e+00 9.353439413579657e+03 + 109040 1.030824868618795e+00 -5.876447335507225e+00 -6.003043499914131e+00 4.353556674639528e+00 4.626621907921945e+00 9.226318264176107e+03 + 109060 1.033604778888065e+00 -5.896443473897992e+00 -6.001981862777876e+00 4.200120510219024e+00 4.594102749257833e+00 9.223115707474957e+03 + 109080 1.106161584843847e+00 -6.024640705380095e+00 -5.981279727269389e+00 3.604383666543284e+00 4.853369112944636e+00 9.159657024244645e+03 + 109100 1.033231964313396e+00 -5.946444455944334e+00 -5.985022142408062e+00 3.978900125120686e+00 4.757381079568274e+00 9.171120154750051e+03 + 109120 9.876269523613225e-01 -5.912758749375993e+00 -6.002815204743119e+00 4.165612512063252e+00 4.648494409153786e+00 9.225660814900870e+03 + 109140 9.796151764542128e-01 -5.931844692645702e+00 -5.982099219874360e+00 4.069923210678621e+00 4.781353938468713e+00 9.162147846492171e+03 + 109160 1.021348174001046e+00 -6.019637389525847e+00 -6.009377132987840e+00 3.558210638735395e+00 4.617126619546204e+00 9.245856325416176e+03 + 109180 9.864313636525568e-01 -5.991396330537551e+00 -5.977123925876591e+00 3.773089372892673e+00 4.855043729103388e+00 9.146955366778560e+03 + 109200 9.992648982807234e-01 -6.027899174426158e+00 -6.006238402199268e+00 3.493128981718361e+00 4.617508487838826e+00 9.236221513557526e+03 + 109220 9.507465321641018e-01 -5.967352609448267e+00 -6.032226782623255e+00 3.831138718120705e+00 4.458621176504074e+00 9.316240680955110e+03 + 109240 9.548286817300414e-01 -5.979306804057134e+00 -6.002111151387452e+00 3.832755142011990e+00 4.701809050679959e+00 9.223519369275626e+03 + 109260 9.884290972072315e-01 -6.031239611695623e+00 -5.998417654467362e+00 3.536534901644072e+00 4.725003659230216e+00 9.212179682770451e+03 + 109280 9.834151871276842e-01 -6.023228864207642e+00 -5.988179589223485e+00 3.587618917715255e+00 4.788877278532059e+00 9.180789194056677e+03 + 109300 1.036567230066173e+00 -6.099299641284405e+00 -5.969092106912140e+00 3.172381708223077e+00 4.920053520139447e+00 9.122413674791265e+03 + 109320 9.679578484946022e-01 -5.994821535565626e+00 -5.955430637689165e+00 3.785556734164111e+00 5.011745365492490e+00 9.080726422925220e+03 + 109340 9.834047512615318e-01 -6.010773621916060e+00 -5.992756886123724e+00 3.690851090318712e+00 4.794305975319160e+00 9.194808689848158e+03 + 109360 9.956012354549679e-01 -6.020395257324511e+00 -6.032364968766105e+00 3.595110540348468e+00 4.526378604943979e+00 9.316679226212851e+03 + 109380 1.035574043301788e+00 -6.073748789494447e+00 -5.979035061685106e+00 3.293287654735710e+00 4.837148536718955e+00 9.152819277393572e+03 + 109400 1.049760804198806e+00 -6.087578085236004e+00 -5.986472840591839e+00 3.236716455522052e+00 4.817278416254890e+00 9.175577657813748e+03 + 109420 9.719260724463334e-01 -5.965723519916740e+00 -6.025300589039885e+00 3.912868587505332e+00 4.570767837078582e+00 9.294854782955441e+03 + 109440 1.018402745089736e+00 -6.026247558939794e+00 -5.991254221683763e+00 3.603880223154861e+00 4.804817380880435e+00 9.190221520398311e+03 + 109460 1.031688983865043e+00 -6.035960991454697e+00 -6.017875043539446e+00 3.525445716562874e+00 4.629298028283642e+00 9.272016881826910e+03 + 109480 9.695572974172975e-01 -5.935224831957745e+00 -6.028537432430114e+00 4.063885587726064e+00 4.528070195735468e+00 9.304867234046753e+03 + 109500 1.046958420043960e+00 -6.041268065038963e+00 -5.966747106560950e+00 3.500767393702673e+00 4.928678269364481e+00 9.115262193163153e+03 + 109520 1.090270988978025e+00 -6.094005153086807e+00 -5.963218423968783e+00 3.208294571520252e+00 4.959292209296867e+00 9.104468293235275e+03 + 109540 1.056001632649307e+00 -6.030414463092251e+00 -5.979046115147068e+00 3.541763183585401e+00 4.836728186712794e+00 9.152820374194976e+03 + 109560 1.038119230920159e+00 -5.988574254866263e+00 -5.950733838970689e+00 3.760596148347378e+00 4.977881672205202e+00 9.066403931545228e+03 + 109580 9.961409078650649e-01 -5.904724053191584e+00 -6.020991573326426e+00 4.120340703945420e+00 4.452714610990567e+00 9.281590406996314e+03 + 109600 1.044063384520297e+00 -5.947882838518247e+00 -5.992967543522778e+00 3.961965887005273e+00 4.703082534033705e+00 9.195480245905896e+03 + 109620 1.040926480769991e+00 -5.914499821219776e+00 -6.032490720204770e+00 4.131191331741499e+00 4.453669330737056e+00 9.317051747331614e+03 + 109640 1.082920502438609e+00 -5.951819894174999e+00 -6.004862717078037e+00 3.931153508749376e+00 4.626573411289817e+00 9.231993134576624e+03 + 109660 1.101285479710887e+00 -5.956814861768744e+00 -6.004983057744803e+00 3.964771896596972e+00 4.688182661298205e+00 9.232363255924425e+03 + 109680 9.614922758609575e-01 -5.733609425866431e+00 -6.116121088020961e+00 5.150074121195966e+00 3.953632963616239e+00 9.576933789071985e+03 + 109700 1.120908431582197e+00 -5.962582493462538e+00 -6.085113253712576e+00 3.809731732313087e+00 4.106141145383499e+00 9.480161421407649e+03 + 109720 1.097393060345488e+00 -5.934305121976575e+00 -6.038324310847176e+00 4.020292379949858e+00 4.422998100537413e+00 9.335074432797139e+03 + 109740 1.092681619239138e+00 -5.945968135621014e+00 -6.029719149121877e+00 3.974578891968682e+00 4.493667612019275e+00 9.308520763876155e+03 + 109760 1.009753177740830e+00 -5.854682898398876e+00 -6.072259685509589e+00 4.434514598894657e+00 4.185155017405952e+00 9.440211450159039e+03 + 109780 1.075444735283184e+00 -5.995001613216040e+00 -6.036343419233195e+00 3.723795064966561e+00 4.486404017192250e+00 9.328969597355430e+03 + 109800 1.057200953712549e+00 -6.018515239191535e+00 -5.975649211794074e+00 3.653962732401921e+00 4.900106095214447e+00 9.142449499845799e+03 + 109820 9.805722317992877e-01 -5.946627074264720e+00 -5.972794562200851e+00 3.989798963415276e+00 4.839541198280342e+00 9.133719750508528e+03 + 109840 1.015715352061382e+00 -6.031256190303548e+00 -6.012091204594137e+00 3.536538821153576e+00 4.646587134868968e+00 9.254199966831578e+03 + 109860 9.619907781113367e-01 -5.975019128796051e+00 -5.998830724125251e+00 3.860446230761955e+00 4.723716365549219e+00 9.213452248074602e+03 + 109880 9.440077034901591e-01 -5.965222098330212e+00 -6.007552001501960e+00 3.918267297324530e+00 4.675202442781013e+00 9.240150764518095e+03 + 109900 9.968722559302153e-01 -6.053399207995785e+00 -5.963856878494955e+00 3.410451152029331e+00 4.924617064653805e+00 9.106425656319872e+03 + 109920 1.020975221889988e+00 -6.093652552225520e+00 -5.989361597218387e+00 3.159559685134366e+00 4.758414487758450e+00 9.184423665767075e+03 + 109940 9.383441653129642e-01 -5.972668072657545e+00 -6.037299545798763e+00 3.822484188034607e+00 4.451360267569582e+00 9.331908492685199e+03 + 109960 9.806844041357176e-01 -6.035170723412321e+00 -6.002684448274636e+00 3.494304317469482e+00 4.680845536544905e+00 9.225290837285782e+03 + 109980 9.990682038725238e-01 -6.060006076587285e+00 -6.016862246907406e+00 3.353712370048687e+00 4.601450916556614e+00 9.268888958842381e+03 + 110000 9.631202086231339e-01 -6.002809976250192e+00 -6.005874094880684e+00 3.659482645654700e+00 4.641888002307587e+00 9.235099313055865e+03 + 110020 9.611245720795852e-01 -5.992889822065468e+00 -6.029167078762120e+00 3.714905329490233e+00 4.506595707650733e+00 9.306803991990879e+03 + 110040 1.028797441788246e+00 -6.082550197076841e+00 -6.006945346122595e+00 3.248726519696023e+00 4.682861273688175e+00 9.238409922028004e+03 + 110060 9.564285780334373e-01 -5.963322714899195e+00 -6.021796413237201e+00 3.913529682973274e+00 4.577764658340870e+00 9.284100803583491e+03 + 110080 9.880434341624579e-01 -5.997711831766342e+00 -6.000700076132957e+00 3.697328671067393e+00 4.680169709484969e+00 9.219196545943134e+03 + 110100 1.006582698211794e+00 -6.008610629086927e+00 -5.955897690913901e+00 3.666002733469244e+00 4.968688581759587e+00 9.082142369547591e+03 + 110120 9.703057559663454e-01 -5.930624168494820e+00 -5.976929453119625e+00 4.057681504556312e+00 4.791789394521046e+00 9.146342408172206e+03 + 110140 9.953056376542930e-01 -5.935332666473962e+00 -6.000599330313023e+00 4.008693505870512e+00 4.633922222123035e+00 9.218893570221764e+03 + 110160 1.049229454858271e+00 -5.973942696374966e+00 -6.036600023041097e+00 3.783620349174940e+00 4.423832283268049e+00 9.329760769761608e+03 + 110180 1.098867978695782e+00 -6.008545090263895e+00 -6.015627252486264e+00 3.590544821860889e+00 4.549877950418982e+00 9.265098357703577e+03 + 110200 1.042750463624591e+00 -5.892782361032745e+00 -6.026762851277297e+00 4.315512578022556e+00 4.546175869624483e+00 9.299367593520377e+03 + 110220 1.040539562264942e+00 -5.863759916786565e+00 -6.037094860470078e+00 4.406341668111525e+00 4.411025597984946e+00 9.331250021292490e+03 + 110240 1.164386694726540e+00 -6.029659843564120e+00 -5.985794098563074e+00 3.489739213850266e+00 4.741623109848378e+00 9.173476536973532e+03 + 110260 1.040737856130779e+00 -5.839594558293899e+00 -6.003955851669151e+00 4.554378784994449e+00 4.610590803605803e+00 9.229149871023656e+03 + 110280 1.069364266719630e+00 -5.884105812880772e+00 -5.994664386278433e+00 4.306675526811829e+00 4.671831089478520e+00 9.200647304044049e+03 + 110300 1.022153390399829e+00 -5.824630657952319e+00 -6.039247674385905e+00 4.537422445217691e+00 4.305058324980089e+00 9.337816893700789e+03 + 110320 1.060252341070120e+00 -5.906430202909847e+00 -5.955022245587648e+00 4.213787169289402e+00 4.934764140639170e+00 9.079425504201674e+03 + 110340 9.718075340336209e-01 -5.808616145030516e+00 -5.958398620750480e+00 4.702556102329972e+00 4.842481947982733e+00 9.089744411220006e+03 + 110360 1.035841199206488e+00 -5.949997274765876e+00 -5.959092543180784e+00 3.991535721389297e+00 4.939309282662661e+00 9.091863519050732e+03 + 110380 9.592101952972271e-01 -5.893121712471011e+00 -6.037116964068937e+00 4.192550958686418e+00 4.365707940817960e+00 9.331316901176097e+03 + 110400 9.823608946914413e-01 -5.984098956251469e+00 -5.972999393487472e+00 3.820829036454195e+00 4.884564443496858e+00 9.134344232084615e+03 + 110420 1.013173491719513e+00 -6.070197521170530e+00 -5.982384214923600e+00 3.253394441209471e+00 4.757632034744567e+00 9.163045137024965e+03 + 110440 9.789675755060403e-01 -6.041473844331204e+00 -5.966118407472591e+00 3.474153674525200e+00 4.906856254183523e+00 9.113337991835855e+03 + 110460 9.635393994322432e-01 -6.029603505291371e+00 -5.989897223155870e+00 3.548134263204532e+00 4.776133879753887e+00 9.186065489485087e+03 + 110480 9.557648819367943e-01 -6.022256242455477e+00 -5.996924896745223e+00 3.634743117029118e+00 4.780199624110476e+00 9.207595312484467e+03 + 110500 9.932126860718657e-01 -6.077263082402734e+00 -5.960563230525356e+00 3.256708408586148e+00 4.926817017309768e+00 9.096398363139187e+03 + 110520 9.902805527745164e-01 -6.069673469241910e+00 -5.949725644403873e+00 3.356427662863234e+00 5.045186634949146e+00 9.063373686886463e+03 + 110540 9.744059797145493e-01 -6.037837112187655e+00 -5.972816523927847e+00 3.517516025508486e+00 4.890874305199823e+00 9.133790109034328e+03 + 110560 1.020632573977142e+00 -6.094825978984220e+00 -5.950030128109451e+00 3.227607768490226e+00 5.059047951298657e+00 9.064272976955621e+03 + 110580 9.452707107029774e-01 -5.967730345072841e+00 -5.970065934599813e+00 3.875500332425703e+00 4.862089015930521e+00 9.125381979718586e+03 + 110600 1.019309082590168e+00 -6.057618538966750e+00 -5.987130422045842e+00 3.436303166811051e+00 4.841056842171743e+00 9.177568719826830e+03 + 110620 1.040498609831277e+00 -6.069505008997652e+00 -5.978609027118043e+00 3.305807019328733e+00 4.827745813389181e+00 9.151501828353839e+03 + 110640 1.050254441300103e+00 -6.063025790303131e+00 -5.933299428676935e+00 3.395923821584967e+00 5.140832665132169e+00 9.013427220328911e+03 + 110660 9.385242646590549e-01 -5.875049096126494e+00 -5.996865651036645e+00 4.344321535441987e+00 4.644832026096958e+00 9.207425008825892e+03 + 110680 1.120336050463750e+00 -6.120194008725425e+00 -5.955580040295480e+00 3.058796599611662e+00 5.004035480265694e+00 9.081201558968443e+03 + 110700 1.013168626702572e+00 -5.939011869429478e+00 -6.068713813266038e+00 4.008094373429469e+00 4.263325740608999e+00 9.429174101791055e+03 + 110720 1.049917044662529e+00 -5.978379985072857e+00 -6.034786454499979e+00 3.780598703830197e+00 4.456704027506726e+00 9.324140410769545e+03 + 110740 1.054238104650073e+00 -5.975061910265833e+00 -6.006857467526606e+00 3.790618550278536e+00 4.608043540140594e+00 9.238117385861266e+03 + 110760 1.039079266365442e+00 -5.944270993740131e+00 -6.005999106233224e+00 4.029051312960261e+00 4.674598938630386e+00 9.235466367755716e+03 + 110780 1.031102060715087e+00 -5.930456790381017e+00 -5.999880637149993e+00 4.076276895731818e+00 4.677634424278790e+00 9.216674770957639e+03 + 110800 1.023358507127717e+00 -5.920963910074263e+00 -6.018916869700291e+00 4.105990386737712e+00 4.543529334393548e+00 9.275235357998505e+03 + 110820 1.006398373435532e+00 -5.904639725831286e+00 -6.049029161825150e+00 4.201478573127780e+00 4.372372087458009e+00 9.368152024239178e+03 + 110840 1.056623712262526e+00 -5.995788987273284e+00 -6.040980236985921e+00 3.698406877903321e+00 4.438911728730065e+00 9.343289900107935e+03 + 110860 9.972251628018030e-01 -5.939796761295446e+00 -6.039693907786966e+00 4.037506353737175e+00 4.463881479549405e+00 9.339297643212347e+03 + 110880 9.592198037513756e-01 -5.927998376000270e+00 -6.023345097382271e+00 4.067756317997795e+00 4.520260688964897e+00 9.288824255847814e+03 + 110900 9.829859962525145e-01 -6.015343280423327e+00 -5.964625489544034e+00 3.596064278488242e+00 4.887293682269918e+00 9.108761485294366e+03 + 110920 9.487454265804381e-01 -6.008173971532840e+00 -5.955185922102647e+00 3.649323551225095e+00 4.953589130927416e+00 9.079979551916234e+03 + 110940 9.511061768808465e-01 -6.044391439362661e+00 -5.984232366907107e+00 3.432620983961473e+00 4.778063687587642e+00 9.168720291183789e+03 + 110960 9.280361683028384e-01 -6.031496510747698e+00 -5.985596211973620e+00 3.568973306901607e+00 4.832539925510641e+00 9.172890537695592e+03 + 110980 9.571644751094749e-01 -6.085219419682263e+00 -6.020541633198145e+00 3.238361646122894e+00 4.609751504969811e+00 9.280217090040311e+03 + 111000 9.701796510896282e-01 -6.110312440209889e+00 -5.989433284400640e+00 3.123573427678453e+00 4.817680246324068e+00 9.184654312588777e+03 + 111020 8.866554673615273e-01 -5.986150088528996e+00 -5.980331904583704e+00 3.833984817101279e+00 4.867393729676204e+00 9.156759282664309e+03 + 111040 9.129432837482182e-01 -6.017205420973212e+00 -5.975712858737922e+00 3.596978092740746e+00 4.835234806049034e+00 9.142617143169262e+03 + 111060 9.844397404442903e-01 -6.109103420142434e+00 -5.975588438591988e+00 3.109072886493152e+00 4.875736571932434e+00 9.142249663007911e+03 + 111080 9.530121645318024e-01 -6.042888832669734e+00 -5.998043567538266e+00 3.449367877648631e+00 4.706876329815865e+00 9.211039492559135e+03 + 111100 9.388601685257981e-01 -5.998881586847782e+00 -6.028894772639929e+00 3.681934574775942e+00 4.509594217431943e+00 9.305958985014502e+03 + 111120 1.039301080855108e+00 -6.122801636773787e+00 -5.987763371704681e+00 3.048530434077743e+00 4.823941049208536e+00 9.179549669897227e+03 + 111140 9.976725214012743e-01 -6.037267850458187e+00 -6.026784643688584e+00 3.472919239415998e+00 4.533115434958059e+00 9.299455626035586e+03 + 111160 1.010210495071028e+00 -6.036294383893769e+00 -5.984181089376712e+00 3.488179901336651e+00 4.787422502959855e+00 9.168530397922417e+03 + 111180 1.072961264572328e+00 -6.110295207886670e+00 -5.952541988131110e+00 3.099949071011195e+00 5.005792471079484e+00 9.071941674169731e+03 + 111200 1.084464179555679e+00 -6.111632032482323e+00 -5.980612463580215e+00 3.101807911846479e+00 4.854142551695144e+00 9.157638050425259e+03 + 111220 9.869635172823698e-01 -5.957175455639652e+00 -5.998248762763737e+00 3.920145342303890e+00 4.684296056723655e+00 9.211662888969862e+03 + 111240 9.965816174347820e-01 -5.963003739288662e+00 -5.967820764741450e+00 3.866999167447280e+00 4.839339061865090e+00 9.118514726182397e+03 + 111260 1.012492559853653e+00 -5.977527193624980e+00 -6.018373124498855e+00 3.790678268627816e+00 4.556134612662652e+00 9.273513239211621e+03 + 111280 1.044198950156115e+00 -6.020191924151532e+00 -5.984378984572420e+00 3.605697593475097e+00 4.811341034572851e+00 9.169129088064741e+03 + 111300 1.054459500615011e+00 -6.033957098565745e+00 -5.985062684108192e+00 3.519905436222747e+00 4.800664730424198e+00 9.171236467575005e+03 + 111320 1.044117566225115e+00 -6.018336685541890e+00 -6.022463271968491e+00 3.588713785517875e+00 4.565018287669155e+00 9.286144370951868e+03 + 111340 1.007505103893710e+00 -5.969370771097360e+00 -6.030745118547811e+00 3.862968864398240e+00 4.510547863688177e+00 9.311681642167521e+03 + 111360 1.003108600947063e+00 -5.968499892922689e+00 -5.994778950783719e+00 3.843908504567358e+00 4.693010087658261e+00 9.201025415808104e+03 + 111380 1.026109068760264e+00 -6.006699294381491e+00 -5.980844906485678e+00 3.667614500320164e+00 4.816074396571518e+00 9.158325321700066e+03 + 111400 1.022221720199890e+00 -6.005759916069312e+00 -5.992151760070488e+00 3.686074965427411e+00 4.764215103027992e+00 9.192970161087935e+03 + 111420 1.011455582069984e+00 -5.995376897274902e+00 -6.024178160360436e+00 3.708988395426534e+00 4.543607085808336e+00 9.291430458242688e+03 + 111440 1.049441418826775e+00 -6.057864876194119e+00 -6.013256880236789e+00 3.405464655671109e+00 4.661610671523157e+00 9.257791986275162e+03 + 111460 9.259409645439901e-01 -5.881603604596744e+00 -6.073774150711185e+00 4.288176323837981e+00 4.184703309752961e+00 9.444901557642659e+03 + 111480 1.002707778261402e+00 -6.002832452463512e+00 -6.022819112622283e+00 3.653955973128906e+00 4.539189477571576e+00 9.287223079423437e+03 + 111500 1.030942942534271e+00 -6.051301508455206e+00 -5.996251029151487e+00 3.415384108086705e+00 4.731492479282798e+00 9.205530545727815e+03 + 111520 1.017076605906306e+00 -6.038812430825541e+00 -5.996189391896944e+00 3.485710396622934e+00 4.730458482044897e+00 9.205353913624833e+03 + 111540 9.581669740423234e-01 -5.959201878599954e+00 -5.982409826241014e+00 3.915453435103102e+00 4.782189808329846e+00 9.163141407581621e+03 + 111560 1.017243167536467e+00 -6.051299809532679e+00 -5.969155447472887e+00 3.433502016922745e+00 4.905187655669017e+00 9.122613020683193e+03 + 111580 9.985404819389064e-01 -6.025588545757175e+00 -5.987357899504442e+00 3.586073755266193e+00 4.805600042222777e+00 9.178262268420607e+03 + 111600 1.008792048849457e+00 -6.042945226690936e+00 -6.003842325118068e+00 3.388512934435357e+00 4.613047846421226e+00 9.228834083556603e+03 + 111620 9.527035071335349e-01 -5.961354796597604e+00 -6.001857780212208e+00 3.874979571285106e+00 4.642405171553591e+00 9.222764819781971e+03 + 111640 9.567940024678132e-01 -5.968390068410855e+00 -6.003901515742824e+00 3.858731864837364e+00 4.654819638878484e+00 9.229022193472048e+03 + 111660 9.581173145250579e-01 -5.969323047754853e+00 -5.994188871407019e+00 3.833245364397062e+00 4.690461957012550e+00 9.199218630461657e+03 + 111680 9.860414743856749e-01 -6.005292048093176e+00 -5.989622569448708e+00 3.641316580426408e+00 4.731293151646927e+00 9.185194623570149e+03 + 111700 9.720208343400414e-01 -5.970871799810975e+00 -5.970053003121384e+00 3.937489624098453e+00 4.942191281398458e+00 9.125328035345126e+03 + 111720 9.858731657196810e-01 -5.971944923805778e+00 -6.010844801838994e+00 3.839557267397587e+00 4.616188147994190e+00 9.250367258129694e+03 + 111740 1.094052766796290e+00 -6.107430667717488e+00 -6.006957755363690e+00 3.151718821167374e+00 4.728649832035826e+00 9.238423671803836e+03 + 111760 9.948237200526550e-01 -5.938078568608679e+00 -5.997890997550368e+00 4.042903115957722e+00 4.699450893031082e+00 9.210590194779254e+03 + 111780 1.024111349153304e+00 -5.961750377572186e+00 -5.995234298828848e+00 3.892964138077342e+00 4.700694280601520e+00 9.202407251249891e+03 + 111800 9.562867134152923e-01 -5.839928141745638e+00 -6.041869790167105e+00 4.522661802155428e+00 4.363081606550264e+00 9.346015868615308e+03 + 111820 1.098943820642986e+00 -6.033955834114106e+00 -5.982584797602132e+00 3.530697631355523e+00 4.825678072649489e+00 9.163655036731603e+03 + 111840 1.021547300916882e+00 -5.908117171073567e+00 -5.992935637187204e+00 4.109151670633766e+00 4.622110912594052e+00 9.195331669872787e+03 + 111860 1.016044433773751e+00 -5.892484894995535e+00 -5.932244639194563e+00 4.306123303678435e+00 5.077816699687089e+00 9.010172580651140e+03 + 111880 1.010193762774610e+00 -5.876438481149404e+00 -5.964775614857632e+00 4.371523695960843e+00 4.864278204080937e+00 9.109146124748642e+03 + 111900 1.042076674799578e+00 -5.918358405720140e+00 -5.982956954619455e+00 4.118932715653557e+00 4.747997851280552e+00 9.164795757627700e+03 + 111920 1.101951494215065e+00 -6.007415611572959e+00 -6.004720752524827e+00 3.626181024245934e+00 4.641655321928397e+00 9.231543827222811e+03 + 111940 1.004792366321632e+00 -5.872560238250436e+00 -6.041681369273295e+00 4.315288843621746e+00 4.344169137878045e+00 9.345428903623328e+03 + 111960 9.891020717787372e-01 -5.866245142782811e+00 -6.020520060679699e+00 4.403258612924962e+00 4.517388160394644e+00 9.280108879642445e+03 + 111980 9.646819048927249e-01 -5.853640718450563e+00 -5.970993329466038e+00 4.481444131807985e+00 4.807587279099266e+00 9.128133336030747e+03 + 112000 1.000273219659092e+00 -5.929848344088561e+00 -5.972209898524761e+00 4.085433511789398e+00 4.842186910787376e+00 9.131891542073889e+03 + 112020 9.952701196776318e-01 -5.949505154545768e+00 -5.994267959804791e+00 3.939901353309772e+00 4.682866398490739e+00 9.199464150612839e+03 + 112040 9.831876944776364e-01 -5.959890807245308e+00 -6.031307682457808e+00 3.898668027070153e+00 4.488581277874252e+00 9.313397451882627e+03 + 112060 9.986925748245677e-01 -6.013158067671665e+00 -6.039441758460333e+00 3.574334089785746e+00 4.423409069889217e+00 9.338501388157551e+03 + 112080 1.024807964931206e+00 -6.080964003575213e+00 -5.982509141959550e+00 3.300827486099337e+00 4.866170537337069e+00 9.163433476880036e+03 + 112100 9.105349109430816e-01 -5.937056575263398e+00 -6.021345737336064e+00 3.997510544095430e+00 4.513509131768506e+00 9.282694683514219e+03 + 112120 9.695689814673774e-01 -6.045278058805998e+00 -5.998874838368845e+00 3.484412889854644e+00 4.750867362479929e+00 9.213614808155491e+03 + 112140 9.719615719381105e-01 -6.066199815492920e+00 -5.991497518718614e+00 3.307013031569649e+00 4.735965179790782e+00 9.190962664530844e+03 + 112160 9.307661445110871e-01 -6.016556900162037e+00 -6.000640175986045e+00 3.589764946361679e+00 4.681161239685331e+00 9.218994746664614e+03 + 112180 9.325026572385275e-01 -6.021276309598633e+00 -5.997920141879403e+00 3.590055352044957e+00 4.724170081444048e+00 9.210656416039723e+03 + 112200 9.402788289074294e-01 -6.029942778492273e+00 -5.958940721581043e+00 3.545442476910298e+00 4.953147275227382e+00 9.091450997725506e+03 + 112220 9.576763992823876e-01 -6.046839152563926e+00 -5.997214110574713e+00 3.458877110045404e+00 4.743831780597896e+00 9.208513415867432e+03 + 112240 1.024740756907708e+00 -6.131991389337621e+00 -6.014747545824420e+00 3.010143687572192e+00 4.683375980451139e+00 9.262398758921778e+03 + 112260 9.563909277022600e-01 -6.015098945706922e+00 -6.032719628221789e+00 3.616988552438676e+00 4.515807866646501e+00 9.317766806810538e+03 + 112280 9.572464347817711e-01 -5.998678167964043e+00 -5.957998505583766e+00 3.741094235931784e+00 4.974683152476743e+00 9.088541376034618e+03 + 112300 9.674091504536828e-01 -5.985701144768317e+00 -5.997355367384297e+00 3.811714774649651e+00 4.744794424903574e+00 9.208926278138148e+03 + 112320 1.030455677508121e+00 -6.041472490241775e+00 -6.003241661392651e+00 3.470111429852910e+00 4.689638765306223e+00 9.227000766063065e+03 + 112340 9.259715049899636e-01 -5.845149207743500e+00 -6.025620199471966e+00 4.545599578502467e+00 4.509307216201907e+00 9.295862684805636e+03 + 112360 1.016585069843441e+00 -5.935024635957183e+00 -5.993456340837836e+00 3.983617054062429e+00 4.648093162360611e+00 9.196945472534971e+03 + 112380 1.073978301749934e+00 -5.972896972143639e+00 -5.967212972542041e+00 3.818121995498756e+00 4.850760400807230e+00 9.116666191331067e+03 + 112400 1.049150561338063e+00 -5.898346710420149e+00 -6.012681530182111e+00 4.214997520913197e+00 4.558469292583829e+00 9.256026383049046e+03 + 112420 1.072697518930334e+00 -5.910679058150886e+00 -6.006899492990800e+00 4.199049556439601e+00 4.646536929524644e+00 9.238239737732440e+03 + 112440 1.057502319052854e+00 -5.882167453298014e+00 -6.036873023796963e+00 4.339670629441702e+00 4.451327303027075e+00 9.330600341851663e+03 + 112460 1.080942491502997e+00 -5.918900218435718e+00 -6.106161044423470e+00 4.064727585682991e+00 3.989446944342151e+00 9.545819753619544e+03 + 112480 1.081764404404194e+00 -5.932614230413456e+00 -6.077612648683335e+00 4.029118237964473e+00 4.196514881826123e+00 9.456854094707858e+03 + 112500 1.052253105512939e+00 -5.907556846406853e+00 -6.019392671500177e+00 4.185554415741237e+00 4.543375801517366e+00 9.276677513339251e+03 + 112520 1.032434575247721e+00 -5.897393171625922e+00 -6.058819443713711e+00 4.201241459216261e+00 4.274306824253308e+00 9.398507687415284e+03 + 112540 1.030545415131917e+00 -5.920357767946715e+00 -6.063940979444839e+00 4.086653014671944e+00 4.262175994819551e+00 9.414385297975292e+03 + 112560 1.086067302305417e+00 -6.031175039114887e+00 -6.009718872193008e+00 3.519374192958451e+00 4.642578823754977e+00 9.246899930044869e+03 + 112580 1.058996149520414e+00 -6.021043951851968e+00 -6.003176345591795e+00 3.614574664025180e+00 4.717173224174222e+00 9.226783560073258e+03 + 112600 9.793396601989561e-01 -5.932216712257886e+00 -6.002587990548997e+00 4.084878919041159e+00 4.680796149173480e+00 9.224964165338599e+03 + 112620 1.004912867593625e+00 -5.995654603937886e+00 -6.028416876949773e+00 3.638560213030026e+00 4.450434171450405e+00 9.304497676896419e+03 + 112640 1.004089811051313e+00 -6.020515042384654e+00 -6.051469922625998e+00 3.558287702813945e+00 4.380539990215913e+00 9.375743901785163e+03 + 112660 9.645723670036118e-01 -5.989006032845529e+00 -5.974320488002284e+00 3.790109563759498e+00 4.874436234830127e+00 9.138380575555060e+03 + 112680 9.884977642803940e-01 -6.043358507795261e+00 -5.954227521119257e+00 3.426433439278175e+00 4.938237357747407e+00 9.077052807491404e+03 + 112700 9.319373496773289e-01 -5.972598627793422e+00 -5.994933681160363e+00 3.838944527040035e+00 4.710693194268723e+00 9.201491819772767e+03 + 112720 9.497699035251898e-01 -6.007924893935157e+00 -6.005452419322860e+00 3.632188662791269e+00 4.646385994629287e+00 9.233772803675696e+03 + 112740 9.659741553597003e-01 -6.035964785071886e+00 -6.002835984412339e+00 3.512736053932863e+00 4.702966753985311e+00 9.225745889049713e+03 + 112760 9.878459137632032e-01 -6.069517415971601e+00 -5.978534584907898e+00 3.352062733278227e+00 4.874500228793618e+00 9.151267776051283e+03 + 112780 9.267327416871275e-01 -5.976193519687730e+00 -6.030640305123512e+00 3.844602990198156e+00 4.531961122613078e+00 9.311363452010466e+03 + 112800 1.030988178292339e+00 -6.124332217241923e+00 -6.024827010025408e+00 2.979627921094329e+00 4.551002219312609e+00 9.293445646786044e+03 + 112820 9.573600814357989e-01 -6.005070676031893e+00 -5.999772476785472e+00 3.669592783018412e+00 4.700015862985047e+00 9.216356461911499e+03 + 112840 9.625066142590142e-01 -5.999313645800932e+00 -5.975394104244506e+00 3.742130623970168e+00 4.879480333124258e+00 9.141658172201494e+03 + 112860 1.000223116435450e+00 -6.035475408564502e+00 -6.011638484268660e+00 3.463992387933259e+00 4.600867695992094e+00 9.252805899575094e+03 + 112880 9.796775322300273e-01 -5.976215615227066e+00 -5.981427231922667e+00 3.803589224342494e+00 4.773663314781273e+00 9.160115322228879e+03 + 112900 1.045075282487091e+00 -6.036851775775834e+00 -5.993635544512214e+00 3.463841315747701e+00 4.711995603353579e+00 9.197515948709299e+03 + 112920 1.048386256654613e+00 -5.996244777719573e+00 -6.046708848945295e+00 3.681009601399425e+00 4.391237095131547e+00 9.360985715208475e+03 + 112940 1.070512408497728e+00 -5.989387822866028e+00 -5.994642261346851e+00 3.738666304127601e+00 4.708494505248989e+00 9.200608828311737e+03 + 112960 1.022283385531610e+00 -5.886939445506356e+00 -6.024126527743179e+00 4.272420778951791e+00 4.484671323115589e+00 9.291247688067033e+03 + 112980 1.115675866707718e+00 -6.002315706637216e+00 -6.014920685509095e+00 3.684365282262843e+00 4.611985542966334e+00 9.262900857708491e+03 + 113000 1.060335582351835e+00 -5.908139866673400e+00 -5.998519895613097e+00 4.173583672431638e+00 4.654607559995626e+00 9.212511049526458e+03 + 113020 1.034670112987123e+00 -5.867353379899839e+00 -6.019409363165813e+00 4.413821900247057e+00 4.540692913746470e+00 9.276715227762228e+03 + 113040 1.141237997598533e+00 -6.029430241886066e+00 -5.997439811172407e+00 3.495613069831209e+00 4.679307073492200e+00 9.209187221529104e+03 + 113060 1.055781843227094e+00 -5.914628454534479e+00 -6.024236306927694e+00 4.148217086546273e+00 4.518831836344092e+00 9.291593436316880e+03 + 113080 1.053783059944841e+00 -5.930180779357594e+00 -6.047270869252380e+00 4.068558972693975e+00 4.396209556885267e+00 9.362729368770046e+03 + 113100 1.041859784514301e+00 -5.936857472160328e+00 -6.042090870579051e+00 4.044925595778864e+00 4.440659137242784e+00 9.346714702184325e+03 + 113120 1.079676503534686e+00 -6.019700875152092e+00 -6.010748165792327e+00 3.615733691687245e+00 4.667141534258310e+00 9.250087480648757e+03 + 113140 1.047653370211837e+00 -5.998932750542533e+00 -6.042124081880833e+00 3.687025797822140e+00 4.439014489440697e+00 9.346827334422460e+03 + 113160 1.061478853278668e+00 -6.042996788701249e+00 -6.011250244469323e+00 3.513862036748704e+00 4.696155606490267e+00 9.251635312133261e+03 + 113180 9.773386402307768e-01 -5.937303601115458e+00 -6.030735758119216e+00 4.057373000202097e+00 4.520871096106948e+00 9.311629600985460e+03 + 113200 9.591626239526742e-01 -5.921650154052769e+00 -6.026521183069956e+00 4.127987753376452e+00 4.525802076020471e+00 9.298639362100696e+03 + 113220 1.045501026155711e+00 -6.058042673847188e+00 -6.005814390518827e+00 3.348485715733249e+00 4.648388600905424e+00 9.234916754292812e+03 + 113240 1.062387515565731e+00 -6.091272855442794e+00 -5.964204541816077e+00 3.210920071218257e+00 4.940565991820851e+00 9.107506990230444e+03 + 113260 1.032691929171520e+00 -6.054171417824201e+00 -5.954454391598771e+00 3.393944449889123e+00 4.966535045635477e+00 9.077771354326114e+03 + 113280 1.011860807162704e+00 -6.028263210383630e+00 -5.958312414939830e+00 3.598670383591397e+00 5.000338675880303e+00 9.089506320760129e+03 + 113300 9.601300087146339e-01 -5.953293501441658e+00 -5.987637308762626e+00 3.976000002018074e+00 4.778792545694070e+00 9.179132820528668e+03 + 113320 9.861743561700556e-01 -5.991146098974784e+00 -6.015228203995212e+00 3.754075165184242e+00 4.615791991463237e+00 9.263838293053153e+03 + 113340 1.051334803800843e+00 -6.088325229166065e+00 -5.981820782825997e+00 3.193558916580670e+00 4.805123928975144e+00 9.161335701550252e+03 + 113360 9.562684887234416e-01 -5.949354374167957e+00 -5.977655338012585e+00 3.986241936244888e+00 4.823733422289032e+00 9.148561663111115e+03 + 113380 9.803688533533917e-01 -5.985197739206146e+00 -5.960369633253324e+00 3.740569820497702e+00 4.883136647015786e+00 9.095780375162751e+03 + 113400 9.058467008821085e-01 -5.869285167229254e+00 -5.975712677969668e+00 4.479524910426859e+00 4.868401674151346e+00 9.142635395726602e+03 + 113420 1.020454566775255e+00 -6.029236701803288e+00 -6.020688044482607e+00 3.539784626989305e+00 4.588872340225105e+00 9.280676011377487e+03 + 113440 9.764899578355382e-01 -5.955350644038475e+00 -6.019236645994813e+00 3.905336091516145e+00 4.538492781956005e+00 9.276220823039212e+03 + 113460 1.001756547813290e+00 -5.982426240245941e+00 -6.057922556079553e+00 3.757750551901283e+00 4.324239023367566e+00 9.395665108339999e+03 + 113480 1.015196367003099e+00 -5.990564479473477e+00 -5.969063691067853e+00 3.733970041229139e+00 4.857430895490484e+00 9.122340691189223e+03 + 113500 1.042225537171450e+00 -6.016077711191711e+00 -5.985921560495115e+00 3.575495813705442e+00 4.748657097654534e+00 9.173872825731221e+03 + 113520 1.007319428514144e+00 -5.946725374094977e+00 -6.003418236148338e+00 3.982075667860210e+00 4.656536480757762e+00 9.227545059481952e+03 + 113540 1.050219067217656e+00 -5.989733901266715e+00 -6.025904823883949e+00 3.747126187631754e+00 4.539427152531409e+00 9.296750135214812e+03 + 113560 1.003340680244085e+00 -5.900939500241304e+00 -6.015415308884916e+00 4.195501414726739e+00 4.538163606420983e+00 9.264405088554324e+03 + 113580 1.022698701296181e+00 -5.909868150688153e+00 -5.987593712232410e+00 4.193811383902975e+00 4.747499181524073e+00 9.178987311308834e+03 + 113600 1.032740644715201e+00 -5.903379258879385e+00 -6.000433707116976e+00 4.203656646855347e+00 4.646354985947773e+00 9.218373224810033e+03 + 113620 1.047077432127802e+00 -5.906702091021727e+00 -6.007059782127608e+00 4.212156969808298e+00 4.635887577175825e+00 9.238708274640712e+03 + 113640 1.052955777376649e+00 -5.900340703230023e+00 -6.041548875597170e+00 4.181817500390880e+00 4.370978322764675e+00 9.345036322525064e+03 + 113660 1.038067852969595e+00 -5.869296930984168e+00 -6.055918359468057e+00 4.371771168167756e+00 4.300162046240543e+00 9.389493057526242e+03 + 113680 1.056589186956626e+00 -5.895449524631271e+00 -6.031407265817788e+00 4.257625785866979e+00 4.476935396581545e+00 9.313717935990524e+03 + 113700 1.050538345841123e+00 -5.895524532352146e+00 -6.044808932132742e+00 4.260273794575599e+00 4.403059669349215e+00 9.355113587131962e+03 + 113720 1.074885998847172e+00 -5.954350361887677e+00 -6.025857223326557e+00 3.914453707121072e+00 4.503850243087978e+00 9.296584508895930e+03 + 113740 1.053075397223026e+00 -5.954744155927774e+00 -6.001508083760733e+00 3.898295665235451e+00 4.629769954924154e+00 9.221686030258621e+03 + 113760 1.025585563791690e+00 -5.957370283479980e+00 -6.001640570047318e+00 3.900885532488576e+00 4.646678696214220e+00 9.222073916126019e+03 + 113780 8.998515792944268e-01 -5.816606662768066e+00 -6.027392709221391e+00 4.645075236218830e+00 4.434709138448574e+00 9.301294051286970e+03 + 113800 9.811905624752199e-01 -5.973878343877914e+00 -5.982605605038614e+00 3.835221682638848e+00 4.785108398514804e+00 9.163714929966771e+03 + 113820 9.934160151628730e-01 -6.021666903517557e+00 -5.997696693279383e+00 3.536254321636803e+00 4.673894978202444e+00 9.210002738143923e+03 + 113840 9.737065389766182e-01 -6.015403846106145e+00 -5.977399969508779e+00 3.644048051755810e+00 4.862272192258784e+00 9.147819552461540e+03 + 113860 9.419595028828395e-01 -5.983252814457114e+00 -5.986243341309979e+00 3.807917441058289e+00 4.790745373086603e+00 9.174864569835896e+03 + 113880 1.014161182161389e+00 -6.099633189523920e+00 -6.020831043642458e+00 3.124665725130521e+00 4.577159841374538e+00 9.281129047288558e+03 + 113900 9.425815441541968e-01 -6.000270028524186e+00 -6.055117291191817e+00 3.625014716736513e+00 4.310073246912506e+00 9.387038041916008e+03 + 113920 9.786022812600489e-01 -6.057628175858474e+00 -6.013084054052003e+00 3.371910455765320e+00 4.627689696358651e+00 9.257257672631400e+03 + 113940 9.867476542686633e-01 -6.068765361976183e+00 -6.000289986208443e+00 3.300645310957464e+00 4.693841515145977e+00 9.217953097546868e+03 + 113960 1.003422502165611e+00 -6.090572723931144e+00 -5.998975343525998e+00 3.197176461449330e+00 4.723142794384483e+00 9.213921152947407e+03 + 113980 9.627326098706298e-01 -6.025589447105665e+00 -6.001838292673305e+00 3.561306535963781e+00 4.697689340193664e+00 9.222713135366852e+03 + 114000 9.796489269414600e-01 -6.041866416395470e+00 -5.989062316660795e+00 3.448739692527652e+00 4.751949004612179e+00 9.183519440488215e+03 + 114020 9.346380606295448e-01 -5.962108933495319e+00 -5.987031048555338e+00 3.921498454817052e+00 4.778391813457584e+00 9.177270822845239e+03 + 114040 9.751387997110569e-01 -6.001678021620756e+00 -5.998260281481974e+00 3.658858094438387e+00 4.678483287208852e+00 9.211716054873848e+03 + 114060 9.860131812443126e-01 -5.991667307521560e+00 -6.027757424382947e+00 3.703877210246245e+00 4.496642174300626e+00 9.302456102718763e+03 + 114080 9.921474886988131e-01 -5.971054936866729e+00 -6.012756016254434e+00 3.824063149614919e+00 4.584609098549535e+00 9.256245319786511e+03 + 114100 1.019828524285505e+00 -5.976747753341808e+00 -6.044445306247016e+00 3.764883925489777e+00 4.376154100545620e+00 9.353989732692255e+03 + 114120 9.882021164453505e-01 -5.889493609194682e+00 -6.077097719552444e+00 4.256889331022283e+00 4.179637497705761e+00 9.455256473250043e+03 + 114140 1.030486584176072e+00 -5.916341212573789e+00 -6.062143370503573e+00 4.123738650521107e+00 4.286520096877266e+00 9.408800733404629e+03 + 114160 1.063359669427315e+00 -5.936238270127506e+00 -6.012069530042528e+00 4.047096240272996e+00 4.611661410991393e+00 9.254142593007815e+03 + 114180 1.050541370107577e+00 -5.893609155871461e+00 -6.025051878750728e+00 4.274310188340356e+00 4.519545732871980e+00 9.294108985563995e+03 + 114200 1.094432762963120e+00 -5.942923317653832e+00 -5.989601917072211e+00 4.032676581092327e+00 4.764640839742079e+00 9.185155980144298e+03 + 114220 1.088926875207340e+00 -5.925776214413763e+00 -6.010835869172358e+00 4.058571577960684e+00 4.570145877397798e+00 9.250367507081599e+03 + 114240 1.069264724042458e+00 -5.899449273746848e+00 -6.032158363066292e+00 4.229375104227945e+00 4.467338976690493e+00 9.315956349086206e+03 + 114260 1.083421741865366e+00 -5.933198956609873e+00 -5.972542681227511e+00 4.065550062417451e+00 4.839632307241267e+00 9.132938352588442e+03 + 114280 1.083022835165377e+00 -5.959972517503360e+00 -6.007257074784797e+00 3.918675217654094e+00 4.647159972482491e+00 9.239334848276543e+03 + 114300 1.082392150885630e+00 -6.012394619496114e+00 -6.009602066305315e+00 3.608715721067218e+00 4.624750993634994e+00 9.246561673501015e+03 + 114320 9.700264706495696e-01 -5.927630750787491e+00 -6.036043276474571e+00 4.120490663887840e+00 4.497969164608500e+00 9.328029763383518e+03 + 114340 9.954101226594214e-01 -6.040689383524455e+00 -5.947270380907034e+00 3.482128612807795e+00 5.018554982380966e+00 9.055872356505424e+03 + 114360 9.292239177038009e-01 -5.982980781215915e+00 -5.994091202285284e+00 3.761922049463488e+00 4.698124292351068e+00 9.198894668707511e+03 + 114380 9.619820502619039e-01 -6.049098354656472e+00 -6.000154781430158e+00 3.409741706612032e+00 4.690783278071005e+00 9.217523716071326e+03 + 114400 9.768387010777391e-01 -6.079741828497829e+00 -6.031865078037186e+00 3.283852798223473e+00 4.558768508271672e+00 9.315147493199109e+03 + 114420 9.629497813635184e-01 -6.064177752355752e+00 -6.009004013035639e+00 3.401914680615440e+00 4.718730829900094e+00 9.244738799006736e+03 + 114440 9.147826953136544e-01 -5.994525523149212e+00 -6.043154360747564e+00 3.713830790271474e+00 4.434596479493442e+00 9.349998078941147e+03 + 114460 9.553838963361226e-01 -6.051923662995337e+00 -5.992843193483983e+00 3.419891406634385e+00 4.759140605241692e+00 9.195092019792442e+03 + 114480 9.452436536673279e-01 -6.029178878870180e+00 -5.975355601258018e+00 3.512169287380464e+00 4.821230876554790e+00 9.141582582355402e+03 + 114500 9.823228282023926e-01 -6.070902426801348e+00 -5.956711942374866e+00 3.317638853818237e+00 4.973338286315450e+00 9.084652138583035e+03 + 114520 1.000876255782605e+00 -6.078013754265454e+00 -5.955857762718504e+00 3.264614436873646e+00 4.966053043914828e+00 9.082039300003080e+03 + 114540 1.014442520101913e+00 -6.073646691955214e+00 -5.978861084486212e+00 3.310197862950817e+00 4.854471489063180e+00 9.152267007072856e+03 + 114560 9.693961845560765e-01 -5.978953256507222e+00 -5.984412319966665e+00 3.853441256137522e+00 4.822094468966064e+00 9.169241941284421e+03 + 114580 1.007929287847707e+00 -6.009380052625222e+00 -5.989660196653920e+00 3.604205485988093e+00 4.717439950613154e+00 9.185339913007292e+03 + 114600 9.725695802139834e-01 -5.928041434326980e+00 -6.027440444911514e+00 4.070928579763370e+00 4.500164079039803e+00 9.301462623733027e+03 + 114620 1.043693670447073e+00 -6.006573145835667e+00 -5.991770925698002e+00 3.693262985818083e+00 4.778259624484720e+00 9.191797036355747e+03 + 114640 1.079952694695270e+00 -6.037249395428407e+00 -5.960907062360873e+00 3.549450785652990e+00 4.987820276064634e+00 9.097429239082783e+03 + 114660 9.383260575810518e-01 -5.809376018439686e+00 -6.023460614362256e+00 4.713333259374333e+00 4.484026380102784e+00 9.289186510785454e+03 + 114680 1.055856191665085e+00 -5.968635032042426e+00 -6.064488785176799e+00 3.851559257967372e+00 4.301152174149445e+00 9.416074901282713e+03 + 114700 1.087402687028027e+00 -6.008766321105809e+00 -6.031468567514963e+00 3.600792002171556e+00 4.470432190128915e+00 9.313916101339617e+03 + 114720 1.064652066092353e+00 -5.974993807848179e+00 -6.000377929022475e+00 3.786046499451994e+00 4.640286947489125e+00 9.218214015278099e+03 + 114740 1.006319703212765e+00 -5.893091868232040e+00 -6.011445934295292e+00 4.272232351077165e+00 4.592624988509443e+00 9.252194207029503e+03 + 114760 1.071149147041094e+00 -6.000529432815002e+00 -5.967311005429825e+00 3.672660602337353e+00 4.863405952918062e+00 9.116976053116683e+03 + 114780 1.016526094179888e+00 -5.934390990105738e+00 -6.004028110364219e+00 4.006024034276619e+00 4.606156913442891e+00 9.229398661319876e+03 + 114800 1.046816526885964e+00 -6.001060693738724e+00 -5.997184541812818e+00 3.627430759602520e+00 4.649688223793648e+00 9.208408159921230e+03 + 114820 1.013846254401766e+00 -5.981779559520774e+00 -6.019890306189137e+00 3.770930768939599e+00 4.552092963950869e+00 9.278222826777095e+03 + 114840 9.964909028261082e-01 -5.996423795028862e+00 -5.999685462779331e+00 3.676494015394494e+00 4.657765014429852e+00 9.216076650422887e+03 + 114860 9.723222901295113e-01 -6.002709096471598e+00 -6.002248431047660e+00 3.655093696980362e+00 4.657738909132361e+00 9.223920683375436e+03 + 114880 9.400416672204666e-01 -5.995245773632248e+00 -5.965695124989861e+00 3.739202590417953e+00 4.908886987870634e+00 9.112022044677051e+03 + 114900 9.510716716685754e-01 -6.041368257058982e+00 -5.972286449209109e+00 3.450129316652240e+00 4.846807747701426e+00 9.132180604290528e+03 + 114920 9.681076098745554e-01 -6.086575142489485e+00 -5.997171769049364e+00 3.224702423195043e+00 4.738070428615547e+00 9.208359732871302e+03 + 114940 9.239029819038312e-01 -6.032451052621890e+00 -6.038879119918727e+00 3.494118426333549e+00 4.457207469174907e+00 9.336769979537325e+03 + 114960 9.480145236825330e-01 -6.071989603815435e+00 -6.011606522188714e+00 3.273176789605037e+00 4.619905788557350e+00 9.252735812887746e+03 + 114980 9.765913709031915e-01 -6.112709121477099e+00 -5.998737288213675e+00 3.062756191339892e+00 4.717200095022669e+00 9.213191822856972e+03 + 115000 9.178963608371304e-01 -6.020827292474923e+00 -6.040121661787843e+00 3.548176375250645e+00 4.437385120861856e+00 9.340643001495084e+03 + 115020 9.241329626305060e-01 -6.020551123817016e+00 -6.017852294230958e+00 3.584223887318436e+00 4.599720984444112e+00 9.271947677248656e+03 + 115040 1.030702678947415e+00 -6.167277443705819e+00 -5.979512353629204e+00 2.738371741343185e+00 4.816547945116891e+00 9.154274337241171e+03 + 115060 8.892205839238039e-01 -5.944257832735749e+00 -5.981175709446179e+00 4.003795115143277e+00 4.791806954049037e+00 9.159352679028119e+03 + 115080 9.509065594376679e-01 -6.019452518676124e+00 -5.987881299725442e+00 3.604992694073274e+00 4.786279518918430e+00 9.179882611404017e+03 + 115100 1.022923552001368e+00 -6.108456411059230e+00 -6.010954280589351e+00 3.103844461030743e+00 4.663716782594715e+00 9.250711568894401e+03 + 115120 9.289438805474236e-01 -5.954300757429904e+00 -6.002013976914299e+00 3.932351804469786e+00 4.658375114593535e+00 9.223225970910233e+03 + 115140 1.015525836753969e+00 -6.068735540084957e+00 -5.980260312572714e+00 3.390255140412124e+00 4.898293588284629e+00 9.156527295758091e+03 + 115160 1.007834078863773e+00 -6.041232032873965e+00 -5.968182306532304e+00 3.494860377152448e+00 4.914323210214880e+00 9.119632628825573e+03 + 115180 9.715186788968777e-01 -5.972541205707669e+00 -6.018480680356728e+00 3.840614558254898e+00 4.576822985709279e+00 9.273845887553160e+03 + 115200 9.958129441781630e-01 -5.996397689835851e+00 -5.972069949272341e+00 3.745179390316250e+00 4.884873041337607e+00 9.131484518209043e+03 + 115220 1.013946942597300e+00 -6.010614831170975e+00 -5.969602480367017e+00 3.632129949919215e+00 4.867629214876313e+00 9.123935382373111e+03 + 115240 1.039725304555369e+00 -6.036923892259118e+00 -5.945281042448188e+00 3.516750523237585e+00 5.042977948537121e+00 9.049791565059724e+03 + 115260 9.610392101527505e-01 -5.910101206941224e+00 -5.977904796235226e+00 4.221064177604167e+00 4.831725475306480e+00 9.149319946515872e+03 + 115280 1.040537989738645e+00 -6.017121927489627e+00 -5.994330812608716e+00 3.605543708755364e+00 4.736413817315186e+00 9.199654132668147e+03 + 115300 1.010127554607323e+00 -5.964317136589941e+00 -5.978448919152290e+00 3.940914263131295e+00 4.859767380772000e+00 9.150987558602437e+03 + 115320 1.000125664603777e+00 -5.944416017618559e+00 -5.962404474578354e+00 3.995346188368585e+00 4.892053684800728e+00 9.101990618025296e+03 + 115340 9.931153703512151e-01 -5.927274894442545e+00 -6.009741719702250e+00 4.083007330843677e+00 4.609470058502484e+00 9.246960898617346e+03 + 115360 1.073291977693205e+00 -6.040532684162450e+00 -6.031359936546205e+00 3.469474878086019e+00 4.522146214376601e+00 9.313593265285479e+03 + 115380 1.048109919180904e+00 -6.004915350070904e+00 -6.041400414563447e+00 3.617605432700438e+00 4.408102546338775e+00 9.344599793286005e+03 + 115400 9.956468140184118e-01 -5.934075115563157e+00 -6.052339705344545e+00 4.006694119212904e+00 4.327600543302053e+00 9.378432410737096e+03 + 115420 1.045542016543026e+00 -6.020079738255394e+00 -5.966234939883172e+00 3.627778386925842e+00 4.936963551634754e+00 9.113689175149106e+03 + 115440 1.023036918712562e+00 -6.005575500060338e+00 -6.025634908647438e+00 3.674140004391016e+00 4.558955776100445e+00 9.295902868185583e+03 + 115460 1.041102068921217e+00 -6.066130058718468e+00 -5.970614857180006e+00 3.382650132749238e+00 4.931113200912749e+00 9.127079476031246e+03 + 115480 9.203568281206690e-01 -5.937358110427454e+00 -6.063543342792972e+00 4.028886514643566e+00 4.304311383299162e+00 9.413143861858012e+03 + 115500 1.012299057173040e+00 -6.138508526522807e+00 -5.975332757155782e+00 2.954050964756214e+00 4.891031483830373e+00 9.141493773589733e+03 + 115520 9.715557378186813e-01 -6.131440044079490e+00 -5.948343655893916e+00 2.975568484961382e+00 5.026936279997447e+00 9.059150696749442e+03 + 115540 9.118730019795683e-01 -6.074393014319377e+00 -5.933607904050456e+00 3.343420723767477e+00 5.151830613357022e+00 9.014379876483645e+03 + 115560 9.207773024323593e-01 -6.101102100523610e+00 -5.972926960673255e+00 3.167902713726190e+00 4.903904201785718e+00 9.134132008995457e+03 + 115580 9.105257102707112e-01 -6.088702938288703e+00 -5.973195826777962e+00 3.261031852617460e+00 4.924291561579876e+00 9.134945660869205e+03 + 115600 9.617326767236335e-01 -6.159179780951208e+00 -5.979350106266597e+00 2.890579478538781e+00 4.923189299130033e+00 9.153777756609581e+03 + 115620 9.042531741561836e-01 -6.060812914187831e+00 -6.013864067497362e+00 3.443164775607219e+00 4.712752318614437e+00 9.259677245368921e+03 + 115640 9.220299390906123e-01 -6.066738135501731e+00 -6.029076957483925e+00 3.338283811096729e+00 4.554540123323434e+00 9.306548153145890e+03 + 115660 9.639084238432762e-01 -6.103610004666057e+00 -6.030305842166404e+00 3.137563352987946e+00 4.558487197843437e+00 9.310341263178330e+03 + 115680 9.145255321660365e-01 -6.001427996233648e+00 -5.998315299153817e+00 3.695667806739961e+00 4.713541395060665e+00 9.211881409428577e+03 + 115700 9.553630288263529e-01 -6.031278051246264e+00 -6.000570034634242e+00 3.594715348471062e+00 4.771045531907507e+00 9.218806326931493e+03 + 115720 9.945925536684486e-01 -6.057798199341484e+00 -6.014929187218487e+00 3.384939433558139e+00 4.631099935126571e+00 9.262938358839685e+03 + 115740 1.021699971541656e+00 -6.070613011459958e+00 -5.975887170163594e+00 3.342474301828525e+00 4.886404741328811e+00 9.143173422459167e+03 + 115760 9.700031369192553e-01 -5.969538574021396e+00 -5.981816074809507e+00 3.857382858321078e+00 4.786883548858633e+00 9.161305689323661e+03 + 115780 9.988289257407426e-01 -5.990131029621454e+00 -5.995432031597927e+00 3.765402913306718e+00 4.734963739630405e+00 9.203041822547688e+03 + 115800 1.052188810888908e+00 -6.050853300296617e+00 -6.000421677675077e+00 3.399083329501546e+00 4.688669510862807e+00 9.218353398333911e+03 + 115820 1.000394795432823e+00 -5.961474652050136e+00 -6.018572811163777e+00 3.904024755551531e+00 4.576158290009444e+00 9.274133751460427e+03 + 115840 1.046020364870198e+00 -6.020010109996225e+00 -5.959430073031417e+00 3.608853199658400e+00 4.956713146640748e+00 9.092934509253093e+03 + 115860 1.034782571185651e+00 -5.996342500305641e+00 -5.979123811717315e+00 3.797170765355629e+00 4.896043139813241e+00 9.153063242848109e+03 + 115880 9.758561317877346e-01 -5.904028988817292e+00 -6.065155162062768e+00 4.197173080486555e+00 4.271961659516314e+00 9.418146942542193e+03 + 115900 1.062677934727908e+00 -6.030077912830269e+00 -6.047957521348196e+00 3.571521267162151e+00 4.468853788191737e+00 9.364843425822442e+03 + 115920 1.081859106295466e+00 -6.061972338223803e+00 -6.039273327423494e+00 3.363877716782011e+00 4.494218949457953e+00 9.338013419243680e+03 + 115940 9.822729082433367e-01 -5.924371721599683e+00 -6.060459688222817e+00 4.089102969013179e+00 4.307664805118370e+00 9.403582946778793e+03 + 115960 1.012957824766927e+00 -5.982550044872101e+00 -6.029521056387285e+00 3.784290604378152e+00 4.514575787517424e+00 9.307912425487641e+03 + 115980 9.396746395141170e-01 -5.889837349008130e+00 -6.062989449392319e+00 4.222877096021850e+00 4.228610940414900e+00 9.411427270345921e+03 + 116000 1.031122994718072e+00 -6.044249450151669e+00 -5.978454520717158e+00 3.483480248621340e+00 4.861284915166725e+00 9.151005894809241e+03 + 116020 9.354646733985654e-01 -5.924129573932783e+00 -6.014962313907153e+00 4.110404833343594e+00 4.588829184089675e+00 9.263015470176391e+03 + 116040 1.030500725489004e+00 -6.091069232017360e+00 -5.993189032585672e+00 3.201235132201953e+00 4.763278384250619e+00 9.196157722487349e+03 + 116060 9.038974239050119e-01 -5.935100148551932e+00 -6.057540246978618e+00 3.980274384780352e+00 4.277204392070320e+00 9.394541130046964e+03 + 116080 9.603086245563205e-01 -6.055080806287993e+00 -5.986830468423485e+00 3.421988336012981e+00 4.813892337736634e+00 9.176665692039935e+03 + 116100 9.513651409710076e-01 -6.081315534991525e+00 -5.996097801529330e+00 3.250767798613162e+00 4.740101211554721e+00 9.205083974735604e+03 + 116120 9.732466298336454e-01 -6.153925038795144e+00 -5.972502966546281e+00 2.865245762611055e+00 4.906999376438975e+00 9.132851135139987e+03 + 116140 9.087552142882209e-01 -6.093302374262454e+00 -5.966527192413406e+00 3.204334551733936e+00 4.932297264307158e+00 9.114587444245022e+03 + 116160 9.099161415141690e-01 -6.119813414145220e+00 -5.966023142919350e+00 3.017447384431484e+00 4.900534920777986e+00 9.113045712964693e+03 + 116180 8.945087717816963e-01 -6.109287518316867e+00 -5.936906726790745e+00 3.118484254954121e+00 5.108321435738388e+00 9.024374313240840e+03 + 116200 9.442702492243973e-01 -6.182475952947275e+00 -5.935906724154090e+00 2.764760376601816e+00 5.180599044797128e+00 9.021350887475619e+03 + 116220 8.854159564291245e-01 -6.082468994502046e+00 -5.996480450526134e+00 3.308289226710735e+00 4.802048752904602e+00 9.206244597715879e+03 + 116240 9.036437257243478e-01 -6.088056612303204e+00 -6.034085430972494e+00 3.188896328684172e+00 4.498807203898425e+00 9.322000641225130e+03 + 116260 9.312384602596577e-01 -6.100188858327566e+00 -6.018578053449547e+00 3.222751164646158e+00 4.691373035486981e+00 9.274188011780099e+03 + 116280 9.119513624836280e-01 -6.040993530577998e+00 -6.008796905818233e+00 3.450438866058345e+00 4.635316867840496e+00 9.244096667457005e+03 + 116300 9.503922175874270e-01 -6.068160574795234e+00 -6.004215902434363e+00 3.342873138108037e+00 4.710053342210228e+00 9.229991900236095e+03 + 116320 9.694570530875718e-01 -6.071954840489939e+00 -5.968731159605627e+00 3.328909412178663e+00 4.921635761629373e+00 9.121319205841346e+03 + 116340 9.172385735394100e-01 -5.975930271502030e+00 -5.987661946743875e+00 3.849655872959238e+00 4.782290778249688e+00 9.179186505018217e+03 + 116360 9.765769197059166e-01 -6.047699254058145e+00 -6.012339402589266e+00 3.449232002462557e+00 4.652273741516193e+00 9.254979434116043e+03 + 116380 1.061250450079728e+00 -6.161175771908096e+00 -5.983660453721100e+00 2.864550918137086e+00 4.883871345573527e+00 9.166986488932809e+03 + 116400 1.018380476412408e+00 -6.089173037608483e+00 -5.975936168469473e+00 3.260554958380084e+00 4.910778584325148e+00 9.143316923376000e+03 + 116420 9.426132546792290e-01 -5.968082801977380e+00 -5.958955050748362e+00 3.857004128806464e+00 4.909417088878424e+00 9.091473477394016e+03 + 116440 9.533238392850396e-01 -5.969158693430990e+00 -5.975431481322770e+00 3.856905639223822e+00 4.820886320438431e+00 9.141767957923632e+03 + 116460 1.030567402346188e+00 -6.064469809608874e+00 -6.012715032029179e+00 3.371759328516851e+00 4.668943270405409e+00 9.256129018983589e+03 + 116480 9.798044679210388e-01 -5.970773611552971e+00 -6.038131959350080e+00 3.832793616999505e+00 4.446011560277872e+00 9.334464675942681e+03 + 116500 1.021665062862286e+00 -6.016053228313108e+00 -6.012362116125058e+00 3.642291667003924e+00 4.663486604385472e+00 9.255036966653033e+03 + 116520 1.059721401741677e+00 -6.057713753944791e+00 -5.966636699588133e+00 3.382092033514646e+00 4.905070573759185e+00 9.114928294018418e+03 + 116540 1.020265898691243e+00 -5.986129155049865e+00 -5.968062657247517e+00 3.738263561832127e+00 4.842004187994711e+00 9.119255103104861e+03 + 116560 1.018987155163338e+00 -5.969628157823351e+00 -5.980931234672534e+00 3.837056926850036e+00 4.772152910436540e+00 9.158592954656555e+03 + 116580 9.630196950285493e-01 -5.871760839952514e+00 -5.985489775502384e+00 4.313443773629960e+00 4.660394626206705e+00 9.172564722253304e+03 + 116600 1.007853862377505e+00 -5.925468670412654e+00 -5.980933827388548e+00 4.120876973894704e+00 4.802387459333818e+00 9.158572455408967e+03 + 116620 1.027999273022305e+00 -5.942720599627634e+00 -5.961575480746031e+00 4.054882312195568e+00 4.946614667030309e+00 9.099457512313644e+03 + 116640 1.051012266785894e+00 -5.964490574057844e+00 -6.004642372790163e+00 3.848970723393814e+00 4.618412881602071e+00 9.231317273956935e+03 + 116660 1.069358629048443e+00 -5.984089386623952e+00 -6.023544518834824e+00 3.762161958572526e+00 4.535604483755720e+00 9.289470948138840e+03 + 116680 1.030723200462149e+00 -5.925157504185580e+00 -6.013246146460805e+00 4.065594384049453e+00 4.559775768431774e+00 9.257708360489298e+03 + 116700 1.064677497428799e+00 -5.976897741760316e+00 -6.021782587703358e+00 3.810142109254636e+00 4.552406377942233e+00 9.284017686560646e+03 + 116720 1.053431909935035e+00 -5.969008086774300e+00 -6.007164747993543e+00 3.834211712869211e+00 4.615110259424076e+00 9.239044620107488e+03 + 116740 1.019202071705839e+00 -5.936751041947703e+00 -6.015839729736149e+00 4.041286538402251e+00 4.587147054186119e+00 9.265709010932214e+03 + 116760 9.846562919879001e-01 -5.912487364498100e+00 -6.011375373325551e+00 4.119300061850528e+00 4.551469812293397e+00 9.251965824402665e+03 + 116780 9.990828682814556e-01 -5.967851934907188e+00 -5.978517796218746e+00 3.859978311109554e+00 4.798733284921882e+00 9.151219367246362e+03 + 116800 9.625785040160860e-01 -5.953987595225881e+00 -5.999382392243342e+00 3.931938094408617e+00 4.671274145112221e+00 9.215126213861276e+03 + 116820 9.621214874782613e-01 -5.993322725926472e+00 -5.947194562347585e+00 3.686240485073444e+00 4.951115538653657e+00 9.055650081906022e+03 + 116840 9.395934667930859e-01 -5.991854408149713e+00 -5.949831094655862e+00 3.769632724077421e+00 5.010937093245857e+00 9.063676772117529e+03 + 116860 9.301236941968620e-01 -6.000833611241911e+00 -5.979386316687211e+00 3.658157756296570e+00 4.781311440587762e+00 9.153881690926941e+03 + 116880 9.479532360604741e-01 -6.042749686270877e+00 -5.949307828546516e+00 3.509093077457403e+00 5.045650684591436e+00 9.062078997674256e+03 + 116900 9.561257927371727e-01 -6.062039846005219e+00 -5.977709160746405e+00 3.379186792956477e+00 4.863426637843956e+00 9.148723679338884e+03 + 116920 9.276129248641349e-01 -6.021286847915617e+00 -6.014267775660543e+00 3.538092806027338e+00 4.578397405113893e+00 9.260914158091413e+03 + 116940 9.510795173945297e-01 -6.052522060911524e+00 -6.026200100035365e+00 3.387940740133729e+00 4.539085512794913e+00 9.297666942854925e+03 + 116960 1.019845104360306e+00 -6.146899968077982e+00 -5.994478259281532e+00 2.866974850124708e+00 4.742203889217126e+00 9.200127906495523e+03 + 116980 9.756781087407516e-01 -6.071723755635213e+00 -5.987901635880116e+00 3.310282088969493e+00 4.791601672034371e+00 9.179962188692736e+03 + 117000 9.281734251934216e-01 -5.985707700554117e+00 -6.025820514553638e+00 3.779199934544983e+00 4.548865949121833e+00 9.296494952279943e+03 + 117020 9.432781024730112e-01 -5.988946390547442e+00 -5.967503209163304e+00 3.822867181271656e+00 4.945997247100969e+00 9.117554767328484e+03 + 117040 9.583512798227373e-01 -5.986573502704617e+00 -6.013298236303530e+00 3.718972500455430e+00 4.565514944491309e+00 9.257902787041034e+03 + 117060 9.882685792889527e-01 -5.998234510687446e+00 -5.983913436038632e+00 3.733254872848073e+00 4.815488699660704e+00 9.167720978088997e+03 + 117080 1.019522954614620e+00 -6.008095744380225e+00 -5.989631725885376e+00 3.664306646126833e+00 4.770329897621882e+00 9.185245978483676e+03 + 117100 1.022742762008697e+00 -5.973591559650266e+00 -6.007460328340685e+00 3.786783460489525e+00 4.592303749494124e+00 9.239978452914109e+03 + 117120 1.066197529122326e+00 -6.007176109228332e+00 -6.014353996465731e+00 3.643914818209212e+00 4.602698278917607e+00 9.261158831768915e+03 + 117140 9.881006967305728e-01 -5.869820476717267e+00 -6.034678817315542e+00 4.399316556402081e+00 4.452674452941031e+00 9.323798062799246e+03 + 117160 1.030539830652059e+00 -5.918659995682388e+00 -6.007462112918757e+00 4.082850316285435e+00 4.572934817030973e+00 9.239979174635508e+03 + 117180 1.131507780672809e+00 -6.062584660096896e+00 -5.983146977382847e+00 3.374884803360044e+00 4.831028270445782e+00 9.165392525640622e+03 + 117200 1.041524498291152e+00 -5.930995373058050e+00 -6.013987333462575e+00 4.120418072988906e+00 4.643865393381756e+00 9.260014118146810e+03 + 117220 1.076369914689623e+00 -5.988610258177175e+00 -6.022164913096231e+00 3.764174554713937e+00 4.571498533602655e+00 9.285205285436094e+03 + 117240 1.036074716018124e+00 -5.938800209731111e+00 -6.014466490743399e+00 4.061964684334772e+00 4.627477189443070e+00 9.261506344802534e+03 + 117260 1.055916133359598e+00 -5.981084700272936e+00 -5.969795488523319e+00 3.821349547303758e+00 4.886173948169929e+00 9.124577962959447e+03 + 117280 1.085826851155927e+00 -6.039298658340408e+00 -5.990179985643739e+00 3.528397137691285e+00 4.810444157405598e+00 9.186932668366620e+03 + 117300 1.049924832951427e+00 -6.001457273730221e+00 -5.987876012477180e+00 3.692035514309885e+00 4.770021218118234e+00 9.179864875685998e+03 + 117320 1.026470608705965e+00 -5.982980079470241e+00 -5.969502006146741e+00 3.856974600582915e+00 4.934367783331554e+00 9.123633021337715e+03 + 117340 9.672647171188222e-01 -5.912660858387021e+00 -6.034321630651412e+00 4.177794553625223e+00 4.479199572339424e+00 9.322673775456522e+03 + 117360 9.756341364402142e-01 -5.943987035462412e+00 -5.984313074083342e+00 4.018318619225488e+00 4.786760265029796e+00 9.168931492484691e+03 + 117380 9.609231430044249e-01 -5.938329974135836e+00 -5.993719327118356e+00 3.999815381952074e+00 4.681761145651766e+00 9.197767197717025e+03 + 117400 1.012353333885247e+00 -6.028035347910292e+00 -6.025025220488160e+00 3.519195750072419e+00 4.536480367546011e+00 9.294032582776907e+03 + 117420 9.489457129313001e-01 -5.951327763350410e+00 -6.037901255242147e+00 3.935758455786677e+00 4.438640068139752e+00 9.333764056221191e+03 + 117440 9.445708759223884e-01 -5.960462189745360e+00 -5.990033745173322e+00 3.910733876302713e+00 4.740929428851942e+00 9.186471787454446e+03 + 117460 9.434124395959006e-01 -5.972933806267852e+00 -6.014846898821684e+00 3.855114146697268e+00 4.614442683223055e+00 9.262685556169990e+03 + 117480 1.029768241905908e+00 -6.111558884935205e+00 -6.005455998739332e+00 3.119073227050341e+00 4.728332418955617e+00 9.233822365403106e+03 + 117500 9.769086919284679e-01 -6.044436604032393e+00 -6.016985916727016e+00 3.444257145916046e+00 4.601883240403650e+00 9.269291867398664e+03 + 117520 9.495039240236921e-01 -6.016010333128997e+00 -6.000226774942446e+00 3.625453953918314e+00 4.716085587523223e+00 9.217724808022625e+03 + 117540 9.526195578239912e-01 -6.030288880329453e+00 -5.946567081999487e+00 3.539158773361602e+00 5.019902295278685e+00 9.053726143636381e+03 + 117560 9.494611283781205e-01 -6.030262580279608e+00 -6.005351518132177e+00 3.547331480145391e+00 4.690374653970347e+00 9.233481450800808e+03 + 117580 1.014718524817938e+00 -6.128983842882715e+00 -5.979754026246431e+00 3.035136986286402e+00 4.892037686651443e+00 9.155014271050281e+03 + 117600 9.611138220754462e-01 -6.047053126315208e+00 -5.980688542331185e+00 3.444807528132988e+00 4.825883239255432e+00 9.157873727707443e+03 + 117620 9.305216831465826e-01 -5.993248371506033e+00 -6.014324861220105e+00 3.769225379941452e+00 4.648200914427006e+00 9.261058161889214e+03 + 117640 9.107588512095844e-01 -5.946925572839532e+00 -6.021597790088206e+00 3.934252666080675e+00 4.505473239150512e+00 9.283451962906158e+03 + 117660 1.016245166873432e+00 -6.074942049556149e+00 -6.008733797041549e+00 3.272143457659779e+00 4.652321489292579e+00 9.243889726021271e+03 + 117680 9.971917289794366e-01 -6.010328255578628e+00 -6.003668020504919e+00 3.650134736154496e+00 4.688378836615781e+00 9.228308466474928e+03 + 117700 1.002784871478584e+00 -5.981739123559359e+00 -6.009413428589382e+00 3.823969782984129e+00 4.665059640916876e+00 9.245969654489380e+03 + 117720 9.621637078652987e-01 -5.881890020335275e+00 -6.027270993673513e+00 4.301841383107339e+00 4.467041336566264e+00 9.300938370291207e+03 + 117740 1.057303598394193e+00 -5.989826227045024e+00 -5.977559459356325e+00 3.788376130882235e+00 4.858813809226908e+00 9.148280814540913e+03 + 117760 1.097135339569717e+00 -6.020186507280268e+00 -6.049025313325066e+00 3.552091849656148e+00 4.386494962556105e+00 9.368162550400513e+03 + 117780 1.071756202961003e+00 -5.966251253205427e+00 -6.055453358625384e+00 3.862280203858887e+00 4.350067910556293e+00 9.388048637247737e+03 + 117800 1.037176040786494e+00 -5.908744485813752e+00 -6.028937634025489e+00 4.188231469395703e+00 4.498063812534339e+00 9.306089888485878e+03 + 117820 1.075759116551152e+00 -5.965853979292499e+00 -5.998193602889000e+00 3.987517445788413e+00 4.801818322556727e+00 9.211474672851486e+03 + 117840 1.070607953867520e+00 -5.964283839229544e+00 -6.007079325810753e+00 3.918557710889191e+00 4.672819404359745e+00 9.238731971347552e+03 + 117860 1.039447639050331e+00 -5.929758603858235e+00 -5.982729653722780e+00 4.024977051983665e+00 4.720809086417975e+00 9.164115693955537e+03 + 117880 1.068408093274025e+00 -5.989968063481235e+00 -6.015422446177435e+00 3.733812854573883e+00 4.587649850079311e+00 9.264451853673787e+03 + 117900 1.023459730636067e+00 -5.949148726159465e+00 -5.995437999351856e+00 4.001604361595851e+00 4.735804191683266e+00 9.203043321360605e+03 + 117920 1.003054202357790e+00 -5.948800062575615e+00 -5.972594525933745e+00 3.994270277794433e+00 4.857638787010742e+00 9.133094934464398e+03 + 117940 1.076917366829456e+00 -6.088786576298965e+00 -5.964100204487521e+00 3.204130494649304e+00 4.920098936744292e+00 9.107175796394788e+03 + 117960 1.009426187367396e+00 -6.020740769972001e+00 -6.027229171985465e+00 3.521448741060190e+00 4.484191332621911e+00 9.300833541108872e+03 + 117980 1.014827856588094e+00 -6.061274947502712e+00 -5.948051444965946e+00 3.334212609600082e+00 4.984359482446584e+00 9.058267320256322e+03 + 118000 9.420980345017893e-01 -5.977968347201312e+00 -5.948668310896842e+00 3.832805054055274e+00 5.001050396681507e+00 9.060130285236870e+03 + 118020 9.837295717468644e-01 -6.055151513391166e+00 -6.001384680721821e+00 3.329633040309653e+00 4.638370513887495e+00 9.221283360198864e+03 + 118040 9.782051809392583e-01 -6.055202942855638e+00 -5.995236865284065e+00 3.393384875188118e+00 4.737719372324602e+00 9.202442127096840e+03 + 118060 9.559909420029702e-01 -6.026317118631438e+00 -6.001352603293189e+00 3.534398705902113e+00 4.677748816220605e+00 9.221202978377753e+03 + 118080 9.238141632561442e-01 -5.979620603081838e+00 -6.010121193926098e+00 3.723199822880957e+00 4.548060710302043e+00 9.248158249304743e+03 + 118100 9.979148898100610e-01 -6.086689492092995e+00 -5.962499461601903e+00 3.224047436948022e+00 4.937165810372981e+00 9.102285822517053e+03 + 118120 9.769872407937902e-01 -6.049696249430857e+00 -5.979424703704497e+00 3.404133601360963e+00 4.807643691408279e+00 9.153984049710158e+03 + 118140 9.793709248393203e-01 -6.045969914860280e+00 -5.979208569559630e+00 3.415412460245272e+00 4.798766436246402e+00 9.153316131159811e+03 + 118160 1.002414579182424e+00 -6.071321047123855e+00 -5.923079617888055e+00 3.359727487332926e+00 5.210952714291926e+00 8.982407725626086e+03 + 118180 1.015529007713820e+00 -6.079627504034958e+00 -5.965796408722426e+00 3.275775659715338e+00 4.929411424304970e+00 9.112337458670465e+03 + 118200 1.022392795794095e+00 -6.078764418991238e+00 -5.975417341579708e+00 3.238645726677692e+00 4.832080638083239e+00 9.141727582228285e+03 + 118220 9.778784698854838e-01 -6.002185319677536e+00 -5.986589954703676e+00 3.677422685290088e+00 4.766973684344918e+00 9.175922169632327e+03 + 118240 9.979285547587164e-01 -6.019132853946044e+00 -5.998169743537391e+00 3.618979914151881e+00 4.739353338149218e+00 9.211434319934260e+03 + 118260 1.089079418958326e+00 -6.142852912115839e+00 -5.992341065775150e+00 2.919298871848323e+00 4.783561185169506e+00 9.193558712780239e+03 + 118280 9.723092668712437e-01 -5.961022814789755e+00 -5.988601516911356e+00 3.934870114141792e+00 4.776508938769194e+00 9.182092018853768e+03 + 118300 9.692718435207140e-01 -5.948706314787096e+00 -6.003359192557741e+00 3.962023505639698e+00 4.648198223975152e+00 9.227371899182259e+03 + 118320 1.067300327405891e+00 -6.085716046620246e+00 -5.963438281250569e+00 3.260324768838095e+00 4.962462620013818e+00 9.105168114403667e+03 + 118340 9.728126005290900e-01 -5.938882982793743e+00 -5.998592789101565e+00 4.015958993984291e+00 4.673096046102115e+00 9.212727288069087e+03 + 118360 9.814526449021093e-01 -5.944494223342439e+00 -5.992145882008586e+00 4.001720819002280e+00 4.728097620870920e+00 9.192923329940139e+03 + 118380 9.921478534320984e-01 -5.950389696021507e+00 -5.974723118284781e+00 3.976611072735090e+00 4.836884796514446e+00 9.139582185971842e+03 + 118400 1.010401258800639e+00 -5.965707088893630e+00 -5.972399359322573e+00 3.888145122788756e+00 4.849717070360267e+00 9.132511605908041e+03 + 118420 1.050587751236012e+00 -6.013236617280777e+00 -5.992408649773625e+00 3.639456146407920e+00 4.759053558951538e+00 9.193781078405975e+03 + 118440 1.078314853473278e+00 -6.042669081472455e+00 -6.005134810633665e+00 3.514116910894562e+00 4.729644502460532e+00 9.232803449364910e+03 + 118460 1.017494142855952e+00 -5.941862066362143e+00 -6.007142172646444e+00 4.066918096552222e+00 4.692069624203967e+00 9.238971323829601e+03 + 118480 1.031951075304278e+00 -5.950067276874099e+00 -6.006618397524604e+00 3.997235465938611e+00 4.672510179905776e+00 9.237361239541915e+03 + 118500 1.054041145044973e+00 -5.965482643987206e+00 -6.003684819156160e+00 3.907656081204672e+00 4.688293279617039e+00 9.228349960772388e+03 + 118520 1.048793168176856e+00 -5.939214742410094e+00 -5.985933567856311e+00 4.032596584286137e+00 4.764329858859091e+00 9.173915945698560e+03 + 118540 1.054153602811155e+00 -5.929835092273697e+00 -6.001512751920159e+00 4.082343216331571e+00 4.670759002559604e+00 9.221676326117520e+03 + 118560 1.085196723945278e+00 -5.959692983144486e+00 -6.030263363992542e+00 3.846535802354050e+00 4.441309754793366e+00 9.310203030581588e+03 + 118580 1.092905293433655e+00 -5.963177097091521e+00 -5.980750697804705e+00 3.871022049203449e+00 4.770111714402422e+00 9.158035535673986e+03 + 118600 1.026287713762927e+00 -5.862589072550952e+00 -5.947405517758163e+00 4.471575264385752e+00 4.984546110703464e+00 9.056221868025001e+03 + 118620 1.017164762353730e+00 -5.852226759885884e+00 -5.952100325753303e+00 4.526712307818545e+00 4.953222837223454e+00 9.070581475234592e+03 + 118640 1.136201678471912e+00 -6.036298063753472e+00 -5.978305344100320e+00 3.505676126666087e+00 4.838679297258846e+00 9.150567320456552e+03 + 118660 1.099069701063826e+00 -6.000562567931905e+00 -5.974617186858535e+00 3.715726479872807e+00 4.864708873030846e+00 9.139295175139892e+03 + 118680 1.033981159695554e+00 -5.930506354926416e+00 -6.027464204860655e+00 4.056558994198462e+00 4.499812015697278e+00 9.301534394957895e+03 + 118700 1.046543833173818e+00 -5.983549236656355e+00 -6.032149148038920e+00 3.793573199148902e+00 4.514504987178229e+00 9.315992497428817e+03 + 118720 1.053252613339676e+00 -6.033588315554017e+00 -6.006508741740481e+00 3.533035069686660e+00 4.688530173074488e+00 9.237031103220352e+03 + 118740 1.008937525338601e+00 -6.005421193875164e+00 -6.035155532631322e+00 3.625112710704530e+00 4.454373536192620e+00 9.325305186813741e+03 + 118760 9.099581511919945e-01 -5.892254248965719e+00 -6.086034533702428e+00 4.198601759794542e+00 4.085885377434213e+00 9.483078692276613e+03 + 118780 9.549841630875712e-01 -5.986494189027875e+00 -6.014575240503912e+00 3.763319674116149e+00 4.602073931012074e+00 9.261845650001322e+03 + 118800 1.014678487630373e+00 -6.095526601897840e+00 -5.983151604543771e+00 3.179508562237563e+00 4.824783187019266e+00 9.165404545506113e+03 + 118820 9.702460890570785e-01 -6.044969650804069e+00 -5.990796540895104e+00 3.479456138753800e+00 4.790526519112740e+00 9.188812266370735e+03 + 118840 9.858588712870096e-01 -6.078167013849701e+00 -5.988690210891744e+00 3.257115961995059e+00 4.770905611070153e+00 9.182379324832718e+03 + 118860 9.503060875717455e-01 -6.030981765418757e+00 -5.970917185641836e+00 3.533909804920747e+00 4.878809916963508e+00 9.127953039879714e+03 + 118880 9.456103758226696e-01 -6.023145373312403e+00 -5.947624917927842e+00 3.604966989923136e+00 5.038617131493981e+00 9.056942849617995e+03 + 118900 9.758390046689390e-01 -6.060941368963034e+00 -5.979246556590564e+00 3.373271776279659e+00 4.842376031153738e+00 9.153435862346154e+03 + 118920 9.693666716480097e-01 -6.039155629609008e+00 -5.987114823880209e+00 3.471405976536767e+00 4.770232336320188e+00 9.177542697363317e+03 + 118940 9.859090056180350e-01 -6.046992975794071e+00 -5.983580854819138e+00 3.472754801065881e+00 4.836877012697950e+00 9.166715838309789e+03 + 118960 9.973112360294156e-01 -6.041343677529918e+00 -6.032212650161722e+00 3.475254181428369e+00 4.527685953598468e+00 9.316185251520847e+03 + 118980 9.643172442073773e-01 -5.969953585231655e+00 -6.001295126004094e+00 3.875643628179499e+00 4.695675650976392e+00 9.221025431532829e+03 + 119000 1.010798279598468e+00 -6.012401787947985e+00 -6.006323496920235e+00 3.598290268706536e+00 4.633192756400370e+00 9.236481850053413e+03 + 119020 1.038385722126180e+00 -6.021563724664233e+00 -6.038044233817327e+00 3.582525719443091e+00 4.487892085535478e+00 9.334201792140433e+03 + 119040 1.051090879994447e+00 -6.012660994003246e+00 -5.980453874930634e+00 3.685092833918517e+00 4.870031095669022e+00 9.157114168562588e+03 + 119060 9.598228858088401e-01 -5.851129606608113e+00 -6.032008933129174e+00 4.473462925659010e+00 4.434825841789764e+00 9.315547118208333e+03 + 119080 1.076436631287748e+00 -5.997764636036068e+00 -5.989333703103078e+00 3.701655750498773e+00 4.750067472082657e+00 9.184345137009488e+03 + 119100 1.064166321921262e+00 -5.954718344693816e+00 -6.021181882950155e+00 3.897480449646486e+00 4.515836527779284e+00 9.282196206310859e+03 + 119120 1.043352933884672e+00 -5.906020635271991e+00 -6.036969487324697e+00 4.219781129839683e+00 4.467852557083683e+00 9.330878459458816e+03 + 119140 1.044786143378554e+00 -5.895997614982479e+00 -6.013166131372079e+00 4.216517611621923e+00 4.543717858743526e+00 9.257509286909048e+03 + 119160 1.041430907256811e+00 -5.884147374428856e+00 -6.030298273892747e+00 4.301017589074577e+00 4.461796507574319e+00 9.310279383851135e+03 + 119180 1.030272975805293e+00 -5.868321362019465e+00 -6.044049964012157e+00 4.350067372067814e+00 4.341006545512506e+00 9.352764149385443e+03 + 119200 1.097097710296557e+00 -5.979554698160427e+00 -5.983761351536383e+00 3.866589681285990e+00 4.842434426623738e+00 9.167255656666495e+03 + 119220 1.008526806230827e+00 -5.878916090911440e+00 -6.072075422308485e+00 4.240585004702059e+00 4.131434232510303e+00 9.439633232113671e+03 + 119240 9.610544771865510e-01 -5.863452859960428e+00 -6.031977556040029e+00 4.460179384493041e+00 4.492484500491531e+00 9.315446377716273e+03 + 119260 1.090909483116227e+00 -6.117342769475410e+00 -5.951332893439723e+00 3.085131932857665e+00 5.038386330999874e+00 9.068257372687727e+03 + 119280 9.748718208942341e-01 -5.999073985028591e+00 -6.000216400146201e+00 3.748809032357737e+00 4.742249107964259e+00 9.217700561077776e+03 + 119300 9.849194729624058e-01 -6.052316567072485e+00 -5.974203321764358e+00 3.423683840916782e+00 4.872222183461695e+00 9.138045144371512e+03 + 119320 9.816753849971117e-01 -6.076028443957259e+00 -6.010869643214338e+00 3.293872021701144e+00 4.668023938858825e+00 9.250457076466922e+03 + 119340 9.939849460704197e-01 -6.114931531151451e+00 -6.006146138184731e+00 3.022658984193077e+00 4.647321545093138e+00 9.235953320039513e+03 + 119360 9.309371617626490e-01 -6.035977597850318e+00 -6.007530238155198e+00 3.493101057116877e+00 4.656450198700942e+00 9.240185300426856e+03 + 119380 1.008158355309710e+00 -6.159174553643037e+00 -5.974798849364122e+00 2.816915740369334e+00 4.875629566386892e+00 9.139866174215229e+03 + 119400 8.794411926872081e-01 -5.971450313439034e+00 -5.974899686500105e+00 3.856453227547429e+00 4.836646393641999e+00 9.140133361061518e+03 + 119420 9.440919293796489e-01 -6.063782786000915e+00 -5.945105073095391e+00 3.358048839107026e+00 5.039514631927260e+00 9.049288214782240e+03 + 119440 9.389686528989794e-01 -6.042905019183673e+00 -5.966176834696231e+00 3.479416561334961e+00 4.920001670310025e+00 9.113511787751444e+03 + 119460 9.368133053923515e-01 -6.017769312640489e+00 -5.993030718783301e+00 3.596098081222711e+00 4.738150915435717e+00 9.195661900274534e+03 + 119480 1.014984236213100e+00 -6.105592258197846e+00 -5.985471816179874e+00 3.113073874567822e+00 4.802824041213341e+00 9.172514673017195e+03 + 119500 9.978945142641790e-01 -6.048438271888010e+00 -6.009615083260899e+00 3.451411741076518e+00 4.674340498042412e+00 9.246592627297228e+03 + 119520 1.007440971008089e+00 -6.032693347091008e+00 -5.984916222391340e+00 3.521414936186707e+00 4.795758579698351e+00 9.170808839105413e+03 + 119540 1.046069880982660e+00 -6.061148104747552e+00 -5.987023456230411e+00 3.380492214641971e+00 4.806127417179686e+00 9.177257487990601e+03 + 119560 9.482920305956614e-01 -5.889088334287274e+00 -6.040435711952207e+00 4.282508908795816e+00 4.413448845312772e+00 9.341609858694357e+03 + 119580 1.049637140530521e+00 -6.017804539306545e+00 -5.961834010236220e+00 3.601930186567791e+00 4.923321625900982e+00 9.100254784628609e+03 + 119600 9.788295524870486e-01 -5.893379040997575e+00 -6.033314336435059e+00 4.222328636388701e+00 4.418798515069682e+00 9.319589840718390e+03 + 119620 1.065663352161337e+00 -6.006429312019749e+00 -6.002467521630189e+00 3.713856813330039e+00 4.736606026831977e+00 9.224638264842219e+03 + 119640 1.013039182266040e+00 -5.919029226798404e+00 -6.048627233973402e+00 4.135599483968107e+00 4.391427671542474e+00 9.366926492454428e+03 + 119660 1.025447719833507e+00 -5.933749485217553e+00 -6.048372165211725e+00 4.050446320926189e+00 4.392265154597252e+00 9.366139524490509e+03 + 119680 1.041247093471711e+00 -5.959777219958424e+00 -6.032024365806345e+00 3.905065809215564e+00 4.490211517547113e+00 9.315634128809752e+03 + 119700 1.034847841346528e+00 -5.959256062660050e+00 -6.056341114680052e+00 3.843643382968927e+00 4.286165990406834e+00 9.390830817313032e+03 + 119720 1.022978895469701e+00 -5.956028175769903e+00 -5.996047055182215e+00 3.975120960118478e+00 4.745326361631408e+00 9.204924072782196e+03 + 119740 1.008798988016486e+00 -5.952442148866107e+00 -6.002133673523078e+00 3.930920748932169e+00 4.645584324613253e+00 9.223600127632284e+03 + 119760 1.015058672695483e+00 -5.983619052638933e+00 -6.031899105987615e+00 3.778571600147131e+00 4.501340062504889e+00 9.315226744015275e+03 + 119780 1.038278375302158e+00 -6.049287116011947e+00 -5.966993682737451e+00 3.474623372738128e+00 4.947165001467924e+00 9.116012735483118e+03 + 119800 1.033857642322377e+00 -6.078056876241071e+00 -5.984923724770832e+00 3.275198581854303e+00 4.809983549905027e+00 9.170815758374491e+03 + 119820 1.007553277827977e+00 -6.079519333998724e+00 -5.973690846763567e+00 3.288279553869230e+00 4.895963104478977e+00 9.136471979499327e+03 + 119840 9.407307859018351e-01 -6.023123385677247e+00 -6.019870197857848e+00 3.574722628693218e+00 4.593402936581393e+00 9.278149399788770e+03 + 119860 9.284640044736524e-01 -6.040676112706596e+00 -5.962133756199496e+00 3.532955885145952e+00 4.983958250600116e+00 9.101162989254217e+03 + 119880 9.205410444224746e-01 -6.053502058245293e+00 -5.991206019477274e+00 3.439660832292857e+00 4.797374327179664e+00 9.190070002716637e+03 + 119900 9.305379406426773e-01 -6.082894968525999e+00 -6.001613015549546e+00 3.268445111568421e+00 4.735178663900786e+00 9.222008946978343e+03 + 119920 1.018397000235681e+00 -6.218699618248187e+00 -5.984494553125563e+00 2.491946370247904e+00 4.836788097298710e+00 9.169543914712178e+03 + 119940 8.695952001570944e-01 -5.997889287429587e+00 -6.013545573525435e+00 3.698434695429785e+00 4.608533877864980e+00 9.258673360755400e+03 + 119960 8.769058638850319e-01 -6.002123878321631e+00 -6.003705905432527e+00 3.660752328074337e+00 4.651668083585664e+00 9.228405976869475e+03 + 119980 9.637374908657271e-01 -6.118567504343105e+00 -5.986002363460525e+00 3.115135871143959e+00 4.876345424480983e+00 9.174096015193030e+03 + 120000 9.209981558754371e-01 -6.040433077089063e+00 -5.966829590857303e+00 3.532443357205042e+00 4.955085965250491e+00 9.115491800124808e+03 + 120020 9.797880787886686e-01 -6.112913259642029e+00 -5.953460904024221e+00 3.108351914551480e+00 5.023952015681216e+00 9.074735489647856e+03 + 120040 9.743944176061097e-01 -6.087200968794580e+00 -6.001055074460147e+00 3.255740674681015e+00 4.750403730983388e+00 9.220290380876953e+03 + 120060 9.474687770952763e-01 -6.030766420465625e+00 -5.996961943701987e+00 3.562696225803922e+00 4.756806762606599e+00 9.207703673565740e+03 + 120080 9.635269268957668e-01 -6.035608965680844e+00 -5.970364013092460e+00 3.569788363896104e+00 4.944434978282388e+00 9.126275253568247e+03 + 120100 9.624385443215485e-01 -6.010789523165797e+00 -6.015449127303000e+00 3.574677697616379e+00 4.547921529589146e+00 9.264530851209998e+03 + 120120 9.429753147628946e-01 -5.960321103667138e+00 -6.017826427054753e+00 3.877879756488266e+00 4.547675290676551e+00 9.271863411029826e+03 + 120140 1.011283470705997e+00 -6.039947070572763e+00 -6.004596662334468e+00 3.507322257931347e+00 4.710309772493631e+00 9.231156942238838e+03 + 120160 9.686997613663088e-01 -5.953692335014338e+00 -6.016348522818806e+00 3.943148627419296e+00 4.583367101032316e+00 9.267308785138475e+03 + 120180 9.575467862576477e-01 -5.917605124731979e+00 -6.012685184361512e+00 4.096141367449238e+00 4.550176951464779e+00 9.256041128199602e+03 + 120200 1.009273883636535e+00 -5.975776196210976e+00 -5.982071900968116e+00 3.857607746837805e+00 4.821456835865146e+00 9.162083510210643e+03 + 120220 1.055267590664103e+00 -6.025290571717587e+00 -6.029172668807332e+00 3.506169855756306e+00 4.483878253514404e+00 9.306830615803847e+03 + 120240 1.042067476728707e+00 -5.990434939449728e+00 -6.026099420437328e+00 3.719074215780396e+00 4.514283246889000e+00 9.297354808025775e+03 + 120260 1.052451334551856e+00 -5.998736109811297e+00 -5.963931078061558e+00 3.697696322909752e+00 4.897552201278009e+00 9.106650109225018e+03 + 120280 9.676878906314603e-01 -5.866906737372149e+00 -6.039372615822825e+00 4.395771356546885e+00 4.405445593474670e+00 9.338272547465192e+03 + 120300 1.117311893178922e+00 -6.086217585950841e+00 -5.968168946102103e+00 3.201906159424730e+00 4.879759717404163e+00 9.119587163442586e+03 + 120320 1.045454173127056e+00 -5.979253797872732e+00 -5.997459434441075e+00 3.781562440026092e+00 4.677022857537512e+00 9.209254314565045e+03 + 120340 9.842563899298871e-01 -5.894214840326756e+00 -6.008920980647911e+00 4.276184602532946e+00 4.617524194091028e+00 9.244440866961606e+03 + 120360 9.737463312282703e-01 -5.887872973783871e+00 -6.022923019989515e+00 4.275931757937270e+00 4.500453493697358e+00 9.287546518902631e+03 + 120380 1.029220987672513e+00 -5.986830238751084e+00 -5.998036692898388e+00 3.723771988763191e+00 4.659422794856197e+00 9.211033246133666e+03 + 120400 1.002827120413883e+00 -5.973252655240296e+00 -6.045427453706200e+00 3.818011529960804e+00 4.403572668155620e+00 9.357022716133644e+03 + 120420 9.639577355682480e-01 -5.952947851042214e+00 -6.029260597378479e+00 3.989212996795939e+00 4.551013397973772e+00 9.307067238504931e+03 + 120440 1.012280707697841e+00 -6.072498928945050e+00 -5.986487059857646e+00 3.329749445557663e+00 4.823642908151260e+00 9.175623033831549e+03 + 120460 9.874503432452649e-01 -6.085600243596560e+00 -6.032029678908675e+00 3.256037968868100e+00 4.563648441324029e+00 9.315645596976066e+03 + 120480 9.252910434772046e-01 -6.037201844175397e+00 -6.026647092763229e+00 3.479351130217347e+00 4.539958146168515e+00 9.299026710336042e+03 + 120500 9.150355233516013e-01 -6.051466504401152e+00 -5.989027262500842e+00 3.421884790812624e+00 4.780420580245660e+00 9.183396415137446e+03 + 120520 9.760963414276158e-01 -6.156408370841838e+00 -5.954839088525535e+00 2.855583909490911e+00 5.013025921296753e+00 9.078937847956266e+03 + 120540 9.385484683364077e-01 -6.105433506033962e+00 -6.004384566216484e+00 3.151107804601957e+00 4.731346454306811e+00 9.230517248368167e+03 + 120560 8.717055688770080e-01 -6.004352848770867e+00 -5.991027886882756e+00 3.669629316224870e+00 4.746143309417590e+00 9.189529092084671e+03 + 120580 9.350214889771606e-01 -6.088597722753363e+00 -5.985533408578309e+00 3.239107963234598e+00 4.830919204378832e+00 9.172689670377735e+03 + 120600 9.943359768953216e-01 -6.158514300021742e+00 -5.955207757368503e+00 2.904014480725748e+00 5.071432110226445e+00 9.080061036663203e+03 + 120620 8.841508229924596e-01 -5.973607529397218e+00 -6.031767420260230e+00 3.781644693636285e+00 4.447681600086844e+00 9.314829873039698e+03 + 120640 9.205719322170441e-01 -6.001583695827840e+00 -6.021116380560878e+00 3.628690748616483e+00 4.516531050206183e+00 9.281991575026874e+03 + 120660 9.546310830259199e-01 -6.022225581024575e+00 -6.008074732029328e+00 3.602014370566023e+00 4.683270735333530e+00 9.241870486314605e+03 + 120680 9.951560055206431e-01 -6.053017697528349e+00 -6.008982999059275e+00 3.409515407543403e+00 4.662369460500389e+00 9.244664440962417e+03 + 120700 1.012288281652514e+00 -6.053772043943967e+00 -5.978283080007419e+00 3.479443584019345e+00 4.912912896822424e+00 9.150490674872572e+03 + 120720 9.600794945489532e-01 -5.956092586799816e+00 -5.988209364204148e+00 3.975702281038694e+00 4.791282775127777e+00 9.180863310283337e+03 + 120740 1.047628779227795e+00 -6.069073636025113e+00 -5.968289779626534e+00 3.296495881059358e+00 4.875212380751368e+00 9.119973694008871e+03 + 120760 1.035513017444710e+00 -6.037138218043567e+00 -6.037774146836355e+00 3.469674543284161e+00 4.466022941746306e+00 9.333378555054891e+03 + 120780 1.008474799565614e+00 -5.987885967553238e+00 -6.009014957184130e+00 3.764431094260363e+00 4.643105166099206e+00 9.244755752452011e+03 + 120800 9.724837142560121e-01 -5.928632597216287e+00 -6.013511965243964e+00 4.092307207965970e+00 4.604916741711301e+00 9.258580077635992e+03 + 120820 1.018412070391606e+00 -5.991323155739472e+00 -6.049288088966235e+00 3.696619277390668e+00 4.363775660758170e+00 9.368980757211102e+03 + 120840 1.071720543868808e+00 -6.072127313261033e+00 -5.990281608638266e+00 3.279738168519700e+00 4.749708870045490e+00 9.187236198343313e+03 + 120860 9.771254852632453e-01 -5.934395356891880e+00 -5.985332950674254e+00 4.054790221061205e+00 4.762298674995649e+00 9.172068193105210e+03 + 120880 1.020295545876077e+00 -6.000802054279295e+00 -5.977939705323814e+00 3.662827322547933e+00 4.794106468187374e+00 9.149442339958128e+03 + 120900 1.010870967593513e+00 -5.988543638247435e+00 -5.975379352089120e+00 3.788371914581656e+00 4.863963282869403e+00 9.141633127721880e+03 + 120920 9.818725469189609e-01 -5.948088666301157e+00 -6.009042004493864e+00 3.990363624201452e+00 4.640360123800329e+00 9.244812656329439e+03 + 120940 1.064826977272341e+00 -6.075353705185368e+00 -5.984638145215103e+00 3.341733994257353e+00 4.862636777794151e+00 9.169943384489818e+03 + 120960 1.018812396298537e+00 -6.014703232459357e+00 -5.931087205805053e+00 3.647873688179973e+00 5.128009852767294e+00 9.006693960994402e+03 + 120980 9.281970365474588e-01 -5.887197828281196e+00 -5.969275907885022e+00 4.305795499370179e+00 4.834490464743241e+00 9.122922652963767e+03 + 121000 9.462889930615317e-01 -5.918451441209609e+00 -6.003188816106798e+00 4.081120969901743e+00 4.594545850175695e+00 9.226817984523535e+03 + 121020 1.027718548890943e+00 -6.044447185486071e+00 -5.978042726443164e+00 3.488484401178244e+00 4.869789081059446e+00 9.149777643455067e+03 + 121040 1.019972218795342e+00 -6.043436318641451e+00 -5.972010087100466e+00 3.502096769103955e+00 4.912237243785893e+00 9.131338920365988e+03 + 121060 1.004227123978435e+00 -6.032072816710746e+00 -5.971812872814963e+00 3.556364527611390e+00 4.902386450657153e+00 9.130732350794937e+03 + 121080 1.044059921152596e+00 -6.105423154946637e+00 -6.029249965784054e+00 3.132805176001399e+00 4.570203415935877e+00 9.307060417974271e+03 + 121100 9.478094492525492e-01 -5.982724273516702e+00 -6.038008073082357e+00 3.788218040677627e+00 4.470769908431302e+00 9.334106738223418e+03 + 121120 1.027326398255241e+00 -6.123847812586209e+00 -5.994122482061491e+00 3.032475912827512e+00 4.777378835630461e+00 9.199030305171029e+03 + 121140 9.417219026265300e-01 -6.019967508865978e+00 -5.977222094679924e+00 3.660077867009940e+00 4.905528650097729e+00 9.147250431548428e+03 + 121160 1.000198538869441e+00 -6.127367359576355e+00 -5.947372171081653e+00 3.047735615348059e+00 5.081295841850032e+00 9.056202012922608e+03 + 121180 9.473426956328034e-01 -6.063796616612604e+00 -6.010042402842043e+00 3.318906202646571e+00 4.627571216554833e+00 9.247912776980575e+03 + 121200 8.783689831293923e-01 -5.971783893969638e+00 -5.999178574812179e+00 3.903805802137828e+00 4.746501305426801e+00 9.214529442162067e+03 + 121220 9.569768166035227e-01 -6.091127469202522e+00 -5.971879351357930e+00 3.245218741650214e+00 4.929959887900462e+00 9.130941488479006e+03 + 121240 9.803391678671258e-01 -6.121629919075924e+00 -6.012086427909022e+00 3.081208763467636e+00 4.710224441548460e+00 9.254202003716455e+03 + 121260 9.355636203667588e-01 -6.046728121294513e+00 -6.025963948697035e+00 3.366949140237053e+00 4.486180232537099e+00 9.296931404074461e+03 + 121280 8.381343951644556e-01 -5.887366358456519e+00 -6.024098102138376e+00 4.259458425185199e+00 4.474323593795023e+00 9.291181247563085e+03 + 121300 1.009195478299509e+00 -6.115987116651512e+00 -5.988168016840021e+00 3.060096273875059e+00 4.794053324934412e+00 9.180792236244391e+03 + 121320 9.460881638219947e-01 -5.989629128548171e+00 -5.991742989570967e+00 3.755696128420623e+00 4.743558011308793e+00 9.191728338437051e+03 + 121340 1.029892999851704e+00 -6.079057016087880e+00 -5.989162753243221e+00 3.254794432999732e+00 4.770981201345983e+00 9.183820863055158e+03 + 121360 9.514238934274937e-01 -5.926068624295748e+00 -6.015477291037216e+00 4.055011388494144e+00 4.541612988118174e+00 9.264625668819675e+03 + 121380 9.806896702378068e-01 -5.937024617400457e+00 -5.989442546710774e+00 4.075283153391390e+00 4.774291291643206e+00 9.184651669275705e+03 + 121400 1.002907485763666e+00 -5.940277195438268e+00 -6.064115731105554e+00 3.961698485444276e+00 4.250598449691260e+00 9.414909956141202e+03 + 121420 1.050174101796645e+00 -5.990713047035623e+00 -6.049784282071744e+00 3.683712540612894e+00 4.344516367791408e+00 9.370501399950033e+03 + 121440 1.067732415208222e+00 -6.005764976834625e+00 -5.993153290721007e+00 3.674833794890723e+00 4.747252048207237e+00 9.196057080798746e+03 + 121460 1.057891878394447e+00 -5.986457057487567e+00 -6.026787660669648e+00 3.770522949820124e+00 4.538938385207942e+00 9.299463976865491e+03 + 121480 1.088195872014811e+00 -6.033115467536007e+00 -6.001197845929197e+00 3.516486695351934e+00 4.699762617854215e+00 9.220719594528915e+03 + 121500 1.021841162282658e+00 -5.940140666739715e+00 -6.023974361829350e+00 4.026212159424689e+00 4.544826108997619e+00 9.290799416461312e+03 + 121520 1.052874672012439e+00 -5.996569107062159e+00 -5.992574701592865e+00 3.721050305995814e+00 4.743986800332748e+00 9.194269037532487e+03 + 121540 9.930289370731258e-01 -5.920225118955974e+00 -6.014556203529160e+00 4.048063973464924e+00 4.506400288157529e+00 9.261775255303022e+03 + 121560 1.044875982242426e+00 -6.011504840563324e+00 -5.973467343526960e+00 3.684408773130088e+00 4.902825967396535e+00 9.135752009909986e+03 + 121580 1.011304992222589e+00 -5.976427129148696e+00 -5.981054563940313e+00 3.834900365620900e+00 4.808328918954218e+00 9.158985704190751e+03 + 121600 1.042125695592204e+00 -6.035800992500590e+00 -5.990845993499123e+00 3.546543520134346e+00 4.804682081164385e+00 9.188969779892801e+03 + 121620 1.033527192132480e+00 -6.039349387612493e+00 -6.014889717085278e+00 3.430940207387507e+00 4.571391420676555e+00 9.262849916570456e+03 + 121640 9.423159415643282e-01 -5.924062507319928e+00 -6.013836737909394e+00 4.143872235158001e+00 4.628374710596002e+00 9.259578505187861e+03 + 121660 9.729372905423213e-01 -5.990009792258607e+00 -6.001375806811071e+00 3.738298162665063e+00 4.673032748219750e+00 9.221244394258079e+03 + 121680 9.809903823783795e-01 -6.020338507080901e+00 -5.987958471578653e+00 3.605547184769109e+00 4.791478359417317e+00 9.180096122922141e+03 + 121700 9.778020122563776e-01 -6.030568173277602e+00 -5.977384485340634e+00 3.520424488425790e+00 4.825813454708966e+00 9.147758041523737e+03 + 121720 9.758121057134208e-01 -6.039933634616521e+00 -5.991878868879057e+00 3.494461161462595e+00 4.770399062778081e+00 9.192145801171517e+03 + 121740 1.010982614319852e+00 -6.107690358915373e+00 -5.981169768117153e+00 3.100566123224136e+00 4.827066934585668e+00 9.159336684973672e+03 + 121760 9.510183134270938e-01 -6.038002816645294e+00 -6.008109474312771e+00 3.456851902847640e+00 4.628504100500763e+00 9.241978029209382e+03 + 121780 8.920619179159005e-01 -5.978078102665229e+00 -6.013311226627407e+00 3.806399576001565e+00 4.604085525902426e+00 9.257964088378983e+03 + 121800 9.938102198696558e-01 -6.167748987942008e+00 -5.975091789595844e+00 2.842348693031621e+00 4.948616139540387e+00 9.140756154825483e+03 + 121820 8.866757569174428e-01 -6.053866567145263e+00 -5.978663026228306e+00 3.412171797879533e+00 4.844002167535047e+00 9.151659210062262e+03 + 121840 9.093505231862662e-01 -6.124588554515836e+00 -5.937308791416124e+00 3.000939450432246e+00 5.076328831600471e+00 9.025621313172338e+03 + 121860 8.902374586426863e-01 -6.121643501776951e+00 -5.918623909304513e+00 3.029870754798961e+00 5.195640671956106e+00 8.968945935654234e+03 + 121880 9.050258394637319e-01 -6.154644913154473e+00 -5.946190486766049e+00 2.923136723197566e+00 5.120114297738125e+00 9.052612489507806e+03 + 121900 9.029497083271938e-01 -6.150982039816471e+00 -5.971586533844656e+00 2.858213085900206e+00 4.888329842555197e+00 9.130048261281341e+03 + 121920 8.604832331806368e-01 -6.077178713361105e+00 -5.994859128997772e+00 3.245723444216935e+00 4.718415236545706e+00 9.201277821007536e+03 + 121940 9.376422981614223e-01 -6.168114025059063e+00 -5.967958902140009e+00 2.764527977837838e+00 4.913849667544215e+00 9.118954881387763e+03 + 121960 9.101516513341555e-01 -6.095437811994779e+00 -5.930974275933783e+00 3.194946217856076e+00 5.139321292568269e+00 9.006369607993951e+03 + 121980 9.346798986038559e-01 -6.089668045233255e+00 -5.952216426641725e+00 3.219714137558170e+00 5.008982602079973e+00 9.070940195702065e+03 + 122000 9.410189873303456e-01 -6.055529195793968e+00 -5.959261712208278e+00 3.364482285276341e+00 4.917265073370309e+00 9.092415827697667e+03 + 122020 9.798991656505787e-01 -6.074905415280423e+00 -5.998302563217940e+00 3.328207445404776e+00 4.768072876200599e+00 9.211843795998626e+03 + 122040 9.609516737032383e-01 -6.017180377735293e+00 -5.981495345601553e+00 3.639810382054740e+00 4.844719358807552e+00 9.160327899001120e+03 + 122060 9.821289830365720e-01 -6.025619003816757e+00 -5.980568237888972e+00 3.574883892959057e+00 4.833572362499896e+00 9.157452699469293e+03 + 122080 9.979085440310806e-01 -6.027320124278249e+00 -5.972595680339477e+00 3.521329597994332e+00 4.835565823671091e+00 9.133096939966934e+03 + 122100 1.002869739644761e+00 -6.016519292147098e+00 -5.993487417398477e+00 3.570940165947724e+00 4.703192754925409e+00 9.197065035637486e+03 + 122120 1.029929193201647e+00 -6.037737507444032e+00 -5.995974800738132e+00 3.461258637346802e+00 4.701066562010054e+00 9.204703177795203e+03 + 122140 1.080917716975854e+00 -6.096908600001250e+00 -5.987229304821057e+00 3.161002420144367e+00 4.790797905885105e+00 9.177899885864827e+03 + 122160 1.088824434160567e+00 -6.094343725205970e+00 -6.014173600427892e+00 3.150131315445810e+00 4.610480578208250e+00 9.260641740470815e+03 + 122180 1.009719376867404e+00 -5.969221736784609e+00 -6.061479394062688e+00 3.835538468577746e+00 4.305780723660699e+00 9.406741467945907e+03 + 122200 9.998825215194708e-01 -5.951323024192961e+00 -5.981435251874603e+00 3.950484643969417e+00 4.777575572769253e+00 9.160134748578779e+03 + 122220 1.036089518310060e+00 -6.001307656786956e+00 -6.000487181402216e+00 3.663072005951427e+00 4.667783302578759e+00 9.218520944961461e+03 + 122240 9.567386705094217e-01 -5.880999696965853e+00 -6.014943654857236e+00 4.294797817507950e+00 4.525670883535137e+00 9.262960183300385e+03 + 122260 1.051291385237442e+00 -6.019350571971252e+00 -6.026025313932031e+00 3.561750288189684e+00 4.523422886937908e+00 9.297094766661421e+03 + 122280 9.819952131167700e-01 -5.918856509009894e+00 -5.978196604981057e+00 4.133510554327278e+00 4.792770540410684e+00 9.150239248376385e+03 + 122300 1.014408627500457e+00 -5.969495803437639e+00 -5.947771479876598e+00 3.846741060775320e+00 4.971485488491024e+00 9.057414634226583e+03 + 122320 1.036374928939502e+00 -6.003183884752712e+00 -5.993049619845838e+00 3.676364567476289e+00 4.734557084843984e+00 9.195732476865509e+03 + 122340 1.012912006670207e+00 -5.972644060084479e+00 -6.020685273428502e+00 3.848397084437621e+00 4.572537003062497e+00 9.280645622427761e+03 + 122360 1.043054828880466e+00 -6.028329656942354e+00 -5.982634289103353e+00 3.542011185060284e+00 4.804401058527150e+00 9.163811519780727e+03 + 122380 9.931228099573532e-01 -5.969653362318398e+00 -5.977369314798119e+00 3.877578842484034e+00 4.833272649305696e+00 9.147694892254143e+03 + 122400 9.769114615291542e-01 -5.965396723851484e+00 -6.021738856648417e+00 3.839666905949836e+00 4.516141660512972e+00 9.283903196216381e+03 + 122420 9.995456258044076e-01 -6.023584583055886e+00 -5.956723650206575e+00 3.578813018039786e+00 4.962738841156447e+00 9.084671686346774e+03 + 122440 1.000567539152121e+00 -6.049675101042125e+00 -5.983043269190605e+00 3.464932813269992e+00 4.847543103004076e+00 9.165068138440483e+03 + 122460 9.247101712025075e-01 -5.964008916073676e+00 -6.016006479125511e+00 3.904296614459505e+00 4.605718560818994e+00 9.266264946022984e+03 + 122480 1.030097384736203e+00 -6.147243639526334e+00 -5.976003457453750e+00 2.960333215438640e+00 4.943620840231949e+00 9.143531422552460e+03 + 122500 8.791260856659509e-01 -5.947377355477783e+00 -6.039615824554296e+00 4.060186438746396e+00 4.530538875452097e+00 9.339043744131923e+03 + 122520 9.870046225568153e-01 -6.126901660136317e+00 -5.991783150080886e+00 3.022569438647797e+00 4.798440832907936e+00 9.191854236752226e+03 + 122540 9.277157605241924e-01 -6.054282811729825e+00 -6.034666970944995e+00 3.428874550976054e+00 4.541511744304097e+00 9.323790557575529e+03 + 122560 9.414313625454815e-01 -6.084676106544887e+00 -6.012577837688470e+00 3.244816440075190e+00 4.658815857019780e+00 9.255722869666548e+03 + 122580 9.874663075425356e-01 -6.157632707266377e+00 -5.998413498572673e+00 2.879290326506329e+00 4.793551661918490e+00 9.212201212512547e+03 + 122600 8.927902172021072e-01 -6.018114954958522e+00 -5.987462944949216e+00 3.644318485212009e+00 4.820327070068656e+00 9.178598133491209e+03 + 122620 9.845891002148218e-01 -6.145555387075291e+00 -5.966205619003479e+00 2.955901429532537e+00 4.985755552087790e+00 9.113598192730165e+03 + 122640 9.488800552739127e-01 -6.073510969596118e+00 -5.997781220383851e+00 3.313690126397181e+00 4.748542065514830e+00 9.210257732474243e+03 + 122660 9.348169316160505e-01 -6.019862831718884e+00 -6.015656372578133e+00 3.612778031639345e+00 4.636932170972986e+00 9.265177024568668e+03 + 122680 8.962433046018666e-01 -5.918897333094039e+00 -6.013782079650056e+00 4.129815517159447e+00 4.584972619067717e+00 9.259399160506771e+03 + 122700 9.765604431988583e-01 -5.984141715566715e+00 -6.019281544516533e+00 3.790329372867823e+00 4.588551037167018e+00 9.276341620635569e+03 + 122720 1.070888754482547e+00 -6.074050727053908e+00 -6.012854685118414e+00 3.284433882673605e+00 4.635831025524094e+00 9.256568533325672e+03 + 122740 1.060499065976080e+00 -6.025078847329861e+00 -6.017952499984123e+00 3.520825867563031e+00 4.561746456820947e+00 9.272247623605417e+03 + 122760 1.032877614827621e+00 -5.966045465613968e+00 -5.959971167854588e+00 3.918363365708214e+00 4.953242923437109e+00 9.094558896081859e+03 + 122780 1.045780770506027e+00 -5.974045944498114e+00 -5.964472206899363e+00 3.760552346466306e+00 4.815526229289437e+00 9.108268160121366e+03 + 122800 1.020885709437235e+00 -5.928936931305628e+00 -6.002098033421676e+00 4.081933191624293e+00 4.661830821629985e+00 9.223464357342311e+03 + 122820 1.045353995968192e+00 -5.962851071167560e+00 -5.983097977452791e+00 3.888408986782205e+00 4.772148117693780e+00 9.165205288475883e+03 + 122840 1.037917843777814e+00 -5.952346323169175e+00 -5.984898218119812e+00 3.968453447757590e+00 4.781535429561570e+00 9.170747462183183e+03 + 122860 1.100136628099640e+00 -6.049922393685627e+00 -6.019428737193754e+00 3.391606223622214e+00 4.566705518076634e+00 9.276782992322409e+03 + 122880 1.001486459018440e+00 -5.914790619809280e+00 -6.039417402940503e+00 4.148054526841458e+00 4.432428252169621e+00 9.338437713746278e+03 + 122900 9.510768414023982e-01 -5.855236463538844e+00 -6.084901732676049e+00 4.383944823306430e+00 4.065171307335063e+00 9.479476874784144e+03 + 122920 1.014382483156633e+00 -5.968151873532575e+00 -6.023529452612203e+00 3.866744391454054e+00 4.548757762726165e+00 9.289396026544913e+03 + 122940 1.075449252843866e+00 -6.081350923668669e+00 -6.003695898174231e+00 3.235975424712325e+00 4.681882598177750e+00 9.228421482934062e+03 + 122960 9.714942785359929e-01 -5.953090315343530e+00 -6.049492708752046e+00 3.959425888868059e+00 4.405868427694189e+00 9.369617837301683e+03 + 122980 9.999830474379393e-01 -6.025682589014585e+00 -5.994326581473207e+00 3.601220545054272e+00 4.781271592683358e+00 9.199615373656792e+03 + 123000 9.353571634814601e-01 -5.956606102626738e+00 -5.993823340707903e+00 3.949316011362501e+00 4.735608870951475e+00 9.198065647158304e+03 + 123020 9.617424523834007e-01 -6.018294446758979e+00 -6.005991531169879e+00 3.577762055775512e+00 4.648407300958162e+00 9.235440106169435e+03 + 123040 9.810338316832351e-01 -6.066546404928065e+00 -6.001685815633303e+00 3.307304637820075e+00 4.679744178694353e+00 9.222196171340556e+03 + 123060 8.981903905473215e-01 -5.959052819680023e+00 -5.989504513536997e+00 3.864250710314789e+00 4.689392371803651e+00 9.184835439848219e+03 + 123080 9.233032421075045e-01 -6.003290590720638e+00 -5.981335205268850e+00 3.611934272222372e+00 4.738005493071453e+00 9.159814924076578e+03 + 123100 8.961786383637401e-01 -5.962948324582951e+00 -5.968887062587974e+00 3.897043500831348e+00 4.862942348189764e+00 9.121751130204519e+03 + 123120 9.589724294120278e-01 -6.048853518712105e+00 -5.952812089967578e+00 3.430442625743459e+00 4.981927371957594e+00 9.072749345895940e+03 + 123140 1.019823544630263e+00 -6.123312589556784e+00 -5.976467318368161e+00 3.038797683442435e+00 4.882005954839786e+00 9.144971738131851e+03 + 123160 9.783873284830409e-01 -6.039639126161354e+00 -6.048053332980606e+00 3.500465954372110e+00 4.452150276721671e+00 9.365153793126658e+03 + 123180 9.753662348907484e-01 -6.011395669193637e+00 -5.982652295932747e+00 3.636373614249070e+00 4.801422511535735e+00 9.163869735313883e+03 + 123200 1.029269657130164e+00 -6.055810762351106e+00 -5.976634323982339e+00 3.401752475085615e+00 4.856395836713313e+00 9.145455917663065e+03 + 123220 9.766531739523108e-01 -5.924274672480021e+00 -6.029502369455225e+00 4.055523035645011e+00 4.451289315679918e+00 9.307820473694181e+03 + 123240 9.760855008512722e-01 -5.858531788725176e+00 -6.012707568320865e+00 4.447625872860448e+00 4.562324687797219e+00 9.256055935077136e+03 + 123260 1.037264087229442e+00 -5.888012098048853e+00 -6.002762768482450e+00 4.265592297963953e+00 4.606676190725380e+00 9.225497171500001e+03 + 123280 1.082225067367437e+00 -5.914933356042854e+00 -5.997152439834236e+00 4.063722409228193e+00 4.591607706735978e+00 9.208277388038296e+03 + 123300 1.086413010269645e+00 -5.904242522291137e+00 -6.017507002555410e+00 4.221280893281145e+00 4.570898719982011e+00 9.270825457388677e+03 + 123320 1.086533403303641e+00 -5.902736523743066e+00 -6.023875064063701e+00 4.219941687159072e+00 4.524345442509454e+00 9.290469691578812e+03 + 123340 1.075121783865439e+00 -5.893722155340365e+00 -6.053518550361066e+00 4.238054818062079e+00 4.320479189441001e+00 9.382054804775635e+03 + 123360 1.130916518602930e+00 -5.993200945748066e+00 -6.015873767076912e+00 3.757967351538693e+00 4.627776502860693e+00 9.265837597208278e+03 + 123380 1.018081394845946e+00 -5.851318013690781e+00 -6.050901102033979e+00 4.420888046642055e+00 4.274851067992308e+00 9.373973593803041e+03 + 123400 9.848739845725890e-01 -5.830803442273425e+00 -6.031570217133051e+00 4.533652417317088e+00 4.380818527515108e+00 9.314207815057445e+03 + 123420 1.023887270737367e+00 -5.919409735109416e+00 -6.037825914218544e+00 4.124323097207048e+00 4.444359071917943e+00 9.333535233108365e+03 + 123440 1.035221388202900e+00 -5.970357855967075e+00 -5.996995743875067e+00 3.798552223506367e+00 4.645593348938850e+00 9.207813600839261e+03 + 123460 1.013800955855953e+00 -5.970559444624490e+00 -6.006196193292432e+00 3.856031991626109e+00 4.651400266005754e+00 9.236072443157367e+03 + 123480 1.062981806146859e+00 -6.072167894436558e+00 -5.989579703220973e+00 3.307259082600848e+00 4.781493257042022e+00 9.185100461183276e+03 + 123500 9.802938354409672e-01 -5.978811813148240e+00 -5.992838082421144e+00 3.858425006691630e+00 4.777883997968462e+00 9.195090379940202e+03 + 123520 9.431878851314405e-01 -5.946473503884246e+00 -6.027745406525801e+00 3.947269333876174e+00 4.480593492122077e+00 9.302416921691001e+03 + 123540 1.003177447096939e+00 -6.053040126858627e+00 -5.995829504914009e+00 3.406671760968773e+00 4.735184005489901e+00 9.204272683740994e+03 + 123560 1.039973595454174e+00 -6.123697155019639e+00 -5.991245078687010e+00 3.010090640529167e+00 4.770650959723691e+00 9.190213983537262e+03 + 123580 9.723041819441364e-01 -6.036397712744627e+00 -5.989526971310569e+00 3.527003023913356e+00 4.796142074451510e+00 9.184941507235135e+03 + 123600 8.786513663463639e-01 -5.905554047788812e+00 -6.053829789942530e+00 4.167239809343012e+00 4.315817552299415e+00 9.383060623138097e+03 + 123620 1.007253991704887e+00 -6.101579265283224e+00 -6.037000009322678e+00 3.128592426213861e+00 4.499416507546880e+00 9.330996097703426e+03 + 123640 9.920399508359660e-01 -6.083113302185224e+00 -6.023941574478631e+00 3.298730677059297e+00 4.638503894345831e+00 9.290717816219178e+03 + 123660 9.767461172764059e-01 -6.063422801863068e+00 -6.012780349513439e+00 3.384849372772928e+00 4.675646171058670e+00 9.256337802428052e+03 + 123680 1.006743890164171e+00 -6.107438909229407e+00 -5.975517978094436e+00 3.122438080739188e+00 4.879948482014306e+00 9.142062286298164e+03 + 123700 9.979922091691785e-01 -6.089791463520310e+00 -6.010443200652583e+00 3.234551768540202e+00 4.690181773030684e+00 9.249132210228405e+03 + 123720 1.017126544827034e+00 -6.110311489777317e+00 -5.942562864492560e+00 3.148672802998337e+00 5.111911368399280e+00 9.041587451238711e+03 + 123740 9.377786304736554e-01 -5.977181395860317e+00 -6.010991290671952e+00 3.807447729491142e+00 4.613306081418419e+00 9.250808640906951e+03 + 123760 1.083944312910552e+00 -6.166235570746960e+00 -5.979232470584986e+00 2.841809092271783e+00 4.915609832038063e+00 9.153423238277472e+03 + 123780 9.587316744157260e-01 -5.945599402925202e+00 -6.018278901199039e+00 3.974607166379101e+00 4.557270240174722e+00 9.273249091001513e+03 + 123800 1.021472519920928e+00 -5.994356981359410e+00 -6.034966183564231e+00 3.708638883822547e+00 4.475454560508732e+00 9.324695275781913e+03 + 123820 1.012722126021111e+00 -5.934705175862732e+00 -6.032610553077223e+00 4.070325354045004e+00 4.508137527271235e+00 9.317403748673705e+03 + 123840 1.048229268904558e+00 -5.948545848719429e+00 -5.989897803875113e+00 3.989815781076932e+00 4.752366455378616e+00 9.186047824070094e+03 + 123860 9.720628159192579e-01 -5.805789434241822e+00 -6.024875465437868e+00 4.723866336246204e+00 4.465840441664752e+00 9.293535047868398e+03 + 123880 1.099858067453143e+00 -5.975067076769561e+00 -5.961241146541541e+00 3.872606932587036e+00 4.951997563512112e+00 9.098431599694331e+03 + 123900 1.097501487090715e+00 -5.958867705275149e+00 -6.002951639614788e+00 3.932932204256019e+00 4.679795431311021e+00 9.226114408316113e+03 + 123920 1.080317660111342e+00 -5.932873808120159e+00 -6.007194519942589e+00 4.079824550973101e+00 4.653063522595725e+00 9.239146092755549e+03 + 123940 1.058119810902120e+00 -5.906593576231476e+00 -6.037324715323791e+00 4.183924755166663e+00 4.433246323920198e+00 9.331986920327610e+03 + 123960 1.053487809124982e+00 -5.913525642412194e+00 -6.020311279822441e+00 4.146375808819167e+00 4.533196153785547e+00 9.279507109512202e+03 + 123980 1.061941219730768e+00 -5.946699513365287e+00 -6.002665700684656e+00 4.036012228432083e+00 4.714645720104769e+00 9.225220351265700e+03 + 124000 1.012274077957281e+00 -5.897146912239277e+00 -6.050321248374281e+00 4.257637395463574e+00 4.378086653724472e+00 9.372141612023126e+03 + 124020 1.085680059621698e+00 -6.032239523861806e+00 -5.990036748671830e+00 3.498025847786092e+00 4.740360713785288e+00 9.186502418393038e+03 + 124040 1.022959445064382e+00 -5.965549981880623e+00 -6.015037502389326e+00 3.882266527122741e+00 4.598101526192719e+00 9.263268334457896e+03 + 124060 9.931326954876774e-01 -5.944988685611698e+00 -6.008312219287410e+00 3.920535993613307e+00 4.556922463962203e+00 9.242595171412024e+03 + 124080 1.057353561950592e+00 -6.059763867882184e+00 -5.988670350776236e+00 3.389567508188625e+00 4.797797485097194e+00 9.182301848971339e+03 + 124100 9.860858845003762e-01 -5.968581534442435e+00 -6.029708915971403e+00 3.835963311580020e+00 4.484960427408964e+00 9.308474208341360e+03 + 124120 1.061590941755535e+00 -6.093015288310814e+00 -5.999832540400881e+00 3.200820403088874e+00 4.735890161571348e+00 9.216546919144843e+03 + 124140 9.662817435301387e-01 -5.963171499859463e+00 -6.024900944515498e+00 3.875060482300348e+00 4.520600458484710e+00 9.293645340266856e+03 + 124160 9.881626582202623e-01 -6.003270910871541e+00 -5.976794962613015e+00 3.720640723439520e+00 4.872669715479725e+00 9.145930727461193e+03 + 124180 9.420939858967305e-01 -5.939318836310806e+00 -6.010773312933384e+00 4.038768325183471e+00 4.628465662872100e+00 9.250123394625247e+03 + 124200 9.934017734789602e-01 -6.015850568389206e+00 -5.963817536660697e+00 3.630940506482832e+00 4.929722226753569e+00 9.106306362934552e+03 + 124220 9.764651631955996e-01 -5.988109143830149e+00 -6.008053979347290e+00 3.749287603562169e+00 4.634761271569426e+00 9.241788763333712e+03 + 124240 9.840243280086807e-01 -5.995880406869042e+00 -6.020968213968503e+00 3.740855524687925e+00 4.596797453997217e+00 9.281542774138152e+03 + 124260 9.455904234278267e-01 -5.936645003790912e+00 -6.058827784888255e+00 4.073631724131467e+00 4.372039287346259e+00 9.398501024624293e+03 + 124280 1.076525222016993e+00 -6.129727327848756e+00 -5.970224897729970e+00 3.015144184634052e+00 4.931031821297410e+00 9.125886647472122e+03 + 124300 1.028786921610537e+00 -6.058171765522241e+00 -5.959352873463576e+00 3.356961891230990e+00 4.924395261605964e+00 9.092714778637652e+03 + 124320 9.899272841505514e-01 -5.997180629092604e+00 -6.007641243055870e+00 3.691021345129546e+00 4.630954880977694e+00 9.240500578839205e+03 + 124340 1.039555768408490e+00 -6.065036819715152e+00 -5.955507943451718e+00 3.379680437452158e+00 5.008612194495617e+00 9.080981140633074e+03 + 124360 9.825832472930974e-01 -5.974527624199014e+00 -5.975736413218733e+00 3.812250640495523e+00 4.805309586884799e+00 9.142711285820058e+03 + 124380 9.980322335042471e-01 -5.986770752267056e+00 -5.985306378016524e+00 3.754519553745834e+00 4.762928217303569e+00 9.172010152928520e+03 + 124400 1.044156042935792e+00 -6.038724291714997e+00 -6.016594664034223e+00 3.495827737133202e+00 4.622899483825025e+00 9.268057505579911e+03 + 124420 1.008758843966250e+00 -5.966960003574558e+00 -6.043515457421063e+00 3.846618743116153e+00 4.407025480211324e+00 9.351117504385731e+03 + 124440 1.070176921641926e+00 -6.033976577163402e+00 -5.980121491141333e+00 3.499725663965798e+00 4.808969901952151e+00 9.156133345841441e+03 + 124460 9.687547762710829e-01 -5.854936462646704e+00 -6.091204725781299e+00 4.470013084408931e+00 4.113324155094525e+00 9.499115901188057e+03 + 124480 1.036390555258667e+00 -5.923838573028403e+00 -6.022000355350316e+00 4.128384730591566e+00 4.564724586012425e+00 9.284686351820284e+03 + 124500 1.077511879157249e+00 -5.954704252766570e+00 -5.999133839975630e+00 3.895802664695853e+00 4.640681099485028e+00 9.214395758764327e+03 + 124520 9.953991383502016e-01 -5.807520480812563e+00 -6.047994305195404e+00 4.652095024823709e+00 4.271257112013383e+00 9.364939454663674e+03 + 124540 1.103043397986634e+00 -5.946767529431950e+00 -6.003041792448391e+00 3.999357860055679e+00 4.676222333401218e+00 9.226390505049303e+03 + 124560 1.185328625152855e+00 -6.056189807233237e+00 -5.996630478980332e+00 3.364306645829181e+00 4.706305525433617e+00 9.206707340062268e+03 + 124580 1.055063125440739e+00 -5.861554272663236e+00 -6.028714716112446e+00 4.467007815042721e+00 4.507146680762335e+00 9.305390820419036e+03 + 124600 1.104701881009136e+00 -5.944126686991133e+00 -6.015340942527543e+00 3.984900490179546e+00 4.575977214519051e+00 9.264202707385744e+03 + 124620 1.123438516348996e+00 -5.996404864448864e+00 -5.952522487754739e+00 3.739715559563866e+00 4.991694957317378e+00 9.071843158278227e+03 + 124640 9.880794721018266e-01 -5.828707062166655e+00 -6.026754623939762e+00 4.585878759020074e+00 4.448659011557758e+00 9.299268423159070e+03 + 124660 9.611105052715775e-01 -5.828862280797315e+00 -6.025052169648831e+00 4.634601284068941e+00 4.508048581996360e+00 9.294081026644240e+03 + 124680 1.073689594477091e+00 -6.039275873682342e+00 -5.994560381599896e+00 3.476525705914460e+00 4.733288981151896e+00 9.200354453593309e+03 + 124700 1.000584873663811e+00 -5.972200184111881e+00 -6.011712062090627e+00 3.768431409911373e+00 4.541548092114057e+00 9.253028618328897e+03 + 124720 9.893961610914653e-01 -5.987684590170650e+00 -6.024597190060384e+00 3.683335744543269e+00 4.471377883770044e+00 9.292703218230341e+03 + 124740 9.767814076171210e-01 -5.991620114108662e+00 -6.000817584938131e+00 3.770828147298456e+00 4.718014846491632e+00 9.219537083458108e+03 + 124760 1.008583611188331e+00 -6.055134777382788e+00 -5.962131998624566e+00 3.443293655654013e+00 4.977330003417229e+00 9.101154378674348e+03 + 124780 1.004712251642494e+00 -6.060629468958676e+00 -5.972598745691249e+00 3.386000263988252e+00 4.891486299700218e+00 9.133125089315479e+03 + 124800 9.513251416107497e-01 -5.988520385929957e+00 -5.989467489666035e+00 3.772880635535071e+00 4.767442219318679e+00 9.184734011475017e+03 + 124820 9.285224611198164e-01 -5.954981763343010e+00 -6.003881627522146e+00 3.932140672107892e+00 4.651350084761767e+00 9.228963818344326e+03 + 124840 9.856680175868193e-01 -6.037245889566232e+00 -5.972432766620466e+00 3.470289073969006e+00 4.842456055721950e+00 9.132612531193368e+03 + 124860 9.820446753741117e-01 -6.025641160062878e+00 -5.994831593049836e+00 3.599242060546033e+00 4.776155362100006e+00 9.201173595634313e+03 + 124880 9.719838054304180e-01 -6.004110762060463e+00 -6.019491239388354e+00 3.655244803399943e+00 4.566927722462021e+00 9.276961003162845e+03 + 124900 9.993336514014178e-01 -6.036433120738961e+00 -5.990876299556321e+00 3.522248426066599e+00 4.783842743192610e+00 9.189051743137688e+03 + 124920 9.760227571907198e-01 -5.990515593656283e+00 -5.987647554355265e+00 3.787178271790977e+00 4.803646997285075e+00 9.179155326055947e+03 + 124940 9.554723263286306e-01 -5.946911489419190e+00 -6.019467089154888e+00 3.968366163028428e+00 4.551740681403272e+00 9.276899071956868e+03 + 124960 1.038749121411120e+00 -6.054603960946668e+00 -5.955746115074043e+00 3.421012064725437e+00 4.988669113928258e+00 9.081704888463535e+03 + 124980 9.813518341174633e-01 -5.950411096188477e+00 -5.982615319779734e+00 3.974584633840274e+00 4.789662998391776e+00 9.163742366609622e+03 + 125000 1.058803600663917e+00 -6.042477251681595e+00 -6.008397168562554e+00 3.469756770881097e+00 4.665449882026449e+00 9.242845901049623e+03 + 125020 1.011004311163601e+00 -5.946555565902699e+00 -5.992371278758494e+00 4.017328654570617e+00 4.754247741393989e+00 9.193654352469128e+03 + 125040 1.128335769362622e+00 -6.093145724125940e+00 -5.982813594951210e+00 3.255061843655502e+00 4.888606003218612e+00 9.164367245017345e+03 + 125060 1.033658255271295e+00 -5.923999791388416e+00 -6.021214713332393e+00 4.077389607437232e+00 4.519166481674371e+00 9.282286635071421e+03 + 125080 1.025966170264179e+00 -5.888257660416938e+00 -6.011463058625383e+00 4.295738492166388e+00 4.588274029679744e+00 9.252226795352315e+03 + 125100 1.113718045768765e+00 -5.990579328552990e+00 -5.958087728954386e+00 3.732188272629949e+00 4.918760065583925e+00 9.088815987963491e+03 + 125120 1.088892424095274e+00 -5.919433775150998e+00 -6.005311331332893e+00 4.120602829942239e+00 4.627480612836932e+00 9.233347157559654e+03 + 125140 1.123476671422095e+00 -5.938802811383860e+00 -6.003112945550227e+00 4.081365768712224e+00 4.712087026367843e+00 9.226581232640488e+03 + 125160 1.108949422776599e+00 -5.890135581963097e+00 -6.008993687416028e+00 4.347248372412208e+00 4.664746737669102e+00 9.244656940776127e+03 + 125180 1.143370688259858e+00 -5.920544147752681e+00 -6.019509448664929e+00 4.161625847191600e+00 4.593351774522647e+00 9.277014287426362e+03 + 125200 1.094110113884833e+00 -5.838998421105206e+00 -6.024589389549471e+00 4.546446071248368e+00 4.480754010331850e+00 9.292663251758731e+03 + 125220 1.038305704692693e+00 -5.760919899281270e+00 -6.026490744578792e+00 4.981287881755168e+00 4.456338991101307e+00 9.298541681479464e+03 + 125240 1.093935211188485e+00 -5.863307236382985e+00 -6.055842015506163e+00 4.460424192384732e+00 4.354859695998669e+00 9.389257707173074e+03 + 125260 1.126232741316094e+00 -5.956377788187481e+00 -6.035169918780081e+00 3.894981494797281e+00 4.442544887891774e+00 9.325341462850929e+03 + 125280 1.060329743271590e+00 -5.921405287826175e+00 -5.997415048166975e+00 4.108176238694208e+00 4.671716432344941e+00 9.209081660912554e+03 + 125300 9.959776766886681e-01 -5.881774580489923e+00 -5.986453988118081e+00 4.367209691398728e+00 4.766124333711869e+00 9.175486083134778e+03 + 125320 1.058343273395161e+00 -6.021569833116390e+00 -6.027113593794644e+00 3.615001761481444e+00 4.583168629772723e+00 9.300447000261905e+03 + 125340 1.032239960784057e+00 -6.019484366065891e+00 -6.013728990104951e+00 3.582298378778156e+00 4.615346638187423e+00 9.259240547244699e+03 + 125360 1.004056682584813e+00 -6.005140857387198e+00 -6.027485510414293e+00 3.750589200923406e+00 4.622282745417943e+00 9.301587421743461e+03 + 125380 9.495696676121819e-01 -5.945150443567941e+00 -6.029309399088422e+00 4.027230015644466e+00 4.543976269489586e+00 9.307266409712036e+03 + 125400 1.004442792203323e+00 -6.041271262809451e+00 -6.019008557231185e+00 3.500140360204990e+00 4.627976260777943e+00 9.275496987756451e+03 + 125420 1.019347572263133e+00 -6.076425444433160e+00 -6.027221883980931e+00 3.303540257994933e+00 4.586074716338003e+00 9.300815091392524e+03 + 125440 9.998373153607814e-01 -6.060262729001812e+00 -6.025429212092256e+00 3.396966124105709e+00 4.596985568669699e+00 9.295280468895882e+03 + 125460 9.742724174621146e-01 -6.033757408641801e+00 -6.025860709988849e+00 3.586384309538112e+00 4.631728375213531e+00 9.296604814371507e+03 + 125480 9.153272335643468e-01 -5.955091350048226e+00 -6.005609558047333e+00 3.982518049293447e+00 4.692434681295154e+00 9.234266505126632e+03 + 125500 9.868012582977953e-01 -6.066774652642710e+00 -5.972992715060176e+00 3.413240324224066e+00 4.951750722530917e+00 9.134312333079199e+03 + 125520 9.985416562089677e-01 -6.083955579526577e+00 -6.019096506027084e+00 3.243013985497389e+00 4.615444822440663e+00 9.275772760288344e+03 + 125540 9.445451434350892e-01 -6.001333626880140e+00 -6.012134515679953e+00 3.760322799775299e+00 4.698302424854639e+00 9.254339058744630e+03 + 125560 9.835987135488923e-01 -6.054060138273593e+00 -5.977890539476261e+00 3.425088351162915e+00 4.862465974664511e+00 9.149283993474472e+03 + 125580 9.708156242733434e-01 -6.024077856301126e+00 -5.971016804859226e+00 3.585428967917394e+00 4.890113736467957e+00 9.128289769474139e+03 + 125600 9.857284541798346e-01 -6.029705592649568e+00 -5.994952979789590e+00 3.560689023068963e+00 4.760243904060419e+00 9.201566393754481e+03 + 125620 9.805411172365961e-01 -6.000845723118795e+00 -5.979062321355821e+00 3.729771165415884e+00 4.854854829309413e+00 9.152871373833053e+03 + 125640 9.934446052095677e-01 -5.992923987257125e+00 -5.983330262727788e+00 3.786043740712754e+00 4.841132391584279e+00 9.165950421119356e+03 + 125660 1.022898881955278e+00 -6.003557834794901e+00 -6.017623691529747e+00 3.650318669887091e+00 4.569550343831317e+00 9.271233004227084e+03 + 125680 9.812225521664235e-01 -5.906446408435178e+00 -6.045647728547983e+00 4.180376924205397e+00 4.381061402783005e+00 9.357719973328123e+03 + 125700 1.038884968407810e+00 -5.961967490074636e+00 -6.027117250243458e+00 3.920760873364321e+00 4.546660868582142e+00 9.300474460682615e+03 + 125720 1.014047045385409e+00 -5.900581840825416e+00 -6.011258037263846e+00 4.215125837972691e+00 4.579605990937181e+00 9.251632841745142e+03 + 125740 1.037712204943780e+00 -5.915738759912657e+00 -6.043271843560960e+00 4.143604827142261e+00 4.411290125152793e+00 9.350347361157903e+03 + 125760 1.005843100422138e+00 -5.855608947953996e+00 -6.027832879838955e+00 4.494285117316235e+00 4.505348648865480e+00 9.302666314612770e+03 + 125780 1.036442332250424e+00 -5.895079259929557e+00 -6.007487392778660e+00 4.242393021369736e+00 4.596928127447848e+00 9.240036300420748e+03 + 125800 1.033653182969207e+00 -5.889618706327971e+00 -5.976926671792755e+00 4.370213115916081e+00 4.868877267353295e+00 9.146316581893683e+03 + 125820 1.082547965046774e+00 -5.966157099810196e+00 -5.993469264419600e+00 3.909754789037940e+00 4.752924113306930e+00 9.197013130416244e+03 + 125840 1.084015407373549e+00 -5.979980014909617e+00 -5.998812477741950e+00 3.875629713342537e+00 4.767490797445076e+00 9.213405186930671e+03 + 125860 1.003395864353425e+00 -5.883054022419498e+00 -6.016418003925783e+00 4.304371042801083e+00 4.538574422982554e+00 9.267524651271990e+03 + 125880 1.038953409490851e+00 -5.974182885231290e+00 -6.016763570687524e+00 3.792090700238202e+00 4.547585815008726e+00 9.268565002541289e+03 + 125900 1.025848325204767e+00 -6.009920869454565e+00 -5.990857512342031e+00 3.625327550425429e+00 4.734792297010582e+00 9.188989005385682e+03 + 125920 9.596258813945371e-01 -5.971204780737382e+00 -6.002307298466624e+00 3.871643566576727e+00 4.693048096676356e+00 9.224135433907537e+03 + 125940 9.468187152049662e-01 -6.004159660645293e+00 -5.990954673519568e+00 3.738623504474289e+00 4.814448584015354e+00 9.189262783893882e+03 + 125960 9.252418716497699e-01 -6.003438821257785e+00 -5.994394916267987e+00 3.688867618492083e+00 4.740799120483282e+00 9.199824549649265e+03 + 125980 9.433694283047944e-01 -6.045222461096742e+00 -5.993417263737068e+00 3.420763689308691e+00 4.718237149376325e+00 9.196846677307958e+03 + 126000 9.074247295366429e-01 -5.997226572508357e+00 -6.031488266485722e+00 3.671191290242314e+00 4.474455341444274e+00 9.313961143393215e+03 + 126020 9.417788512939868e-01 -6.048655753032055e+00 -5.990211702502586e+00 3.431866868207617e+00 4.767461650535415e+00 9.187012355122486e+03 + 126040 9.181244022498743e-01 -6.007371570285549e+00 -5.972997233893471e+00 3.683062796262651e+00 4.880445555237331e+00 9.134345306285408e+03 + 126060 9.140409062871906e-01 -5.989046965932240e+00 -6.025225613837806e+00 3.748907054077019e+00 4.541163659175592e+00 9.294667101149495e+03 + 126080 1.021718872608038e+00 -6.133475266382705e+00 -5.968548278077069e+00 3.006553739935851e+00 4.953590029155766e+00 9.120745260658678e+03 + 126100 1.036007945343511e+00 -6.136547581298867e+00 -5.971573664939749e+00 2.972605432932966e+00 4.919911190298073e+00 9.129985653594542e+03 + 126120 9.840400007309779e-01 -6.037958745068978e+00 -5.998311055281426e+00 3.510391570145234e+00 4.738054740365525e+00 9.211870340881129e+03 + 126140 9.591541988278618e-01 -5.977231370806799e+00 -6.035831487645790e+00 3.809679177326709e+00 4.473188238098448e+00 9.327387610250129e+03 + 126160 9.831623845582614e-01 -5.989809122046782e+00 -6.005626307270774e+00 3.743399847132836e+00 4.652575121875172e+00 9.234333106555781e+03 + 126180 9.831261497659205e-01 -5.965843649577028e+00 -6.060248918319530e+00 3.887280286198827e+00 4.345190623911259e+00 9.402937246209694e+03 + 126200 1.100700991815297e+00 -6.118245281910656e+00 -5.998540302343055e+00 3.093601244710562e+00 4.780965761673448e+00 9.212572041959735e+03 + 126220 1.068825287626537e+00 -6.054677497409041e+00 -5.999042020917519e+00 3.422207399134424e+00 4.741674914710908e+00 9.214105910211345e+03 + 126240 1.034571182758139e+00 -5.991617902713482e+00 -5.980836128841276e+00 3.795915381388534e+00 4.857825995436857e+00 9.158297883393012e+03 + 126260 1.023293506858967e+00 -5.962895328007463e+00 -5.991718378693212e+00 3.957544216841449e+00 4.792037799451193e+00 9.191624687795342e+03 + 126280 1.014627145856603e+00 -5.940210215362608e+00 -6.018133682075455e+00 4.030413921479928e+00 4.582965316997265e+00 9.272783850424348e+03 + 126300 9.837103546122099e-01 -5.886610371647957e+00 -6.020328436126865e+00 4.325706851607530e+00 4.557877032566034e+00 9.279530911443155e+03 + 126320 1.041775249319381e+00 -5.967195202276034e+00 -6.045504061155243e+00 3.822602832692018e+00 4.372941246750855e+00 9.357266769537484e+03 + 126340 1.032482657250843e+00 -5.953581899024300e+00 -6.000539965073119e+00 3.919912582996281e+00 4.650272101006726e+00 9.218701611591128e+03 + 126360 1.074996796693191e+00 -6.020785166852886e+00 -6.017103585694621e+00 3.574730064034863e+00 4.595870272768465e+00 9.269628744233378e+03 + 126380 1.040044141715966e+00 -5.982160316614779e+00 -6.005431420206675e+00 3.784663072232191e+00 4.651036794215885e+00 9.233737403517143e+03 + 126400 1.043615083844873e+00 -6.011658766460149e+00 -5.999620990639462e+00 3.616192333872894e+00 4.685315105475064e+00 9.215880829103737e+03 + 126420 9.493937484818084e-01 -5.908592090418303e+00 -6.023982552886112e+00 4.193688698476589e+00 4.531098806370071e+00 9.290803859937976e+03 + 126440 1.011406119749822e+00 -6.045839445242018e+00 -6.005960103451505e+00 3.432407941876658e+00 4.661401293745983e+00 9.235377222422225e+03 + 126460 1.023678153577608e+00 -6.114306313820338e+00 -6.010621662886549e+00 3.049069872270353e+00 4.644443183080046e+00 9.249703494021627e+03 + 126480 9.540694749489361e-01 -6.055316112252806e+00 -5.981672625444338e+00 3.410059807228490e+00 4.832932104775468e+00 9.160879625706701e+03 + 126500 9.955999900932107e-01 -6.147457260935766e+00 -5.947314333033954e+00 2.912145683520015e+00 5.061397347550221e+00 9.056019583226489e+03 + 126520 9.167819055554327e-01 -6.048334273562610e+00 -5.994541524917432e+00 3.406992279772886e+00 4.715878566894446e+00 9.200290776742981e+03 + 126540 9.522111950455127e-01 -6.108753218698528e+00 -5.959076799027974e+00 3.152969742236919e+00 5.012434906336326e+00 9.091837321232588e+03 + 126560 9.506452207683755e-01 -6.106796466361642e+00 -5.960762548506428e+00 3.109165788454054e+00 4.947715143454448e+00 9.096989888241151e+03 + 126580 9.471114000031166e-01 -6.094382142904365e+00 -5.958676104472291e+00 3.150265834388096e+00 4.929510907506646e+00 9.090647226400770e+03 + 126600 9.487255147836527e-01 -6.081802974480584e+00 -5.987142901727276e+00 3.254514960139605e+00 4.798067746488016e+00 9.177624758793811e+03 + 126620 9.941834773784647e-01 -6.126552186362151e+00 -5.984209160008705e+00 3.056247166330020e+00 4.873602851163648e+00 9.168640290362178e+03 + 126640 9.345920617210182e-01 -6.012617169982644e+00 -5.975473328570888e+00 3.643158156219315e+00 4.856443841596498e+00 9.141914545494041e+03 + 126660 9.706563502237273e-01 -6.037503061292819e+00 -5.967404989428872e+00 3.481696244071721e+00 4.884210220356067e+00 9.117258457561353e+03 + 126680 9.639067441494563e-01 -5.995491733028210e+00 -5.961172398454392e+00 3.774898639708575e+00 4.971965569731302e+00 9.098198319145669e+03 + 126700 1.008261769052061e+00 -6.029658765942020e+00 -5.943176154995239e+00 3.557029441056906e+00 5.053625976254112e+00 9.043412518523703e+03 + 126720 9.970643201092895e-01 -5.984493772983585e+00 -5.972907714916406e+00 3.730276098933138e+00 4.796805037291570e+00 9.134060293682871e+03 + 126740 1.049933145617008e+00 -6.040989452569630e+00 -5.976023063038459e+00 3.447608015976301e+00 4.820655078180573e+00 9.143588036187504e+03 + 126760 9.868219497222818e-01 -5.932048595677825e+00 -5.992948340681076e+00 4.040102658794053e+00 4.690406898780309e+00 9.195407426080634e+03 + 126780 9.980300797949851e-01 -5.938000364645976e+00 -5.989558066145712e+00 4.028415500373043e+00 4.732363199833039e+00 9.185020808859656e+03 + 126800 1.028464457138578e+00 -5.975626108810529e+00 -6.015376970573717e+00 3.786085384605621e+00 4.557829784935413e+00 9.264318200817546e+03 + 126820 1.025703953085985e+00 -5.969627670504784e+00 -6.021912772219588e+00 3.793587152548197e+00 4.493358007408451e+00 9.284442247047527e+03 + 126840 9.984488201142101e-01 -5.930326579934677e+00 -5.993357715621778e+00 4.095930431014089e+00 4.733995895862028e+00 9.196594132604121e+03 + 126860 9.621866375370721e-01 -5.877247972913261e+00 -6.027786235507817e+00 4.331471233858212e+00 4.467057234319422e+00 9.302514322946876e+03 + 126880 1.064593734511871e+00 -6.032495445997998e+00 -5.967204341599871e+00 3.558012482312989e+00 4.932924107532786e+00 9.116648804736615e+03 + 126900 9.737903680949692e-01 -5.902686682178262e+00 -6.032938494603252e+00 4.188780094572940e+00 4.440854031225812e+00 9.318432046980965e+03 + 126920 1.052819996258342e+00 -6.027648730335134e+00 -6.018445143941685e+00 3.479306669440790e+00 4.532155086762362e+00 9.273772356962736e+03 + 126940 9.919873355300870e-01 -5.949833708650692e+00 -6.025178757636807e+00 3.975002013452395e+00 4.542359082565475e+00 9.294517230436159e+03 + 126960 9.917578423447562e-01 -5.965268771509736e+00 -6.021728681872689e+00 3.879071845077743e+00 4.554870302630778e+00 9.283855661434280e+03 + 126980 1.013263728604067e+00 -6.014374353414841e+00 -5.971392284462335e+00 3.636769354757162e+00 4.883579046136122e+00 9.129420355565026e+03 + 127000 1.022603874958202e+00 -6.045912280210102e+00 -5.985798212731823e+00 3.452509324463841e+00 4.797693602545993e+00 9.173515049382457e+03 + 127020 1.015561887116795e+00 -6.058070276800820e+00 -5.978091713976291e+00 3.332012902153485e+00 4.791262186534535e+00 9.149924274270854e+03 + 127040 9.043615711825281e-01 -5.919493354035021e+00 -5.997697410829794e+00 4.120573121927379e+00 4.671513325773114e+00 9.209984103850622e+03 + 127060 1.014252189478500e+00 -6.113931453507769e+00 -6.024172367306615e+00 3.043978774025595e+00 4.559389337166318e+00 9.291423858159529e+03 + 127080 9.593592194692250e-01 -6.072542510234534e+00 -6.009478703103726e+00 3.301243945930372e+00 4.663366085568082e+00 9.246174354934357e+03 + 127100 9.015870049721679e-01 -6.026519446661443e+00 -6.008404230252973e+00 3.541652007734915e+00 4.645672383673035e+00 9.242872514427767e+03 + 127120 9.990307641025947e-01 -6.209352165825001e+00 -5.978437125359591e+00 2.594327263182106e+00 4.920277159521517e+00 9.150983321374553e+03 + 127140 9.084509835110506e-01 -6.107426670704972e+00 -5.989908204527757e+00 3.143938694499359e+00 4.818747913212793e+00 9.186089210668133e+03 + 127160 9.244882007937428e-01 -6.153562771851583e+00 -5.976258070787955e+00 2.877610284849740e+00 4.895721316170906e+00 9.144298236244025e+03 + 127180 8.504790203082592e-01 -6.053395514576076e+00 -5.995470703970223e+00 3.407297225363354e+00 4.739910451697635e+00 9.203141239047183e+03 + 127200 8.885694387093030e-01 -6.107188957488241e+00 -5.973805462804898e+00 3.143428009635155e+00 4.909336677136000e+00 9.136799946080862e+03 + 127220 8.958302941423194e-01 -6.103299302875531e+00 -5.945963605280572e+00 3.146366567383388e+00 5.049812490594155e+00 9.051920415285314e+03 + 127240 8.765755654581900e-01 -6.048673280952560e+00 -5.984944817265025e+00 3.452121226841267e+00 4.818059927282977e+00 9.170890575193031e+03 + 127260 9.759236799546855e-01 -6.164807424510532e+00 -5.961720939526692e+00 2.844803162704984e+00 5.010957187014180e+00 9.099919666177393e+03 + 127280 9.104275537397444e-01 -6.035465354080143e+00 -6.000150608195881e+00 3.520367179473318e+00 4.723149915280015e+00 9.217511210654533e+03 + 127300 9.952333733855508e-01 -6.131981841854936e+00 -5.975538992640811e+00 3.007035452120751e+00 4.905354501760932e+00 9.142124595957663e+03 + 127320 9.346279061661406e-01 -6.020325345258759e+00 -6.021321082679785e+00 3.572377591121918e+00 4.566659912760518e+00 9.282606336470413e+03 + 127340 9.407729467588528e-01 -6.012880996123896e+00 -6.000333076079414e+00 3.580808387125946e+00 4.652860485805715e+00 9.218087695853681e+03 + 127360 9.766444499051924e-01 -6.051322748034778e+00 -6.015891374567842e+00 3.403447400720510e+00 4.606899830154979e+00 9.265889872404841e+03 + 127380 9.543635393758086e-01 -6.004981608993443e+00 -6.031773753968452e+00 3.617535151012880e+00 4.463690508495349e+00 9.314851945013756e+03 + 127400 1.011547457715317e+00 -6.076381021692956e+00 -6.037392279824749e+00 3.248586429482230e+00 4.472465818777787e+00 9.332194335241436e+03 + 127420 1.022351064199831e+00 -6.079483171173040e+00 -5.989005119304127e+00 3.278369098549660e+00 4.797908073814233e+00 9.183334380262815e+03 + 127440 1.056920713897966e+00 -6.118899077014094e+00 -5.980426361778528e+00 3.060688781893487e+00 4.855820541359533e+00 9.157055895969101e+03 + 127460 9.769051316479397e-01 -5.986007062309012e+00 -5.982893078266102e+00 3.761534030257490e+00 4.779415008519356e+00 9.164599861467263e+03 + 127480 9.362620345062764e-01 -5.910264058259147e+00 -6.009392175507827e+00 4.163157782269461e+00 4.593948793000971e+00 9.245856017173834e+03 + 127500 1.037020497505846e+00 -6.040872372215827e+00 -6.000256015503711e+00 3.511144904902483e+00 4.744370310504342e+00 9.217835416183261e+03 + 127520 1.028722671049858e+00 -6.009575557581574e+00 -5.973910512949543e+00 3.709133762458935e+00 4.913927967883874e+00 9.137141834266686e+03 + 127540 9.624747677999433e-01 -5.893757721519711e+00 -6.053484730436590e+00 4.209558613855549e+00 4.292381410980076e+00 9.381938159287627e+03 + 127560 1.090080258347061e+00 -6.066935040616704e+00 -5.994585310292456e+00 3.314684298890981e+00 4.730127646497392e+00 9.200432133342587e+03 + 127580 1.007191360059820e+00 -5.929114689223937e+00 -6.060652352552559e+00 4.057989185868950e+00 4.302679567648384e+00 9.404155847173575e+03 + 127600 1.011812233518575e+00 -5.926219271986834e+00 -6.050407230685113e+00 4.028941558385343e+00 4.315835081515325e+00 9.372437679758055e+03 + 127620 1.070322103340254e+00 -6.008763646443046e+00 -5.991379467544618e+00 3.690863193839013e+00 4.790685839266777e+00 9.190561383893388e+03 + 127640 1.017461155922950e+00 -5.928324726385360e+00 -5.997245953604642e+00 4.057553042525242e+00 4.661796690306682e+00 9.208559534514436e+03 + 127660 1.004773866765832e+00 -5.907992505647534e+00 -5.993893064066500e+00 4.241701974095027e+00 4.748447674584873e+00 9.198291600701936e+03 + 127680 1.026260531868406e+00 -5.941467341365021e+00 -5.998795158406031e+00 4.026789155913205e+00 4.697603959012715e+00 9.213356812865102e+03 + 127700 1.047910136316763e+00 -5.981455137926904e+00 -6.013897593849566e+00 3.758651125176722e+00 4.572361522814967e+00 9.259773576759901e+03 + 127720 1.047184019493177e+00 -5.997153305851448e+00 -6.016812281269359e+00 3.703153671641148e+00 4.590268792574890e+00 9.268716712274882e+03 + 127740 1.008240590328148e+00 -5.965909146258094e+00 -5.988940704785584e+00 3.903280894323582e+00 4.771030121136572e+00 9.183122651570988e+03 + 127760 1.007796344426536e+00 -5.998180202237426e+00 -5.961197743709556e+00 3.771068983624221e+00 4.983427983508212e+00 9.098312622408001e+03 + 127780 1.010228455336822e+00 -6.039499163939140e+00 -6.009429050583632e+00 3.490991029600625e+00 4.663658273822952e+00 9.246016412755722e+03 + 127800 1.010801155267739e+00 -6.079246759812655e+00 -6.033104276329803e+00 3.240175439769998e+00 4.505132720454776e+00 9.318963303286648e+03 + 127820 9.732746016710978e-01 -6.061500255328550e+00 -6.010759082051681e+00 3.354766535290266e+00 4.646130204417235e+00 9.250124965197783e+03 + 127840 1.001492954255722e+00 -6.133948890435713e+00 -5.978817854620903e+00 2.958966478767818e+00 4.849752892866665e+00 9.152147119166935e+03 + 127860 9.082763612129098e-01 -6.016577961495685e+00 -5.975859739036301e+00 3.614132537128376e+00 4.847942871614718e+00 9.143082795671931e+03 + 127880 9.579078061137467e-01 -6.100391848098502e+00 -6.003602501526389e+00 3.174436530605568e+00 4.730215936725611e+00 9.228092336387032e+03 + 127900 9.612172359892955e-01 -6.109962996245846e+00 -5.972415500436060e+00 3.109731815706260e+00 4.899550822052241e+00 9.132558471509383e+03 + 127920 9.059452279812215e-01 -6.024854133018119e+00 -5.996012019907109e+00 3.532553395730067e+00 4.698169272516066e+00 9.204781343721061e+03 + 127940 8.736080385693705e-01 -5.965881818102577e+00 -5.955801721672975e+00 3.930657730869412e+00 4.988539204458069e+00 9.081828736273741e+03 + 127960 9.957576108738313e-01 -6.127172550232813e+00 -5.956140520955687e+00 2.990453315067025e+00 4.972545694297276e+00 9.082913870460263e+03 + 127980 9.754811778341296e-01 -6.071999062819128e+00 -5.985467191231405e+00 3.309645563535001e+00 4.806524960955556e+00 9.172509619449565e+03 + 128000 9.654507645089453e-01 -6.032146535642744e+00 -5.993516840004962e+00 3.506235263517421e+00 4.728052953795648e+00 9.197147331460341e+03 + 128020 9.677328979384587e-01 -6.009809161885104e+00 -5.978228982434555e+00 3.641111929642785e+00 4.822450207064819e+00 9.150338396339881e+03 + 128040 9.448769873186841e-01 -5.950490925886834e+00 -6.009381356753849e+00 3.954088583214701e+00 4.615930615911575e+00 9.245864002718792e+03 + 128060 9.937629834265210e-01 -6.000415420942415e+00 -6.006296574374933e+00 3.667719453242782e+00 4.633948960127714e+00 9.236409200882212e+03 + 128080 1.035050171015811e+00 -6.046072296141639e+00 -6.004840375476181e+00 3.417058006687169e+00 4.653818075767326e+00 9.231916623211149e+03 + 128100 9.764341102110845e-01 -5.949258235763965e+00 -5.990942696128662e+00 4.007458624397588e+00 4.768100002334106e+00 9.189268343743037e+03 + 128120 1.032948509422864e+00 -6.025791829462957e+00 -5.954543688448536e+00 3.557358977398851e+00 4.966476828717846e+00 9.078039496182633e+03 + 128140 1.058648198845030e+00 -6.058106460400031e+00 -5.974338949722354e+00 3.360267291018784e+00 4.841273300310389e+00 9.138449133751052e+03 + 128160 9.676756839569388e-01 -5.920498791139682e+00 -5.980095734338475e+00 4.150359762873517e+00 4.808144892428897e+00 9.156050604161488e+03 + 128180 1.003457117960137e+00 -5.969604234616411e+00 -6.018022183805282e+00 3.885862509873321e+00 4.607839152977399e+00 9.272455500527642e+03 + 128200 1.082234146400672e+00 -6.086439804212803e+00 -5.980373637678067e+00 3.235998617921222e+00 4.845046959849906e+00 9.156897974937894e+03 + 128220 1.033487423352725e+00 -6.016080806067976e+00 -6.002490389994877e+00 3.605248671584007e+00 4.683286943785832e+00 9.224691013326039e+03 + 128240 9.530500556957630e-01 -5.901190313025213e+00 -6.005532935653758e+00 4.211015523616226e+00 4.611864037514460e+00 9.234039109386131e+03 + 128260 9.620994771598668e-01 -5.918121074776619e+00 -6.015097233869730e+00 4.116140220453154e+00 4.559288107928392e+00 9.263458491759042e+03 + 128280 9.974484138168876e-01 -5.973078439384391e+00 -6.025987124040616e+00 3.808759307451641e+00 4.504949452563110e+00 9.296985542199340e+03 + 128300 1.079425612706120e+00 -6.100022684942491e+00 -5.964573825041390e+00 3.178173910770239e+00 4.955942224965689e+00 9.108623733721075e+03 + 128320 1.001142902072301e+00 -5.992161745392119e+00 -5.976209932414944e+00 3.739713133523697e+00 4.831310912173715e+00 9.144153788989503e+03 + 128340 9.872812772178077e-01 -5.980907371555402e+00 -5.933344519637441e+00 3.839081091245891e+00 5.112194347286369e+00 9.013539073314381e+03 + 128360 1.035076673531440e+00 -6.059163323213880e+00 -5.972963122791487e+00 3.406764308367213e+00 4.901739198630491e+00 9.134234134621376e+03 + 128380 9.709245880925518e-01 -5.974499738754015e+00 -6.018367628643727e+00 3.849341795605787e+00 4.597445583325038e+00 9.273532481664237e+03 + 128400 9.737951930847101e-01 -5.994692987035931e+00 -6.022123587434970e+00 3.706591279947901e+00 4.549080527584927e+00 9.285108217157698e+03 + 128420 1.018304878002660e+00 -6.080795237224591e+00 -6.009558886659461e+00 3.244441527166341e+00 4.653491675900943e+00 9.246421812080547e+03 + 128440 1.017113791085324e+00 -6.105703769652395e+00 -5.987110110685302e+00 3.154984730715035e+00 4.835967872813498e+00 9.177528217024319e+03 + 128460 9.208370804711532e-01 -5.994838854076720e+00 -6.027635653970679e+00 3.732711213416429e+00 4.544386913136940e+00 9.302079997682213e+03 + 128480 9.437501303737642e-01 -6.059186659972251e+00 -5.995518537055216e+00 3.406455579933851e+00 4.772047794333647e+00 9.203307725230748e+03 + 128500 9.345167627928597e-01 -6.074359179929963e+00 -6.038465827587848e+00 3.256848914334841e+00 4.462954097961585e+00 9.335522124487714e+03 + 128520 9.559437298619869e-01 -6.129864919985712e+00 -5.980881694606651e+00 3.012849683019882e+00 4.868334418226071e+00 9.158458740557371e+03 + 128540 9.032210429967854e-01 -6.067754081571346e+00 -5.983148123879960e+00 3.324238731292831e+00 4.810059233086402e+00 9.165392135013983e+03 + 128560 8.801647633934440e-01 -6.040105126661830e+00 -6.028453371051267e+00 3.461559256740132e+00 4.528465440559342e+00 9.304589040195979e+03 + 128580 9.619821771486821e-01 -6.160779672898782e+00 -5.955627600524290e+00 2.869238148472404e+00 5.047253095227333e+00 9.081334337549175e+03 + 128600 9.152371521820265e-01 -6.080838248678182e+00 -5.992685305704716e+00 3.262583620737569e+00 4.768771460915049e+00 9.194614869696172e+03 + 128620 8.711415040924867e-01 -5.993613409209078e+00 -6.060355610717561e+00 3.669689219174053e+00 4.286445169790039e+00 9.403268308838455e+03 + 128640 9.824333271557915e-01 -6.127194001682281e+00 -5.992791018057348e+00 3.005057216049078e+00 4.776819946817941e+00 9.194940661165070e+03 + 128660 9.222612616105965e-01 -5.999082189916067e+00 -5.997007016716132e+00 3.684625783707280e+00 4.696541749353321e+00 9.207861049730191e+03 + 128680 9.340841079834711e-01 -5.972921620003774e+00 -6.024309903158194e+00 3.822379048395539e+00 4.527299574211741e+00 9.291835223682332e+03 + 128700 9.157328492946151e-01 -5.903759119694975e+00 -6.067158872259439e+00 4.186523150098655e+00 4.248256484843513e+00 9.424397059378944e+03 + 128720 1.066717470641097e+00 -6.097108327083287e+00 -5.973750410481124e+00 3.180249181555795e+00 4.888589428261316e+00 9.136656564899091e+03 + 128740 1.007049864689797e+00 -5.988831984002792e+00 -6.040468846189336e+00 3.710166940850664e+00 4.413660087396934e+00 9.341646370907192e+03 + 128760 9.969658591018101e-01 -5.961823251049095e+00 -6.009493789809204e+00 3.881072776314035e+00 4.607341165761462e+00 9.246210779813944e+03 + 128780 9.923620390066570e-01 -5.945718529825307e+00 -6.034892190513863e+00 3.901228796042058e+00 4.389179836788976e+00 9.324476397199731e+03 + 128800 1.000106938618093e+00 -5.952020961031598e+00 -6.008491455541188e+00 3.920869816145808e+00 4.596607497890962e+00 9.243130898265372e+03 + 128820 1.057929545241915e+00 -6.033752621115360e+00 -5.987292465947128e+00 3.483913045693549e+00 4.750694446355311e+00 9.178093050968460e+03 + 128840 1.093818700164423e+00 -6.087827329357928e+00 -5.979373053306605e+00 3.229300495308684e+00 4.852061731640362e+00 9.153831815709274e+03 + 128860 1.004423072441234e+00 -5.959710237629121e+00 -5.986134143042574e+00 3.916445360524895e+00 4.764715206554699e+00 9.174524082864375e+03 + 128880 1.008539273848093e+00 -5.971426967829748e+00 -5.966046161291739e+00 3.829963220531481e+00 4.860860644349847e+00 9.113076872415650e+03 + 128900 1.055127142291735e+00 -6.045006030220060e+00 -5.971328645821119e+00 3.456123426335318e+00 4.879190369092423e+00 9.129213445994073e+03 + 128920 1.033422803455056e+00 -6.020032158480019e+00 -5.983043042679641e+00 3.557555100850963e+00 4.769952327823907e+00 9.165057184771174e+03 + 128940 9.680326533134758e-01 -5.931697202826408e+00 -5.971446137863349e+00 4.063665462440170e+00 4.835420926330241e+00 9.129583941881709e+03 + 128960 1.032098293613718e+00 -6.035204683795853e+00 -5.937599786631828e+00 3.535586456827988e+00 5.096048880652843e+00 9.026472335858865e+03 + 128980 1.034493499479607e+00 -6.047042392660358e+00 -5.978627616346857e+00 3.417195312828504e+00 4.810043545573045e+00 9.151558259326528e+03 + 129000 1.006171309796463e+00 -6.017072151163605e+00 -6.008453277886951e+00 3.589886776420461e+00 4.639377680541338e+00 9.243019464982692e+03 + 129020 9.341254896397182e-01 -5.927003425691939e+00 -6.043519348451069e+00 4.045005219864233e+00 4.375952760600536e+00 9.351114945490746e+03 + 129040 9.860075082440577e-01 -6.023469626471840e+00 -6.011024787510211e+00 3.554134424148387e+00 4.625594615298667e+00 9.250914611541668e+03 + 129060 9.639737572455594e-01 -6.013515971868909e+00 -6.019643330006526e+00 3.595186736596333e+00 4.560002497964526e+00 9.277473235405847e+03 + 129080 1.027449794957783e+00 -6.135822720032940e+00 -5.950287107082921e+00 2.986506317536744e+00 5.051880518639070e+00 9.065085653959524e+03 + 129100 9.671836068588365e-01 -6.075413950427336e+00 -5.981393099326080e+00 3.284691332220448e+00 4.824573608923550e+00 9.160033817885675e+03 + 129120 9.245174010955705e-01 -6.039809864423798e+00 -6.012772101914381e+00 3.417489864612519e+00 4.572744881021820e+00 9.256305305909071e+03 + 129140 9.319521892205886e-01 -6.075818290102951e+00 -6.001509498430783e+00 3.283288054236778e+00 4.709980635266713e+00 9.221682915198273e+03 + 129160 9.128937140768254e-01 -6.066282050034484e+00 -5.968855034256105e+00 3.351824504424506e+00 4.911265505805927e+00 9.121675089020244e+03 + 129180 9.245339745460468e-01 -6.094452521603944e+00 -5.939275073879644e+00 3.195222899967907e+00 5.086275818433261e+00 9.031580994046211e+03 + 129200 9.339436463764496e-01 -6.111274533898261e+00 -5.944929720637922e+00 3.083750867182780e+00 5.038928526700305e+00 9.048762819841420e+03 + 129220 9.281593182456351e-01 -6.096148966111992e+00 -5.963632611783428e+00 3.194048492139138e+00 4.954977905533307e+00 9.105701668443924e+03 + 129240 9.072135605278561e-01 -6.047428258397335e+00 -5.977549556699731e+00 3.494317766785595e+00 4.895572085627372e+00 9.148259591521877e+03 + 129260 9.188448161568123e-01 -6.030383439753365e+00 -6.012569169089827e+00 3.538888122043214e+00 4.641180420942727e+00 9.255678301912612e+03 + 129280 9.118224665895619e-01 -5.975026511973351e+00 -6.034644634922781e+00 3.826147766461717e+00 4.483811278611380e+00 9.323727832952020e+03 + 129300 1.025146159059513e+00 -6.092467095814302e+00 -6.009238166402124e+00 3.174732512788587e+00 4.652645905108516e+00 9.245449401255852e+03 + 129320 1.015117929308483e+00 -6.034748045844030e+00 -5.987265010510431e+00 3.515469693270357e+00 4.788124630131859e+00 9.178002971347369e+03 + 129340 9.335812917316212e-01 -5.883384774188620e+00 -6.028421915475858e+00 4.256925559051675e+00 4.424099849355280e+00 9.304497196190774e+03 + 129360 1.036327053993415e+00 -6.013226345842714e+00 -5.991806406730674e+00 3.647047926804245e+00 4.770044531910445e+00 9.191916497315024e+03 + 129380 1.026877672673132e+00 -5.985633070068450e+00 -6.044178648008410e+00 3.783866196613983e+00 4.447688428183825e+00 9.353173429878327e+03 + 129400 1.009276299591125e+00 -5.952149595721756e+00 -6.074857068358862e+00 3.971572498010091e+00 4.266967201207804e+00 9.448279334395809e+03 + 129420 1.040985967185833e+00 -5.997378871524619e+00 -6.018834661637285e+00 3.704365985769367e+00 4.581163518669653e+00 9.274959229231068e+03 + 129440 1.064811273874027e+00 -6.034269001749547e+00 -6.015518683693140e+00 3.506564159441399e+00 4.614231387323635e+00 9.264754660148681e+03 + 129460 1.030975690457545e+00 -5.990966038896381e+00 -6.000567431918346e+00 3.796001994984536e+00 4.740869310441649e+00 9.218776066590895e+03 + 129480 9.844319334987990e-01 -5.929669017065686e+00 -6.029007516140009e+00 4.068563991668848e+00 4.498146957401036e+00 9.306300382415440e+03 + 129500 1.040163420141318e+00 -6.021732011072735e+00 -6.005197732822660e+00 3.579720114122737e+00 4.674662498505955e+00 9.233018287771631e+03 + 129520 1.068082595570755e+00 -6.076563857957208e+00 -5.989158681862374e+00 3.262877359248948e+00 4.764771406292767e+00 9.183806813643550e+03 + 129540 9.709707668020946e-01 -5.947613464711456e+00 -6.050097479269049e+00 4.012325378038756e+00 4.423846307099054e+00 9.371473863153195e+03 + 129560 1.005902038355223e+00 -6.019296624848729e+00 -6.006545328712858e+00 3.569904747741351e+00 4.643124663410221e+00 9.237149443273058e+03 + 129580 9.298289463997406e-01 -5.926954287668595e+00 -5.990481969132403e+00 4.057450089812495e+00 4.692664311970378e+00 9.187839865066184e+03 + 129600 1.030030375407591e+00 -6.091856401712850e+00 -5.996375204697285e+00 3.126557942093946e+00 4.674825751024803e+00 9.205943902130874e+03 + 129620 9.988993340110458e-01 -6.065203333834758e+00 -5.984948430979443e+00 3.324813984874410e+00 4.785650056475708e+00 9.170905414680263e+03 + 129640 9.268190574951019e-01 -5.978073380745987e+00 -6.007460127924151e+00 3.758600261463767e+00 4.589857011582320e+00 9.239966444600755e+03 + 129660 9.686763216865590e-01 -6.059095192291855e+00 -6.013980629797294e+00 3.366554667910996e+00 4.625609467210752e+00 9.260006269246871e+03 + 129680 9.668306824222946e-01 -6.076710071103831e+00 -5.975023260879812e+00 3.275422850373065e+00 4.859324250662405e+00 9.140516175380773e+03 + 129700 8.937728645520689e-01 -5.986472353495123e+00 -5.956749439546799e+00 3.766315100924344e+00 4.936988672421686e+00 9.084752442045874e+03 + 129720 9.200753940898841e-01 -6.038857293263064e+00 -5.995170047948045e+00 3.436581580363463e+00 4.687440503541666e+00 9.202202511019364e+03 + 129740 9.872176668838795e-01 -6.148353661172314e+00 -5.966080318675376e+00 2.917486634089538e+00 4.964128373415550e+00 9.113220184481908e+03 + 129760 9.256531287892650e-01 -6.064358629739904e+00 -5.991256003532211e+00 3.350915626390644e+00 4.770682218670064e+00 9.190245744394666e+03 + 129780 9.714905507034255e-01 -6.134963044584921e+00 -5.978233684249467e+00 2.994586699616590e+00 4.894550940452893e+00 9.150361989080753e+03 + 129800 9.305192445025794e-01 -6.070285205790953e+00 -5.973451413895965e+00 3.366821513068014e+00 4.922856131109901e+00 9.135715927127480e+03 + 129820 8.887904997029160e-01 -5.995156219089777e+00 -5.985576553173556e+00 3.753401586237926e+00 4.808409510377378e+00 9.172808643157929e+03 + 129840 9.876475701062374e-01 -6.113874538717629e+00 -6.004195891854090e+00 3.091400198144704e+00 4.721191961150895e+00 9.229956943211682e+03 + 129860 1.035172078284576e+00 -6.145348753568552e+00 -5.997112737024753e+00 2.925130501964847e+00 4.776324648408766e+00 9.208220066055703e+03 + 129880 9.100978147403386e-01 -5.919461795787170e+00 -6.070923237614566e+00 4.115479402913041e+00 4.245764365357759e+00 9.436062135638471e+03 + 129900 1.040157942737347e+00 -6.072724864014445e+00 -5.987151494239729e+00 3.312684689323380e+00 4.804060221005971e+00 9.177651957818816e+03 + 129920 9.953724396492994e-01 -5.972382261355053e+00 -6.016110802137147e+00 3.788720667499106e+00 4.537624619358505e+00 9.266582569055889e+03 + 129940 1.035336575554755e+00 -6.002960981349743e+00 -6.008213515845567e+00 3.697678840006529e+00 4.667517974104424e+00 9.242274913530824e+03 + 129960 1.022618371383055e+00 -5.961794595014908e+00 -5.992602864713087e+00 4.004190523261604e+00 4.827284671090332e+00 9.194312566764047e+03 + 129980 1.032588886695788e+00 -5.958018635050045e+00 -5.995527108989883e+00 3.908422690084037e+00 4.693043228303905e+00 9.203319157043894e+03 + 130000 1.104169247170680e+00 -6.051172124072947e+00 -5.992990249935561e+00 3.412671128223337e+00 4.746760453136130e+00 9.195562279572714e+03 + 130020 1.000316218995396e+00 -5.892143466740721e+00 -6.022364122956566e+00 4.253596790065225e+00 4.505849630492417e+00 9.285830696154315e+03 + 130040 1.048947475846856e+00 -5.964370614595948e+00 -6.004242905016046e+00 3.864574935602495e+00 4.635622073793296e+00 9.230058375729537e+03 + 130060 9.904828112649209e-01 -5.879937943812184e+00 -6.044182958571730e+00 4.317256268352542e+00 4.374135976769337e+00 9.353154149855442e+03 + 130080 1.029365307274480e+00 -5.944667164374422e+00 -6.011741387629565e+00 3.981629076653193e+00 4.596478507019665e+00 9.253117967692006e+03 + 130100 1.080638449795668e+00 -6.034767466587525e+00 -5.949705089496352e+00 3.518720864561803e+00 5.007162197179633e+00 9.063284305845484e+03 + 130120 1.034259727427872e+00 -5.982712071735659e+00 -5.936224279661723e+00 3.808493362329170e+00 5.075433458380278e+00 9.022303937304468e+03 + 130140 1.056719416506494e+00 -6.036123573529244e+00 -5.966908527277853e+00 3.555804936897505e+00 4.953248443466784e+00 9.115737919893192e+03 + 130160 9.905948052021167e-01 -5.965020390388405e+00 -6.041319455319518e+00 3.901718163797132e+00 4.463597125720543e+00 9.344323849298471e+03 + 130180 9.852535461557632e-01 -5.988795027637960e+00 -6.022957829889998e+00 3.775484125859629e+00 4.579316028651862e+00 9.287624509998550e+03 + 130200 9.617900430711576e-01 -5.988978959765634e+00 -5.991145230193576e+00 3.784477133488790e+00 4.772038073462277e+00 9.189862170572374e+03 + 130220 1.000741158316274e+00 -6.082955040292641e+00 -5.938731713495676e+00 3.345121163728994e+00 5.173273824684863e+00 9.029915307258010e+03 + 130240 9.671098931843203e-01 -6.064675324646883e+00 -5.971642482322729e+00 3.332470274717930e+00 4.866679252129041e+00 9.130198387050483e+03 + 130260 9.470679993183454e-01 -6.059282507156906e+00 -5.970030566175299e+00 3.397346378767563e+00 4.909844835577181e+00 9.125254392793679e+03 + 130280 9.115916060253344e-01 -6.021920827461239e+00 -6.006742320785550e+00 3.587840075765000e+00 4.674997409963122e+00 9.237751664008620e+03 + 130300 9.826911079357723e-01 -6.136374981652850e+00 -5.967887495065792e+00 2.984464477184970e+00 4.951945698522143e+00 9.118737888407073e+03 + 130320 9.413933053210759e-01 -6.076489319074319e+00 -6.004150031652622e+00 3.252367026750905e+00 4.667750409594841e+00 9.229782101381503e+03 + 130340 9.358362672922282e-01 -6.063213732096999e+00 -6.000063702931143e+00 3.331598659599098e+00 4.694215899504872e+00 9.217222123339934e+03 + 130360 9.202683130911380e-01 -6.029777433358518e+00 -5.970868036264891e+00 3.527192629727333e+00 4.865459504038681e+00 9.127836659636167e+03 + 130380 1.007434289069087e+00 -6.141531942369340e+00 -6.015672404605356e+00 2.902121885936533e+00 4.624826828477854e+00 9.265224295447328e+03 + 130400 9.610841965572609e-01 -6.055748746282560e+00 -5.987992894516507e+00 3.458148079893774e+00 4.847212665918621e+00 9.180230892413229e+03 + 130420 9.712142581419018e-01 -6.053999630078730e+00 -5.983516695311410e+00 3.420128726337561e+00 4.824852644970418e+00 9.166492570010927e+03 + 130440 8.914294441318441e-01 -5.917833730222050e+00 -6.012626566155738e+00 4.124695887786398e+00 4.580380754711209e+00 9.255845430501769e+03 + 130460 9.746777641571345e-01 -6.025970631301579e+00 -6.017984819290037e+00 3.538505855539825e+00 4.584361623910514e+00 9.272354104194324e+03 + 130480 9.554933727410769e-01 -5.987034396581089e+00 -6.039768711522166e+00 3.773455777968345e+00 4.470647180967817e+00 9.339527515018615e+03 + 130500 1.009959137325287e+00 -6.060990727859224e+00 -6.013587327288979e+00 3.359058424141346e+00 4.631256085868224e+00 9.258810393314587e+03 + 130520 9.298974331030029e-01 -5.935522818380198e+00 -6.028977878049615e+00 4.097710619651657e+00 4.561077204906124e+00 9.306200844730762e+03 + 130540 9.896155771267494e-01 -6.017766070810324e+00 -5.997970511058551e+00 3.602179310635658e+00 4.715848478083314e+00 9.210837812094398e+03 + 130560 1.063879928018026e+00 -6.120811555752455e+00 -5.988829426599659e+00 3.075477298613058e+00 4.833339108376896e+00 9.182806426970648e+03 + 130580 9.578590312585442e-01 -5.956442928587865e+00 -6.010886961579125e+00 3.948815708574311e+00 4.636189645951619e+00 9.250516146140999e+03 + 130600 9.739441242910462e-01 -5.973072805362641e+00 -6.035849441481784e+00 3.880881009944719e+00 4.520407850695554e+00 9.327425134101979e+03 + 130620 1.048864346095900e+00 -6.077673890480655e+00 -5.977135258139565e+00 3.307249515920778e+00 4.884557901126386e+00 9.147007687428682e+03 + 130640 9.375531545102268e-01 -5.904043950642779e+00 -6.003484146915490e+00 4.208719382000007e+00 4.637718386681465e+00 9.227751053033373e+03 + 130660 1.034946471911228e+00 -6.037881714897889e+00 -6.005444373408693e+00 3.524351024748786e+00 4.710611259242124e+00 9.233775091995743e+03 + 130680 9.980527736920107e-01 -5.973548436107194e+00 -6.015492585124742e+00 3.842910254094558e+00 4.602060459599718e+00 9.264674998671993e+03 + 130700 1.028196710792318e+00 -6.008327543449901e+00 -6.000216270880836e+00 3.641267957900877e+00 4.687844140207821e+00 9.217698524971920e+03 + 130720 1.000472493239456e+00 -5.957097399252117e+00 -5.992470716131067e+00 3.948427920654928e+00 4.745308861132900e+00 9.193945784968475e+03 + 130740 1.028938099898568e+00 -5.989575283487385e+00 -5.998982991710323e+00 3.712144080762183e+00 4.658123564307934e+00 9.213924038575715e+03 + 130760 1.022498028302934e+00 -5.973625808936009e+00 -5.970487614694260e+00 3.839725633422481e+00 4.857745630392595e+00 9.126650229371771e+03 + 130780 9.678498911483023e-01 -5.883692294812350e+00 -5.974707901027978e+00 4.295914099478324e+00 4.773288403968642e+00 9.139557636021002e+03 + 130800 1.055893623337957e+00 -6.002951444357945e+00 -5.996612883958681e+00 3.665229779310629e+00 4.701626774012256e+00 9.206637095838989e+03 + 130820 1.083105300658058e+00 -6.030172810975066e+00 -5.991095705151839e+00 3.498372706007542e+00 4.722759494807097e+00 9.189749086874102e+03 + 130840 9.930522249106003e-01 -5.885538104014326e+00 -6.012472668687282e+00 4.265764627075155e+00 4.536886713662646e+00 9.255387872958439e+03 + 130860 9.837088888554437e-01 -5.864683403278612e+00 -6.063964566549617e+00 4.432434001460917e+00 4.288130723298454e+00 9.414423665507786e+03 + 130880 1.015465813765257e+00 -5.908737858817327e+00 -6.038190531683166e+00 4.217017951591750e+00 4.473680671259716e+00 9.334633392943884e+03 + 130900 1.093378820823633e+00 -6.025616306331575e+00 -5.988783410465001e+00 3.583469388544033e+00 4.794969576482109e+00 9.182629574772362e+03 + 130920 9.844216271553589e-01 -5.870779829866249e+00 -6.012634728848759e+00 4.358465680169422e+00 4.543912898237179e+00 9.255855361041904e+03 + 130940 1.049766353035625e+00 -5.979760622077858e+00 -5.947197157564784e+00 3.882875203683592e+00 5.069859656097518e+00 9.055636036135560e+03 + 130960 1.034808536778568e+00 -5.974453884372552e+00 -5.997634473490846e+00 3.846096663090794e+00 4.712990133188976e+00 9.209765849884041e+03 + 130980 1.058571508920091e+00 -6.034454980228020e+00 -5.991423197730352e+00 3.544955052572833e+00 4.792050206821258e+00 9.190760146519862e+03 + 131000 9.729217140004026e-01 -5.937520976741134e+00 -6.068091635626637e+00 4.003432963641904e+00 4.253676034577194e+00 9.427263012983856e+03 + 131020 1.023117271640621e+00 -6.047900618823444e+00 -6.023523298410036e+00 3.434914323667209e+00 4.574892669859143e+00 9.289423045298492e+03 + 131040 9.792328030079827e-01 -6.017284379289269e+00 -6.026926058847527e+00 3.591996084157357e+00 4.536632068088749e+00 9.299882663117291e+03 + 131060 1.028063036809075e+00 -6.121693854656348e+00 -5.983900863720138e+00 3.033232045018208e+00 4.824460722370358e+00 9.167694330289994e+03 + 131080 9.784915469439992e-01 -6.075070998859776e+00 -5.993393248880324e+00 3.275358059997616e+00 4.744364339970590e+00 9.196799486556767e+03 + 131100 8.929855728145889e-01 -5.968905037673095e+00 -5.983164664511335e+00 3.892831067490689e+00 4.810950083515394e+00 9.165423659265716e+03 + 131120 9.390158082438451e-01 -6.047199449797296e+00 -5.979854739945525e+00 3.469332055524716e+00 4.856035801053755e+00 9.155303080128442e+03 + 131140 9.529250796158291e-01 -6.071186369016491e+00 -5.976791512373100e+00 3.304354348348292e+00 4.846384222751500e+00 9.145948430963761e+03 + 131160 9.628042162825089e-01 -6.084439843649562e+00 -5.952978825050783e+00 3.267995672998639e+00 5.022865185319712e+00 9.073269579074671e+03 + 131180 9.529225121940557e-01 -6.060763829946472e+00 -5.959541543510480e+00 3.334539859213369e+00 4.915773892027037e+00 9.093276760006544e+03 + 131200 9.843104700832480e-01 -6.091784959350332e+00 -5.933433055117296e+00 3.220791236076818e+00 5.130072375060895e+00 9.013840610252479e+03 + 131220 9.632823848209409e-01 -6.037856903994149e+00 -5.984121226546807e+00 3.479249372514864e+00 4.787807947986709e+00 9.168350657808873e+03 + 131240 1.003149601599338e+00 -6.069349974640456e+00 -5.947581458198631e+00 3.336874722842397e+00 5.036088387868378e+00 9.056837350599457e+03 + 131260 1.003882030734760e+00 -6.037010689502744e+00 -6.001101326580766e+00 3.525462472792474e+00 4.731659591646424e+00 9.220435011158090e+03 + 131280 1.011573596948397e+00 -6.016727133510457e+00 -6.031726160174792e+00 3.585877047928306e+00 4.499750315729825e+00 9.314684451544721e+03 + 131300 1.003517268057811e+00 -5.978475278454981e+00 -6.004379727327705e+00 3.835951791675412e+00 4.687204437547726e+00 9.230490125454924e+03 + 131320 1.024670644035960e+00 -5.988018049024664e+00 -5.978881997371198e+00 3.762795335035885e+00 4.815255957429509e+00 9.152337624715574e+03 + 131340 1.013711990584448e+00 -5.954577926499031e+00 -6.035890161482587e+00 3.903169574101386e+00 4.436262137798112e+00 9.327535822650003e+03 + 131360 1.027736378969403e+00 -5.966304505494363e+00 -6.030483259794224e+00 3.863999355027829e+00 4.495475016207898e+00 9.310863441606340e+03 + 131380 1.096662246956929e+00 -6.066370202480748e+00 -6.003530021955664e+00 3.294054089233345e+00 4.654892130294888e+00 9.227920485331419e+03 + 131400 1.002971500064141e+00 -5.929542413956620e+00 -6.052065801018373e+00 4.032331159122984e+00 4.328782910181526e+00 9.377558768115701e+03 + 131420 1.024252901945822e+00 -5.967334963738172e+00 -6.016513718779505e+00 3.890162338614638e+00 4.607770316779557e+00 9.267760171297110e+03 + 131440 9.552777418968104e-01 -5.870043585041251e+00 -6.034664707817273e+00 4.382179863938366e+00 4.436899901922034e+00 9.323758297068562e+03 + 131460 1.111093076941678e+00 -6.107199925980609e+00 -5.984324433964461e+00 3.103530814023912e+00 4.809100904101571e+00 9.169000551798281e+03 + 131480 1.034067381378517e+00 -6.002030817801160e+00 -6.026948078869804e+00 3.680074811773742e+00 4.536996042783896e+00 9.299966314376548e+03 + 131500 9.800802440599204e-01 -5.934208479089004e+00 -6.007206031127135e+00 4.068390366851407e+00 4.649227126713792e+00 9.239187526972961e+03 + 131520 9.904397121340484e-01 -5.961069445252014e+00 -6.021699258602359e+00 3.876805013153832e+00 4.528659242462859e+00 9.283791684599188e+03 + 131540 1.009320208691154e+00 -6.002319489631943e+00 -5.999227060342406e+00 3.674462336076394e+00 4.692219543608804e+00 9.214672691537919e+03 + 131560 9.942509269962964e-01 -5.992841053761710e+00 -5.966336333956363e+00 3.712945304523986e+00 4.865139507238423e+00 9.114004415441399e+03 + 131580 9.922053275991994e-01 -6.000434444788290e+00 -5.995532394467409e+00 3.678733182852928e+00 4.706881514385265e+00 9.203345883124173e+03 + 131600 9.932263045687070e-01 -6.013151342920659e+00 -5.987463116665161e+00 3.661385234279831e+00 4.808891004679062e+00 9.178602529660893e+03 + 131620 9.962850676794905e-01 -6.028378167334931e+00 -5.976142671296111e+00 3.556598190067735e+00 4.856542491739523e+00 9.143951231423700e+03 + 131640 9.892026251246759e-01 -6.026297067608541e+00 -5.987555243024403e+00 3.512244412028348e+00 4.734705964068448e+00 9.178891634993031e+03 + 131660 9.232309999023891e-01 -5.934829297567035e+00 -6.001256226481390e+00 4.039787889919560e+00 4.658354184559303e+00 9.220904008991245e+03 + 131680 9.758791956918986e-01 -6.019050206698671e+00 -6.006221712125369e+00 3.584775615656803e+00 4.658438816699818e+00 9.236177475569066e+03 + 131700 9.379765139869896e-01 -5.968728490081491e+00 -6.025465343664683e+00 3.870589257793169e+00 4.544797464518767e+00 9.295386008157093e+03 + 131720 1.068688699769764e+00 -6.166949710804097e+00 -5.986420234401045e+00 2.767759461580971e+00 4.804387651933485e+00 9.175432835358639e+03 + 131740 1.010672282084292e+00 -6.085201506505737e+00 -6.019034090828414e+00 3.251414644663130e+00 4.631358184856807e+00 9.275590098882094e+03 + 131760 9.672416606802616e-01 -6.027484325782861e+00 -6.010263357789781e+00 3.541324996198633e+00 4.640210459351079e+00 9.248593404961703e+03 + 131780 8.990563676294964e-01 -5.933764814130628e+00 -5.993892673009589e+00 4.046496905119414e+00 4.701233434680330e+00 9.198291125269139e+03 + 131800 1.038125876916316e+00 -6.142920579136632e+00 -5.969092155092786e+00 2.906201421942535e+00 4.904351132663981e+00 9.122428041154088e+03 + 131820 9.336075908135112e-01 -5.986167483097782e+00 -5.988673618617832e+00 3.800672008963500e+00 4.786281390984155e+00 9.182334222898880e+03 + 131840 9.878151102638031e-01 -6.061804369842512e+00 -5.950797403524747e+00 3.393677135780793e+00 5.031096314649919e+00 9.066640535965522e+03 + 131860 9.865914064252586e-01 -6.050376180636450e+00 -5.962026668483629e+00 3.480060342562836e+00 4.987376913387152e+00 9.100823836790238e+03 + 131880 9.445672601381528e-01 -5.972743128378099e+00 -5.976238986286807e+00 3.864576965926697e+00 4.844503208832627e+00 9.144187179621895e+03 + 131900 1.004275211599622e+00 -6.041527336471732e+00 -5.983193338018093e+00 3.504773914341240e+00 4.839736760619123e+00 9.165484007019277e+03 + 131920 9.397166042841005e-01 -5.920827738968568e+00 -6.011634026479029e+00 4.111252523058181e+00 4.589828767945540e+00 9.252783576783117e+03 + 131940 1.014172009258640e+00 -6.001714591919812e+00 -6.004351778834083e+00 3.734970459769611e+00 4.719827324404513e+00 9.230404506783309e+03 + 131960 1.040292781208354e+00 -6.009262734987058e+00 -6.030985741784840e+00 3.628496766306086e+00 4.503759899648781e+00 9.312437086212592e+03 + 131980 1.091325419117280e+00 -6.061280453268994e+00 -5.993701127256977e+00 3.407655214320084e+00 4.795706162147988e+00 9.197734834099634e+03 + 132000 1.065491629368890e+00 -6.006357849481001e+00 -5.988849929763671e+00 3.677192905432705e+00 4.777726089791430e+00 9.182830727780081e+03 + 132020 1.097982224709716e+00 -6.041110335532081e+00 -6.003855494576903e+00 3.442345939596186e+00 4.656269001528827e+00 9.228886558694063e+03 + 132040 1.042641291503157e+00 -5.950442739269262e+00 -6.020862972557248e+00 3.932588006154520e+00 4.528224129119018e+00 9.281198642108719e+03 + 132060 9.670522844470950e-01 -5.834790289531083e+00 -6.010805359870869e+00 4.606704417277696e+00 4.595998645142537e+00 9.250233854253935e+03 + 132080 1.031694068182383e+00 -5.927710078348651e+00 -6.053375662990991e+00 4.075868358367709e+00 4.354277124665022e+00 9.381627841401547e+03 + 132100 1.085594302868293e+00 -6.011336903759373e+00 -6.044093479945431e+00 3.616895930739825e+00 4.428802601215695e+00 9.352913991088779e+03 + 132120 1.004034373578224e+00 -5.904955667835869e+00 -6.038635803351039e+00 4.231354169923298e+00 4.463742144861082e+00 9.336044575848769e+03 + 132140 1.011996683522389e+00 -5.941020581627084e+00 -6.045269578689521e+00 3.936270175725488e+00 4.337656302112824e+00 9.356561771851471e+03 + 132160 1.028914546577905e+00 -5.999003166372002e+00 -6.038518008307820e+00 3.687107321548306e+00 4.460206984250814e+00 9.335667176930072e+03 + 132180 1.019849808999467e+00 -6.026534625272331e+00 -6.022051008064526e+00 3.502165410843935e+00 4.527911034688666e+00 9.284880485476251e+03 + 132200 1.012623171946348e+00 -6.064271342466329e+00 -5.970147196136766e+00 3.395855943493614e+00 4.936331357382537e+00 9.125633440172893e+03 + 132220 9.289310653323588e-01 -5.977806489100574e+00 -5.981984973218800e+00 3.767703268759718e+00 4.743709766334542e+00 9.161829742829306e+03 + 132240 9.788010731458674e-01 -6.078465725720863e+00 -5.974930509937734e+00 3.298154279157154e+00 4.892669510206739e+00 9.140250162495971e+03 + 132260 9.056257970189709e-01 -5.987363499975785e+00 -6.013080522961729e+00 3.721027244242376e+00 4.573356118560641e+00 9.257247613947013e+03 + 132280 9.687206735547004e-01 -6.089846880600771e+00 -5.949337209370480e+00 3.200616543378893e+00 5.007444819384570e+00 9.062177757202646e+03 + 132300 9.837147614891352e-01 -6.113326970592984e+00 -5.927305740322531e+00 3.078358691937990e+00 5.146521382843280e+00 8.995247236102583e+03 + 132320 9.732155548080043e-01 -6.093108531640963e+00 -5.955384602501708e+00 3.204487378155700e+00 4.995319491982460e+00 9.080591460390004e+03 + 132340 9.259666563576376e-01 -6.014169397835060e+00 -5.994024838300223e+00 3.560688462965369e+00 4.676361641174916e+00 9.198708811588360e+03 + 132360 9.468459342125349e-01 -6.032069346177106e+00 -5.962392780363214e+00 3.484453197271210e+00 4.884546820588293e+00 9.101954768722744e+03 + 132380 9.931548021200675e-01 -6.081912210435366e+00 -5.974958340296141e+00 3.263662616668333e+00 4.877808290065678e+00 9.140331218752799e+03 + 132400 9.978232879279847e-01 -6.069466686281583e+00 -5.990065413504260e+00 3.293888703338349e+00 4.749823098932993e+00 9.186611281373320e+03 + 132420 9.755819342792181e-01 -6.020240606927674e+00 -5.991446720606729e+00 3.624056526153888e+00 4.789395477248263e+00 9.190800448748456e+03 + 132440 9.876318718610894e-01 -6.020997067034952e+00 -5.974584813014150e+00 3.539831400726244e+00 4.806337745586788e+00 9.139191490546593e+03 + 132460 9.619286599317186e-01 -5.966008975138416e+00 -5.957216133789147e+00 3.920706737639317e+00 4.971196593354620e+00 9.086167989934866e+03 + 132480 9.684243621514940e-01 -5.959933992194438e+00 -5.988866182920771e+00 3.921830565043568e+00 4.755697448650919e+00 9.182832211999927e+03 + 132500 9.968536327579650e-01 -5.986071645493661e+00 -5.959517372668894e+00 3.816382722590130e+00 4.968861466410383e+00 9.093165898632915e+03 + 132520 1.073760765343268e+00 -6.085755324841104e+00 -5.957761940218028e+00 3.240893678151458e+00 4.975851499569416e+00 9.087804172344389e+03 + 132540 9.503138910657258e-01 -5.890535030509758e+00 -6.016768520279302e+00 4.234925515942152e+00 4.510073283116022e+00 9.268591851678852e+03 + 132560 1.061598141578479e+00 -6.045118774323414e+00 -5.997917878656546e+00 3.462602953580725e+00 4.733637800814882e+00 9.210665034399417e+03 + 132580 1.047073050887451e+00 -6.019174509706593e+00 -6.049116625835873e+00 3.618445616652516e+00 4.446513352310697e+00 9.368457879060266e+03 + 132600 1.012329356064740e+00 -5.967912076320514e+00 -6.044644954614967e+00 3.825554684552512e+00 4.384942623011230e+00 9.354624718448758e+03 + 132620 1.074335375212432e+00 -6.064133231423622e+00 -5.982201753007153e+00 3.412075707702636e+00 4.882538935625304e+00 9.162491119385550e+03 + 132640 1.000683350686506e+00 -5.961894101005387e+00 -6.027278708396974e+00 3.826534434304731e+00 4.451085900426946e+00 9.301002372879384e+03 + 132660 9.952222537251562e-01 -5.960874785455147e+00 -5.976199833273202e+00 3.951452786444573e+00 4.863453990329815e+00 9.144114084491806e+03 + 132680 9.685060113734959e-01 -5.926333978142932e+00 -6.014116595834272e+00 4.059144302285968e+00 4.555082927186105e+00 9.260431053259235e+03 + 132700 1.013015892019874e+00 -5.997578356718474e+00 -6.016209828900536e+00 3.687652617482683e+00 4.580667821002285e+00 9.266901428351002e+03 + 132720 1.017748377019775e+00 -6.010737734397365e+00 -5.999686875342457e+00 3.664312227496306e+00 4.727767970304503e+00 9.216094041071743e+03 + 132740 1.046446692403036e+00 -6.060388098956939e+00 -5.993540975613866e+00 3.323617599800807e+00 4.707464126595641e+00 9.197245332741266e+03 + 132760 1.045636680786479e+00 -6.065083308789472e+00 -5.998838682304964e+00 3.316791909646820e+00 4.697178806243683e+00 9.213499532439931e+03 + 132780 9.910110354007096e-01 -5.989919203249939e+00 -6.037265830415930e+00 3.723955442007225e+00 4.452083781953228e+00 9.331818695346989e+03 + 132800 1.016887882463320e+00 -6.036375968303036e+00 -5.997676989985738e+00 3.467906624911351e+00 4.690122147056814e+00 9.209922307614843e+03 + 132820 9.135835618522420e-01 -5.889363979045744e+00 -6.027805036475682e+00 4.245488445165089e+00 4.450538469717989e+00 9.302587896450643e+03 + 132840 9.963030995598791e-01 -6.015078879046035e+00 -5.986842951038905e+00 3.593917101422632e+00 4.756052169535311e+00 9.176697264218750e+03 + 132860 9.357127828952373e-01 -5.924831562705464e+00 -5.998210431183720e+00 4.084999963413543e+00 4.663647145268200e+00 9.211532445087132e+03 + 132880 9.728254357506572e-01 -5.977886351611906e+00 -5.987861116234787e+00 3.849915674684055e+00 4.792639032629637e+00 9.179817425617102e+03 + 132900 1.010979254693925e+00 -6.032296229543508e+00 -6.018828389152844e+00 3.519305315373654e+00 4.596639739038409e+00 9.274942297706419e+03 + 132920 1.041289677381281e+00 -6.076095047557565e+00 -5.968174778661417e+00 3.300743427986961e+00 4.920438312596279e+00 9.119590342137746e+03 + 132940 9.728509201570851e-01 -5.972934293654172e+00 -6.025700450918322e+00 3.787877109338278e+00 4.484885668791089e+00 9.296115284521691e+03 + 132960 1.042032012706514e+00 -6.075207414533070e+00 -5.983115162766888e+00 3.298392140211113e+00 4.827200101082434e+00 9.165296331132051e+03 + 132980 9.811635603611188e-01 -5.985174268897868e+00 -5.996712030767289e+00 3.790222215670905e+00 4.723970601553814e+00 9.206939770255321e+03 + 133000 1.021611416103556e+00 -6.043127404011926e+00 -6.000875772150067e+00 3.472732417349893e+00 4.715347825919585e+00 9.219744608200876e+03 + 133020 9.614238177046439e-01 -5.952072365826485e+00 -6.015943679661754e+00 3.974120946377314e+00 4.607361978281325e+00 9.266063132773794e+03 + 133040 9.844347216610244e-01 -5.983949154266593e+00 -6.005933623532785e+00 3.761649757279128e+00 4.635411532667028e+00 9.235266744773096e+03 + 133060 1.022024253025465e+00 -6.036225515218599e+00 -5.987645007417905e+00 3.576280397605971e+00 4.855237191206844e+00 9.179146135739655e+03 + 133080 9.944918664090714e-01 -5.992962742917793e+00 -6.002547765177829e+00 3.756715514431574e+00 4.701676833337051e+00 9.224868867186875e+03 + 133100 1.000072931153555e+00 -5.997791882617317e+00 -5.995945400943048e+00 3.722657060183177e+00 4.733259843698946e+00 9.204621778787463e+03 + 133120 9.880038362072485e-01 -5.975057693731678e+00 -5.997654064574769e+00 3.826186152413892e+00 4.696434294255772e+00 9.209845558612440e+03 + 133140 1.007296367605285e+00 -5.998446503964416e+00 -5.992849022749831e+00 3.749199550586853e+00 4.781341153928421e+00 9.195096269403031e+03 + 133160 1.022312113888329e+00 -6.012678510309021e+00 -6.033530965880084e+00 3.675002880202512e+00 4.555264853406396e+00 9.320236927074082e+03 + 133180 9.755465692595282e-01 -5.936087632264056e+00 -6.059905395981245e+00 4.033154525675057e+00 4.322173765673947e+00 9.401864788991856e+03 + 133200 1.010484279731543e+00 -5.983046209162685e+00 -6.011352755255274e+00 3.824557649833385e+00 4.662017081745891e+00 9.251953365905067e+03 + 133220 1.068534883137551e+00 -6.063534430613060e+00 -5.983183235217634e+00 3.452964643342029e+00 4.914353641609862e+00 9.165496817305606e+03 + 133240 9.756001788886215e-01 -5.920824373854352e+00 -6.038898860642904e+00 4.178707734149523e+00 4.500705759041874e+00 9.336820224489678e+03 + 133260 1.018398722836955e+00 -5.978350310281646e+00 -6.031372011106472e+00 3.811479864132397e+00 4.507021052914562e+00 9.313597523188659e+03 + 133280 1.082010886613598e+00 -6.066938973140800e+00 -5.989770017521053e+00 3.384313447468956e+00 4.827429532494830e+00 9.185679887215731e+03 + 133300 1.043756066800481e+00 -6.004157574887813e+00 -6.032215683075380e+00 3.676106735840803e+00 4.514992736649584e+00 9.316205789113486e+03 + 133320 9.988357980798949e-01 -5.939456200701182e+00 -6.028598252945498e+00 4.051652970772368e+00 4.539785512097500e+00 9.305054359362692e+03 + 133340 1.034020073990885e+00 -5.998098615566682e+00 -5.993577173514683e+00 3.750706367783864e+00 4.776669187737340e+00 9.197333115433823e+03 + 133360 9.979772258468070e-01 -5.951276845109858e+00 -6.005027316906256e+00 3.995683337825139e+00 4.687039810911591e+00 9.232480132862082e+03 + 133380 1.092090430819119e+00 -6.100815788967999e+00 -6.004321175711237e+00 3.169559669594496e+00 4.723646671407965e+00 9.230327824027623e+03 + 133400 1.045444614916810e+00 -6.049375438739567e+00 -5.973062956596912e+00 3.434935946066087e+00 4.873134027847652e+00 9.134548708699273e+03 + 133420 1.006400882420135e+00 -6.010395030561625e+00 -5.982295707111049e+00 3.740578819125603e+00 4.901929482735061e+00 9.162715864367174e+03 + 133440 1.006301222965949e+00 -6.030538245893702e+00 -5.980323030988106e+00 3.588832781443134e+00 4.877176316210459e+00 9.156735872814821e+03 + 133460 9.744693481587791e-01 -6.004143449749841e+00 -5.983178983694544e+00 3.755389363523106e+00 4.875770571853257e+00 9.165474057823581e+03 + 133480 9.996493155797510e-01 -6.062088974312039e+00 -5.962109271571446e+00 3.430686766960992e+00 5.004785691906475e+00 9.101108286649629e+03 + 133500 9.392357459343811e-01 -5.990627513504789e+00 -6.025356018297121e+00 3.802708998287035e+00 4.603292549550720e+00 9.295046262874081e+03 + 133520 9.885394959847975e-01 -6.081035520198896e+00 -5.980499073663968e+00 3.332587027680298e+00 4.909882861648676e+00 9.157292879561677e+03 + 133540 9.390579377029294e-01 -6.021898092908790e+00 -6.004083173440559e+00 3.526649485632805e+00 4.628945510069267e+00 9.229587862271745e+03 + 133560 9.568118876994509e-01 -6.057819627929410e+00 -6.008575191448968e+00 3.355825347765805e+00 4.638594522588418e+00 9.243405153077834e+03 + 133580 9.422198224381588e-01 -6.042500190932707e+00 -5.990855018018841e+00 3.550530026956140e+00 4.847084601892239e+00 9.189007222907296e+03 + 133600 9.866663318926765e-01 -6.110453859554553e+00 -6.015472110183592e+00 3.079207693257113e+00 4.624607596523379e+00 9.264618360085222e+03 + 133620 8.758316124251760e-01 -5.944627056473825e+00 -6.021659807009289e+00 4.081627976549974e+00 4.639294002195723e+00 9.283659284282045e+03 + 133640 1.010333598767250e+00 -6.135323771416097e+00 -5.970362842315738e+00 3.034659971061434e+00 4.981891153576972e+00 9.126292925254187e+03 + 133660 1.023747679642860e+00 -6.134972516802505e+00 -6.008692120771023e+00 2.960601719166342e+00 4.685723295007245e+00 9.243765895507302e+03 + 133680 9.675502897781302e-01 -6.024620544959927e+00 -6.011093709865127e+00 3.579170808346773e+00 4.656843988732079e+00 9.251153603818173e+03 + 133700 1.022924529241480e+00 -6.069758163752358e+00 -5.986630012174479e+00 3.359118090977419e+00 4.836452801377478e+00 9.176040616420030e+03 + 133720 9.693445031740692e-01 -5.947312740090167e+00 -5.987320557307003e+00 4.002433028080965e+00 4.772701950432188e+00 9.178168048289728e+03 + 133740 1.014906938909986e+00 -5.969152934584564e+00 -5.991404543873026e+00 3.861593077542620e+00 4.733820893582858e+00 9.190677206076682e+03 + 133760 1.034525676877319e+00 -5.959200510914160e+00 -5.997432855127107e+00 3.973334536627337e+00 4.753798499720453e+00 9.209150405367393e+03 + 133780 1.047551927982597e+00 -5.950047975767287e+00 -5.992221320504731e+00 4.010408989760336e+00 4.768243117973928e+00 9.193165424498096e+03 + 133800 1.047382632163678e+00 -5.930504006402900e+00 -6.077838660065508e+00 4.035907596185502e+00 4.189889214890838e+00 9.457526639036023e+03 + 133820 1.067592633276134e+00 -5.953493670025167e+00 -6.006175135294981e+00 3.999513421773573e+00 4.697008295763895e+00 9.235999133222560e+03 + 133840 1.024598464676316e+00 -5.890901253678570e+00 -6.046346266758817e+00 4.266493200531729e+00 4.373903880386920e+00 9.359821077611796e+03 + 133860 1.089893670702421e+00 -5.994562544421340e+00 -5.979622404804341e+00 3.746664932003067e+00 4.832453525663009e+00 9.154594674828333e+03 + 133880 1.028452736194007e+00 -5.915484211146172e+00 -5.990627659439177e+00 4.144529804704362e+00 4.713044496194885e+00 9.188292095955674e+03 + 133900 1.019130713260869e+00 -5.916355080529220e+00 -6.004676849145951e+00 4.132235759298339e+00 4.625078496151550e+00 9.231388951708464e+03 + 133920 1.069731765673821e+00 -6.008009702309238e+00 -5.996602401607418e+00 3.736181900654938e+00 4.801684386558867e+00 9.206612787295093e+03 + 133940 1.001965224132118e+00 -5.929672060925872e+00 -6.008156038396509e+00 4.088965533100654e+00 4.638298389107995e+00 9.242119761074562e+03 + 133960 1.027490143177410e+00 -5.989894042185160e+00 -6.013890739351978e+00 3.742881808825680e+00 4.605089060216928e+00 9.259715503503076e+03 + 133980 1.067912451512028e+00 -6.073965761799312e+00 -5.975350895065555e+00 3.304502155789173e+00 4.870763981175713e+00 9.141540601346815e+03 + 134000 9.693855976090501e-01 -5.951789062086675e+00 -6.005529549819242e+00 3.978268212404368e+00 4.669682015530370e+00 9.234029073231279e+03 + 134020 9.850179330002994e-01 -5.993880461575698e+00 -6.014831733071897e+00 3.724366163056486e+00 4.604060719926522e+00 9.262602551839103e+03 + 134040 1.022316947304968e+00 -6.065203377117165e+00 -5.998385655778762e+00 3.377530052709362e+00 4.761207748643431e+00 9.212102658197040e+03 + 134060 9.685420893611494e-01 -6.000055978357385e+00 -5.991315750313665e+00 3.672820886631006e+00 4.723008628603967e+00 9.190419090504687e+03 + 134080 9.675016255973119e-01 -6.006777841202176e+00 -5.985332737273795e+00 3.645898136828800e+00 4.769039242204670e+00 9.172091573425259e+03 + 134100 9.987927667428893e-01 -6.057315661192904e+00 -6.006577417620312e+00 3.364101355145591e+00 4.655448201457235e+00 9.237243426216733e+03 + 134120 9.891238694806389e-01 -6.045044431508938e+00 -5.963969130624257e+00 3.470326461442858e+00 4.935873385484958e+00 9.106775270434056e+03 + 134140 1.009325133210154e+00 -6.073557213045891e+00 -5.977243092935130e+00 3.321817926304601e+00 4.874868508542507e+00 9.147330760374400e+03 + 134160 9.900317657755426e-01 -6.042056738018474e+00 -5.962694825111071e+00 3.486470097737828e+00 4.942178482868464e+00 9.102897099848773e+03 + 134180 1.004366147770202e+00 -6.058984551196311e+00 -5.988999906650637e+00 3.393898833703850e+00 4.795761492773851e+00 9.183309098727465e+03 + 134200 9.942767605354268e-01 -6.038701791099617e+00 -5.984676269694502e+00 3.468954368724030e+00 4.779177273054621e+00 9.170048861755786e+03 + 134220 1.021518048426868e+00 -6.072821963655356e+00 -5.960891510292544e+00 3.300673376086620e+00 4.943395360477563e+00 9.097376845939089e+03 + 134240 1.019161672622134e+00 -6.062242265885670e+00 -5.995344438864782e+00 3.367724596338359e+00 4.751862271497576e+00 9.202752845324329e+03 + 134260 9.610888330709214e-01 -5.971615402964286e+00 -5.965934931912919e+00 3.905206002112065e+00 4.937824145939070e+00 9.112744266560085e+03 + 134280 1.018666246237368e+00 -6.048582836219751e+00 -5.964752338175651e+00 3.493342728011412e+00 4.974710420508282e+00 9.109161697702893e+03 + 134300 1.040997337240444e+00 -6.073201000975438e+00 -6.004422058034249e+00 3.305617302833265e+00 4.700556636708588e+00 9.230638335123154e+03 + 134320 9.479888132480758e-01 -5.928743289853869e+00 -6.023495900197874e+00 4.097735703901222e+00 4.553651552386883e+00 9.289308953045289e+03 + 134340 1.005909444483253e+00 -6.007448915618292e+00 -5.981607238275156e+00 3.701910293942968e+00 4.850297204233896e+00 9.160645192752936e+03 + 134360 9.971478318097469e-01 -5.987602592421088e+00 -5.990589133667696e+00 3.770458504570193e+00 4.753309322566405e+00 9.188166196479338e+03 + 134380 9.758011944731900e-01 -5.947960174813698e+00 -6.047862549175901e+00 3.879266638289443e+00 4.305611744859206e+00 9.364546439025322e+03 + 134400 9.607141446627846e-01 -5.918174955671712e+00 -6.038808408901946e+00 4.113751420653486e+00 4.421055464238924e+00 9.336560012845373e+03 + 134420 9.995263430993162e-01 -5.967554043913330e+00 -6.014060722201032e+00 3.863116795134810e+00 4.596068251521615e+00 9.260270346862137e+03 + 134440 1.025596552570541e+00 -5.999110019148148e+00 -5.984945890844894e+00 3.681179126760616e+00 4.762511743369672e+00 9.170897205268937e+03 + 134460 1.009192076701818e+00 -5.967819416353110e+00 -5.991135487223989e+00 3.840461473434199e+00 4.706576986343307e+00 9.189843261634976e+03 + 134480 1.018353642119958e+00 -5.974081819353414e+00 -5.988797655040019e+00 3.825913812738619e+00 4.741413206957921e+00 9.182662543663386e+03 + 134500 1.038082731226579e+00 -5.992792976043125e+00 -5.979571995722969e+00 3.661661158626714e+00 4.737578073565146e+00 9.154429665937147e+03 + 134520 1.039148482053148e+00 -5.977997944494911e+00 -6.009690746063496e+00 3.819613332727813e+00 4.637628361675802e+00 9.246781316351502e+03 + 134540 1.054294598957380e+00 -5.982806259994755e+00 -5.964349953773574e+00 3.795647079058558e+00 4.901626045484734e+00 9.107917711286569e+03 + 134560 1.031685957251909e+00 -5.927442796213885e+00 -5.997511897161767e+00 4.087619037228540e+00 4.685271416427473e+00 9.209379552612036e+03 + 134580 1.050846355528312e+00 -5.933447240556674e+00 -5.956285469426932e+00 4.054840936648051e+00 4.923700292270538e+00 9.083310093397437e+03 + 134600 9.868172858354941e-01 -5.815896147771146e+00 -6.002506264824526e+00 4.672323624231315e+00 4.600779454288520e+00 9.224730547199986e+03 + 134620 1.065319446531914e+00 -5.912389848494087e+00 -6.025652131942617e+00 4.137865906443736e+00 4.487496347600556e+00 9.295958589057031e+03 + 134640 1.165298504725571e+00 -6.044671046841195e+00 -5.999911672135897e+00 3.408936962013492e+00 4.665952218062165e+00 9.216784101410321e+03 + 134660 1.056661575111701e+00 -5.879890672372785e+00 -6.026681419684789e+00 4.273435621857557e+00 4.430540434997297e+00 9.299117143105021e+03 + 134680 1.059135195929530e+00 -5.888783646542569e+00 -5.993277319534114e+00 4.298004629299840e+00 4.697985788638758e+00 9.196421204960492e+03 + 134700 1.105262874123701e+00 -5.972455513418467e+00 -6.029491930187564e+00 3.815172638291730e+00 4.487660706846609e+00 9.307825196991465e+03 + 134720 1.029460959793053e+00 -5.886940553401670e+00 -6.034197054338677e+00 4.274683945490054e+00 4.429114329239887e+00 9.322312014995603e+03 + 134740 1.047640861917031e+00 -5.950784742812106e+00 -5.994652742285909e+00 3.947651232741168e+00 4.695754391211606e+00 9.200615151631762e+03 + 134760 1.085622329303730e+00 -6.046396782389277e+00 -5.951603110781282e+00 3.424977434311804e+00 4.969297365958179e+00 9.069063769672222e+03 + 134780 1.007791660956589e+00 -5.968761765576872e+00 -5.970796670881665e+00 3.925504198953459e+00 4.913819457792757e+00 9.127603499507843e+03 + 134800 9.960253549706910e-01 -5.982698544896148e+00 -6.003733975759372e+00 3.785179708127253e+00 4.664391008888219e+00 9.228523492853761e+03 + 134820 1.031191351411042e+00 -6.062949003318506e+00 -6.005603398817518e+00 3.407445278128759e+00 4.736732613377044e+00 9.234230016667179e+03 + 134840 9.631474975457992e-01 -5.984337695897054e+00 -6.027757915251029e+00 3.846213007832618e+00 4.596887389044864e+00 9.302457301578139e+03 + 134860 1.016100817482414e+00 -6.081246143451756e+00 -5.997187779380221e+00 3.291232671993211e+00 4.773908806481759e+00 9.208428020006540e+03 + 134880 1.001620654917322e+00 -6.074394260780251e+00 -5.988475172941440e+00 3.299860991771201e+00 4.793221690077523e+00 9.181719622016404e+03 + 134900 9.452512744020880e-01 -6.000575100119785e+00 -5.983466728798295e+00 3.715976794340584e+00 4.814215709980489e+00 9.166365370623625e+03 + 134920 1.035858085596521e+00 -6.139903652990537e+00 -5.939406451799563e+00 3.000548275708071e+00 5.151834231788252e+00 9.031966824771089e+03 + 134940 9.806801799775273e-01 -6.056923951259271e+00 -5.982898748014649e+00 3.395202511415492e+00 4.820266683809291e+00 9.164638377278070e+03 + 134960 9.706567946439090e-01 -6.037985796318637e+00 -5.961965732688894e+00 3.494130133908828e+00 4.930649103337642e+00 9.100658891363943e+03 + 134980 1.026500069257789e+00 -6.113504785810966e+00 -5.963035551411349e+00 3.086165500970229e+00 4.950183129931600e+00 9.103922118072915e+03 + 135000 9.441283902600983e-01 -5.980527992136636e+00 -6.032063927690107e+00 3.793453320629696e+00 4.497526003521418e+00 9.315732016160026e+03 + 135020 9.699100370285354e-01 -6.004797800914381e+00 -6.003701178532358e+00 3.685534390018776e+00 4.691831365438119e+00 9.228389407549601e+03 + 135040 1.028570529851006e+00 -6.072643387283338e+00 -6.001737866183896e+00 3.300236171042739e+00 4.707386645789661e+00 9.222378724136333e+03 + 135060 9.511553005823629e-01 -5.935978222331883e+00 -6.032103461830918e+00 3.973370130034900e+00 4.421404129498708e+00 9.315868899307596e+03 + 135080 9.786968550244616e-01 -5.950054624323963e+00 -6.007187707149327e+00 3.921018095882695e+00 4.592951092983462e+00 9.239089218903740e+03 + 135100 1.065759519242730e+00 -6.045741456757829e+00 -5.983953661229345e+00 3.422955427952078e+00 4.777750511507096e+00 9.167864200979138e+03 + 135120 9.873612230474046e-01 -5.892611808302609e+00 -6.008775799516830e+00 4.246267843491736e+00 4.579236229620140e+00 9.243977444242879e+03 + 135140 9.943683144454598e-01 -5.863648102501340e+00 -5.989268644040829e+00 4.454361338075440e+00 4.733028748839721e+00 9.184106023196482e+03 + 135160 1.052177033054590e+00 -5.905560402170901e+00 -6.017199082653247e+00 4.128131152204877e+00 4.487084572845274e+00 9.269941740021002e+03 + 135180 1.112511364232299e+00 -5.955090173022720e+00 -6.065720301258491e+00 3.914548631752203e+00 4.279293315465390e+00 9.419921521966677e+03 + 135200 1.118199811178228e+00 -5.941498463680056e+00 -6.016107444912985e+00 3.998595513854009e+00 4.570179197912005e+00 9.266565141251320e+03 + 135220 1.082082846107906e+00 -5.880305315426551e+00 -6.035921588727494e+00 4.290363606121955e+00 4.396790883287475e+00 9.327649658784549e+03 + 135240 1.144026176979042e+00 -5.976263702709836e+00 -6.024694337569596e+00 3.803687557046655e+00 4.525591357065392e+00 9.293001546020940e+03 + 135260 1.016573477156018e+00 -5.802309068600850e+00 -6.017072038330365e+00 4.776696594798352e+00 4.543494388149321e+00 9.269514108850843e+03 + 135280 1.018464550294152e+00 -5.822165013882079e+00 -6.029245122615507e+00 4.701807362572509e+00 4.512721332681905e+00 9.307006965628820e+03 + 135300 1.078683951858797e+00 -5.929136331625910e+00 -6.036984237087646e+00 4.112693306759055e+00 4.493413944188337e+00 9.330897796232546e+03 + 135320 1.102503338278025e+00 -5.984685412995852e+00 -6.018822574090304e+00 3.767833241336247e+00 4.571812379623298e+00 9.274940708316939e+03 + 135340 1.000381840260648e+00 -5.853480491373474e+00 -6.115997669310183e+00 4.463011276990899e+00 3.955597016876324e+00 9.576558676097997e+03 + 135360 1.036288556508216e+00 -5.927288094729210e+00 -6.039756766939353e+00 4.080553818717797e+00 4.434741298416381e+00 9.339508052467345e+03 + 135380 1.008885702006785e+00 -5.904188662354951e+00 -6.049724396166170e+00 4.118826313818513e+00 4.283137608692473e+00 9.370333197481761e+03 + 135400 1.098850966616866e+00 -6.055269495244323e+00 -5.971049090710268e+00 3.412930332299593e+00 4.896536928199613e+00 9.128370050946889e+03 + 135420 1.012268195559939e+00 -5.944048547938035e+00 -6.019939863975795e+00 3.977758430077702e+00 4.541978749245684e+00 9.278363559132378e+03 + 135440 1.039086573435671e+00 -6.003820155753894e+00 -6.019217687719358e+00 3.680039136395698e+00 4.591624125089632e+00 9.276145469640014e+03 + 135460 9.915039857539619e-01 -5.955711032291807e+00 -6.021888641135829e+00 3.942906216358691e+00 4.562904145424445e+00 9.284372031514735e+03 + 135480 1.012653147205272e+00 -6.009281084948046e+00 -6.031936761153135e+00 3.629216470479775e+00 4.499124071755592e+00 9.315345951659900e+03 + 135500 9.790247544170458e-01 -5.980493464703635e+00 -6.033648457104173e+00 3.791452731743013e+00 4.486228539670636e+00 9.320640111860293e+03 + 135520 1.010916748225532e+00 -6.047868083113204e+00 -5.999066124609559e+00 3.477255838361529e+00 4.757484236168128e+00 9.214180743651013e+03 + 135540 9.365665324388841e-01 -5.957258474512021e+00 -6.044225159663116e+00 3.918145974132976e+00 4.418769809944358e+00 9.353317062263635e+03 + 135560 9.693315292775547e-01 -6.024462184572679e+00 -5.993521650430470e+00 3.563501171764242e+00 4.741166506840991e+00 9.197165381959639e+03 + 135580 9.765809358310944e-01 -6.047971207562903e+00 -5.990114005949865e+00 3.446595496048858e+00 4.778820501083938e+00 9.186735857560681e+03 + 135600 9.756597860699231e-01 -6.057220907372679e+00 -6.021319687129094e+00 3.361019684835315e+00 4.567170047169858e+00 9.282621401419761e+03 + 135620 9.670370181049692e-01 -6.053333161925959e+00 -5.964614562776795e+00 3.422320441254473e+00 4.931756366727821e+00 9.108742352261819e+03 + 135640 9.399305302177708e-01 -6.017128357251917e+00 -5.939335424018664e+00 3.648372712114222e+00 5.095071773157068e+00 9.031742620538071e+03 + 135660 9.698250323518357e-01 -6.058391754585021e+00 -5.935862784866839e+00 3.425009361351492e+00 5.128589666770072e+00 9.021191237886973e+03 + 135680 9.833197398999090e-01 -6.068501608080950e+00 -5.967825743087045e+00 3.322705944823363e+00 4.900802341158123e+00 9.118537588040628e+03 + 135700 9.697748506479794e-01 -6.029664261863756e+00 -5.972275329576894e+00 3.548565837645918e+00 4.878101967745653e+00 9.132151829336684e+03 + 135720 9.947047555983253e-01 -6.039957343609053e+00 -5.990938256300926e+00 3.516689165776619e+00 4.798164350779131e+00 9.189233843014656e+03 + 135740 9.698472589285689e-01 -5.967902484689058e+00 -5.993434706796222e+00 3.887732568236027e+00 4.741122597798088e+00 9.196908758910497e+03 + 135760 9.756602916013396e-01 -5.932776782742335e+00 -6.005688425508307e+00 4.011272950905856e+00 4.592603015103397e+00 9.234502236335253e+03 + 135780 1.058376787479655e+00 -6.006723029622833e+00 -5.964605190247257e+00 3.721560020129755e+00 4.963407171538896e+00 9.108721712377755e+03 + 135800 1.054884865080725e+00 -5.959966577596602e+00 -6.049179584955121e+00 3.872290064920249e+00 4.360015170999358e+00 9.368615350093904e+03 + 135820 1.131695902005475e+00 -6.046891975041634e+00 -6.012002662872479e+00 3.429582244673742e+00 4.629922074252640e+00 9.253933026855324e+03 + 135840 1.026233991138003e+00 -5.877476038899651e+00 -6.004968319904576e+00 4.350833547327445e+00 4.618753140430443e+00 9.232303994951715e+03 + 135860 1.080899336777158e+00 -5.953675157549505e+00 -5.979208715582567e+00 3.936517614843690e+00 4.789899973312506e+00 9.153329870916816e+03 + 135880 1.115068463555549e+00 -6.007393651003335e+00 -5.942931160761962e+00 3.699596641466969e+00 5.069750235971062e+00 9.042677861279537e+03 + 135900 1.047323664768908e+00 -5.913983911730012e+00 -5.979347272339563e+00 4.182371091289316e+00 4.807044559721915e+00 9.153727755913891e+03 + 135920 1.042555090627455e+00 -5.917647004575754e+00 -6.014038745590931e+00 4.143961400175561e+00 4.590465106692701e+00 9.260173957358707e+03 + 135940 1.086599288545800e+00 -5.998660037815684e+00 -6.017376928826088e+00 3.598879879528782e+00 4.491404594917522e+00 9.270466009296541e+03 + 135960 1.028703449135273e+00 -5.933017058571592e+00 -5.952720001181738e+00 4.096143166726923e+00 4.983005821238952e+00 9.072455452798426e+03 + 135980 9.884316537942814e-01 -5.894173497068046e+00 -5.978731971672183e+00 4.251315682267518e+00 4.765767835708909e+00 9.151854119570376e+03 + 136000 1.068829454451514e+00 -6.031925359048610e+00 -5.974268403934760e+00 3.514698260619154e+00 4.845773419267852e+00 9.138208440017092e+03 + 136020 9.923740732413736e-01 -5.937253905537931e+00 -6.023377624458455e+00 3.998437318276388e+00 4.503901596632307e+00 9.288936771605182e+03 + 136040 9.831399858522880e-01 -5.941776456375737e+00 -6.005777535823306e+00 3.987437445958242e+00 4.619933343635267e+00 9.234783891962534e+03 + 136060 1.029582504137016e+00 -6.027464969864919e+00 -5.991915725529092e+00 3.551348362954362e+00 4.755477625158465e+00 9.192247975908940e+03 + 136080 1.079615942437887e+00 -6.115691952261560e+00 -5.990161401319341e+00 3.076929676701972e+00 4.797745526002171e+00 9.186881068693207e+03 + 136100 9.804265967112398e-01 -5.979844360952997e+00 -6.035738125105898e+00 3.792516532201380e+00 4.471565888903374e+00 9.327069084425008e+03 + 136120 1.018159779493264e+00 -6.047949349649494e+00 -5.974251079190813e+00 3.515632131807721e+00 4.938819005551964e+00 9.138161194984836e+03 + 136140 1.031754214405736e+00 -6.075394080199154e+00 -5.966401892107920e+00 3.357477421468967e+00 4.983327431975427e+00 9.114209044339868e+03 + 136160 9.881896471347161e-01 -6.018045594737544e+00 -6.019437011769536e+00 3.603040908526334e+00 4.595051176607541e+00 9.276813628054977e+03 + 136180 1.025537463870473e+00 -6.076541186602233e+00 -5.981423473805411e+00 3.311111287621318e+00 4.857291913919154e+00 9.160138673985983e+03 + 136200 1.049294905017373e+00 -6.112936852459408e+00 -5.997469061609136e+00 3.134222761881956e+00 4.797256685527103e+00 9.209286596863099e+03 + 136220 1.030480316237187e+00 -6.088448563352166e+00 -6.000950707215428e+00 3.179935868201008e+00 4.682362098387634e+00 9.219983242503758e+03 + 136240 9.800394824228993e-01 -6.015279309471921e+00 -5.985659644916852e+00 3.604335380663481e+00 4.774416078166961e+00 9.173060881181395e+03 + 136260 9.327598249139613e-01 -5.943701726181975e+00 -5.984420254801326e+00 3.996657198520198e+00 4.762845106015947e+00 9.169249325679388e+03 + 136280 9.947544090140791e-01 -6.030327406915912e+00 -5.957359847416629e+00 3.548048417552612e+00 4.967039435890837e+00 9.086614322854315e+03 + 136300 1.035373375075447e+00 -6.083595145491326e+00 -5.987623166447296e+00 3.215321843233778e+00 4.766407798520362e+00 9.179102025234037e+03 + 136320 1.043303927466342e+00 -6.088843917815097e+00 -5.995982418005545e+00 3.181694769188292e+00 4.714919871365394e+00 9.204740844845363e+03 + 136340 9.859887317825763e-01 -5.999058807247710e+00 -6.018569316120496e+00 3.737448838558730e+00 4.625416477369705e+00 9.274135586794842e+03 + 136360 1.022032885797105e+00 -6.049153231499328e+00 -5.976708572228217e+00 3.423478069706188e+00 4.839466514015696e+00 9.145700717058980e+03 + 136380 1.016252438895692e+00 -6.036684514363619e+00 -5.996698208227883e+00 3.503198113690507e+00 4.732805671382783e+00 9.206924383055019e+03 + 136400 1.014482498470448e+00 -6.029549134088272e+00 -6.011645242074867e+00 3.548935445464845e+00 4.651742364024158e+00 9.252832395275582e+03 + 136420 9.533320776774808e-01 -5.935803778719102e+00 -6.058946885636515e+00 4.044018890980732e+00 4.336912114726741e+00 9.398874558101950e+03 + 136440 1.043551046472035e+00 -6.067790238199271e+00 -5.988998273047525e+00 3.351066890789775e+00 4.803502547708301e+00 9.183293640561616e+03 + 136460 1.009567018459496e+00 -6.015804172106607e+00 -6.018914666286268e+00 3.575053416593328e+00 4.557192477666303e+00 9.275181320537002e+03 + 136480 1.055207706873927e+00 -6.083637818639451e+00 -5.980840702918184e+00 3.231200825890635e+00 4.821477772164396e+00 9.158313885694066e+03 + 136500 9.769912277580959e-01 -5.966508622928183e+00 -6.000414632927589e+00 3.895634315256324e+00 4.700940758901644e+00 9.218302952114913e+03 + 136520 9.592987908398813e-01 -5.938047514754180e+00 -5.999560604571658e+00 4.019184505718325e+00 4.665966824866481e+00 9.215701098857555e+03 + 136540 9.930154643752914e-01 -5.986656723328995e+00 -6.001034322119532e+00 3.829639475082289e+00 4.747081077900802e+00 9.220236615551896e+03 + 136560 9.393170316115811e-01 -5.906753013072812e+00 -6.046785262528307e+00 4.217883368264553e+00 4.413796521970531e+00 9.361217317982031e+03 + 136580 1.014361554918613e+00 -6.017548869094822e+00 -5.987257307178396e+00 3.640287334015340e+00 4.814226170143519e+00 9.177976036951895e+03 + 136600 1.049508309133553e+00 -6.068130563942215e+00 -5.998809841904775e+00 3.336706849374489e+00 4.734757162660538e+00 9.213396969624082e+03 + 136620 1.050224248707701e+00 -6.069998407104860e+00 -6.014946134142451e+00 3.312019151792184e+00 4.628137822454043e+00 9.262983528208568e+03 + 136640 9.938130468497640e-01 -5.987928601449500e+00 -6.052697156356228e+00 3.784227532066514e+00 4.412316466890602e+00 9.379521414192508e+03 + 136660 1.003249465753937e+00 -6.004862845175831e+00 -6.023081911109543e+00 3.639795031304911e+00 4.535178335322192e+00 9.288055932018675e+03 + 136680 8.663398807591594e-01 -5.805993617139563e+00 -6.023344023454684e+00 4.754316060158915e+00 4.506256392230812e+00 9.288835057160612e+03 + 136700 1.022852591551916e+00 -6.038842254689841e+00 -5.996160786648855e+00 3.457662613733013e+00 4.702746208160193e+00 9.205251547359612e+03 + 136720 1.031042785058859e+00 -6.050082347954968e+00 -5.943424205858021e+00 3.470149467673318e+00 5.082597024888136e+00 9.044178437805391e+03 + 136740 1.010345902938224e+00 -6.017956916554642e+00 -5.965156673192554e+00 3.551413347304666e+00 4.854600515501026e+00 9.110381177025030e+03 + 136760 9.969983523697701e-01 -5.994849308984442e+00 -5.988292709296669e+00 3.757334273116612e+00 4.794983283154327e+00 9.181129682060484e+03 + 136780 9.383349662954873e-01 -5.905015326955368e+00 -6.011508165907759e+00 4.224583027785691e+00 4.613084666807500e+00 9.252373547788882e+03 + 136800 1.056538955588018e+00 -6.076730027265558e+00 -5.950642221161815e+00 3.279762704018359e+00 5.003778398690987e+00 9.066150266720502e+03 + 136820 1.017433314496651e+00 -6.014737072655810e+00 -6.006742345649879e+00 3.634895106788549e+00 4.680802066436617e+00 9.237753621280091e+03 + 136840 1.053938348691172e+00 -6.068721751190915e+00 -5.998458840856856e+00 3.284280317697745e+00 4.687740821986146e+00 9.212336201006718e+03 + 136860 1.023933812072702e+00 -6.024727097400055e+00 -5.971149597429758e+00 3.565893577135892e+00 4.873543873056660e+00 9.128714584627225e+03 + 136880 9.171326666869494e-01 -5.866192653570816e+00 -6.037496800703400e+00 4.378759660371657e+00 4.395104738305262e+00 9.332470430465688e+03 + 136900 9.731781716433238e-01 -5.949051863263223e+00 -5.991726823775732e+00 4.013442234542912e+00 4.768396007351291e+00 9.191602766661701e+03 + 136920 1.003551197297427e+00 -5.992529006678416e+00 -5.994521466068285e+00 3.699616592392836e+00 4.688175582244117e+00 9.200240724413039e+03 + 136940 9.850617178139464e-01 -5.962408810751944e+00 -6.043124128283266e+00 3.912542448450152e+00 4.449062604530285e+00 9.349917536960749e+03 + 136960 9.814483441930956e-01 -5.957777023111169e+00 -6.037393199660933e+00 3.945938427809754e+00 4.488770021497510e+00 9.332170957164843e+03 + 136980 1.010788853924944e+00 -6.002811659139951e+00 -6.039851389527048e+00 3.650797052169974e+00 4.438109188407505e+00 9.339761497556856e+03 + 137000 9.991509272069224e-01 -5.987039792058004e+00 -6.039458329302597e+00 3.722407626844988e+00 4.421412274244115e+00 9.338576042741306e+03 + 137020 9.425519045384113e-01 -5.908139262995117e+00 -6.007241296622684e+00 4.165716854978040e+00 4.596657641898414e+00 9.239278192523421e+03 + 137040 9.847560173297604e-01 -5.975791591805898e+00 -5.961302530805293e+00 3.843737093029719e+00 4.926935523470135e+00 9.098587468652093e+03 + 137060 9.500754724545072e-01 -5.924315410507564e+00 -6.022354792423129e+00 4.050512891230443e+00 4.487555588725950e+00 9.285745949651615e+03 + 137080 9.787311358600240e-01 -5.966735096419446e+00 -5.985952574586157e+00 3.871478261902932e+00 4.761128528374536e+00 9.173935144261697e+03 + 137100 1.016092318549220e+00 -6.019859542490249e+00 -5.994218071076720e+00 3.602587206573203e+00 4.749824503434564e+00 9.199289705744904e+03 + 137120 1.009299135336053e+00 -6.002109285396493e+00 -6.066207364882803e+00 3.632647272468966e+00 4.264586180912826e+00 9.421401557511925e+03 + 137140 9.693261549808431e-01 -5.935282326772901e+00 -6.050631331699191e+00 4.008602142591174e+00 4.346250306103594e+00 9.373166693150031e+03 + 137160 1.057429804314449e+00 -6.059033954811825e+00 -6.014690726511027e+00 3.335773955671503e+00 4.590399634667089e+00 9.262235012547486e+03 + 137180 1.007707836587857e+00 -5.980127180827967e+00 -5.991922505446376e+00 3.810327277476088e+00 4.742596698196599e+00 9.192257296548027e+03 + 137200 9.722190211236019e-01 -5.920930844757012e+00 -6.012102045310597e+00 4.064921501791073e+00 4.541402359514700e+00 9.254197411327381e+03 + 137220 1.045125957836011e+00 -6.023307613043908e+00 -6.001630501505958e+00 3.524311414399945e+00 4.648784743373024e+00 9.222004912192220e+03 + 137240 1.025203195130222e+00 -5.989980039138755e+00 -6.010233472738074e+00 3.678825906634024e+00 4.562527556698010e+00 9.248490975439730e+03 + 137260 1.036443409954271e+00 -6.005486639700235e+00 -5.997011005150795e+00 3.606393478573316e+00 4.655061883756412e+00 9.207865168493468e+03 + 137280 9.880746729940637e-01 -5.934209034861803e+00 -6.002298174611841e+00 4.043693242958551e+00 4.652714865753514e+00 9.224111538711813e+03 + 137300 1.035012770052782e+00 -6.006504461609005e+00 -6.006042723025380e+00 3.653046953024022e+00 4.655698327425010e+00 9.235595868857026e+03 + 137320 9.933715614793592e-01 -5.948430477397632e+00 -5.989252760354288e+00 3.952962838567592e+00 4.718554972602598e+00 9.184085904773186e+03 + 137340 1.103067595199341e+00 -6.116679781961702e+00 -5.965442594243738e+00 3.131336592246091e+00 4.999763928001799e+00 9.111275839451793e+03 + 137360 9.801011743172191e-01 -5.943571899264999e+00 -6.011131453011259e+00 3.989239786796552e+00 4.601302374378373e+00 9.251263111601284e+03 + 137380 1.012125873004371e+00 -6.001266297558162e+00 -5.985256174862652e+00 3.749443764772908e+00 4.841376366849010e+00 9.171826151075013e+03 + 137400 1.015875855811291e+00 -6.017101832974991e+00 -6.032300689227538e+00 3.607433456874138e+00 4.520159272256610e+00 9.316476143471064e+03 + 137420 9.390818254618089e-01 -5.916933309184474e+00 -6.041277744760224e+00 4.190523796161138e+00 4.476518804845963e+00 9.344182118599329e+03 + 137440 9.268913129030821e-01 -5.913492943034760e+00 -6.063421331249753e+00 4.122571215880407e+00 4.261659209406823e+00 9.412755554742398e+03 + 137460 1.003693176782576e+00 -6.042348121349740e+00 -5.994641690231393e+00 3.475401720344188e+00 4.749339430372093e+00 9.200607425135258e+03 + 137480 1.014275253891363e+00 -6.070996583992850e+00 -5.971843635295945e+00 3.307995106593990e+00 4.877346681880843e+00 9.130837578405924e+03 + 137500 9.761930896543723e-01 -6.026664991074238e+00 -6.010681756831959e+00 3.582038777376604e+00 4.673816981793274e+00 9.249880208489782e+03 + 137520 9.261329957568745e-01 -5.963818183670790e+00 -6.012757357767892e+00 3.869548783529076e+00 4.588532472550796e+00 9.256276857838908e+03 + 137540 9.529555810347632e-01 -6.013414472810366e+00 -6.034240429970730e+00 3.571359099086399e+00 4.451773230265137e+00 9.322463771785577e+03 + 137560 9.632833903457236e-01 -6.036060639208438e+00 -5.983217216545308e+00 3.500313336870534e+00 4.803748447295461e+00 9.165601287729743e+03 + 137580 1.005613619977791e+00 -6.102785852834947e+00 -5.936403440720850e+00 3.185644342267028e+00 5.141037900221228e+00 9.022854526544124e+03 + 137600 9.316863074455614e-01 -5.991482601766986e+00 -6.002945903811332e+00 3.708371628200380e+00 4.642547573921487e+00 9.226085325274686e+03 + 137620 1.013644838625650e+00 -6.107177497048085e+00 -5.953069854233986e+00 3.139964784029895e+00 5.024874717149101e+00 9.073544232524080e+03 + 137640 9.985450496543775e-01 -6.073395807523471e+00 -5.979357647802161e+00 3.259493673137089e+00 4.799475338615038e+00 9.153780635259969e+03 + 137660 9.538997279997700e-01 -5.986399366319057e+00 -5.998530414692991e+00 3.769194535355457e+00 4.699536178318662e+00 9.212541867476628e+03 + 137680 9.513754178153582e-01 -5.955048421416341e+00 -6.046653284192769e+00 3.898340496978556e+00 4.372331199109609e+00 9.360844776769673e+03 + 137700 9.863946398659318e-01 -5.973181949033245e+00 -6.033878264688854e+00 3.839927821726656e+00 4.491400184507654e+00 9.321327363211572e+03 + 137720 1.052721075930549e+00 -6.038316993780059e+00 -6.000194311327752e+00 3.458011377695419e+00 4.676917719802614e+00 9.217624122263445e+03 + 137740 1.028975455613955e+00 -5.969280478631759e+00 -5.979167010943874e+00 3.872767590713560e+00 4.815997592241470e+00 9.153197746047375e+03 + 137760 1.045228388056955e+00 -5.962669358035461e+00 -5.934527932839773e+00 3.930638129736055e+00 5.092230548081174e+00 9.017114825166649e+03 + 137780 9.638230810847727e-01 -5.815198992629285e+00 -6.011218332099558e+00 4.662011530033492e+00 4.536438148900440e+00 9.251381311769286e+03 + 137800 1.054819274374448e+00 -5.925484529122527e+00 -5.965691044621343e+00 4.084184783166855e+00 4.853312749234491e+00 9.111992791914519e+03 + 137820 1.080693730775991e+00 -5.945972798286506e+00 -5.993049876208326e+00 3.984154664931423e+00 4.713830798350070e+00 9.195714321888952e+03 + 137840 1.068536481653145e+00 -5.921304782566994e+00 -6.039717230122331e+00 4.082052087496232e+00 4.402109489366443e+00 9.339345817118980e+03 + 137860 1.042696320296683e+00 -5.886808703348026e+00 -5.961230830388187e+00 4.304113337225914e+00 4.876769966974368e+00 9.098429385891070e+03 + 137880 1.049047846503601e+00 -5.904242853294108e+00 -5.987238653431401e+00 4.203162089807955e+00 4.726587361861054e+00 9.177896004437242e+03 + 137900 1.032368797295968e+00 -5.891545802812154e+00 -6.030010601036810e+00 4.252995971438995e+00 4.457909672674750e+00 9.309401280316724e+03 + 137920 1.031320840278714e+00 -5.909493258160772e+00 -6.035571399722849e+00 4.182827649848450e+00 4.458867450469655e+00 9.326573258441604e+03 + 137940 1.084386338774264e+00 -6.014917637770553e+00 -6.046534799593216e+00 3.574527503588335e+00 4.392976867662629e+00 9.360462651654494e+03 + 137960 9.806100879962542e-01 -5.894508259018193e+00 -6.072894439720367e+00 4.275916158171389e+00 4.251595103407255e+00 9.442169637758463e+03 + 137980 9.746444907094887e-01 -5.918124582160170e+00 -6.026824729304174e+00 4.117214500329135e+00 4.493041434134859e+00 9.299594320245291e+03 + 138000 1.002655025271267e+00 -5.985561745014941e+00 -6.028884666879778e+00 3.800473275896725e+00 4.551706354348342e+00 9.305930415170416e+03 + 138020 1.021587260246894e+00 -6.032710394794419e+00 -6.052026040993356e+00 3.537139517368584e+00 4.426226087807702e+00 9.377437905892188e+03 + 138040 1.003598909513602e+00 -6.021678344218886e+00 -5.975921254573771e+00 3.678027742021504e+00 4.940772031650495e+00 9.143274972527448e+03 + 138060 1.036855406240606e+00 -6.079145838427833e+00 -5.956767916724377e+00 3.353368691316671e+00 5.056081655660101e+00 9.084799581062793e+03 + 138080 9.692985466900462e-01 -5.982011384036091e+00 -5.969046473801894e+00 3.829320036532633e+00 4.903766557410764e+00 9.122279449202002e+03 + 138100 9.705385883862624e-01 -5.983871693693493e+00 -6.022801306091651e+00 3.763650142845127e+00 4.540110284116850e+00 9.287171819150723e+03 + 138120 1.004241753919461e+00 -6.033933026100030e+00 -5.987717956306110e+00 3.460306635150106e+00 4.725680717665734e+00 9.179402358871139e+03 + 138140 1.004430960219895e+00 -6.033118093050096e+00 -5.950079721520694e+00 3.546348541405741e+00 5.023167720874033e+00 9.064448063266120e+03 + 138160 9.448985344343350e-01 -5.940255046665037e+00 -6.005938809572994e+00 3.973507301390738e+00 4.596340970243789e+00 9.235287171347456e+03 + 138180 9.637906311211420e-01 -5.961740620637454e+00 -6.032187939712964e+00 3.958748128401083e+00 4.554228720582112e+00 9.316092890239892e+03 + 138200 1.041595366902554e+00 -6.069537852135358e+00 -5.976082909544226e+00 3.325321252180357e+00 4.861953994644269e+00 9.143780259532145e+03 + 138220 1.038763545836012e+00 -6.055755800306680e+00 -5.991239620572197e+00 3.389417197040455e+00 4.759879084922408e+00 9.190184767276489e+03 + 138240 1.020484566701619e+00 -6.020246891444675e+00 -6.028169760272017e+00 3.561484315241386e+00 4.515989976374799e+00 9.303717100691145e+03 + 138260 9.846594290080384e-01 -5.960587759450487e+00 -5.995623723902191e+00 3.909500125317707e+00 4.708318195638046e+00 9.203616775346487e+03 + 138280 1.039759743207341e+00 -6.032964843821327e+00 -6.012656656190168e+00 3.501704569987524e+00 4.618317326047523e+00 9.255952399805512e+03 + 138300 1.084784439111142e+00 -6.091616299301173e+00 -5.980096095560764e+00 3.211652031174335e+00 4.852018298747520e+00 9.156063042812691e+03 + 138320 9.879542921735197e-01 -5.941809809663524e+00 -6.007566030336269e+00 4.001272010257619e+00 4.623689615412450e+00 9.240291643761675e+03 + 138340 1.046189547665074e+00 -6.020601061450487e+00 -6.035305597768387e+00 3.583694215661820e+00 4.499258492604799e+00 9.325743325774547e+03 + 138360 1.068618341087495e+00 -6.048931712658112e+00 -6.004940092340472e+00 3.397381311920565e+00 4.649988003465699e+00 9.232243802107501e+03 + 138380 1.022370128481884e+00 -5.977514290134662e+00 -6.006153562918412e+00 3.879671595288193e+00 4.715220459050766e+00 9.235941490792888e+03 + 138400 1.001460545296459e+00 -5.945620486254661e+00 -5.985203637428327e+00 4.053029792299196e+00 4.825737212787161e+00 9.171681104954676e+03 + 138420 9.812835069223571e-01 -5.916991081304393e+00 -6.006818866024022e+00 4.192546932533500e+00 4.676741891868629e+00 9.237985897473292e+03 + 138440 9.953844457100985e-01 -5.939052170580297e+00 -6.004218045245167e+00 4.081524110721523e+00 4.707331574009327e+00 9.230005080993293e+03 + 138460 1.064159170383417e+00 -6.046071940492279e+00 -6.012421881285512e+00 3.469317511262850e+00 4.662541358557942e+00 9.255223193440588e+03 + 138480 9.432464641669073e-01 -5.877711681396527e+00 -6.040010978526224e+00 4.373021298605189e+00 4.441073618751409e+00 9.340290989251767e+03 + 138500 1.008942094328704e+00 -5.990392563598535e+00 -5.991600202403768e+00 3.802662279441262e+00 4.795727830540112e+00 9.191271955658051e+03 + 138520 9.358043935023291e-01 -5.898106111662854e+00 -6.022678769913165e+00 4.268944926179107e+00 4.553629444949263e+00 9.286778958091843e+03 + 138540 1.044815194930107e+00 -6.077730035631197e+00 -6.006793263512779e+00 3.254680231093122e+00 4.662010154027083e+00 9.237919679964583e+03 + 138560 1.029685823305845e+00 -6.077118343001547e+00 -5.978525901160941e+00 3.307503684641595e+00 4.873636742821419e+00 9.151254881921288e+03 + 138580 1.041986097576706e+00 -6.118899287609727e+00 -5.982773793551007e+00 3.121123305329147e+00 4.902776957566441e+00 9.164254938415968e+03 + 138600 9.434210668659752e-01 -5.997978123939192e+00 -5.989008340254092e+00 3.714647691383093e+00 4.766153577372479e+00 9.183327121603985e+03 + 138620 9.778652783946806e-01 -6.073034833166809e+00 -5.932014614208673e+00 3.407782252884164e+00 5.217542172950139e+00 9.009489686534414e+03 + 138640 8.673369738455792e-01 -5.925262866408961e+00 -5.969771041935225e+00 4.084711828119826e+00 4.829138996630116e+00 9.124446694627542e+03 + 138660 9.174413039729665e-01 -6.005559085466901e+00 -5.961579496322836e+00 3.670581823392223e+00 4.923119430076870e+00 9.099464190790106e+03 + 138680 1.009182807692230e+00 -6.140629772894999e+00 -5.991452622781026e+00 2.919654585254289e+00 4.776252866298099e+00 9.190822974973729e+03 + 138700 8.819863618150909e-01 -5.948426511265433e+00 -6.000359121455020e+00 3.978633197593742e+00 4.680428113339682e+00 9.218166923918370e+03 + 138720 9.407669504974367e-01 -6.025366141121287e+00 -6.043016302486016e+00 3.490896523069382e+00 4.389546565159463e+00 9.349561206106628e+03 + 138740 1.011927435349186e+00 -6.113459499682836e+00 -5.998734152976636e+00 3.055954881164031e+00 4.714725575641056e+00 9.213187814071629e+03 + 138760 9.283232574156345e-01 -5.964693016350180e+00 -6.016168090356844e+00 3.882199355770090e+00 4.586621515081868e+00 9.266759278513631e+03 + 138780 9.569219939692702e-01 -5.973720322636479e+00 -6.037206229427882e+00 3.825852656197193e+00 4.461306754988635e+00 9.331608585942515e+03 + 138800 1.043105661801749e+00 -6.060855863922247e+00 -6.003814847363433e+00 3.401724719217296e+00 4.729263063366788e+00 9.228763191977489e+03 + 138820 9.937292131565840e-01 -5.943337266582921e+00 -6.008948677897992e+00 4.025990558698645e+00 4.649239681594417e+00 9.244548890601902e+03 + 138840 9.406335730223223e-01 -5.827071053885653e+00 -6.074870368496941e+00 4.620240162521058e+00 4.197338151203037e+00 9.448311864407284e+03 + 138860 1.093336986825499e+00 -6.023944676421438e+00 -5.979663963811009e+00 3.533800493852026e+00 4.788067198079241e+00 9.154742781016363e+03 + 138880 1.077618088895531e+00 -5.979999476624354e+00 -6.030896311568420e+00 3.755452120840701e+00 4.463194618332118e+00 9.312148974158610e+03 + 138900 1.025076721348547e+00 -5.893375333804697e+00 -6.070243049612462e+00 4.170109718994785e+00 4.154507924636035e+00 9.433957516822491e+03 + 138920 1.066802855599658e+00 -5.956322259872403e+00 -6.028999958571063e+00 3.991306853848634e+00 4.573980261083403e+00 9.306288592703144e+03 + 138940 1.105810857849289e+00 -6.020293704888637e+00 -6.021312005501794e+00 3.574513108108667e+00 4.568665868406411e+00 9.282603560394917e+03 + 138960 1.001323654027588e+00 -5.879914577305163e+00 -6.024592106800130e+00 4.283075902127582e+00 4.452315138992148e+00 9.292703584699679e+03 + 138980 1.016703981596852e+00 -5.917372767650296e+00 -5.985478221033047e+00 4.119432188960545e+00 4.728360136351933e+00 9.172518502835144e+03 + 139000 9.969975007127980e-01 -5.901972861624685e+00 -6.012017579144143e+00 4.247640206581140e+00 4.615746409219418e+00 9.253977629274381e+03 + 139020 1.070860151517397e+00 -6.028146528194418e+00 -5.998492167324613e+00 3.546228308199573e+00 4.716508237311502e+00 9.212402734487845e+03 + 139040 9.665655290721255e-01 -5.890514600040862e+00 -6.009347325674596e+00 4.252227442690048e+00 4.569871542796289e+00 9.245736486230961e+03 + 139060 9.739695294179109e-01 -5.917192747182552e+00 -5.988390402281745e+00 4.173887493334298e+00 4.765059539953216e+00 9.181415268287930e+03 + 139080 1.016564594898197e+00 -5.993829685212724e+00 -5.973671336891360e+00 3.742823090910468e+00 4.858575446466062e+00 9.136375153600749e+03 + 139100 9.919120175399586e-01 -5.967905339242114e+00 -5.960571862941193e+00 3.849810611086823e+00 4.891920566858506e+00 9.096385732133824e+03 + 139120 9.593431401980245e-01 -5.927740052867414e+00 -5.989763380468634e+00 4.081457245404864e+00 4.725309700239735e+00 9.185641248078313e+03 + 139140 1.029260602735118e+00 -6.038429149571138e+00 -5.987843712715988e+00 3.452830170317347e+00 4.743299576810673e+00 9.179757957045314e+03 + 139160 1.007602529722866e+00 -6.013369668526346e+00 -5.997165788775633e+00 3.640375003335248e+00 4.733420188406130e+00 9.208353816702804e+03 + 139180 1.005751298805370e+00 -6.016636340406102e+00 -5.982758828792088e+00 3.585977554120060e+00 4.780507468335709e+00 9.164211451440220e+03 + 139200 1.012859047746622e+00 -6.032285668830134e+00 -6.007847296346293e+00 3.541653493668940e+00 4.681982410297072e+00 9.241136555172676e+03 + 139220 9.412601307221020e-01 -5.929863041632634e+00 -6.030119315717780e+00 4.106342520559301e+00 4.530655480154121e+00 9.309724776983961e+03 + 139240 1.039867683526883e+00 -6.078774398843350e+00 -6.000508568280813e+00 3.283556733968843e+00 4.732971244657071e+00 9.218616700334074e+03 + 139260 9.579760975566122e-01 -5.960302341834712e+00 -6.017738175606967e+00 3.966804398253108e+00 4.636998952566271e+00 9.271579522465128e+03 + 139280 1.006513485075464e+00 -6.035688213205995e+00 -6.027483372912727e+00 3.532560273749913e+00 4.579673736408793e+00 9.301609465580883e+03 + 139300 9.413413535085295e-01 -5.941315067493709e+00 -6.035004718854179e+00 3.953206693070244e+00 4.415226216531734e+00 9.324799873752816e+03 + 139320 1.036604837790182e+00 -6.085094896611094e+00 -5.958378488481497e+00 3.260980158272331e+00 4.988605383053264e+00 9.089712485498809e+03 + 139340 9.602035904648629e-01 -5.970819675345785e+00 -5.981712978074727e+00 3.862568968958901e+00 4.800017938956170e+00 9.160994394184114e+03 + 139360 9.555371278452660e-01 -5.960854684823919e+00 -6.004735016827692e+00 3.925630273042839e+00 4.673662616217740e+00 9.231568127956347e+03 + 139380 1.041683927286453e+00 -6.078293093063744e+00 -5.962992567082728e+00 3.324131167721012e+00 4.986204630602735e+00 9.103783677294819e+03 + 139400 1.008814371850416e+00 -6.008775004673254e+00 -5.980103053268999e+00 3.639574031765455e+00 4.804212813698829e+00 9.156058797477979e+03 + 139420 1.018405908523166e+00 -5.989106267237901e+00 -5.967593905722952e+00 3.754195921302007e+00 4.877723230148027e+00 9.117810849008187e+03 + 139440 1.026589314700578e+00 -5.959363941247018e+00 -5.950992857716891e+00 3.936936231434696e+00 4.985004288485678e+00 9.067206479068494e+03 + 139460 1.058996101984110e+00 -5.961220186556544e+00 -5.992187929920552e+00 3.916145616186856e+00 4.738324041547919e+00 9.193067210214364e+03 + 139480 1.057187127234161e+00 -5.918014733182435e+00 -6.037050520730308e+00 4.135955587373111e+00 4.452433674544634e+00 9.331141309028935e+03 + 139500 1.060839069856907e+00 -5.894758090857223e+00 -6.043060071204196e+00 4.233914976503533e+00 4.382342055693925e+00 9.349694142146733e+03 + 139520 1.069032013165838e+00 -5.890548527149431e+00 -6.021337900824861e+00 4.259769335976289e+00 4.508756512741805e+00 9.282658669001094e+03 + 139540 1.047311496178486e+00 -5.850123600122386e+00 -6.073504708125919e+00 4.445543681402930e+00 4.162854791131896e+00 9.444039534669551e+03 + 139560 1.071327160342137e+00 -5.889239343635555e+00 -6.040401216516305e+00 4.263145443432229e+00 4.395150577126740e+00 9.341486027049808e+03 + 139580 1.121221342033233e+00 -5.979564799131463e+00 -5.958737164783913e+00 3.797898436561423e+00 4.917493936051053e+00 9.090816094392132e+03 + 139600 1.063692413359104e+00 -5.917159640320579e+00 -6.006363360616401e+00 4.132521552781726e+00 4.620299986612008e+00 9.236588354938336e+03 + 139620 1.084823498349184e+00 -5.981191321971450e+00 -6.041709383644728e+00 3.721161804040230e+00 4.373657728772494e+00 9.345544496698485e+03 + 139640 9.905322450335997e-01 -5.881280409533627e+00 -6.005254813588605e+00 4.311662510868109e+00 4.599782297807402e+00 9.233194272476068e+03 + 139660 1.021144749275619e+00 -5.966474441909938e+00 -6.012886819951032e+00 3.894619190388229e+00 4.628112133383977e+00 9.256633330416696e+03 + 139680 9.633283261434359e-01 -5.914937797774867e+00 -6.030870314345679e+00 4.136103828051098e+00 4.470401377402542e+00 9.312047847433660e+03 + 139700 1.031224508358351e+00 -6.046010203432660e+00 -6.008185940397095e+00 3.408265564828944e+00 4.625458336464947e+00 9.242204062429020e+03 + 139720 9.835376527396956e-01 -6.000598169744826e+00 -6.006803270722343e+00 3.672060804250850e+00 4.636430154201676e+00 9.237958176929886e+03 + 139740 1.037252904784985e+00 -6.099637402106771e+00 -5.973884537289730e+00 3.176311832843171e+00 4.898404242815557e+00 9.137052912916975e+03 + 139760 9.710522183907180e-01 -6.015795025050281e+00 -5.987860510203809e+00 3.602875718061262e+00 4.763280025161905e+00 9.179784302628845e+03 + 139780 9.628781758015147e-01 -6.012300674185990e+00 -6.009910026788692e+00 3.633670400817359e+00 4.647397868124134e+00 9.247501150983402e+03 + 139800 9.251426510128338e-01 -5.961898783981693e+00 -6.044961014792069e+00 3.914760062295630e+00 4.437803879143777e+00 9.355577989612069e+03 + 139820 9.111794078438058e-01 -5.943203107269698e+00 -6.033744682280211e+00 4.008448155365498e+00 4.488544420391674e+00 9.320927061407769e+03 + 139840 1.010410791248123e+00 -6.089584368775077e+00 -5.980213761559461e+00 3.200264222750792e+00 4.828287174429628e+00 9.156419337689182e+03 + 139860 9.890780792576576e-01 -6.053689281354137e+00 -5.998952167624942e+00 3.371121898652071e+00 4.685430876226085e+00 9.213837128099700e+03 + 139880 1.020476860372789e+00 -6.093270882862875e+00 -6.012202981566916e+00 3.177106716043943e+00 4.642611150502521e+00 9.254559113163687e+03 + 139900 9.381846549064705e-01 -5.961654492799696e+00 -6.011679781752263e+00 3.863185179100062e+00 4.575932228545980e+00 9.252931766910113e+03 + 139920 1.078120048000827e+00 -6.155622852792122e+00 -5.974382907820118e+00 2.871242399158222e+00 4.911950209978311e+00 9.138578302428348e+03 + 139940 1.012277511651776e+00 -6.040295660276224e+00 -6.018938546770022e+00 3.418404196668437e+00 4.541040047423682e+00 9.275278756475209e+03 + 139960 9.837023350126741e-01 -5.976340485370481e+00 -5.974034036775229e+00 3.862664182041054e+00 4.875908166796759e+00 9.137412638484386e+03 + 139980 9.897853041003999e-01 -5.953432011634995e+00 -5.988309437539861e+00 3.907579020859092e+00 4.707307444049130e+00 9.181193269775307e+03 + 140000 9.788193215398436e-01 -5.898574522652016e+00 -6.021652540946462e+00 4.198561371742542e+00 4.491828344434055e+00 9.283616034230648e+03 + 140020 1.008471367237756e+00 -5.895193949358843e+00 -6.030760004478312e+00 4.202796580545804e+00 4.424355313270582e+00 9.311714060576729e+03 + 140040 1.081658994576293e+00 -5.958535139447593e+00 -6.021997897689684e+00 3.887060779285941e+00 4.522647800629755e+00 9.284688273059926e+03 + 140060 1.085007409799589e+00 -5.930830541671099e+00 -5.977621087107359e+00 4.082940093156421e+00 4.814261540447915e+00 9.148440811459113e+03 + 140080 1.054751194101547e+00 -5.865046221644407e+00 -5.966547831393621e+00 4.430732242558745e+00 4.847894292055416e+00 9.114616009324458e+03 + 140100 1.062840565039670e+00 -5.865858224838235e+00 -5.958679053611625e+00 4.450954182416525e+00 4.917962619622888e+00 9.090603062603448e+03 + 140120 1.089002408052415e+00 -5.900774906675563e+00 -5.967981992874171e+00 4.256486673931043e+00 4.870573184715660e+00 9.119009899836290e+03 + 140140 1.101494017388322e+00 -5.923305071183652e+00 -6.031510824903899e+00 4.069028146953702e+00 4.447693964305776e+00 9.314041442297921e+03 + 140160 1.059511841788898e+00 -5.876515788766618e+00 -6.085020664064515e+00 4.323714984927514e+00 4.126447724941817e+00 9.479895542089440e+03 + 140180 1.055811097029639e+00 -5.895141315342804e+00 -6.048825302839449e+00 4.236943274327874e+00 4.354466035601938e+00 9.367555721373099e+03 + 140200 1.077080582811771e+00 -5.956175741882549e+00 -5.991816381960835e+00 3.951605360287705e+00 4.746951289586966e+00 9.191936144123456e+03 + 140220 1.013577984007188e+00 -5.888480011771967e+00 -5.990719679491425e+00 4.338743698699642e+00 4.751667705117069e+00 9.188566570094565e+03 + 140240 1.014807061416192e+00 -5.911937573848485e+00 -6.015297004913188e+00 4.113462445488429e+00 4.519956597494644e+00 9.264047713150818e+03 + 140260 1.011870125922103e+00 -5.925393132056071e+00 -6.006478961283511e+00 4.041827625931523e+00 4.576220246516042e+00 9.236894733949674e+03 + 140280 1.037888241080970e+00 -5.978495142178147e+00 -5.989560141606611e+00 3.804515528069345e+00 4.740978589047979e+00 9.185000174563103e+03 + 140300 1.059458314577908e+00 -6.022170766720881e+00 -6.007795162030860e+00 3.593462577633149e+00 4.676009524380891e+00 9.240987028045221e+03 + 140320 9.928459108879778e-01 -5.937889506755788e+00 -5.996343098227166e+00 3.975954882125606e+00 4.640305314232902e+00 9.205826055707430e+03 + 140340 9.414358892970871e-01 -5.873705785645719e+00 -6.016098786212575e+00 4.392744974476403e+00 4.575102329975897e+00 9.266510395859012e+03 + 140360 1.093373903859890e+00 -6.110343039601594e+00 -5.955036651650448e+00 3.097671364319747e+00 4.989464677521092e+00 9.079545273787515e+03 + 140380 9.922463446956121e-01 -5.972117021342447e+00 -5.998829289255700e+00 3.844684661258877e+00 4.691298685190879e+00 9.213439607026763e+03 + 140400 9.559224387258649e-01 -5.928162493654090e+00 -6.052052777752324e+00 4.065038849151660e+00 4.353641665900105e+00 9.377543267164880e+03 + 140420 1.028093704335014e+00 -6.048228259499221e+00 -6.016331087746416e+00 3.431095685859646e+00 4.614254182135628e+00 9.267257262237585e+03 + 140440 9.450772014969973e-01 -5.939134386186402e+00 -6.019081920188301e+00 4.014089781500839e+00 4.555018669421037e+00 9.275704016104866e+03 + 140460 1.015908355243267e+00 -6.056892853905057e+00 -5.993002516316306e+00 3.389698334626581e+00 4.756566540058983e+00 9.195577686742017e+03 + 140480 9.647227394242229e-01 -5.992419198496027e+00 -6.002366616130443e+00 3.767405665334308e+00 4.710286053919589e+00 9.224303478137925e+03 + 140500 9.366416597217013e-01 -5.960324618634110e+00 -6.000612400208841e+00 3.946551785190970e+00 4.715213108874821e+00 9.218906527237963e+03 + 140520 9.726252299728879e-01 -6.019858129595307e+00 -6.019665326027194e+00 3.576291190045314e+00 4.577398297969672e+00 9.277539908694649e+03 + 140540 1.009385246964118e+00 -6.080886184857526e+00 -5.995840122695757e+00 3.250973229134085e+00 4.739320878902546e+00 9.204303632552141e+03 + 140560 9.539913150621055e-01 -6.005898857533337e+00 -6.006363848199791e+00 3.693699383504472e+00 4.691029335140621e+00 9.236578667269458e+03 + 140580 9.227247949162940e-01 -5.965080602331487e+00 -5.975026034680650e+00 3.866811972823949e+00 4.809703761224377e+00 9.140518207064582e+03 + 140600 1.037740492441840e+00 -6.136212861319004e+00 -5.949213254971285e+00 2.980900110661939e+00 5.054680788406097e+00 9.061796572884432e+03 + 140620 9.787228143780681e-01 -6.045927634867674e+00 -5.989167562199748e+00 3.390185558412396e+00 4.716110679264485e+00 9.183835726612167e+03 + 140640 9.557002688564795e-01 -6.004246027041735e+00 -6.000561403767816e+00 3.666952759430593e+00 4.688110436463047e+00 9.218773042713676e+03 + 140660 9.426766024006065e-01 -5.970222813042710e+00 -5.987534453734143e+00 3.925270740590129e+00 4.825864620772182e+00 9.178806425668810e+03 + 140680 9.986807348933981e-01 -6.030919755454440e+00 -6.014774377601023e+00 3.460506042119018e+00 4.553215300242492e+00 9.262486633880677e+03 + 140700 1.016887322057612e+00 -6.029932147385885e+00 -5.993680414850035e+00 3.553574627788989e+00 4.761737685947323e+00 9.197661951509031e+03 + 140720 1.000472705871802e+00 -5.975758663559182e+00 -6.027681450178287e+00 3.801847112263010e+00 4.503698436470849e+00 9.302218832366023e+03 + 140740 1.001973364321476e+00 -5.947302567451344e+00 -6.009000630967154e+00 3.984556031641565e+00 4.630276203189314e+00 9.244700495838237e+03 + 140760 9.681501632530367e-01 -5.868471974583949e+00 -6.033635741875741e+00 4.432636094611668e+00 4.484240183811815e+00 9.320570995451511e+03 + 140780 1.034248566292155e+00 -5.942229175413677e+00 -5.978082685144418e+00 4.031093606834003e+00 4.825217205647383e+00 9.149873088407252e+03 + 140800 1.058140341021698e+00 -5.953095906468089e+00 -6.024186750079615e+00 3.962987038897569e+00 4.554772413607699e+00 9.291434277284676e+03 + 140820 1.099336863563966e+00 -5.996971844636814e+00 -5.998072564186392e+00 3.755171062362095e+00 4.748850560372616e+00 9.211127408571156e+03 + 140840 1.024683675855185e+00 -5.878286826960359e+00 -6.044496268919011e+00 4.333211804644463e+00 4.378811468089865e+00 9.354137605622242e+03 + 140860 1.047304959649211e+00 -5.912891585353480e+00 -6.024671465848774e+00 4.109030859434010e+00 4.467173487749429e+00 9.292908974942040e+03 + 140880 1.068801363808031e+00 -5.951779825137063e+00 -6.009736274695192e+00 3.975985901427654e+00 4.643190999333292e+00 9.246938773748656e+03 + 140900 1.057245026878601e+00 -5.947500703666660e+00 -6.023847464513727e+00 3.986849720346205e+00 4.548454804939289e+00 9.290388251615086e+03 + 140920 1.020892057826922e+00 -5.915475163943222e+00 -6.017124508921835e+00 4.165330246031246e+00 4.581643976978750e+00 9.269685559645030e+03 + 140940 1.080815778321744e+00 -6.034227627796374e+00 -6.007622734535374e+00 3.495954007815252e+00 4.648723422013837e+00 9.240469447319761e+03 + 140960 1.038798334836277e+00 -6.015374902291191e+00 -5.998582371447091e+00 3.630212588720040e+00 4.726637899462610e+00 9.212711608191994e+03 + 140980 9.846476907999268e-01 -5.977725911144168e+00 -5.969058226808738e+00 3.831910974285732e+00 4.881682159059583e+00 9.122306711057085e+03 + 141000 1.012782988623940e+00 -6.056358123216759e+00 -5.981927082762950e+00 3.382684468068678e+00 4.810079020520734e+00 9.161645465491947e+03 + 141020 9.331963290987556e-01 -5.966837015806142e+00 -5.998211895047554e+00 3.880286940358214e+00 4.700127528507155e+00 9.211550377967083e+03 + 141040 9.725698411944492e-01 -6.042824452769178e+00 -5.964668686558828e+00 3.513912276968919e+00 4.962694781114483e+00 9.108897483434388e+03 + 141060 9.537777346531708e-01 -6.024603945271705e+00 -5.989731729349669e+00 3.627969236650291e+00 4.828210896932591e+00 9.185469231339333e+03 + 141080 9.125449879887032e-01 -5.967204689353025e+00 -5.944220701510270e+00 3.868266407372017e+00 5.000244022325738e+00 9.046577184114920e+03 + 141100 9.496454377090862e-01 -6.017469537974544e+00 -5.980613062874609e+00 3.577687722714566e+00 4.789323306259485e+00 9.157614873322362e+03 + 141120 1.022608858818241e+00 -6.117334194985709e+00 -5.970021056435797e+00 3.058069603344914e+00 4.903964441533018e+00 9.125255897962623e+03 + 141140 9.422624947674526e-01 -5.988318403748321e+00 -5.995116197180967e+00 3.744915328758613e+00 4.705881346913229e+00 9.202047737251341e+03 + 141160 9.318497058825266e-01 -5.961813257693670e+00 -6.030668081679886e+00 3.916895673474701e+00 4.521520618896270e+00 9.311418934605976e+03 + 141180 9.524203649108555e-01 -5.979643797843841e+00 -6.004447479106374e+00 3.852015169154395e+00 4.709588592987660e+00 9.230692083684376e+03 + 141200 1.014496659151786e+00 -6.056633779084986e+00 -6.033242699549225e+00 3.353348863298372e+00 4.487664061750570e+00 9.319395643766569e+03 + 141220 9.736842024005447e-01 -5.982301170022232e+00 -6.067746071573859e+00 3.712569755154459e+00 4.221931907889236e+00 9.426186998773475e+03 + 141240 9.617641525119370e-01 -5.951982066857266e+00 -6.035442762282052e+00 3.974889991080258e+00 4.495645762450260e+00 9.326158613294971e+03 + 141260 1.029320540777737e+00 -6.040648165187566e+00 -5.959920431303212e+00 3.505469023021348e+00 4.969020163561749e+00 9.094427259907759e+03 + 141280 9.875343725921770e-01 -5.967881427458170e+00 -6.009298894153105e+00 3.892703649416815e+00 4.654878146322243e+00 9.245608769350609e+03 + 141300 1.004000578093182e+00 -5.980530047746252e+00 -6.019062288346904e+00 3.738870420153007e+00 4.517612331779099e+00 9.275663200677953e+03 + 141320 9.898567604551874e-01 -5.946921836710097e+00 -6.055306890354071e+00 3.960407259145301e+00 4.338043508588762e+00 9.387600233710555e+03 + 141340 1.003409714762444e+00 -5.954736996179795e+00 -6.025439686042429e+00 4.000539419814517e+00 4.594553633417381e+00 9.295323515626227e+03 + 141360 1.050138721125615e+00 -6.014553387524312e+00 -6.037529100276554e+00 3.620434675669820e+00 4.488504577566387e+00 9.332599284020900e+03 + 141380 1.014948745599096e+00 -5.956235385869240e+00 -5.988026770453421e+00 3.970006449783819e+00 4.787455399800590e+00 9.180324299223661e+03 + 141400 1.008376528857462e+00 -5.940272961427265e+00 -6.000319095568400e+00 4.046751586574173e+00 4.701957392226553e+00 9.217984286201090e+03 + 141420 1.042282943946845e+00 -5.981289389704787e+00 -6.009819210059625e+00 3.785965672385986e+00 4.622143028933072e+00 9.247200175719410e+03 + 141440 1.043389738560972e+00 -5.973973967391723e+00 -5.998117719773798e+00 3.796829680706877e+00 4.658192518295397e+00 9.211284237683783e+03 + 141460 1.049973237070911e+00 -5.974610867961662e+00 -6.010088325621212e+00 3.832711939192586e+00 4.628994887192618e+00 9.248045090373784e+03 + 141480 9.856353910073936e-01 -5.872350682940461e+00 -6.030281705590166e+00 4.430477351003837e+00 4.523612979202460e+00 9.310221950251613e+03 + 141500 1.094852320423915e+00 -6.030770292825814e+00 -6.002127256903139e+00 3.575721172615216e+00 4.740193917378697e+00 9.223560225688245e+03 + 141520 1.002548746000000e+00 -5.893710241434317e+00 -6.010223148557893e+00 4.240847041340434e+00 4.571811898322761e+00 9.248444762372636e+03 + 141540 1.096090919969329e+00 -6.036114783093078e+00 -5.958350855130687e+00 3.551108919685816e+00 4.997641427974829e+00 9.089632304879780e+03 + 141560 1.045250521026980e+00 -5.970255347940622e+00 -6.008056563159828e+00 3.889484182805476e+00 4.672423755297642e+00 9.241781394227923e+03 + 141580 1.030683709581593e+00 -5.964883530541449e+00 -6.034062025869428e+00 3.902590036932113e+00 4.505356411421309e+00 9.321891699754453e+03 + 141600 1.051152989156530e+00 -6.019141668627091e+00 -5.997305045410230e+00 3.581932894701833e+00 4.707322164419569e+00 9.208781417289596e+03 + 141620 9.923238020042643e-01 -5.957025928739258e+00 -5.963957881092998e+00 3.970087832479134e+00 4.930283489347799e+00 9.106713194566510e+03 + 141640 9.815858782634215e-01 -5.965825807573410e+00 -6.000506403483266e+00 3.844340741284245e+00 4.645199392764978e+00 9.218591295164460e+03 + 141660 1.019925299904355e+00 -6.048205966553680e+00 -5.958491160784597e+00 3.456635971742735e+00 4.971792269790132e+00 9.090066627262768e+03 + 141680 1.001210581587734e+00 -6.044873883275864e+00 -5.978163979940311e+00 3.491459476902040e+00 4.874518065178965e+00 9.150121781112641e+03 + 141700 1.024266102268441e+00 -6.100128644344905e+00 -5.977549582267455e+00 3.150897502713097e+00 4.854765446210365e+00 9.148249470543460e+03 + 141720 8.916198222627948e-01 -5.920832729548112e+00 -6.021505051829986e+00 4.105865387718702e+00 4.527789334184658e+00 9.283189159539441e+03 + 141740 9.998075039834057e-01 -6.095855681469897e+00 -6.001302177405094e+00 3.174716221088308e+00 4.717657073535867e+00 9.221065941595492e+03 + 141760 9.192097224682672e-01 -5.987577876302164e+00 -6.046774304328042e+00 3.799407642252626e+00 4.459492591910403e+00 9.361195924863256e+03 + 141780 9.445068678504496e-01 -6.034281019726019e+00 -6.044552441291101e+00 3.504477944360279e+00 4.445497852236227e+00 9.354320379923614e+03 + 141800 9.850064074616284e-01 -6.099480375510989e+00 -6.001499315171895e+00 3.123502340826925e+00 4.686124751814091e+00 9.221661916059093e+03 + 141820 9.353130997985565e-01 -6.026393856622533e+00 -6.022079995445178e+00 3.564320443441181e+00 4.589091301889416e+00 9.284955839328552e+03 + 141840 9.768670996770961e-01 -6.082097873160181e+00 -6.028410819218248e+00 3.220268853999540e+00 4.528548225778868e+00 9.304474137151225e+03 + 141860 9.340788116085329e-01 -6.006797864839420e+00 -6.007033555084535e+00 3.658235856278199e+00 4.656882486417803e+00 9.238666043791689e+03 + 141880 1.032612029671214e+00 -6.135757858655850e+00 -5.946721232059984e+00 3.005109744250366e+00 5.090587307487256e+00 9.054206587493045e+03 + 141900 9.694995961509025e-01 -6.014555211385390e+00 -5.975979135865552e+00 3.655149753707003e+00 4.876659548970305e+00 9.143453577473605e+03 + 141920 1.018078996903040e+00 -6.046732447701013e+00 -5.973917602483297e+00 3.471901531389994e+00 4.890015640690995e+00 9.137141519424158e+03 + 141940 1.039177700143413e+00 -6.031613439680869e+00 -5.985591131026885e+00 3.546934726198931e+00 4.811201944419356e+00 9.172872084839390e+03 + 141960 1.033790809398444e+00 -5.973328423817815e+00 -6.017317592531891e+00 3.806633526622475e+00 4.554040912564389e+00 9.270306603429259e+03 + 141980 1.010613518134506e+00 -5.902777376837367e+00 -5.998089968504837e+00 4.188496949899607e+00 4.641197298969103e+00 9.211200695012167e+03 + 142000 1.085989377118981e+00 -5.988551024929858e+00 -6.037586731496352e+00 3.740986665128835e+00 4.459416049772964e+00 9.332799712749376e+03 + 142020 1.075967449344958e+00 -5.962875558030481e+00 -6.017958792207370e+00 3.896025813869053e+00 4.579729359122413e+00 9.272263114751131e+03 + 142040 1.050914389592182e+00 -5.923077000341830e+00 -6.023369420478124e+00 4.108783720181778e+00 4.532889123557322e+00 9.288921579586791e+03 + 142060 9.898549394867717e-01 -5.835474626863780e+00 -6.059301056624584e+00 4.544648944894635e+00 4.259402948180038e+00 9.399960356058997e+03 + 142080 1.007299785204346e+00 -5.871988965834976e+00 -6.010120530617906e+00 4.353042719287075e+00 4.559869898512924e+00 9.248131814015062e+03 + 142100 1.028874016260903e+00 -5.915968114960552e+00 -5.993505069272464e+00 4.169829871874262e+00 4.724600681410362e+00 9.197103460815284e+03 + 142120 1.041062544570025e+00 -5.949924961931789e+00 -6.040554018836059e+00 3.952181820744643e+00 4.431775751199092e+00 9.341917643926519e+03 + 142140 1.038253447292529e+00 -5.965403382672638e+00 -6.000938914415531e+00 3.848457240493013e+00 4.644406718119555e+00 9.219946602703412e+03 + 142160 9.717387905417684e-01 -5.889732832903052e+00 -6.065346806235516e+00 4.308769550061026e+00 4.300366939011473e+00 9.418740722976783e+03 + 142180 9.600550569993933e-01 -5.896121343948279e+00 -6.055001655958865e+00 4.252474326961165e+00 4.340158988747556e+00 9.386663050480975e+03 + 142200 9.989612713387177e-01 -5.978506378029313e+00 -6.024550376888639e+00 3.798361880046777e+00 4.533970113310733e+00 9.292582508432160e+03 + 142220 9.701679759790333e-01 -5.956276431651458e+00 -6.043077060742815e+00 3.914791548917440e+00 4.416368904320928e+00 9.349771173021309e+03 + 142240 9.864297481616576e-01 -5.999418203416937e+00 -6.025839808031574e+00 3.710761903742735e+00 4.559044961315392e+00 9.296547119568961e+03 + 142260 1.031589454125466e+00 -6.082048271402744e+00 -6.008292101447406e+00 3.259860461572296e+00 4.683379803186260e+00 9.242529125631792e+03 + 142280 1.016206748975860e+00 -6.072456171134401e+00 -6.022243432512639e+00 3.318849047931903e+00 4.607178363494247e+00 9.285466238119976e+03 + 142300 9.858973379806485e-01 -6.038551832869407e+00 -5.985631719274734e+00 3.480776706664734e+00 4.784652188286460e+00 9.173000170833815e+03 + 142320 9.534620895438528e-01 -5.995974948553473e+00 -6.009262741024678e+00 3.677424332527555e+00 4.601123771878659e+00 9.245485222882207e+03 + 142340 9.489995838093430e-01 -5.989588171874563e+00 -5.979357207521215e+00 3.810090324967979e+00 4.868838105521526e+00 9.153762590515036e+03 + 142360 9.500831472902470e-01 -5.987758019551035e+00 -6.008425495397796e+00 3.769934879740749e+00 4.651259035147090e+00 9.242938058384516e+03 + 142380 1.023676604158108e+00 -6.091337946633017e+00 -6.002438846524937e+00 3.216520128650160e+00 4.726992518562037e+00 9.224551582208713e+03 + 142400 1.013586864427438e+00 -6.072448578674462e+00 -5.983697261469882e+00 3.319816177805480e+00 4.829439975416133e+00 9.167087563257079e+03 + 142420 1.022026477152856e+00 -6.080068177248421e+00 -5.983484283676161e+00 3.259589680829872e+00 4.814189344031015e+00 9.166428147024097e+03 + 142440 9.895899956530062e-01 -6.026610351980243e+00 -5.971528076764933e+00 3.567814229968127e+00 4.884105178208978e+00 9.129851227510797e+03 + 142460 1.010728375195445e+00 -6.050949332534872e+00 -5.977266161939693e+00 3.442969799816917e+00 4.866069967808233e+00 9.147411440921094e+03 + 142480 9.812315753803259e-01 -6.001184729880938e+00 -6.020532297198506e+00 3.701712320875436e+00 4.590615595311595e+00 9.280150625260138e+03 + 142500 1.019444973036665e+00 -6.050085042662143e+00 -6.005232460303950e+00 3.391845757584712e+00 4.649396226400144e+00 9.233115279460686e+03 + 142520 1.029499258447256e+00 -6.057401513283143e+00 -6.000540998176605e+00 3.433233313639404e+00 4.759735190517420e+00 9.218714593633642e+03 + 142540 9.618571081634936e-01 -5.951746004969213e+00 -5.999166428194438e+00 3.941791989701279e+00 4.669496581255256e+00 9.214502083700158e+03 + 142560 1.001727373234672e+00 -6.004722465743097e+00 -5.996221575610094e+00 3.678935239312044e+00 4.727748665964242e+00 9.205436810204093e+03 + 142580 9.480885807851986e-01 -5.918878042020682e+00 -5.998090536997521e+00 4.113115086089448e+00 4.658264681838456e+00 9.211156645162946e+03 + 142600 1.048312946464728e+00 -6.060417564157462e+00 -5.975054610638480e+00 3.367626782042234e+00 4.857794071022595e+00 9.140636609128493e+03 + 142620 1.019216192891963e+00 -6.011375754087511e+00 -6.003825778553175e+00 3.639902134216960e+00 4.683255262090052e+00 9.228783407872977e+03 + 142640 9.882163786831829e-01 -5.962273561268762e+00 -5.964831452257936e+00 3.842188508273817e+00 4.827500702381627e+00 9.109373022364780e+03 + 142660 1.022600669047640e+00 -6.006887851033656e+00 -5.956866279247644e+00 3.665691168348492e+00 4.952922774356986e+00 9.085086920442895e+03 + 142680 1.049926383602889e+00 -6.037773493208575e+00 -5.947468761277122e+00 3.514185640661143e+00 5.032729386023646e+00 9.056488991712788e+03 + 142700 1.021219795649507e+00 -5.981882270770957e+00 -5.995665069764787e+00 3.788894575842684e+00 4.709751611138866e+00 9.203741779564223e+03 + 142720 1.024966490489663e+00 -5.969496319399387e+00 -5.988248490353747e+00 3.868447438090159e+00 4.760769570581144e+00 9.180991001768512e+03 + 142740 1.055866591551193e+00 -5.989928265178365e+00 -5.958941048449887e+00 3.730951483933304e+00 4.908884877644520e+00 9.091422519873271e+03 + 142760 1.095657879687061e+00 -6.008336664920087e+00 -5.982331836525477e+00 3.605687774639610e+00 4.755011523515647e+00 9.162888183519692e+03 + 142780 9.958254094129426e-01 -5.815371353214683e+00 -5.995108840829507e+00 4.717870584141266e+00 4.685790115970634e+00 9.201999632085857e+03 + 142800 1.068792494073418e+00 -5.880290535489213e+00 -5.953758514181800e+00 4.398506087079436e+00 4.976641584293638e+00 9.075588118607597e+03 + 142820 1.171344088723258e+00 -5.992870329852718e+00 -5.985252137904786e+00 3.701995812048761e+00 4.745740649125178e+00 9.171834879952445e+03 + 142840 1.038292397008148e+00 -5.769439035492558e+00 -6.093083061941872e+00 4.920606220133546e+00 4.062192136510355e+00 9.505003950539349e+03 + 142860 1.040854983894000e+00 -5.765640372611668e+00 -6.070115187477225e+00 4.925792759288347e+00 4.177451255004997e+00 9.433558859541592e+03 + 142880 1.083892364367855e+00 -5.837398419737574e+00 -6.043075261630007e+00 4.540640632548518e+00 4.359612378013749e+00 9.349745829748987e+03 + 142900 1.083050220023592e+00 -5.855956581785444e+00 -6.024990393755004e+00 4.474023076753097e+00 4.503404770526022e+00 9.293906311276118e+03 + 142920 1.058499636185399e+00 -5.850904018880387e+00 -6.039179486100780e+00 4.516723776860369e+00 4.435616908546479e+00 9.337695721105898e+03 + 142940 1.093233512574005e+00 -5.942965610034361e+00 -6.016498762209756e+00 4.027711076425636e+00 4.605472337415993e+00 9.267773322001169e+03 + 142960 1.074025373600346e+00 -5.962304428774550e+00 -6.017148776779352e+00 3.914921311431216e+00 4.599996578052219e+00 9.269772369297718e+03 + 142980 1.114653814353787e+00 -6.067129309714629e+00 -5.966810141681367e+00 3.310872852441630e+00 4.886921039629700e+00 9.115440435412678e+03 + 143000 9.644143239396895e-01 -5.879117943352171e+00 -5.991867773820264e+00 4.378232663692804e+00 4.730805689165137e+00 9.192091812818011e+03 + 143020 1.019796335116242e+00 -5.985815115387457e+00 -5.980709999230152e+00 3.805512179011711e+00 4.834826546001127e+00 9.157916864582157e+03 + 143040 1.035987757969618e+00 -6.030734295820723e+00 -5.981186633486726e+00 3.551762044729329e+00 4.836272389327107e+00 9.159381494778885e+03 + 143060 9.884198835724802e-01 -5.977048389649038e+00 -5.969308873895418e+00 3.838289753524994e+00 4.882731250668472e+00 9.123058810185208e+03 + 143080 9.953583068783813e-01 -5.999776818724980e+00 -5.960280502096255e+00 3.726740549890734e+00 4.953534512008114e+00 9.095497602818015e+03 + 143100 9.920789540924153e-01 -6.002597878325419e+00 -5.978398854958395e+00 3.704329074406661e+00 4.843283611366878e+00 9.150840018443323e+03 + 143120 9.908955265973325e-01 -6.007824424275439e+00 -5.992937248101034e+00 3.657266956603045e+00 4.742751425979547e+00 9.195388443355501e+03 + 143140 9.938459515122293e-01 -6.019248223096881e+00 -6.000418311489446e+00 3.616649479811765e+00 4.724773746181054e+00 9.218315976803462e+03 + 143160 1.019046575549265e+00 -6.061282033957120e+00 -6.004059930903273e+00 3.360345409239273e+00 4.688923580066292e+00 9.229520592024382e+03 + 143180 9.908524969450737e-01 -6.023884561524197e+00 -6.029648822217053e+00 3.586266130925079e+00 4.553166854010239e+00 9.308297737400046e+03 + 143200 1.019004037398567e+00 -6.071859029278377e+00 -5.973011158537732e+00 3.320662602099191e+00 4.888262372550537e+00 9.134391687265306e+03 + 143220 1.013192699346962e+00 -6.067033069506929e+00 -5.981346321444700e+00 3.355770482760747e+00 4.847797050115471e+00 9.159877250343457e+03 + 143240 9.703230209736557e-01 -6.005240798331498e+00 -6.000551397854529e+00 3.758893499769442e+00 4.785820762990580e+00 9.218731755714207e+03 + 143260 9.777612806289899e-01 -6.015686162632171e+00 -6.020828834811243e+00 3.599351322991653e+00 4.569821303513477e+00 9.281111852829643e+03 + 143280 1.037132512269292e+00 -6.101701990771929e+00 -5.984046903817799e+00 3.137331009936041e+00 4.812924726292515e+00 9.168160908455964e+03 + 143300 1.017483713298927e+00 -6.067810860020703e+00 -5.975745111138258e+00 3.429310495775940e+00 4.957966272987539e+00 9.142747554677597e+03 + 143320 1.001701053967201e+00 -6.039020616099960e+00 -6.010316649574150e+00 3.481512072326722e+00 4.646334690042393e+00 9.248732795863594e+03 + 143340 9.429618201607630e-01 -5.942260997003803e+00 -5.981227165646139e+00 4.053180597943015e+00 4.829430827603613e+00 9.159484370498229e+03 + 143360 9.573825642428547e-01 -5.947405151181627e+00 -5.964103275443799e+00 3.953679777623731e+00 4.857796564083962e+00 9.107178738114002e+03 + 143380 9.909587528747177e-01 -5.971671506017308e+00 -5.958668849105213e+00 3.875537923630510e+00 4.950201191774413e+00 9.090567240228469e+03 + 143400 9.728773850022959e-01 -5.912766620098158e+00 -6.045065966579863e+00 4.111757837808510e+00 4.352074517052866e+00 9.355909839969980e+03 + 143420 1.039247182666702e+00 -5.976327385477138e+00 -5.968749075673207e+00 3.785697706329996e+00 4.829213533963820e+00 9.121369585638840e+03 + 143440 9.910360917759028e-01 -5.873124420696885e+00 -6.005601026030686e+00 4.357691327980401e+00 4.596990159465297e+00 9.234241727177148e+03 + 143460 1.039106640999686e+00 -5.915652273699784e+00 -6.020688190551758e+00 4.159732232187347e+00 4.556599743367712e+00 9.280629548374067e+03 + 143480 1.059320112497310e+00 -5.920105466146627e+00 -6.051041610130254e+00 4.080998883592365e+00 4.329143282535579e+00 9.374380273595882e+03 + 143500 1.028989859516793e+00 -5.861530406938961e+00 -5.994089601992082e+00 4.442579873633837e+00 4.681404462169681e+00 9.198894362493518e+03 + 143520 1.005064874320691e+00 -5.819507195159078e+00 -5.991548112444883e+00 4.656026098072791e+00 4.668140527771795e+00 9.191080956019543e+03 + 143540 1.023443437908404e+00 -5.845007038240031e+00 -6.039265476144996e+00 4.477523671901001e+00 4.362061660054576e+00 9.337974898463488e+03 + 143560 1.141437484198878e+00 -6.024625374393328e+00 -6.020050064001441e+00 3.523847795420421e+00 4.550119935717634e+00 9.278706092752509e+03 + 143580 1.037560196757685e+00 -5.889292628200973e+00 -6.036716455520191e+00 4.227397161992857e+00 4.380866731762366e+00 9.330108210897586e+03 + 143600 1.074574940066438e+00 -5.974381151766103e+00 -5.969536640676546e+00 3.804035273672960e+00 4.831853206034862e+00 9.123761100624386e+03 + 143620 1.025863708981987e+00 -5.939372409630199e+00 -5.966803862184516e+00 4.031281334753073e+00 4.873765689182622e+00 9.115379252716872e+03 + 143640 9.965258894866950e-01 -5.933248211228533e+00 -5.990476190842358e+00 4.054289056186426e+00 4.725677141242621e+00 9.187818645921463e+03 + 143660 1.016271450202795e+00 -6.001761796687785e+00 -5.971560938256169e+00 3.722598472716184e+00 4.896016475398263e+00 9.129934479923877e+03 + 143680 1.054378766366740e+00 -6.092996396786535e+00 -5.988905248468065e+00 3.143331870482801e+00 4.741039352180602e+00 9.183026145573014e+03 + 143700 9.456376595879629e-01 -5.960515907759085e+00 -6.044429421667810e+00 3.851721803474777e+00 4.369877421036568e+00 9.353925453000766e+03 + 143720 9.631501900113086e-01 -6.005923202668134e+00 -5.977990645994030e+00 3.649647463359674e+00 4.810040526331557e+00 9.149608182424976e+03 + 143740 9.040649337756710e-01 -5.926686671724698e+00 -6.000311243950444e+00 4.112443082967743e+00 4.689679395881781e+00 9.217953821855735e+03 + 143760 9.599376745611714e-01 -6.011369168994648e+00 -5.959550385350087e+00 3.605930623228148e+00 4.903482097846068e+00 9.093287827184857e+03 + 143780 9.874584965527364e-01 -6.049215391736672e+00 -6.004565222820297e+00 3.360445156225188e+00 4.616833335734320e+00 9.231071411556037e+03 + 143800 1.060655303099585e+00 -6.153037678239428e+00 -5.970254833759023e+00 2.872069574249736e+00 4.921636952809988e+00 9.125977779248944e+03 + 143820 9.330518483103182e-01 -5.959911877105672e+00 -5.995723343930269e+00 3.912969435908378e+00 4.707334451594957e+00 9.203905125697520e+03 + 143840 9.816754693393441e-01 -6.025141425626161e+00 -5.980401404740652e+00 3.638088979206262e+00 4.894993102626707e+00 9.156965128476388e+03 + 143860 1.058628340156113e+00 -6.129267750195740e+00 -5.976833341808441e+00 3.010949824351136e+00 4.886251786459464e+00 9.146074848882672e+03 + 143880 9.904539789550721e-01 -6.018650270942724e+00 -5.992525777153535e+00 3.570262962020410e+00 4.720273848110282e+00 9.194114196513798e+03 + 143900 9.858467773739675e-01 -6.001806244166477e+00 -5.990046620022056e+00 3.674666049900069e+00 4.742191631533284e+00 9.186490743652348e+03 + 143920 9.706999507522228e-01 -5.965324733470921e+00 -6.014089077404838e+00 3.886196252471652e+00 4.606183843345264e+00 9.260327842593188e+03 + 143940 1.074541068784169e+00 -6.102902188370853e+00 -5.989193402554600e+00 3.145894188303734e+00 4.798827632838398e+00 9.183895265783778e+03 + 143960 9.896227914799409e-01 -5.960522621961890e+00 -6.037138986237969e+00 3.887453232460321e+00 4.447510212443023e+00 9.331416781630693e+03 + 143980 1.017054348292765e+00 -5.987057445264989e+00 -5.991647073566656e+00 3.736126215753573e+00 4.709771859802719e+00 9.191431309678665e+03 + 144000 1.022210512030115e+00 -5.979876391222276e+00 -5.978317748697746e+00 3.804485241539632e+00 4.813435208114633e+00 9.150575148061374e+03 + 144020 1.019506348873456e+00 -5.957407019379268e+00 -5.991794151450773e+00 3.908318973119612e+00 4.710862739373541e+00 9.191880949439386e+03 + 144040 1.081909361299180e+00 -6.027101171231140e+00 -6.005364235839410e+00 3.508432198633287e+00 4.633249045432477e+00 9.233525483210513e+03 + 144060 1.058050817585162e+00 -5.970070189010050e+00 -5.995677086120103e+00 3.865495883729396e+00 4.718457117868953e+00 9.203789048286679e+03 + 144080 1.045439195547904e+00 -5.930207067719433e+00 -5.990963257512362e+00 4.100621600936991e+00 4.751750157156009e+00 9.189324728198761e+03 + 144100 1.002310321649499e+00 -5.843141820207396e+00 -6.017425792052732e+00 4.587162958620532e+00 4.586397421927137e+00 9.270568640940879e+03 + 144120 1.113194084908791e+00 -5.977711090998692e+00 -6.014225874473762e+00 3.789250978116157e+00 4.579577440757830e+00 9.260756263992034e+03 + 144140 1.074339933024374e+00 -5.892846716401976e+00 -6.058872254665230e+00 4.227364878080413e+00 4.274020545003800e+00 9.398661326688747e+03 + 144160 1.084576815986524e+00 -5.885817982326344e+00 -6.080039586433305e+00 4.267204894341847e+00 4.151954387863579e+00 9.464390209110636e+03 + 144180 1.099266312391600e+00 -5.896018113260707e+00 -6.025156422859846e+00 4.256711920881668e+00 4.515179763074593e+00 9.294407779454898e+03 + 144200 1.139527688894762e+00 -5.956281023152593e+00 -5.969595845379710e+00 3.963682963740604e+00 4.887227194050419e+00 9.123904570726650e+03 + 144220 1.088409644539106e+00 -5.889807148574015e+00 -5.998751155450886e+00 4.321051029984109e+00 4.695477683466536e+00 9.213197423590684e+03 + 144240 1.090722640484478e+00 -5.915033335285470e+00 -6.058294199434290e+00 4.166893839248626e+00 4.344267787759019e+00 9.396848877641376e+03 + 144260 1.031690603948053e+00 -5.866787428604852e+00 -6.087184945505877e+00 4.342914940429584e+00 4.077358291978386e+00 9.486639844870337e+03 + 144280 1.081580318112931e+00 -5.995840430430276e+00 -6.040969974633354e+00 3.638987312003587e+00 4.379846485415114e+00 9.343237265402704e+03 + 144300 9.895424516891865e-01 -5.914372512536897e+00 -5.997117801620967e+00 4.161830789921556e+00 4.686694535208722e+00 9.208177127617755e+03 + 144320 1.028894866350819e+00 -6.014172289051032e+00 -5.940742022683645e+00 3.675536627769886e+00 5.097184580548415e+00 9.036010459950436e+03 + 144340 1.003021136453330e+00 -6.004606227890990e+00 -5.969709671151866e+00 3.665370519414098e+00 4.865751948434852e+00 9.124293362559742e+03 + 144360 1.009401528671106e+00 -6.033870525334589e+00 -5.989728921704151e+00 3.515393466631568e+00 4.768861385568625e+00 9.185540045976764e+03 + 144380 9.632569665107366e-01 -5.981185782711842e+00 -6.013656363404124e+00 3.773713924353793e+00 4.587262825212588e+00 9.259018927265357e+03 + 144400 9.753166321323964e-01 -6.011151492597649e+00 -5.979733154133045e+00 3.588571784611976e+00 4.768980746047892e+00 9.154947755014713e+03 + 144420 1.045682136508665e+00 -6.123657601323297e+00 -5.957476263850237e+00 3.018691810421093e+00 4.972930766670261e+00 9.086967654820019e+03 + 144440 9.535999721654209e-01 -5.992495236923250e+00 -5.984232388350178e+00 3.728768940104316e+00 4.776215495282580e+00 9.168702510670742e+03 + 144460 9.513768366710755e-01 -5.990304478016673e+00 -5.990258613430318e+00 3.761729979195532e+00 4.761993340747908e+00 9.187182371330233e+03 + 144480 9.806073741835450e-01 -6.032380883743617e+00 -6.006958534409096e+00 3.496343115530336e+00 4.642322179505001e+00 9.238429535308773e+03 + 144500 9.745920288590990e-01 -6.020277490444245e+00 -5.992884226306334e+00 3.543309841916659e+00 4.700606203690469e+00 9.195208122482767e+03 + 144520 9.340482544890468e-01 -5.951720121933333e+00 -6.026634266697121e+00 3.888694646812982e+00 4.458526034652875e+00 9.299007190604298e+03 + 144540 1.019799356386708e+00 -6.067388832615380e+00 -5.997753120263240e+00 3.304281100630583e+00 4.704140137048229e+00 9.210178536369178e+03 + 144560 9.479756135049967e-01 -5.947418971767434e+00 -6.009805578760052e+00 3.945855066478356e+00 4.587621514830509e+00 9.247168177007085e+03 + 144580 1.068742493181399e+00 -6.109168809382945e+00 -5.993523557016772e+00 3.097755680432335e+00 4.761808615563867e+00 9.197164489598061e+03 + 144600 1.074366698628719e+00 -6.094852414082236e+00 -5.954083720782201e+00 3.243482759870324e+00 5.051798380684007e+00 9.076618156033925e+03 + 144620 9.272528846528260e-01 -5.852761415177568e+00 -6.010219164835382e+00 4.519477897279837e+00 4.615331132236661e+00 9.248373320994437e+03 + 144640 1.021122445897783e+00 -5.963309523337470e+00 -5.973642789842378e+00 3.885903857799278e+00 4.826568642460275e+00 9.136313122453925e+03 + 144660 1.053579758318158e+00 -5.978359457042215e+00 -6.022590149626675e+00 3.751495968461701e+00 4.497516486964179e+00 9.286524824209167e+03 + 144680 1.087530503184823e+00 -5.995616671637519e+00 -5.975483328181280e+00 3.734232699615602e+00 4.849841473366154e+00 9.141954048594871e+03 + 144700 1.058618305535936e+00 -5.923067438614238e+00 -6.007527054110591e+00 4.105628317559749e+00 4.620648135296428e+00 9.240172208885006e+03 + 144720 1.014105610612681e+00 -5.834858279590419e+00 -6.039659591302023e+00 4.548796176677758e+00 4.372795351929168e+00 9.339182477500692e+03 + 144740 1.065971384166577e+00 -5.895465308475139e+00 -5.987356337836994e+00 4.226817112511135e+00 4.699164601824532e+00 9.178278897593535e+03 + 144760 1.089920194613861e+00 -5.924744779308169e+00 -6.011976713913104e+00 4.073906463849817e+00 4.573007196250026e+00 9.253854196730705e+03 + 144780 1.081875838801640e+00 -5.914778047749969e+00 -5.993459270111188e+00 4.157130119845022e+00 4.705330365167094e+00 9.196961348463303e+03 + 144800 1.030758418947701e+00 -5.848285047751322e+00 -6.066881885614263e+00 4.472339368284453e+00 4.217122497524109e+00 9.423451258036243e+03 + 144820 1.046777032082592e+00 -5.896318539539203e+00 -6.000549380695677e+00 4.299794026186107e+00 4.701284406595089e+00 9.218693037413834e+03 + 144840 9.174913557389572e-01 -5.745428229510479e+00 -6.034182019329323e+00 5.071579430675111e+00 4.413510485030745e+00 9.322295719849444e+03 + 144860 1.033346144513867e+00 -5.977513232519722e+00 -5.991807082905179e+00 3.870698576724243e+00 4.788621075844745e+00 9.191910749924802e+03 + 144880 1.029691638621359e+00 -6.035682330906645e+00 -6.007862760977277e+00 3.465442370621318e+00 4.625186646220284e+00 9.241197659497673e+03 + 144900 9.014181341543103e-01 -5.895490161570365e+00 -6.065428932962612e+00 4.244541878251824e+00 4.268727154977660e+00 9.418986874853807e+03 + 144920 1.022773368964170e+00 -6.107727929010672e+00 -5.963183272421752e+00 3.103350451936961e+00 4.933348238283855e+00 9.104377040485999e+03 + 144940 9.202254579638478e-01 -5.971516355608389e+00 -6.029853712228320e+00 3.823675503586328e+00 4.488693374197928e+00 9.308916647082553e+03 + 144960 9.999674536031598e-01 -6.098616511009944e+00 -6.020479729250301e+00 3.161547198417656e+00 4.610220690909427e+00 9.280032580656794e+03 + 144980 9.353313826043863e-01 -6.008271943074234e+00 -6.014039800343128e+00 3.649184272402096e+00 4.616064343391082e+00 9.260241115020186e+03 + 145000 9.402824927763279e-01 -6.016044062625248e+00 -6.030840056288740e+00 3.671387140918637e+00 4.586426255630248e+00 9.311966398989898e+03 + 145020 1.014612525758448e+00 -6.123028949670284e+00 -5.990771384741592e+00 3.098717688129210e+00 4.858161092741788e+00 9.188756428489314e+03 + 145040 9.856358195201276e-01 -6.074171252950487e+00 -6.037138641460466e+00 3.280297313348916e+00 4.492944299302723e+00 9.331433168950050e+03 + 145060 9.910961800157465e-01 -6.075562049968168e+00 -5.994832907714406e+00 3.302435634549190e+00 4.765994862164682e+00 9.201189289772547e+03 + 145080 9.265106746528887e-01 -5.968652506652664e+00 -6.004093556596342e+00 3.867260839283770e+00 4.663752846022420e+00 9.229619171935434e+03 + 145100 1.007630389315747e+00 -6.069471706922844e+00 -6.032385342674567e+00 3.326692324012121e+00 4.539647966622047e+00 9.316717724349959e+03 + 145120 1.004489994047310e+00 -6.045466677972623e+00 -5.975574500915295e+00 3.470004175051850e+00 4.871335871494471e+00 9.142236971032236e+03 + 145140 1.000361597229159e+00 -6.017020275008067e+00 -5.984367488565338e+00 3.600245583138165e+00 4.787742935894690e+00 9.169119170233715e+03 + 145160 1.043492840104798e+00 -6.056080637472655e+00 -5.976283730272459e+00 3.392190540375252e+00 4.850396730050258e+00 9.144377773847245e+03 + 145180 1.030687016017780e+00 -6.009220651392867e+00 -5.979208818897622e+00 3.693689881858887e+00 4.866022468362649e+00 9.153332159257750e+03 + 145200 1.084739891407558e+00 -6.060862086425541e+00 -6.000773103772461e+00 3.364293719803807e+00 4.709333956937799e+00 9.219431255154874e+03 + 145220 1.013861317247316e+00 -5.933185849791751e+00 -6.026473335328024e+00 4.073713051270901e+00 4.538041873129889e+00 9.298475839618830e+03 + 145240 1.024210170290731e+00 -5.928930607336943e+00 -6.008524868250376e+00 4.051050670610904e+00 4.594008107273903e+00 9.243223955405769e+03 + 145260 1.033253249543048e+00 -5.926389871113110e+00 -6.038677174131772e+00 4.082437446982111e+00 4.437666376644970e+00 9.336150055767594e+03 + 145280 1.024330032871510e+00 -5.903576431191135e+00 -6.010641276595285e+00 4.196602034441721e+00 4.581819123899811e+00 9.249739792479517e+03 + 145300 1.075815503310104e+00 -5.974940125914619e+00 -6.035925724369997e+00 3.865753458469554e+00 4.515564714647917e+00 9.327554911388850e+03 + 145320 1.050802755703566e+00 -5.938989548900341e+00 -6.016315849371900e+00 4.014762494409170e+00 4.570742910895151e+00 9.267183335682712e+03 + 145340 1.035284839996167e+00 -5.924478064644788e+00 -6.000709660989774e+00 4.127435987219649e+00 4.689702364205336e+00 9.219203640200816e+03 + 145360 1.096100206323709e+00 -6.032225134913777e+00 -5.999096805512743e+00 3.522833711056095e+00 4.713061705069236e+00 9.214278796387667e+03 + 145380 1.057844779514080e+00 -6.010001178175404e+00 -6.000964599435188e+00 3.659233380557971e+00 4.711122814090331e+00 9.220005172006977e+03 + 145400 9.812983468918689e-01 -5.951284538609361e+00 -6.013485944670389e+00 3.949656890903705e+00 4.592486791664799e+00 9.258465446992779e+03 + 145420 9.695403398682304e-01 -5.995059824520369e+00 -5.972667062485584e+00 3.749535344019309e+00 4.878118048891769e+00 9.133288935937293e+03 + 145440 9.492126248428828e-01 -6.011315618752801e+00 -5.949965760116690e+00 3.669124776310314e+00 5.021405158458803e+00 9.064105518136528e+03 + 145460 9.963536766049228e-01 -6.112316346535594e+00 -5.984779539855507e+00 3.151921438033155e+00 4.884257518247265e+00 9.170399251879613e+03 + 145480 9.768848009823462e-01 -6.105319595678480e+00 -6.000018195779527e+00 3.136104217100899e+00 4.740761150659663e+00 9.217126239879466e+03 + 145500 9.536619736909214e-01 -6.082586736577495e+00 -6.015892782011670e+00 3.183637609306931e+00 4.566604617280014e+00 9.265920349722568e+03 + 145520 9.315211007725590e-01 -6.054779123871855e+00 -5.991251516370577e+00 3.364999255031987e+00 4.729784608169813e+00 9.190217088988478e+03 + 145540 9.563276649230867e-01 -6.087915213814458e+00 -5.991565169624117e+00 3.201539102471016e+00 4.754795966333106e+00 9.191178015771033e+03 + 145560 9.464222445353853e-01 -6.063952163193084e+00 -6.006552729487130e+00 3.377321730575746e+00 4.706918161448993e+00 9.237150529073073e+03 + 145580 9.828026523752563e-01 -6.104394685498788e+00 -5.977180053670898e+00 3.115625257835192e+00 4.846111360191591e+00 9.147130278504867e+03 + 145600 9.419860758394146e-01 -6.026533706947342e+00 -5.959135884320141e+00 3.572825870383506e+00 4.959834597688239e+00 9.092038538306422e+03 + 145620 9.264686217235986e-01 -5.979390641820293e+00 -5.999140303428212e+00 3.836116567089472e+00 4.722710953886545e+00 9.214397839794090e+03 + 145640 9.718506940803160e-01 -6.018292394312661e+00 -5.992363561094612e+00 3.628937168428922e+00 4.777824541240939e+00 9.193604643203998e+03 + 145660 9.673341232956011e-01 -5.980989476808312e+00 -6.011925309605004e+00 3.811075606634886e+00 4.633437267411626e+00 9.253693502129914e+03 + 145680 1.017150124093664e+00 -6.026598991360386e+00 -5.998791858387049e+00 3.533938548676491e+00 4.693611409349309e+00 9.213365494635496e+03 + 145700 1.036336776721640e+00 -6.030979473267756e+00 -5.985283951640790e+00 3.513344734289950e+00 4.775735490831108e+00 9.171919334673577e+03 + 145720 1.008424842964302e+00 -5.970666558281130e+00 -6.016868246825199e+00 3.803343818416237e+00 4.538046573108002e+00 9.268903704054819e+03 + 145740 1.092679012282497e+00 -6.080622457259713e+00 -5.963750656243575e+00 3.281056566107306e+00 4.952152533394724e+00 9.106102564002424e+03 + 145760 9.896663383496291e-01 -5.917941202575729e+00 -6.032257001989129e+00 4.125334342474461e+00 4.468915331929934e+00 9.316303544804752e+03 + 145780 1.024669244691494e+00 -5.964500725380759e+00 -5.970629716091297e+00 3.845350468436670e+00 4.810156855318517e+00 9.127117786387407e+03 + 145800 1.033974309198313e+00 -5.975203785341843e+00 -6.021644452705235e+00 3.795847204324480e+00 4.529177705653829e+00 9.283610288832748e+03 + 145820 1.053974900331853e+00 -6.006010319967837e+00 -5.987273548350285e+00 3.634791705710557e+00 4.742381147844577e+00 9.178028983136453e+03 + 145840 9.686296009404674e-01 -5.881863325669591e+00 -6.009877685312694e+00 4.295581742821562e+00 4.560503479592733e+00 9.247382788318540e+03 + 145860 9.918676002531757e-01 -5.919795120908255e+00 -6.019832179645833e+00 4.068950686820813e+00 4.494522414864828e+00 9.278038021576484e+03 + 145880 1.012636813102866e+00 -5.956361530280740e+00 -6.073651006220183e+00 3.914609825497327e+00 4.241115504165304e+00 9.444522555556372e+03 + 145900 1.019826426751164e+00 -5.978890025242512e+00 -6.074609364966562e+00 3.745134671314812e+00 4.195499410099369e+00 9.447520761164520e+03 + 145920 9.596632627022854e-01 -5.904969280523870e+00 -6.074766042607113e+00 4.209163400356357e+00 4.234164116510363e+00 9.448006437426937e+03 + 145940 9.166657448468659e-01 -5.859188295659235e+00 -6.118582576476643e+00 4.396656850731762e+00 3.907174749142977e+00 9.584659018303391e+03 + 145960 9.451047375814985e-01 -5.918498155660906e+00 -6.042971738802627e+00 4.166058255374759e+00 4.451311678750261e+00 9.349436115981409e+03 + 145980 1.029244736227485e+00 -6.061080400523420e+00 -5.991988577991420e+00 3.338908209363752e+00 4.735644146267480e+00 9.192495451212404e+03 + 146000 9.342851060260058e-01 -5.934926355011434e+00 -6.031473250344757e+00 3.999009562269385e+00 4.444622348681677e+00 9.313919966606927e+03 + 146020 1.036109983915124e+00 -6.098624775872919e+00 -5.991098744529488e+00 3.200533173107086e+00 4.817964284680640e+00 9.189752132059140e+03 + 146040 1.004844848805031e+00 -6.064070847854333e+00 -5.971360041954200e+00 3.340589182457312e+00 4.872948976886724e+00 9.129357455780539e+03 + 146060 9.220943852611928e-01 -5.949768947245596e+00 -6.036265380636284e+00 3.988821093952277e+00 4.492145188143146e+00 9.328692514496652e+03 + 146080 9.394140042392169e-01 -5.980500558987492e+00 -6.012567318522181e+00 3.870543017006704e+00 4.686410721443521e+00 9.255631927328368e+03 + 146100 1.007636365126500e+00 -6.081441286611076e+00 -6.000896493096358e+00 3.246992156974399e+00 4.709492825602419e+00 9.219805047034175e+03 + 146120 1.010934195611452e+00 -6.084485848711070e+00 -6.006276504836556e+00 3.240557420672793e+00 4.689647576057099e+00 9.236349451632273e+03 + 146140 9.530579177429476e-01 -5.997143773545310e+00 -6.022395723529105e+00 3.703991101034936e+00 4.558990496501350e+00 9.285930150874072e+03 + 146160 9.153430128449697e-01 -5.935614127046904e+00 -6.039403185116655e+00 4.021666789973533e+00 4.425693957232191e+00 9.338408267679031e+03 + 146180 9.715258362893063e-01 -6.010076478124630e+00 -6.016760744284140e+00 3.625956441152251e+00 4.587574350477501e+00 9.268589037019037e+03 + 146200 9.912515427010384e-01 -6.030202372210554e+00 -5.980692373218643e+00 3.599761923024462e+00 4.884055998883595e+00 9.157864262854146e+03 + 146220 1.024582103101166e+00 -6.067747915930495e+00 -5.954168125094353e+00 3.358224248756162e+00 5.010416984153117e+00 9.076873524453042e+03 + 146240 9.670679323961847e-01 -5.963396194687419e+00 -6.002328294838356e+00 3.911769445813695e+00 4.688215302023986e+00 9.224167475698501e+03 + 146260 1.008773283356508e+00 -5.993052056678286e+00 -5.985069600499534e+00 3.719968805595022e+00 4.765805304254516e+00 9.171265388962431e+03 + 146280 1.027288565056898e+00 -5.947802140321048e+00 -6.015801507295537e+00 3.965727396987771e+00 4.575264508952228e+00 9.265604784411173e+03 + 146300 1.111955114151632e+00 -5.959920671568852e+00 -6.050366921944659e+00 3.891647098214544e+00 4.372290732044654e+00 9.372294528523209e+03 + 146320 1.087208159887513e+00 -5.848605863574324e+00 -6.040435353471667e+00 4.456346697323673e+00 4.354832080815507e+00 9.341605921023394e+03 + 146340 1.043880534879352e+00 -5.754364875933859e+00 -6.072309229424271e+00 4.926875901588481e+00 4.101190222116844e+00 9.440353048889740e+03 + 146360 1.169809082914887e+00 -5.930774781233576e+00 -6.016153246938061e+00 4.112759487924408e+00 4.622503125574386e+00 9.266667810748861e+03 + 146380 1.101922384045817e+00 -5.836258983292675e+00 -6.036339890320859e+00 4.507378846789016e+00 4.358483316212886e+00 9.328892319920233e+03 + 146400 1.116708983005252e+00 -5.877251382618168e+00 -6.006907448438943e+00 4.371097275739075e+00 4.626592081584846e+00 9.238199891018883e+03 + 146420 1.160910734506137e+00 -5.974314684826933e+00 -6.009129376328239e+00 3.891575052098006e+00 4.691663705941401e+00 9.245081919875582e+03 + 146440 1.079686478738224e+00 -5.901251396800552e+00 -6.009321596623297e+00 4.238402309887483e+00 4.617846498695905e+00 9.245667919054637e+03 + 146460 1.000436535070707e+00 -5.832051175285336e+00 -6.007973260775412e+00 4.533844618934726e+00 4.523672780195964e+00 9.241507304548446e+03 + 146480 1.043528295530512e+00 -5.937287004014801e+00 -5.964442604232580e+00 4.057515353812769e+00 4.901583695046736e+00 9.108179071638870e+03 + 146500 1.052968497102157e+00 -5.991292262785580e+00 -5.978799920304808e+00 3.744663598178206e+00 4.816396561886551e+00 9.152073395797621e+03 + 146520 9.450617676091623e-01 -5.866320667628278e+00 -6.044881260346232e+00 4.374563642292497e+00 4.349241086743588e+00 9.355310905864157e+03 + 146540 1.059459729669544e+00 -6.068117757063598e+00 -6.004002751691242e+00 3.325600830293661e+00 4.693759112906747e+00 9.229349639658469e+03 + 146560 9.762615968622409e-01 -5.976841463301147e+00 -6.021815879598275e+00 3.827370158705786e+00 4.569120100559249e+00 9.284153061544215e+03 + 146580 9.837622833302723e-01 -6.015081557244224e+00 -6.000876733763139e+00 3.659985856438309e+00 4.741552151056032e+00 9.219730120251721e+03 + 146600 9.895468458199043e-01 -6.047286768419053e+00 -5.980933209117491e+00 3.467008554364013e+00 4.848020960053704e+00 9.158608221394285e+03 + 146620 9.268175425018635e-01 -5.972631948408539e+00 -5.993802967006736e+00 3.904449500121281e+00 4.782882235125896e+00 9.198040363791337e+03 + 146640 9.730050360575444e-01 -6.054932920029318e+00 -5.991519495867454e+00 3.386141549431748e+00 4.750271244164841e+00 9.191037916374617e+03 + 146660 9.435965040782058e-01 -6.021032396404289e+00 -5.949270850708078e+00 3.600375730651872e+00 5.012441631102821e+00 9.061965545065597e+03 + 146680 9.069092825532131e-01 -5.968753422099710e+00 -6.001533519528506e+00 3.831560764744709e+00 4.643332372604881e+00 9.221760422436364e+03 + 146700 1.023129760213275e+00 -6.138774815565306e+00 -5.976199038212815e+00 2.906689225728219e+00 4.840224497806453e+00 9.144127640002300e+03 + 146720 9.106533745834371e-01 -5.964969595488947e+00 -6.027678269566131e+00 3.888959026707203e+00 4.528876116020059e+00 9.302208635157644e+03 + 146740 9.816642441512673e-01 -6.058059572114021e+00 -6.008261649549547e+00 3.448765028940618e+00 4.734712406509441e+00 9.242441817963208e+03 + 146760 9.602061028990557e-01 -6.009836657078118e+00 -6.030841297446315e+00 3.694795097062862e+00 4.574183201611086e+00 9.311973111244853e+03 + 146780 9.465773008191593e-01 -5.970769631690213e+00 -6.024705174694003e+00 3.890791281949823e+00 4.581085047523753e+00 9.293055208687261e+03 + 146800 1.051881201774814e+00 -6.102172420625910e+00 -5.968781686874832e+00 3.170689257803601e+00 4.936639493151633e+00 9.121459156711924e+03 + 146820 1.030034153027777e+00 -6.043764254290242e+00 -5.969213939520788e+00 3.450765145634434e+00 4.878844589664564e+00 9.122766742847803e+03 + 146840 9.578559505898195e-01 -5.907396640882239e+00 -5.982610396859833e+00 4.203198468786928e+00 4.771309442672460e+00 9.163731504778136e+03 + 146860 9.835758747559161e-01 -5.915158701652629e+00 -6.024708435846550e+00 4.089430708818883e+00 4.460379182310808e+00 9.293035843837541e+03 + 146880 1.041698229453244e+00 -5.973637069850342e+00 -5.969037742336551e+00 3.868327679966797e+00 4.894737730294616e+00 9.122227505274044e+03 + 146900 1.036591265634566e+00 -5.940698445555705e+00 -5.981523925160052e+00 4.046236107206683e+00 4.811809885595975e+00 9.160384753972750e+03 + 146920 1.137507595585855e+00 -6.068260593515021e+00 -5.980472154791829e+00 3.333383379054134e+00 4.837478179419690e+00 9.157186841484103e+03 + 146940 1.060253650914079e+00 -5.939315938293372e+00 -6.003284998534792e+00 4.033492218615823e+00 4.666171975529508e+00 9.227131020809828e+03 + 146960 1.078809901012547e+00 -5.962229592209948e+00 -5.983384166629034e+00 3.941872529699975e+00 4.820399689725773e+00 9.166109483097316e+03 + 146980 1.076939042687234e+00 -5.963376231277841e+00 -6.021608163384031e+00 3.844729617554468e+00 4.510352852038351e+00 9.283502056754358e+03 + 147000 1.065575680493418e+00 -5.957056636055171e+00 -5.988477482670197e+00 3.929533801357894e+00 4.749110437734119e+00 9.181704382120643e+03 + 147020 1.038781878793479e+00 -5.931090521878517e+00 -6.014556670254990e+00 4.016933121431184e+00 4.537657581108758e+00 9.261784148521132e+03 + 147040 1.054521931198552e+00 -5.974860904767612e+00 -6.032177421541622e+00 3.793301625074341e+00 4.464181316055677e+00 9.316115124706421e+03 + 147060 1.038106267173353e+00 -5.983094594282507e+00 -6.031167052647656e+00 3.750372570441196e+00 4.474333075319620e+00 9.312988281615584e+03 + 147080 9.994126646414436e-01 -5.965684668715010e+00 -6.050155479140535e+00 3.837214694255285e+00 4.352170228976258e+00 9.371652230757254e+03 + 147100 1.014509075177281e+00 -6.035644222920311e+00 -6.002347598644500e+00 3.488514158277843e+00 4.679708527505507e+00 9.224262476350224e+03 + 147120 9.005830134463917e-01 -5.908052361275734e+00 -6.023322909968011e+00 4.207686203989504e+00 4.545784875338691e+00 9.288758475968454e+03 + 147140 9.664849589515255e-01 -6.035920220072896e+00 -5.985951064684791e+00 3.488929921140056e+00 4.775860544080357e+00 9.173989277730780e+03 + 147160 9.833159863705071e-01 -6.077120020470039e+00 -5.993662525977967e+00 3.268260743270071e+00 4.747486591649080e+00 9.197618573484098e+03 + 147180 1.071702441569530e+00 -6.215868830488357e+00 -5.963522215591906e+00 2.507723693578843e+00 4.956737006826712e+00 9.105428332483261e+03 + 147200 9.063400326202361e-01 -5.972899672621519e+00 -5.979447507094841e+00 3.892546192647443e+00 4.854947513827520e+00 9.154057849802955e+03 + 147220 9.238033691271338e-01 -5.994680416787252e+00 -5.973492394366275e+00 3.736256850303139e+00 4.857921753880263e+00 9.135848601139942e+03 + 147240 9.849302506238601e-01 -6.075127673092194e+00 -6.019546359866382e+00 3.248494218628837e+00 4.567650720351875e+00 9.277155519780332e+03 + 147260 9.900832801166953e-01 -6.073425549873228e+00 -5.999914128183327e+00 3.254102506932759e+00 4.676216466131912e+00 9.216800582905278e+03 + 147280 9.358519618907827e-01 -5.981461744723795e+00 -6.009364514814460e+00 3.813151173951300e+00 4.652929150150985e+00 9.245796517852639e+03 + 147300 9.620424738932651e-01 -6.005351367794629e+00 -5.958462514590823e+00 3.720610079839340e+00 4.989853130962174e+00 9.089975349374659e+03 + 147320 9.517193564429207e-01 -5.969286434528465e+00 -6.019167643720662e+00 3.843229661656856e+00 4.556804039383088e+00 9.275993883675023e+03 + 147340 9.761731745966711e-01 -5.982982948636804e+00 -6.034665513054563e+00 3.764026743959082e+00 4.467257461221319e+00 9.323774966314444e+03 + 147360 9.620806314382306e-01 -5.940894605468012e+00 -6.018795472709902e+00 4.003762599551262e+00 4.556443764728082e+00 9.274835982946093e+03 + 147380 1.053950414784084e+00 -6.055378410997507e+00 -5.998590259523348e+00 3.405511401523996e+00 4.731597755226661e+00 9.212730034656228e+03 + 147400 9.746849345650567e-01 -5.917286345482706e+00 -6.023482603312237e+00 4.133236107743421e+00 4.523440761468467e+00 9.289277242842885e+03 + 147420 1.002034272145176e+00 -5.938845063052676e+00 -6.010563860946154e+00 4.007221108667495e+00 4.595400672715038e+00 9.249519886817592e+03 + 147440 1.063516812609236e+00 -6.011986556318882e+00 -6.009990314305742e+00 3.609276332790502e+00 4.620739063347401e+00 9.247748070705702e+03 + 147460 1.046558709219932e+00 -5.973582295562760e+00 -5.992184964819701e+00 3.893349586993884e+00 4.786530181366762e+00 9.193069295768459e+03 + 147480 1.003200678486407e+00 -5.900412400235664e+00 -6.036925115245118e+00 4.233603799659062e+00 4.449726664800409e+00 9.330755391530533e+03 + 147500 1.033195957798800e+00 -5.941454520431762e+00 -6.008884689188932e+00 4.020420489456436e+00 4.633226025667877e+00 9.244332840296043e+03 + 147520 1.064224873673664e+00 -5.988247667743936e+00 -5.941558246238659e+00 3.701368962373131e+00 4.969466845821056e+00 9.038510936037195e+03 + 147540 9.900921216704990e-01 -5.879983190819305e+00 -6.012190578809145e+00 4.329706245102539e+00 4.570550964237704e+00 9.254477856492844e+03 + 147560 1.027615365927224e+00 -5.943513842298212e+00 -5.993355259057427e+00 3.940937225420726e+00 4.654740097454996e+00 9.196638944863356e+03 + 147580 1.022876803181970e+00 -5.950417256321040e+00 -5.988910148648042e+00 3.957827220099767e+00 4.736795075602284e+00 9.183013458760865e+03 + 147600 1.021630542410002e+00 -5.970076544807824e+00 -6.004554534990737e+00 3.839002992449868e+00 4.641025037367847e+00 9.231042900396122e+03 + 147620 1.013971619028438e+00 -5.992951406702041e+00 -6.021127145486098e+00 3.724278026759573e+00 4.562488574480028e+00 9.282000749989444e+03 + 147640 9.973840496026797e-01 -6.013352510834546e+00 -6.013440113448819e+00 3.614213577279701e+00 4.613710549512083e+00 9.258335593894883e+03 + 147660 9.659350174744817e-01 -6.013427311245348e+00 -6.010615253451397e+00 3.604307670926669e+00 4.620454941944070e+00 9.249667257046320e+03 + 147680 9.326462148087226e-01 -6.006166824762192e+00 -6.007304268134179e+00 3.656508337030825e+00 4.649976961170085e+00 9.239487153383199e+03 + 147700 8.762308564632937e-01 -5.952200555265967e+00 -5.997181539113994e+00 3.917996625372281e+00 4.659708855332154e+00 9.208391797685956e+03 + 147720 9.631774218283768e-01 -6.098232115861881e+00 -5.955396384148790e+00 3.206463354235003e+00 5.026648229489616e+00 9.080612763524956e+03 + 147740 1.006732566218577e+00 -6.169690765988399e+00 -5.966564313123426e+00 2.791608017057621e+00 4.957991543125289e+00 9.114692745410408e+03 + 147760 9.582760488326885e-01 -6.098627338073102e+00 -5.977817635701862e+00 3.151518502508643e+00 4.845226508765329e+00 9.149088868060491e+03 + 147780 9.124698496834842e-01 -6.026244475273343e+00 -5.996217592543302e+00 3.511200658943180e+00 4.683619666224157e+00 9.205457175119485e+03 + 147800 9.619191808835996e-01 -6.088770859700382e+00 -5.980713946478601e+00 3.200835481023085e+00 4.821314998495833e+00 9.157946998757323e+03 + 147820 9.643448144814772e-01 -6.075806403219199e+00 -5.970229967586068e+00 3.316718521734194e+00 4.922954753040242e+00 9.125889863179658e+03 + 147840 9.945182932585239e-01 -6.098257931198596e+00 -5.978582328889623e+00 3.146310545172474e+00 4.833506373370197e+00 9.151440790382949e+03 + 147860 9.659590021196989e-01 -6.029853890456608e+00 -6.023860722850536e+00 3.553677313261809e+00 4.588091009095567e+00 9.290448549146882e+03 + 147880 1.008633885569229e+00 -6.067012649180972e+00 -5.992863839636564e+00 3.380044035580053e+00 4.805817974475240e+00 9.195178686062993e+03 + 147900 9.739620046932055e-01 -5.990595908688277e+00 -6.006056025127406e+00 3.772206202857211e+00 4.683431821818449e+00 9.235654066938181e+03 + 147920 9.549093951965635e-01 -5.937644596725423e+00 -6.002175842041855e+00 4.041788017124788e+00 4.671239620339900e+00 9.223738745119814e+03 + 147940 1.102483691256749e+00 -6.134570095467152e+00 -5.971418594391340e+00 3.015390527356396e+00 4.952231694146906e+00 9.129529188449993e+03 + 147960 1.012972697169058e+00 -5.986470560179397e+00 -6.019681031939598e+00 3.776799564435340e+00 4.586099896284371e+00 9.277571518651042e+03 + 147980 9.749425719556081e-01 -5.921756953769655e+00 -6.011932315107870e+00 4.098352750917704e+00 4.580551871521605e+00 9.253713896591165e+03 + 148000 1.070109286821341e+00 -6.056461821687487e+00 -6.004682316373098e+00 3.387248628629103e+00 4.684574560996876e+00 9.231433618198329e+03 + 148020 9.902638893803355e-01 -5.934004418055082e+00 -6.055515975046729e+00 3.999620939125487e+00 4.301882775026778e+00 9.388262209456941e+03 + 148040 9.897615351195371e-01 -5.935095973336256e+00 -6.032618998503080e+00 4.060936000445651e+00 4.500943698298376e+00 9.317412069560112e+03 + 148060 1.085238530396146e+00 -6.080636314945125e+00 -5.973808091320646e+00 3.317256016635258e+00 4.930680208301196e+00 9.136809844629766e+03 + 148080 1.044579815054365e+00 -6.023698084897552e+00 -6.016759152074973e+00 3.546902630688328e+00 4.586747056751956e+00 9.268580222813556e+03 + 148100 9.777590692165292e-01 -5.931180533100734e+00 -6.005818790237676e+00 4.076376993264252e+00 4.647792570550965e+00 9.234911934408750e+03 + 148120 1.017846441823961e+00 -5.995942894019807e+00 -5.974599481775986e+00 3.712939888816869e+00 4.835497064803263e+00 9.139252034248559e+03 + 148140 9.687294014955719e-01 -5.927740579051606e+00 -6.004043646354701e+00 4.091859878097296e+00 4.653715857781419e+00 9.229462204884001e+03 + 148160 9.568014478491175e-01 -5.915720381028480e+00 -6.031999256519079e+00 4.133053586156850e+00 4.465362288992003e+00 9.315513469276739e+03 + 148180 1.040862425197149e+00 -6.044900724036706e+00 -5.967284382335305e+00 3.485574211159155e+00 4.931259256298662e+00 9.116904444728318e+03 + 148200 1.093514159926527e+00 -6.127858350442940e+00 -6.021650884542738e+00 2.977264262886303e+00 4.587123967637496e+00 9.283648161511939e+03 + 148220 9.929950509154217e-01 -5.988609665090152e+00 -6.010066238327926e+00 3.740932442519514e+00 4.617725478594238e+00 9.247974064104626e+03 + 148240 9.666243152533401e-01 -5.959223132149596e+00 -5.982976106263047e+00 3.951427961839134e+00 4.815034708718830e+00 9.164839325451787e+03 + 148260 1.002547017168844e+00 -6.019288246549095e+00 -5.993514408845407e+00 3.576722223395052e+00 4.724719587978129e+00 9.197137975280353e+03 + 148280 9.976035775731529e-01 -6.020089016037030e+00 -6.006557711453492e+00 3.634055163049969e+00 4.711754007931258e+00 9.237197792729736e+03 + 148300 9.540656092471164e-01 -5.965740245904180e+00 -6.034828531490184e+00 3.841916967584449e+00 4.445201340371968e+00 9.324276101881456e+03 + 148320 9.969973121791984e-01 -6.042946331290940e+00 -5.965635073050022e+00 3.459791514901797e+00 4.903724723599694e+00 9.111821305377945e+03 + 148340 9.175811620376667e-01 -5.936979560581555e+00 -5.987864776537041e+00 4.026215869347523e+00 4.734025084869402e+00 9.179822746833552e+03 + 148360 1.025532050027586e+00 -6.112464981045278e+00 -5.982841078788863e+00 3.134623639762816e+00 4.878944145753195e+00 9.164432509077413e+03 + 148380 9.880441680680256e-01 -6.078765111875846e+00 -5.988947983625831e+00 3.285995029152028e+00 4.801738878719291e+00 9.183153073458876e+03 + 148400 9.352657659337830e-01 -6.026375731617719e+00 -6.019747673759342e+00 3.511084420148667e+00 4.549143754060107e+00 9.277771379252350e+03 + 148420 1.013464001358629e+00 -6.171507172323161e+00 -5.960602172133965e+00 2.811034647558906e+00 5.022083796088568e+00 9.096513191541651e+03 + 148440 8.658300657255028e-01 -5.978487883916946e+00 -5.984699938558352e+00 3.860848085377656e+00 4.825177506314352e+00 9.170132059299083e+03 + 148460 8.880314509268985e-01 -6.028685999159032e+00 -5.944306759751037e+00 3.577305355727041e+00 5.061824006052845e+00 9.046871231343488e+03 + 148480 9.499737271605003e-01 -6.127431368286963e+00 -5.971024592361706e+00 3.012914314268948e+00 4.911026225502125e+00 9.128325516498280e+03 + 148500 9.200298726309915e-01 -6.082194985358914e+00 -6.012535216179670e+00 3.214402611523302e+00 4.614399785964961e+00 9.255582319247356e+03 + 148520 9.095102014506612e-01 -6.058969412480756e+00 -5.975625303661701e+00 3.359088080670662e+00 4.837662850968830e+00 9.142397685464090e+03 + 148540 9.319930251231311e-01 -6.076202214124780e+00 -5.999378835731135e+00 3.264479304566550e+00 4.705611031682246e+00 9.215142340782442e+03 + 148560 9.185771989205889e-01 -6.030133724783111e+00 -5.990288760691397e+00 3.488318908989651e+00 4.717114858792534e+00 9.187262146434723e+03 + 148580 9.933580252418474e-01 -6.107932558055012e+00 -5.958759244047257e+00 3.104452653946216e+00 4.961028907474484e+00 9.090881840822160e+03 + 148600 9.652521055641422e-01 -6.025656040751643e+00 -6.003783164317905e+00 3.505971389677570e+00 4.631568830976778e+00 9.228652813772884e+03 + 148620 9.646374783845550e-01 -5.985273385677446e+00 -6.016797800565131e+00 3.765343663714059e+00 4.584325595041532e+00 9.268684762820349e+03 + 148640 1.001975721026050e+00 -6.006255588601622e+00 -6.043902065070998e+00 3.607918458961228e+00 4.391746565300664e+00 9.352320249103474e+03 + 148660 9.782465868450666e-01 -5.946126578793100e+00 -6.012126025975050e+00 4.021860133346900e+00 4.642881094246701e+00 9.254300808336084e+03 + 148680 1.022760238256472e+00 -5.992994312313469e+00 -6.006713354730621e+00 3.703611086925390e+00 4.624834222351147e+00 9.237673139326453e+03 + 148700 1.034743026161218e+00 -5.996271033619035e+00 -6.017194727830335e+00 3.699215474075153e+00 4.579068383982657e+00 9.269890653597382e+03 + 148720 9.387954426731207e-01 -5.843726190093903e+00 -6.048000820985521e+00 4.512763240338693e+00 4.339786698362054e+00 9.364984567096795e+03 + 148740 9.677469747871864e-01 -5.879972586521713e+00 -6.060071170627753e+00 4.335937562442474e+00 4.301783622339769e+00 9.402358684882523e+03 + 148760 9.971600232127474e-01 -5.920728958438067e+00 -6.043774029824622e+00 4.109844174453989e+00 4.403300333389136e+00 9.351904209580603e+03 + 148780 1.047498724932693e+00 -5.997544673534498e+00 -6.006933432583651e+00 3.679303634103386e+00 4.625391926737386e+00 9.238340299851656e+03 + 148800 9.916242281609570e-01 -5.919892821259730e+00 -6.011215512767518e+00 4.106615615668069e+00 4.582226588889511e+00 9.251487443974584e+03 + 148820 1.062032548363734e+00 -6.030909085956646e+00 -5.942137054137520e+00 3.589417414724179e+00 5.099160158857122e+00 9.040259916154726e+03 + 148840 9.889760202788839e-01 -5.930878951691304e+00 -6.052217116120625e+00 4.065889967477486e+00 4.369147450304069e+00 9.378030385070228e+03 + 148860 1.071976316426278e+00 -6.065252806374444e+00 -6.052835209810787e+00 3.340097495650378e+00 4.411401256735749e+00 9.379960253764222e+03 + 148880 9.882297925071922e-01 -5.963903461326367e+00 -6.013592048739210e+00 3.894300214978604e+00 4.608980656770004e+00 9.258818132621109e+03 + 148900 9.871604654665437e-01 -5.986731541088610e+00 -5.989215707812895e+00 3.825310274147645e+00 4.811045804393244e+00 9.183966735012884e+03 + 148920 9.777326463762732e-01 -6.003538379710181e+00 -6.023180842145290e+00 3.638972515173342e+00 4.526182456209707e+00 9.288348106427902e+03 + 148940 9.495409983705687e-01 -5.994488103511454e+00 -6.014997420916482e+00 3.726118397581784e+00 4.608350723235501e+00 9.263135443837726e+03 + 148960 9.319298647783092e-01 -6.002202821176582e+00 -6.001387315318129e+00 3.654518268516340e+00 4.659201029354701e+00 9.221308722505426e+03 + 148980 9.702531358586300e-01 -6.091171752653831e+00 -5.990256878513732e+00 3.205448550181603e+00 4.784917374020354e+00 9.187166954510483e+03 + 149000 9.555480309803654e-01 -6.100320506180590e+00 -6.003177801217802e+00 3.162452934140269e+00 4.720261378821602e+00 9.226823093561648e+03 + 149020 9.591630989133524e-01 -6.132941951060305e+00 -5.969454774439789e+00 2.948138390893425e+00 4.886907058607241e+00 9.123537672225229e+03 + 149040 9.140790069492226e-01 -6.083851962012092e+00 -5.979621453797276e+00 3.159510866347591e+00 4.758018574136085e+00 9.154615912074874e+03 + 149060 9.117785071603963e-01 -6.089485847995926e+00 -5.972103891576873e+00 3.198406760948568e+00 4.872432119505814e+00 9.131607181773656e+03 + 149080 8.583247656209404e-01 -6.010624228428672e+00 -5.966538034642333e+00 3.640939604770538e+00 4.894089351808131e+00 9.114589635427281e+03 + 149100 9.501773447563995e-01 -6.135318296125980e+00 -5.930370335609149e+00 3.005573517974896e+00 5.182416422856931e+00 9.004543364281204e+03 + 149120 9.264847934953789e-01 -6.072462028013182e+00 -5.978967278175997e+00 3.336631522709883e+00 4.873492844540779e+00 9.152596373130513e+03 + 149140 9.355808766771774e-01 -6.040604153960872e+00 -6.032395586041773e+00 3.465258771190565e+00 4.512393638453808e+00 9.316779311326984e+03 + 149160 9.884416968087282e-01 -6.055404590142630e+00 -6.005520307828047e+00 3.396294796824091e+00 4.682738065442166e+00 9.234011761123716e+03 + 149180 9.867515331203045e-01 -5.990610590998948e+00 -5.977677466831366e+00 3.801426784502123e+00 4.875690784866874e+00 9.148650647885794e+03 + 149200 1.020920510450418e+00 -5.999172827693941e+00 -6.013765568103580e+00 3.690198444107339e+00 4.606404670455915e+00 9.259346967431886e+03 + 149220 1.036985912253243e+00 -6.001431769816188e+00 -5.999273197546904e+00 3.706843581318633e+00 4.719238437326844e+00 9.214827103708058e+03 + 149240 1.001393952414178e+00 -5.937612394299311e+00 -6.085626569206395e+00 3.979500050982625e+00 4.129579753546606e+00 9.481763069203724e+03 + 149260 1.038083052648653e+00 -5.988403336767922e+00 -6.013168730324876e+00 3.742238449915355e+00 4.600031727679052e+00 9.257517256108127e+03 + 149280 1.037310504143736e+00 -5.986417597222532e+00 -6.031912138781911e+00 3.731747438689307e+00 4.470510740797804e+00 9.315272311562769e+03 + 149300 1.041967014936237e+00 -5.998017109849537e+00 -6.012996483587679e+00 3.660581895853194e+00 4.574568013798186e+00 9.256970636369058e+03 + 149320 9.908451584400902e-01 -5.929769545863131e+00 -6.007679407669706e+00 4.027420204523898e+00 4.580049721518400e+00 9.240626411628657e+03 + 149340 1.001830568977747e+00 -5.955565987267375e+00 -6.002386047659849e+00 3.928199807384543e+00 4.659351775230032e+00 9.224378226870338e+03 + 149360 1.063645601089322e+00 -6.057813144452950e+00 -5.978726939641605e+00 3.409230508741682e+00 4.863355735319066e+00 9.151850529137759e+03 + 149380 9.833041858305926e-01 -5.950701212686327e+00 -6.018840682235790e+00 3.957597870671585e+00 4.566330491969732e+00 9.274981058467969e+03 + 149400 1.078167837241122e+00 -6.106101913856929e+00 -5.992282548280976e+00 3.145612108179131e+00 4.799180518806155e+00 9.193382353133262e+03 + 149420 9.755743138805277e-01 -5.971023819325926e+00 -6.039032650222440e+00 3.829550099223270e+00 4.439032867882920e+00 9.337265770922233e+03 + 149440 1.014931793493759e+00 -6.049210875425539e+00 -6.011248871591116e+00 3.445051931484599e+00 4.663035632102963e+00 9.251618942493558e+03 + 149460 9.774026326215259e-01 -6.014053303605452e+00 -5.999158755489930e+00 3.654169457951653e+00 4.739696258154851e+00 9.214467735918312e+03 + 149480 9.847264595742603e-01 -6.043244683192965e+00 -5.981946429175494e+00 3.532139633569160e+00 4.884123694011631e+00 9.161709560640547e+03 + 149500 9.632228593569714e-01 -6.027641463495756e+00 -5.987627714814349e+00 3.537491705154677e+00 4.767256842190916e+00 9.179110272909693e+03 + 149520 9.915909337872482e-01 -6.083030043256894e+00 -5.951728909570742e+00 3.325629221041859e+00 5.079580649452518e+00 9.069443639713385e+03 + 149540 9.725159434259926e-01 -6.063826628035661e+00 -5.979826651131965e+00 3.383129321255899e+00 4.865470187591337e+00 9.155238416776147e+03 + 149560 9.717511553640832e-01 -6.068794314393019e+00 -5.995228782927384e+00 3.316295938762303e+00 4.738720604667180e+00 9.202414602310961e+03 + 149580 9.994400049201998e-01 -6.112574230212691e+00 -5.957922970474870e+00 3.142641462993562e+00 5.030672928613227e+00 9.088330817529939e+03 + 149600 9.513113547820288e-01 -6.037909897300880e+00 -5.964561762916744e+00 3.542207855021135e+00 4.963384193241955e+00 9.108579069419260e+03 + 149620 9.375791821707874e-01 -6.008700076293080e+00 -5.983504837305659e+00 3.721800116843144e+00 4.866475078059546e+00 9.166455537760432e+03 + 149640 8.888240276595070e-01 -5.917267942746625e+00 -6.005005717301918e+00 4.088296276718696e+00 4.584492397845471e+00 9.232410213825611e+03 + 149660 1.009800773049985e+00 -6.064530962323119e+00 -6.003779253352840e+00 3.337498257860947e+00 4.686343972064872e+00 9.228673241704328e+03 + 149680 9.193357898233663e-01 -5.891054566751519e+00 -6.087553056543850e+00 4.245092694024150e+00 4.116767957593565e+00 9.487783593235583e+03 + 149700 9.787528916850636e-01 -5.936026885089722e+00 -6.049497378526199e+00 4.044486983728270e+00 4.392921850913903e+00 9.369628379168274e+03 + 149720 1.072466895120564e+00 -6.033003489680712e+00 -6.005129751853829e+00 3.493390171887607e+00 4.653445487936553e+00 9.232798612643783e+03 + 149740 1.038466236429112e+00 -5.949317558955997e+00 -6.024779434142694e+00 3.926345429696016e+00 4.493031664686553e+00 9.293275561486022e+03 + 149760 1.036670938581995e+00 -5.924329651562857e+00 -6.002892079101688e+00 4.139888742640146e+00 4.688771126215812e+00 9.225881688195797e+03 + 149780 9.806966176860448e-01 -5.827433295578679e+00 -5.994457425476673e+00 4.670729796033187e+00 4.711651395258335e+00 9.199998395170323e+03 + 149800 1.057798340113215e+00 -5.931999799765908e+00 -6.007535645936189e+00 4.024585721051024e+00 4.590847203206855e+00 9.240198847355317e+03 + 149820 1.073693507750809e+00 -5.953218678511425e+00 -6.030547813270803e+00 3.957610270984331e+00 4.513574412551055e+00 9.311058448744236e+03 + 149840 1.025149097673004e+00 -5.888863406411859e+00 -6.017017231332128e+00 4.271739025066626e+00 4.535859930634131e+00 9.269363188716614e+03 + 149860 1.109093960834532e+00 -6.025474583973589e+00 -5.969561222567913e+00 3.638966087782962e+00 4.960029261539067e+00 9.123836889986344e+03 + 149880 1.042197706272741e+00 -5.943459064003320e+00 -6.000979797891327e+00 4.008828459277579e+00 4.678535503987839e+00 9.220061135477297e+03 + 149900 1.005023587935166e+00 -5.909418153165021e+00 -6.012822217676428e+00 4.189358427481056e+00 4.595596287329291e+00 9.256430575993565e+03 + 149920 1.023595695931044e+00 -5.958653209371946e+00 -5.986424501881814e+00 3.947681562046709e+00 4.788214502861420e+00 9.175419226850287e+03 + 149940 1.037728898461327e+00 -6.001910845855869e+00 -5.964693530483965e+00 3.674134047309070e+00 4.887841631535485e+00 9.108977499518473e+03 + 149960 1.036291945791406e+00 -6.018534218417487e+00 -5.970547045372105e+00 3.598908720968963e+00 4.874458494586575e+00 9.126824168694717e+03 + 149980 9.749912919555134e-01 -5.944265280159549e+00 -5.981527251371983e+00 4.035816310930693e+00 4.821852305957482e+00 9.160422363548916e+03 + 150000 1.000746349859700e+00 -5.995105229027912e+00 -5.990612669802424e+00 3.751209043129280e+00 4.777006013423326e+00 9.188260787544164e+03 + 150020 1.009603466233564e+00 -6.018629198197260e+00 -6.036802247050409e+00 3.542910449175948e+00 4.438557990390946e+00 9.330382329884915e+03 + 150040 9.836447938387544e-01 -5.989361828706469e+00 -6.033672867363838e+00 3.721827478535733e+00 4.467386637454053e+00 9.320703486986977e+03 + 150060 9.682959386008054e-01 -5.972433656819764e+00 -6.017577125455869e+00 3.808675339552505e+00 4.549454556714792e+00 9.271096659975286e+03 + 150080 9.913470011297861e-01 -6.010796410608586e+00 -5.999179344801330e+00 3.657421045325327e+00 4.724128034925714e+00 9.214521491659189e+03 + 150100 1.002680263297291e+00 -6.029727691708482e+00 -5.982564618148485e+00 3.553567764419905e+00 4.824385431263449e+00 9.163604274640982e+03 + 150120 9.885494621538494e-01 -6.008486574460028e+00 -5.988226887899067e+00 3.665169241879245e+00 4.781503497288641e+00 9.180950021348504e+03 + 150140 9.854882495488646e-01 -6.003111420752450e+00 -6.004734622407958e+00 3.673081871635125e+00 4.663761196539555e+00 9.231582999484290e+03 + 150160 1.001620122669466e+00 -6.024787143490674e+00 -5.966297787391675e+00 3.565151430961454e+00 4.901006364880510e+00 9.113887872352245e+03 + 150180 1.006850765052086e+00 -6.029272273626804e+00 -6.002492806843060e+00 3.568478557346657e+00 4.722250399728006e+00 9.224672881719383e+03 + 150200 1.069526029800845e+00 -6.118678166112872e+00 -5.970627143627156e+00 3.088102318475911e+00 4.938234200410579e+00 9.127100687385555e+03 + 150220 9.781274685791935e-01 -5.979278314600574e+00 -5.979121257550968e+00 3.829296643927057e+00 4.830198489810392e+00 9.153053027941969e+03 + 150240 9.798517785923420e-01 -5.977052730942283e+00 -6.015042033294630e+00 3.861029414290817e+00 4.642888961358103e+00 9.263278214659425e+03 + 150260 9.913663567693438e-01 -5.990582008605550e+00 -5.975565499295971e+00 3.781550438150769e+00 4.867777558403677e+00 9.142185886324654e+03 + 150280 1.012050797497780e+00 -6.015109069964392e+00 -6.021130178125844e+00 3.638982806793945e+00 4.604408671967409e+00 9.282021712660486e+03 + 150300 1.029540921495488e+00 -6.034392888289961e+00 -5.986448426344984e+00 3.559541937392017e+00 4.834846457261585e+00 9.175491254244005e+03 + 150320 9.978671226835317e-01 -5.982908181390681e+00 -5.972123789735834e+00 3.803116241090053e+00 4.865041886851404e+00 9.131652337420877e+03 + 150340 9.381223577589265e-01 -5.885865212881697e+00 -6.020214775705394e+00 4.319582601652487e+00 4.548126621391163e+00 9.279175175170591e+03 + 150360 9.352425656863960e-01 -5.868417254345248e+00 -6.002190784166351e+00 4.449764373080928e+00 4.681616063461318e+00 9.223755515455765e+03 + 150380 1.057054880633936e+00 -6.027909476075520e+00 -5.980814780400161e+00 3.535939825062264e+00 4.806364855510777e+00 9.158244685302805e+03 + 150400 1.001193349014441e+00 -5.916284104545692e+00 -6.063316047368043e+00 4.057038005090810e+00 4.212757836285252e+00 9.412459852805780e+03 + 150420 1.103224072128724e+00 -6.030423665264951e+00 -6.025890324804283e+00 3.542312920547334e+00 4.568344063004659e+00 9.296699708782435e+03 + 150440 1.068042584619465e+00 -5.940288506571102e+00 -6.023882524146398e+00 4.054847110345259e+00 4.574837325295502e+00 9.290482814981440e+03 + 150460 1.028568924415552e+00 -5.849764074165900e+00 -6.017967045616854e+00 4.491420788369796e+00 4.525573296972710e+00 9.272274902596249e+03 + 150480 1.084235660274938e+00 -5.905153815394046e+00 -5.955591223289929e+00 4.211413696916372e+00 4.921794295614568e+00 9.081206241346359e+03 + 150500 1.094939847214556e+00 -5.897740067211156e+00 -5.971194970466074e+00 4.274782874112671e+00 4.852993452513390e+00 9.128806988302778e+03 + 150520 1.060008473138131e+00 -5.829648248098029e+00 -6.059722497898953e+00 4.625197545053721e+00 4.304075598821727e+00 9.401288103742056e+03 + 150540 1.136285198194765e+00 -5.941342614665860e+00 -6.035066194293719e+00 4.009425257606282e+00 4.471249959706038e+00 9.325021519130018e+03 + 150560 1.046491546269421e+00 -5.821540823654393e+00 -6.019268157367252e+00 4.673651547476949e+00 4.538270599091711e+00 9.276288455753749e+03 + 150580 1.092924541058410e+00 -5.916316963423075e+00 -6.020332770608984e+00 4.081090575929458e+00 4.483815714673825e+00 9.279564841650561e+03 + 150600 1.077246319718537e+00 -5.930027000145854e+00 -6.040420973581192e+00 4.070501726875413e+00 4.436602447997526e+00 9.341555576119184e+03 + 150620 1.081387906507317e+00 -5.987286941151554e+00 -6.032736518740514e+00 3.737841324369370e+00 4.476862816554158e+00 9.317815934375285e+03 + 150640 1.023219331424679e+00 -5.951808265275351e+00 -6.014570848949219e+00 3.954020418633097e+00 4.593627950699307e+00 9.261829989445889e+03 + 150660 1.014746412120589e+00 -5.978792372843383e+00 -6.013589318559614e+00 3.795706367186674e+00 4.595896920074132e+00 9.258799497109085e+03 + 150680 1.017859844087429e+00 -6.011506238431652e+00 -5.989162073297894e+00 3.618121464770067e+00 4.746425118716484e+00 9.183805419742781e+03 + 150700 1.060636454275692e+00 -6.094071834431030e+00 -6.021455591352630e+00 3.152929558368030e+00 4.569903263451500e+00 9.283021814229569e+03 + 150720 9.821993193527552e-01 -5.992657394375923e+00 -5.994080561695123e+00 3.744938196799296e+00 4.736766149818022e+00 9.198891160476036e+03 + 150740 9.635046167031955e-01 -5.974920530622235e+00 -6.024096479542361e+00 3.823787941086658e+00 4.541412032433788e+00 9.291175671679908e+03 + 150760 1.042071127438678e+00 -6.098107566615688e+00 -6.016159517634082e+00 3.203109982586342e+00 4.673668361258318e+00 9.266728194264100e+03 + 150780 1.011272806120310e+00 -6.060286492676744e+00 -6.006288543062744e+00 3.399615054123844e+00 4.709679636963134e+00 9.236370023235317e+03 + 150800 9.555380627667490e-01 -5.984971494940432e+00 -5.980547607617535e+00 3.772756442785968e+00 4.798159088388392e+00 9.157430516894054e+03 + 150820 9.880269080683777e-01 -6.037741707127041e+00 -5.985799948641088e+00 3.447923292194662e+00 4.746180907382150e+00 9.173472128589383e+03 + 150840 9.148411601213425e-01 -5.929302776842778e+00 -6.016592279999100e+00 4.025868009781565e+00 4.524638174651007e+00 9.268053518418810e+03 + 150860 9.321045864257766e-01 -5.952194765918282e+00 -6.011620012060129e+00 3.939221379425699e+00 4.597992420052098e+00 9.252745622296132e+03 + 150880 9.728569281342325e-01 -6.006241222399943e+00 -5.986137395386181e+00 3.704225050593066e+00 4.819664336363266e+00 9.174531479800720e+03 + 150900 9.893637918491844e-01 -6.019609921429345e+00 -5.955452140312008e+00 3.590855052966243e+00 4.959258960526535e+00 9.080794259479362e+03 + 150920 1.008402946986077e+00 -6.030958457477076e+00 -5.995343764100028e+00 3.546702795087030e+00 4.751207875814027e+00 9.202760372928915e+03 + 150940 1.022731407626673e+00 -6.032584004146097e+00 -5.978275517940849e+00 3.506725739959434e+00 4.818573471961047e+00 9.150501377640547e+03 + 150960 1.021737826429853e+00 -6.009138179770336e+00 -5.998419615855447e+00 3.650294408842746e+00 4.711842061534446e+00 9.212190929214590e+03 + 150980 9.855800317423309e-01 -5.928319463220397e+00 -6.039809292605836e+00 4.103228238858790e+00 4.463036385532257e+00 9.339661018993216e+03 + 151000 1.050683322057888e+00 -5.995094499545748e+00 -6.017637894544511e+00 3.718395229882715e+00 4.588947567220716e+00 9.271282799102430e+03 + 151020 1.039756909373752e+00 -5.950449733795551e+00 -6.041610032516839e+00 3.953006807920958e+00 4.429550265652687e+00 9.345226937602096e+03 + 151040 1.004350151788975e+00 -5.870714517990969e+00 -6.071100218273487e+00 4.374976780474732e+00 4.224331079865612e+00 9.436603161260675e+03 + 151060 1.035419117880078e+00 -5.895318297519967e+00 -6.031860348723509e+00 4.238822721477089e+00 4.454777133652220e+00 9.315085216248077e+03 + 151080 1.013239379056700e+00 -5.845526081629730e+00 -6.020885361710429e+00 4.562613153395092e+00 4.555673030410825e+00 9.281248897543073e+03 + 151100 1.089987410997262e+00 -5.945447472461987e+00 -6.040801766408169e+00 3.921136500382726e+00 4.373597388514450e+00 9.342736046459726e+03 + 151120 1.046933333672284e+00 -5.876016179774455e+00 -6.016227262640525e+00 4.413409645981955e+00 4.608295910570028e+00 9.266894558813861e+03 + 151140 9.997341997972827e-01 -5.809299877916972e+00 -6.037906275497038e+00 4.728736593388832e+00 4.416043281758401e+00 9.333752132077156e+03 + 151160 1.054316638405036e+00 -5.901428653358761e+00 -6.037300865957439e+00 4.232211390203929e+00 4.452012119305372e+00 9.331882616571107e+03 + 151180 1.089892910539441e+00 -5.980809869769407e+00 -6.026353267570629e+00 3.875352355195365e+00 4.613835117202721e+00 9.298120899873840e+03 + 151200 1.111558855991609e+00 -6.061577603584464e+00 -5.979556420188363e+00 3.395930232750122e+00 4.866908560547642e+00 9.154412026811136e+03 + 151220 1.038555593839252e+00 -6.013742703627779e+00 -6.018848756443674e+00 3.651552032497980e+00 4.622232287069993e+00 9.275003443206826e+03 + 151240 9.537137507573855e-01 -5.945284433539432e+00 -6.030055523776670e+00 3.972891672558619e+00 4.486122954132580e+00 9.309532999795378e+03 + 151260 9.608485051562297e-01 -5.993885626088748e+00 -5.943001539665609e+00 3.740501935153751e+00 5.032686233682341e+00 9.042909555079072e+03 + 151280 9.885008514243666e-01 -6.057868271828751e+00 -5.972277873604152e+00 3.395122078017342e+00 4.886595389694306e+00 9.132140561423039e+03 + 151300 1.022368306136238e+00 -6.124591808290953e+00 -5.966443700180272e+00 3.056367475744671e+00 4.964478385856838e+00 9.114332302103292e+03 + 151320 9.277085231573764e-01 -5.995926366840009e+00 -5.955245322107059e+00 3.750064700879829e+00 4.983661555107751e+00 9.080166409642865e+03 + 151340 9.080652603581796e-01 -5.970086408282470e+00 -6.001645538076616e+00 3.856741655205158e+00 4.675524248167622e+00 9.222076994487079e+03 + 151360 9.686739199831036e-01 -6.057474377292611e+00 -5.985852268852433e+00 3.385588171691384e+00 4.796853401840345e+00 9.173653816994352e+03 + 151380 9.498473788330186e-01 -6.023202979297734e+00 -5.941977970994039e+00 3.626665844597869e+00 5.093072411807098e+00 9.039764843709552e+03 + 151400 8.855328462794647e-01 -5.913053894147227e+00 -6.006844887595846e+00 4.121425079999998e+00 4.582862681508700e+00 9.238051998011737e+03 + 151420 1.042985979738206e+00 -6.123439052208607e+00 -5.984627929134223e+00 3.037999781587738e+00 4.835074731232725e+00 9.169953202528999e+03 + 151440 1.029442640730459e+00 -6.079459701929698e+00 -5.998923613769241e+00 3.263824303145713e+00 4.726274984282420e+00 9.213764793352764e+03 + 151460 9.508834342594117e-01 -5.942930283648078e+00 -6.005044776252562e+00 3.924978776569339e+00 4.568307747847728e+00 9.232530797675730e+03 + 151480 9.573613764998928e-01 -5.930364706034017e+00 -5.992060578919617e+00 4.067218508461268e+00 4.712951258946686e+00 9.192688381108583e+03 + 151500 1.050669843975219e+00 -6.043460816906126e+00 -5.989097317499439e+00 3.436287346052890e+00 4.748450972370430e+00 9.183582736164168e+03 + 151520 9.754121981980741e-01 -5.905724162552630e+00 -5.960108389391514e+00 4.235842388922688e+00 4.923559742481914e+00 9.094966612387749e+03 + 151540 1.046768753281480e+00 -5.985679061813991e+00 -5.945752296412028e+00 3.735635685041546e+00 4.964901350626601e+00 9.051269500635104e+03 + 151560 1.039619638059015e+00 -5.952393851155655e+00 -5.967376942602351e+00 3.979164584042289e+00 4.893129354329457e+00 9.117156867652677e+03 + 151580 1.094868753602539e+00 -6.016869995758238e+00 -5.985187022377287e+00 3.576338436330576e+00 4.758266972408279e+00 9.171650158144310e+03 + 151600 9.808656533992882e-01 -5.837423940619686e+00 -6.059900664333373e+00 4.547602721991810e+00 4.270106946266093e+00 9.401837026703997e+03 + 151620 1.005518223028536e+00 -5.869103954008161e+00 -5.983765814729772e+00 4.347297826150006e+00 4.688891678020918e+00 9.167252386327955e+03 + 151640 9.979406654387901e-01 -5.854790864603054e+00 -5.962540505830664e+00 4.517827004764499e+00 4.899111890632467e+00 9.102389696456972e+03 + 151660 1.090934673361515e+00 -5.992366462405522e+00 -6.008079897274205e+00 3.713876612203406e+00 4.623647637541244e+00 9.241834854397872e+03 + 151680 1.127731640294702e+00 -6.056094071076554e+00 -6.013456467352157e+00 3.350252870857004e+00 4.595084589590345e+00 9.258417637162349e+03 + 151700 9.688795251540822e-01 -5.842611912661931e+00 -6.062191743688187e+00 4.526159033567650e+00 4.265297663945856e+00 9.408947638814087e+03 + 151720 1.040962093349269e+00 -5.986177187411456e+00 -6.000021611171896e+00 3.775798356841198e+00 4.696301533191095e+00 9.217116453050055e+03 + 151740 9.985513396979232e-01 -5.978220100310472e+00 -6.019107118908904e+00 3.790253302049563e+00 4.555473714011690e+00 9.275802348232399e+03 + 151760 9.814636402093748e-01 -6.016737616388793e+00 -6.014098625587303e+00 3.618262176150427e+00 4.633415669715092e+00 9.260364008094855e+03 + 151780 9.497965227361332e-01 -6.025017881645683e+00 -6.011111935756190e+00 3.550634300379274e+00 4.630484393614910e+00 9.251201689018544e+03 + 151800 1.017309151803874e+00 -6.160230993182501e+00 -5.989701302592079e+00 2.823899115914128e+00 4.803106988668665e+00 9.185481732898510e+03 + 151820 9.080378795330997e-01 -6.019383029669922e+00 -5.982483163606519e+00 3.606382410596440e+00 4.818267151768318e+00 9.163371781458760e+03 + 151840 9.930165723566796e-01 -6.152805521028907e+00 -5.968809347419153e+00 2.921526963881445e+00 4.978061466064498e+00 9.121554539774961e+03 + 151860 9.287734568370655e-01 -6.056796138967373e+00 -5.976438043134815e+00 3.401485337586604e+00 4.862913959232293e+00 9.144853252147526e+03 + 151880 8.915203591566058e-01 -5.992765054561088e+00 -5.992568796550957e+00 3.697035225486222e+00 4.698162169351218e+00 9.194250967014876e+03 + 151900 9.865639182463944e-01 -6.118455592844485e+00 -5.954648309205840e+00 3.094322897933846e+00 5.034929669682163e+00 9.078350893013456e+03 + 151920 1.001897570064303e+00 -6.121695840513720e+00 -5.976914558390227e+00 3.040967131320513e+00 4.872323658104604e+00 9.146346032762878e+03 + 151940 9.776868465406648e-01 -6.063825616327211e+00 -5.979907732020536e+00 3.404329185811634e+00 4.886198663751187e+00 9.155467200339654e+03 + 151960 9.073038871709135e-01 -5.936366178977369e+00 -5.994652868809597e+00 4.082329953395200e+00 4.747638760542449e+00 9.200629070096418e+03 + 151980 9.593235549090360e-01 -5.985631880952491e+00 -5.978098256306125e+00 3.834230342906069e+00 4.877489581450149e+00 9.149910388174412e+03 + 152000 9.650688264619897e-01 -5.963330700456472e+00 -6.001100713295623e+00 3.812159882421151e+00 4.595278623808152e+00 9.220422354491822e+03 + 152020 1.009724315320795e+00 -6.000263569253713e+00 -6.011478655281321e+00 3.686647499036401e+00 4.622248739536921e+00 9.252322948016867e+03 + 152040 9.934536845042076e-01 -5.949933688814662e+00 -6.042872261414586e+00 3.956901327389128e+00 4.423233661322735e+00 9.349125320160934e+03 + 152060 1.038646279971501e+00 -5.998375483227020e+00 -5.985524209543942e+00 3.793262239484405e+00 4.867056241700816e+00 9.172654466487344e+03 + 152080 1.007490496990422e+00 -5.936832301570265e+00 -5.968376994437580e+00 4.070109301632755e+00 4.888974793663186e+00 9.120228344967505e+03 + 152100 1.011568116049612e+00 -5.930314944141040e+00 -6.008801603758715e+00 4.133566190075120e+00 4.682883644779108e+00 9.244093624613079e+03 + 152120 1.089849109918662e+00 -6.038442299063486e+00 -5.976042066626178e+00 3.547514689886591e+00 4.905826480946375e+00 9.143648413596991e+03 + 152140 1.040920804665440e+00 -5.963328535396206e+00 -6.007955121633658e+00 3.855764435307505e+00 4.599511671190157e+00 9.241453813885266e+03 + 152160 1.047741791748945e+00 -5.975004945024188e+00 -5.978016821206632e+00 3.866764577567192e+00 4.849469918441265e+00 9.149680885955409e+03 + 152180 1.017126808175849e+00 -5.933604854760050e+00 -5.968031940034569e+00 4.073359382756071e+00 4.875673731535552e+00 9.119140063977700e+03 + 152200 1.021413381180211e+00 -5.948419546313046e+00 -5.963405267335819e+00 4.009993215434157e+00 4.923942886288559e+00 9.105003205990231e+03 + 152220 1.037872248559532e+00 -5.983546293985240e+00 -5.995322205007122e+00 3.777482503338159e+00 4.709863399934175e+00 9.202664858758279e+03 + 152240 1.061344235020368e+00 -6.033536530420349e+00 -5.991134365940708e+00 3.497017339121199e+00 4.740497129277045e+00 9.189875020405578e+03 + 152260 9.724242737112576e-01 -5.928111150760007e+00 -6.020780719955232e+00 4.089356035912435e+00 4.557233029023970e+00 9.280965346086998e+03 + 152280 9.734181061354155e-01 -5.966542651882375e+00 -5.993346222180249e+00 3.850110323903590e+00 4.696200075414102e+00 9.196629206981708e+03 + 152300 9.807074969776035e-01 -6.022257177696241e+00 -5.958537805692300e+00 3.555958694945168e+00 4.921845189532741e+00 9.090187518500117e+03 + 152320 9.460268187827032e-01 -6.016364302611555e+00 -5.973304536783368e+00 3.571136876652202e+00 4.818392715514877e+00 9.135253987750337e+03 + 152340 9.957645920621123e-01 -6.130277785117588e+00 -5.977897921213822e+00 3.004723448662648e+00 4.879712207905805e+00 9.149334862484138e+03 + 152360 9.144244795561043e-01 -6.041463363314792e+00 -6.021737881943308e+00 3.417869459376813e+00 4.531136225920255e+00 9.283916961003186e+03 + 152380 9.510485177636557e-01 -6.114906766791842e+00 -6.004633345103129e+00 3.044412846917959e+00 4.677619899011404e+00 9.231302258434202e+03 + 152400 9.317684506012232e-01 -6.096622610461853e+00 -5.988198460511848e+00 3.179959371542298e+00 4.802547619138210e+00 9.180876413758879e+03 + 152420 8.724421049795216e-01 -6.009025872905376e+00 -6.021322321277962e+00 3.618627483867034e+00 4.548019374442407e+00 9.282610690357960e+03 + 152440 9.278044059932564e-01 -6.083522531374467e+00 -6.000600214443496e+00 3.241127958462223e+00 4.717280734466926e+00 9.218911000992346e+03 + 152460 9.739913095595303e-01 -6.139071521827939e+00 -5.978511003789442e+00 2.964543850684228e+00 4.886507191921142e+00 9.151220578373835e+03 + 152480 9.361620388874895e-01 -6.067622955364333e+00 -6.024047368880511e+00 3.319519718284912e+00 4.569737479175231e+00 9.291006311304318e+03 + 152500 9.540451158088731e-01 -6.076768471437614e+00 -5.974522921512234e+00 3.303998949968892e+00 4.891108720088138e+00 9.138992676441019e+03 + 152520 9.185414480152624e-01 -6.004646483188917e+00 -5.928134737535126e+00 3.722372169990082e+00 5.161714453688522e+00 8.997740183010006e+03 + 152540 9.863562788746199e-01 -6.082725699831085e+00 -5.934148425122495e+00 3.273914974415125e+00 5.127068678050805e+00 9.016007954111856e+03 + 152560 1.004814774849207e+00 -6.086531350468787e+00 -6.011405818296346e+00 3.173742848924284e+00 4.605125280296972e+00 9.252097471347273e+03 + 152580 9.724440988292451e-01 -6.018943348303868e+00 -6.009122779820667e+00 3.592253950329463e+00 4.648645174288061e+00 9.245076340146414e+03 + 152600 1.033754263615396e+00 -6.092347320427087e+00 -5.959597241149662e+00 3.236919587692019e+00 4.999191085911371e+00 9.093435170841292e+03 + 152620 9.832708279676347e-01 -6.001726916928268e+00 -5.978932706055276e+00 3.662625009478275e+00 4.793512895703728e+00 9.152486293960792e+03 + 152640 9.716104636217388e-01 -5.969749055036559e+00 -6.019513617082342e+00 3.842058719808273e+00 4.556302903500299e+00 9.277023090367182e+03 + 152660 9.757009670874064e-01 -5.962129251666004e+00 -5.992517099610720e+00 3.950687596414144e+00 4.776195871011311e+00 9.194101945122809e+03 + 152680 1.004161888860337e+00 -5.991635062758340e+00 -6.054511815855344e+00 3.717348725455260e+00 4.356300679026173e+00 9.385120210703290e+03 + 152700 9.849092733880136e-01 -5.953640991704454e+00 -6.006415400989546e+00 3.933780779134803e+00 4.630741954206361e+00 9.236747968713547e+03 + 152720 1.026322183232623e+00 -6.007382823888434e+00 -5.985048788064599e+00 3.696211335283707e+00 4.824456825165035e+00 9.171196855116852e+03 + 152740 1.052263435778194e+00 -6.038387555637335e+00 -6.033193424914826e+00 3.490718082539106e+00 4.520543584936887e+00 9.319197854678241e+03 + 152760 9.561111621181165e-01 -5.891348247350078e+00 -6.023021860351321e+00 4.285514320438153e+00 4.529424058159259e+00 9.287844235709686e+03 + 152780 1.006205264120804e+00 -5.962621026212300e+00 -6.033340631720892e+00 3.889779627724578e+00 4.483696709070665e+00 9.319673505356963e+03 + 152800 1.035678310114099e+00 -6.004849970007421e+00 -6.023470710147678e+00 3.621365234606639e+00 4.514442063171058e+00 9.289249773610716e+03 + 152820 1.002909960394694e+00 -5.958295830262862e+00 -5.996574135811009e+00 3.945221405634840e+00 4.725421451628737e+00 9.206521534613526e+03 + 152840 1.049340940448883e+00 -6.032053488185921e+00 -6.013369327541003e+00 3.499621224820776e+00 4.606908566608410e+00 9.258149517155152e+03 + 152860 9.552944572485400e-01 -5.901413573379068e+00 -6.033433121129609e+00 4.235641316391090e+00 4.477564643248500e+00 9.319962416598990e+03 + 152880 1.001238933322254e+00 -5.983068787004171e+00 -6.018187951148816e+00 3.804326385125058e+00 4.602666709933416e+00 9.272958364873710e+03 + 152900 1.045583396787685e+00 -6.071694065072273e+00 -6.017245159213985e+00 3.320603455657172e+00 4.633257499036409e+00 9.270084911892520e+03 + 152920 9.760510207340989e-01 -6.003371857535328e+00 -6.032117048297929e+00 3.645590097358416e+00 4.480530763695667e+00 9.315895805861030e+03 + 152940 9.613747960673488e-01 -6.023372271324771e+00 -6.023539436153528e+00 3.545728457187481e+00 4.544768570872083e+00 9.289441006479201e+03 + 152960 9.626213296228121e-01 -6.066835953596167e+00 -5.976457042763319e+00 3.381964561721490e+00 4.900934253814952e+00 9.144934496002877e+03 + 152980 9.462104689922540e-01 -6.078670493013249e+00 -5.992996153318811e+00 3.269370609250515e+00 4.761325925837198e+00 9.195588810865202e+03 + 153000 8.788373256814356e-01 -6.003928805939038e+00 -6.026385224462270e+00 3.670973573715602e+00 4.542025343435670e+00 9.298241825249623e+03 + 153020 9.969368942648322e-01 -6.195097486899137e+00 -5.964046704298610e+00 2.684114957557548e+00 5.010844306242821e+00 9.107040314229964e+03 + 153040 9.392618986218996e-01 -6.118829865922464e+00 -6.017933183328455e+00 3.013374984096410e+00 4.592739349262380e+00 9.272210405991475e+03 + 153060 9.363078166696888e-01 -6.116291488023835e+00 -6.024341624858243e+00 2.983314381357895e+00 4.511304724850061e+00 9.291958710900117e+03 + 153080 9.667008446549012e-01 -6.156012141110791e+00 -5.954260735141370e+00 2.849142343835590e+00 5.007630137841177e+00 9.077190872755367e+03 + 153100 8.735992339277909e-01 -6.003954867271736e+00 -6.024908054785431e+00 3.669088021983172e+00 4.548771576784240e+00 9.293644363126283e+03 + 153120 9.039768161870817e-01 -6.024754910643693e+00 -5.994577505375348e+00 3.575777958844550e+00 4.749061289833756e+00 9.200402349783340e+03 + 153140 9.547856047857561e-01 -6.067868999869823e+00 -6.043347971778338e+00 3.285486207986787e+00 4.426289745904927e+00 9.350588048143516e+03 + 153160 9.771029646153233e-01 -6.064148449236200e+00 -6.015580131006017e+00 3.357869905991578e+00 4.636756705192246e+00 9.264944697437861e+03 + 153180 9.637103805507405e-01 -6.009981024979293e+00 -6.019870740815078e+00 3.585822138419163e+00 4.529033859661505e+00 9.278148140457253e+03 + 153200 9.447780169096544e-01 -5.951049849357537e+00 -6.019395218710231e+00 3.942259326149399e+00 4.549809638914505e+00 9.276686561150704e+03 + 153220 9.735626733495769e-01 -5.969420498445515e+00 -6.025300587178010e+00 3.892122876535245e+00 4.571250759617479e+00 9.294876883141364e+03 + 153240 9.610265611767959e-01 -5.934415803918671e+00 -6.040945926586103e+00 4.040212877577897e+00 4.428500427738298e+00 9.343156908080618e+03 + 153260 9.481231927026337e-01 -5.904789393837875e+00 -5.999381544992257e+00 4.193810701909038e+00 4.650647931892496e+00 9.215140899030426e+03 + 153280 9.782213688880540e-01 -5.940314088004233e+00 -6.001259531361214e+00 4.039418387068326e+00 4.689460220035664e+00 9.220901398364244e+03 + 153300 1.003123243523314e+00 -5.970006846398224e+00 -5.992294591299472e+00 3.810476608074689e+00 4.682496927834348e+00 9.193389325536124e+03 + 153320 9.904573086532718e-01 -5.944207594545228e+00 -6.002229146828857e+00 3.955461907968220e+00 4.622293175949421e+00 9.223889945072231e+03 + 153340 1.002449493439268e+00 -5.955147782143270e+00 -5.974535999241034e+00 3.957435482893847e+00 4.846105340001587e+00 9.139064671872025e+03 + 153360 1.059985694239380e+00 -6.037180141995123e+00 -6.010640438044944e+00 3.444855186736093e+00 4.597250273823934e+00 9.249747995055330e+03 + 153380 1.022722290656006e+00 -5.983609956418340e+00 -5.980134805934759e+00 3.799816603384638e+00 4.819771455239158e+00 9.156169821518946e+03 + 153400 1.097037367047074e+00 -6.096309468548624e+00 -5.996465429942455e+00 3.222164099945383e+00 4.795484020437044e+00 9.206194016866068e+03 + 153420 1.030770880464101e+00 -6.003380074113911e+00 -5.989654575423401e+00 3.695056555980212e+00 4.773870493475172e+00 9.185325590239227e+03 + 153440 9.908544557560722e-01 -5.952598274952019e+00 -6.028928235556302e+00 3.937371861010150e+00 4.499073415197122e+00 9.306069028368243e+03 + 153460 9.829452643138996e-01 -5.952253397929202e+00 -6.010844794705353e+00 3.957797720682790e+00 4.621356853404786e+00 9.250368403505921e+03 + 153480 1.027339726141806e+00 -6.030433789177856e+00 -6.024391935516743e+00 3.537387005737943e+00 4.572080264433890e+00 9.292084529715423e+03 + 153500 1.023849961036998e+00 -6.044975767954078e+00 -5.990247144830064e+00 3.445910683335350e+00 4.760170906540494e+00 9.187150619517564e+03 + 153520 9.547442190166811e-01 -5.965966181443966e+00 -6.035065954131987e+00 3.828242526057328e+00 4.431460938127449e+00 9.325017367878658e+03 + 153540 1.019553052641491e+00 -6.092683179443765e+00 -5.986958359559166e+00 3.179270945097727e+00 4.786359221738092e+00 9.177067918133298e+03 + 153560 9.661256427502110e-01 -6.048467106918759e+00 -5.982163206343514e+00 3.423966649087431e+00 4.804693906685943e+00 9.162362600295761e+03 + 153580 9.175701559950632e-01 -6.012024366023091e+00 -5.936124898335567e+00 3.652763329656314e+00 5.088589818522743e+00 9.021990595011657e+03 + 153600 9.022807241043519e-01 -6.016378919778482e+00 -5.965886617405851e+00 3.619955482293023e+00 4.909890096175211e+00 9.112631575299682e+03 + 153620 9.573449953944353e-01 -6.121536261596678e+00 -5.978906736587676e+00 3.088905269802506e+00 4.907906074251850e+00 9.152424743540423e+03 + 153640 9.272487411317598e-01 -6.095656336233136e+00 -5.949675136093950e+00 3.147663190549060e+00 4.985909832265980e+00 9.063214169415332e+03 + 153660 8.767374418213179e-01 -6.029544094242864e+00 -6.018545095497592e+00 3.454139121203798e+00 4.517297074088706e+00 9.274063761594572e+03 + 153680 9.666683368634530e-01 -6.164456121813123e+00 -5.955218010683176e+00 2.782526596188335e+00 4.984004209789537e+00 9.080082666283019e+03 + 153700 8.794937894475620e-01 -6.027258036991245e+00 -5.971929843182073e+00 3.590246663221222e+00 4.907949714083814e+00 9.131076505607400e+03 + 153720 9.641473479542558e-01 -6.131525861154378e+00 -5.949849627419757e+00 3.047983097016624e+00 5.091196145427130e+00 9.063735016651513e+03 + 153740 9.473542403892279e-01 -6.068086599518979e+00 -5.952590971779626e+00 3.337317960086676e+00 5.000511727456669e+00 9.072094896664770e+03 + 153760 9.969739157248306e-01 -6.085985269030145e+00 -5.986071301259081e+00 3.204821608077544e+00 4.778543072655536e+00 9.174316988321079e+03 + 153780 9.676419825191406e-01 -5.982243014527521e+00 -6.000636628308075e+00 3.799938448870523e+00 4.694319472140048e+00 9.218997498861174e+03 + 153800 9.941716391912007e-01 -5.973791920685066e+00 -5.986089372779013e+00 3.880624619365888e+00 4.810010746417884e+00 9.174371035872664e+03 + 153820 9.626057239374757e-01 -5.897159334753761e+00 -6.032827387437418e+00 4.246392525307648e+00 4.467365572234788e+00 9.318049720931374e+03 + 153840 1.003440677831400e+00 -5.940320484278769e+00 -5.944564562322978e+00 4.059856484249380e+00 5.035486331350576e+00 9.047629498799410e+03 + 153860 1.044376643708210e+00 -5.989244937005662e+00 -5.970829355362403e+00 3.804426409425975e+00 4.910171529023620e+00 9.127703964085449e+03 + 153880 1.092648252342945e+00 -6.053321206300581e+00 -6.020163700156647e+00 3.453030192198693e+00 4.643425723584648e+00 9.279038146164243e+03 + 153900 9.935389305330289e-01 -5.905550950552178e+00 -6.037455237535251e+00 4.235294584885150e+00 4.477879756905899e+00 9.332399147615497e+03 + 153920 1.054973676932879e+00 -6.000626110001885e+00 -6.048369914216551e+00 3.648781496459367e+00 4.374629184328930e+00 9.366144515964897e+03 + 153940 1.028336474424619e+00 -5.970130267083856e+00 -6.008690719962944e+00 3.895340055551937e+00 4.673919967909415e+00 9.243768101206140e+03 + 153960 1.043782559703057e+00 -6.006934579772891e+00 -5.990275543346154e+00 3.711313767348333e+00 4.806972532488210e+00 9.187187738415490e+03 + 153980 1.032681045868201e+00 -6.005836048067446e+00 -5.978672109091969e+00 3.649075586495680e+00 4.805055127698843e+00 9.151680134737024e+03 + 154000 1.006080890299680e+00 -5.982756562088112e+00 -6.009717087762290e+00 3.798318232553808e+00 4.643506722004813e+00 9.246902604799121e+03 + 154020 9.938012898309097e-01 -5.984191769701455e+00 -6.030521179340216e+00 3.751615145645855e+00 4.485584506047119e+00 9.310983881207705e+03 + 154040 1.029228187109917e+00 -6.057995793930031e+00 -5.977659898696462e+00 3.418668609902217e+00 4.879969752272980e+00 9.148584361984618e+03 + 154060 9.448789164223784e-01 -5.953630557006893e+00 -6.010437846705200e+00 3.996607726730534e+00 4.670411478383182e+00 9.249109060347453e+03 + 154080 1.009757339626900e+00 -6.068588255829212e+00 -5.980761570543135e+00 3.376924354305031e+00 4.881238772353312e+00 9.158100821936592e+03 + 154100 9.392274216121579e-01 -5.981859031018712e+00 -6.030878378208710e+00 3.811658282361489e+00 4.530181605077063e+00 9.312090458607387e+03 + 154120 1.013398561154043e+00 -6.108927377502023e+00 -5.981959008347394e+00 3.139203651328573e+00 4.868275675306080e+00 9.161776405733168e+03 + 154140 9.847284461100466e-01 -6.082163747212057e+00 -6.002491596351607e+00 3.232770344824009e+00 4.690260164290210e+00 9.224723281347957e+03 + 154160 8.891249252763935e-01 -5.954036926601228e+00 -5.999353912640581e+00 3.973152165212837e+00 4.712935018593948e+00 9.215051434976633e+03 + 154180 1.010695062991616e+00 -6.144228698042324e+00 -5.986388248200079e+00 2.893246582419514e+00 4.799590871144355e+00 9.175297550585898e+03 + 154200 8.976551954383657e-01 -5.982154802278624e+00 -6.034669217880718e+00 3.777458515093786e+00 4.475912614127008e+00 9.323771414901508e+03 + 154220 9.267975141770829e-01 -6.025942909113143e+00 -6.025102861691266e+00 3.522290435190690e+00 4.527114117484023e+00 9.294273133982944e+03 + 154240 9.747091464879393e-01 -6.090851176663282e+00 -6.017697597758962e+00 3.223524536828151e+00 4.643583707376502e+00 9.271463412809058e+03 + 154260 8.991316002943195e-01 -5.966303028795561e+00 -5.997456858739715e+00 3.904234604861705e+00 4.725344492282767e+00 9.209245800359011e+03 + 154280 9.517127353987361e-01 -6.019742815986369e+00 -5.990321042541113e+00 3.580771024045219e+00 4.749715400172608e+00 9.187364369645513e+03 + 154300 1.022103448853994e+00 -6.082870360477687e+00 -6.003676220204540e+00 3.265347900906856e+00 4.720092909608873e+00 9.228369775409104e+03 + 154320 1.009698595177319e+00 -6.015308589739647e+00 -6.065904331185815e+00 3.580529316953831e+00 4.290000739904252e+00 9.420493181511301e+03 + 154340 9.520899029581139e-01 -5.885820376740973e+00 -6.031291122647040e+00 4.297842788383287e+00 4.462527253865482e+00 9.313362351734597e+03 + 154360 1.039817945788410e+00 -5.979074963860912e+00 -5.965693378358049e+00 3.873264613599658e+00 4.950103748350764e+00 9.112019940709477e+03 + 154380 1.042665236396224e+00 -5.952602664287590e+00 -6.035252045076518e+00 3.901890441206923e+00 4.427304906766555e+00 9.325587652223721e+03 + 154400 1.056671231701882e+00 -5.953477353435457e+00 -6.031531570526425e+00 3.932524534342086e+00 4.484325140954686e+00 9.314086686568638e+03 + 154420 1.041206936490361e+00 -5.919790783163110e+00 -6.036283992811867e+00 4.122831491696986e+00 4.453909454627898e+00 9.328766334648357e+03 + 154440 1.077353464080280e+00 -5.971906687747246e+00 -6.020854921047511e+00 3.799361646520855e+00 4.518293316196107e+00 9.281176911086073e+03 + 154460 1.050662359765104e+00 -5.938111412813444e+00 -5.997530544599448e+00 3.992707872859653e+00 4.651514023063493e+00 9.209470160265948e+03 + 154480 1.044188756724534e+00 -5.939293008700773e+00 -5.995886893698918e+00 3.996457685880661e+00 4.671486840345914e+00 9.204413585341727e+03 + 154500 1.056411966800912e+00 -5.971606862999575e+00 -5.988314213086397e+00 3.881084573767780e+00 4.785148384115178e+00 9.181176802076287e+03 + 154520 1.006109171421546e+00 -5.914268114855199e+00 -6.038180177857820e+00 4.117815343033474e+00 4.406293101942648e+00 9.334595006468091e+03 + 154540 1.052493294595480e+00 -6.005321365856107e+00 -6.001714903300647e+00 3.713800387418453e+00 4.734509253510177e+00 9.222313349846541e+03 + 154560 1.017567024626996e+00 -5.980702188931515e+00 -6.021083183032514e+00 3.782711302634873e+00 4.550837385568290e+00 9.281897505798352e+03 + 154580 1.029368401639717e+00 -6.029537199522997e+00 -6.002248626779322e+00 3.514687021347194e+00 4.671382228934362e+00 9.223962022826190e+03 + 154600 1.016554670475315e+00 -6.041754999992593e+00 -5.973443823636511e+00 3.477049771702257e+00 4.869303117459255e+00 9.135707477755164e+03 + 154620 1.002347071816549e+00 -6.046517669782873e+00 -5.961707286988086e+00 3.441065667171873e+00 4.928060009543863e+00 9.099875812788687e+03 + 154640 9.526002382775833e-01 -5.993792867952488e+00 -6.037056613503819e+00 3.745990949928134e+00 4.497563827929403e+00 9.331169596918073e+03 + 154660 1.006998132780232e+00 -6.091282498006998e+00 -5.987972692843293e+00 3.198479097300505e+00 4.791699985691179e+00 9.180191744120095e+03 + 154680 9.855735511252161e-01 -6.071082940301535e+00 -6.024602928029518e+00 3.280315971981467e+00 4.547211395206045e+00 9.292754343494769e+03 + 154700 9.987860882714890e-01 -6.097433771488230e+00 -6.001418740183117e+00 3.187286408718414e+00 4.738619576750452e+00 9.221422727191490e+03 + 154720 9.885942687883705e-01 -6.086037059760309e+00 -6.005148637832950e+00 3.262154145199430e+00 4.726627981349163e+00 9.232872842498065e+03 + 154740 1.000484362593262e+00 -6.102551110553986e+00 -5.969756779877024e+00 3.132820338525222e+00 4.895345935128592e+00 9.124454428296962e+03 + 154760 9.623357330313957e-01 -6.041942160877678e+00 -5.998271164052441e+00 3.477105226686450e+00 4.727870848521878e+00 9.211747087016871e+03 + 154780 9.120489470733505e-01 -5.961673508596509e+00 -6.027722346101544e+00 3.880697314254594e+00 4.501434668276116e+00 9.302337071551781e+03 + 154800 9.446420730459519e-01 -6.001939354056098e+00 -5.985688169431195e+00 3.730754405218601e+00 4.824071222197489e+00 9.173143066909055e+03 + 154820 9.364642473442250e-01 -5.978841645601251e+00 -5.978854311216190e+00 3.787346787231974e+00 4.787274059310996e+00 9.152254800597519e+03 + 154840 9.903654985101851e-01 -6.045655042458341e+00 -5.993477139563081e+00 3.422808995321298e+00 4.722422588250257e+00 9.197051251903724e+03 + 154860 9.836687708530971e-01 -6.022210411091764e+00 -6.043196821196949e+00 3.596496089502685e+00 4.475988875042244e+00 9.350140963723992e+03 + 154880 9.337780692557968e-01 -5.938960945611880e+00 -6.062915981825025e+00 3.959821812262275e+00 4.248052812346536e+00 9.411213393050923e+03 + 154900 1.039395085132604e+00 -6.087293198703271e+00 -5.987438224943905e+00 3.275703609341793e+00 4.849086321175315e+00 9.178534791128577e+03 + 154920 9.883209247688736e-01 -6.002477573116246e+00 -6.015988151753326e+00 3.694977102334287e+00 4.617397269044886e+00 9.266177920584181e+03 + 154940 9.686264342623134e-01 -5.963883416001982e+00 -6.008055264186673e+00 3.836715109180907e+00 4.583073521332997e+00 9.241812636574761e+03 + 154960 1.043631862460856e+00 -6.063973094014504e+00 -5.986436178312775e+00 3.369834934786154e+00 4.815063903544408e+00 9.175480488115734e+03 + 154980 9.650582382571515e-01 -5.936681899378245e+00 -6.034724945559202e+00 4.037046001893794e+00 4.474067658610376e+00 9.323953457007387e+03 + 155000 1.035056902793770e+00 -6.033265329854432e+00 -5.966780518779539e+00 3.537344406204184e+00 4.919110479887483e+00 9.115359997335991e+03 + 155020 1.010303888629375e+00 -5.989269439649504e+00 -6.006877358014536e+00 3.743124013928789e+00 4.642016621860209e+00 9.238151058921952e+03 + 155040 9.914973223094834e-01 -5.952485873759290e+00 -6.033725944173218e+00 3.900639786064115e+00 4.434146729887075e+00 9.320854594971821e+03 + 155060 1.057460335104942e+00 -6.042651673292700e+00 -5.993463286420224e+00 3.484674397250779e+00 4.767121726550806e+00 9.197003528155330e+03 + 155080 9.722620562372843e-01 -5.908752667586335e+00 -5.990254974933360e+00 4.226402970241930e+00 4.758404109014014e+00 9.187158956624247e+03 + 155100 1.041578493503403e+00 -6.002341114401576e+00 -6.009647876754705e+00 3.714135324297154e+00 4.672178764147660e+00 9.246681870184239e+03 + 155120 1.041435836887612e+00 -5.990281481912597e+00 -6.024638969735434e+00 3.765918469679080e+00 4.568632457796296e+00 9.292837383047796e+03 + 155140 1.061291202962360e+00 -6.008097191518011e+00 -6.024181590967688e+00 3.679163574624073e+00 4.586804463931262e+00 9.291426788958108e+03 + 155160 1.047448198177473e+00 -5.976095052715634e+00 -6.035215607405886e+00 3.819167572829837e+00 4.479688198922140e+00 9.325473718520625e+03 + 155180 1.088754246874466e+00 -6.028814091855928e+00 -5.971248585753687e+00 3.566744401615643e+00 4.897294445887988e+00 9.129009412207473e+03 + 155200 1.016608044376245e+00 -5.913871592854204e+00 -6.039546291258212e+00 4.124355575520633e+00 4.402712009188101e+00 9.338849999580167e+03 + 155220 1.011504184395611e+00 -5.903366027331806e+00 -6.047389268381857e+00 4.231320649803256e+00 4.404316912169343e+00 9.363070355941267e+03 + 155240 1.071295279424158e+00 -5.994786209954467e+00 -6.046987099676588e+00 3.690052896497691e+00 4.390307309651690e+00 9.361871414390405e+03 + 155260 1.053722524360117e+00 -5.980221197072319e+00 -6.021875025487752e+00 3.801849016046261e+00 4.562666287375727e+00 9.284310905088021e+03 + 155280 1.090790198209860e+00 -6.053838519153247e+00 -5.951289482473940e+00 3.459922729628629e+00 5.048775167653350e+00 9.068101084046541e+03 + 155300 1.011207572895067e+00 -5.956988867562002e+00 -5.985985380735051e+00 3.961867090381518e+00 4.795364624545959e+00 9.174064775328492e+03 + 155320 1.006504407648036e+00 -5.974424589579948e+00 -6.042376941808323e+00 3.797678113692786e+00 4.407485191604939e+00 9.347612098864491e+03 + 155340 1.038854880366614e+00 -6.051189301147229e+00 -6.005123966939442e+00 3.396812090312909e+00 4.661326367921458e+00 9.232811217379762e+03 + 155360 1.022489040317271e+00 -6.058836749789315e+00 -5.969386158484447e+00 3.475717352507204e+00 4.989356490214021e+00 9.123301553288591e+03 + 155380 1.014544281163765e+00 -6.075096379394166e+00 -5.995218061641643e+00 3.296395204902759e+00 4.755068866567466e+00 9.202378480461513e+03 + 155400 9.559461935484818e-01 -6.013778226130894e+00 -5.982696124984864e+00 3.584693535240283e+00 4.763171769960392e+00 9.164016333722568e+03 + 155420 9.742975685088897e-01 -6.059866047811530e+00 -5.949499880338741e+00 3.403033160974968e+00 5.036772773712944e+00 9.062665376014393e+03 + 155440 9.883034321457554e-01 -6.094304241457007e+00 -5.968940994276501e+00 3.201747554784375e+00 4.921602719994638e+00 9.121945987859974e+03 + 155460 9.863232496103932e-01 -6.099621375215275e+00 -5.972986819736896e+00 3.168361648924166e+00 4.895516863115143e+00 9.134319448441529e+03 + 155480 9.077974402566161e-01 -5.985752506666948e+00 -6.031573625243134e+00 3.816336240832210e+00 4.553224287172574e+00 9.314220576921434e+03 + 155500 9.885345826337424e-01 -6.104095591786633e+00 -5.975247824185892e+00 3.110402238683869e+00 4.850266059374921e+00 9.141233940022905e+03 + 155520 1.015824948648091e+00 -6.138532878060566e+00 -5.952567812812851e+00 2.950721416822712e+00 5.018561599475936e+00 9.072009584539368e+03 + 155540 9.812670754642160e-01 -6.072861301059818e+00 -6.003457304417253e+00 3.320607243375947e+00 4.719135732331329e+00 9.227688118560482e+03 + 155560 9.546894915921815e-01 -6.013897599782829e+00 -6.028821599306686e+00 3.630530302899227e+00 4.544834388151776e+00 9.305763706607768e+03 + 155580 9.624324658799677e-01 -5.998873025801113e+00 -6.023930486324878e+00 3.667067601244392e+00 4.523183785287447e+00 9.290656488576948e+03 + 155600 1.033203170669302e+00 -6.068753016955212e+00 -5.998868482269229e+00 3.295825791295843e+00 4.697113604059545e+00 9.213593200067369e+03 + 155620 1.106133514291326e+00 -6.133681148039849e+00 -5.981476204342202e+00 2.995949345124469e+00 4.869933685475274e+00 9.160273873662969e+03 + 155640 1.024351242360092e+00 -5.969707618402991e+00 -6.003469187820439e+00 3.863905056946735e+00 4.670040900765763e+00 9.227702651371414e+03 + 155660 9.601339179608509e-01 -5.837627598919338e+00 -6.065888349858691e+00 4.531111896348618e+00 4.220403341217808e+00 9.420342824656331e+03 + 155680 1.015983081776965e+00 -5.891613233582048e+00 -6.006185725404034e+00 4.229429852934018e+00 4.571536874856371e+00 9.236040997258324e+03 + 155700 1.093403137191323e+00 -5.984000314471436e+00 -5.993919306734241e+00 3.837977404279981e+00 4.781021015747863e+00 9.198376782757394e+03 + 155720 9.964840804970309e-01 -5.830294643931099e+00 -5.988778879480504e+00 4.599105167342852e+00 4.689064161461975e+00 9.182612104095408e+03 + 155740 1.132352218787188e+00 -6.028278700333013e+00 -5.994184507249237e+00 3.557687517078174e+00 4.753461649824546e+00 9.199177121952112e+03 + 155760 1.052859249978167e+00 -5.915467756682727e+00 -6.058292093411502e+00 4.163582927811536e+00 4.343463484320232e+00 9.396857416898505e+03 + 155780 1.098535808826655e+00 -5.997014267934558e+00 -6.009639015376395e+00 3.703876900104375e+00 4.631383646619994e+00 9.246661503300144e+03 + 155800 1.007069154100690e+00 -5.877486615868667e+00 -5.981380048376424e+00 4.398729458987925e+00 4.802157292071667e+00 9.159947486844745e+03 + 155820 1.023878129901651e+00 -5.915327796069828e+00 -6.006949935625534e+00 4.174690608207760e+00 4.648582104398625e+00 9.238348513479963e+03 + 155840 1.059814095847255e+00 -5.980261146204718e+00 -6.051766594778003e+00 3.774650120958275e+00 4.364054769818067e+00 9.376625730390850e+03 + 155860 1.139290421738917e+00 -6.115998943307925e+00 -5.975275989028055e+00 3.056520302391248e+00 4.864573282673060e+00 9.141341782463545e+03 + 155880 9.981908238546902e-01 -5.926913117107254e+00 -5.994911366547557e+00 4.165780225675929e+00 4.775323754694614e+00 9.201437247012262e+03 + 155900 1.002792510749386e+00 -5.953124735761390e+00 -6.042992285277506e+00 3.926649903096367e+00 4.410616526816483e+00 9.349523469527163e+03 + 155920 9.945031672500202e-01 -5.959463760407226e+00 -6.037594810679018e+00 3.944078838937155e+00 4.495438257535570e+00 9.332804785542416e+03 + 155940 9.850905384689252e-01 -5.962716826341114e+00 -6.024792714950874e+00 3.891147331570772e+00 4.534697972960814e+00 9.293316680392380e+03 + 155960 1.011653132141998e+00 -6.018644201957330e+00 -6.014584062783694e+00 3.571068042134197e+00 4.594381989573719e+00 9.261883706508699e+03 + 155980 9.371380778417941e-01 -5.922981565632353e+00 -5.996843727456358e+00 4.135278859213571e+00 4.711150895887531e+00 9.207359068338445e+03 + 156000 9.851230987112951e-01 -6.004878197790578e+00 -5.962133440557000e+00 3.652274632626282e+00 4.897721643391293e+00 9.101169737538214e+03 + 156020 9.990774585533788e-01 -6.032995610621001e+00 -6.012875936001409e+00 3.510112531514966e+00 4.625642816690249e+00 9.256619978974708e+03 + 156040 1.011747495597885e+00 -6.057249728880647e+00 -5.999241132703499e+00 3.367203003745300e+00 4.700297339795726e+00 9.214735036419277e+03 + 156060 1.063585064737059e+00 -6.139408995420933e+00 -5.969327801771431e+00 2.989396851156600e+00 4.966029385071694e+00 9.123138460588090e+03 + 156080 9.641798038935850e-01 -5.995343728123187e+00 -6.023021890624529e+00 3.771814504942692e+00 4.612882212678183e+00 9.287839999837002e+03 + 156100 1.003090409415947e+00 -6.055691296501591e+00 -5.999080117361984e+00 3.417468219278377e+00 4.742538370449654e+00 9.214222853198764e+03 + 156120 9.390381197776414e-01 -5.961113833621155e+00 -6.040690526836850e+00 3.869743148953634e+00 4.412801462055636e+00 9.342394299930696e+03 + 156140 9.109249101219047e-01 -5.917681603447852e+00 -6.038896976955733e+00 4.073734085726843e+00 4.377696653026162e+00 9.336826763981226e+03 + 156160 1.019794619009582e+00 -6.073377437246371e+00 -5.961722555472705e+00 3.349387993824565e+00 4.990527603506070e+00 9.099930599153546e+03 + 156180 1.019154207653741e+00 -6.058072738377920e+00 -6.021262427045079e+00 3.410416214388498e+00 4.621786718438941e+00 9.282441997596097e+03 + 156200 9.609526069457154e-01 -5.952472589226481e+00 -6.025903173115400e+00 3.932921154646199e+00 4.511271378609896e+00 9.296741948251791e+03 + 156220 1.001043112834890e+00 -5.982341694331422e+00 -5.988434244038456e+00 3.829648002381205e+00 4.794663639144392e+00 9.181553288765843e+03 + 156240 9.952326640482679e-01 -5.929245085809661e+00 -6.048950060377127e+00 4.081486999461239e+00 4.394122511209905e+00 9.367919609744566e+03 + 156260 1.072756704655115e+00 -5.996960179455620e+00 -6.029950125559624e+00 3.690207862303613e+00 4.500774486596763e+00 9.309227207156920e+03 + 156280 1.013614955635552e+00 -5.870773792142417e+00 -6.037293102255300e+00 4.402582445094914e+00 4.446402797646784e+00 9.331883622983794e+03 + 156300 1.055384163672764e+00 -5.904465956091917e+00 -5.995221977014692e+00 4.203043360599409e+00 4.681908244011982e+00 9.202356617316394e+03 + 156320 1.015397216574106e+00 -5.823621163102004e+00 -5.993618855450769e+00 4.624205993379015e+00 4.648052936854535e+00 9.197408735938725e+03 + 156340 1.087146289081227e+00 -5.915924775817325e+00 -5.962802958618751e+00 4.090276423514592e+00 4.821094643493460e+00 9.103186919996086e+03 + 156360 1.038832348907501e+00 -5.836962326337999e+00 -6.014769479880101e+00 4.503902970224948e+00 4.482906779018111e+00 9.262429412176094e+03 + 156380 1.117641657109536e+00 -5.956120259857387e+00 -5.995846331590268e+00 3.941174450640115e+00 4.713061199160181e+00 9.204267095964839e+03 + 156400 1.080602510073727e+00 -5.912883905079114e+00 -6.005055901154387e+00 4.135881484286486e+00 4.606615619251970e+00 9.232550863667015e+03 + 156420 1.015369853445159e+00 -5.837795996599421e+00 -6.018230258854945e+00 4.571552135200927e+00 4.535470679217863e+00 9.273087401370789e+03 + 156440 1.116103947650118e+00 -6.017424889882971e+00 -5.976440752276223e+00 3.682639541668831e+00 4.917976802081576e+00 9.144858400394629e+03 + 156460 1.092769064215351e+00 -6.023542121639212e+00 -5.999008060798825e+00 3.584859023385814e+00 4.725737397364965e+00 9.214003906910191e+03 + 156480 1.037669976125390e+00 -5.984915596349691e+00 -6.013467000131739e+00 3.753439163514512e+00 4.589492584682533e+00 9.258432795034898e+03 + 156500 1.046553427409252e+00 -6.035946978274758e+00 -6.021143740525937e+00 3.502290793866459e+00 4.587293275813829e+00 9.282065351618279e+03 + 156520 1.015782283051081e+00 -6.022934476135940e+00 -6.025768095866501e+00 3.561401748456954e+00 4.545130665462838e+00 9.296287322666318e+03 + 156540 9.432264844886296e-01 -5.939019675339206e+00 -6.031603387012860e+00 4.004180264741649e+00 4.472550265028447e+00 9.314293213354391e+03 + 156560 9.805687936000543e-01 -6.009118622692423e+00 -6.011476841579672e+00 3.663701995120478e+00 4.650160737336702e+00 9.252287208458176e+03 + 156580 9.829337792183133e-01 -6.021831343743437e+00 -5.999291391585315e+00 3.587518559512631e+00 4.716946452850889e+00 9.214860689132303e+03 + 156600 9.913589372530340e-01 -6.038629645227829e+00 -5.971977789750348e+00 3.494821393812114e+00 4.877546662305112e+00 9.131222593573433e+03 + 156620 9.967725493112850e-01 -6.048315203686377e+00 -5.976963443925165e+00 3.436716227430488e+00 4.846429073628507e+00 9.146456864043907e+03 + 156640 1.026767591212955e+00 -6.091996373300296e+00 -5.975948420162380e+00 3.219090266285857e+00 4.885455571566478e+00 9.143343084268938e+03 + 156660 9.291764153782525e-01 -5.944657951602942e+00 -6.009470843749691e+00 4.015882142928965e+00 4.643716486459685e+00 9.246117237877334e+03 + 156680 1.005280362309762e+00 -6.051563900604213e+00 -5.974686341121933e+00 3.417543912404411e+00 4.858986755715549e+00 9.139484794370057e+03 + 156700 9.992639319888027e-01 -6.034749473561571e+00 -5.972288352867204e+00 3.518288975098570e+00 4.876950395952816e+00 9.132190167618193e+03 + 156720 9.516052486632066e-01 -5.953114996471902e+00 -6.017959103336563e+00 3.971312914206007e+00 4.598968017996016e+00 9.272251518344594e+03 + 156740 9.751507718386345e-01 -5.974512103796578e+00 -6.023987043353328e+00 3.874348379813012e+00 4.590255620656001e+00 9.290822372255067e+03 + 156760 9.646689384553735e-01 -5.944008880182968e+00 -6.041119270709475e+00 3.962089644884244e+00 4.404466754696675e+00 9.343713441704891e+03 + 156780 9.870792174785599e-01 -5.961074132495041e+00 -5.999057298311868e+00 3.903521554840482e+00 4.685416338844347e+00 9.214152307847327e+03 + 156800 1.069617506845110e+00 -6.063495803781873e+00 -5.955635750534007e+00 3.362699799617932e+00 4.982048916656476e+00 9.081371265339438e+03 + 156820 1.014449764805830e+00 -5.957839963746443e+00 -5.998112598996258e+00 3.947334018542061e+00 4.716082314767458e+00 9.211243456001532e+03 + 156840 1.096186385861377e+00 -6.051851488654359e+00 -5.970996054770513e+00 3.441937311837814e+00 4.906221725536811e+00 9.128208772096474e+03 + 156860 9.951249893995683e-01 -5.873342655746431e+00 -6.010071723735328e+00 4.353436779631140e+00 4.568317312484000e+00 9.247935734267356e+03 + 156880 1.048712750449049e+00 -5.920499500150036e+00 -5.952384535590358e+00 4.137844818474079e+00 4.954756010782457e+00 9.071406467579274e+03 + 156900 1.056515038695708e+00 -5.895690937675800e+00 -5.982991389947125e+00 4.284984816990825e+00 4.783692110347554e+00 9.164867015284124e+03 + 156920 1.105078396103916e+00 -5.931851520081457e+00 -6.030796998413899e+00 4.034788088542762e+00 4.466627840194596e+00 9.311795850556864e+03 + 156940 1.099777838596810e+00 -5.895211644363241e+00 -6.056351713464003e+00 4.182153284508842e+00 4.256862071387165e+00 9.390838665671847e+03 + 156960 1.071742439975349e+00 -5.836578673374818e+00 -6.051888869362928e+00 4.544513562631026e+00 4.308169098122154e+00 9.376986452750667e+03 + 156980 1.054475492560718e+00 -5.805955899100940e+00 -6.020717472631752e+00 4.737430004809797e+00 4.504235815349783e+00 9.280706229068415e+03 + 157000 1.142860433472879e+00 -5.941816423490788e+00 -6.019534558078012e+00 4.032950823108855e+00 4.586681267466561e+00 9.277066605409145e+03 + 157020 1.062622493338061e+00 -5.843525353233388e+00 -6.064790475018648e+00 4.498348373514592e+00 4.227809803556694e+00 9.416989485221964e+03 + 157040 1.091539414494438e+00 -5.931480737932060e+00 -6.005510042661849e+00 4.023203317868013e+00 4.598115594111680e+00 9.233967471476586e+03 + 157060 1.032116976829460e+00 -5.906596294733038e+00 -6.012549521037408e+00 4.163786529025667e+00 4.555386707377198e+00 9.255568719159790e+03 + 157080 1.007582193526400e+00 -5.933097264583997e+00 -5.995729330970470e+00 4.039702297778644e+00 4.680059280306573e+00 9.203955471330619e+03 + 157100 9.896826739414173e-01 -5.955258450748525e+00 -6.030704566855634e+00 3.905376156660423e+00 4.472152882724675e+00 9.311559972260700e+03 + 157120 1.042940571472123e+00 -6.065074415784890e+00 -5.983400746921841e+00 3.339358764897483e+00 4.808341610468521e+00 9.166164208962065e+03 + 157140 9.589700562608268e-01 -5.959330021442903e+00 -6.042723456121260e+00 3.912986425373518e+00 4.434128418358083e+00 9.348678495264727e+03 + 157160 9.629021088978623e-01 -5.979889871749885e+00 -6.011243202394236e+00 3.785441285732074e+00 4.605405609259972e+00 9.251609294110604e+03 + 157180 1.005790794598529e+00 -6.054794439742697e+00 -5.997737756898220e+00 3.385317515781769e+00 4.712945818167891e+00 9.210113343501733e+03 + 157200 9.902741142434432e-01 -6.040599465257844e+00 -6.026831781891191e+00 3.403359778422529e+00 4.482415946855964e+00 9.299609918739154e+03 + 157220 9.800126280290037e-01 -6.031103688883891e+00 -6.003087114168600e+00 3.543813984901270e+00 4.704689492467397e+00 9.226510883837142e+03 + 157240 9.670576831069158e-01 -6.013250071269490e+00 -6.022343809787680e+00 3.637639795407150e+00 4.585422141584218e+00 9.285761266061034e+03 + 157260 9.967855240684532e-01 -6.058884703230060e+00 -5.957752991741849e+00 3.413495841172593e+00 4.994209778619673e+00 9.087824545238231e+03 + 157280 9.454745252467858e-01 -5.982260287942500e+00 -5.981484619526378e+00 3.798255854708663e+00 4.802709862788335e+00 9.160293606043782e+03 + 157300 9.623262530696711e-01 -6.000526819987513e+00 -6.013050354267374e+00 3.713587493944276e+00 4.641675422098647e+00 9.257150123927047e+03 + 157320 1.003892435471925e+00 -6.052968344125878e+00 -5.982609639753900e+00 3.420042741725688e+00 4.824053310203900e+00 9.163737228298145e+03 + 157340 9.770093710873025e-01 -6.000808518935791e+00 -5.975172066354933e+00 3.737081720305492e+00 4.884290198252994e+00 9.140971816895339e+03 + 157360 1.002396486050873e+00 -6.020820637139413e+00 -6.004899937567920e+00 3.570229333651800e+00 4.661648454311607e+00 9.232116354268739e+03 + 157380 1.014581446087795e+00 -6.018282131158774e+00 -6.005542311517429e+00 3.620896720460178e+00 4.694050736321502e+00 9.234075132789141e+03 + 157400 1.015772543770686e+00 -5.999227493910452e+00 -5.998751406932449e+00 3.672347133385771e+00 4.675080898487686e+00 9.213197655499147e+03 + 157420 9.641884629082225e-01 -5.901067266356829e+00 -5.959531839648802e+00 4.236735552452531e+00 4.901022925246545e+00 9.093201611283204e+03 + 157440 1.043660013327860e+00 -5.992911390122451e+00 -5.951062171620124e+00 3.737972606031273e+00 4.978277294817271e+00 9.067395098640267e+03 + 157460 1.080946425449140e+00 -6.019129689234010e+00 -6.003343981889150e+00 3.586051732349769e+00 4.676695706754275e+00 9.227313490413826e+03 + 157480 1.059580570669120e+00 -5.962573665041109e+00 -6.009518433795272e+00 3.884656352882016e+00 4.615092226016130e+00 9.246289929634040e+03 + 157500 1.073895919835061e+00 -5.965259108893285e+00 -5.988595082300522e+00 3.841443506353528e+00 4.707444735818962e+00 9.182057263372242e+03 + 157520 1.087095053756703e+00 -5.968328290356059e+00 -5.977469044991816e+00 3.879557852510749e+00 4.827070224865023e+00 9.148005575274461e+03 + 157540 1.046790518674720e+00 -5.899398356682418e+00 -6.023693505008726e+00 4.219877654449749e+00 4.506155678148043e+00 9.289868774807712e+03 + 157560 9.858667654243174e-01 -5.806736446224214e+00 -6.051392685082196e+00 4.673292311813251e+00 4.268438327860115e+00 9.375438258802145e+03 + 157580 1.014169505772033e+00 -5.849674274562933e+00 -6.041268313736410e+00 4.490780234777486e+00 4.390617612761640e+00 9.344155731429628e+03 + 157600 1.073579895392337e+00 -5.948411847254055e+00 -6.031069790684841e+00 3.993135125270185e+00 4.518500422815203e+00 9.312660407838483e+03 + 157620 1.060948921897720e+00 -5.957738740207255e+00 -6.015871045644660e+00 3.894432896759985e+00 4.560628202993212e+00 9.265849596706144e+03 + 157640 1.018651875212477e+00 -5.940475884283983e+00 -6.035871716338974e+00 4.029635524696809e+00 4.481857894579750e+00 9.327499059654652e+03 + 157660 1.023956115205057e+00 -6.009112570955598e+00 -5.990857469993908e+00 3.657233957042197e+00 4.762057571731969e+00 9.189033214915740e+03 + 157680 9.782283330662809e-01 -5.996392640005429e+00 -5.975330285400696e+00 3.771299830009306e+00 4.892243129538520e+00 9.141452511621786e+03 + 157700 9.939484311924264e-01 -6.058966906573394e+00 -5.980862014497862e+00 3.391460253657961e+00 4.839950630648655e+00 9.158395900710702e+03 + 157720 9.756425815958355e-01 -6.058841117112107e+00 -6.009186634022923e+00 3.342149142517113e+00 4.627272868421632e+00 9.245287967890446e+03 + 157740 9.646589861040111e-01 -6.059712509620677e+00 -5.993620358889970e+00 3.436472401788079e+00 4.815983759011072e+00 9.197469804168268e+03 + 157760 9.613737819772491e-01 -6.063125334986598e+00 -5.988268235161698e+00 3.320922153074384e+00 4.750763204367719e+00 9.181082802705461e+03 + 157780 9.625500320501665e-01 -6.066815997706712e+00 -5.990562865126814e+00 3.325962737128431e+00 4.763820024536335e+00 9.188100963701669e+03 + 157800 1.022087329745438e+00 -6.153884731326552e+00 -5.942189012114458e+00 2.857369112609981e+00 5.072958692132499e+00 9.040447524138366e+03 + 157820 9.978150040337113e-01 -6.111529153150520e+00 -5.947888774436050e+00 3.088894297865399e+00 5.028542675710651e+00 9.057773441798623e+03 + 157840 9.407446312539284e-01 -6.015528327942970e+00 -5.952729876741563e+00 3.643472157293244e+00 5.004070582120645e+00 9.072482056962537e+03 + 157860 9.350562956983784e-01 -5.989508458687986e+00 -5.960701331769544e+00 3.821825595734427e+00 4.987240576388604e+00 9.096763013474938e+03 + 157880 9.550630295046345e-01 -5.992371069393723e+00 -5.990153699102807e+00 3.777817724310727e+00 4.790550207658109e+00 9.186828678357941e+03 + 157900 9.755250067435878e-01 -5.991959042102112e+00 -6.013474078158187e+00 3.739912097623486e+00 4.616369431148437e+00 9.258454284395735e+03 + 157920 1.024941017091621e+00 -6.035556728790546e+00 -5.994157061413688e+00 3.521672488838974e+00 4.759395785494716e+00 9.199123681315332e+03 + 157940 9.454635831627758e-01 -5.891170429540308e+00 -6.014663494851695e+00 4.268405609881385e+00 4.559289318373303e+00 9.262089778772828e+03 + 157960 9.957779863941147e-01 -5.941597585078336e+00 -6.024278996086787e+00 4.002900694119536e+00 4.528131237202006e+00 9.291731613424263e+03 + 157980 1.050495329301911e+00 -6.002257385002910e+00 -6.025301513883567e+00 3.666018030769961e+00 4.533695076669806e+00 9.294855478650623e+03 + 158000 9.698185724622979e-01 -5.869176786915680e+00 -6.017472669924018e+00 4.376136550976426e+00 4.524598642028819e+00 9.270737902847235e+03 + 158020 1.032633288821288e+00 -5.950669958080143e+00 -5.994446726052686e+00 3.941764849501035e+00 4.690391873369741e+00 9.200009749124796e+03 + 158040 1.085090562188813e+00 -6.023712472208288e+00 -5.953465824692144e+00 3.575160450331492e+00 4.978527571002761e+00 9.074740954529479e+03 + 158060 1.039398072442566e+00 -5.955771632537167e+00 -5.952403081663143e+00 3.916547869641785e+00 4.935890610041992e+00 9.071470558075376e+03 + 158080 1.020344296430323e+00 -5.929683977951738e+00 -5.973634010680438e+00 4.050953615819965e+00 4.798585726646187e+00 9.136245722753114e+03 + 158100 1.067627277999520e+00 -6.004010661859183e+00 -5.957357615035038e+00 3.652847703928093e+00 4.920736718327997e+00 9.086596888298684e+03 + 158120 1.042881421161178e+00 -5.972462623051247e+00 -6.001229601875482e+00 3.808570653913294e+00 4.643386209828949e+00 9.220821322064876e+03 + 158140 1.072667243458804e+00 -6.027703539520227e+00 -5.974441970125278e+00 3.573126807869461e+00 4.878962981536479e+00 9.138760292479083e+03 + 158160 1.048168839899823e+00 -6.005713444124058e+00 -6.008588401400798e+00 3.678853515766183e+00 4.662345066184936e+00 9.243422356220099e+03 + 158180 1.060366561411537e+00 -6.043937768609987e+00 -6.010964443056160e+00 3.452111023799575e+00 4.641448961735285e+00 9.250749211328673e+03 + 158200 9.776658767950973e-01 -5.946275128586545e+00 -6.016941603289514e+00 3.964826016180015e+00 4.559048182833948e+00 9.269150190978158e+03 + 158220 1.020086316005639e+00 -6.040907800079610e+00 -6.003933599130631e+00 3.451126891732048e+00 4.663438475320190e+00 9.229133284875383e+03 + 158240 1.021325134759740e+00 -6.079672339620037e+00 -5.974486900869338e+00 3.320844984225048e+00 4.924836050925604e+00 9.138900320806220e+03 + 158260 9.161689065857410e-01 -5.968827483032936e+00 -6.012396526623854e+00 3.850452050867154e+00 4.600271860280403e+00 9.255131694898164e+03 + 158280 9.426781278613302e-01 -6.054562862578303e+00 -5.964708033150391e+00 3.428870340549007e+00 4.944830676113991e+00 9.109006829536500e+03 + 158300 9.790282043227638e-01 -6.150694730819888e+00 -5.958508512859213e+00 2.875746586960437e+00 4.979309591211742e+00 9.090125796181685e+03 + 158320 8.980618658862692e-01 -6.065861929724618e+00 -5.994323240427315e+00 3.363357041507202e+00 4.774143266028704e+00 9.199638762810440e+03 + 158340 8.949410516783209e-01 -6.083477048113374e+00 -5.968932891367418e+00 3.227466862076468e+00 4.885197135762718e+00 9.121938773333924e+03 + 158360 8.531442364011002e-01 -6.028693901857788e+00 -5.997213428183141e+00 3.578751132784344e+00 4.759516884211727e+00 9.208498037958292e+03 + 158380 9.241902415858100e-01 -6.130309695472032e+00 -5.961924006310128e+00 3.017155425236606e+00 4.984052110005443e+00 9.100547865954792e+03 + 158400 9.095897398262726e-01 -6.099708613894931e+00 -5.963978659142244e+00 3.205322223059933e+00 4.984704627392478e+00 9.106805862778992e+03 + 158420 9.065996692855635e-01 -6.082180295015280e+00 -6.000835312572480e+00 3.232637406543037e+00 4.699732883824946e+00 9.219622693090068e+03 + 158440 9.294654550530256e-01 -6.099991924158820e+00 -6.002313179401304e+00 3.149974714866301e+00 4.710861183000858e+00 9.224173475072310e+03 + 158460 9.240822581442983e-01 -6.072126577793190e+00 -6.036657482961953e+00 3.291887749826989e+00 4.495556781172642e+00 9.329924481496093e+03 + 158480 9.468913179119914e-01 -6.084488987246747e+00 -5.978316316802198e+00 3.281656096775646e+00 4.891316000635898e+00 9.150620534826561e+03 + 158500 9.839264305867028e-01 -6.114237078041051e+00 -5.972119704242506e+00 3.070480955598124e+00 4.886540908541887e+00 9.131670398010121e+03 + 158520 1.010979775314062e+00 -6.125263916798614e+00 -5.991283179086526e+00 3.044787362668500e+00 4.814125492063464e+00 9.190321363440762e+03 + 158540 9.909010778225573e-01 -6.063811131265357e+00 -6.016122076839816e+00 3.346642761813308e+00 4.620480692182084e+00 9.266600931273646e+03 + 158560 9.571952874803844e-01 -5.985301152924057e+00 -5.979481582211760e+00 3.771525315825901e+00 4.804942191431566e+00 9.154174364629211e+03 + 158580 9.920684074527284e-01 -6.008712052400680e+00 -5.968203758110633e+00 3.632963100724110e+00 4.865567995175843e+00 9.119699281018815e+03 + 158600 9.989102527852459e-01 -5.991708309621817e+00 -5.955680767336299e+00 3.707039443044082e+00 4.913915166091678e+00 9.081494116017602e+03 + 158620 1.005162862822301e+00 -5.973762160664369e+00 -6.014949402934308e+00 3.844388802048698e+00 4.607885283229568e+00 9.262982760303898e+03 + 158640 1.027875873140508e+00 -5.982673711345784e+00 -6.052555561051894e+00 3.771019404431059e+00 4.369747009237286e+00 9.379083534990732e+03 + 158660 1.006954342488638e+00 -5.935395511469149e+00 -6.007357057332980e+00 4.050875722791834e+00 4.637661390428487e+00 9.239647944973871e+03 + 158680 1.031770710038963e+00 -5.957832436595398e+00 -6.021689334912185e+00 3.909770625854558e+00 4.543094433896485e+00 9.283743383240924e+03 + 158700 1.020328030889193e+00 -5.932970435236313e+00 -6.007872490048541e+00 4.041990063276682e+00 4.611890873489346e+00 9.241230613592103e+03 + 158720 1.035463099820945e+00 -5.953096438086517e+00 -5.952570477438250e+00 3.937944883621341e+00 4.940965031055839e+00 9.072020805996906e+03 + 158740 1.100983881691858e+00 -6.048415803114295e+00 -5.959993574025052e+00 3.425164540635564e+00 4.932898663361731e+00 9.094628464352367e+03 + 158760 1.018089901529338e+00 -5.924844136717158e+00 -6.033699119425405e+00 4.073398543418013e+00 4.448336387453126e+00 9.320794991134151e+03 + 158780 1.070094255683429e+00 -6.009791942715301e+00 -6.051597774702209e+00 3.594276678779418e+00 4.354221122079004e+00 9.376117729893031e+03 + 158800 1.005281925885868e+00 -5.929447453481468e+00 -6.012629751863898e+00 4.070988178858575e+00 4.593342549127589e+00 9.255855874346180e+03 + 158820 9.844486790304082e-01 -5.920190225694405e+00 -6.020447967814114e+00 4.108428498242470e+00 4.532733028155648e+00 9.279896487268943e+03 + 158840 9.947874331775804e-01 -5.962872634193308e+00 -5.992007322819468e+00 3.925205044087492e+00 4.757909153417587e+00 9.192510573524043e+03 + 158860 9.536421822604666e-01 -5.935118249111079e+00 -5.991344291944224e+00 4.009110593162378e+00 4.686251954262455e+00 9.190469448891381e+03 + 158880 1.001697364435717e+00 -6.042267105089044e+00 -5.990121739043472e+00 3.484094970948362e+00 4.783521732251350e+00 9.186723689807653e+03 + 158900 9.821260124535123e-01 -6.052076029873674e+00 -5.976294209351318e+00 3.385840081654259e+00 4.820991022292454e+00 9.144418008954171e+03 + 158920 9.800563033996513e-01 -6.083679542532979e+00 -5.931704657018589e+00 3.234123315384951e+00 5.106786626046103e+00 9.008572994314689e+03 + 158940 9.453378554396978e-01 -6.055517786947956e+00 -5.951523075087072e+00 3.367073661486960e+00 4.964227390121801e+00 9.068816259929932e+03 + 158960 9.183194234918602e-01 -6.030274066284863e+00 -5.963388720268366e+00 3.505405111967062e+00 4.889471119267633e+00 9.105006479886822e+03 + 158980 9.126891152927652e-01 -6.025952434668577e+00 -6.015804977111930e+00 3.564433225702099e+00 4.622701497306345e+00 9.265627871321640e+03 + 159000 9.574023039379355e-01 -6.090968685459745e+00 -5.986059658243648e+00 3.186990415435055e+00 4.789394284329378e+00 9.174327513660752e+03 + 159020 9.338634701600146e-01 -6.049487700583299e+00 -6.025074514639975e+00 3.406561045978134e+00 4.546745337593014e+00 9.294200606572480e+03 + 159040 9.497499552541671e-01 -6.062356375862340e+00 -5.967912789255150e+00 3.364845249591674e+00 4.907154938987953e+00 9.118829538016544e+03 + 159060 9.291331683151399e-01 -6.018346994214162e+00 -5.971687335072648e+00 3.672896301806937e+00 4.940823285156423e+00 9.130332301470755e+03 + 159080 9.327323548618007e-01 -6.005346218796013e+00 -6.001468995519174e+00 3.621687516848646e+00 4.643951132902616e+00 9.221579900993625e+03 + 159100 9.658529261993256e-01 -6.036228716760505e+00 -5.981581770198186e+00 3.459461455758329e+00 4.773252679506811e+00 9.160599188258953e+03 + 159120 9.930394104017475e-01 -6.058229466871088e+00 -5.990166246926133e+00 3.338472742601765e+00 4.729302284274946e+00 9.186894165598032e+03 + 159140 9.687481329010974e-01 -6.007264968623776e+00 -5.992069636039571e+00 3.648510832326164e+00 4.735764783494787e+00 9.192726842436599e+03 + 159160 9.393100468971451e-01 -5.951719583285605e+00 -5.990789246063790e+00 3.927488978869504e+00 4.703144929186392e+00 9.188808127944205e+03 + 159180 1.008148806105042e+00 -6.043776954201796e+00 -5.987327606801935e+00 3.486657469521689e+00 4.810798357799967e+00 9.178197147528897e+03 + 159200 1.043895727716148e+00 -6.088607786360543e+00 -6.001600833485251e+00 3.207884693706381e+00 4.707492081398751e+00 9.221976831795466e+03 + 159220 1.027531575574081e+00 -6.058056338133317e+00 -5.995398302403984e+00 3.381509605141324e+00 4.741301742598846e+00 9.202946216369197e+03 + 159240 9.670711286624439e-01 -5.963916353923217e+00 -6.014529141706108e+00 3.893071908086724e+00 4.602445448333771e+00 9.261708371145958e+03 + 159260 1.022381810423875e+00 -6.041431179755431e+00 -5.991409475790287e+00 3.510677774090294e+00 4.797910139091821e+00 9.190683546397486e+03 + 159280 9.538689555042004e-01 -5.935029051290416e+00 -6.000224938954323e+00 4.061118798841687e+00 4.686753922844527e+00 9.217727800950513e+03 + 159300 1.063401750480270e+00 -6.091578373326209e+00 -5.990921590545755e+00 3.247495820929431e+00 4.825482644241597e+00 9.189202276873406e+03 + 159320 1.051631545493499e+00 -6.068501240727747e+00 -5.962053964874337e+00 3.440409464319489e+00 5.051646194932469e+00 9.100918783270406e+03 + 159340 1.000910531331261e+00 -5.988587805239485e+00 -5.980584139514930e+00 3.772755206433410e+00 4.818713493587076e+00 9.157510804807414e+03 + 159360 9.276062800403968e-01 -5.873564395741175e+00 -5.980142675667549e+00 4.370427949176535e+00 4.758438972903780e+00 9.156168686584733e+03 + 159380 1.062201382367013e+00 -6.064281415510985e+00 -5.997127493649803e+00 3.384681756099790e+00 4.770289967462524e+00 9.208250764233722e+03 + 159400 1.038971017768886e+00 -6.022563540251824e+00 -6.016250514167800e+00 3.568286733837204e+00 4.604537106549294e+00 9.266996222634793e+03 + 159420 9.745996276905634e-01 -5.920809750920212e+00 -5.992494666315149e+00 4.136071602099553e+00 4.724445724697019e+00 9.193997368614011e+03 + 159440 9.613447103771818e-01 -5.893569825920785e+00 -6.014976022176231e+00 4.228930716564085e+00 4.531797550117163e+00 9.263034225329211e+03 + 159460 1.010892513962043e+00 -5.957306837663056e+00 -6.001824092913458e+00 3.959663822128458e+00 4.704038853457664e+00 9.222654003809221e+03 + 159480 1.064000134859606e+00 -6.023128623084922e+00 -6.025400498569198e+00 3.599708031191319e+00 4.586662570589015e+00 9.295193800481640e+03 + 159500 1.023653290739963e+00 -5.952984821435278e+00 -6.026750666996509e+00 3.896827077914089e+00 4.473252177473794e+00 9.299367149065953e+03 + 159520 1.077727945413640e+00 -6.026183895727552e+00 -5.969153564394150e+00 3.639525070552029e+00 4.967002058483674e+00 9.122584894472646e+03 + 159540 1.022149245490557e+00 -5.936596285475908e+00 -5.975825546811525e+00 4.085428225979533e+00 4.860167736681842e+00 9.142971009948527e+03 + 159560 9.548649937218950e-01 -5.832012094490262e+00 -5.969697946339539e+00 4.630876095790996e+00 4.840262627655737e+00 9.124224710860404e+03 + 159580 1.017324377014077e+00 -5.919492096502819e+00 -5.986173380288712e+00 4.112187248420714e+00 4.729292998026802e+00 9.174603009088736e+03 + 159600 9.972050533204111e-01 -5.887084119261441e+00 -6.025905238909279e+00 4.331632249396554e+00 4.534499897879836e+00 9.296701012265892e+03 + 159620 1.056463019567889e+00 -5.976273522614386e+00 -5.989412494728974e+00 3.855194918797115e+00 4.779748907665790e+00 9.184563180244366e+03 + 159640 1.039988914097818e+00 -5.956396710662003e+00 -6.024147688285371e+00 3.869268251296258e+00 4.480231653352977e+00 9.291347759398524e+03 + 159660 9.990985558041287e-01 -5.906098175636922e+00 -6.038094933699151e+00 4.228839982954566e+00 4.470894171728957e+00 9.334355441528402e+03 + 159680 1.070810920018540e+00 -6.031887753356043e+00 -6.009084002243419e+00 3.514381899471780e+00 4.645324567229546e+00 9.244941302366133e+03 + 159700 1.013664331595894e+00 -5.973047570121448e+00 -5.999151885718473e+00 3.865761031476089e+00 4.715866011688188e+00 9.214423110061796e+03 + 159720 1.050428051773329e+00 -6.059159425274064e+00 -5.973407644129782e+00 3.371121668321620e+00 4.863521665697336e+00 9.135587118528250e+03 + 159740 9.420157403576664e-01 -5.929782663791087e+00 -6.041043727355316e+00 4.075586640379653e+00 4.436708395799916e+00 9.343452573242312e+03 + 159760 9.965734877245368e-01 -6.039326866822048e+00 -5.994747595599556e+00 3.510248619240187e+00 4.766229693219664e+00 9.200919158888595e+03 + 159780 9.574404155866684e-01 -6.006558207472702e+00 -6.029806051851946e+00 3.678271507007243e+00 4.544778786989334e+00 9.308775540567196e+03 + 159800 9.452665991817946e-01 -6.011948649831208e+00 -6.053274421738664e+00 3.593589063570510e+00 4.356290086135365e+00 9.381322278933862e+03 + 159820 9.091029020000138e-01 -5.975808471078857e+00 -6.027570455182249e+00 3.840434064369721e+00 4.543208741506888e+00 9.301849317929635e+03 + 159840 9.971198159711572e-01 -6.119354546773181e+00 -5.992108139009541e+00 3.072085735306334e+00 4.802754300003119e+00 9.192853132830116e+03 + 159860 9.804063308342029e-01 -6.103343053013414e+00 -6.006949287693869e+00 3.144688053238382e+00 4.698195970590178e+00 9.238404822877916e+03 + 159880 9.446173079473499e-01 -6.053101553558562e+00 -5.996845182817244e+00 3.400413689815231e+00 4.723446476257116e+00 9.207363258792982e+03 + 159900 9.510357417197004e-01 -6.060683611881169e+00 -5.969738366836815e+00 3.411552378737357e+00 4.933774049513227e+00 9.124392891491303e+03 + 159920 1.004361373099638e+00 -6.131972324548982e+00 -5.945974572216656e+00 2.979194320136722e+00 5.047222197088090e+00 9.051934613123145e+03 + 159940 9.800600845119262e-01 -6.080648984605929e+00 -5.955888857139600e+00 3.282550087754632e+00 4.998942046233624e+00 9.082133205843687e+03 + 159960 9.499070351325912e-01 -6.011240856017125e+00 -5.974883352000113e+00 3.622166056485997e+00 4.830936470857243e+00 9.140115658337303e+03 + 159980 1.025320917373206e+00 -6.086917500840879e+00 -5.973464779074217e+00 3.257558909381542e+00 4.909021994517669e+00 9.135762131581945e+03 + 160000 9.399726349497040e-01 -5.910740771447418e+00 -6.035194781093599e+00 4.155913175762048e+00 4.441278993177932e+00 9.325404989728439e+03 + 160020 9.808920085636095e-01 -5.923903630536819e+00 -6.013507269238785e+00 4.079274055618663e+00 4.564756096073703e+00 9.258568049523979e+03 + 160040 1.065148542957790e+00 -6.003394834333378e+00 -6.014647621517323e+00 3.697861319765574e+00 4.633246074392169e+00 9.262078721675405e+03 + 160060 1.036509315605115e+00 -5.930734556587509e+00 -6.068474424248012e+00 4.025698345647426e+00 4.234774710365184e+00 9.428467977067377e+03 + 160080 9.986574143694632e-01 -5.860132375430748e+00 -6.095727228994482e+00 4.435737279348197e+00 4.082915171999475e+00 9.513252239280928e+03 + 160100 1.057493993860023e+00 -5.944650045686870e+00 -6.053291503628516e+00 3.978804372125293e+00 4.354968308413073e+00 9.381371065593459e+03 + 160120 1.052212184098265e+00 -5.941857759545673e+00 -6.028639366116957e+00 4.053962638335351e+00 4.555649223992820e+00 9.305180000221208e+03 + 160140 1.017491853209114e+00 -5.901617512446663e+00 -6.003675549404427e+00 4.278426631121257e+00 4.692393589479599e+00 9.228285586306805e+03 + 160160 9.791654557562276e-01 -5.855609235464485e+00 -5.973325718023437e+00 4.536092429398531e+00 4.860146169978225e+00 9.135264649153161e+03 + 160180 1.095994711489422e+00 -6.037513118562012e+00 -5.960767352412127e+00 3.481593433887382e+00 4.922279499488957e+00 9.096994428698439e+03 + 160200 1.053799120668693e+00 -5.987936220346573e+00 -6.047982774660277e+00 3.708529214351842e+00 4.363732607308308e+00 9.364933927499453e+03 + 160220 1.047072173451426e+00 -5.997601215741199e+00 -6.002957818730445e+00 3.709241942998267e+00 4.678483499702381e+00 9.226128524552238e+03 + 160240 1.007853289775680e+00 -5.961014124217182e+00 -6.033149370916704e+00 3.856195382193625e+00 4.441983632751616e+00 9.319123918226442e+03 + 160260 1.044218442731836e+00 -6.040386458405478e+00 -5.993579754171064e+00 3.488178732192756e+00 4.756950071220832e+00 9.197353155516843e+03 + 160280 9.561921292371524e-01 -5.934954516875090e+00 -5.977752599378698e+00 4.014986200241479e+00 4.769232987523892e+00 9.148892748376975e+03 + 160300 9.650283231047512e-01 -5.967732005004477e+00 -5.987432743890053e+00 3.835277321086950e+00 4.722152629726483e+00 9.178512168747106e+03 + 160320 1.041443695491874e+00 -6.096653630432838e+00 -5.964776719247878e+00 3.197489199747568e+00 4.954746831657663e+00 9.109235828863255e+03 + 160340 9.595100222858196e-01 -5.990386753872547e+00 -6.000379344409385e+00 3.737981361209295e+00 4.680602359998387e+00 9.218206210027241e+03 + 160360 9.966715658915174e-01 -6.057632720004217e+00 -5.971681098620000e+00 3.352322298545487e+00 4.845869809504086e+00 9.130310835549568e+03 + 160380 9.698672318965091e-01 -6.025950170767810e+00 -5.996191706043236e+00 3.583284759457562e+00 4.754162469013600e+00 9.205347882400329e+03 + 160400 9.750661845594895e-01 -6.038076024889579e+00 -5.949183696649925e+00 3.567781410237071e+00 5.078214915032502e+00 9.061714911713314e+03 + 160420 9.504862556509137e-01 -6.000361372350707e+00 -6.031722968009812e+00 3.677507659512000e+00 4.497424524046173e+00 9.314706480592376e+03 + 160440 9.971736506237416e-01 -6.067113054819553e+00 -6.012780722434808e+00 3.348230036217724e+00 4.660214696672194e+00 9.256341101273021e+03 + 160460 1.001479739154472e+00 -6.069819799750714e+00 -5.994696750068682e+00 3.339191165034122e+00 4.770559341562715e+00 9.200779702808306e+03 + 160480 9.564938174999156e-01 -5.994312774362599e+00 -5.988638164242287e+00 3.766604937791448e+00 4.799189427245357e+00 9.182207656800912e+03 + 160500 9.934674670159975e-01 -6.031413888062776e+00 -5.962698018766941e+00 3.572768729850547e+00 4.967345885093634e+00 9.102875221400574e+03 + 160520 9.579322317094875e-01 -5.947641901992867e+00 -5.980913849176217e+00 4.008267249217449e+00 4.817214579673471e+00 9.158520943450236e+03 + 160540 1.001411437362417e+00 -5.962620033507650e+00 -6.029181027881346e+00 3.883005665693516e+00 4.500802135719164e+00 9.306777406061126e+03 + 160560 1.072154562169849e+00 -6.007601534537461e+00 -6.031837288462196e+00 3.606404889638196e+00 4.467239440131570e+00 9.315050419287367e+03 + 160580 1.065367513281493e+00 -5.950269846249613e+00 -6.025662146306662e+00 3.913073823884455e+00 4.480159570036149e+00 9.295996615153270e+03 + 160600 1.023156314797608e+00 -5.853436719747481e+00 -6.056259558562024e+00 4.511096110820650e+00 4.346455983614677e+00 9.390541371979407e+03 + 160620 1.108521218243921e+00 -5.960403549679981e+00 -6.011061236342114e+00 3.900431023395397e+00 4.609546747329754e+00 9.251037212159106e+03 + 160640 1.041664426070571e+00 -5.854826465500003e+00 -6.023640094876265e+00 4.419901255771438e+00 4.450547272068221e+00 9.289734251419204e+03 + 160660 1.101880677810955e+00 -5.946492223116513e+00 -5.993345317246210e+00 4.007792713548893e+00 4.738754996563288e+00 9.196626130011464e+03 + 160680 1.076894909434662e+00 -5.920475471324465e+00 -6.028586424941093e+00 4.121331298468577e+00 4.500541472685897e+00 9.305013863627040e+03 + 160700 1.039924343699047e+00 -5.885838855470521e+00 -6.033771446075315e+00 4.345586602243795e+00 4.496134774496659e+00 9.321017230226955e+03 + 160720 1.033109188213106e+00 -5.901688568146314e+00 -6.027632987598209e+00 4.149746621513352e+00 4.426554275184649e+00 9.302081175740801e+03 + 160740 1.055795991988790e+00 -5.968754017575486e+00 -6.008396885310666e+00 3.881201764204100e+00 4.653566282954738e+00 9.242850910236340e+03 + 160760 1.005657058590011e+00 -5.930945630554363e+00 -5.991396744807606e+00 4.110108913563457e+00 4.762989260741637e+00 9.190642611609095e+03 + 160780 1.047128139263350e+00 -6.024881822075962e+00 -5.986025082602841e+00 3.642220686665044e+00 4.865342097780706e+00 9.174176803123368e+03 + 160800 1.038033506410136e+00 -6.037933130582186e+00 -6.003687842944122e+00 3.523335465563875e+00 4.719977206622772e+00 9.228375266649809e+03 + 160820 1.026438968370604e+00 -6.045312037897373e+00 -5.985528204346414e+00 3.483584265867951e+00 4.826872289635902e+00 9.172686698052670e+03 + 160840 9.819314297618624e-01 -5.997757320524366e+00 -6.009319229046188e+00 3.706066603577276e+00 4.639676335645417e+00 9.245684817886509e+03 + 160860 9.865099471253355e-01 -6.019217011164370e+00 -6.002126942729442e+00 3.608106866782074e+00 4.706240684414976e+00 9.223568952985232e+03 + 160880 1.003490227940993e+00 -6.052252346477676e+00 -6.001000178956694e+00 3.473617481615153e+00 4.767915358767921e+00 9.220099861589757e+03 + 160900 1.033831578292342e+00 -6.102674140787588e+00 -5.986236340333356e+00 3.192548712220606e+00 4.861152581120193e+00 9.174852205339032e+03 + 160920 9.877879709790602e-01 -6.039577545036948e+00 -6.021829451924027e+00 3.462233215760839e+00 4.564145512923762e+00 9.284190916455666e+03 + 160940 1.003202730067998e+00 -6.064640309068633e+00 -6.016864567180445e+00 3.394063939451140e+00 4.668399642645277e+00 9.268892874852019e+03 + 160960 9.394893143762911e-01 -5.971590657858687e+00 -5.988223327177643e+00 3.827300425481030e+00 4.731793064354324e+00 9.180940710155710e+03 + 160980 9.409703868796269e-01 -5.971003163812262e+00 -6.036246774011047e+00 3.830486941631595e+00 4.455848035454123e+00 9.328639830906464e+03 + 161000 9.708156717767303e-01 -6.009126362490987e+00 -6.023133701080456e+00 3.616296527028270e+00 4.535864221218900e+00 9.288207111996324e+03 + 161020 9.803835337611397e-01 -6.016142088238199e+00 -5.982685656006312e+00 3.615912330522665e+00 4.808024341764314e+00 9.163972493795498e+03 + 161040 9.912036111736192e-01 -6.020111742100628e+00 -6.023137924535320e+00 3.580833254371037e+00 4.563456446530819e+00 9.288214468707169e+03 + 161060 1.007247788663592e+00 -6.031522988784685e+00 -5.984037426045887e+00 3.515081277932560e+00 4.787750727545820e+00 9.168111851972055e+03 + 161080 9.941703140772706e-01 -5.996897824409364e+00 -5.955783707200983e+00 3.738043551690800e+00 4.974127175090395e+00 9.081814054131844e+03 + 161100 1.041144155839224e+00 -6.042665605408391e+00 -5.987789750795847e+00 3.463199004378587e+00 4.778304653574872e+00 9.179619799429467e+03 + 161120 1.003228008124460e+00 -5.955664536248199e+00 -5.979833367790728e+00 4.013706182354063e+00 4.874925011522271e+00 9.155225522564757e+03 + 161140 1.053873104186462e+00 -5.990723308399001e+00 -5.970237127546789e+00 3.751522224389894e+00 4.869157045069532e+00 9.125914120683730e+03 + 161160 9.711971601396562e-01 -5.815006118209706e+00 -6.059764845129257e+00 4.652992557679636e+00 4.247550071416997e+00 9.401428075491054e+03 + 161180 1.076232786561651e+00 -5.919729725969598e+00 -6.052277810770425e+00 4.141339580785396e+00 4.380227966109214e+00 9.378219414113324e+03 + 161200 1.102478600776878e+00 -5.918939173091913e+00 -6.062966916165484e+00 4.098653823415916e+00 4.271624234466265e+00 9.411349492884570e+03 + 161220 1.087251821297010e+00 -5.872943969150382e+00 -6.052002709838185e+00 4.339039174720669e+00 4.310856176440743e+00 9.377364946321166e+03 + 161240 1.010038870370776e+00 -5.751883298449872e+00 -6.052651816946000e+00 4.992777834656559e+00 4.265718457673985e+00 9.379376127483230e+03 + 161260 1.092599400223713e+00 -5.878835482960334e+00 -6.047670588932738e+00 4.335873326989935e+00 4.366396021348177e+00 9.363976786162893e+03 + 161280 1.084309675459875e+00 -5.881574324362872e+00 -6.048779934330901e+00 4.331803912420803e+00 4.371683424999864e+00 9.367393763993594e+03 + 161300 1.083054630717559e+00 -5.904025840408231e+00 -5.981216079485799e+00 4.168912162836286e+00 4.725673864901995e+00 9.159481642676992e+03 + 161320 1.089238637785522e+00 -5.938940085155091e+00 -6.025843863736573e+00 4.003922411401782e+00 4.504907466470638e+00 9.296556731791641e+03 + 161340 1.094741144549793e+00 -5.977280323077478e+00 -5.989027667307621e+00 3.888883368785610e+00 4.821428300320486e+00 9.183389539732872e+03 + 161360 1.002433399857184e+00 -5.866408797689527e+00 -6.020463333224148e+00 4.515605193060317e+00 4.631000210158193e+00 9.279957809169156e+03 + 161380 1.069717626176580e+00 -5.989761164545700e+00 -5.991813440212421e+00 3.779622457217072e+00 4.767837972750129e+00 9.191906529255770e+03 + 161400 1.036607959465053e+00 -5.961685189584067e+00 -5.973940221693836e+00 3.910205465669518e+00 4.839835174835138e+00 9.137216994004928e+03 + 161420 1.036008049049247e+00 -5.978567918804394e+00 -5.957337190186822e+00 3.806524805115132e+00 4.928434934281873e+00 9.086509463076527e+03 + 161440 9.233165003702806e-01 -5.825415582903469e+00 -5.977681983932461e+00 4.590717028059786e+00 4.716379790201908e+00 9.148628344724959e+03 + 161460 1.039073858469874e+00 -6.007136585109272e+00 -5.993217609563757e+00 3.587403591307345e+00 4.667328502844198e+00 9.196238231714016e+03 + 161480 1.017204898915156e+00 -5.985206545687710e+00 -5.972777629751076e+00 3.756896376605481e+00 4.828265135282159e+00 9.133677866926437e+03 + 161500 1.011045809337130e+00 -5.987127517334615e+00 -5.997052415887040e+00 3.745331922755134e+00 4.688341619394020e+00 9.208006793062505e+03 + 161520 1.075955436738055e+00 -6.094939250460896e+00 -5.994855152878284e+00 3.201717703082086e+00 4.776416079365493e+00 9.201262470830143e+03 + 161540 9.804809611294001e-01 -5.969904269843672e+00 -5.989713940893435e+00 3.803458656122169e+00 4.689708459417744e+00 9.185515332449426e+03 + 161560 9.542997730278802e-01 -5.945333924503183e+00 -5.978979729920486e+00 4.003636229772132e+00 4.810436808394418e+00 9.152627566044854e+03 + 161580 9.954382265371100e-01 -6.016620446548646e+00 -6.017369959915347e+00 3.609289019640756e+00 4.604985197902337e+00 9.270445037385824e+03 + 161600 1.023052618253661e+00 -6.070537376854359e+00 -5.971149206409000e+00 3.335147646904189e+00 4.905849901871113e+00 9.128709230426122e+03 + 161620 9.559154289258309e-01 -5.984327243815384e+00 -6.006284460924181e+00 3.753234911970152e+00 4.627153173463073e+00 9.236355363501631e+03 + 161640 9.301064820608891e-01 -5.956916214580928e+00 -6.005798635502968e+00 3.929836143746811e+00 4.649145718282265e+00 9.234850720143731e+03 + 161660 9.544315365814562e-01 -6.004722230707030e+00 -6.000822251623513e+00 3.653195954069851e+00 4.675590237487221e+00 9.219577069506189e+03 + 161680 9.750722119711537e-01 -6.043415077828495e+00 -5.996494157860504e+00 3.492293358496461e+00 4.761720541941571e+00 9.206278370435914e+03 + 161700 9.592481487377785e-01 -6.027084765412924e+00 -5.970724854277306e+00 3.578356362547953e+00 4.901983693956735e+00 9.127399684698054e+03 + 161720 9.002501508128924e-01 -5.944684248776280e+00 -5.991249021568359e+00 4.034861511527800e+00 4.767479380280383e+00 9.190168318791628e+03 + 161740 1.001883629854006e+00 -6.094110312873083e+00 -5.996470533764364e+00 3.166244760042566e+00 4.726907481391816e+00 9.206223504308293e+03 + 161760 9.975313097936616e-01 -6.081090060810471e+00 -6.007397432976460e+00 3.241698165261540e+00 4.664852638181733e+00 9.239778184048339e+03 + 161780 9.901650455971855e-01 -6.060824341825948e+00 -5.931792038258775e+00 3.429390834077759e+00 5.170314288844907e+00 9.008847735059595e+03 + 161800 9.342815008725615e-01 -5.959479322963702e+00 -5.963645823978852e+00 3.958276672375436e+00 4.934351978782499e+00 9.105772301568250e+03 + 161820 1.003337790695439e+00 -6.031461911781351e+00 -6.009896406658520e+00 3.490326660264591e+00 4.614159127931023e+00 9.247469021326797e+03 + 161840 9.429672754115861e-01 -5.905467627887485e+00 -6.094812719473669e+00 4.137373231936531e+00 4.050124414990434e+00 9.510410937374623e+03 + 161860 1.008867675163742e+00 -5.967990708076190e+00 -6.036551124913268e+00 3.871667467270503e+00 4.477982944101785e+00 9.329601031816937e+03 + 161880 1.033564994462538e+00 -5.975229430855498e+00 -5.989492420306222e+00 3.841818782805249e+00 4.759918490188708e+00 9.184797495883629e+03 + 161900 1.012463535767002e+00 -5.917264121085976e+00 -6.012237759203172e+00 4.151879144351999e+00 4.606525817160057e+00 9.254624147964782e+03 + 161920 1.035793713795176e+00 -5.927309368062039e+00 -6.021068230881504e+00 4.085098149310301e+00 4.546720249863802e+00 9.281819132235256e+03 + 161940 1.014886284306586e+00 -5.878313629094414e+00 -6.039625489921086e+00 4.394507747408183e+00 4.468230079611650e+00 9.339073050093089e+03 + 161960 1.123320963045888e+00 -6.030759050811043e+00 -5.953032198667207e+00 3.535861294502571e+00 4.982180907703976e+00 9.073424121250044e+03 + 161980 9.712971382020206e-01 -5.801294388589707e+00 -6.006142349174405e+00 4.799197804467099e+00 4.622929114670304e+00 9.235874048058628e+03 + 162000 1.007187872745212e+00 -5.854830436464284e+00 -6.062711950370902e+00 4.423821683232126e+00 4.230133860820012e+00 9.410524392657537e+03 + 162020 1.043729535736961e+00 -5.916487663651502e+00 -6.062048453354465e+00 4.128027198831600e+00 4.292194618897777e+00 9.408492423717807e+03 + 162040 1.030181452747277e+00 -5.911299444782066e+00 -6.065102217139168e+00 4.128956829845008e+00 4.245797510068424e+00 9.417974524707075e+03 + 162060 1.051243718307378e+00 -5.970609469780458e+00 -6.015886573114088e+00 3.866381796140712e+00 4.606393662189912e+00 9.265889226221949e+03 + 162080 1.010595824561274e+00 -5.946106826207853e+00 -6.049166334506747e+00 3.971186256439839e+00 4.379402611380222e+00 9.368588262875059e+03 + 162100 1.091320185823295e+00 -6.109419579965328e+00 -5.987112702523140e+00 3.105926312692027e+00 4.808231329893188e+00 9.177527352951554e+03 + 162120 9.650218503099308e-01 -5.965718561470987e+00 -6.018597216614165e+00 3.867625765566373e+00 4.563988344788804e+00 9.274212820527171e+03 + 162140 9.382335992437946e-01 -5.962217237872146e+00 -6.021462994470992e+00 3.919332706275117e+00 4.579134403633340e+00 9.283040067927392e+03 + 162160 9.015658370091538e-01 -5.931817713342571e+00 -6.034152972722895e+00 4.074571726123598e+00 4.486946830431573e+00 9.322179538115653e+03 + 162180 9.870960004589449e-01 -6.073547684052460e+00 -5.985446769899948e+00 3.244163274806891e+00 4.750052357443015e+00 9.172460878150367e+03 + 162200 9.806954074150837e-01 -6.070659784019922e+00 -6.019900101503564e+00 3.257848213705265e+00 4.549318165749670e+00 9.278259956232831e+03 + 162220 9.415940802769128e-01 -6.015741467183267e+00 -6.015657183116738e+00 3.620427132522930e+00 4.620911104675853e+00 9.265178082287170e+03 + 162240 9.749002984887419e-01 -6.065077502915942e+00 -5.965775573238829e+00 3.397652395716909e+00 4.967859442846850e+00 9.112281635094740e+03 + 162260 9.889995182611527e-01 -6.081689653391416e+00 -5.976828389816245e+00 3.223283733187179e+00 4.825413335863905e+00 9.146066123104461e+03 + 162280 9.344341437202388e-01 -5.992352692059560e+00 -5.987020613918317e+00 3.710118717084685e+00 4.740736334908128e+00 9.177231419058156e+03 + 162300 9.748656193246829e-01 -6.039307216165382e+00 -5.962005535830837e+00 3.483346037034853e+00 4.927224247912178e+00 9.100782666108676e+03 + 162320 1.000511510262489e+00 -6.060706311073877e+00 -5.990930068892450e+00 3.346330598700934e+00 4.746996579145275e+00 9.189224630975214e+03 + 162340 9.906717483345594e-01 -6.027900119262839e+00 -6.032071275693019e+00 3.505914000390729e+00 4.481962574684265e+00 9.315762758155262e+03 + 162360 9.727389429867523e-01 -5.983967006256304e+00 -5.989064642592261e+00 3.801439040447745e+00 4.772167623750006e+00 9.183528046182884e+03 + 162380 9.370000143472786e-01 -5.913474909046638e+00 -6.035654044730349e+00 4.109943677610943e+00 4.408372173354930e+00 9.326823156736391e+03 + 162400 9.607207698266811e-01 -5.930186910741354e+00 -6.066258682470469e+00 3.990067896322882e+00 4.208722726015680e+00 9.421559271683584e+03 + 162420 1.000904807420621e+00 -5.971153518175170e+00 -6.057198375997512e+00 3.812306540882992e+00 4.318223651868392e+00 9.393471207788283e+03 + 162440 1.063074931926065e+00 -6.048736308084578e+00 -5.991308515390546e+00 3.430154329686826e+00 4.759913602258157e+00 9.190407123757783e+03 + 162460 9.783235345045167e-01 -5.911536007488039e+00 -5.982771402991423e+00 4.197940171006210e+00 4.788895506383949e+00 9.164226324964749e+03 + 162480 1.011798587374074e+00 -5.949626275063929e+00 -6.025236910598455e+00 3.981421250705631e+00 4.547253280758354e+00 9.294657758259456e+03 + 162500 1.016236411617874e+00 -5.947600424656504e+00 -5.999474315669458e+00 3.963100354754034e+00 4.665232445098963e+00 9.215409672207938e+03 + 162520 1.014916187515347e+00 -5.938687135030134e+00 -5.962578543382540e+00 4.078835293853333e+00 4.941647129910330e+00 9.102468206135665e+03 + 162540 1.008018019160987e+00 -5.918492239783259e+00 -5.987581061233589e+00 4.111699167341499e+00 4.714980463113134e+00 9.178958902441862e+03 + 162560 1.075500680822997e+00 -6.008890143605986e+00 -5.999530025082767e+00 3.679337182058734e+00 4.733084431092717e+00 9.215602650410605e+03 + 162580 1.046367660064607e+00 -5.956329045255175e+00 -5.997003458955055e+00 3.923805538148841e+00 4.690246760338953e+00 9.207877056072901e+03 + 162600 1.087556120179716e+00 -6.007516013950550e+00 -5.988984877335006e+00 3.637780239090524e+00 4.744188893221100e+00 9.183284567118908e+03 + 162620 1.074638278292985e+00 -5.980528004659189e+00 -5.990371906421180e+00 3.803971028188393e+00 4.747445820932164e+00 9.187519502313087e+03 + 162640 1.043245900752999e+00 -5.929067782757871e+00 -6.038736157925413e+00 4.070866911396108e+00 4.441134130057871e+00 9.336366868949150e+03 + 162660 1.039160521047207e+00 -5.925900257140243e+00 -6.061902816142956e+00 4.077720034921594e+00 4.296772294800028e+00 9.408020127743672e+03 + 162680 9.843928189401719e-01 -5.855541284014834e+00 -6.047677127327080e+00 4.370688942718738e+00 4.267415197494159e+00 9.363972771180583e+03 + 162700 1.038018619339763e+00 -5.951056317868337e+00 -5.980928776035093e+00 3.958068627462837e+00 4.786536349921367e+00 9.158612889732603e+03 + 162720 1.049498226791958e+00 -5.990085082577055e+00 -5.966924115112179e+00 3.789037949087968e+00 4.922031808419417e+00 9.115780009034026e+03 + 162740 9.764649042420084e-01 -5.907579579280620e+00 -6.037014865277660e+00 4.171276711596098e+00 4.428039269355322e+00 9.331027849809743e+03 + 162760 1.002280575925416e+00 -5.974896049653909e+00 -6.047898239725459e+00 3.841069605753654e+00 4.421879733310411e+00 9.364679554737717e+03 + 162780 9.367232431622372e-01 -5.909315200303888e+00 -6.045374339919769e+00 4.127957742065977e+00 4.346685107307781e+00 9.356869139275375e+03 + 162800 1.023337490167012e+00 -6.065619190998289e+00 -6.009631096296134e+00 3.334828258651403e+00 4.656320562560828e+00 9.246637182675086e+03 + 162820 9.391641230340534e-01 -5.967936573542799e+00 -6.035175401876685e+00 3.871653509728072e+00 4.485557752259838e+00 9.325342649251603e+03 + 162840 9.982406249938827e-01 -6.079851641695286e+00 -5.982850326483566e+00 3.304433983555319e+00 4.861430546406030e+00 9.164484404631756e+03 + 162860 1.022149825200615e+00 -6.134635905823668e+00 -5.984323793753211e+00 2.989265996587172e+00 4.852381404819903e+00 9.168963871110949e+03 + 162880 9.028867144036470e-01 -5.972253582737718e+00 -5.990519603305319e+00 3.809507049772508e+00 4.704620733015791e+00 9.187978040069118e+03 + 162900 9.537243737902877e-01 -6.055545623705087e+00 -5.958638302897511e+00 3.417649402424467e+00 4.974106234860998e+00 9.090493009951697e+03 + 162920 9.009353873168511e-01 -5.977845546355162e+00 -6.030962599127580e+00 3.780049695205938e+00 4.475043358349366e+00 9.312317056532735e+03 + 162940 9.967274890825212e-01 -6.116238309874726e+00 -5.939075910105414e+00 3.079320189116680e+00 5.096614104384832e+00 9.030980376435722e+03 + 162960 9.551150106241686e-01 -6.043028906705282e+00 -6.022971725019599e+00 3.426091861007310e+00 4.541263302085335e+00 9.287708103959878e+03 + 162980 9.707844465767645e-01 -6.051298961933812e+00 -6.012937630540158e+00 3.429905733231805e+00 4.650182434491017e+00 9.256828261315619e+03 + 163000 9.504721624089499e-01 -6.000733888022360e+00 -6.024943153645596e+00 3.712058724167435e+00 4.573045374587065e+00 9.293786215797070e+03 + 163020 1.001942816810722e+00 -6.048358344867216e+00 -6.024779372655132e+00 3.415443266654861e+00 4.550837373930808e+00 9.293287172301116e+03 + 163040 9.726448810858962e-01 -5.971070356433644e+00 -6.031209885034774e+00 3.809993257082643e+00 4.464662777292978e+00 9.313111383930927e+03 + 163060 1.056822004940084e+00 -6.061268990986827e+00 -5.950807381318343e+00 3.394930007475542e+00 5.029217664070826e+00 9.066655622604640e+03 + 163080 1.035023577269626e+00 -5.990718993146752e+00 -6.009953136395916e+00 3.749205675072043e+00 4.638760248061291e+00 9.247619149178794e+03 + 163100 1.083404748665865e+00 -6.031484699168294e+00 -6.002797823024695e+00 3.472551910400550e+00 4.637276392496831e+00 9.225636273521766e+03 + 163120 1.029961737571383e+00 -5.930643402033360e+00 -5.994299745684120e+00 4.058275067483287e+00 4.692750491453282e+00 9.199456140779150e+03 + 163140 1.006500044492990e+00 -5.880168599127322e+00 -5.954088086758197e+00 4.374508783451136e+00 4.950051646470915e+00 9.076459707518168e+03 + 163160 1.021341420796735e+00 -5.889087167535349e+00 -5.952612909463833e+00 4.265637056045781e+00 4.900862415315632e+00 9.072118951004088e+03 + 163180 1.102174255070495e+00 -5.999582200395922e+00 -5.975082221480998e+00 3.687789116719556e+00 4.828471787008535e+00 9.140685184366535e+03 + 163200 1.074916227910037e+00 -5.958459344725615e+00 -6.007456019503113e+00 3.864988627576227e+00 4.583642138792912e+00 9.239929494730493e+03 + 163220 1.031999183212925e+00 -5.901256730511313e+00 -6.039509482859098e+00 4.173074084110078e+00 4.379205385584814e+00 9.338698303599080e+03 + 163240 9.908129333680146e-01 -5.849090945856749e+00 -6.043172879333421e+00 4.428039190756482e+00 4.313590694651291e+00 9.350069083270386e+03 + 163260 1.040035000549079e+00 -5.935327100027491e+00 -6.041383804940069e+00 3.991431255174567e+00 4.382437243344500e+00 9.344542838127043e+03 + 163280 1.012914866324482e+00 -5.909814323401996e+00 -6.056114883836060e+00 4.106170293320459e+00 4.266089835369502e+00 9.390097151539754e+03 + 163300 1.063950438858502e+00 -5.999699037718605e+00 -6.055104291589891e+00 3.635699495233416e+00 4.317553953569163e+00 9.386972210261274e+03 + 163320 1.020800939242729e+00 -5.951973579899263e+00 -5.999686509363075e+00 3.969407830436209e+00 4.695432805903026e+00 9.216079268812577e+03 + 163340 1.004198250813433e+00 -5.942349523135688e+00 -5.975567724521582e+00 4.000018613344225e+00 4.809274560486369e+00 9.142192276741494e+03 + 163360 9.604055335673590e-01 -5.888358760189602e+00 -6.038963129165378e+00 4.251672387025591e+00 4.386878794415906e+00 9.337035962611268e+03 + 163380 1.016118400904988e+00 -5.981573031122268e+00 -5.994832466311181e+00 3.781432786486708e+00 4.705295057741006e+00 9.201192776818678e+03 + 163400 1.069696318362005e+00 -6.070502946795155e+00 -5.977702371866958e+00 3.388543999708812e+00 4.921419261789080e+00 9.148717463480289e+03 + 163420 1.111639600391405e+00 -6.145131111428213e+00 -6.004611883163761e+00 2.889668092215974e+00 4.696551246190753e+00 9.231208042546805e+03 + 163440 9.410377197886891e-01 -5.905795474056436e+00 -6.014161036369930e+00 4.190751682706500e+00 4.568499854385847e+00 9.260571642272547e+03 + 163460 9.895054382125503e-01 -5.990045920506423e+00 -6.037143975034377e+00 3.706011206910298e+00 4.435566889410406e+00 9.331416250419768e+03 + 163480 1.012164183693893e+00 -6.035941493527857e+00 -5.997356744330350e+00 3.524375446480637e+00 4.745935047343364e+00 9.208938264206592e+03 + 163500 1.009824435500284e+00 -6.044733377523796e+00 -6.019256821638966e+00 3.476964849352322e+00 4.623255175727297e+00 9.276249603657676e+03 + 163520 9.743764793974828e-01 -6.005105155025115e+00 -5.982160951466256e+00 3.665357292354739e+00 4.797106459793731e+00 9.162372246012150e+03 + 163540 9.782538670304899e-01 -6.020339025114633e+00 -5.999060753610401e+00 3.514038853206116e+00 4.636221980985290e+00 9.214173151657869e+03 + 163560 9.637708838276348e-01 -6.006527977701047e+00 -5.999440828134971e+00 3.753456031126198e+00 4.794151540667455e+00 9.215318125149292e+03 + 163580 1.012948912259935e+00 -6.087057005986865e+00 -6.011785567369873e+00 3.238329190610547e+00 4.670549439366794e+00 9.253226830884154e+03 + 163600 9.380379958622476e-01 -5.982619258804082e+00 -5.991296877345834e+00 3.784789312703692e+00 4.734961084179819e+00 9.190315034937281e+03 + 163620 9.624239808206947e-01 -6.021986798087871e+00 -5.991574979313138e+00 3.602498921907172e+00 4.777128291525436e+00 9.191181330905007e+03 + 163640 9.915729883211112e-01 -6.065524940923495e+00 -6.005984682884772e+00 3.349817759623881e+00 4.691707135107386e+00 9.235430180974377e+03 + 163660 1.005791539039243e+00 -6.085055932118293e+00 -6.003594864534932e+00 3.221428110129323e+00 4.689190166252452e+00 9.228088257513855e+03 + 163680 9.738318964451762e-01 -6.031220400339741e+00 -5.972310972530724e+00 3.567312627226158e+00 4.905579677910029e+00 9.132249963818969e+03 + 163700 9.857612394836859e-01 -6.035898444142392e+00 -5.952929092829885e+00 3.532227757573354e+00 5.008650612275389e+00 9.073126169602065e+03 + 163720 9.899998083844502e-01 -6.019467234702422e+00 -6.000647515531145e+00 3.601929945657505e+00 4.709995685481106e+00 9.219030059041561e+03 + 163740 1.066477508583124e+00 -6.103649339581274e+00 -6.003910916709473e+00 3.164713055754777e+00 4.737426514355716e+00 9.229075151320347e+03 + 163760 9.984553751449995e-01 -5.973839283435900e+00 -6.065037219126345e+00 3.794368292184085e+00 4.270695632614611e+00 9.417753478146624e+03 + 163780 1.035742081107139e+00 -6.002217223004647e+00 -5.997819008268923e+00 3.706574422898288e+00 4.731829652532344e+00 9.210348058884816e+03 + 163800 1.046386270690945e+00 -5.991119700147747e+00 -5.995770362459373e+00 3.764985494557457e+00 4.738280671876437e+00 9.204076931247673e+03 + 163820 1.151657135190971e+00 -6.122836776228781e+00 -5.977467925448167e+00 3.067773491001744e+00 4.902503927940989e+00 9.148023866124824e+03 + 163840 1.053706559533024e+00 -5.961099759632146e+00 -6.033319466515727e+00 3.924052514855764e+00 4.509355781966719e+00 9.319617174997644e+03 + 163860 1.042518197407502e+00 -5.935913522725601e+00 -6.001547241426177e+00 4.060920516326876e+00 4.684041546763023e+00 9.221775979511598e+03 + 163880 9.474003437533657e-01 -5.788736288713352e+00 -6.031544196341009e+00 4.819735099313832e+00 4.425494519313554e+00 9.314097677476497e+03 + 163900 1.074305405256065e+00 -5.974523492726554e+00 -6.002309762607679e+00 3.846298831682461e+00 4.686745770113680e+00 9.224108107634556e+03 + 163920 1.007889602799791e+00 -5.879505993959864e+00 -6.016892886227452e+00 4.356405732296503e+00 4.567508936343146e+00 9.268957715356177e+03 + 163940 1.044677559747021e+00 -5.944481281121458e+00 -5.969636942903729e+00 4.021563067632306e+00 4.877115364852428e+00 9.124055508774458e+03 + 163960 1.027221349500734e+00 -5.933512550382947e+00 -6.039450931366778e+00 4.027148086532865e+00 4.418833509012229e+00 9.338538845344274e+03 + 163980 1.026723684419981e+00 -5.957187232066660e+00 -6.026554121701439e+00 3.924717028387941e+00 4.526401613613565e+00 9.298743483845719e+03 + 164000 1.001148612301440e+00 -5.952602981436852e+00 -5.995009058622275e+00 3.951127922985032e+00 4.707625665467098e+00 9.201737551174761e+03 + 164020 1.040598814036212e+00 -6.048149602228094e+00 -5.975575534250233e+00 3.445808164569852e+00 4.862539693699450e+00 9.142228015816350e+03 + 164040 1.010157865196069e+00 -6.042591860654753e+00 -6.000380442097256e+00 3.499593780260511e+00 4.741978277813566e+00 9.218223949433162e+03 + 164060 9.965545557205129e-01 -6.059411183244029e+00 -5.964776344971131e+00 3.383255836678075e+00 4.926663722734948e+00 9.109225091795615e+03 + 164080 9.205590259938137e-01 -5.975087765848401e+00 -6.013266413811673e+00 3.839013493531330e+00 4.619785788799541e+00 9.257828210865206e+03 + 164100 9.997428379265941e-01 -6.112717387232392e+00 -6.012282938153333e+00 3.149495914512092e+00 4.726206063304814e+00 9.254813795169808e+03 + 164120 9.391943001321162e-01 -6.037898976185831e+00 -6.013095508585970e+00 3.507864354232978e+00 4.650289703515588e+00 9.257307591381996e+03 + 164140 9.347531602786676e-01 -6.039330059431107e+00 -5.983529677842435e+00 3.497932409314997e+00 4.818346835478291e+00 9.166555652878609e+03 + 164160 9.077495228524818e-01 -5.998095474941739e+00 -6.024148291068508e+00 3.709718487983231e+00 4.560119186123057e+00 9.291326496648680e+03 + 164180 9.710037681415328e-01 -6.085741722473275e+00 -5.980047733764549e+00 3.232545829565282e+00 4.839457068822682e+00 9.155924905455342e+03 + 164200 9.634742117934106e-01 -6.066054884551777e+00 -5.952609868592730e+00 3.327433674254823e+00 4.978852511451155e+00 9.072155088132542e+03 + 164220 9.737657226828359e-01 -6.068103944819762e+00 -5.970419811463053e+00 3.361890691509720e+00 4.922808101814725e+00 9.126465421560255e+03 + 164240 1.025347507824341e+00 -6.128879148094189e+00 -5.983761560738776e+00 3.003276549986028e+00 4.836564193454880e+00 9.167272355147448e+03 + 164260 9.260151703808808e-01 -5.966032701227707e+00 -6.002290116897621e+00 3.880061557804798e+00 4.671865866211210e+00 9.224058387521420e+03 + 164280 9.088679675065678e-01 -5.924787733715312e+00 -6.000522737883025e+00 4.053639161160117e+00 4.618757047275091e+00 9.218631627012866e+03 + 164300 9.554343924527755e-01 -5.975371484028456e+00 -6.017784914026086e+00 3.750014138007297e+00 4.506469659503828e+00 9.271733924403037e+03 + 164320 1.014999190760925e+00 -6.046400218696409e+00 -5.991700840111424e+00 3.471863304258410e+00 4.785955600794876e+00 9.191590606560843e+03 + 164340 9.794605932056099e-01 -5.980502060234826e+00 -6.024036767281658e+00 3.789713980745391e+00 4.539730955908339e+00 9.290988044515761e+03 + 164360 9.912905336467982e-01 -5.986967607936889e+00 -5.984658931851858e+00 3.796646585534019e+00 4.809903360880736e+00 9.170028376931246e+03 + 164380 1.006306591423076e+00 -6.001104509033086e+00 -6.014904668087472e+00 3.679786444106994e+00 4.600543795248997e+00 9.262877483234090e+03 + 164400 1.023377649365099e+00 -6.020564607445333e+00 -6.011410892923048e+00 3.550192290467698e+00 4.602754335787404e+00 9.252107682440335e+03 + 164420 9.328673012246472e-01 -5.882695046251074e+00 -6.014718068248436e+00 4.259696954859773e+00 4.501600332054296e+00 9.262299805309734e+03 + 164440 1.016827232579926e+00 -6.002194922242476e+00 -6.034617342442528e+00 3.656985956588251e+00 4.470811402446243e+00 9.323616686241223e+03 + 164460 1.036338013709010e+00 -6.029480616399830e+00 -5.999909087190472e+00 3.503187913894854e+00 4.672992210794343e+00 9.216784916911967e+03 + 164480 9.610438520059726e-01 -5.919402168658439e+00 -6.019990138650178e+00 4.090134813549580e+00 4.512543123918968e+00 9.278522845314883e+03 + 164500 1.042346296799027e+00 -6.041818960537751e+00 -5.989303552405087e+00 3.465550893079034e+00 4.767102493309937e+00 9.184224768918019e+03 + 164520 9.762053677456177e-01 -5.944723295874420e+00 -6.025092125807031e+00 3.999874366942788e+00 4.538384108433495e+00 9.294241550477514e+03 + 164540 1.037437641964744e+00 -6.037301361740465e+00 -5.987910667368582e+00 3.509147787793486e+00 4.792756798062086e+00 9.179982193796408e+03 + 164560 1.060507657566253e+00 -6.074512083154907e+00 -5.981489187004776e+00 3.287400022563187e+00 4.821551887503898e+00 9.160326733794582e+03 + 164580 1.009953483709239e+00 -6.003884889041220e+00 -6.013491818410135e+00 3.693848692357249e+00 4.638684217253424e+00 9.258526161231974e+03 + 164600 9.703800688783961e-01 -5.952020150220163e+00 -6.021571695190870e+00 3.927894452199904e+00 4.528518717911304e+00 9.283393265132390e+03 + 164620 9.951182734581367e-01 -5.997277524847433e+00 -5.996937044888913e+00 3.686348807113879e+00 4.688303895724805e+00 9.207645375072056e+03 + 164640 1.029900498279307e+00 -6.057829276102006e+00 -5.952125688131627e+00 3.381679036543445e+00 4.988645396246739e+00 9.070667870623885e+03 + 164660 9.339333962974141e-01 -5.925518548549439e+00 -6.014936134552197e+00 4.085988492614581e+00 4.572538876460029e+00 9.262940150209461e+03 + 164680 9.928042499109493e-01 -6.025634291130154e+00 -6.012632213811476e+00 3.523739563686708e+00 4.598399503715518e+00 9.255880830550444e+03 + 164700 1.022314980096026e+00 -6.090985547840610e+00 -5.984038935122218e+00 3.191665881802741e+00 4.805769881966578e+00 9.168151685712606e+03 + 164720 9.493251713294495e-01 -6.015061655732826e+00 -5.984521171268804e+00 3.581558311207185e+00 4.756926499124303e+00 9.169599027051994e+03 + 164740 9.250030631040805e-01 -6.014946754057609e+00 -5.968548873147141e+00 3.618237799755583e+00 4.884661611992358e+00 9.120745128924173e+03 + 164760 8.957604227974576e-01 -6.004346797579313e+00 -6.010089347757078e+00 3.618362590556935e+00 4.585387978779440e+00 9.248045875397547e+03 + 164780 9.401081050610942e-01 -6.097435501725895e+00 -5.949538169053088e+00 3.188825300592019e+00 5.038074671837544e+00 9.062791390288863e+03 + 164800 8.849313242926307e-01 -6.030885700530975e+00 -6.015866383026191e+00 3.513869384682043e+00 4.600112630026387e+00 9.265812984024480e+03 + 164820 9.475376462877442e-01 -6.131912072496372e+00 -6.013788327782378e+00 2.978734588237069e+00 4.657019409975243e+00 9.259441202083273e+03 + 164840 9.288246417134460e-01 -6.107607674129375e+00 -5.968807078753969e+00 3.126700918370944e+00 4.923715416339245e+00 9.121543472544719e+03 + 164860 8.765253427884372e-01 -6.024618913805066e+00 -5.967463707459770e+00 3.596783259771603e+00 4.924977299345887e+00 9.117402470339419e+03 + 164880 9.202121176437905e-01 -6.073162655874746e+00 -5.961746781654242e+00 3.294948835127963e+00 4.934716026452906e+00 9.099971335902635e+03 + 164900 9.225935698921532e-01 -6.047898331563763e+00 -5.964556484191908e+00 3.432668908872099e+00 4.911230693590493e+00 9.108568582994296e+03 + 164920 9.433908401047710e-01 -6.040104701714657e+00 -5.997534226405241e+00 3.498194863076288e+00 4.742641120062720e+00 9.209466001798819e+03 + 164940 1.003673116050245e+00 -6.088890538275883e+00 -5.990985992603713e+00 3.227549940054497e+00 4.789732991983572e+00 9.189398745604778e+03 + 164960 9.730000155384259e-01 -6.006727427412576e+00 -6.017739379305995e+00 3.636382543039278e+00 4.573150211173221e+00 9.271600044158855e+03 + 164980 1.040226228389026e+00 -6.075652661830345e+00 -6.016192965888443e+00 3.249952193294599e+00 4.591378968751208e+00 9.266818130837146e+03 + 165000 9.485760128758511e-01 -5.916739880682917e+00 -6.038211848633807e+00 4.164629848290448e+00 4.467119010590152e+00 9.334698910870449e+03 + 165020 1.004338661138920e+00 -5.982342819411682e+00 -5.975416570285288e+00 3.803168766846267e+00 4.842940361163604e+00 9.141716379336685e+03 + 165040 1.025798720264593e+00 -5.998951243390087e+00 -5.974936944294774e+00 3.688833833790155e+00 4.826727655396210e+00 9.140272108101739e+03 + 165060 1.003435804799144e+00 -5.953229585891919e+00 -6.019721463272913e+00 3.939700335542775e+00 4.557893686036337e+00 9.277688599837869e+03 + 165080 1.023505971491609e+00 -5.975407418081673e+00 -6.007931373477128e+00 3.833526532175669e+00 4.646768947229137e+00 9.241432874286229e+03 + 165100 1.049064042629113e+00 -6.007848012516179e+00 -6.053515481276627e+00 3.656771876136098e+00 4.394542203495659e+00 9.382071146334752e+03 + 165120 1.019383119958062e+00 -5.965030087726134e+00 -6.020341984081133e+00 3.858953390254117e+00 4.541343921895418e+00 9.279629926039319e+03 + 165140 1.001690158256775e+00 -5.944295090482152e+00 -6.015005865600621e+00 3.976859745164647e+00 4.570827531977312e+00 9.263186794054638e+03 + 165160 1.049738465969482e+00 -6.023729097383256e+00 -5.983651347700286e+00 3.590806562212399e+00 4.820939202903736e+00 9.166898929423471e+03 + 165180 9.636501491588934e-01 -5.904744065965029e+00 -5.992244146206106e+00 4.242949301047306e+00 4.740510299709388e+00 9.193212975310804e+03 + 165200 1.025258224193686e+00 -6.005928149157295e+00 -6.005127683896401e+00 3.671514549545745e+00 4.676110944945404e+00 9.232777493005377e+03 + 165220 1.026234815562151e+00 -6.019981500497336e+00 -5.994403415447916e+00 3.594339374152157e+00 4.741212696701792e+00 9.199879284976867e+03 + 165240 1.010692402426985e+00 -6.015280687912606e+00 -6.008938028854272e+00 3.579800376329372e+00 4.616220906165644e+00 9.244489875345780e+03 + 165260 9.958459826280568e-01 -6.015420466235421e+00 -5.971628744385946e+00 3.620178211255779e+00 4.871637054862516e+00 9.130148866101130e+03 + 165280 9.733309830510544e-01 -6.008105975359985e+00 -6.027081888650535e+00 3.600676876682349e+00 4.491714246054918e+00 9.300375430227881e+03 + 165300 1.009737757280632e+00 -6.096129980779802e+00 -6.004700124643508e+00 3.193487373427120e+00 4.718491756086231e+00 9.231496998792160e+03 + 165320 9.843741141344144e-01 -6.098210700652363e+00 -5.983104493293110e+00 3.183509056415958e+00 4.844466711700806e+00 9.165263948996804e+03 + 165340 9.243284270515657e-01 -6.048056412374070e+00 -5.956390524854450e+00 3.484450559373542e+00 5.010810270761450e+00 9.083659881976448e+03 + 165360 8.907231733043808e-01 -6.027316084208714e+00 -5.946632306464855e+00 3.564474273568815e+00 5.027773011148309e+00 9.053936257339396e+03 + 165380 9.621516755979446e-01 -6.152900710350401e+00 -5.951159655485034e+00 2.893534183699023e+00 5.051962540063306e+00 9.067717135272927e+03 + 165400 8.786023297483069e-01 -6.039175390218580e+00 -5.991528408780200e+00 3.462821029995646e+00 4.736417370761376e+00 9.191044603199283e+03 + 165420 9.030535142006715e-01 -6.076824625405761e+00 -5.978259638960235e+00 3.278941126633664e+00 4.844916531686232e+00 9.150417225317613e+03 + 165440 9.384210810024903e-01 -6.121828135819438e+00 -5.957243171617885e+00 3.050192133929255e+00 4.995264467815471e+00 9.086251331064666e+03 + 165460 8.897762294335501e-01 -6.030886984251786e+00 -5.994055922660507e+00 3.523830702489797e+00 4.735320357735280e+00 9.198799518438182e+03 + 165480 9.994282040887725e-01 -6.162191113867421e+00 -5.958386898306436e+00 2.861773097965289e+00 5.032048442316897e+00 9.089761991079800e+03 + 165500 9.971206320466740e-01 -6.117940729250219e+00 -5.980881733164880e+00 3.040590299405847e+00 4.827604264738960e+00 9.158465804244204e+03 + 165520 9.761711005018174e-01 -6.043970069606521e+00 -5.990739964630398e+00 3.475112546174070e+00 4.780768046279094e+00 9.188647761458376e+03 + 165540 1.035273136539422e+00 -6.096296131011345e+00 -5.963290698379604e+00 3.177971886619802e+00 4.941709663315441e+00 9.104703643051987e+03 + 165560 9.758216236204874e-01 -5.981089681071365e+00 -5.979377071309673e+00 3.804930472451016e+00 4.814764542728158e+00 9.153819705760734e+03 + 165580 1.010461771277313e+00 -6.015165521565926e+00 -5.988342935810744e+00 3.636819254900908e+00 4.790838693088898e+00 9.181291453791784e+03 + 165600 9.691019331948778e-01 -5.942450293628315e+00 -6.024751028018762e+00 3.999089459184135e+00 4.526505906316706e+00 9.293183347706548e+03 + 165620 9.923186158230185e-01 -5.971314126292355e+00 -5.983936831730908e+00 3.855936055244825e+00 4.783454527259301e+00 9.167791615474473e+03 + 165640 1.078302801599700e+00 -6.095078609793026e+00 -5.955873158699093e+00 3.177685714815525e+00 4.977024956970819e+00 9.082071313609280e+03 + 165660 9.311821229559124e-01 -5.872082565210619e+00 -6.010247587926930e+00 4.401036049932481e+00 4.607671108527259e+00 9.248523414495688e+03 + 165680 1.062579220576476e+00 -6.062358379254521e+00 -6.005014808535655e+00 3.330944881450582e+00 4.660220538407195e+00 9.232457077471350e+03 + 165700 1.056556873137881e+00 -6.051107923708167e+00 -6.022292625386584e+00 3.406200374179809e+00 4.571662276295347e+00 9.285641918822525e+03 + 165720 1.017147101764566e+00 -5.995754872314279e+00 -5.986917525336507e+00 3.734607246423048e+00 4.785352660344440e+00 9.176915713326454e+03 + 165740 9.154976146008741e-01 -5.849176589367297e+00 -5.992772070926649e+00 4.456924663485013e+00 4.632377187042262e+00 9.194835858946353e+03 + 165760 9.994773796181111e-01 -5.975322884928745e+00 -5.954680514831860e+00 3.802068202129567e+00 4.920599885622325e+00 9.078437063705951e+03 + 165780 1.025981430479790e+00 -6.014688574115288e+00 -5.986742110563571e+00 3.581903365967659e+00 4.742376284382876e+00 9.176373960366840e+03 + 165800 1.040793690792459e+00 -6.037164619001456e+00 -5.997674810553200e+00 3.465291107940094e+00 4.692047699078093e+00 9.209909844156758e+03 + 165820 1.028193796465471e+00 -6.021265251375336e+00 -6.002239333211423e+00 3.582886274775400e+00 4.692136041123907e+00 9.223905635943906e+03 + 165840 9.671673989090588e-01 -5.936378308552662e+00 -5.990152221977931e+00 4.033979973435962e+00 4.725201841061856e+00 9.186836173859780e+03 + 165860 1.016879579298759e+00 -6.015934692656344e+00 -5.979798755952325e+00 3.609186145655891e+00 4.816684286228492e+00 9.155129209536721e+03 + 165880 1.045847695708238e+00 -6.064474956963316e+00 -5.986080002468832e+00 3.387261563671946e+00 4.837417523959281e+00 9.174363202115013e+03 + 165900 9.840096485733572e-01 -5.980526574397962e+00 -6.012525239080682e+00 3.817919011668978e+00 4.634177727283443e+00 9.255534862722076e+03 + 165920 9.836662868989957e-01 -5.993755372664696e+00 -5.969842218126887e+00 3.724982345242907e+00 4.862295379147708e+00 9.124678526388039e+03 + 165940 9.376646757167715e-01 -5.938448252698278e+00 -5.930985424463248e+00 4.021063405800198e+00 5.063916120394680e+00 9.006367349024009e+03 + 165960 1.003719267699708e+00 -6.045209768493768e+00 -5.939359758519990e+00 3.439377934603434e+00 5.047185072108976e+00 9.031819383049238e+03 + 165980 9.676595887333380e-01 -5.996591003719549e+00 -6.001336576957520e+00 3.723151808293415e+00 4.695901992385897e+00 9.221154791038958e+03 + 166000 1.021366316972018e+00 -6.082467577148750e+00 -6.003992326809521e+00 3.229732615779352e+00 4.680349647232950e+00 9.229308378019481e+03 + 166020 9.440426354839239e-01 -5.977383035533467e+00 -6.019238950417140e+00 3.790183026642150e+00 4.549839886198208e+00 9.276200143157472e+03 + 166040 9.751121998279721e-01 -6.031536130121589e+00 -5.991020218366491e+00 3.533733545618579e+00 4.766382180733433e+00 9.189493859998036e+03 + 166060 9.649609600857295e-01 -6.019596152418438e+00 -5.993805589669060e+00 3.627872069775775e+00 4.775965472159387e+00 9.198049828115123e+03 + 166080 9.350322020480325e-01 -5.976007141489054e+00 -6.067549605675595e+00 3.814129630663037e+00 4.288478635153376e+00 9.425590718367283e+03 + 166100 9.912352340088673e-01 -6.059413109288780e+00 -6.037082652096245e+00 3.342639164059880e+00 4.470864104886497e+00 9.331270677846542e+03 + 166120 9.507049665548862e-01 -5.999048629952195e+00 -6.041236210851309e+00 3.689741999403311e+00 4.447494381373552e+00 9.344080585791826e+03 + 166140 9.819722596252993e-01 -6.043576922555983e+00 -6.004579298161347e+00 3.480617597250158e+00 4.704547991387032e+00 9.231114877500484e+03 + 166160 9.557712411997997e-01 -5.999369111723094e+00 -5.973979568266683e+00 3.706688377090788e+00 4.852479064636650e+00 9.137339074114507e+03 + 166180 1.003077320573980e+00 -6.057801007173517e+00 -5.964311998649931e+00 3.436887417319133e+00 4.973715771638879e+00 9.107813309499033e+03 + 166200 9.152244053688136e-01 -5.908978929244306e+00 -6.017054069704354e+00 4.122658528053699e+00 4.502074346958165e+00 9.269448511866913e+03 + 166220 9.714002374921845e-01 -5.967641067178317e+00 -6.001563904275963e+00 3.861004831247579e+00 4.666214651090817e+00 9.221831840107876e+03 + 166240 9.971245341694073e-01 -5.974991837373670e+00 -6.016655496592596e+00 3.841406129410745e+00 4.602166950745240e+00 9.268244341449330e+03 + 166260 1.051456546306953e+00 -6.026465305352705e+00 -5.968869464768817e+00 3.566897372991253e+00 4.897621602551460e+00 9.121744803038897e+03 + 166280 1.004488020071721e+00 -5.925882122745504e+00 -6.083361639638611e+00 4.094150598519088e+00 4.189878842642391e+00 9.474728525577404e+03 + 166300 9.842792119752980e-01 -5.871339428089427e+00 -6.069480596534211e+00 4.376974357391578e+00 4.239217105934907e+00 9.431564871169452e+03 + 166320 1.030207135606775e+00 -5.922576725769554e+00 -5.989827256061607e+00 4.114561309872214e+00 4.728398357949320e+00 9.185793698699012e+03 + 166340 1.063656322893622e+00 -5.958060562323180e+00 -5.942610165168730e+00 3.974204318523167e+00 5.062922889925245e+00 9.041646359999131e+03 + 166360 1.071397678600928e+00 -5.958258573659499e+00 -5.986942524807199e+00 3.863721868287424e+00 4.699014181970236e+00 9.176972899437131e+03 + 166380 1.097541656331303e+00 -5.989807609216938e+00 -5.992178885235467e+00 3.742659406972492e+00 4.729043173120321e+00 9.193050677276737e+03 + 166400 1.121987518250165e+00 -6.026945032909869e+00 -5.970920856527115e+00 3.556489521463527e+00 4.878189011966573e+00 9.127998598703743e+03 + 166420 1.038093856137929e+00 -5.912192707342580e+00 -6.002538626660161e+00 4.161345894572353e+00 4.642565644864971e+00 9.224840489406277e+03 + 166440 1.043058568671170e+00 -5.936622088711750e+00 -6.017635117648088e+00 4.010469484408535e+00 4.545280135530371e+00 9.271276504949272e+03 + 166460 1.042397914242696e+00 -5.965482401389670e+00 -6.050521041420506e+00 3.877607491651559e+00 4.389302460907484e+00 9.372788220511211e+03 + 166480 1.026712458978544e+00 -5.986581902237359e+00 -6.016849614825443e+00 3.741897054845425e+00 4.568095165251261e+00 9.268845068668041e+03 + 166500 1.030073489694778e+00 -6.044981602779193e+00 -5.996304298543407e+00 3.460624364526777e+00 4.740136978237145e+00 9.205716339442963e+03 + 166520 1.002267262515550e+00 -6.055665248128250e+00 -6.011079803452339e+00 3.351035604290656e+00 4.607052127195001e+00 9.251100767203128e+03 + 166540 9.592375394269405e-01 -6.033233902651163e+00 -5.950490857213076e+00 3.497809037074869e+00 4.972932408425262e+00 9.065707169327261e+03 + 166560 9.472764038207523e-01 -6.038211383848202e+00 -5.958668491001109e+00 3.526911076595662e+00 4.983658676546556e+00 9.090605348840838e+03 + 166580 9.270077687206861e-01 -6.019051814326366e+00 -5.950050050054109e+00 3.603569626881888e+00 4.999788435321699e+00 9.064331488556565e+03 + 166600 9.228004999978331e-01 -6.013671360073827e+00 -5.977781850685394e+00 3.564564131077238e+00 4.770647247869245e+00 9.148956876736127e+03 + 166620 9.685289094344968e-01 -6.074926482056385e+00 -5.971458416785779e+00 3.265825589064309e+00 4.859955231479478e+00 9.129638468680505e+03 + 166640 9.762603787504949e-01 -6.076111251644694e+00 -5.979794794979989e+00 3.255178013768556e+00 4.808242012860784e+00 9.155144633554966e+03 + 166660 1.019411900711306e+00 -6.127186351758633e+00 -5.916042015315389e+00 3.057790550030562e+00 5.270214004368135e+00 8.961096202900406e+03 + 166680 9.692385627129526e-01 -6.036882221095866e+00 -5.944396484792606e+00 3.499580141075626e+00 5.030647551050384e+00 9.047153373532828e+03 + 166700 9.141862075137208e-01 -5.935025342098744e+00 -6.034331232236426e+00 3.967617875059701e+00 4.397388086352304e+00 9.322700541313099e+03 + 166720 9.955375652140142e-01 -6.031958649147912e+00 -5.980999679462830e+00 3.511817739817498e+00 4.804432029624312e+00 9.158805744051988e+03 + 166740 9.974304841977606e-01 -6.008119636069985e+00 -6.010248397196195e+00 3.692433476967455e+00 4.680209801156035e+00 9.248524825898457e+03 + 166760 1.014849478741141e+00 -6.010245509209287e+00 -6.061228281768240e+00 3.584302821255048e+00 4.291551851662985e+00 9.405970151684685e+03 + 166780 1.116486067605308e+00 -6.142537936685952e+00 -6.008389928090300e+00 2.920718904131308e+00 4.691017528824783e+00 9.242844523710173e+03 + 166800 9.726967910680372e-01 -5.914687152553438e+00 -6.072939760129119e+00 4.171232737603592e+00 4.262521775392160e+00 9.442322836636364e+03 + 166820 1.021159149251269e+00 -5.977277267235523e+00 -6.031061574467302e+00 3.816795440882591e+00 4.507957625663070e+00 9.312648860731306e+03 + 166840 1.032641269512210e+00 -5.988898225387757e+00 -6.003084020282319e+00 3.762444657011272e+00 4.680987627482033e+00 9.226522254052457e+03 + 166860 1.035296046602321e+00 -5.990472795353280e+00 -5.972710721262479e+00 3.733542399200416e+00 4.835534977301874e+00 9.133455359394957e+03 + 166880 1.010769852092382e+00 -5.952499687129150e+00 -5.989172944022894e+00 3.964594425943198e+00 4.754010909691152e+00 9.183815733280160e+03 + 166900 1.025041371477794e+00 -5.975494767215718e+00 -5.951337652547778e+00 3.904908425522170e+00 5.043622316246894e+00 9.068231702300574e+03 + 166920 9.982603960559440e-01 -5.937353199110719e+00 -6.047248092926822e+00 3.944199734460505e+00 4.313166247988589e+00 9.362655713611073e+03 + 166940 1.038186110608346e+00 -6.000671641367780e+00 -6.011229584403312e+00 3.676776295503718e+00 4.616150952757289e+00 9.251574028540548e+03 + 166960 1.053805846686334e+00 -6.034809236768497e+00 -6.003875027399162e+00 3.499874733533840e+00 4.677503750785995e+00 9.228934532508389e+03 + 166980 1.021046552157900e+00 -6.007452666074796e+00 -5.958075905203686e+00 3.702218895373908e+00 4.985747897324869e+00 9.088780451363531e+03 + 167000 1.058406708839200e+00 -6.096007104866924e+00 -5.936283977704912e+00 3.213383007150781e+00 5.130537920389100e+00 9.022493762529441e+03 + 167020 9.631677268727427e-01 -5.994995669486617e+00 -6.012774544480179e+00 3.682705195888725e+00 4.580616144403674e+00 9.256319593386395e+03 + 167040 1.025524366499356e+00 -6.133849350657677e+00 -6.014520316725015e+00 2.947590070846558e+00 4.632795849796224e+00 9.261700125021669e+03 + 167060 9.516034436000417e-01 -6.067584461345720e+00 -6.031384134722598e+00 3.294033303253995e+00 4.501901180706399e+00 9.313655522175761e+03 + 167080 9.369818092597044e-01 -6.079162554677797e+00 -5.965355963107049e+00 3.335535843350514e+00 4.989030903662877e+00 9.111013686531536e+03 + 167100 9.387693991862996e-01 -6.102566939777946e+00 -5.993747292175476e+00 3.136142104779732e+00 4.761001361099158e+00 9.197852729205526e+03 + 167120 9.762403772719263e-01 -6.169835888702647e+00 -5.953476235616520e+00 2.819866626558796e+00 5.062237236127438e+00 9.074790791055389e+03 + 167140 9.574426153331849e-01 -6.144455533093416e+00 -5.959471085236828e+00 2.942496597572488e+00 5.004705923415806e+00 9.093057633339347e+03 + 167160 8.452208070026784e-01 -5.971302993692965e+00 -6.029120632117292e+00 3.836383768446855e+00 4.504385941363742e+00 9.306655335361873e+03 + 167180 9.535842207485695e-01 -6.117304545157376e+00 -5.965657711521173e+00 3.065158750668746e+00 4.935938336679490e+00 9.111940371713146e+03 + 167200 9.585362162398349e-01 -6.102063705455821e+00 -5.975129860558967e+00 3.130370999535465e+00 4.859244779882214e+00 9.140870279055116e+03 + 167220 9.402637813005357e-01 -6.045862280474664e+00 -5.990854421503414e+00 3.445122223785953e+00 4.760985862437529e+00 9.189004042558718e+03 + 167240 8.999909555870045e-01 -5.952940066288223e+00 -6.017175143322012e+00 3.963132074831851e+00 4.594284322157789e+00 9.269837289146264e+03 + 167260 1.013687076921721e+00 -6.087656353722195e+00 -5.954547218874366e+00 3.244767600092489e+00 5.009100850960769e+00 9.078032959650005e+03 + 167280 9.998027532802858e-01 -6.035106525257122e+00 -5.969369665105679e+00 3.547843176442008e+00 4.925314400177822e+00 9.123244960390515e+03 + 167300 1.007914329766234e+00 -6.018987260135010e+00 -5.999330177143257e+00 3.617849083151666e+00 4.730723095614070e+00 9.215010904356996e+03 + 167320 1.011417681646572e+00 -6.004726918262120e+00 -6.025997927082499e+00 3.608721374586011e+00 4.486579950261421e+00 9.297046788001833e+03 + 167340 1.003446829367902e+00 -5.980070465071472e+00 -6.011936653972316e+00 3.809171141926820e+00 4.626190553981383e+00 9.253712767476109e+03 + 167360 9.903574759227143e-01 -5.950768614455566e+00 -6.052274018039512e+00 3.904944832716994e+00 4.322085097427538e+00 9.378197493337326e+03 + 167380 1.010566060085903e+00 -5.973195831889321e+00 -6.017103920727397e+00 3.801283325499440e+00 4.549156284636419e+00 9.269618602832132e+03 + 167400 9.774959730960828e-01 -5.921148474866386e+00 -6.002474510068009e+00 4.128252878710813e+00 4.661266199419825e+00 9.224636344063545e+03 + 167420 1.048433102258171e+00 -6.024653560956384e+00 -5.972886282625062e+00 3.592090975599926e+00 4.889346698738814e+00 9.133970276666967e+03 + 167440 1.056492335413519e+00 -6.034803065721652e+00 -5.996897033842286e+00 3.532379288666400e+00 4.750041589657197e+00 9.207504246120096e+03 + 167460 9.526873521994242e-01 -5.882505268868856e+00 -6.046656464811663e+00 4.317864062436735e+00 4.375282493017663e+00 9.360784036133218e+03 + 167480 9.505860375494879e-01 -5.881276836129248e+00 -5.993896826470424e+00 4.352946850190014e+00 4.706265437763800e+00 9.198313576162969e+03 + 167500 1.007152896698728e+00 -5.966713902806125e+00 -6.010089472973124e+00 3.884763490087220e+00 4.635694253840521e+00 9.248060470260079e+03 + 167520 1.057109516430551e+00 -6.044631923699367e+00 -6.029809928152686e+00 3.444728922808973e+00 4.529839114934411e+00 9.308803046954694e+03 + 167540 1.015474586731282e+00 -5.993295151067107e+00 -6.056419809972598e+00 3.741122389383079e+00 4.378650829438352e+00 9.391061344039941e+03 + 167560 1.103267502638440e+00 -6.138543478410689e+00 -5.968111758702340e+00 2.983487948368567e+00 4.962133257157295e+00 9.119428193562093e+03 + 167580 1.011987943917144e+00 -6.024388011722388e+00 -6.006618311686128e+00 3.593598372312561e+00 4.695634739772963e+00 9.237382299443971e+03 + 167600 1.020786890643810e+00 -6.068583823415978e+00 -5.996521771877996e+00 3.346971566202682e+00 4.760763017700211e+00 9.206379033979807e+03 + 167620 8.999776465660398e-01 -5.927674270559208e+00 -5.999975762190043e+00 4.097070472115647e+00 4.681904118551723e+00 9.216960410620663e+03 + 167640 9.786029393546344e-01 -6.083334419564388e+00 -5.983659550959781e+00 3.212855431234266e+00 4.785203951397988e+00 9.166949701106143e+03 + 167660 9.488041937863054e-01 -6.077434899922848e+00 -5.980856045509015e+00 3.262791056525370e+00 4.817361784099014e+00 9.158348848080563e+03 + 167680 8.871397692184833e-01 -6.014336746801713e+00 -5.959679735002371e+00 3.627789458318813e+00 4.941638478215874e+00 9.093675271537535e+03 + 167700 9.141447462819622e-01 -6.071520657001473e+00 -5.976921396863204e+00 3.319198288999456e+00 4.862401879901592e+00 9.146343176722963e+03 + 167720 9.671712224205127e-01 -6.158148273061348e+00 -5.988713835169087e+00 2.804674118247454e+00 4.777592880519349e+00 9.182475964308078e+03 + 167740 9.130737767028931e-01 -6.078627818928707e+00 -6.020615104540776e+00 3.287285658987119e+00 4.620403642441155e+00 9.280455902872303e+03 + 167760 9.320927445643246e-01 -6.102086887639029e+00 -5.974653966135145e+00 3.155649319668052e+00 4.887388875124222e+00 9.139420861768966e+03 + 167780 9.664646798899579e-01 -6.140207428405105e+00 -5.954241852029272e+00 2.938077136890087e+00 5.005920254520065e+00 9.077115456775997e+03 + 167800 8.905025489346398e-01 -6.004700266883127e+00 -6.006646736190191e+00 3.662914725014806e+00 4.651737797038487e+00 9.237477529598349e+03 + 167820 9.671711076156827e-01 -6.086194227380280e+00 -5.963895725388481e+00 3.249074669388143e+00 4.951331593457073e+00 9.106557671901859e+03 + 167840 9.558555888222361e-01 -6.031571023274830e+00 -5.984322812136201e+00 3.548695828035738e+00 4.820002368030786e+00 9.168996103421545e+03 + 167860 9.941312425570010e-01 -6.047917239170769e+00 -6.029744249511456e+00 3.453411552599492e+00 4.557763671484326e+00 9.308580789661381e+03 + 167880 1.047614694329666e+00 -6.097049477962578e+00 -6.018168012326317e+00 3.158363218168950e+00 4.611312800719716e+00 9.272914644139581e+03 + 167900 9.595174620958807e-01 -5.948446997521113e+00 -6.028974482131387e+00 4.037311392084650e+00 4.574910113864489e+00 9.306211059498162e+03 + 167920 1.038409102290184e+00 -6.053425900963605e+00 -6.016100138807943e+00 3.441980861536831e+00 4.656311163977666e+00 9.266559779257997e+03 + 167940 9.962512785341822e-01 -5.985124061638791e+00 -6.033148323377055e+00 3.784261858671432e+00 4.508499116039836e+00 9.319109479660707e+03 + 167960 1.018469306023284e+00 -6.015143995841250e+00 -6.027995037155034e+00 3.616134726292700e+00 4.542342058376736e+00 9.303157278189256e+03 + 167980 1.049402970640187e+00 -6.060302199423786e+00 -5.992139241841528e+00 3.436971627707801e+00 4.828373878328723e+00 9.192947828240067e+03 + 168000 9.810102854473706e-01 -5.959454075944157e+00 -6.001272661122109e+00 3.971674009441736e+00 4.731545221944793e+00 9.220964176139823e+03 + 168020 1.027339122616754e+00 -6.028270509025845e+00 -6.010649510898904e+00 3.508332426604620e+00 4.609514924690163e+00 9.249773796119012e+03 + 168040 1.034033703170494e+00 -6.040498727702604e+00 -6.009356623121044e+00 3.467739382983012e+00 4.646562166715440e+00 9.245791153997341e+03 + 168060 9.520555741662647e-01 -5.923569241307943e+00 -5.988082677962063e+00 4.107520246933445e+00 4.737074110243433e+00 9.180511942955938e+03 + 168080 1.016959251833817e+00 -6.023453010255251e+00 -6.015697184080325e+00 3.580621352052153e+00 4.625156506158796e+00 9.265283188786789e+03 + 168100 9.984689731714895e-01 -5.998755417719217e+00 -6.055864365979149e+00 3.623059074325277e+00 4.295130655835569e+00 9.389328111051282e+03 + 168120 9.757081330891263e-01 -5.970650392196534e+00 -6.008033443939251e+00 3.861285452328307e+00 4.646626184213067e+00 9.241711358461636e+03 + 168140 9.861241669275939e-01 -5.991287377986544e+00 -6.007568997474019e+00 3.671226416002647e+00 4.577734837333092e+00 9.240297505670715e+03 + 168160 9.778128663578285e-01 -5.983571235197211e+00 -6.003639025888869e+00 3.784273120176002e+00 4.669040760543927e+00 9.228210706856087e+03 + 168180 1.044519331894726e+00 -6.088520745503303e+00 -5.956292894847333e+00 3.259283094860483e+00 5.018555875520824e+00 9.083350055795743e+03 + 168200 9.377800452558145e-01 -5.935408606860237e+00 -6.003015630216781e+00 4.077871895754400e+00 4.689661905488074e+00 9.226293974903292e+03 + 168220 1.072530314689263e+00 -6.138867244651243e+00 -5.953603597436825e+00 2.954670599197508e+00 5.018483130959449e+00 9.075174345837298e+03 + 168240 9.808247169928299e-01 -6.006585189957734e+00 -6.001640716948886e+00 3.660879879451366e+00 4.689271808622896e+00 9.222079349980893e+03 + 168260 1.000376286024474e+00 -6.037847122274918e+00 -6.010104851547267e+00 3.520947280061504e+00 4.680247691682200e+00 9.248092504845697e+03 + 168280 1.010439001539138e+00 -6.055742097090139e+00 -6.009041819850434e+00 3.398951912358957e+00 4.667112131113891e+00 9.244812776782532e+03 + 168300 1.042353503862047e+00 -6.104719885806098e+00 -5.997880846171707e+00 3.109765936572489e+00 4.723252235441109e+00 9.210564947470917e+03 + 168320 9.935891748776303e-01 -6.035610177520040e+00 -5.990057732488337e+00 3.498544185900603e+00 4.760113374490726e+00 9.186561152285543e+03 + 168340 9.611495047384812e-01 -5.988846742589476e+00 -5.983136582137884e+00 3.735327609300682e+00 4.768116234258200e+00 9.165348258366777e+03 + 168360 9.707427382250238e-01 -5.999500290035220e+00 -6.006961493859886e+00 3.676198481923273e+00 4.633355094944481e+00 9.238438804099200e+03 + 168380 1.042075067849303e+00 -6.098648417545730e+00 -5.991809276489709e+00 3.142750414753324e+00 4.756237296000641e+00 9.191949974342535e+03 + 168400 9.802296402726708e-01 -5.999549474264470e+00 -6.035658282494889e+00 3.670165180356594e+00 4.462822815677519e+00 9.326851174692405e+03 + 168420 1.007137935107914e+00 -6.029918607969732e+00 -6.058748470091388e+00 3.506850541790652e+00 4.341305012081363e+00 9.398280787341233e+03 + 168440 9.789750800120962e-01 -5.978419048411698e+00 -6.040901308924353e+00 3.805216908241625e+00 4.446434099279401e+00 9.343057002513098e+03 + 168460 9.631040551368775e-01 -5.944281233465803e+00 -6.028174838415723e+00 3.989436173143411e+00 4.507706111027568e+00 9.303734860161732e+03 + 168480 9.970167376710625e-01 -5.980929738077193e+00 -6.006000165177396e+00 3.795835380595850e+00 4.651877108550428e+00 9.235481093744935e+03 + 168500 1.004185904761261e+00 -5.974531590324310e+00 -6.080890709891098e+00 3.782247089743209e+00 4.171516566170155e+00 9.467023569189076e+03 + 168520 1.013827236428084e+00 -5.973049311141013e+00 -6.012419485385690e+00 3.840984825903659e+00 4.614915192875946e+00 9.255221235073066e+03 + 168540 1.076859101202937e+00 -6.053186792390386e+00 -5.995586413061469e+00 3.418400539656923e+00 4.749150831393460e+00 9.203507131764953e+03 + 168560 1.043881651533439e+00 -5.992707235612097e+00 -5.996168097459625e+00 3.726689913047351e+00 4.706817108752205e+00 9.205279692437851e+03 + 168580 9.737186113369496e-01 -5.876932466512167e+00 -5.991104755771518e+00 4.338427004733473e+00 4.682832051701614e+00 9.189740656006938e+03 + 168600 1.094596503803888e+00 -6.042894973784376e+00 -5.970877966879069e+00 3.427454269791486e+00 4.840987068037563e+00 9.127860232527708e+03 + 168620 1.033729774112933e+00 -5.941687711327800e+00 -5.974789717065383e+00 4.019444731563217e+00 4.829367892099186e+00 9.139822181709802e+03 + 168640 1.050341511893878e+00 -5.960504392549590e+00 -6.003942140054882e+00 3.839880874428225e+00 4.590454606283140e+00 9.229131651380329e+03 + 168660 1.007979209796018e+00 -5.896037139427145e+00 -5.973113176423912e+00 4.250819036897588e+00 4.808236504983981e+00 9.134662441056038e+03 + 168680 1.055534606159882e+00 -5.965412039415228e+00 -5.991132780259292e+00 3.833686406117894e+00 4.685993931919493e+00 9.189846381055224e+03 + 168700 1.017491393242823e+00 -5.914795220899256e+00 -5.983688675467978e+00 4.135292024947770e+00 4.739695147586528e+00 9.167016774283409e+03 + 168720 9.929851922165435e-01 -5.888202690553465e+00 -6.029376041529388e+00 4.256356292265606e+00 4.445717064456397e+00 9.307439504389782e+03 + 168740 1.041436389252518e+00 -5.976004549909236e+00 -6.020341615956690e+00 3.776569617870068e+00 4.521979323486788e+00 9.279594800672634e+03 + 168760 1.057589580365572e+00 -6.026361774466510e+00 -6.006984956455374e+00 3.546126247343759e+00 4.657390934916603e+00 9.238515712228700e+03 + 168780 9.315622772572537e-01 -5.875895303441302e+00 -6.037901775604793e+00 4.382418388768011e+00 4.452152155184701e+00 9.333740528929004e+03 + 168800 1.022258214850825e+00 -6.048001483303411e+00 -5.983452342384318e+00 3.395455104104973e+00 4.766106260209681e+00 9.166319157999251e+03 + 168820 1.011169067048232e+00 -6.067326144909360e+00 -5.959810764013612e+00 3.339739661489530e+00 4.957109616544337e+00 9.094099565584142e+03 + 168840 1.025020236976436e+00 -6.117665487057854e+00 -5.973190723675447e+00 3.121478401817856e+00 4.951074850557013e+00 9.134927349190359e+03 + 168860 9.463644152986400e-01 -6.025476332915616e+00 -6.008009633252114e+00 3.518262851117608e+00 4.618559343548475e+00 9.241654430254257e+03 + 168880 9.334698927256949e-01 -6.023383396928434e+00 -5.985452456730509e+00 3.566078145444812e+00 4.783883473855324e+00 9.172436467963322e+03 + 168900 9.510709456428174e-01 -6.060016525786116e+00 -5.997483369874761e+00 3.361660532797660e+00 4.720735591015265e+00 9.209320555277578e+03 + 168920 9.730250911305984e-01 -6.097095521270990e+00 -5.977041073949358e+00 3.158828303504729e+00 4.848199518391223e+00 9.146695280216542e+03 + 168940 9.558141948268647e-01 -6.070433359706711e+00 -5.924860591364033e+00 3.365261151523176e+00 5.201162514659930e+00 8.987807619985155e+03 + 168960 9.258467656357104e-01 -6.016408193529506e+00 -5.966268312549667e+00 3.620941408309057e+00 4.908852364016791e+00 9.113779585905784e+03 + 168980 9.841433380522656e-01 -6.085575134652720e+00 -5.988611291840447e+00 3.297175115354938e+00 4.853956505889187e+00 9.182116048274267e+03 + 169000 8.978617716414307e-01 -5.936027897521306e+00 -6.034526833937395e+00 4.020281557852432e+00 4.454685422290102e+00 9.323360812508037e+03 + 169020 9.772038054029044e-01 -6.027909326832266e+00 -5.977939674347870e+00 3.567197332494232e+00 4.854130809838366e+00 9.149454308838647e+03 + 169040 1.021951532861171e+00 -6.064897671267945e+00 -5.978235666492353e+00 3.358109575201783e+00 4.855736217525131e+00 9.150343781253187e+03 + 169060 1.027576518727818e+00 -6.039430666740722e+00 -6.038217903364465e+00 3.466189915985461e+00 4.473153790966458e+00 9.334751237827581e+03 + 169080 9.936332127660447e-01 -5.960300019132356e+00 -6.007500849921213e+00 3.888822860662688e+00 4.617788385968119e+00 9.240081895516532e+03 + 169100 1.008692332085153e+00 -5.958893362928133e+00 -5.972862347851516e+00 3.958697756062315e+00 4.878485682938816e+00 9.133933559378087e+03 + 169120 1.065751004338330e+00 -6.026793979216103e+00 -5.992995966686865e+00 3.548386346339673e+00 4.742459764508095e+00 9.195553317278525e+03 + 169140 9.637628816064123e-01 -5.865746658181116e+00 -6.016361843763390e+00 4.409256881206532e+00 4.544401177968477e+00 9.267298699769202e+03 + 169160 1.027750194272457e+00 -5.954994367432889e+00 -5.976955404581854e+00 3.902922321199174e+00 4.776818647430296e+00 9.146435278467725e+03 + 169180 1.128221251554644e+00 -6.101370439026750e+00 -5.965054609424826e+00 3.140868604709728e+00 4.923615193090438e+00 9.110101371640070e+03 + 169200 1.037485058988604e+00 -5.970499850173887e+00 -5.994522205262080e+00 3.847419957191451e+00 4.709479876827610e+00 9.200239128053541e+03 + 169220 1.026562875976002e+00 -5.959905423906728e+00 -5.984367609292732e+00 3.939443560982471e+00 4.798977906985083e+00 9.169113652909171e+03 + 169240 1.022930598386316e+00 -5.961382394625726e+00 -6.014960333826480e+00 3.916507386401036e+00 4.608854568351015e+00 9.263028590828702e+03 + 169260 1.042237202648395e+00 -5.999814228241953e+00 -6.008424093610194e+00 3.704738004342276e+00 4.655298825025476e+00 9.242919865925160e+03 + 169280 1.005654422619085e+00 -5.957692906086175e+00 -5.976610996054559e+00 3.930174927904944e+00 4.821544327741522e+00 9.145374825744408e+03 + 169300 9.979623960856984e-01 -5.957912585152604e+00 -5.969106859230363e+00 3.998932413969210e+00 4.934653159906402e+00 9.122417324779897e+03 + 169320 9.838781255130404e-01 -5.944658283632568e+00 -6.012119863251195e+00 3.982506766202607e+00 4.595131936386737e+00 9.254252914936042e+03 + 169340 1.069551239447834e+00 -6.079052070554599e+00 -6.003008584182153e+00 3.232291238937528e+00 4.668944705379598e+00 9.226297176781885e+03 + 169360 1.019714566427577e+00 -6.017843870035239e+00 -5.988410119814670e+00 3.697530376212716e+00 4.866543524837349e+00 9.181503408217062e+03 + 169380 1.077089134624681e+00 -6.119744161902767e+00 -5.973935150311946e+00 3.057553216642677e+00 4.894811125068795e+00 9.137221788073928e+03 + 169400 9.577590763724352e-01 -5.959558895049918e+00 -6.005931164278123e+00 3.870048780070473e+00 4.603772034076651e+00 9.235263983211778e+03 + 169420 9.546099549913467e-01 -5.972970617552560e+00 -5.989378003475453e+00 3.843704376425677e+00 4.749490627421661e+00 9.184445871356631e+03 + 169440 9.672922474783208e-01 -6.005900824195700e+00 -5.971360899209590e+00 3.633824356255846e+00 4.832157950562207e+00 9.129318504588613e+03 + 169460 9.354970541407890e-01 -5.970578711854884e+00 -6.000636329624539e+00 3.812118517886766e+00 4.639523025252087e+00 9.218981922734605e+03 + 169480 9.953037596837457e-01 -6.070517429784870e+00 -5.976620285869886e+00 3.303890140160079e+00 4.843062071055979e+00 9.145421165819649e+03 + 169500 9.564261778725953e-01 -6.022296634215536e+00 -6.031265855771065e+00 3.599158273446532e+00 4.547655615292133e+00 9.313299574930305e+03 + 169520 9.533002482044989e-01 -6.030344533034954e+00 -6.026914756366521e+00 3.546636195897941e+00 4.566330504284306e+00 9.299856867630253e+03 + 169540 9.218347217271218e-01 -5.998368876769133e+00 -6.025615504681825e+00 3.668216240239366e+00 4.511761886362640e+00 9.295853291617765e+03 + 169560 9.970559879286637e-01 -6.125110979886927e+00 -5.943626387791891e+00 3.067991154854963e+00 5.110103767314515e+00 9.044798171844053e+03 + 169580 9.550985687257757e-01 -6.073919422849407e+00 -5.984582365077939e+00 3.243198781281949e+00 4.756185991870728e+00 9.169784803673725e+03 + 169600 9.311614749439289e-01 -6.047510906199292e+00 -6.021211109473283e+00 3.457211866767605e+00 4.608229369448740e+00 9.282278198268095e+03 + 169620 9.019674994514773e-01 -6.009569091682552e+00 -6.017872915283037e+00 3.629534565919198e+00 4.581852725792661e+00 9.271998904310905e+03 + 169640 9.522675028193525e-01 -6.085120252150315e+00 -6.004010619599317e+00 3.259685877287144e+00 4.725429939070047e+00 9.229370620903808e+03 + 169660 9.264916004470432e-01 -6.040990000734582e+00 -6.037216595039303e+00 3.474287987107039e+00 4.495955466541976e+00 9.331662576823261e+03 + 169680 9.785989703150859e-01 -6.105472746408179e+00 -6.021695295434523e+00 3.186747334445674e+00 4.667810422455044e+00 9.283782332778919e+03 + 169700 9.870105024731289e-01 -6.098338022542421e+00 -6.002827259316935e+00 3.213789575474086e+00 4.762227158157670e+00 9.225746824955111e+03 + 169720 9.182129516544071e-01 -5.969224699657318e+00 -6.057334169015666e+00 3.835441249474334e+00 4.329503041522386e+00 9.393895922368396e+03 + 169740 9.974687210385852e-01 -6.055082459020586e+00 -6.020458804828923e+00 3.431463891969735e+00 4.630278272331433e+00 9.279961816751680e+03 + 169760 1.021385387971490e+00 -6.056482306478014e+00 -6.006646682111493e+00 3.401112389342596e+00 4.687276256493101e+00 9.237479916116761e+03 + 169780 1.005925873913511e+00 -6.000150629030334e+00 -6.039839651959369e+00 3.692585628624745e+00 4.464685117109781e+00 9.339754958972273e+03 + 169800 1.002885685681158e+00 -5.966996381172388e+00 -6.016671378939895e+00 3.832653335258377e+00 4.547411810896292e+00 9.268309010774403e+03 + 169820 1.039585889759940e+00 -5.997117770090741e+00 -5.978297105817553e+00 3.788923728624128e+00 4.896994895369154e+00 9.150511463674646e+03 + 169840 1.017496821679604e+00 -5.943228357664990e+00 -6.010509730835819e+00 4.020314623350593e+00 4.633974566844847e+00 9.249331137594687e+03 + 169860 1.025020312609788e+00 -5.939911742171553e+00 -5.999544790537533e+00 4.038334767737267e+00 4.695912575835396e+00 9.215648442947095e+03 + 169880 1.011619743944109e+00 -5.909615454877444e+00 -6.045946159889828e+00 4.140251660776395e+00 4.357419655486868e+00 9.358641939391624e+03 + 169900 1.067311876306702e+00 -5.987281956574188e+00 -6.022711241456910e+00 3.765956892797317e+00 4.562516456336613e+00 9.286894571414674e+03 + 169920 1.071050380397811e+00 -5.993606732514963e+00 -5.988683256433588e+00 3.737303577495812e+00 4.765574939060531e+00 9.182334570723609e+03 + 169940 1.018181681648257e+00 -5.919219557523519e+00 -6.028111609099024e+00 4.112787327412216e+00 4.487512316275146e+00 9.303567603645566e+03 + 169960 1.013170091625445e+00 -5.924718278791855e+00 -6.022180148726331e+00 4.124126533580051e+00 4.564485394240660e+00 9.285263092257750e+03 + 169980 1.024407579775419e+00 -5.958604125805228e+00 -6.021702508177075e+00 3.915670025512649e+00 4.553349349490384e+00 9.283781335469925e+03 + 170000 1.018221192148465e+00 -5.974353792418123e+00 -5.992193393705416e+00 3.875008256311948e+00 4.772570505050933e+00 9.193095161753770e+03 + 170020 1.042351238870336e+00 -6.040995409880978e+00 -5.967316672444354e+00 3.539749464400567e+00 4.962824176509429e+00 9.116976629634582e+03 + 170040 9.914209667031570e-01 -6.000229857265493e+00 -6.015963302892558e+00 3.763617544290198e+00 4.673273664756747e+00 9.266097844712569e+03 + 170060 1.034733042854603e+00 -6.108384503132043e+00 -5.992481709315068e+00 3.121527774890239e+00 4.787059552886689e+00 9.193993903196844e+03 + 170080 9.397373283605081e-01 -6.008796477040999e+00 -6.008299563487647e+00 3.670538985807122e+00 4.673392340327594e+00 9.242554854003269e+03 + 170100 9.352200444151164e-01 -6.038648732118046e+00 -6.020744318654856e+00 3.484430594380992e+00 4.587240507185653e+00 9.280833482084103e+03 + 170120 9.726439827333372e-01 -6.119245213331881e+00 -5.979838494630489e+00 3.043759069244617e+00 4.844254021148005e+00 9.155249791550972e+03 + 170140 9.365000991102005e-01 -6.077795023780181e+00 -5.953330799722764e+00 3.286489709675720e+00 5.001182544989835e+00 9.074341722270015e+03 + 170160 9.212522219931480e-01 -6.055304792727600e+00 -6.004308962263983e+00 3.394383719948365e+00 4.687209670049709e+00 9.230267798148687e+03 + 170180 9.505445827871878e-01 -6.094214281864375e+00 -5.989592201276027e+00 3.204766873049646e+00 4.805523050002586e+00 9.185130020262563e+03 + 170200 9.475438158188727e-01 -6.082536845979496e+00 -5.978685669002435e+00 3.255276816197649e+00 4.851606345317627e+00 9.151715745272320e+03 + 170220 9.365147047407512e-01 -6.054555728385830e+00 -5.972135302775057e+00 3.386753793811953e+00 4.860024632188656e+00 9.131707405131336e+03 + 170240 8.520528527270319e-01 -5.912648696059914e+00 -6.036098843721047e+00 4.138482661585984e+00 4.429612809867154e+00 9.328167936163900e+03 + 170260 9.655707814947831e-01 -6.063383800585354e+00 -5.973893656488170e+00 3.308452200066950e+00 4.822318456028022e+00 9.137059108571249e+03 + 170280 9.658195758693514e-01 -6.042798930721443e+00 -5.996895059592011e+00 3.459088733852861e+00 4.722675865479163e+00 9.207521676412576e+03 + 170300 9.655323730554030e-01 -6.022222176450374e+00 -5.992159985702391e+00 3.617594932778368e+00 4.790216684162269e+00 9.192993655791328e+03 + 170320 9.969409238888579e-01 -6.047682970368264e+00 -6.026712116822573e+00 3.407681285848283e+00 4.528099172136741e+00 9.299238123761106e+03 + 170340 1.056188440360386e+00 -6.115237168691078e+00 -6.024364968501036e+00 3.001026442965414e+00 4.522828678884165e+00 9.292035398565024e+03 + 170360 9.417937044665678e-01 -5.930126822977082e+00 -6.037268202716104e+00 4.086599967621773e+00 4.471377585085380e+00 9.331800989362053e+03 + 170380 1.051925507588887e+00 -6.079820776615825e+00 -5.984995621274686e+00 3.202561953040747e+00 4.747062669154930e+00 9.171054398337639e+03 + 170400 9.652766409689445e-01 -5.936211614938637e+00 -6.003397019223716e+00 4.008972473514619e+00 4.623183485201980e+00 9.227466927209005e+03 + 170420 1.001022974229388e+00 -5.975566925739768e+00 -5.969215429048081e+00 3.832364615754913e+00 4.868835892649520e+00 9.122764755413333e+03 + 170440 1.044591770065379e+00 -6.025616577307121e+00 -5.980008715900333e+00 3.584136800093449e+00 4.846024198084964e+00 9.155758362128547e+03 + 170460 1.039327592966997e+00 -6.004824447409662e+00 -6.027695085848128e+00 3.641528299341432e+00 4.510201554207904e+00 9.302222086343778e+03 + 170480 1.083905516160292e+00 -6.059933331954823e+00 -5.986993198291197e+00 3.352879390417891e+00 4.771712925363636e+00 9.177179313635452e+03 + 170500 1.040192586591136e+00 -5.989210795734403e+00 -6.003708880742542e+00 3.726949239355794e+00 4.643698991667658e+00 9.228430037821292e+03 + 170520 1.009668855808574e+00 -5.941197257203990e+00 -5.991555922496095e+00 4.078132853750395e+00 4.788965604664853e+00 9.191114581704445e+03 + 170540 9.794286743542329e-01 -5.893361148285857e+00 -6.028724292342002e+00 4.220531656966072e+00 4.443255536416843e+00 9.305427561850074e+03 + 170560 9.683814571543250e-01 -5.876273132851452e+00 -5.956318728816906e+00 4.328514568905150e+00 4.868880369855570e+00 9.083458697188480e+03 + 170580 1.041584915052905e+00 -5.986711679326891e+00 -5.994869938065093e+00 3.803110961162459e+00 4.756264977001248e+00 9.201265125865752e+03 + 170600 1.000801476284196e+00 -5.930760088746859e+00 -6.033649264170018e+00 4.060299604464596e+00 4.469494037136382e+00 9.320627320544390e+03 + 170620 1.034878622800377e+00 -5.993368645355741e+00 -5.998714396326448e+00 3.702534832039707e+00 4.671838702713617e+00 9.213082586816368e+03 + 170640 1.018440253400480e+00 -5.988772905030628e+00 -5.997579079468695e+00 3.735111911505739e+00 4.684545495131271e+00 9.209601416923637e+03 + 170660 1.003222454235318e+00 -5.993249722684387e+00 -5.992579331378779e+00 3.726248424739012e+00 4.730097915358535e+00 9.194272502888114e+03 + 170680 9.961471764107238e-01 -6.014585870520928e+00 -5.976859986420358e+00 3.620276912922983e+00 4.836904777490152e+00 9.146143205257018e+03 + 170700 9.927600260838007e-01 -6.042574584515392e+00 -5.973265898090660e+00 3.456337300682211e+00 4.854318503617582e+00 9.135182543616163e+03 + 170720 9.652652722411914e-01 -6.032711425074404e+00 -5.985171522998706e+00 3.524352331372965e+00 4.797333805867694e+00 9.171596569254334e+03 + 170740 9.260347572933402e-01 -5.999983936473900e+00 -5.984081319808709e+00 3.690953964378742e+00 4.782269250192242e+00 9.168234199792883e+03 + 170760 9.385566099388128e-01 -6.038227980073770e+00 -5.997435810930737e+00 3.453983154860438e+00 4.688218102647502e+00 9.209182772539596e+03 + 170780 1.008800387357944e+00 -6.155627896394275e+00 -5.978586685943808e+00 2.878235196751189e+00 4.894833224196544e+00 9.151445606785259e+03 + 170800 9.339674148239079e-01 -6.052114016151570e+00 -6.022707390301278e+00 3.432626475263452e+00 4.601483871556477e+00 9.286887343452872e+03 + 170820 9.026841480509497e-01 -6.008609767442591e+00 -6.016128722704627e+00 3.615436672391678e+00 4.572261667722504e+00 9.266636552998798e+03 + 170840 9.614351384338152e-01 -6.093136964397873e+00 -5.956578103927869e+00 3.211300276043321e+00 4.995442385277443e+00 9.084248488319894e+03 + 170860 9.494609892774311e-01 -6.064744278935260e+00 -5.989757627916260e+00 3.332614604343507e+00 4.763199558641342e+00 9.185644572006644e+03 + 170880 9.758723107783824e-01 -6.086596242950184e+00 -5.963794901251054e+00 3.181849094124565e+00 4.886993401607175e+00 9.106245891304350e+03 + 170900 9.443564440876259e-01 -6.013023523779257e+00 -5.991066015571589e+00 3.595247305250703e+00 4.721330715292543e+00 9.189636401065081e+03 + 170920 9.979735738741532e-01 -6.057433059651650e+00 -5.998401222332658e+00 3.359855507634828e+00 4.698825452667784e+00 9.212152075969656e+03 + 170940 1.021561085619873e+00 -6.052757243599248e+00 -6.034398194398078e+00 3.406388056103865e+00 4.511808557670667e+00 9.322956882158285e+03 + 170960 9.910188057034205e-01 -5.970757000806626e+00 -6.028199268858287e+00 3.814860649949634e+00 4.485018257634742e+00 9.303807957927480e+03 + 170980 1.014363910710538e+00 -5.977264986747066e+00 -5.978052909270562e+00 3.859526915253322e+00 4.855002542192791e+00 9.149782643402903e+03 + 171000 1.084497722298993e+00 -6.058373537128502e+00 -5.968757823358532e+00 3.395168191396990e+00 4.909755487851051e+00 9.121380774248420e+03 + 171020 9.276966639107868e-01 -5.810107943743019e+00 -6.012651724672794e+00 4.652525348393491e+00 4.489487614745926e+00 9.255870450664617e+03 + 171040 1.045145576062407e+00 -5.971755310255063e+00 -5.975066130884569e+00 3.863180548851889e+00 4.844169304449434e+00 9.140636691907986e+03 + 171060 1.029475837236159e+00 -5.939465731492257e+00 -6.008012805490893e+00 3.995523271580218e+00 4.601915365054635e+00 9.241665426773423e+03 + 171080 1.072865108081996e+00 -6.000119805814780e+00 -6.016181997813996e+00 3.660709544658617e+00 4.568477952582938e+00 9.266809198092127e+03 + 171100 1.034307016829046e+00 -5.947771556199718e+00 -6.043228510943781e+00 3.990405546480476e+00 4.442276940424062e+00 9.350232372443277e+03 + 171120 9.909806713831958e-01 -5.893630259803997e+00 -6.004482228143315e+00 4.268158226041095e+00 4.631629069550068e+00 9.230814562618483e+03 + 171140 1.095352219066863e+00 -6.058963998309231e+00 -6.034920213769887e+00 3.354800989796277e+00 4.492864121384822e+00 9.324546417283334e+03 + 171160 9.361818597836059e-01 -5.837702006150529e+00 -6.074215658044883e+00 4.543063798914179e+00 4.184965809367458e+00 9.446259669591762e+03 + 171180 1.063586238159527e+00 -6.041074751836959e+00 -5.993216660738875e+00 3.475828806547899e+00 4.750637371648756e+00 9.196230146157655e+03 + 171200 9.223231871640362e-01 -5.845355329042358e+00 -6.038626205803416e+00 4.454368731478369e+00 4.344577448544857e+00 9.336025105847053e+03 + 171220 1.001657265629783e+00 -5.977460492764368e+00 -6.037023127197168e+00 3.810550129172141e+00 4.468532264971110e+00 9.331074181307609e+03 + 171240 1.005827042537463e+00 -5.999050556772287e+00 -6.021340289169739e+00 3.687283384524524e+00 4.559292291773414e+00 9.282681492792377e+03 + 171260 1.001987463006701e+00 -6.007314462474951e+00 -6.000273816219245e+00 3.656292073567790e+00 4.696720553904538e+00 9.217883179848644e+03 + 171280 9.391827089957673e-01 -5.925549663450369e+00 -6.027063977593748e+00 4.073394302550900e+00 4.490483401450274e+00 9.300322702355819e+03 + 171300 1.019392492956403e+00 -6.053581334082163e+00 -6.001521994477442e+00 3.365681927440092e+00 4.664614711607167e+00 9.221744281017252e+03 + 171320 1.043979530262219e+00 -6.097425445007454e+00 -6.000371943071759e+00 3.206867108916930e+00 4.764163336012579e+00 9.218200644254624e+03 + 171340 9.669808066950646e-01 -5.989453513208580e+00 -6.011425453621453e+00 3.738455560082376e+00 4.612289278084866e+00 9.252138444819684e+03 + 171360 9.489642931133299e-01 -5.966098076171398e+00 -6.034651487722937e+00 3.841932536420052e+00 4.448288238684961e+00 9.323725841115664e+03 + 171380 9.937773520064063e-01 -6.034596647015252e+00 -5.987116854457822e+00 3.513693630166775e+00 4.786329946505689e+00 9.177552623595084e+03 + 171400 9.693534057665260e-01 -5.999670653650709e+00 -5.941421223222612e+00 3.736992166098672e+00 5.071469409687032e+00 9.038096113695467e+03 + 171420 9.554796697473289e-01 -5.974817086276644e+00 -5.984861273439644e+00 3.811510434577100e+00 4.753835157554215e+00 9.170617582354420e+03 + 171440 1.006728585824680e+00 -6.044963394225207e+00 -5.956203933333204e+00 3.458599687376750e+00 4.968270247300817e+00 9.083086999592480e+03 + 171460 9.952638910946333e-01 -6.022079869660653e+00 -5.993659030556267e+00 3.572420916997035e+00 4.735617773245061e+00 9.197578902818570e+03 + 171480 1.000897589531404e+00 -6.025654491205266e+00 -5.964523484370750e+00 3.529465204783151e+00 4.880488906019679e+00 9.108460581256915e+03 + 171500 8.851589681811243e-01 -5.847968305863181e+00 -6.038696579494841e+00 4.471370755269139e+00 4.376179492971192e+00 9.336175048552645e+03 + 171520 9.747771986418258e-01 -5.973323182732736e+00 -5.986960188578504e+00 3.820354647736007e+00 4.742048849849779e+00 9.177045450884305e+03 + 171540 1.024118150039167e+00 -6.039158840368815e+00 -5.987859842372965e+00 3.495607699408173e+00 4.790174484394631e+00 9.179826495095242e+03 + 171560 1.054708707629149e+00 -6.079628563944896e+00 -5.994265628718345e+00 3.319600567337748e+00 4.809767751280133e+00 9.199437620177328e+03 + 171580 9.654746301756072e-01 -5.944464419688822e+00 -6.015722557509570e+00 3.975020445735633e+00 4.565845191207707e+00 9.265375345004941e+03 + 171600 9.934451304520083e-01 -5.983428454092348e+00 -6.039299735468349e+00 3.763111637289891e+00 4.442290093576043e+00 9.338091574357446e+03 + 171620 1.017559659825727e+00 -6.017085151594062e+00 -5.992653914417639e+00 3.626361415854595e+00 4.766649360443346e+00 9.194515109745516e+03 + 171640 9.709030598019428e-01 -5.946862077441454e+00 -6.011799143925126e+00 3.975992419417954e+00 4.603113734690144e+00 9.253298900456324e+03 + 171660 1.025282394828877e+00 -6.026472431076947e+00 -6.003703376045156e+00 3.610320431112913e+00 4.741063868605333e+00 9.228398495997293e+03 + 171680 9.797543814871998e-01 -5.959089858204219e+00 -5.980995277290864e+00 3.957445529865331e+00 4.831661223617166e+00 9.158790095591123e+03 + 171700 9.879801297184002e-01 -5.969363242232961e+00 -5.976911486548956e+00 3.938516059477347e+00 4.895172872527871e+00 9.146281707245815e+03 + 171720 1.001725550943119e+00 -5.987246185676660e+00 -6.043439976764630e+00 3.656076930229333e+00 4.333403485841139e+00 9.350856420682028e+03 + 171740 1.007051566544903e+00 -5.994115571265025e+00 -5.971141406770496e+00 3.754958249862434e+00 4.886879457630489e+00 9.128675402733710e+03 + 171760 1.018446533448224e+00 -6.008468265866791e+00 -5.978347989306979e+00 3.690532377804710e+00 4.863487666908890e+00 9.150695006217993e+03 + 171780 1.002158495960799e+00 -5.978755835794822e+00 -6.039174383172543e+00 3.755089604884001e+00 4.408156956101141e+00 9.337707619621324e+03 + 171800 1.009484596766189e+00 -5.986760190431491e+00 -5.992087566815591e+00 3.816200457989901e+00 4.785609838383573e+00 9.192796906804604e+03 + 171820 1.041604118544639e+00 -6.032403206145791e+00 -6.002896833464178e+00 3.521867967333264e+00 4.691298125367497e+00 9.225953927108612e+03 + 171840 9.665822786040212e-01 -5.920381871429842e+00 -6.043708844495072e+00 4.088432370134125e+00 4.380269806006170e+00 9.351693299077364e+03 + 171860 1.074678360988256e+00 -6.080659785731807e+00 -5.981246488845114e+00 3.249144402998712e+00 4.819990937880080e+00 9.159573559695207e+03 + 171880 1.021758790337151e+00 -6.002998917291436e+00 -6.038845177180287e+00 3.664133224065047e+00 4.458298452592475e+00 9.336675552161771e+03 + 171900 9.773372821515389e-01 -5.943025881703281e+00 -6.001987395753183e+00 4.010165381458823e+00 4.671599243519475e+00 9.223153033009939e+03 + 171920 1.031542957852331e+00 -6.028838780742541e+00 -6.004602094285159e+00 3.521817174616015e+00 4.660987978869406e+00 9.231195388797376e+03 + 171940 9.931641978527259e-01 -5.981737343578180e+00 -6.025112956408787e+00 3.760827828149687e+00 4.511758346921954e+00 9.294312047528045e+03 + 171960 9.942910999199028e-01 -5.995904350195556e+00 -5.999471829507865e+00 3.752050717800490e+00 4.731565699523570e+00 9.215432487080032e+03 + 171980 9.763760373089337e-01 -5.982684865313786e+00 -6.024086023079970e+00 3.737813051981539e+00 4.500081197279654e+00 9.291146887632491e+03 + 172000 9.890078617169029e-01 -6.014780413382620e+00 -5.970289022350176e+00 3.656029403532166e+00 4.911505855860971e+00 9.126064556626347e+03 + 172020 1.030418325087919e+00 -6.089505935786843e+00 -6.008572171970718e+00 3.196709946469086e+00 4.661444142760746e+00 9.243373255725261e+03 + 172040 9.113729681880006e-01 -5.926264147339674e+00 -6.045669303285655e+00 4.059907602402332e+00 4.374264719072340e+00 9.357753761197173e+03 + 172060 1.037731908280993e+00 -6.127639944662689e+00 -5.943297243257048e+00 2.998114652903837e+00 5.056638971315880e+00 9.043819576115819e+03 + 172080 9.664889632182478e-01 -6.031891814831638e+00 -5.956363317556741e+00 3.505287301688137e+00 4.938983621037777e+00 9.083559367768732e+03 + 172100 9.675846243518632e-01 -6.039486628621668e+00 -5.981788502176136e+00 3.488376645873756e+00 4.819688216680213e+00 9.161235017877274e+03 + 172120 9.427911565687183e-01 -6.002596525330778e+00 -6.065851509203759e+00 3.635868782999956e+00 4.272648876924187e+00 9.420302608302583e+03 + 172140 1.025710259579387e+00 -6.124028208938828e+00 -5.995221513746751e+00 3.033499318125382e+00 4.773127294689953e+00 9.202414933250018e+03 + 172160 1.022930234879329e+00 -6.117667476990171e+00 -6.005436978973149e+00 3.064685001424672e+00 4.709129888651852e+00 9.233765814712531e+03 + 172180 9.528841140287684e-01 -6.010462711715466e+00 -6.008392079401310e+00 3.599722870796881e+00 4.611612761974078e+00 9.242849098932280e+03 + 172200 9.769086256639007e-01 -6.037469267969271e+00 -5.993920472892267e+00 3.540402981661931e+00 4.790466902148351e+00 9.198372194122510e+03 + 172220 1.001685117511323e+00 -6.057814855343692e+00 -6.007727948729677e+00 3.373897329674729e+00 4.661504098376156e+00 9.240784063165436e+03 + 172240 1.000293486810821e+00 -6.033765832241881e+00 -5.985063958971355e+00 3.541511843009716e+00 4.821165535919611e+00 9.171247080303594e+03 + 172260 1.029843233002278e+00 -6.050375412886610e+00 -5.931952273062092e+00 3.475083819945331e+00 5.155087814739376e+00 9.009317550731905e+03 + 172280 9.979083500795413e-01 -5.968938097493893e+00 -5.996681256075377e+00 3.900376482313927e+00 4.741070972499131e+00 9.206856415300068e+03 + 172300 9.910953191488213e-01 -5.920612380312593e+00 -6.039534535713416e+00 4.146052007954139e+00 4.463182588498543e+00 9.338811746995858e+03 + 172320 1.059253938255195e+00 -5.987092018009369e+00 -6.003790633122820e+00 3.793123860490346e+00 4.697237828406570e+00 9.228688296592190e+03 + 172340 1.048394965046214e+00 -5.943226468609465e+00 -6.037081333647786e+00 4.010430358619571e+00 4.471501199576102e+00 9.331212543504442e+03 + 172360 1.048798603325881e+00 -5.923953548004551e+00 -6.019785239773594e+00 4.132316830279241e+00 4.582036426235025e+00 9.277880432263342e+03 + 172380 1.054822752980198e+00 -5.921160533112129e+00 -6.040287114743693e+00 4.201034368739275e+00 4.516991102231910e+00 9.341122409992860e+03 + 172400 1.070624697258100e+00 -5.943701495588893e+00 -6.006700808958228e+00 4.022619710845968e+00 4.660867904367014e+00 9.237616575151951e+03 + 172420 1.087665722417053e+00 -5.973309647536586e+00 -5.990742047255759e+00 3.855704375234299e+00 4.755604838391663e+00 9.188625658294219e+03 + 172440 1.082671555508895e+00 -5.975098137206616e+00 -6.032851852051314e+00 3.835652335015956e+00 4.504021567019214e+00 9.318158082155564e+03 + 172460 1.075880443809336e+00 -5.984550528514778e+00 -6.016158023779798e+00 3.787897836809965e+00 4.606402707754134e+00 9.266728491515081e+03 + 172480 1.030377831704585e+00 -5.946548995702058e+00 -6.011534811357571e+00 4.005989054705988e+00 4.632830444689559e+00 9.252487485879567e+03 + 172500 1.009986612423348e+00 -5.949526728630444e+00 -6.017141988862014e+00 3.995566411707327e+00 4.607309124029947e+00 9.269747940604722e+03 + 172520 1.032006171283480e+00 -6.017425392705233e+00 -6.013504647391644e+00 3.628234371708197e+00 4.650747898032203e+00 9.258578016736792e+03 + 172540 1.045127023049643e+00 -6.075682116403290e+00 -6.004701169464201e+00 3.353530151080817e+00 4.761113732671108e+00 9.231503742012002e+03 + 172560 9.328167180436451e-01 -5.942895991482249e+00 -6.040270540398437e+00 3.993177521342875e+00 4.434037792803384e+00 9.341109408519034e+03 + 172580 9.569570424580628e-01 -6.001283495106502e+00 -6.029771398867808e+00 3.650117188354000e+00 4.486535236467725e+00 9.308641086014748e+03 + 172600 9.711383143553693e-01 -6.034969535257957e+00 -6.002105787817385e+00 3.525292281998686e+00 4.714001005450935e+00 9.223513315950806e+03 + 172620 9.695345062701345e-01 -6.037660094581866e+00 -5.981064015227295e+00 3.557403469660122e+00 4.882386915529040e+00 9.159005824058595e+03 + 172640 9.262001757590222e-01 -5.973060304432867e+00 -5.997804083077527e+00 3.883306133553282e+00 4.741223527488275e+00 9.210291180478478e+03 + 172660 9.807106669965060e-01 -6.049597162517309e+00 -5.981247828085527e+00 3.469973749691794e+00 4.862446205024409e+00 9.159565589861624e+03 + 172680 9.514318914662905e-01 -5.999393397720797e+00 -6.036095332866749e+00 3.733845237342295e+00 4.523097046128131e+00 9.328189204685377e+03 + 172700 9.539407440784161e-01 -5.995231582357144e+00 -6.022609409682798e+00 3.737461398108739e+00 4.580253676899749e+00 9.286606942001843e+03 + 172720 9.801825496110435e-01 -6.026928550237892e+00 -5.997009518303758e+00 3.577571027635955e+00 4.749370738956975e+00 9.207857850063427e+03 + 172740 9.858211385633077e-01 -6.024066985329942e+00 -5.997241331361455e+00 3.567562514191609e+00 4.721599570535195e+00 9.208577849712383e+03 + 172760 1.027614273873148e+00 -6.070526706382096e+00 -6.000133456637364e+00 3.331638996131673e+00 4.735847929486113e+00 9.217463963702086e+03 + 172780 9.924021303201925e-01 -6.003649369653463e+00 -6.017113068579690e+00 3.727382623388439e+00 4.650071980653369e+00 9.269652267904345e+03 + 172800 9.822262316195856e-01 -5.973445616491210e+00 -6.047312994501391e+00 3.866678748033224e+00 4.442520832558955e+00 9.362873375793612e+03 + 172820 1.045701315700432e+00 -6.051834337745269e+00 -6.010285318213351e+00 3.423894521653975e+00 4.662475421496242e+00 9.248659991004879e+03 + 172840 9.932735794916475e-01 -5.960201368732760e+00 -6.005699352140431e+00 3.975203653402160e+00 4.713947191885136e+00 9.234537887363775e+03 + 172860 9.767187191188476e-01 -5.921345331474637e+00 -6.019146440161713e+00 4.128508824574022e+00 4.566919723820175e+00 9.275910407278221e+03 + 172880 1.037488936465995e+00 -5.994567586924026e+00 -5.987900519717890e+00 3.830838451594528e+00 4.869121783217475e+00 9.179943528156775e+03 + 172900 1.034260541130848e+00 -5.972910243693983e+00 -6.038777378763229e+00 3.793055317253698e+00 4.414836034779875e+00 9.336484724653827e+03 + 172920 1.037315623599830e+00 -5.963630706909944e+00 -6.018265155122256e+00 3.893719876292875e+00 4.580000420004242e+00 9.273218014629445e+03 + 172940 1.055160987536114e+00 -5.978988893475173e+00 -5.987824119486614e+00 3.801986179482366e+00 4.751252944477866e+00 9.179687414965316e+03 + 172960 9.702833095912661e-01 -5.840991960859178e+00 -6.031057769142107e+00 4.524497354666903e+00 4.433110070917548e+00 9.312626508725054e+03 + 172980 1.095999026118134e+00 -6.015260597932206e+00 -6.019661736591093e+00 3.592142107342071e+00 4.566870088088737e+00 9.277510732199004e+03 + 173000 1.059105901226753e+00 -5.954643219047735e+00 -6.037985020293568e+00 3.945239107761918e+00 4.466677587906290e+00 9.334008061221604e+03 + 173020 1.040382771581557e+00 -5.925256495979632e+00 -6.065720095080787e+00 4.027556589492034e+00 4.220992866781489e+00 9.419890129539695e+03 + 173040 1.065033415603978e+00 -5.966439556451606e+00 -6.041543398258449e+00 3.894009558650715e+00 4.462751676713863e+00 9.344996423570939e+03 + 173060 9.828180189809057e-01 -5.860201626399448e+00 -6.064714023509033e+00 4.372721395332970e+00 4.198379562938558e+00 9.416790512609132e+03 + 173080 1.085337289523845e+00 -6.038428248566185e+00 -6.005454351652530e+00 3.534491882486018e+00 4.723833101258279e+00 9.233790642084487e+03 + 173100 9.990484560066603e-01 -5.945884859694917e+00 -6.056270077558128e+00 4.015952910086753e+00 4.382103907058945e+00 9.390601555318568e+03 + 173120 1.015634147231315e+00 -6.011858284024379e+00 -6.023865377686884e+00 3.622815174183521e+00 4.553868584281678e+00 9.290458094768865e+03 + 173140 9.552580740726015e-01 -5.961412638041280e+00 -5.971241894836776e+00 3.908114150496128e+00 4.851673036903812e+00 9.128981571337610e+03 + 173160 9.305778856185259e-01 -5.954230577838489e+00 -6.011161779187345e+00 3.958894878622979e+00 4.631987110402910e+00 9.251346829643579e+03 + 173180 1.004265136632929e+00 -6.090516674166908e+00 -6.012856916614709e+00 3.194386654755098e+00 4.640321000428470e+00 9.256550708127948e+03 + 173200 8.990016148434702e-01 -5.955769491476167e+00 -6.038204461943130e+00 3.858051786474328e+00 4.384697429282569e+00 9.334686274128735e+03 + 173220 9.791377970712588e-01 -6.086829828988833e+00 -5.985064166714954e+00 3.186556580349054e+00 4.770910761311004e+00 9.171271558508854e+03 + 173240 9.178561836157619e-01 -6.000873112545937e+00 -6.019295793190077e+00 3.673941804461277e+00 4.568155921302013e+00 9.276399978438039e+03 + 173260 1.024461387080682e+00 -6.161088725650881e+00 -5.955357648241751e+00 2.825248896394360e+00 5.006588579658922e+00 9.080528074449341e+03 + 173280 9.401720232504444e-01 -6.034173748647902e+00 -5.978445835631708e+00 3.519538817437126e+00 4.839537117842782e+00 9.150998687050354e+03 + 173300 9.470540276866289e-01 -6.037068525726442e+00 -5.972023956749140e+00 3.501390940657594e+00 4.874886921339779e+00 9.131367269831122e+03 + 173320 9.108501766157171e-01 -5.968946882093755e+00 -6.015118299458585e+00 3.816558113533273e+00 4.551434690020675e+00 9.263511983231312e+03 + 173340 1.029235403157530e+00 -6.122762203149047e+00 -5.954753905417141e+00 3.027174268288450e+00 4.991903913065103e+00 9.078686758177966e+03 + 173360 9.818262960992878e-01 -6.023412690631263e+00 -6.015999275447353e+00 3.564654286904957e+00 4.607223264113264e+00 9.266200376867040e+03 + 173380 1.001159147502946e+00 -6.016922699347793e+00 -6.013974089907674e+00 3.635101728305686e+00 4.652033100006684e+00 9.260001572950863e+03 + 173400 1.027042410060890e+00 -6.018981695469641e+00 -6.025554783804002e+00 3.635558655327230e+00 4.597814964929199e+00 9.295677307233909e+03 + 173420 1.004062108728824e+00 -5.953600053463845e+00 -6.055777283455601e+00 3.977742863076556e+00 4.391025396588654e+00 9.389066569268389e+03 + 173440 1.003151985130466e+00 -5.928628000133264e+00 -6.056167081024177e+00 4.097540783854696e+00 4.365191644770091e+00 9.390260647780548e+03 + 173460 1.052210238382461e+00 -5.984234005807235e+00 -6.004828848866408e+00 3.743388821908794e+00 4.625130046021358e+00 9.231869410027091e+03 + 173480 9.871523806603745e-01 -5.877989579162440e+00 -6.033214628513395e+00 4.314775876070700e+00 4.423449621698764e+00 9.319235962218390e+03 + 173500 1.031525440889237e+00 -5.937048709049370e+00 -5.996162679946292e+00 4.059574712262241e+00 4.720133143514684e+00 9.205260683628650e+03 + 173520 1.006552588570192e+00 -5.898841603488368e+00 -6.034626629368055e+00 4.191335493886501e+00 4.411636862620495e+00 9.323635224091404e+03 + 173540 1.038771599441801e+00 -5.949209941983998e+00 -5.988878061605327e+00 4.037638616402416e+00 4.809858134915078e+00 9.182896220146396e+03 + 173560 1.061288698208912e+00 -5.985945902691494e+00 -6.016114399520863e+00 3.768115648683763e+00 4.594883471329727e+00 9.266583752364602e+03 + 173580 1.103606726850638e+00 -6.058110321408405e+00 -6.034439221645863e+00 3.356107795104212e+00 4.492030913031579e+00 9.323087448367194e+03 + 173600 9.889032319626195e-01 -5.901157331932627e+00 -6.073112700582467e+00 4.141101452704678e+00 4.153707115909998e+00 9.442863274692640e+03 + 173620 1.053724298458657e+00 -6.011179843180615e+00 -6.022403942206569e+00 3.655945020991484e+00 4.591494507460746e+00 9.285963464590632e+03 + 173640 1.052470906114627e+00 -6.023753451526209e+00 -5.973077801713588e+00 3.597244847251640e+00 4.888232270507174e+00 9.134582364346446e+03 + 173660 9.999558623766148e-01 -5.958130706256950e+00 -5.970517611813904e+00 3.936885342070613e+00 4.865757813495144e+00 9.126757577108681e+03 + 173680 9.741656194470899e-01 -5.929609314306802e+00 -5.963471490823021e+00 4.115023158883413e+00 4.920581301172404e+00 9.105219226846948e+03 + 173700 1.001649616539517e+00 -5.976186939960305e+00 -5.985031663926883e+00 3.816147745517227e+00 4.765359971784532e+00 9.171139630054591e+03 + 173720 9.928822207895293e-01 -5.967897433565623e+00 -6.016209217170697e+00 3.842270758697348e+00 4.564857021012658e+00 9.266860247535784e+03 + 173740 1.000305238398981e+00 -5.984764448073079e+00 -5.981043178806662e+00 3.775660073722656e+00 4.797028177714984e+00 9.158943933196617e+03 + 173760 1.030708470277271e+00 -6.035614638130282e+00 -5.994197637306218e+00 3.481364037871348e+00 4.719186865863287e+00 9.199246769754171e+03 + 173780 1.024563620353439e+00 -6.035096106001772e+00 -5.975507566403075e+00 3.496529323497055e+00 4.838695939169474e+00 9.141988281766386e+03 + 173800 9.577741359538310e-01 -5.943629092969581e+00 -5.979990568174130e+00 3.943286083773390e+00 4.734492866228766e+00 9.155685231236090e+03 + 173820 9.530738206765744e-01 -5.939991473691727e+00 -5.974018787309910e+00 4.000676412601569e+00 4.805286312096201e+00 9.137454207099527e+03 + 173840 9.799106825999193e-01 -5.981760307817236e+00 -6.005063955990226e+00 3.807349945732891e+00 4.673536791695682e+00 9.232600264701590e+03 + 173860 9.883661500418113e-01 -5.995776082610538e+00 -6.024574548531402e+00 3.706975394264605e+00 4.541610146398807e+00 9.292622184133701e+03 + 173880 9.750428267315292e-01 -5.978233142818242e+00 -6.026572478828854e+00 3.792798227115356e+00 4.515226279254351e+00 9.298775776116358e+03 + 173900 1.008640543466448e+00 -6.031628694671824e+00 -5.961455403589120e+00 3.521709321975823e+00 4.924655218654406e+00 9.099091088598856e+03 + 173920 9.847806395747991e-01 -5.999545610604539e+00 -5.999357727614077e+00 3.714825439528858e+00 4.715904292734889e+00 9.215079945701889e+03 + 173940 1.011804177466070e+00 -6.042197219856634e+00 -5.979821766380606e+00 3.513723847601102e+00 4.871893354030680e+00 9.155222915216162e+03 + 173960 9.527390450684928e-01 -5.956866396877421e+00 -5.998209698267011e+00 3.939743157503088e+00 4.702343523068853e+00 9.211540220545190e+03 + 173980 9.611787608566198e-01 -5.969444628549403e+00 -6.014124102973319e+00 3.833460308970261e+00 4.576903852701816e+00 9.260452304897100e+03 + 174000 1.051438175025631e+00 -6.101382917722644e+00 -6.003234890590925e+00 3.125614704336761e+00 4.689195864485206e+00 9.226992653992756e+03 + 174020 1.016491565054876e+00 -6.048832191926746e+00 -5.973604720634263e+00 3.429651843891688e+00 4.861619625466684e+00 9.136208237788278e+03 + 174040 1.000615219460889e+00 -6.022916712535356e+00 -6.018932770809801e+00 3.552661413143449e+00 4.575537823044573e+00 9.275264680312906e+03 + 174060 9.683843814119234e-01 -5.971381302071002e+00 -6.053135284238339e+00 3.846189532850520e+00 4.376745515857817e+00 9.380898409580950e+03 + 174080 9.440087991074108e-01 -5.932881217537550e+00 -6.010467723524440e+00 4.043986458314921e+00 4.598472734465202e+00 9.249210889651768e+03 + 174100 1.010613704460070e+00 -6.025771438071368e+00 -5.987825841603489e+00 3.555497855165043e+00 4.773387342145679e+00 9.179729078363245e+03 + 174120 1.044133563438923e+00 -6.066505358172167e+00 -6.022882286755126e+00 3.347819597293139e+00 4.598310024018271e+00 9.287433117890796e+03 + 174140 9.781586743719261e-01 -5.962621385295517e+00 -6.012283321628204e+00 3.897399002924013e+00 4.612232479341911e+00 9.254789936498002e+03 + 174160 9.746014350685996e-01 -5.951307679885520e+00 -5.996050783033438e+00 4.043306056995272e+00 4.786384234747093e+00 9.204905530435886e+03 + 174180 9.954889584992697e-01 -5.972316759932900e+00 -5.991811845423159e+00 3.871242491866175e+00 4.759298694126375e+00 9.191928984663662e+03 + 174200 1.050772740077655e+00 -6.043639672419418e+00 -6.008547542641598e+00 3.428222748864688e+00 4.629727188538461e+00 9.243315068976488e+03 + 174220 1.023765236847365e+00 -5.992055408819955e+00 -6.044657515823374e+00 3.675631547964270e+00 4.373582109400885e+00 9.354640277300208e+03 + 174240 1.046392339188033e+00 -6.018924473130356e+00 -5.989769492875867e+00 3.586276002306303e+00 4.753688410646192e+00 9.185683497784485e+03 + 174260 1.015108843710412e+00 -5.966860520289887e+00 -5.960978674007062e+00 3.946954180268471e+00 4.980728651837222e+00 9.097635091524840e+03 + 174280 9.791716693996031e-01 -5.908854050837242e+00 -6.011248726672193e+00 4.165476439013407e+00 4.577510364844246e+00 9.251571178905018e+03 + 174300 1.038695613666949e+00 -5.990839533370369e+00 -5.967136105700257e+00 3.800935307660985e+00 4.937044057436346e+00 9.116373765497350e+03 + 174320 9.965467827563848e-01 -5.923973165205544e+00 -5.990357262825743e+00 4.094499312234920e+00 4.713311550793828e+00 9.187446228327795e+03 + 174340 1.004870379091036e+00 -5.931437159618277e+00 -6.030649982531689e+00 4.080061508381705e+00 4.510366126078165e+00 9.311346253472977e+03 + 174360 1.039917780731387e+00 -5.981886101720000e+00 -6.015883526583417e+00 3.729054536575616e+00 4.533836061925374e+00 9.265885258379683e+03 + 174380 9.864902931081017e-01 -5.904987221705570e+00 -5.995007862683268e+00 4.204464325481234e+00 4.687551874338120e+00 9.201712856755988e+03 + 174400 1.036104906486244e+00 -5.983643905546630e+00 -5.990473119218975e+00 3.842928683472250e+00 4.803714281748247e+00 9.187813735658379e+03 + 174420 1.003709915709491e+00 -5.944024347502874e+00 -6.064263319361854e+00 3.949481236278648e+00 4.259050452943626e+00 9.415375589778439e+03 + 174440 1.035179221244382e+00 -6.007218921436386e+00 -5.987037150584401e+00 3.643566192744809e+00 4.759453044095853e+00 9.177292378937995e+03 + 174460 1.032568640147012e+00 -6.025253982723124e+00 -5.959459799333843e+00 3.613638531334762e+00 4.991438913972989e+00 9.093013390533764e+03 + 174480 1.034758135363307e+00 -6.056483161167654e+00 -5.956797817264913e+00 3.367561156090326e+00 4.939969827036978e+00 9.084863152663405e+03 + 174500 9.196981530775679e-01 -5.911737234803506e+00 -6.005054952600645e+00 4.143747774606792e+00 4.607902998145462e+00 9.232559543681442e+03 + 174520 9.186762584221807e-01 -5.934538794441067e+00 -6.017212927833728e+00 3.983370363519943e+00 4.508642695798492e+00 9.269946957236350e+03 + 174540 1.054070701226391e+00 -6.159082686582558e+00 -5.948702974845154e+00 2.846051611761915e+00 5.054084472713264e+00 9.060248691763456e+03 + 174560 9.653389608377355e-01 -6.047864038211833e+00 -5.998909702758517e+00 3.383337965918037e+00 4.664441335749903e+00 9.213709426951667e+03 + 174580 9.609617113016398e-01 -6.060096881273115e+00 -5.999233143679163e+00 3.371268706760870e+00 4.720757706658293e+00 9.214699745737607e+03 + 174600 9.640280626724278e-01 -6.079687569308292e+00 -5.965564758009998e+00 3.305317521218256e+00 4.960628364141036e+00 9.111628775419680e+03 + 174620 8.648201632019097e-01 -5.942520591153901e+00 -6.015367135856446e+00 3.958944951082072e+00 4.540648818433698e+00 9.264260838278611e+03 + 174640 9.966821325964648e-01 -6.141581028176240e+00 -5.940414868496555e+00 2.915045098074807e+00 5.070172317318164e+00 9.035034622079773e+03 + 174660 9.375379632826779e-01 -6.050012130192616e+00 -5.959288314281568e+00 3.437096688120009e+00 4.958046878546384e+00 9.092442633435885e+03 + 174680 9.402071521268851e-01 -6.039928341001955e+00 -5.963789853082072e+00 3.458500257663897e+00 4.895699237692793e+00 9.106223561114526e+03 + 174700 9.848713248346646e-01 -6.080797328449105e+00 -5.963189804564539e+00 3.278305398508512e+00 4.953626000359188e+00 9.104389550779115e+03 + 174720 9.134862840435471e-01 -5.938020371764987e+00 -6.018670984795548e+00 4.038019027102622e+00 4.574910726439102e+00 9.274437411386276e+03 + 174740 9.918059173549123e-01 -6.003528785476028e+00 -6.027559199170959e+00 3.633407768602843e+00 4.495421414472050e+00 9.301853169693930e+03 + 174760 1.046236361776978e+00 -6.033584970788386e+00 -6.002572232957873e+00 3.505975897682127e+00 4.684055837510599e+00 9.224929913832821e+03 + 174780 1.026536954946409e+00 -5.964337774800743e+00 -5.996648400491042e+00 3.882036033494087e+00 4.696503420727224e+00 9.206735205194431e+03 + 174800 1.084339524756345e+00 -6.022329183800460e+00 -5.946243816464033e+00 3.627730291026798e+00 5.064624244445101e+00 9.052741459188614e+03 + 174820 9.705829365599744e-01 -5.835133533409908e+00 -6.002905084077506e+00 4.579543052273783e+00 4.616172845776875e+00 9.225917121868259e+03 + 174840 1.003618385241124e+00 -5.872887151328572e+00 -6.020347355932135e+00 4.347036130216428e+00 4.500296815989860e+00 9.279596161391304e+03 + 174860 1.124632892657651e+00 -6.047845871847927e+00 -6.001254562064416e+00 3.437623482441562e+00 4.705157993200368e+00 9.220912164663565e+03 + 174880 1.122434057187399e+00 -6.049354473347607e+00 -5.975891564693987e+00 3.409980578362641e+00 4.831815968200102e+00 9.143204342338193e+03 + 174900 9.801290169801421e-01 -5.849277232551999e+00 -6.029348891493987e+00 4.514139284328269e+00 4.480139952684211e+00 9.307344192485067e+03 + 174920 1.032719377264109e+00 -5.940230774000820e+00 -5.989712455552693e+00 4.063940079187157e+00 4.779808606450834e+00 9.185480392842705e+03 + 174940 1.036620814058223e+00 -5.961077583644971e+00 -6.021414603589954e+00 3.917361549819090e+00 4.570897044171337e+00 9.282897857713866e+03 + 174960 1.046173343168461e+00 -5.994651099924696e+00 -5.977765948548530e+00 3.788646984347273e+00 4.885604136517953e+00 9.148905303487192e+03 + 174980 1.066887151945785e+00 -6.046693930554738e+00 -5.976806756855856e+00 3.464881400249225e+00 4.866184366633382e+00 9.145973718675545e+03 + 175000 1.000710526864937e+00 -5.970307709516566e+00 -5.989446526025936e+00 3.894959334436430e+00 4.785061288317347e+00 9.184671606008205e+03 + 175020 9.775454083726365e-01 -5.958385814941584e+00 -6.004343035156874e+00 3.884475759038880e+00 4.620582288705840e+00 9.230388023585576e+03 + 175040 9.830730462118193e-01 -5.987286225679458e+00 -5.975990249816544e+00 3.774741637620947e+00 4.839604879072418e+00 9.143480689260336e+03 + 175060 9.770876779713118e-01 -5.995262846676658e+00 -5.974285484680803e+00 3.667110575280606e+00 4.787565834097081e+00 9.138280230687616e+03 + 175080 1.008433059375599e+00 -6.054041858716727e+00 -5.984187716979234e+00 3.431176829447673e+00 4.832290121197854e+00 9.168557627911840e+03 + 175100 1.012544572260639e+00 -6.070806627686350e+00 -5.960550001377166e+00 3.387002748465409e+00 5.020113358890521e+00 9.096328707431903e+03 + 175120 9.457104303326398e-01 -5.981896725781137e+00 -5.990034511386096e+00 3.812743803782181e+00 4.766015379520256e+00 9.186455998206689e+03 + 175140 9.901723248783303e-01 -6.053372113003624e+00 -5.970401680727641e+00 3.427390519694038e+00 4.903819581455630e+00 9.126376517540111e+03 + 175160 9.105977381562370e-01 -5.937229540437806e+00 -6.041491990471892e+00 3.989999477549876e+00 4.391308354892160e+00 9.344828725476253e+03 + 175180 9.346449595561432e-01 -5.970543129578758e+00 -6.012433855370110e+00 3.884182477457053e+00 4.643639447394243e+00 9.255234843052860e+03 + 175200 9.619354393067603e-01 -6.003731864892144e+00 -6.015603559588437e+00 3.629736310019110e+00 4.561567201934178e+00 9.265004999719466e+03 + 175220 1.031730129615966e+00 -6.092073548663091e+00 -5.981688868927734e+00 3.247071611270102e+00 4.880917524284503e+00 9.160918358558509e+03 + 175240 9.457385376413708e-01 -5.937483004834699e+00 -6.034841563558111e+00 4.013534442346124e+00 4.454486531968022e+00 9.324314622484324e+03 + 175260 1.012972497910468e+00 -5.994558380105588e+00 -6.009786930500825e+00 3.711645215171383e+00 4.624200522191371e+00 9.247131831875433e+03 + 175280 1.003584735572427e+00 -5.921112349079406e+00 -6.081134247764435e+00 4.062600621226110e+00 4.143730115667882e+00 9.467781070915198e+03 + 175300 1.001031001508667e+00 -5.861733416348391e+00 -6.031672343984603e+00 4.454540800532521e+00 4.478725180081338e+00 9.314496723622646e+03 + 175320 1.056642167777405e+00 -5.899986891600236e+00 -6.004215103270684e+00 4.216724305335988e+00 4.618229784660646e+00 9.229971515848923e+03 + 175340 1.091861734789924e+00 -5.923828467016058e+00 -5.975814622623737e+00 4.119329665720839e+00 4.820817115389967e+00 9.142915281666857e+03 + 175360 1.066226409453938e+00 -5.869065064436087e+00 -5.978308551463122e+00 4.443489954410609e+00 4.816196946526393e+00 9.150515809697854e+03 + 175380 1.144911718039423e+00 -5.979671441717842e+00 -6.026195100798812e+00 3.804716255831831e+00 4.537570205875923e+00 9.297610076281011e+03 + 175400 1.033354659246867e+00 -5.822725272432550e+00 -6.042786533036471e+00 4.656808118801401e+00 4.393182306043671e+00 9.348839203743337e+03 + 175420 1.109544362252024e+00 -5.951296098484495e+00 -6.033321436471180e+00 3.910276971212790e+00 4.439274787113215e+00 9.319617883291057e+03 + 175440 1.062850555364077e+00 -5.907162775872243e+00 -6.041347555090574e+00 4.157358564480340e+00 4.386848797181212e+00 9.344415303713013e+03 + 175460 1.075002272985246e+00 -5.960393817222204e+00 -6.009637022726769e+00 3.934101823188168e+00 4.651339716819525e+00 9.246629526333079e+03 + 175480 1.021938543006268e+00 -5.921093195689862e+00 -5.988745078032901e+00 4.062814465657575e+00 4.674346888148887e+00 9.182513953795018e+03 + 175500 9.987453139703080e-01 -5.922379602060656e+00 -5.986081945471948e+00 4.125142750548127e+00 4.759354036774703e+00 9.174330922403329e+03 + 175520 1.020453678554516e+00 -5.983061328708857e+00 -5.968122554244326e+00 3.841198042199659e+00 4.926978796942874e+00 9.119425134199761e+03 + 175540 1.025513757223260e+00 -6.015797202584976e+00 -5.997697370047124e+00 3.591707465398155e+00 4.695639504770533e+00 9.209997574847857e+03 + 175560 1.018133941626763e+00 -6.024306924599324e+00 -6.029329235264163e+00 3.546374429573762e+00 4.517535544536194e+00 9.307318223390999e+03 + 175580 9.586621654685762e-01 -5.954183021503569e+00 -6.031661103540634e+00 3.963072989877570e+00 4.518181853126295e+00 9.314496373553340e+03 + 175600 9.800920068637435e-01 -6.001319793732035e+00 -6.026396171640499e+00 3.697645212429957e+00 4.553652769922615e+00 9.298260736428507e+03 + 175620 1.029637790698154e+00 -6.086308613894776e+00 -6.009066787202578e+00 3.228830682581238e+00 4.672365204581885e+00 9.244896601364308e+03 + 175640 9.460856754323483e-01 -5.971146168053560e+00 -6.007965581383676e+00 3.872803776223288e+00 4.661381007095963e+00 9.241513036849856e+03 + 175660 9.997255227824924e-01 -6.057172672975602e+00 -6.006545521433639e+00 3.377394644511017e+00 4.668103583191350e+00 9.237155894386980e+03 + 175680 8.881222878087094e-01 -5.896644933169255e+00 -6.010190353652395e+00 4.243896774127259e+00 4.591901398616035e+00 9.248368530499807e+03 + 175700 1.016139285236189e+00 -6.086475322073271e+00 -5.967858223507587e+00 3.224705360119309e+00 4.905823096020146e+00 9.118645974995596e+03 + 175720 9.943715633449440e-01 -6.050491674057533e+00 -5.990869989750486e+00 3.414166946570640e+00 4.756523884287532e+00 9.189028426020182e+03 + 175740 9.480831658741777e-01 -5.977383845204230e+00 -6.003339017836144e+00 3.793076244676183e+00 4.644037626873747e+00 9.227294540942050e+03 + 175760 9.970700890635151e-01 -6.041754131880070e+00 -5.981340974978751e+00 3.510561003255094e+00 4.857462699088286e+00 9.159857290699631e+03 + 175780 9.790998228482189e-01 -6.001181957410349e+00 -6.019864608270336e+00 3.686404009208094e+00 4.579125336839176e+00 9.278136806449240e+03 + 175800 9.677190489862882e-01 -5.965389307404235e+00 -5.990184518348505e+00 3.878820303891608e+00 4.736442365603116e+00 9.186949330478750e+03 + 175820 1.044705951696796e+00 -6.053403556383961e+00 -5.979683117312389e+00 3.484712117504333e+00 4.908026286854376e+00 9.154781708963681e+03 + 175840 1.046097542900421e+00 -6.018640834513687e+00 -5.966626313496580e+00 3.604308665550589e+00 4.902984094451928e+00 9.114878091651126e+03 + 175860 1.000242432396510e+00 -5.906264228308455e+00 -6.010406804582970e+00 4.181953776284132e+00 4.583950987304275e+00 9.249000359784266e+03 + 175880 1.054316828390019e+00 -5.936402992096022e+00 -6.015761754548665e+00 4.028854131628155e+00 4.573163836896279e+00 9.265473418437932e+03 + 175900 1.088605765230973e+00 -5.943114097928319e+00 -6.004792210642015e+00 4.019314978523613e+00 4.665149710664475e+00 9.231758686099753e+03 + 175920 1.086609816987527e+00 -5.907812103631249e+00 -6.026342603817763e+00 4.114872996985561e+00 4.434252522378981e+00 9.298090660710135e+03 + 175940 1.074783091139512e+00 -5.874169416303852e+00 -6.021550897748083e+00 4.356994936820788e+00 4.510707663157466e+00 9.283305550768608e+03 + 175960 1.092242401119250e+00 -5.895716158204312e+00 -6.101785680884506e+00 4.158701970801515e+00 3.975418882416272e+00 9.532056761467878e+03 + 175980 1.116263327577770e+00 -5.940814747651736e+00 -6.015184684509078e+00 3.996220318235415e+00 4.569176632090020e+00 9.263730319385841e+03 + 176000 1.109632120473638e+00 -5.950042204112828e+00 -6.004534405858630e+00 3.992186064095210e+00 4.679283409029845e+00 9.230964814967951e+03 + 176020 1.078421036665945e+00 -5.929606917918194e+00 -6.023226265874472e+00 3.995224357861306e+00 4.457647574349087e+00 9.288475337227044e+03 + 176040 1.089183685495825e+00 -5.972300284285479e+00 -6.038626412495281e+00 3.843434743682260e+00 4.462579851566411e+00 9.335989096482193e+03 + 176060 1.028621714309083e+00 -5.911061017809054e+00 -6.025826702272282e+00 4.126329997226906e+00 4.467327677106783e+00 9.296512425232298e+03 + 176080 1.032484923622059e+00 -5.941999586291912e+00 -6.030737965588086e+00 3.967788058282404e+00 4.458238552143957e+00 9.311634476454554e+03 + 176100 1.000346346053875e+00 -5.917385736397415e+00 -6.022379067836454e+00 4.141023870018723e+00 4.538135913230236e+00 9.285877076878300e+03 + 176120 9.907863038399976e-01 -5.920858200637586e+00 -6.027186737683641e+00 4.108262621518233e+00 4.497707707511856e+00 9.300703326128982e+03 + 176140 1.030127425217976e+00 -5.995320820277602e+00 -6.010240704737175e+00 3.762558043271528e+00 4.676885757860003e+00 9.248530117809683e+03 + 176160 1.001469631235880e+00 -5.968358162170704e+00 -6.020893456238717e+00 3.867311525270922e+00 4.565645736921910e+00 9.281298381999868e+03 + 176180 9.861023187916214e-01 -5.959891103579418e+00 -6.007170983730911e+00 3.901818371226619e+00 4.630329982858936e+00 9.239073630909852e+03 + 176200 9.676868595179293e-01 -5.944009392864858e+00 -6.022903273239253e+00 3.974225570758102e+00 4.521204700859796e+00 9.287485077511168e+03 + 176220 9.961086074878160e-01 -5.997022086628611e+00 -6.032849961525577e+00 3.688708529109916e+00 4.482979327105816e+00 9.318184406272921e+03 + 176240 1.003521119184531e+00 -6.020374307953215e+00 -6.035752397114171e+00 3.543669494974224e+00 4.455366127260410e+00 9.327135617608368e+03 + 176260 1.049445826905085e+00 -6.100331440871149e+00 -6.001687709666906e+00 3.178646439268678e+00 4.745074008911510e+00 9.222247831171415e+03 + 176280 9.304152442435101e-01 -5.936853336784266e+00 -6.035222111993854e+00 4.022335427589333e+00 4.457486697817111e+00 9.325502537390321e+03 + 176300 9.919521147608475e-01 -6.039292925507530e+00 -5.980012731203749e+00 3.490974673891608e+00 4.831370723164338e+00 9.155804749826439e+03 + 176320 9.889326945046298e-01 -6.042719643211468e+00 -5.990087657258148e+00 3.495091046344956e+00 4.797312054462420e+00 9.186650645564809e+03 + 176340 1.012797120684468e+00 -6.085172225638020e+00 -5.986788016657047e+00 3.270011846732740e+00 4.834949199608625e+00 9.176522149947785e+03 + 176360 9.339033703110842e-01 -5.972993437124924e+00 -6.032256277936183e+00 3.837640000092903e+00 4.497343597259674e+00 9.316325549267805e+03 + 176380 9.846652605715701e-01 -6.054059306436207e+00 -5.958659787445218e+00 3.448735536685144e+00 4.996534337759251e+00 9.090578849482810e+03 + 176400 9.898238632856670e-01 -6.063255214420408e+00 -5.987903837003699e+00 3.350592743061065e+00 4.783272012775784e+00 9.179952107726216e+03 + 176420 9.752420409159185e-01 -6.038513925687624e+00 -6.002139437781365e+00 3.495712837578977e+00 4.704580776070534e+00 9.223617258692728e+03 + 176440 9.623368452274625e-01 -6.012076370197827e+00 -5.993416249482086e+00 3.637705549017666e+00 4.744854849811802e+00 9.196845794188621e+03 + 176460 9.829739726867087e-01 -6.029124383339026e+00 -5.970076906039211e+00 3.548897139321295e+00 4.887956891544410e+00 9.125415844777861e+03 + 176480 9.434184563697375e-01 -5.948326693832302e+00 -6.003672148520301e+00 4.000118877203260e+00 4.682316711703336e+00 9.228324025556083e+03 + 176500 1.020903602935919e+00 -6.030570855847295e+00 -6.012838222869147e+00 3.531277554939288e+00 4.633101077615895e+00 9.256492617676869e+03 + 176520 1.041157740788483e+00 -6.024462006861803e+00 -6.000023802202747e+00 3.518125088874237e+00 4.658453041826485e+00 9.217121919067016e+03 + 176540 9.885446321914746e-01 -5.912488136321778e+00 -5.998059024564729e+00 4.176267031684067e+00 4.684905749340886e+00 9.211056058985025e+03 + 176560 1.019211598928082e+00 -5.923168346125426e+00 -5.975467176051110e+00 4.094090942725782e+00 4.793782968074728e+00 9.141861813032156e+03 + 176580 1.046262050848526e+00 -5.932111273781900e+00 -5.998576865808968e+00 4.054873943383560e+00 4.673218228447018e+00 9.212660283321111e+03 + 176600 1.094198817674762e+00 -5.980592932138750e+00 -5.982265230489157e+00 3.789368601939811e+00 4.779766006024443e+00 9.162681433676655e+03 + 176620 1.144036926844769e+00 -6.039499449329122e+00 -6.041077094657560e+00 3.448166253911479e+00 4.439107170295763e+00 9.343582179703148e+03 + 176640 1.015826449234961e+00 -5.845995524822099e+00 -6.080071605721557e+00 4.539104969559908e+00 4.195003889878768e+00 9.464485260019594e+03 + 176660 1.068903655369921e+00 -5.933398317612209e+00 -6.026524129849493e+00 4.064913612758023e+00 4.530170787718666e+00 9.298655357001109e+03 + 176680 1.042335464583136e+00 -5.909138833097207e+00 -6.008001050059379e+00 4.213451726743071e+00 4.645769578067648e+00 9.241585458936632e+03 + 176700 1.054838247228415e+00 -5.947566625699009e+00 -6.015614469966804e+00 3.956035996362650e+00 4.565294744207099e+00 9.265039340065476e+03 + 176720 1.010585820093854e+00 -5.909291001078947e+00 -6.036197143903490e+00 4.223009109780649e+00 4.494294399019990e+00 9.328496685001453e+03 + 176740 1.024935890387010e+00 -5.964553993998748e+00 -6.046978085499459e+00 3.812202251898193e+00 4.338910363414167e+00 9.361844099192565e+03 + 176760 1.032955855329152e+00 -6.013630558067927e+00 -5.992743868922451e+00 3.664167446867828e+00 4.784102048145847e+00 9.194793731877868e+03 + 176780 1.015702155291322e+00 -6.023582254176080e+00 -5.988060437293352e+00 3.568790454196646e+00 4.772762223720670e+00 9.180450950871207e+03 + 176800 9.587992457634591e-01 -5.967923337852767e+00 -6.050356877200164e+00 3.831061966600240e+00 4.357715827118497e+00 9.372267789593247e+03 + 176820 9.057334169722548e-01 -5.911152453380048e+00 -6.021327960792380e+00 4.113804789551304e+00 4.481159976385020e+00 9.282619203786388e+03 + 176840 9.253725696381762e-01 -5.951228405233462e+00 -5.975896332577704e+00 3.954259784589748e+00 4.812612728429695e+00 9.143198735919039e+03 + 176860 9.958595942756007e-01 -6.060661339434910e+00 -5.979854510759387e+00 3.398385578652649e+00 4.862390893723823e+00 9.155314261816042e+03 + 176880 9.951409545049615e-01 -6.060962384969407e+00 -5.979132465929501e+00 3.387431193729884e+00 4.857311251996065e+00 9.153094063287826e+03 + 176900 9.604499276401842e-01 -6.009151490382777e+00 -5.984545398335742e+00 3.641704250916129e+00 4.782996239230640e+00 9.169648239551898e+03 + 176920 9.932908889533425e-01 -6.053472347547421e+00 -5.954090715217832e+00 3.402284798574061e+00 4.972949510668457e+00 9.076655038186400e+03 + 176940 1.003959483201050e+00 -6.060411794872726e+00 -5.996195360801592e+00 3.369629164576939e+00 4.738369866474446e+00 9.205374443881312e+03 + 176960 8.879174592637858e-01 -5.880378407857701e+00 -6.018077533846760e+00 4.366143355231262e+00 4.575453664931200e+00 9.272602072860253e+03 + 176980 9.569869173001665e-01 -5.972653037483554e+00 -5.948757935673378e+00 3.864029074762670e+00 5.001238447111757e+00 9.060410588216237e+03 + 177000 1.025009921400114e+00 -6.058869601562160e+00 -5.971779043241307e+00 3.417710025648805e+00 4.917797488747487e+00 9.130595134542145e+03 + 177020 9.770813333579562e-01 -5.972324209956359e+00 -5.998364475588362e+00 3.852326693956853e+00 4.702799458979809e+00 9.212005759796386e+03 + 177040 1.033041421879915e+00 -6.038905980303069e+00 -5.999000514180917e+00 3.473329607938361e+00 4.702472969762679e+00 9.213959620118105e+03 + 177060 9.358887080073058e-01 -5.879440202138515e+00 -6.016089211764699e+00 4.293435743110912e+00 4.508775983471466e+00 9.266486696279606e+03 + 177080 1.022610411925349e+00 -5.990866024105470e+00 -5.959726207114985e+00 3.732076395855455e+00 4.910886043885927e+00 9.093832555554698e+03 + 177100 1.018316063280657e+00 -5.968168347240160e+00 -6.020305346999251e+00 3.885013064574077e+00 4.585634343782734e+00 9.279479099246808e+03 + 177120 1.060334019644992e+00 -6.017921702327977e+00 -6.016307792011372e+00 3.591169070464986e+00 4.600436393254742e+00 9.267178831706275e+03 + 177140 1.054710743130254e+00 -6.001142282717915e+00 -5.965714095548419e+00 3.685721270697461e+00 4.889155403918955e+00 9.112080287406094e+03 + 177160 9.902798929068691e-01 -5.895154121377912e+00 -5.979802282916824e+00 4.247611118536998e+00 4.761548275719900e+00 9.155132633282670e+03 + 177180 1.046634933802410e+00 -5.964525053478533e+00 -6.027610807971170e+00 3.960939507633245e+00 4.598691342847565e+00 9.301978974383754e+03 + 177200 1.090327003457063e+00 -6.016843589101904e+00 -5.952534782686925e+00 3.656960370487808e+00 5.026231488678246e+00 9.071910343298921e+03 + 177220 1.084027245568444e+00 -5.994815749818553e+00 -5.953292807972153e+00 3.805708285148143e+00 5.044139442884658e+00 9.074188515101399e+03 + 177240 1.103031039301715e+00 -6.010048904830867e+00 -5.937531330529599e+00 3.656319475013450e+00 5.072726608709687e+00 9.026256216822110e+03 + 177260 9.881482659632953e-01 -5.825115442706624e+00 -5.967880875616761e+00 4.628722179143905e+00 4.808940970494555e+00 9.118680963545545e+03 + 177280 1.016450235729778e+00 -5.852312487233776e+00 -5.976867513190966e+00 4.379287234597777e+00 4.664073000723621e+00 9.146167039301348e+03 + 177300 1.080457456213344e+00 -5.930038048700706e+00 -6.021269063125199e+00 4.066440519930861e+00 4.542577917151563e+00 9.282432909878635e+03 + 177320 1.032146904119835e+00 -5.847702839189421e+00 -6.059461591587430e+00 4.508238525452911e+00 4.292286999622518e+00 9.400481958068412e+03 + 177340 1.022983394585840e+00 -5.835168440933270e+00 -6.036955747083208e+00 4.609936268180052e+00 4.451242329782398e+00 9.330828331742805e+03 + 177360 1.061481071179172e+00 -5.902012186680889e+00 -6.046083182413493e+00 4.222838701523507e+00 4.395560749112365e+00 9.359051361055010e+03 + 177380 1.078061668237210e+00 -5.945693215916322e+00 -6.051708281002705e+00 3.963592467604568e+00 4.354837558100249e+00 9.376441564235211e+03 + 177400 1.053302126279887e+00 -5.939355203345316e+00 -6.048328443610584e+00 3.990667566743017e+00 4.364926357585411e+00 9.366010571919971e+03 + 177420 1.038594496708761e+00 -5.956840189659104e+00 -6.006354053055609e+00 3.938017671683525e+00 4.653701405815197e+00 9.236561302523593e+03 + 177440 1.057505893323009e+00 -6.025660750493481e+00 -5.980326373660249e+00 3.585032790757059e+00 4.845349798005616e+00 9.156744067816739e+03 + 177460 9.798993824035245e-01 -5.948052592141694e+00 -6.019007701042168e+00 3.969040104618309e+00 4.561604889044177e+00 9.275493316331642e+03 + 177480 1.007900865813226e+00 -6.020866779681768e+00 -6.002652765595409e+00 3.623550694843643e+00 4.728138382337091e+00 9.225205416851000e+03 + 177500 9.827410028235338e-01 -6.011552832826689e+00 -5.990913395954755e+00 3.646367325042319e+00 4.764882165503501e+00 9.189170144136448e+03 + 177520 9.745882306055479e-01 -6.020663894292174e+00 -5.968532377183299e+00 3.581281620159346e+00 4.880628858724706e+00 9.120667928880510e+03 + 177540 9.617101252266793e-01 -6.015401286785862e+00 -5.963016447525351e+00 3.646522457772365e+00 4.947324311333899e+00 9.103854653632645e+03 + 177560 9.875521959621576e-01 -6.060754785144141e+00 -6.009534739115063e+00 3.365353186925578e+00 4.659466617501054e+00 9.246342174373014e+03 + 177580 9.585731607667553e-01 -6.022231416145212e+00 -6.033618684370011e+00 3.605405451644674e+00 4.540017995323816e+00 9.320552204449381e+03 + 177600 9.882730993536900e-01 -6.070486759216120e+00 -6.003981598929437e+00 3.336267997116926e+00 4.718150919123354e+00 9.229301735724761e+03 + 177620 9.495987695028141e-01 -6.014530968173483e+00 -6.004223250417935e+00 3.702739830560975e+00 4.761928341027501e+00 9.230002749515586e+03 + 177640 1.019682660515718e+00 -6.114165521585603e+00 -5.979122165174360e+00 3.115754050745100e+00 4.891193901150324e+00 9.153080738540582e+03 + 177660 9.130751625668337e-01 -5.947369198254375e+00 -6.049527200572304e+00 3.987106863032013e+00 4.400499804822696e+00 9.369716425601639e+03 + 177680 1.010432072999256e+00 -6.080670459888448e+00 -5.992256167333132e+00 3.265163968135851e+00 4.772852518056032e+00 9.193290909892527e+03 + 177700 9.690236044088988e-01 -6.002950836043820e+00 -6.015287614585615e+00 3.648979430566451e+00 4.578139739069158e+00 9.264033589939781e+03 + 177720 9.862075045301948e-01 -6.008358717766985e+00 -5.954820700285494e+00 3.729559108552533e+00 5.036982689912681e+00 9.078815612412331e+03 + 177740 9.792000461456802e-01 -5.968763978649007e+00 -5.952058907481518e+00 3.841710418891771e+00 4.937633522636903e+00 9.070423244955695e+03 + 177760 1.020061046420733e+00 -5.988931226244473e+00 -5.969067553318995e+00 3.752942403269245e+00 4.867002687100790e+00 9.122312864469493e+03 + 177780 1.013311688687711e+00 -5.931657799006251e+00 -5.994612189606086e+00 4.048896008644920e+00 4.687402155660204e+00 9.200511696261054e+03 + 177800 1.013301033402241e+00 -5.889609282854146e+00 -6.021042068806055e+00 4.320203219902625e+00 4.565495823808870e+00 9.281761131401325e+03 + 177820 1.106136498388638e+00 -5.997910789973972e+00 -6.011933961278374e+00 3.723701137241830e+00 4.643177917533206e+00 9.253717584491502e+03 + 177840 1.056492996152001e+00 -5.906204467294977e+00 -6.012284225770157e+00 4.153139846505487e+00 4.544013457551432e+00 9.254787524293697e+03 + 177860 1.035313283682176e+00 -5.867726694668173e+00 -5.959240961702406e+00 4.414596928065888e+00 4.889107844968268e+00 9.092327472356461e+03 + 177880 1.050119961312785e+00 -5.885394818547150e+00 -5.988633025832117e+00 4.357475770672719e+00 4.764666008381490e+00 9.182171941056080e+03 + 177900 1.113317530100131e+00 -5.982303536242167e+00 -5.990825655052387e+00 3.749697563530506e+00 4.700762238528605e+00 9.188901536926813e+03 + 177920 1.131103180235899e+00 -6.021336895453932e+00 -6.032318709090001e+00 3.589199165750570e+00 4.526139892422092e+00 9.316531014804159e+03 + 177940 1.039296219489151e+00 -5.907997350392710e+00 -6.040929046484202e+00 4.250964467968370e+00 4.487650097897543e+00 9.343090536807427e+03 + 177960 1.016752457239048e+00 -5.895266113901704e+00 -5.978103470687304e+00 4.278011214006379e+00 4.802346292303927e+00 9.149917493664763e+03 + 177980 1.076325480205031e+00 -6.002470930504447e+00 -6.010928617646244e+00 3.645485435017899e+00 4.596920086626849e+00 9.250648565883175e+03 + 178000 1.049912998115743e+00 -5.985146315398543e+00 -6.012210272729718e+00 3.807455115033521e+00 4.652049683904059e+00 9.254547597775098e+03 + 178020 1.020664112264212e+00 -5.962819665328294e+00 -5.965913946075620e+00 3.889065540257290e+00 4.871297701367750e+00 9.112701885328697e+03 + 178040 9.866252508687497e-01 -5.927940405766451e+00 -6.005816059847609e+00 4.094029983257268e+00 4.646855926304739e+00 9.234892066796041e+03 + 178060 1.017538023763460e+00 -5.986518078459097e+00 -6.020304484519027e+00 3.780401967783485e+00 4.586395195757927e+00 9.279486181846476e+03 + 178080 9.914996228478319e-01 -5.960699413383012e+00 -6.002160369826623e+00 3.918929311807851e+00 4.680854083846361e+00 9.223671973404065e+03 + 178100 1.023077510959729e+00 -6.018079559694416e+00 -5.990833849176520e+00 3.598830438147247e+00 4.755279524201089e+00 9.188912235268097e+03 + 178120 9.739313324187965e-01 -5.954455430513685e+00 -5.983525386285719e+00 3.941006994707139e+00 4.774082810103003e+00 9.166545825636676e+03 + 178140 1.039030751253139e+00 -6.057993247153625e+00 -5.967173197065491e+00 3.437639895496197e+00 4.959142677459594e+00 9.116560619394751e+03 + 178160 1.024271712008636e+00 -6.044007664614893e+00 -5.984727746972809e+00 3.429545770471989e+00 4.769940231110443e+00 9.170228152779446e+03 + 178180 1.038225068698104e+00 -6.072393376001667e+00 -5.957680663106505e+00 3.307112454238144e+00 4.965810603417115e+00 9.087579896938811e+03 + 178200 9.876023595098380e-01 -6.003155146069703e+00 -5.989286176991743e+00 3.701745143414262e+00 4.781382910075942e+00 9.184171768824084e+03 + 178220 1.025309394593949e+00 -6.062053287081526e+00 -5.972066170026809e+00 3.343456549566668e+00 4.860176501156219e+00 9.131496360839108e+03 + 178240 1.008415938885669e+00 -6.038491462437518e+00 -5.972393454322969e+00 3.505633754208940e+00 4.885178745436377e+00 9.132482764760189e+03 + 178260 9.810733857967525e-01 -5.997250640816810e+00 -6.007794333024505e+00 3.709508440633500e+00 4.648964928345817e+00 9.240991140741015e+03 + 178280 1.029430127637681e+00 -6.068294424510865e+00 -5.988540619196494e+00 3.299921547416364e+00 4.757880239392975e+00 9.181922499519484e+03 + 178300 9.795956104556666e-01 -5.992222493516088e+00 -6.005270538060213e+00 3.741055067736794e+00 4.666131176786061e+00 9.233228164287322e+03 + 178320 9.761041251076085e-01 -5.984890928112428e+00 -5.996650369351490e+00 3.766182588390559e+00 4.698658057028218e+00 9.206743637201160e+03 + 178340 1.007560883082137e+00 -6.026189148128525e+00 -5.986284192401719e+00 3.534246507370133e+00 4.763386938425393e+00 9.174986631651833e+03 + 178360 9.661643222374150e-01 -5.951196534330817e+00 -6.073781202962037e+00 3.867189625840211e+00 4.163289488643582e+00 9.444937990699609e+03 + 178380 1.036588790853904e+00 -6.038682155347941e+00 -6.030591728293103e+00 3.481939657473787e+00 4.528396141612204e+00 9.311204075383161e+03 + 178400 9.811053256602159e-01 -5.936825954768733e+00 -6.006574457379378e+00 4.053703798018720e+00 4.653197102482499e+00 9.237241349341162e+03 + 178420 1.014230630914596e+00 -5.963308186994956e+00 -5.976489479690434e+00 3.923031739294143e+00 4.847342716838255e+00 9.145013825967719e+03 + 178440 1.014891518514339e+00 -5.938243148997521e+00 -6.045235037090563e+00 4.039909979610042e+00 4.425546001238620e+00 9.356402450227621e+03 + 178460 1.025205128362773e+00 -5.930727592861884e+00 -5.999553240217312e+00 4.091827949924691e+00 4.696620432075316e+00 9.215653733060099e+03 + 178480 1.031304785829340e+00 -5.919381296402983e+00 -5.938413326626785e+00 4.127019982066699e+00 5.017735119324477e+00 9.028927111561710e+03 + 178500 1.002026526561253e+00 -5.854412742000912e+00 -5.964723374542423e+00 4.524903996272007e+00 4.891483273703437e+00 9.109020815274826e+03 + 178520 1.051121192789698e+00 -5.907075578058452e+00 -6.031214054178282e+00 4.158710488521642e+00 4.445888148274483e+00 9.313075315239599e+03 + 178540 1.033296495232992e+00 -5.867595673519162e+00 -6.021215763569765e+00 4.393659483725644e+00 4.511549154022981e+00 9.282274525149747e+03 + 178560 1.053584616793111e+00 -5.893024602178700e+00 -6.065211011266779e+00 4.232776329563904e+00 4.244055322819461e+00 9.418279501916308e+03 + 178580 1.120250113067785e+00 -5.998180702951038e+00 -5.988690801858783e+00 3.687073950663053e+00 4.741566431292232e+00 9.182354724242168e+03 + 178600 1.009390129991587e+00 -5.848038822714061e+00 -6.031044570371574e+00 4.513521076829045e+00 4.462673753731688e+00 9.312571196669442e+03 + 178620 1.018901890639166e+00 -5.885124155639941e+00 -5.989451538270686e+00 4.333224568703253e+00 4.734160593027233e+00 9.184668290300149e+03 + 178640 1.061454289004453e+00 -5.977464918813215e+00 -5.988253776177325e+00 3.769888303502095e+00 4.707937014947094e+00 9.181017685620633e+03 + 178660 9.963541925685615e-01 -5.914436344333303e+00 -6.021457466300760e+00 4.139996450521616e+00 4.525464606719383e+00 9.283029996831667e+03 + 178680 1.085717262167000e+00 -6.088901634842970e+00 -5.998204532105190e+00 3.228613063664555e+00 4.749409862916175e+00 9.211559129958203e+03 + 178700 9.790254375194649e-01 -5.975114500142242e+00 -6.008262610980734e+00 3.809056280535124e+00 4.618714698446929e+00 9.242448539905065e+03 + 178720 9.682338145768683e-01 -5.992616889360279e+00 -6.006162222551238e+00 3.691598859522338e+00 4.613819460206313e+00 9.235974691955236e+03 + 178740 9.666742776875273e-01 -6.012858823233547e+00 -5.977324017044870e+00 3.655844523785202e+00 4.859890879914071e+00 9.147586832780678e+03 + 178760 9.627152974033564e-01 -6.022546907993776e+00 -6.003023094192944e+00 3.608810220138910e+00 4.720918980283709e+00 9.226328965985926e+03 + 178780 9.655701205818503e-01 -6.034855459368957e+00 -5.994283150866871e+00 3.514038553717074e+00 4.747011027680502e+00 9.199501238284882e+03 + 178800 9.416645786675479e-01 -6.002637842850691e+00 -5.994889434521459e+00 3.656344061440584e+00 4.700836621129342e+00 9.201360418317568e+03 + 178820 9.588913304688526e-01 -6.026798382561734e+00 -5.992574659355109e+00 3.503130260629898e+00 4.699648175386389e+00 9.194283247053703e+03 + 178840 9.479200886603818e-01 -6.005791731186609e+00 -5.996943620055413e+00 3.634678558777769e+00 4.685485782133870e+00 9.207668499774536e+03 + 178860 9.485461644605615e-01 -5.997774830205608e+00 -6.008109689371725e+00 3.667434549614244e+00 4.608090188968113e+00 9.241954077193468e+03 + 178880 9.827662878359871e-01 -6.036433729504010e+00 -6.015910432531350e+00 3.481666114173510e+00 4.599514061360464e+00 9.265959590761777e+03 + 178900 9.935916504865916e-01 -6.041543001828783e+00 -6.010359719469600e+00 3.507629966499176e+00 4.686689199402958e+00 9.248874215666485e+03 + 178920 9.466490159337945e-01 -5.959535279680732e+00 -6.011378564188592e+00 3.914864425089416e+00 4.617172262722930e+00 9.251971942333561e+03 + 178940 9.896121235014427e-01 -6.006846766313679e+00 -6.010968826415185e+00 3.604596959235963e+00 4.580927452246375e+00 9.250749588808776e+03 + 178960 9.939686666479026e-01 -5.994896758983690e+00 -5.989534609625403e+00 3.729853267536776e+00 4.760643558941987e+00 9.184923661083600e+03 + 178980 9.548563913133278e-01 -5.917162620373237e+00 -6.012012072403470e+00 4.129352549254127e+00 4.584712317791269e+00 9.253931566940682e+03 + 179000 9.774606757168747e-01 -5.927382066564416e+00 -6.053995020383422e+00 4.078579470954653e+00 4.351548296834644e+00 9.383532790250505e+03 + 179020 1.046952091355962e+00 -6.008757444002383e+00 -6.018686516494840e+00 3.639906115832221e+00 4.582891845061532e+00 9.274504500645327e+03 + 179040 1.036609430692788e+00 -5.973254558448725e+00 -5.992141629145463e+00 3.863082422401268e+00 4.754629939695857e+00 9.192911664572319e+03 + 179060 1.048765002866066e+00 -5.974059236403223e+00 -5.968602903436663e+00 3.792558794723447e+00 4.823889902982233e+00 9.120871580184334e+03 + 179080 1.008118343371213e+00 -5.894381220275415e+00 -5.962682958894735e+00 4.291121631611891e+00 4.898922478799862e+00 9.102815373024136e+03 + 179100 9.845124210627896e-01 -5.833970389845003e+00 -6.011786987451313e+00 4.513995487648748e+00 4.492945067163769e+00 9.253238010766636e+03 + 179120 1.072437769755122e+00 -5.931199693407397e+00 -5.995218721846892e+00 4.104570232884326e+00 4.736963064672111e+00 9.202349724725153e+03 + 179140 1.087599942076391e+00 -5.911302616185481e+00 -6.037730371950281e+00 4.082037605165597e+00 4.356069866932144e+00 9.333207043313270e+03 + 179160 1.159924825293056e+00 -5.973178625032077e+00 -5.979538598384348e+00 3.844262777381127e+00 4.807742826189688e+00 9.154320380111898e+03 + 179180 1.079864959925007e+00 -5.811342270592492e+00 -5.991227210104730e+00 4.674675665519170e+00 4.641748505735476e+00 9.190094655457411e+03 + 179200 1.094663459872127e+00 -5.799174096416000e+00 -5.965781600797892e+00 4.778738181193113e+00 4.822052108604312e+00 9.112197436082915e+03 + 179220 1.126776355936258e+00 -5.822365844157098e+00 -5.975574398333231e+00 4.639224179293446e+00 4.759476952266953e+00 9.142126718327112e+03 + 179240 1.108733868113785e+00 -5.784329381030785e+00 -5.981835139084190e+00 4.841839071545041e+00 4.707730444885112e+00 9.161301772065679e+03 + 179260 1.157252343974405e+00 -5.860423604095528e+00 -5.981557347358155e+00 4.474619147027831e+00 4.779050447827639e+00 9.160492423520394e+03 + 179280 1.050759677168004e+00 -5.725083400195427e+00 -6.030463589043251e+00 5.108584302833474e+00 4.355044001037776e+00 9.310804999435015e+03 + 179300 1.153099017755405e+00 -5.917281624519756e+00 -6.037427122771275e+00 4.144906584518203e+00 4.455012541102215e+00 9.332258387281250e+03 + 179320 1.066281899149278e+00 -5.852393396124542e+00 -6.039406855123252e+00 4.477501357795260e+00 4.403641135985422e+00 9.338414358479926e+03 + 179340 1.055117509048732e+00 -5.895101540476739e+00 -6.029988675915589e+00 4.196186873142757e+00 4.421644067736137e+00 9.309335999159755e+03 + 179360 1.088628877604191e+00 -5.992859793628127e+00 -5.991680388486882e+00 3.762991400237708e+00 4.769763727071091e+00 9.191524924205680e+03 + 179380 1.006057422025108e+00 -5.902516707851793e+00 -6.042189643344285e+00 4.224186164882139e+00 4.422162554967344e+00 9.347007224092378e+03 + 179400 1.067073471864699e+00 -6.017593386754417e+00 -5.968831456357947e+00 3.654690582391890e+00 4.934689132612762e+00 9.121615772709421e+03 + 179420 9.493469236958167e-01 -5.863158978390316e+00 -5.998355935410769e+00 4.493491455020175e+00 4.717169606147252e+00 9.211989755451956e+03 + 179440 1.024690346442564e+00 -5.991189180023664e+00 -6.012499892494338e+00 3.736200917484644e+00 4.613831508655938e+00 9.255444942789482e+03 + 179460 9.905185285712660e-01 -5.958052786732432e+00 -6.050145850787127e+00 3.902420488171484e+00 4.373607863013828e+00 9.371607982112311e+03 + 179480 1.012203309279417e+00 -6.009620545167718e+00 -6.001013786568098e+00 3.599234047747770e+00 4.648655387518377e+00 9.220135003691834e+03 + 179500 9.756329817127348e-01 -5.972854496973094e+00 -5.998357695805740e+00 3.864152014737036e+00 4.717708700432719e+00 9.211969405689615e+03 + 179520 1.063906395039762e+00 -6.119163207934124e+00 -5.970129535078084e+00 3.072165763851364e+00 4.927940176277087e+00 9.125588011098829e+03 + 179540 9.405744271454427e-01 -5.953925041191678e+00 -6.000955331397253e+00 3.958556565781662e+00 4.688501361507360e+00 9.219977193239692e+03 + 179560 9.849918780386494e-01 -6.033790864231099e+00 -5.973498460515798e+00 3.541092306195253e+00 4.887300618547831e+00 9.135886662054645e+03 + 179580 9.766016973973498e-01 -6.032001375606143e+00 -6.000941688112572e+00 3.528842145271762e+00 4.707191677330949e+00 9.219938326157522e+03 + 179600 9.562399358420326e-01 -6.010195896672728e+00 -5.997453217565448e+00 3.697014515803902e+00 4.770184951161127e+00 9.209240453682105e+03 + 179620 9.960619207915347e-01 -6.075289030892755e+00 -5.981247386562478e+00 3.253358468996880e+00 4.793360143638755e+00 9.159591783229735e+03 + 179640 9.716103013073514e-01 -6.042232182611457e+00 -6.026227255174946e+00 3.442828609664788e+00 4.534731379759752e+00 9.297734506423863e+03 + 179660 9.552420684467672e-01 -6.019866844546089e+00 -6.013878302465820e+00 3.611844376103451e+00 4.646231511452244e+00 9.259710082880933e+03 + 179680 9.266938994253918e-01 -5.975106750472463e+00 -5.997410301576512e+00 3.847217937193010e+00 4.719147495290188e+00 9.209119052820750e+03 + 179700 9.438634623097828e-01 -5.993285815372074e+00 -6.020584974776908e+00 3.686683256369400e+00 4.529927258535582e+00 9.280348006930735e+03 + 179720 1.013962611103239e+00 -6.083485666507359e+00 -6.020305982913003e+00 3.230143604732655e+00 4.592931124955888e+00 9.279507794570471e+03 + 179740 9.960948714186612e-01 -6.039042695708099e+00 -6.011399618238673e+00 3.508025351148733e+00 4.666756179730594e+00 9.252093022876128e+03 + 179760 9.777158998479560e-01 -5.991301067610372e+00 -6.004030443417117e+00 3.756724766710816e+00 4.683630720963947e+00 9.229430659112102e+03 + 179780 9.987071503097394e-01 -5.995807221375340e+00 -5.999022852931034e+00 3.704311004565095e+00 4.685846350554923e+00 9.214049534507742e+03 + 179800 1.015541225126704e+00 -5.987711881670568e+00 -6.028896461834986e+00 3.757709283605004e+00 4.521221051007732e+00 9.305969300247589e+03 + 179820 1.028860904465860e+00 -5.971150371284462e+00 -6.049700792316487e+00 3.804833857091046e+00 4.353785183886794e+00 9.370269859923446e+03 + 179840 1.000550535697526e+00 -5.896608786478920e+00 -6.061727664921485e+00 4.248849244782436e+00 4.300711092701366e+00 9.407507613248490e+03 + 179860 1.056696099303076e+00 -5.953794645637642e+00 -6.008726151023369e+00 3.980390862933721e+00 4.664965658385894e+00 9.243856354602514e+03 + 179880 1.057240979065718e+00 -5.935570772799001e+00 -6.021250393418533e+00 4.015752913671358e+00 4.523767273195567e+00 9.282412600299058e+03 + 179900 1.120549265292441e+00 -6.016716129814172e+00 -6.037219057522423e+00 3.536374825471076e+00 4.418643841752495e+00 9.331639481452701e+03 + 179920 1.019449897934293e+00 -5.864620969248749e+00 -6.027432864496088e+00 4.426358685091675e+00 4.491467587522092e+00 9.301417253097643e+03 + 179940 1.063034029699103e+00 -5.934078810947814e+00 -5.960638495884524e+00 4.052504515142052e+00 4.899994694137503e+00 9.096592949531385e+03 + 179960 1.039740719005494e+00 -5.909306513036979e+00 -6.023456819279144e+00 4.230111827237595e+00 4.574643104092284e+00 9.289184221885396e+03 + 179980 1.076107557885185e+00 -5.981579552764204e+00 -6.013247463443655e+00 3.771960594497863e+00 4.590118550783118e+00 9.257755134303496e+03 + 180000 1.125421404175584e+00 -6.085968025914815e+00 -5.993606785513094e+00 3.223085671505041e+00 4.753438206747486e+00 9.197421878711461e+03 + 180020 9.913221772149444e-01 -5.932501751885166e+00 -6.008979852863348e+00 4.118210015318938e+00 4.679060924554343e+00 9.244633695269851e+03 + 180040 9.653988223105963e-01 -5.948516840407977e+00 -6.031587231318644e+00 3.984058623317844e+00 4.507055583607344e+00 9.314239828369922e+03 + 180060 9.986620192815925e-01 -6.047377353568788e+00 -5.999813741405408e+00 3.411792750496912e+00 4.684910371984237e+00 9.216485518753385e+03 + 180080 9.448802166799275e-01 -6.005760266482371e+00 -6.014363156470528e+00 3.643047108458528e+00 4.593647982853600e+00 9.261186589794068e+03 + 180100 1.001341353680793e+00 -6.110810269308422e+00 -5.949083770314513e+00 3.090503695395500e+00 5.019162279713354e+00 9.061404095381333e+03 + 180120 9.299581804089481e-01 -6.013988834245307e+00 -5.962317047744852e+00 3.635105198618713e+00 4.931812592887443e+00 9.101745247127130e+03 + 180140 9.638827220680215e-01 -6.065461973945254e+00 -5.965576643573652e+00 3.360499190895905e+00 4.934056215094563e+00 9.111667412037092e+03 + 180160 9.782190348152016e-01 -6.082095963041246e+00 -5.953448674714096e+00 3.260113302422796e+00 4.998825940100817e+00 9.074702574970917e+03 + 180180 9.233719232405143e-01 -5.991614092881761e+00 -5.962665681788380e+00 3.738755722331895e+00 4.904981978582231e+00 9.102792258098307e+03 + 180200 9.340234955887675e-01 -5.994663038346721e+00 -5.995551730692926e+00 3.696295159558013e+00 4.691192150581402e+00 9.203403657845156e+03 + 180220 9.998598897263635e-01 -6.076309704171266e+00 -6.019594603152853e+00 3.274489030246864e+00 4.600155916928115e+00 9.277313333831849e+03 + 180240 1.004637648004705e+00 -6.065358548623474e+00 -6.018882220206416e+00 3.317249463327768e+00 4.584123733287092e+00 9.275119190255426e+03 + 180260 9.140358557284201e-01 -5.913743166992745e+00 -6.050507478014527e+00 4.115038039785730e+00 4.329716201689925e+00 9.372735275506027e+03 + 180280 9.504128454372901e-01 -5.946921224160363e+00 -6.019924946092878e+00 4.014906948323338e+00 4.595708279697375e+00 9.278289147806650e+03 + 180300 9.955057992839643e-01 -5.991191950976859e+00 -6.031813146029588e+00 3.775132985903218e+00 4.541879797800828e+00 9.314970387136289e+03 + 180320 1.038086217098168e+00 -6.032738523484217e+00 -6.031843260940660e+00 3.541326183624400e+00 4.546466919690935e+00 9.315071414834885e+03 + 180340 9.814040669012805e-01 -5.930386226000901e+00 -6.042050315964517e+00 4.049195524198636e+00 4.408003039665475e+00 9.346601217574911e+03 + 180360 1.047879431956461e+00 -6.013010299762059e+00 -6.043940529203699e+00 3.594948528078496e+00 4.417342364187065e+00 9.352436173879929e+03 + 180380 1.027204192272059e+00 -5.970956026261110e+00 -6.010311474391696e+00 3.864662232589248e+00 4.638677159187505e+00 9.248715701734483e+03 + 180400 9.865789025789117e-01 -5.901172920863145e+00 -6.022101230227761e+00 4.165503004116772e+00 4.471113938149751e+00 9.284986017861145e+03 + 180420 1.015911017697820e+00 -5.936081645743652e+00 -6.052055803979870e+00 3.995830472190482e+00 4.329888908655136e+00 9.377499928077836e+03 + 180440 1.025610344802659e+00 -5.943830544495004e+00 -5.968647004380312e+00 4.046964197987646e+00 4.904464244991452e+00 9.121041661909290e+03 + 180460 1.091639965437210e+00 -6.037476042009661e+00 -6.020683791906936e+00 3.525609162083694e+00 4.622032860765850e+00 9.280644127461339e+03 + 180480 1.004995671747160e+00 -5.910121904438055e+00 -6.034021232946737e+00 4.155591211680798e+00 4.444142094024826e+00 9.321800643674747e+03 + 180500 1.037650957236568e+00 -5.966103607909934e+00 -6.043241321583285e+00 3.863551050522339e+00 4.420614361587351e+00 9.350274424950541e+03 + 180520 1.050038963324319e+00 -6.003953765909282e+00 -6.039391287993084e+00 3.662328622192842e+00 4.458840886448829e+00 9.338383615130062e+03 + 180540 9.915689712192942e-01 -5.950127446817041e+00 -5.991119688023770e+00 3.969049991971632e+00 4.733666199433772e+00 9.189816930724404e+03 + 180560 9.968365549273531e-01 -5.996951601235232e+00 -6.005202592116648e+00 3.737937451221171e+00 4.690558984743369e+00 9.233029473009072e+03 + 180580 1.022850048243853e+00 -6.081493030290620e+00 -6.019854983715596e+00 3.273939425566257e+00 4.627874627456928e+00 9.278110643972086e+03 + 180600 9.673253678583703e-01 -6.043222685009202e+00 -6.006990898047782e+00 3.487984697026506e+00 4.696033224609891e+00 9.238535507917653e+03 + 180620 9.130043827356075e-01 -5.996538830222480e+00 -6.052268587011494e+00 3.686164608785946e+00 4.366155721151436e+00 9.378187555666180e+03 + 180640 9.443766292908865e-01 -6.068685046904566e+00 -5.982508910144664e+00 3.300461091922872e+00 4.795297804912294e+00 9.163446624817416e+03 + 180660 8.701562468933893e-01 -5.972241463864579e+00 -5.967321019397588e+00 3.843693780889991e+00 4.871947734455777e+00 9.117011773639222e+03 + 180680 9.514773545243300e-01 -6.096613534870450e+00 -5.981227844278083e+00 3.211338752091921e+00 4.873901243351202e+00 9.159510830644731e+03 + 180700 9.058303090571815e-01 -6.024313798326060e+00 -6.001161544673757e+00 3.607811346197257e+00 4.740755169468456e+00 9.220620680508207e+03 + 180720 9.290727136485980e-01 -6.049150166104898e+00 -5.975689433510163e+00 3.403279214462404e+00 4.825102109033002e+00 9.142583706787240e+03 + 180740 9.324953553023744e-01 -6.037878139155898e+00 -5.963261386182763e+00 3.503737107125956e+00 4.932198049602897e+00 9.104626628440999e+03 + 180760 9.343066694848940e-01 -6.017516299990763e+00 -5.999546246205599e+00 3.611596700090432e+00 4.714783529781680e+00 9.215642372700175e+03 + 180780 9.639711637325877e-01 -6.032249107436899e+00 -5.996627373481408e+00 3.480356127134967e+00 4.684901635952908e+00 9.206707951471177e+03 + 180800 9.614517521289969e-01 -5.995363885380623e+00 -6.001052380607915e+00 3.758697549686905e+00 4.726033329800001e+00 9.220261531279049e+03 + 180820 1.026855300177598e+00 -6.061057180173231e+00 -5.981450471276252e+00 3.395749156205141e+00 4.852863197789981e+00 9.160191346300924e+03 + 180840 1.016742308594960e+00 -6.017777740616434e+00 -6.017843521608612e+00 3.614784570555419e+00 4.614406845918755e+00 9.271903497567455e+03 + 180860 9.598269151110441e-01 -5.911964366635502e+00 -6.022243237137112e+00 4.186222851143889e+00 4.552984511123583e+00 9.285455372202970e+03 + 180880 1.002722684794844e+00 -5.961716793005307e+00 -6.019558922476595e+00 3.865187806356758e+00 4.533049347892014e+00 9.277180178931494e+03 + 180900 1.046379800253978e+00 -6.015224534558715e+00 -6.006456132163017e+00 3.592023894417100e+00 4.642373417879085e+00 9.236869396908458e+03 + 180920 9.970554810146385e-01 -5.935102661524946e+00 -6.023218496272721e+00 4.028023722187161e+00 4.522048963184077e+00 9.288445026950883e+03 + 180940 1.011203324394180e+00 -5.953842743406380e+00 -6.035022009806198e+00 3.935708705127477e+00 4.469564795008845e+00 9.324871255177608e+03 + 180960 1.066170903186995e+00 -6.037285389211596e+00 -6.011338872604016e+00 3.513267075448850e+00 4.662255989020046e+00 9.251848390542702e+03 + 180980 1.022694318436432e+00 -5.977692528751573e+00 -6.009175393001126e+00 3.830827380005613e+00 4.650047901527188e+00 9.245231439748079e+03 + 181000 1.034961924456969e+00 -6.001779995912164e+00 -6.010284718278571e+00 3.689523617872284e+00 4.640688185942842e+00 9.248647610236281e+03 + 181020 1.026810033396168e+00 -5.997263531486535e+00 -6.004291827620186e+00 3.723401964280419e+00 4.683044400255682e+00 9.230241780176573e+03 + 181040 9.804031346278518e-01 -5.937073717236286e+00 -6.034438702078535e+00 4.067700415001844e+00 4.508615604854936e+00 9.323068168013077e+03 + 181060 1.039851783436849e+00 -6.035979728872313e+00 -6.004116623480322e+00 3.514686471501187e+00 4.697649353461620e+00 9.229703798412140e+03 + 181080 1.033040025606348e+00 -6.038778997979981e+00 -6.001434796116058e+00 3.475648797779997e+00 4.690084983879205e+00 9.221448835374671e+03 + 181100 1.033507833197241e+00 -6.053159380093524e+00 -5.985074307750543e+00 3.407894125392784e+00 4.798849146917072e+00 9.171288838114617e+03 + 181120 9.969357198094637e-01 -6.012982435253976e+00 -6.009382161123741e+00 3.593225227786296e+00 4.613898558982725e+00 9.245876091373377e+03 + 181140 9.982846919832451e-01 -6.030380113627192e+00 -5.974680103092503e+00 3.554222551509219e+00 4.874060631548177e+00 9.139490971491072e+03 + 181160 9.421994365518558e-01 -5.961705253898592e+00 -6.016957260464529e+00 3.879061280752804e+00 4.561795708830813e+00 9.269159035816336e+03 + 181180 9.774436339880400e-01 -6.028891534586135e+00 -6.018560788954730e+00 3.473155861176168e+00 4.532476601269416e+00 9.274125502040955e+03 + 181200 9.927633887557642e-01 -6.069571935294340e+00 -5.974638821217621e+00 3.371996019863215e+00 4.917116651743664e+00 9.139363015209634e+03 + 181220 9.726828831700212e-01 -6.064099161709088e+00 -5.984873484400010e+00 3.317905002741819e+00 4.772831101984485e+00 9.170693903605745e+03 + 181240 9.437891248539668e-01 -6.053950855937367e+00 -6.004152569766916e+00 3.435713003311629e+00 4.721662468762235e+00 9.229792756376513e+03 + 181260 9.608334786304651e-01 -6.119763141484224e+00 -6.015103620339307e+00 3.066593407992396e+00 4.667564574415064e+00 9.263481524973848e+03 + 181280 9.019207094144750e-01 -6.077102424171327e+00 -6.013285396171963e+00 3.259574067958527e+00 4.626021318384048e+00 9.257886567491509e+03 + 181300 8.936973742317200e-01 -6.100053003912221e+00 -5.996814674143701e+00 3.144766412054914e+00 4.737576877665652e+00 9.207289289537144e+03 + 181320 9.100568746739061e-01 -6.149481302277849e+00 -5.994642580200656e+00 2.879717827210444e+00 4.768825730592487e+00 9.200635124114659e+03 + 181340 8.800653825952511e-01 -6.118979960054954e+00 -5.994741207337619e+00 3.022288895558907e+00 4.735687039546693e+00 9.200939050143530e+03 + 181360 8.351205731705921e-01 -6.053320931461045e+00 -6.013307295879164e+00 3.390418836210975e+00 4.620183323812224e+00 9.257967641631794e+03 + 181380 8.896019121328670e-01 -6.123720865255657e+00 -6.014197575234633e+00 3.011383500560150e+00 4.640283180535226e+00 9.260687987328974e+03 + 181400 9.140412800009025e-01 -6.139902444982267e+00 -5.971674415745955e+00 2.947432952075728e+00 4.913424329154024e+00 9.130324250536150e+03 + 181420 8.628342615565623e-01 -6.033889438192309e+00 -5.973026226407151e+00 3.502942118204216e+00 4.852428098826179e+00 9.134430826065634e+03 + 181440 9.256285000643992e-01 -6.088529603232922e+00 -5.945158927853521e+00 3.295458907263929e+00 5.118715511832757e+00 9.049457855344832e+03 + 181460 9.415491294923307e-01 -6.068621345371437e+00 -5.996079238005941e+00 3.343030296026801e+00 4.759578302374318e+00 9.205020170948526e+03 + 181480 9.911251649508644e-01 -6.104881485605352e+00 -5.959889012494896e+00 3.158686417927005e+00 4.991255636039944e+00 9.094310103409998e+03 + 181500 9.386703973013569e-01 -5.999669278295515e+00 -5.992197154079760e+00 3.701122455180400e+00 4.744028548734752e+00 9.193118363798327e+03 + 181520 9.709752550783157e-01 -6.024223410957008e+00 -6.035802155111824e+00 3.548545125139667e+00 4.482058184397848e+00 9.327293231385385e+03 + 181540 9.641803582799450e-01 -5.996942640876028e+00 -6.014787214455438e+00 3.740699188836333e+00 4.638232885904519e+00 9.262505834364767e+03 + 181560 9.759908150220242e-01 -5.999752521652729e+00 -6.011224667211032e+00 3.684332047474408e+00 4.618457212369844e+00 9.251540289516433e+03 + 181580 9.730523394290131e-01 -5.980340678994457e+00 -5.994630445882089e+00 3.797988431670070e+00 4.715934378867008e+00 9.200566221276064e+03 + 181600 9.922259010250978e-01 -5.992307729420636e+00 -5.994807275657577e+00 3.788666581122309e+00 4.774313799826270e+00 9.201088159728963e+03 + 181620 1.024734629795362e+00 -6.023836930280693e+00 -6.005070978818349e+00 3.537965090685463e+00 4.645722088003846e+00 9.232621243018730e+03 + 181640 9.476716807509727e-01 -5.893287536047615e+00 -6.028809688865383e+00 4.289063305741166e+00 4.510874132276170e+00 9.305712211848717e+03 + 181660 1.007705689979440e+00 -5.967292709368282e+00 -6.027315623568732e+00 3.896843639264795e+00 4.552182777409853e+00 9.301100273893862e+03 + 181680 9.948290999588609e-01 -5.935225817735478e+00 -6.048499166884421e+00 4.063475261790677e+00 4.413042161983324e+00 9.366535231242346e+03 + 181700 1.057762420597955e+00 -6.019425899228712e+00 -6.033145446176822e+00 3.604505064602411e+00 4.525725302933335e+00 9.319080586248412e+03 + 181720 1.065828124030555e+00 -6.025897715005232e+00 -6.001589154902350e+00 3.561013087282940e+00 4.700596601131213e+00 9.221940570660796e+03 + 181740 9.670976860416579e-01 -5.879209048945593e+00 -6.022321361815548e+00 4.366850275500990e+00 4.545077228442870e+00 9.285687598831506e+03 + 181760 1.014831224613179e+00 -5.949645957338634e+00 -6.024826293346750e+00 3.864529488974774e+00 4.432832365496771e+00 9.293414259146552e+03 + 181780 1.033522577357795e+00 -5.980750346560871e+00 -5.999495271666475e+00 3.787685903271255e+00 4.680049642547096e+00 9.215502539762370e+03 + 181800 9.760676000770202e-01 -5.903055509685956e+00 -6.007945443344893e+00 4.224935303616530e+00 4.622641072882137e+00 9.241457358804264e+03 + 181820 9.628423259909821e-01 -5.895559375821137e+00 -6.028200632522810e+00 4.227904734093922e+00 4.466258111944780e+00 9.303797019279371e+03 + 181840 1.004632299599707e+00 -5.977182932813477e+00 -5.983487567904758e+00 3.846378811904008e+00 4.810176621570744e+00 9.166396868966467e+03 + 181860 1.000637274111631e+00 -5.992729982203437e+00 -5.972519341505672e+00 3.770203876096978e+00 4.886256502570091e+00 9.132865625951643e+03 + 181880 1.000968757102357e+00 -6.019676131962095e+00 -5.971099905394277e+00 3.595931910844122e+00 4.874864120943302e+00 9.128532571267064e+03 + 181900 9.943822118448582e-01 -6.042329420760476e+00 -5.950118841222725e+00 3.492641264733741e+00 5.022128681980573e+00 9.064547890073829e+03 + 181920 9.509009486225022e-01 -6.009284036946914e+00 -6.001010045070011e+00 3.595621610694612e+00 4.643132152447895e+00 9.220124150339174e+03 + 181940 9.640261589274948e-01 -6.057726239945605e+00 -5.942244232324349e+00 3.429837357705744e+00 5.092952916249926e+00 9.040582476612153e+03 + 181960 9.556198166713632e-01 -6.068523922199570e+00 -5.972846780969221e+00 3.328443946284227e+00 4.877836897218652e+00 9.133902591650038e+03 + 181980 9.205975274375046e-01 -6.035687790830488e+00 -6.018216507122204e+00 3.457267094312269e+00 4.557589909037647e+00 9.273069088132621e+03 + 182000 9.092847204146728e-01 -6.033061985401256e+00 -5.967132899963322e+00 3.526192316645555e+00 4.904767327723169e+00 9.116426496260070e+03 + 182020 9.451764137513948e-01 -6.090705591156501e+00 -5.958829882959080e+00 3.273493194957166e+00 5.030743919126650e+00 9.091075975346628e+03 + 182040 8.527114361738871e-01 -5.948658044663998e+00 -6.089683480935885e+00 3.963260159238467e+00 4.153470280549560e+00 9.494390287868422e+03 + 182060 9.396643653636382e-01 -6.068486733793518e+00 -6.031157935789227e+00 3.340147394319639e+00 4.554495129073097e+00 9.312941185847112e+03 + 182080 9.575131070140854e-01 -6.077625724672888e+00 -6.009996609000997e+00 3.272910111979643e+00 4.661246959739467e+00 9.247767864699133e+03 + 182100 9.208155532903834e-01 -5.995175869056211e+00 -6.021359315727283e+00 3.732314283393104e+00 4.581964880732528e+00 9.282719461112672e+03 + 182120 1.003986353811705e+00 -6.075659119257620e+00 -6.024067327676457e+00 3.226029051833506e+00 4.522277102896487e+00 9.291055757864491e+03 + 182140 9.596345583736023e-01 -5.958865454126673e+00 -6.021609424102346e+00 3.935689045748638e+00 4.575403460550351e+00 9.283499207195933e+03 + 182160 1.038161002125665e+00 -6.022287893741444e+00 -6.008877960936134e+00 3.630745518646675e+00 4.707747427995160e+00 9.244327378943810e+03 + 182180 1.038766359938085e+00 -5.982080068189855e+00 -6.032124945224610e+00 3.795283981242434e+00 4.507918552889180e+00 9.315924433733193e+03 + 182200 1.097354821803763e+00 -6.047100933383801e+00 -6.007640724794521e+00 3.423950426663027e+00 4.650537050830216e+00 9.240526136137129e+03 + 182220 1.037630195085614e+00 -5.948404359040689e+00 -6.037398857422440e+00 3.930745581669599e+00 4.419725400107470e+00 9.332208242367906e+03 + 182240 9.980981943497592e-01 -5.887581941566524e+00 -5.997086264481874e+00 4.266753195340176e+00 4.637962427421036e+00 9.208073557800413e+03 + 182260 1.015156081367137e+00 -5.911922238064271e+00 -5.960855052407324e+00 4.226026120474256e+00 4.945046328187900e+00 9.097235328356561e+03 + 182280 1.085619397997308e+00 -6.017531383885437e+00 -5.978495392569972e+00 3.612630568118046e+00 4.836781271051581e+00 9.151144825762951e+03 + 182300 1.041657901787031e+00 -5.959996567619565e+00 -6.016244510140841e+00 3.888494455072252e+00 4.565510064774112e+00 9.266987443649163e+03 + 182320 1.065477873461993e+00 -6.008850312936737e+00 -5.999875733966373e+00 3.620792468928576e+00 4.672325890188010e+00 9.216652494203507e+03 + 182340 1.038130279452357e+00 -5.984766817780004e+00 -5.947172652557769e+00 3.801532616012624e+00 5.017404130396965e+00 9.055573047543021e+03 + 182360 9.927442724458968e-01 -5.934054925695696e+00 -5.936661410547272e+00 4.090282078728653e+00 5.075315239358678e+00 9.023623477054431e+03 + 182380 9.885691098897834e-01 -5.943539026770265e+00 -5.962090975748258e+00 3.974204234348758e+00 4.867676072412299e+00 9.101034071285543e+03 + 182400 1.010170362051772e+00 -5.990898180052040e+00 -6.011395017024995e+00 3.702858965442329e+00 4.585162955668352e+00 9.252047436767594e+03 + 182420 9.628682229100015e-01 -5.939113311982030e+00 -6.046757477562593e+00 4.028047253273160e+00 4.409937796628779e+00 9.361127099358822e+03 + 182440 1.037001329506324e+00 -6.069564591617658e+00 -5.964943167607914e+00 3.343723575721161e+00 4.944475982498152e+00 9.109759226191385e+03 + 182460 9.600789418251379e-01 -5.975903137652145e+00 -6.023302846267487e+00 3.855991458634700e+00 4.583814996684197e+00 9.288704180610326e+03 + 182480 9.778646620103488e-01 -6.024079995783051e+00 -6.005296386751924e+00 3.540055005205066e+00 4.647913395015901e+00 9.233324857474610e+03 + 182500 9.957557160515575e-01 -6.071591666086233e+00 -5.974154681995539e+00 3.370210400637615e+00 4.929708641610941e+00 9.137882616331639e+03 + 182520 1.013325417394368e+00 -6.118047820343834e+00 -5.975339156813394e+00 3.078019194855379e+00 4.897474424941468e+00 9.141508124314574e+03 + 182540 9.613240598370664e-01 -6.061677844223954e+00 -6.009592888465038e+00 3.376534819403375e+00 4.675614695491929e+00 9.246504140606903e+03 + 182560 9.617654015954540e-01 -6.081063719797248e+00 -5.982361662175835e+00 3.277796105263663e+00 4.844558594219871e+00 9.162983298053527e+03 + 182580 9.594098643635102e-01 -6.093744497442604e+00 -5.990320539733304e+00 3.177423600274917e+00 4.771299970247446e+00 9.187383874962499e+03 + 182600 9.497451495577089e-01 -6.095427173149379e+00 -5.996070252507400e+00 3.204007521222534e+00 4.774530334982556e+00 9.205012574430339e+03 + 182620 9.573688775996365e-01 -6.123038709052206e+00 -6.001865206875396e+00 3.049202062236197e+00 4.744999063274300e+00 9.222808399023968e+03 + 182640 8.664541792424135e-01 -6.005982223020002e+00 -6.049353358631251e+00 3.734610787240868e+00 4.485567014899529e+00 9.369171635410001e+03 + 182660 9.375517716114481e-01 -6.127673878863621e+00 -5.986889371149994e+00 3.020911417051582e+00 4.829317846675385e+00 9.176856986943652e+03 + 182680 9.542033162293304e-01 -6.163652850380975e+00 -5.989981148480254e+00 2.827329966624821e+00 4.824579754547773e+00 9.186345057329394e+03 + 182700 8.907672037867657e-01 -6.075169465346674e+00 -6.015855579770943e+00 3.286519169470169e+00 4.627108679240144e+00 9.265792099413395e+03 + 182720 9.522489418475915e-01 -6.164499173195958e+00 -5.974007236244782e+00 2.821288621963502e+00 4.915122802469128e+00 9.137453950196372e+03 + 182740 9.171069863368213e-01 -6.099004952098431e+00 -5.994686665292605e+00 3.194626120653698e+00 4.793637866695464e+00 9.200752811985540e+03 + 182760 1.009850135217530e+00 -6.210106083450473e+00 -5.975706558111641e+00 2.553277377512090e+00 4.899235725216977e+00 9.142665386615898e+03 + 182780 9.033878153086177e-01 -6.018592788233847e+00 -6.034564683207395e+00 3.556617139290597e+00 4.464904046709727e+00 9.323433001476336e+03 + 182800 9.333965571682911e-01 -6.024413175908081e+00 -5.998025762073112e+00 3.525744998976313e+00 4.677265612655801e+00 9.210993073101467e+03 + 182820 9.867772757962188e-01 -6.059120723071954e+00 -5.993772073276403e+00 3.383007862082665e+00 4.758249921879597e+00 9.197944292885690e+03 + 182840 1.003767031592404e+00 -6.045447409391301e+00 -5.971886935895461e+00 3.419944180460007e+00 4.842339802719602e+00 9.130949863239864e+03 + 182860 1.011828891863232e+00 -6.025200376837055e+00 -6.002443913195602e+00 3.548344742068656e+00 4.679015877849244e+00 9.224544093170924e+03 + 182880 9.871520108714894e-01 -5.961223240183211e+00 -6.026562622126217e+00 3.891081131039785e+00 4.515892288686365e+00 9.298767393333714e+03 + 182900 1.005301953050382e+00 -5.967290282470310e+00 -6.045786421458040e+00 3.814054396272449e+00 4.363317418966654e+00 9.358152078470661e+03 + 182920 1.015613564543907e+00 -5.968050868607349e+00 -6.060904531574825e+00 3.826824915361818e+00 4.293644813544667e+00 9.404949274246454e+03 + 182940 9.969716708539996e-01 -5.931123384339414e+00 -6.014241296501447e+00 4.075206707600547e+00 4.597930793510819e+00 9.260819731382779e+03 + 182960 1.060537865677831e+00 -6.019367173577299e+00 -5.977793615209092e+00 3.587407651604850e+00 4.826129457242462e+00 9.148989400562497e+03 + 182980 1.022625105231310e+00 -5.957877138585613e+00 -6.016767132936128e+00 3.974366214218911e+00 4.636210753461081e+00 9.268586020405126e+03 + 183000 9.684773287633293e-01 -5.876876887352115e+00 -6.054699949295212e+00 4.353707550284700e+00 4.332620010577529e+00 9.385732056240946e+03 + 183020 1.020727142661099e+00 -5.958063270001578e+00 -6.020554289981227e+00 3.928433995752505e+00 4.569600888575266e+00 9.280264834202590e+03 + 183040 9.880035495949384e-01 -5.916004221742985e+00 -6.103653582651074e+00 4.092692618517393e+00 4.015180949538397e+00 9.537974668507883e+03 + 183060 1.022242628823166e+00 -5.980092836724189e+00 -6.006519187213458e+00 3.831760600373085e+00 4.680016406399178e+00 9.237082033021474e+03 + 183080 1.039545886716792e+00 -6.023733054906250e+00 -6.029721835420217e+00 3.583538027710625e+00 4.549149523238642e+00 9.308532809260447e+03 + 183100 1.024180695182789e+00 -6.025497882006650e+00 -6.004890319711416e+00 3.578946135833577e+00 4.697277947542775e+00 9.232075672394185e+03 + 183120 1.001278174104750e+00 -6.021736612040046e+00 -5.999684612436123e+00 3.591359579268254e+00 4.717985573529890e+00 9.216079003670620e+03 + 183140 9.874100598659102e-01 -6.034737467594228e+00 -5.988819981406456e+00 3.512523950341049e+00 4.776189261739258e+00 9.182770713788766e+03 + 183160 1.003855482111840e+00 -6.090995565314183e+00 -5.965986545609766e+00 3.207348821615689e+00 4.925169957841730e+00 9.112938000938619e+03 + 183180 9.126786489754910e-01 -5.985258903960299e+00 -6.002868345603831e+00 3.793088291915336e+00 4.691972152945887e+00 9.225858751670539e+03 + 183200 9.476196599666125e-01 -6.061428688049135e+00 -5.986781706509492e+00 3.354329282525161e+00 4.782963802108851e+00 9.176512968531300e+03 + 183220 9.276450905201146e-01 -6.047813059089366e+00 -5.987852265994707e+00 3.460258387845239e+00 4.804562540697511e+00 9.179791576862553e+03 + 183240 9.974596717293623e-01 -6.160287482512414e+00 -5.979503677967003e+00 2.881390773358254e+00 4.919479355261344e+00 9.154252378065508e+03 + 183260 9.024733952084930e-01 -6.022562244245775e+00 -6.014707626239056e+00 3.601092192538271e+00 4.646194624631065e+00 9.262269785166551e+03 + 183280 9.354355866101309e-01 -6.067988331930275e+00 -6.037457162152712e+00 3.306313799609485e+00 4.481628501155508e+00 9.332402819647072e+03 + 183300 9.912144764911170e-01 -6.140766837073901e+00 -6.026079484419021e+00 2.880689388980709e+00 4.539241915735498e+00 9.297292946517144e+03 + 183320 9.573525510056339e-01 -6.076441766210662e+00 -6.000451067900589e+00 3.258711100386248e+00 4.695061449605246e+00 9.218433566758509e+03 + 183340 9.794943047673691e-01 -6.083421368270191e+00 -5.974187773070541e+00 3.237160892247332e+00 4.864397099727950e+00 9.138006155026749e+03 + 183360 9.374945370235039e-01 -5.975324776641306e+00 -5.977263931856917e+00 3.876990851325654e+00 4.865855921994314e+00 9.147378801722516e+03 + 183380 1.033576184941678e+00 -6.052115913652509e+00 -6.010657803713789e+00 3.428947865434389e+00 4.667006748324300e+00 9.249799307607205e+03 + 183400 1.050309019596442e+00 -6.011844847878848e+00 -6.035040490469532e+00 3.607044458772885e+00 4.473851489503090e+00 9.324938532836812e+03 + 183420 1.058184751047710e+00 -5.982364982797669e+00 -6.000145833086636e+00 3.840937241827181e+00 4.738836847890239e+00 9.217494883170712e+03 + 183440 1.022510178995043e+00 -5.907744355534378e+00 -6.046476844947712e+00 4.177877572785197e+00 4.381254149790482e+00 9.360241055560129e+03 + 183460 1.005756208910567e+00 -5.872344383362115e+00 -6.029155866048146e+00 4.336195564640567e+00 4.435759764558855e+00 9.306746104273585e+03 + 183480 1.098128936456117e+00 -6.006494259882746e+00 -5.992820343235844e+00 3.691013146415995e+00 4.769530891834271e+00 9.195007047584664e+03 + 183500 1.109547364595911e+00 -6.027351801680505e+00 -5.977702490108150e+00 3.592268746077262e+00 4.877362776331857e+00 9.148728692541106e+03 + 183520 1.040899474111211e+00 -5.936046909980776e+00 -6.056858040651310e+00 4.001067257951492e+00 4.307351050179240e+00 9.392383460341536e+03 + 183540 1.016404860640310e+00 -5.916789564396753e+00 -6.002957616567284e+00 4.115201500142506e+00 4.620411210116340e+00 9.226105412144669e+03 + 183560 9.964895139143400e-01 -5.904767782410787e+00 -6.015469089938182e+00 4.199076185642051e+00 4.563412146847776e+00 9.264588304500072e+03 + 183580 1.026024237613868e+00 -5.969904100590394e+00 -6.019342353079809e+00 3.836522004443575e+00 4.552639908104508e+00 9.276514908208346e+03 + 183600 9.929863832337298e-01 -5.945018137316734e+00 -6.020135456266216e+00 4.040664090568213e+00 4.609328820792752e+00 9.278937209780821e+03 + 183620 1.009605475727610e+00 -5.994809859954065e+00 -6.015070670984768e+00 3.749209434340291e+00 4.632868722051627e+00 9.263361547595365e+03 + 183640 1.016991316532674e+00 -6.031522013883414e+00 -6.019121750592094e+00 3.509567074543125e+00 4.580771305296426e+00 9.275854911539114e+03 + 183660 1.024970281485106e+00 -6.069571913364922e+00 -5.949147297140289e+00 3.372577490470559e+00 5.064074272481536e+00 9.061602150983947e+03 + 183680 9.559523738005318e-01 -5.989262682868043e+00 -6.025532581653927e+00 3.769603565832827e+00 4.561336194255585e+00 9.295582465247586e+03 + 183700 1.001171884324846e+00 -6.076427704436652e+00 -5.986707354749227e+00 3.280415293477588e+00 4.795603425562023e+00 9.176291942424505e+03 + 183720 9.338436823009627e-01 -5.990915870870106e+00 -6.017387957385110e+00 3.794089510342202e+00 4.642082693030899e+00 9.270509615304130e+03 + 183740 9.808999832662227e-01 -6.070804908010293e+00 -5.999573647115786e+00 3.338184544323380e+00 4.747205467381642e+00 9.215726502040370e+03 + 183760 9.878853033790093e-01 -6.087115585656086e+00 -5.988500133135667e+00 3.230313118596940e+00 4.796578307661146e+00 9.181795846634226e+03 + 183780 1.001340792909470e+00 -6.110109487642375e+00 -5.976282559712478e+00 3.150483278003567e+00 4.918938207827197e+00 9.144373783845755e+03 + 183800 9.630575831544059e-01 -6.050893490699070e+00 -6.046150251815641e+00 3.399706865363983e+00 4.426943277046474e+00 9.359279691317544e+03 + 183820 9.716988953583182e-01 -6.059234507583635e+00 -6.026871326297243e+00 3.355836834305882e+00 4.541671229438458e+00 9.299752638170059e+03 + 183840 9.677341744770432e-01 -6.044961835207429e+00 -6.010863063751893e+00 3.466204454295096e+00 4.662004876760617e+00 9.250417008032908e+03 + 183860 9.505173415080799e-01 -6.004550261477382e+00 -6.014292159809347e+00 3.679686700749218e+00 4.623747212973175e+00 9.260959693419783e+03 + 183880 9.709762195571179e-01 -6.005940097291234e+00 -6.040195931063629e+00 3.655143550610627e+00 4.458441252016392e+00 9.340857365227454e+03 + 183900 1.046195560098781e+00 -6.074134774482527e+00 -5.969052686330778e+00 3.336096493197444e+00 4.939494104765375e+00 9.122316611304615e+03 + 183920 1.010900233183605e+00 -5.968147151589728e+00 -6.024823274136601e+00 3.888544948699880e+00 4.563101882434117e+00 9.293399598891627e+03 + 183940 9.838686943026379e-01 -5.873701632503632e+00 -6.065610282697635e+00 4.367544241598011e+00 4.265575074416405e+00 9.419557749610267e+03 + 183960 1.053601058613419e+00 -5.934416635874749e+00 -6.015361332600828e+00 4.085531834369297e+00 4.620734859616814e+00 9.264244314409852e+03 + 183980 1.011713937995149e+00 -5.845058757127666e+00 -6.026299590386820e+00 4.545111459469327e+00 4.504398547966959e+00 9.297965546287960e+03 + 184000 1.110118649392717e+00 -5.977154801176939e+00 -6.016064671568905e+00 3.822194408857061e+00 4.598767911783404e+00 9.266414810016317e+03 + 184020 1.051991651443827e+00 -5.887919308189043e+00 -5.969747358485749e+00 4.336434634397450e+00 4.866565306743907e+00 9.124398638239798e+03 + 184040 1.098882870242725e+00 -5.961505800250821e+00 -5.994440542809387e+00 3.927392050169627e+00 4.738275661763404e+00 9.199950091105951e+03 + 184060 1.035466889658421e+00 -5.877081148298771e+00 -6.008914917518497e+00 4.327248302342611e+00 4.570238398273092e+00 9.244436230156527e+03 + 184080 1.078515627536226e+00 -5.957127649137883e+00 -6.027585810914584e+00 3.906109584918595e+00 4.501527916631483e+00 9.301912791213688e+03 + 184100 1.038223650467996e+00 -5.922731292643221e+00 -6.016237441399646e+00 4.078836444662191e+00 4.541909668473037e+00 9.266945569870393e+03 + 184120 1.045827628646379e+00 -5.960567978324763e+00 -5.994701987418697e+00 3.901278722376712e+00 4.705275959938502e+00 9.200792113875821e+03 + 184140 9.781605051897939e-01 -5.890310313094882e+00 -6.061824887689260e+00 4.286155935048116e+00 4.301292705932555e+00 9.407790869116872e+03 + 184160 1.056042822797573e+00 -6.036098395732020e+00 -5.997356861890220e+00 3.482171159039827e+00 4.704631041592435e+00 9.208951458281343e+03 + 184180 1.010173470243720e+00 -5.993577471525382e+00 -5.979013488970035e+00 3.767665540684176e+00 4.851294182285996e+00 9.152737805472940e+03 + 184200 1.052497175969134e+00 -6.077715936045644e+00 -5.993202739870577e+00 3.258547978767605e+00 4.743835829579681e+00 9.196208432942707e+03 + 184220 9.528297002243094e-01 -5.947130735282414e+00 -6.054568476559050e+00 3.973568236234311e+00 4.356644099887139e+00 9.385330635655017e+03 + 184240 9.871815263813776e-01 -6.013568698915368e+00 -5.976166471482038e+00 3.617475615620102e+00 4.832244993518279e+00 9.144036756662159e+03 + 184260 9.156574686081256e-01 -5.916953406055957e+00 -5.976295841734558e+00 4.189211475938760e+00 4.848458027059992e+00 9.144421104854828e+03 + 184280 1.016007496502646e+00 -6.069215417145420e+00 -5.976527635665899e+00 3.361635366090836e+00 4.893862950734074e+00 9.145123706294808e+03 + 184300 9.587601734473629e-01 -5.984931827692202e+00 -6.028795732127411e+00 3.799501875034164e+00 4.547628547849924e+00 9.305642792755758e+03 + 184320 9.779364809249865e-01 -6.012838660069846e+00 -5.993899466867044e+00 3.621211936441520e+00 4.729963714642690e+00 9.198315642655483e+03 + 184340 9.838778107739444e-01 -6.019186284178160e+00 -5.987568351101640e+00 3.618496039141967e+00 4.800051103726674e+00 9.178923062461423e+03 + 184360 1.007402964405228e+00 -6.050066346971223e+00 -5.979259145830998e+00 3.458541357484671e+00 4.865127263810805e+00 9.153483656530809e+03 + 184380 9.725585467029291e-01 -5.992889577430406e+00 -6.011237588541381e+00 3.723886529336675e+00 4.618529410191910e+00 9.251563542096173e+03 + 184400 1.021473705158710e+00 -6.057491639632749e+00 -5.993936964538010e+00 3.403705209743035e+00 4.768645989191213e+00 9.198466726327053e+03 + 184420 1.031311436481565e+00 -6.063377039869460e+00 -5.984060694662572e+00 3.355107476477176e+00 4.810554204819880e+00 9.168197121373743e+03 + 184440 1.004252072994218e+00 -6.015217316621763e+00 -6.005317682447428e+00 3.621679639035548e+00 4.678524870428019e+00 9.233379560720236e+03 + 184460 1.061588354928094e+00 -6.091589738317410e+00 -5.992360688078429e+00 3.252827474314339e+00 4.822616036432461e+00 9.193600706931946e+03 + 184480 1.030105727896354e+00 -6.037179347538536e+00 -6.012622642106184e+00 3.526688944047745e+00 4.667697346778196e+00 9.255855248811540e+03 + 184500 1.033458043315452e+00 -6.031617222320730e+00 -6.010430519006556e+00 3.557499510714897e+00 4.679156839776622e+00 9.249111225743338e+03 + 184520 9.515787209968618e-01 -5.898384525323422e+00 -6.041580344699914e+00 4.263032265388995e+00 4.440779711047750e+00 9.345128493099972e+03 + 184540 1.043170403146162e+00 -6.016641265845783e+00 -6.001275422443378e+00 3.611001612074698e+00 4.699234662747891e+00 9.220962024485900e+03 + 184560 1.061498061712716e+00 -6.017157297070371e+00 -5.988500025645300e+00 3.634983681002874e+00 4.799538168224052e+00 9.181787301083905e+03 + 184580 1.029236570540878e+00 -5.935119534523276e+00 -6.009329218064535e+00 4.071734706055832e+00 4.645611219250510e+00 9.245693139762319e+03 + 184600 1.031029692956090e+00 -5.898842704358213e+00 -6.052419752307454e+00 4.240394899101300e+00 4.358531723805397e+00 9.378631798380102e+03 + 184620 1.027657499595159e+00 -5.856948109936418e+00 -6.035054848421307e+00 4.465709329421095e+00 4.442992875112158e+00 9.324977177317289e+03 + 184640 1.104726445797538e+00 -5.939627487930865e+00 -6.022776481123362e+00 4.030826570073442e+00 4.553372183897015e+00 9.287096981394527e+03 + 184660 1.141292422252629e+00 -5.973499914847106e+00 -6.070501804633727e+00 3.785968828479118e+00 4.228968966330410e+00 9.434749428820847e+03 + 184680 1.063035697725606e+00 -5.852230676329455e+00 -6.096132746732304e+00 4.440706608270899e+00 4.040183176294328e+00 9.514523448591759e+03 + 184700 1.090900584087680e+00 -5.902678074258304e+00 -6.032605910353370e+00 4.164460582410079e+00 4.418394841284562e+00 9.317411845991241e+03 + 184720 1.019292156284217e+00 -5.816645029941313e+00 -6.047532460795942e+00 4.690344496563575e+00 4.364553138881845e+00 9.363499143213323e+03 + 184740 1.109292941476850e+00 -5.978299616272839e+00 -6.016480121935713e+00 3.768633158980165e+00 4.549394787049787e+00 9.267688742788072e+03 + 184760 1.045214074605613e+00 -5.922398334334043e+00 -6.048715268296599e+00 4.070183196182008e+00 4.344851813886655e+00 9.367219773828210e+03 + 184780 1.043895848461791e+00 -5.966536341474749e+00 -6.026614929669050e+00 3.855342169246426e+00 4.510361618703282e+00 9.298921883190262e+03 + 184800 9.742464213411808e-01 -5.903780444945077e+00 -6.030961090535593e+00 4.216161437121597e+00 4.485870488999557e+00 9.312326457237796e+03 + 184820 1.038251467987524e+00 -6.031569277917167e+00 -6.003827057036464e+00 3.539413738191214e+00 4.698713863583020e+00 9.228801977052244e+03 + 184840 1.025315054422569e+00 -6.037849753889736e+00 -5.979074358714123e+00 3.494896697030291e+00 4.832394111591670e+00 9.152941723144519e+03 + 184860 9.341307659176772e-01 -5.922828443192557e+00 -5.987095997602385e+00 4.140913908536599e+00 4.771879665743467e+00 9.177450819495547e+03 + 184880 9.695440296921758e-01 -5.986407863705953e+00 -5.997480225262516e+00 3.777991843041167e+00 4.714412629540968e+00 9.209296196999187e+03 + 184900 9.884508013782041e-01 -6.020796918118061e+00 -6.035543564959017e+00 3.568378334528847e+00 4.483700806331854e+00 9.326466286159031e+03 + 184920 9.671258445295973e-01 -5.996011725792417e+00 -5.989397384119241e+00 3.700816978502375e+00 4.738797551955822e+00 9.184532495014910e+03 + 184940 9.456525612851926e-01 -5.968067622676734e+00 -5.971647299665113e+00 3.885257606414527e+00 4.864702547194026e+00 9.130208380158592e+03 + 184960 9.975889583994834e-01 -6.045253738329905e+00 -5.979336686852395e+00 3.472394740796420e+00 4.850900651011025e+00 9.153713012575279e+03 + 184980 9.401807168448983e-01 -5.956360517021791e+00 -5.997952494561053e+00 3.863198791041339e+00 4.624371219673171e+00 9.210767712803021e+03 + 185000 9.041176593845776e-01 -5.895822743639059e+00 -6.008804947158706e+00 4.218115625420680e+00 4.569354328871377e+00 9.244071266898658e+03 + 185020 1.003982056674882e+00 -6.032854501747692e+00 -6.004398498254497e+00 3.544184918044214e+00 4.707583693654446e+00 9.230550271948190e+03 + 185040 1.015873229456205e+00 -6.037025625825211e+00 -5.974225259522392e+00 3.493664839272701e+00 4.854274260908768e+00 9.138095551201633e+03 + 185060 1.018531373676182e+00 -6.024412355959226e+00 -5.988387250088391e+00 3.568948564546045e+00 4.775810297323496e+00 9.181445040174409e+03 + 185080 1.000638322041537e+00 -5.978595249195068e+00 -6.040616498056051e+00 3.797551554879471e+00 4.441415946162461e+00 9.342164233010717e+03 + 185100 1.007416828273757e+00 -5.967512268864924e+00 -6.053616431320521e+00 3.852188372707908e+00 4.357764947311796e+00 9.382396936508509e+03 + 185120 1.040261656798839e+00 -5.991255045036958e+00 -5.994535944198516e+00 3.785803989730864e+00 4.766964559027697e+00 9.200303043320489e+03 + 185140 1.034779990962368e+00 -5.958288055460671e+00 -6.012842933140750e+00 3.910864682753278e+00 4.597602132774230e+00 9.256516819275228e+03 + 185160 1.072888847478848e+00 -5.986526973507564e+00 -5.977014087272437e+00 3.800746391910415e+00 4.855370856786902e+00 9.146613249233180e+03 + 185180 1.028143229372419e+00 -5.890594843565127e+00 -5.988741535359881e+00 4.303938080730618e+00 4.740364588293672e+00 9.182486527331233e+03 + 185200 1.000750417767579e+00 -5.821220060443945e+00 -5.983535419842143e+00 4.568208379458863e+00 4.636168467573721e+00 9.166528635904477e+03 + 185220 1.022982967666760e+00 -5.822740110476578e+00 -5.974354369427646e+00 4.622437906291779e+00 4.751845369163998e+00 9.138433790810614e+03 + 185240 1.053789858100241e+00 -5.836152899512858e+00 -5.988415972527819e+00 4.516509250429876e+00 4.642191122543573e+00 9.181457927189302e+03 + 185260 1.130107318262074e+00 -5.918863091151801e+00 -5.982952227795077e+00 4.123051272351912e+00 4.755041531984378e+00 9.164776936622173e+03 + 185280 1.070744715427829e+00 -5.806406913895175e+00 -6.070323258488806e+00 4.734436683426211e+00 4.218988191847255e+00 9.434178835866833e+03 + 185300 1.168209572999858e+00 -5.941979528439012e+00 -6.062736506652255e+00 3.947251534304493e+00 4.253846278322064e+00 9.410641547132447e+03 + 185320 1.099026889565406e+00 -5.850946837601781e+00 -6.028927267886548e+00 4.518498482513463e+00 4.496507309435760e+00 9.306021171600576e+03 + 185340 1.078446184938955e+00 -5.848849364766389e+00 -5.984254412912240e+00 4.484777819444444e+00 4.707261079127487e+00 9.168796988452532e+03 + 185360 1.098162745942777e+00 -5.923413104758728e+00 -6.068116143809597e+00 4.045182239274698e+00 4.214274996321687e+00 9.427345234071579e+03 + 185380 1.041846598400082e+00 -5.904470806242720e+00 -6.032424401698130e+00 4.226536872901185e+00 4.491807527041325e+00 9.316839491183591e+03 + 185400 1.029157943363053e+00 -5.945659304819125e+00 -5.982114275524933e+00 4.059448261405571e+00 4.850118178224335e+00 9.162194318624717e+03 + 185420 1.029198263354715e+00 -5.988325874183715e+00 -5.981877729898676e+00 3.846169754868704e+00 4.883195997200506e+00 9.161486081196907e+03 + 185440 9.670405769970989e-01 -5.921791465862795e+00 -6.049304036762996e+00 4.048772467720456e+00 4.316575553104935e+00 9.369024029145459e+03 + 185460 9.327855768417140e-01 -5.889773341735926e+00 -6.006260876193060e+00 4.298963866996800e+00 4.630074417756240e+00 9.236229542721157e+03 + 185480 9.912101864343976e-01 -5.987857365711900e+00 -5.992209700174170e+00 3.772482401691135e+00 4.747490623687196e+00 9.193094191915112e+03 + 185500 1.018496577791338e+00 -6.035888373877107e+00 -5.984603237468292e+00 3.506599036628273e+00 4.801086226236901e+00 9.169819971660090e+03 + 185520 1.010354190864812e+00 -6.028653006326449e+00 -5.995390241266351e+00 3.531565069621988e+00 4.722565013993326e+00 9.202883881822210e+03 + 185540 9.268431003901618e-01 -5.911049793676989e+00 -6.015786024946857e+00 4.166534701587460e+00 4.565123053756472e+00 9.265549522080117e+03 + 185560 1.009421387056205e+00 -6.038274071522450e+00 -5.974534145513069e+00 3.503476254250542e+00 4.869480773118075e+00 9.139060326328748e+03 + 185580 9.910767747663354e-01 -6.015412782515984e+00 -6.018407008991261e+00 3.581877779443277e+00 4.564684467667185e+00 9.273659730457890e+03 + 185600 9.701700294042073e-01 -5.988307953147064e+00 -5.970354505120878e+00 3.792071089952945e+00 4.895162566806411e+00 9.126267097639053e+03 + 185620 9.797124562966963e-01 -6.003213575426982e+00 -5.989526756585840e+00 3.659115322264248e+00 4.737707154078457e+00 9.184898236746123e+03 + 185640 9.433616013586430e-01 -5.946724690532390e+00 -6.027814334433953e+00 3.997952106999838e+00 4.532322823135225e+00 9.302622538765001e+03 + 185660 9.186120817489071e-01 -5.906681229967679e+00 -6.065914302091246e+00 4.107180902055314e+00 4.192839960683520e+00 9.420521097689680e+03 + 185680 1.004781046611605e+00 -6.031202407178282e+00 -5.986819370738830e+00 3.528549773148095e+00 4.783404036636121e+00 9.176624405371240e+03 + 185700 9.161781652028301e-01 -5.893488313492351e+00 -5.982474174392390e+00 4.269815156882800e+00 4.758844573077307e+00 9.163308985528527e+03 + 185720 9.761427585098773e-01 -5.971626011338190e+00 -5.984362860624346e+00 3.857539105206446e+00 4.784402145584286e+00 9.169073344821705e+03 + 185740 9.760210997188503e-01 -5.953566634546820e+00 -6.013306135800674e+00 3.903336871952940e+00 4.560303411095371e+00 9.257938590479915e+03 + 185760 1.033266980782642e+00 -6.018849238562722e+00 -5.991556208511069e+00 3.581361099108338e+00 4.738081901247680e+00 9.191149563849791e+03 + 185780 1.041965821483321e+00 -6.010554278638002e+00 -5.992890280043696e+00 3.670929579544791e+00 4.772358992968242e+00 9.195238011845764e+03 + 185800 1.047665326713946e+00 -5.995777238739688e+00 -6.022434798821588e+00 3.702348612928393e+00 4.549276777694033e+00 9.286031544330706e+03 + 185820 1.048720421351691e+00 -5.977319830451124e+00 -5.965030601448968e+00 3.847682997050328e+00 4.918249651732756e+00 9.109992410159126e+03 + 185840 9.457119008522243e-01 -5.803715945821020e+00 -6.022723056158099e+00 4.714445817000475e+00 4.456873098204176e+00 9.286896316487671e+03 + 185860 1.047437938874544e+00 -5.933787310753452e+00 -6.007476483903579e+00 4.032893084386848e+00 4.609758448796127e+00 9.240014990662936e+03 + 185880 1.095977677254185e+00 -5.987514796487254e+00 -5.968431589422411e+00 3.816966238653442e+00 4.926544966736518e+00 9.120376476236226e+03 + 185900 9.976802104975052e-01 -5.827678569556628e+00 -6.029626937520445e+00 4.580691989469514e+00 4.421073209212337e+00 9.308196257288848e+03 + 185920 1.076624926092300e+00 -5.934216923147818e+00 -6.032216618917353e+00 4.026218337021944e+00 4.463488918509369e+00 9.316203843990366e+03 + 185940 1.088192628649703e+00 -5.947148549720774e+00 -6.034207840880567e+00 3.978059212325609e+00 4.478151290104314e+00 9.322372291511872e+03 + 185960 1.045301471878106e+00 -5.889827428930012e+00 -6.078533214689987e+00 4.225569670483142e+00 4.141991846523399e+00 9.459690106103961e+03 + 185980 1.072575044503015e+00 -5.952481211335395e+00 -6.029228960794081e+00 3.886679022106483e+00 4.445981568038864e+00 9.306997377709622e+03 + 186000 1.042779047565370e+00 -5.944028417302754e+00 -6.014041746713178e+00 3.966204674364099e+00 4.564177302361729e+00 9.260195752954429e+03 + 186020 1.031020652703580e+00 -5.974417312331937e+00 -5.990690049983575e+00 3.807461751410843e+00 4.714021173617125e+00 9.188466415885779e+03 + 186040 1.022527084902250e+00 -6.013150204376615e+00 -5.962777455998066e+00 3.627059022196265e+00 4.916307138543512e+00 9.103135954684012e+03 + 186060 1.002518746327171e+00 -6.027686768331249e+00 -5.983424407849368e+00 3.516118787117454e+00 4.770280110582561e+00 9.166228960518303e+03 + 186080 1.001107748930780e+00 -6.057269439067742e+00 -5.985613465670408e+00 3.411915473960787e+00 4.823375161934327e+00 9.172952352347271e+03 + 186100 9.346612492110948e-01 -5.982096172669222e+00 -6.030515383905172e+00 3.737526460955635e+00 4.459495857190087e+00 9.310975497276515e+03 + 186120 9.252253017078199e-01 -5.982263087367459e+00 -5.986927864716431e+00 3.762735403171366e+00 4.735949529761609e+00 9.176992200764860e+03 + 186140 1.009328479376835e+00 -6.115518354520454e+00 -5.939788039712223e+00 3.078518742065147e+00 5.087589403872339e+00 9.033141018430973e+03 + 186160 9.071215853102388e-01 -5.965393607522716e+00 -5.964911900846257e+00 3.944492196482396e+00 4.947258230762493e+00 9.109646249371166e+03 + 186180 9.753669573614483e-01 -6.061725818932347e+00 -5.984841540199401e+00 3.410516749212121e+00 4.851998175500375e+00 9.170566250487909e+03 + 186200 1.013581517416732e+00 -6.108692787018881e+00 -5.996613509175106e+00 3.124645091349650e+00 4.768221648940797e+00 9.206654649200524e+03 + 186220 9.427096023164401e-01 -5.990842832261961e+00 -6.033101983846658e+00 3.721637613737844e+00 4.478979025755941e+00 9.318935205612370e+03 + 186240 9.930794779060100e-01 -6.051693343526072e+00 -6.017173325663627e+00 3.398056915782077e+00 4.596276200303733e+00 9.269859204286917e+03 + 186260 9.928647918049680e-01 -6.034153996944970e+00 -6.009071309733171e+00 3.500445931818847e+00 4.644474603322299e+00 9.244917714191482e+03 + 186280 9.556215879350598e-01 -5.960056525916730e+00 -6.032447688295306e+00 3.929971326369039e+00 4.514290069495080e+00 9.316923411982598e+03 + 186300 1.050262832942374e+00 -6.079448687006836e+00 -6.015398448514189e+00 3.250322072543391e+00 4.618108453710546e+00 9.264384475450588e+03 + 186320 9.931332608766693e-01 -5.972826506600821e+00 -6.031386936056980e+00 3.785749302618346e+00 4.449486254483914e+00 9.313647664284130e+03 + 186340 1.027496507631874e+00 -6.002227440521472e+00 -5.998013908890345e+00 3.654407945194948e+00 4.678602695862788e+00 9.210949689678182e+03 + 186360 1.013260164462804e+00 -5.957849972041716e+00 -5.979991951979196e+00 3.915074528696894e+00 4.787931853435561e+00 9.155732514468869e+03 + 186380 9.818742084576281e-01 -5.887577047843616e+00 -6.012411302993200e+00 4.236963516594397e+00 4.520145905486936e+00 9.255171994958682e+03 + 186400 1.046742321383515e+00 -5.958332355320721e+00 -5.992220420003236e+00 3.885097777733995e+00 4.690507266165930e+00 9.193168901795190e+03 + 186420 1.001371579335905e+00 -5.865235488279005e+00 -6.059275830058220e+00 4.347374642559789e+00 4.233164972417692e+00 9.399880628048390e+03 + 186440 1.070587606439025e+00 -5.942004385211278e+00 -6.040736197193956e+00 4.018045897569773e+00 4.451112554466707e+00 9.342487507183301e+03 + 186460 1.102999821052950e+00 -5.965442257190348e+00 -5.983039891920763e+00 3.880276782152912e+00 4.779228440305693e+00 9.165052461013862e+03 + 186480 1.082521851725404e+00 -5.912743740355033e+00 -5.957050216337508e+00 4.159568628372348e+00 4.905153986875981e+00 9.085658321487705e+03 + 186500 1.110756833269781e+00 -5.929799395166510e+00 -6.000045746160557e+00 4.044663502556188e+00 4.641298084560688e+00 9.217179066404942e+03 + 186520 1.112104601301257e+00 -5.906943589715880e+00 -6.025641801041936e+00 4.222681417298498e+00 4.541097919375447e+00 9.295908766682989e+03 + 186540 1.057704881332429e+00 -5.807941166093006e+00 -6.014377594241997e+00 4.765888252993046e+00 4.580498336627525e+00 9.261218401192284e+03 + 186560 1.122404897818578e+00 -5.887779795466338e+00 -6.038975292861270e+00 4.291511837853871e+00 4.423323894384568e+00 9.337047635681069e+03 + 186580 1.091702189816600e+00 -5.837290217142248e+00 -6.065536886983222e+00 4.592688366563687e+00 4.282060667278814e+00 9.419327910744425e+03 + 186600 1.144381761928308e+00 -5.927228735512145e+00 -6.037417959232600e+00 4.084296855095796e+00 4.451573280765682e+00 9.332275347104580e+03 + 186620 1.119825147553620e+00 -5.923845726061165e+00 -6.018903880057690e+00 4.138520117295672e+00 4.592681486845841e+00 9.275168900948436e+03 + 186640 1.024519136182959e+00 -5.829064457750234e+00 -6.029548911098603e+00 4.557460102667097e+00 4.406247346671873e+00 9.308011092586481e+03 + 186660 1.056929967585875e+00 -5.929810545718619e+00 -6.015497285489076e+00 4.088936383730128e+00 4.596909863988039e+00 9.264693661696401e+03 + 186680 1.024957747914378e+00 -5.933034660228435e+00 -6.018152434781978e+00 4.021810679580685e+00 4.533051246161197e+00 9.272843249775946e+03 + 186700 1.058833983117284e+00 -6.024860347020438e+00 -5.974027380096007e+00 3.585780379732756e+00 4.877671142189048e+00 9.137471656379115e+03 + 186720 1.062613261405321e+00 -6.064948477899399e+00 -5.982014174308262e+00 3.382623031455032e+00 4.858844636717349e+00 9.161921324331519e+03 + 186740 1.010385322587362e+00 -6.015130667549718e+00 -6.028413807328409e+00 3.528538839633257e+00 4.452264995464778e+00 9.304484539406343e+03 + 186760 9.743172766219365e-01 -5.984220005211003e+00 -6.039967586287172e+00 3.744931713411144e+00 4.424820475961488e+00 9.340125449283481e+03 + 186780 1.030423860279781e+00 -6.085737034418922e+00 -5.989832629873499e+00 3.253819205773300e+00 4.804517137831759e+00 9.185862261988475e+03 + 186800 1.010178131546324e+00 -6.069651997730382e+00 -5.992221382154328e+00 3.345933972758810e+00 4.790552549745546e+00 9.193171861844710e+03 + 186820 9.400084104397697e-01 -5.978509258022677e+00 -5.979219642872318e+00 3.798614300705335e+00 4.794535160966994e+00 9.153373183164837e+03 + 186840 9.801768515088850e-01 -6.047218961517502e+00 -5.988214291746822e+00 3.424307057771874e+00 4.763121002538258e+00 9.180891672866304e+03 + 186860 9.649202174065267e-01 -6.028921368292059e+00 -6.000581687277425e+00 3.578695585774806e+00 4.741426419712297e+00 9.218835587206304e+03 + 186880 9.883318567481777e-01 -6.065996271725696e+00 -5.989520194166037e+00 3.355989315853136e+00 4.795126787835459e+00 9.184917832502742e+03 + 186900 9.303828721863562e-01 -5.978827212756742e+00 -6.008154242868232e+00 3.792651613460669e+00 4.624251268217257e+00 9.242074076582929e+03 + 186920 9.987186763006329e-01 -6.075707344598140e+00 -5.956324462895100e+00 3.324555811374710e+00 5.010070792554799e+00 9.083451158194463e+03 + 186940 9.556223143675261e-01 -5.999897377397238e+00 -5.993212909649419e+00 3.632912452579089e+00 4.671295700805105e+00 9.196236280133311e+03 + 186960 9.661932948032397e-01 -5.999351705670685e+00 -5.997545054246227e+00 3.681383608994689e+00 4.691757681052334e+00 9.209511080259645e+03 + 186980 9.331371712050814e-01 -5.926986069516897e+00 -6.027834303892449e+00 4.131729260666040e+00 4.552643092667792e+00 9.302681307931265e+03 + 187000 9.991620043512178e-01 -5.995421436362049e+00 -6.038684044620863e+00 3.706944199539496e+00 4.458523608050390e+00 9.336185826117948e+03 + 187020 9.984252806061611e-01 -5.962374346262470e+00 -6.055518668438074e+00 3.920552748890816e+00 4.385703636921223e+00 9.388260284358616e+03 + 187040 1.045041356016762e+00 -6.002259238126165e+00 -6.021324109913393e+00 3.718074730318998e+00 4.608601286237363e+00 9.282612375518893e+03 + 187060 1.020335070437836e+00 -5.938226042769958e+00 -6.017822754234155e+00 4.053193662118691e+00 4.596137027339985e+00 9.271850576427871e+03 + 187080 1.057466697787437e+00 -5.966960619237297e+00 -6.036848378482438e+00 3.881776704133240e+00 4.480470375451851e+00 9.330516066549841e+03 + 187100 1.028835666131603e+00 -5.904610069214259e+00 -6.063731561469718e+00 4.202430842376371e+00 4.288730609874181e+00 9.413745958365696e+03 + 187120 1.036828196275169e+00 -5.904750651544834e+00 -6.057442399314407e+00 4.175345079610089e+00 4.298565434945599e+00 9.394253467310918e+03 + 187140 1.036712300123146e+00 -5.900042770636301e+00 -6.072285139640308e+00 4.230334886932079e+00 4.241292549690612e+00 9.440288501625588e+03 + 187160 1.054495050016417e+00 -5.931311794907593e+00 -6.033576356000159e+00 4.116609605077056e+00 4.529390669893862e+00 9.320409689866718e+03 + 187180 1.090704149942278e+00 -6.000023712358605e+00 -5.974105212716631e+00 3.708421623833032e+00 4.857249659652105e+00 9.137742305979056e+03 + 187200 1.045427661679310e+00 -5.956619937390156e+00 -5.986364725431453e+00 3.945211893776597e+00 4.774412717852401e+00 9.175212674283095e+03 + 187220 1.067513209096400e+00 -6.026568558345110e+00 -5.959852532799883e+00 3.567312062827479e+00 4.950405805779758e+00 9.094227370306920e+03 + 187240 1.022224273167519e+00 -6.012710704790606e+00 -6.024270150414243e+00 3.622242391123824e+00 4.555866265534467e+00 9.291701357125254e+03 + 187260 9.392689337615499e-01 -5.952363271049459e+00 -5.988648767811608e+00 3.939674022588872e+00 4.731317085018141e+00 9.182223427525465e+03 + 187280 9.356925570078081e-01 -5.996583260063040e+00 -5.952089575682574e+00 3.727798541192985e+00 4.983288162281021e+00 9.070547095173159e+03 + 187300 9.628790555559413e-01 -6.065952055700597e+00 -5.974760706671912e+00 3.324132808765250e+00 4.847767646703615e+00 9.139743742593135e+03 + 187320 9.403934061492137e-01 -6.048161510123434e+00 -5.975542472921589e+00 3.438357639969778e+00 4.855347389342456e+00 9.142107919759279e+03 + 187340 9.109138045319671e-01 -6.008700321065351e+00 -5.939195128625794e+00 3.629422236291495e+00 5.028531807173202e+00 9.031320918590029e+03 + 187360 9.807769712653686e-01 -6.107741700928441e+00 -5.984776332736314e+00 3.125663815397996e+00 4.831749988386422e+00 9.170365744815108e+03 + 187380 9.621917439100052e-01 -6.072075103730400e+00 -5.959665627458695e+00 3.320952435596486e+00 4.966425043658850e+00 9.093661982714981e+03 + 187400 9.557826198092048e-01 -6.050218742520419e+00 -6.011110642850433e+00 3.395144327491002e+00 4.619709087754932e+00 9.251197161312601e+03 + 187420 9.772799359262452e-01 -6.064640502213159e+00 -6.012882372667359e+00 3.335056001062638e+00 4.632259190459282e+00 9.256655208796059e+03 + 187440 9.799800524139662e-01 -6.050615542890261e+00 -5.986662165575053e+00 3.436293623008029e+00 4.803523812305105e+00 9.176161079788431e+03 + 187460 9.575846475440787e-01 -5.996023255264544e+00 -6.027843002498814e+00 3.674622561506429e+00 4.491908648797277e+00 9.302697803611158e+03 + 187480 9.853973628938401e-01 -6.012411389526036e+00 -6.021623021927882e+00 3.597663511163769e+00 4.544768892416867e+00 9.283567363091111e+03 + 187500 1.042031988659263e+00 -6.072998865980701e+00 -6.004134748391932e+00 3.312711572156664e+00 4.708139992039136e+00 9.229741007117545e+03 + 187520 9.459167420619240e-01 -5.908330927637697e+00 -6.038696637770089e+00 4.161061459462107e+00 4.412481377853467e+00 9.336218964881467e+03 + 187540 1.003123019467519e+00 -5.973195836020475e+00 -5.990695519065680e+00 3.854359602481891e+00 4.753873714369124e+00 9.188492478969363e+03 + 187560 9.443921395664403e-01 -5.867020938410749e+00 -6.034420338837155e+00 4.418001604017006e+00 4.456768341795092e+00 9.323005210359141e+03 + 187580 1.037085868160331e+00 -5.985826394509319e+00 -6.034608619555526e+00 3.799127742623312e+00 4.519012657383062e+00 9.323588661495318e+03 + 187600 9.864672952387298e-01 -5.897895957369727e+00 -6.041903878747088e+00 4.259828923477037e+00 4.432913153774417e+00 9.346077796199081e+03 + 187620 9.942385089514749e-01 -5.900011919640180e+00 -6.017663738886242e+00 4.117722223895990e+00 4.442147271224916e+00 9.271347905178993e+03 + 187640 1.058167750799638e+00 -5.987700109794499e+00 -5.992290798075151e+00 3.824739026526899e+00 4.798378584012676e+00 9.193389323620677e+03 + 187660 1.006612262481241e+00 -5.908386393495501e+00 -6.004811893663032e+00 4.197488635163195e+00 4.643798491403312e+00 9.231805151247338e+03 + 187680 1.005181018295197e+00 -5.906192200391622e+00 -6.040425995970099e+00 4.191677070786325e+00 4.420885843961980e+00 9.341565579499489e+03 + 187700 1.087735861352167e+00 -6.034980940595824e+00 -5.979125084925866e+00 3.508467966557406e+00 4.829200933480037e+00 9.153089901549889e+03 + 187720 1.008770670578979e+00 -5.932022176273186e+00 -6.051299577696961e+00 4.013758168474073e+00 4.328848871380544e+00 9.375175494248097e+03 + 187740 1.061813157611948e+00 -6.038553664861821e+00 -6.002791828115599e+00 3.478734042341010e+00 4.684084043064168e+00 9.225624918447626e+03 + 187760 9.520806639350479e-01 -5.918188281174189e+00 -6.022680771618656e+00 4.125454869150070e+00 4.525442818857303e+00 9.286806407540860e+03 + 187780 1.015521256191388e+00 -6.069463876343882e+00 -5.973765058889539e+00 3.349901168244129e+00 4.899418587411104e+00 9.136687806990671e+03 + 187800 9.742852545814802e-01 -6.063996999484311e+00 -5.968085470529485e+00 3.328708738627806e+00 4.879447580147554e+00 9.119371584052340e+03 + 187820 1.041995785607911e+00 -6.205699088085471e+00 -5.969308093862208e+00 2.581452016404254e+00 4.938845686622366e+00 9.123082730854941e+03 + 187840 8.873951637501517e-01 -6.003614124832986e+00 -6.002305278415308e+00 3.618488577710471e+00 4.626004176384100e+00 9.224136068400141e+03 + 187860 8.884534120266929e-01 -6.018066424377311e+00 -6.020389388739895e+00 3.546918274087910e+00 4.533579453240376e+00 9.279752057838505e+03 + 187880 9.499169670531472e-01 -6.112554303417117e+00 -5.974668006635110e+00 3.081906387804145e+00 4.873670841761898e+00 9.139458374755139e+03 + 187900 9.339703228851576e-01 -6.085246463337047e+00 -5.993225902299603e+00 3.222420443424719e+00 4.750816745037522e+00 9.196275372939022e+03 + 187920 9.733347136159928e-01 -6.133435766718804e+00 -5.962601212835068e+00 2.991868010727253e+00 4.972826455689443e+00 9.102628177527518e+03 + 187940 9.122608480012248e-01 -6.025798087472030e+00 -6.022037057166010e+00 3.523751337315139e+00 4.545347755349866e+00 9.284813710113087e+03 + 187960 1.012408855575704e+00 -6.151796177276626e+00 -6.007036952095621e+00 2.879996335314077e+00 4.711226207721109e+00 9.238673286279251e+03 + 187980 9.261735775762988e-01 -5.998518478473338e+00 -6.005898964863691e+00 3.733738602237448e+00 4.691358707257463e+00 9.235170666587412e+03 + 188000 1.006979360091281e+00 -6.090922781296095e+00 -5.973689148766391e+00 3.194824674238758e+00 4.867998334070318e+00 9.136448908195265e+03 + 188020 9.850216271568561e-01 -6.026511343500488e+00 -5.987485683698942e+00 3.547759818977604e+00 4.771851196759415e+00 9.178687479184577e+03 + 188040 9.728051688498196e-01 -5.978882442037638e+00 -6.040707707542766e+00 3.810819762324150e+00 4.455809520364792e+00 9.342432442740912e+03 + 188060 9.818992863502871e-01 -5.967360994249038e+00 -6.051806674529895e+00 3.843290445012227e+00 4.358390280912755e+00 9.376797487614462e+03 + 188080 1.052297393176537e+00 -6.053772281587420e+00 -6.007199865711026e+00 3.386847070553766e+00 4.654273089574086e+00 9.239178126587127e+03 + 188100 1.046893205829760e+00 -6.034000159693503e+00 -5.966020302881568e+00 3.533604878423872e+00 4.923955736086846e+00 9.113022679077165e+03 + 188120 9.521012300317291e-01 -5.883174474022115e+00 -5.987705278305032e+00 4.350685076781486e+00 4.750453022499295e+00 9.179328893989930e+03 + 188140 1.022710526411044e+00 -5.978865719726636e+00 -6.018254225589109e+00 3.804860003894003e+00 4.578685107880103e+00 9.273155646889229e+03 + 188160 9.908140413471827e-01 -5.926169113731577e+00 -6.049368239620392e+00 4.093709494059851e+00 4.386281048203156e+00 9.369209275864427e+03 + 188180 1.115620967231093e+00 -6.110405688709008e+00 -5.959117822728169e+00 3.132003116635469e+00 5.000721454819043e+00 9.091977548125928e+03 + 188200 1.082200491609300e+00 -6.064188800062556e+00 -5.958756100298021e+00 3.371521365732900e+00 4.976932243438421e+00 9.090856239748764e+03 + 188220 9.741879427639298e-01 -5.907428084409361e+00 -6.022549504373215e+00 4.239562623166187e+00 4.578517614751576e+00 9.286336194245199e+03 + 188240 1.014144461705364e+00 -5.971522520701200e+00 -5.997553752918042e+00 3.828389989412096e+00 4.678914625702819e+00 9.209507770334843e+03 + 188260 1.021338988104697e+00 -5.987889585626456e+00 -5.981397613978544e+00 3.805669882213746e+00 4.842947788045425e+00 9.160015725376503e+03 + 188280 1.026720541473632e+00 -6.005079485500787e+00 -5.978384006327485e+00 3.679133033869279e+00 4.832422606394426e+00 9.150788797659618e+03 + 188300 1.014412033138585e+00 -5.997365852915326e+00 -5.963878368850643e+00 3.764846020533017e+00 4.957136336203842e+00 9.106483348781998e+03 + 188320 9.784395763381555e-01 -5.954300729660013e+00 -5.993134424784777e+00 4.038073484019431e+00 4.815084397118141e+00 9.195963604363009e+03 + 188340 1.046884300723660e+00 -6.068811369413000e+00 -5.994509055645652e+00 3.295150546747851e+00 4.721805930645853e+00 9.200211726056830e+03 + 188360 9.976467994626792e-01 -6.015912325694622e+00 -5.986090056404239e+00 3.601546112545385e+00 4.772790197792022e+00 9.174406099815271e+03 + 188380 1.034389278159326e+00 -6.102251791847856e+00 -5.989023563813575e+00 3.113167676810151e+00 4.763341684194653e+00 9.183378704445320e+03 + 188400 9.396382743144147e-01 -6.006215729274780e+00 -5.976028709737490e+00 3.689885770597054e+00 4.863224308206355e+00 9.143599896504469e+03 + 188420 9.464512449870724e-01 -6.067976999622854e+00 -5.951635898185820e+00 3.339431004745360e+00 5.007479612924071e+00 9.069170099960118e+03 + 188440 9.298218150127306e-01 -6.087516289624699e+00 -5.967212275955053e+00 3.206369659095565e+00 4.897173922572624e+00 9.116671130502968e+03 + 188460 8.701587018530968e-01 -6.030988061985333e+00 -5.969525427764248e+00 3.553559681643653e+00 4.906487638653032e+00 9.123728501318221e+03 + 188480 8.766452640126813e-01 -6.056964537557363e+00 -5.974586877087320e+00 3.405205303600909e+00 4.878230577921657e+00 9.139187169577064e+03 + 188500 8.960078163215408e-01 -6.089416484674764e+00 -5.979990610410220e+00 3.238052749382567e+00 4.866393053008895e+00 9.155728255315398e+03 + 188520 9.306027439101184e-01 -6.134494392319277e+00 -5.978754843057485e+00 2.964037789169440e+00 4.858318381648010e+00 9.151956878685591e+03 + 188540 9.436375558771526e-01 -6.139554150388649e+00 -5.981199987146118e+00 2.997044672804174e+00 4.906338783370350e+00 9.159447501549166e+03 + 188560 8.834341370979402e-01 -6.027968133594073e+00 -6.014434947159287e+00 3.592512273145231e+00 4.670221923907608e+00 9.261432312328208e+03 + 188580 8.937184198855749e-01 -6.016802754209667e+00 -6.013430688667203e+00 3.583773968921536e+00 4.603136891091825e+00 9.258340165252983e+03 + 188600 1.003816763307793e+00 -6.149257241343234e+00 -5.957461043026825e+00 2.945672140773023e+00 5.046995591871609e+00 9.086946213926249e+03 + 188620 9.562116229441519e-01 -6.047151557354937e+00 -5.992154585551321e+00 3.449721233955665e+00 4.765522356805910e+00 9.192998019771085e+03 + 188640 9.899498664766415e-01 -6.068459303385493e+00 -5.985412734797574e+00 3.353961154124639e+00 4.830827402371429e+00 9.172315105613288e+03 + 188660 9.787552271442698e-01 -6.028503310460732e+00 -5.977267202605601e+00 3.553114287688142e+00 4.847319947754375e+00 9.147395291825305e+03 + 188680 1.022405124125336e+00 -6.071788786205794e+00 -5.997427502682928e+00 3.318919375588851e+00 4.745913372948580e+00 9.209167843875031e+03 + 188700 1.064006225374504e+00 -6.119126466680164e+00 -5.973117034215775e+00 3.086448450718424e+00 4.924857206815597e+00 9.134734437014147e+03 + 188720 1.009110680520988e+00 -6.027308730120838e+00 -6.017482201120389e+00 3.529961690530194e+00 4.586387140701223e+00 9.270790668023363e+03 + 188740 1.071643289449887e+00 -6.110608267090898e+00 -6.005622157611207e+00 3.083998903288944e+00 4.686845390469270e+00 9.234278217899649e+03 + 188760 9.583151469612496e-01 -5.936198803751449e+00 -6.013821881436687e+00 4.062749187589644e+00 4.617025463388559e+00 9.259518547351023e+03 + 188780 9.913832932052363e-01 -5.980287477801335e+00 -5.997159858598338e+00 3.854179046913592e+00 4.757295225384711e+00 9.208315206831294e+03 + 188800 1.061076738529573e+00 -6.076447367077092e+00 -5.992202773386271e+00 3.260066014537661e+00 4.743811508319094e+00 9.193138669384725e+03 + 188820 1.036360863915443e+00 -6.034911410258912e+00 -5.987187428292120e+00 3.558217650377885e+00 4.832256140093549e+00 9.177745646450516e+03 + 188840 9.722392847661596e-01 -5.937434767549409e+00 -5.972852140893701e+00 4.010781022191562e+00 4.807408983627824e+00 9.133889693185651e+03 + 188860 9.607483040257760e-01 -5.916417446225780e+00 -5.987927840608629e+00 4.182235999489929e+00 4.771612248745845e+00 9.179984047886022e+03 + 188880 9.883076609964926e-01 -5.951248588845649e+00 -5.941900205048311e+00 4.006695437019889e+00 5.060375303441918e+00 9.039535618136077e+03 + 188900 1.018372190317341e+00 -5.987623644029500e+00 -5.960541276026077e+00 3.744886823524742e+00 4.900397971583304e+00 9.096313313161678e+03 + 188920 1.100553972580510e+00 -6.097644660181176e+00 -5.963821881582211e+00 3.147716264908218e+00 4.916147368631536e+00 9.106339628632293e+03 + 188940 9.902274701095951e-01 -5.924117814818277e+00 -6.013283666516328e+00 4.065103261090281e+00 4.553099142269114e+00 9.257884457731785e+03 + 188960 9.411914223002298e-01 -5.840695092197502e+00 -6.067910623911068e+00 4.523291840128907e+00 4.218585095539717e+00 9.426700568225895e+03 + 188980 1.074033243649517e+00 -6.026765245530889e+00 -6.017213316782637e+00 3.570478455406383e+00 4.625327108435043e+00 9.269967277965312e+03 + 189000 9.943814770298425e-01 -5.898227712660852e+00 -6.043772539425726e+00 4.200958725745769e+00 4.365217807472715e+00 9.351914176324981e+03 + 189020 1.031992176035345e+00 -5.945509537996477e+00 -6.031297661957254e+00 3.950222063156796e+00 4.457613379704737e+00 9.313354617392155e+03 + 189040 1.051128076048910e+00 -5.966388017320948e+00 -5.996339294577919e+00 3.872827051078233e+00 4.700842182123532e+00 9.205818158554583e+03 + 189060 1.025194257657443e+00 -5.924156932132849e+00 -6.046290877212893e+00 4.060481719844811e+00 4.359169707028278e+00 9.359666871542144e+03 + 189080 1.057419055574063e+00 -5.972582629087258e+00 -6.023392188354589e+00 3.788064344105802e+00 4.496307992038901e+00 9.288995163799284e+03 + 189100 1.067887001607686e+00 -5.995518367801735e+00 -5.996489382710737e+00 3.741441554565022e+00 4.735865836693458e+00 9.206282558084251e+03 + 189120 1.006135508930121e+00 -5.920009840260724e+00 -6.071852995649436e+00 4.051004899654705e+00 4.179098003760367e+00 9.438931170412965e+03 + 189140 1.013418007364389e+00 -5.954081704263778e+00 -5.996618057932095e+00 3.917396190724767e+00 4.673145865481835e+00 9.206657664677839e+03 + 189160 1.030261308382780e+00 -6.004832877822267e+00 -5.952469750169823e+00 3.721722824957815e+00 5.022400007105965e+00 9.071710097505869e+03 + 189180 1.057965090290120e+00 -6.074660738114238e+00 -5.988014627559363e+00 3.282486970767549e+00 4.780022346015913e+00 9.180298990476222e+03 + 189200 1.000321080109322e+00 -6.020162704957389e+00 -6.017638185805925e+00 3.576117350631824e+00 4.590613530267607e+00 9.271280559558556e+03 + 189220 9.847590299779856e-01 -6.027028187048012e+00 -5.998964654206068e+00 3.594339132467918e+00 4.755484280864037e+00 9.213891109347520e+03 + 189240 9.680689128081202e-01 -6.030684352006950e+00 -6.016252627887251e+00 3.524663582618138e+00 4.607532775815534e+00 9.267022433628861e+03 + 189260 9.761003562878930e-01 -6.064062505776025e+00 -5.982831135030002e+00 3.336332639677309e+00 4.802775741014973e+00 9.164419141395550e+03 + 189280 9.146454712944040e-01 -5.988624443545700e+00 -5.994995307460660e+00 3.774846030034733e+00 4.738263543547031e+00 9.201697968153207e+03 + 189300 9.501820695925323e-01 -6.051912944848105e+00 -5.981977139795550e+00 3.356631146984699e+00 4.758213362127329e+00 9.161813676565718e+03 + 189320 9.312356272849381e-01 -6.027720844664540e+00 -5.947588223211703e+00 3.531839519356581e+00 4.991973432221860e+00 9.056859778690961e+03 + 189340 9.101978295233698e-01 -5.992346255017211e+00 -5.979625244264387e+00 3.768388147133733e+00 4.841434159446500e+00 9.154576991753667e+03 + 189360 9.905585945666261e-01 -6.099922062543376e+00 -5.953172992670785e+00 3.199990008821130e+00 5.042645877374715e+00 9.073854256084205e+03 + 189380 9.585042504255242e-01 -6.034434721978760e+00 -5.999366071438541e+00 3.564536517548858e+00 4.765906135806930e+00 9.215102226993356e+03 + 189400 9.322769816458653e-01 -5.972424056415463e+00 -5.994177016051021e+00 3.838161753842111e+00 4.713252893355113e+00 9.199194861796863e+03 + 189420 1.049490170302159e+00 -6.115632587169573e+00 -5.950558300725380e+00 3.089758493468100e+00 5.037640591393926e+00 9.065891751330733e+03 + 189440 9.343541857223273e-01 -5.908579210249313e+00 -6.013167326631542e+00 4.167177795113078e+00 4.566616645887613e+00 9.257512087227096e+03 + 189460 1.002719940140937e+00 -5.969685474692711e+00 -6.004584381269646e+00 3.870552764365507e+00 4.670157842212404e+00 9.231123916940260e+03 + 189480 1.057761780523360e+00 -6.012852361765907e+00 -6.013405841490401e+00 3.619491000769727e+00 4.616312834540967e+00 9.258255913238345e+03 + 189500 1.041778794639399e+00 -5.961324480378417e+00 -6.024216839440154e+00 3.851517123636820e+00 4.490379465343221e+00 9.291530489606337e+03 + 189520 1.036911943284363e+00 -5.936438517233583e+00 -6.015536536743364e+00 3.997942396644425e+00 4.543749328240304e+00 9.264765600863233e+03 + 189540 1.028930475379204e+00 -5.915435313048166e+00 -5.994726758833279e+00 4.149515134368782e+00 4.694211382359084e+00 9.200848023007833e+03 + 189560 1.068218532432107e+00 -5.972228137232257e+00 -5.994492925871787e+00 3.821233754506534e+00 4.693385892673443e+00 9.200134149559795e+03 + 189580 1.006522990159559e+00 -5.883718796322963e+00 -6.003821591386337e+00 4.336083710603597e+00 4.646434875502236e+00 9.228783362242615e+03 + 189600 1.082672846832262e+00 -6.002607917794338e+00 -6.020522810224580e+00 3.720594819941682e+00 4.617724735286589e+00 9.280155923515680e+03 + 189620 1.080879886437811e+00 -6.011744950281750e+00 -6.017143200799799e+00 3.618551224848903e+00 4.587553634997703e+00 9.269752219065278e+03 + 189640 1.079511573881293e+00 -6.026770983784043e+00 -5.964475638032990e+00 3.584804249818746e+00 4.942513765294891e+00 9.108308268488605e+03 + 189660 1.044142798566378e+00 -5.988995006880343e+00 -5.970006648752939e+00 3.812669344591547e+00 4.921703435398022e+00 9.125168310306524e+03 + 189680 9.899892102576219e-01 -5.924035812524107e+00 -5.977254736587502e+00 4.086997295841779e+00 4.781405998267876e+00 9.147300856003560e+03 + 189700 1.018992331687494e+00 -5.981168465657881e+00 -5.998096220522529e+00 3.768718297113589e+00 4.671516509119181e+00 9.211106487300995e+03 + 189720 1.020056458858804e+00 -5.995873642520126e+00 -5.993213237084141e+00 3.710806919467923e+00 4.726083379177760e+00 9.196196146482074e+03 + 189740 1.027438244518289e+00 -6.021374641500143e+00 -5.998468954305802e+00 3.562325003931524e+00 4.693853004445063e+00 9.212347939070802e+03 + 189760 9.949674761309182e-01 -5.988752525351055e+00 -6.022254018021498e+00 3.746426312466988e+00 4.554055557214065e+00 9.285471742871214e+03 + 189780 1.019474519505277e+00 -6.041312727050937e+00 -6.015638130609037e+00 3.412540830999957e+00 4.559968336900310e+00 9.265114786018547e+03 + 189800 9.504746573455150e-01 -5.957345120714892e+00 -5.978476013660759e+00 3.956798054702154e+00 4.835461197411866e+00 9.151083623126733e+03 + 189820 9.537378945249358e-01 -5.975941375318472e+00 -5.982603447454518e+00 3.817721209126174e+00 4.779466559968668e+00 9.163730995963148e+03 + 189840 9.731760948265287e-01 -6.018266372853386e+00 -5.962214162678456e+00 3.627735556380583e+00 4.949596021256522e+00 9.101426543137281e+03 + 189860 9.485717365173745e-01 -5.991308683184388e+00 -5.975709376968419e+00 3.756911604174097e+00 4.846485234451030e+00 9.142628136542293e+03 + 189880 1.011838848235262e+00 -6.092973306417206e+00 -5.971463101564272e+00 3.185363305633629e+00 4.883093705542611e+00 9.129671470754154e+03 + 189900 9.734482929178860e-01 -6.040799683842081e+00 -6.003826693726562e+00 3.467108123108626e+00 4.679412753903664e+00 9.228793877775644e+03 + 189920 9.817624073819173e-01 -6.056576151906751e+00 -6.005202146169400e+00 3.394304388473848e+00 4.689301879519412e+00 9.233026931054286e+03 + 189940 1.019153497231239e+00 -6.116077443500625e+00 -5.973668870209851e+00 3.123135309853121e+00 4.940867375344242e+00 9.136377307141802e+03 + 189960 9.557104761987338e-01 -6.023775512057821e+00 -5.976125311319016e+00 3.588793522276139e+00 4.862408348763092e+00 9.143891840456228e+03 + 189980 9.474883145511540e-01 -6.006933884497309e+00 -5.989512642019218e+00 3.675819820116519e+00 4.775855290354279e+00 9.184885444714371e+03 + 190000 9.846720417817334e-01 -6.050301470110785e+00 -5.975314702564438e+00 3.417172116766587e+00 4.847757740182487e+00 9.141446124783106e+03 + 190020 9.949752975560008e-01 -6.045482330050792e+00 -6.002900165973160e+00 3.428515352514685e+00 4.673028728217043e+00 9.225964314945408e+03 + 190040 1.024360329578800e+00 -6.063963124092105e+00 -6.005563175415130e+00 3.386300728996978e+00 4.721642271663022e+00 9.234135540685989e+03 + 190060 1.010387477049022e+00 -6.016357712935315e+00 -5.979650906474884e+00 3.635384580377635e+00 4.846160743433375e+00 9.154697417349837e+03 + 190080 1.086582435539829e+00 -6.102234366783573e+00 -5.963536491475864e+00 3.215056872422376e+00 5.011481535866082e+00 9.105437338090511e+03 + 190100 9.465343762279351e-01 -5.866388975322349e+00 -6.023972073698847e+00 4.452815098768323e+00 4.547948561984813e+00 9.290730202284509e+03 + 190120 1.083134108924415e+00 -6.042796146897892e+00 -5.940753152172684e+00 3.427886347298133e+00 5.013833014112675e+00 9.036057761448605e+03 + 190140 1.029358103573011e+00 -5.936854318172314e+00 -5.982116465519741e+00 4.023065753078098e+00 4.763163498714502e+00 9.162215268199929e+03 + 190160 1.043321281223898e+00 -5.936468324004830e+00 -6.036941946479470e+00 3.983870142843698e+00 4.406935054351488e+00 9.330775234115357e+03 + 190180 1.055075198115035e+00 -5.939839706768147e+00 -5.976245545668881e+00 4.035966911451277e+00 4.826918950697900e+00 9.144275221365961e+03 + 190200 1.077472279539197e+00 -5.966295632524577e+00 -5.996724790845075e+00 3.861662252311047e+00 4.686933316337716e+00 9.206969332019411e+03 + 190220 9.868799315492813e-01 -5.831106285171232e+00 -6.037558105658665e+00 4.549260469528422e+00 4.363782167973615e+00 9.332676147168004e+03 + 190240 1.028396982630166e+00 -5.897081241129103e+00 -5.978877759605669e+00 4.238190849143288e+00 4.768502582080527e+00 9.152305172542490e+03 + 190260 1.021145386434750e+00 -5.895132296262881e+00 -5.985494190164780e+00 4.177119797999570e+00 4.658247819756977e+00 9.172554692081316e+03 + 190280 1.028958387057407e+00 -5.920964000412150e+00 -5.974634089389317e+00 4.142391984881504e+00 4.834210028555181e+00 9.139328140016218e+03 + 190300 9.912585629808726e-01 -5.885339054669712e+00 -6.052764110627546e+00 4.309606333989024e+00 4.348225753735460e+00 9.379720271758106e+03 + 190320 1.009018272924071e+00 -5.943255568524396e+00 -6.043016719335252e+00 3.980310625070251e+00 4.407466659126117e+00 9.349572065355533e+03 + 190340 1.094961812520404e+00 -6.111999095530543e+00 -5.966729782808567e+00 3.086087114944705e+00 4.920245988947780e+00 9.115221337031380e+03 + 190360 9.762047990396142e-01 -5.977107264267184e+00 -6.024591574407957e+00 3.799974962725482e+00 4.527312705723919e+00 9.292678780573500e+03 + 190380 9.317126570815166e-01 -5.950371814041162e+00 -6.051055702455971e+00 3.925522440378491e+00 4.347379972319286e+00 9.374458796282881e+03 + 190400 9.473602237034222e-01 -6.005378911630371e+00 -6.004513050001028e+00 3.685161613196456e+00 4.690133524663798e+00 9.230900995210492e+03 + 190420 9.781968535273151e-01 -6.072132264909230e+00 -5.999201868669262e+00 3.312741384639483e+00 4.731519005791720e+00 9.214611141094354e+03 + 190440 9.441649207118489e-01 -6.033979039341370e+00 -6.045088185676901e+00 3.508190838078944e+00 4.444400400685481e+00 9.355958320381342e+03 + 190460 9.524660567663235e-01 -6.051802217036185e+00 -6.009332057204258e+00 3.444521034354431e+00 4.688391264345349e+00 9.245710054636089e+03 + 190480 9.513755706677944e-01 -6.051413775392801e+00 -5.982890661057498e+00 3.419836529228136e+00 4.813306855659119e+00 9.164595671850255e+03 + 190500 9.543090111839104e-01 -6.051594696790855e+00 -5.981736152048502e+00 3.382928177150434e+00 4.784066751635888e+00 9.161059673826383e+03 + 190520 9.413576012815014e-01 -6.023524997989377e+00 -5.988055332073344e+00 3.529441869483070e+00 4.733114180085993e+00 9.180422214755910e+03 + 190540 9.388700663992661e-01 -6.006752232854194e+00 -5.993604856996873e+00 3.657585026975184e+00 4.733079293697763e+00 9.197414247533978e+03 + 190560 9.833050060597186e-01 -6.054339848346380e+00 -6.060301565089770e+00 3.346198197531904e+00 4.311965097418669e+00 9.403098967833046e+03 + 190580 1.005692502575849e+00 -6.071929883110822e+00 -6.013830055670981e+00 3.287775571312705e+00 4.621393771391508e+00 9.259556965682279e+03 + 190600 9.703335498884368e-01 -6.005077780759230e+00 -6.029857551388368e+00 3.604538900713528e+00 4.462249623103904e+00 9.308952939545008e+03 + 190620 9.678111936559554e-01 -5.985980859942302e+00 -6.010360039102984e+00 3.757457266935334e+00 4.617468247528911e+00 9.248896858976428e+03 + 190640 9.602124997306477e-01 -5.960438694599944e+00 -6.010838534484652e+00 3.874233240077438e+00 4.584829560109431e+00 9.250366780955077e+03 + 190660 9.781515288078385e-01 -5.972834731115540e+00 -5.994344722055382e+00 3.846896027065503e+00 4.723382330428589e+00 9.199691627984683e+03 + 190680 9.812861866268077e-01 -5.961589585443058e+00 -5.981313784987448e+00 3.912125875890140e+00 4.798866469796234e+00 9.159768498268373e+03 + 190700 1.053460122723251e+00 -6.054646890940683e+00 -5.945044731559412e+00 3.425890387909851e+00 5.055242947956458e+00 9.049121833324392e+03 + 190720 1.014988527304233e+00 -5.986046761327209e+00 -5.984949236409331e+00 3.784435964818002e+00 4.790738122737895e+00 9.170884350469783e+03 + 190740 9.970053852924304e-01 -5.948119817686064e+00 -6.017404088421558e+00 3.914484970211600e+00 4.516643965942148e+00 9.270574121106136e+03 + 190760 9.931020325878860e-01 -5.933080983394271e+00 -6.086494509606532e+00 4.037819073838922e+00 4.156894865661664e+00 9.484497137201859e+03 + 190780 1.027706326649170e+00 -5.983078523129707e+00 -6.027747375513186e+00 3.828549364294305e+00 4.572053901425806e+00 9.302426035049935e+03 + 190800 1.056749982485872e+00 -6.028888356915134e+00 -5.970368228985762e+00 3.564924259613832e+00 4.900955890144818e+00 9.126313367395036e+03 + 190820 9.947612903690880e-01 -5.939666453288919e+00 -6.045807688744712e+00 3.962267739245452e+00 4.352788339955186e+00 9.358232866617907e+03 + 190840 1.021669786096216e+00 -5.983925628455154e+00 -6.041251240793441e+00 3.828271520005099e+00 4.499098982848815e+00 9.344106748497423e+03 + 190860 9.926819393668991e-01 -5.947830111411902e+00 -6.031886526354843e+00 3.986515181455256e+00 4.503850239164711e+00 9.315191702831295e+03 + 190880 1.036624859750390e+00 -6.021582322484967e+00 -5.991646715902803e+00 3.560113633709377e+00 4.732008519224311e+00 9.191422114444018e+03 + 190900 1.062582640845421e+00 -6.066091719031804e+00 -5.990735088292674e+00 3.355857588459839e+00 4.788567023564846e+00 9.188633280217324e+03 + 190920 9.476821390329740e-01 -5.901174630272386e+00 -6.060367633872728e+00 4.219271524684616e+00 4.305160662973760e+00 9.403293984470971e+03 + 190940 1.037789526814926e+00 -6.040666707978343e+00 -5.972286716762053e+00 3.547684347607391e+00 4.940332838940777e+00 9.132175579506882e+03 + 190960 1.031640682226401e+00 -6.036937874377916e+00 -5.947690412014111e+00 3.487603216980834e+00 5.000075956873965e+00 9.057158015761654e+03 + 190980 8.988350048408269e-01 -5.842285094910398e+00 -6.022902648681460e+00 4.530615358534945e+00 4.493481414305394e+00 9.287381841332586e+03 + 191000 9.884930018384180e-01 -5.974062398617810e+00 -5.972332577936207e+00 3.857368187410119e+00 4.867301085452768e+00 9.132269451345092e+03 + 191020 1.012328382640624e+00 -6.005572348411107e+00 -6.022607845120326e+00 3.594965521523881e+00 4.497145063184950e+00 9.286582821675878e+03 + 191040 1.011165443602551e+00 -6.001606999708979e+00 -6.018583587933064e+00 3.665063362416446e+00 4.567581165715213e+00 9.274187382099622e+03 + 191060 1.025157191255118e+00 -6.023259548791088e+00 -6.001371371174829e+00 3.563641427852124e+00 4.689326730909222e+00 9.221257235727857e+03 + 191080 9.627880440192340e-01 -5.932606372037060e+00 -6.019269256438226e+00 4.018552956476225e+00 4.520921263206711e+00 9.276300736768346e+03 + 191100 9.883719641433746e-01 -5.971982654659463e+00 -6.003527499114668e+00 3.879208929223864e+00 4.698073550813175e+00 9.227870981404065e+03 + 191120 1.018700952240416e+00 -6.019825322089840e+00 -6.003408918747208e+00 3.542629036997646e+00 4.636894565421247e+00 9.227514021240246e+03 + 191140 9.775869559813583e-01 -5.962628010899882e+00 -5.974447023686439e+00 3.871172069789490e+00 4.803305469382765e+00 9.138761185188832e+03 + 191160 9.575842823635106e-01 -5.934964836854888e+00 -5.987004193625969e+00 4.020834913171735e+00 4.722016873527756e+00 9.177167241133671e+03 + 191180 9.766674588819099e-01 -5.962414980807438e+00 -5.999607322562332e+00 3.908443995387198e+00 4.694879813534312e+00 9.215848819731458e+03 + 191200 1.057033604397919e+00 -6.080198113998206e+00 -6.019494869063649e+00 3.235811214901568e+00 4.584378641112585e+00 9.276988515172734e+03 + 191220 1.028428858684864e+00 -6.038980502499752e+00 -5.977618349815493e+00 3.553106332824295e+00 4.905457309299747e+00 9.148462050239459e+03 + 191240 9.798349567249403e-01 -5.968777590733155e+00 -6.023368799232172e+00 3.858380752356253e+00 4.544909585192688e+00 9.288912428764299e+03 + 191260 1.021149951491767e+00 -6.033421583891826e+00 -5.988463171325856e+00 3.528462156510131e+00 4.786620318755793e+00 9.181660514927613e+03 + 191280 9.870583297370342e-01 -5.987444658927341e+00 -5.990938192053354e+00 3.744985675751993e+00 4.724925267919925e+00 9.189226037132848e+03 + 191300 9.972713961256987e-01 -6.007248874853379e+00 -5.939457038942326e+00 3.685660208658384e+00 5.074931421212352e+00 9.032117665459686e+03 + 191320 9.809334095747532e-01 -5.984858010767615e+00 -6.017482103610936e+00 3.807420840827554e+00 4.620088251159154e+00 9.270772153691061e+03 + 191340 9.929872228339379e-01 -6.004754123457651e+00 -5.968797238695299e+00 3.712746251666842e+00 4.919216248282208e+00 9.121511597798695e+03 + 191360 1.040257266141776e+00 -6.076277729437621e+00 -5.959862238985341e+00 3.319121711456789e+00 4.987597472872700e+00 9.094241215232747e+03 + 191380 9.500954749788099e-01 -5.942113778439211e+00 -6.027044362779476e+00 4.010181095497776e+00 4.522496537250526e+00 9.300246504542101e+03 + 191400 9.616819308656267e-01 -5.960042327020192e+00 -6.031252682067715e+00 3.897441435356034e+00 4.488540556906327e+00 9.313243729114085e+03 + 191420 1.039567635193720e+00 -6.076633865642119e+00 -5.985682219856422e+00 3.237330663056402e+00 4.759589087879574e+00 9.173157615085946e+03 + 191440 9.481730758090652e-01 -5.941752986127252e+00 -5.986492313602886e+00 4.031526695721395e+00 4.774626553967752e+00 9.175591078148997e+03 + 191460 9.330019644063953e-01 -5.916539628597675e+00 -5.989181022903091e+00 4.150051392848605e+00 4.732933265527469e+00 9.183850415680912e+03 + 191480 1.095981447134261e+00 -6.150769926526729e+00 -5.948358164052827e+00 2.924176716286909e+00 5.086456379531065e+00 9.059213880597868e+03 + 191500 1.040712975603094e+00 -6.061964103733344e+00 -5.948299518493112e+00 3.392780513694147e+00 5.045460151681278e+00 9.059028330636083e+03 + 191520 9.995539954568957e-01 -5.994123383829915e+00 -5.966119419747059e+00 3.739339607790896e+00 4.900142703154090e+00 9.113316960545917e+03 + 191540 9.576930749736212e-01 -5.922074264370151e+00 -5.981816397552222e+00 4.142519239335513e+00 4.799470665538832e+00 9.161301747456726e+03 + 191560 1.034456826556005e+00 -6.022097755787619e+00 -5.978529868747279e+00 3.563113531962679e+00 4.813287081457037e+00 9.151254477829640e+03 + 191580 1.042623788337842e+00 -6.019831724713553e+00 -5.967660591700179e+00 3.625785991692482e+00 4.925360710912021e+00 9.118019777521284e+03 + 191600 9.834600528847722e-01 -5.915700480421364e+00 -6.008601331784430e+00 4.132907970222582e+00 4.599456905335572e+00 9.243424657351015e+03 + 191620 1.043156628161256e+00 -5.986212045043613e+00 -5.992473425873283e+00 3.777509336323068e+00 4.741555518653555e+00 9.193919339302058e+03 + 191640 1.024603150584142e+00 -5.940115571304681e+00 -6.028990609278971e+00 4.001937268740464e+00 4.491603047324418e+00 9.306255409054536e+03 + 191660 1.045132770134011e+00 -5.954862955719603e+00 -6.052565601860306e+00 3.884039702993804e+00 4.323015989418264e+00 9.379134458001525e+03 + 191680 1.062706032646265e+00 -5.970264433607397e+00 -6.024114965791954e+00 3.823717071752321e+00 4.514498982605671e+00 9.291244870496274e+03 + 191700 1.091790389513301e+00 -6.007627948172823e+00 -6.033340401080626e+00 3.611937909924132e+00 4.464293026338298e+00 9.319691513987751e+03 + 191720 1.013126508194464e+00 -5.892267560777530e+00 -6.045973545193585e+00 4.237243999894996e+00 4.354640451453792e+00 9.358701837983730e+03 + 191740 1.046963494442749e+00 -5.952281442488442e+00 -6.005332484595868e+00 3.962311454456111e+00 4.657684161053028e+00 9.233421417500926e+03 + 191760 1.034115674025881e+00 -5.950247741282316e+00 -5.978880797097928e+00 3.963265613757211e+00 4.798850176312895e+00 9.152293194718994e+03 + 191780 1.034431433710293e+00 -5.974363468743800e+00 -5.949589660440886e+00 3.848632723529853e+00 4.990887764539629e+00 9.062934268868681e+03 + 191800 9.701842858589952e-01 -5.910233826516230e+00 -5.998253545182092e+00 4.117304273706056e+00 4.611881428119231e+00 9.211681276753099e+03 + 191820 9.586208864922741e-01 -5.928421324337817e+00 -5.984084562679448e+00 4.044034704473816e+00 4.724407776057875e+00 9.168245992319951e+03 + 191840 1.012041844234107e+00 -6.043960612574699e+00 -5.986991213228803e+00 3.407738448256561e+00 4.734865555286747e+00 9.177165062268308e+03 + 191860 9.825368466711656e-01 -6.036011463230507e+00 -6.002526058441384e+00 3.494845438264997e+00 4.687123814413786e+00 9.224823691606021e+03 + 191880 9.310965398909162e-01 -5.988219814448264e+00 -6.002042522130832e+00 3.695546123049714e+00 4.616173996479309e+00 9.223321041241479e+03 + 191900 1.030243972169419e+00 -6.157981324990889e+00 -5.972416696428040e+00 2.878298947889262e+00 4.943839761130606e+00 9.132571275260963e+03 + 191920 9.309270038733016e-01 -6.026307223722691e+00 -6.026043013416359e+00 3.543382206911540e+00 4.544899343376911e+00 9.297189243481806e+03 + 191940 9.152764003706629e-01 -6.013626720585474e+00 -5.992583553961000e+00 3.655282884344927e+00 4.776116003522171e+00 9.194311904720362e+03 + 191960 9.376932394741377e-01 -6.050332906183336e+00 -5.985472354385708e+00 3.460941887295690e+00 4.833381212855618e+00 9.172512593726580e+03 + 191980 9.508519382382915e-01 -6.066571595799283e+00 -6.017373253007710e+00 3.315914809031724e+00 4.598419306759880e+00 9.270467706138101e+03 + 192000 9.389485372737877e-01 -6.039675401839528e+00 -5.982298271439711e+00 3.522188342499056e+00 4.851656704337038e+00 9.162801044730391e+03 + 192020 9.818093914323293e-01 -6.089924755798545e+00 -5.970145457175034e+00 3.223106780935544e+00 4.910898049418300e+00 9.125644013963845e+03 + 192040 9.168542279300756e-01 -5.974647001016805e+00 -6.042617710774910e+00 3.826553515958745e+00 4.436255182094370e+00 9.348320250182165e+03 + 192060 9.717250709553036e-01 -6.033424363986803e+00 -5.986143161108158e+00 3.548407554351336e+00 4.819903538023019e+00 9.174588947741715e+03 + 192080 9.759669995982853e-01 -6.015157152491703e+00 -5.976083044010982e+00 3.634532418563625e+00 4.858901996158673e+00 9.143792090537003e+03 + 192100 1.003616313252345e+00 -6.031648483057495e+00 -5.982921259662253e+00 3.513218058978461e+00 4.793017316227393e+00 9.164703361860005e+03 + 192120 1.000847201995444e+00 -6.003322009582517e+00 -5.976047078110566e+00 3.677374793614643e+00 4.833991670908588e+00 9.143653088975183e+03 + 192140 1.000959771998380e+00 -5.983162100252622e+00 -5.977380801301535e+00 3.757195827642106e+00 4.790392940872367e+00 9.147695816873798e+03 + 192160 9.859669558136969e-01 -5.944433422948818e+00 -5.987211989478224e+00 4.036112762645367e+00 4.790471613671743e+00 9.177776983512254e+03 + 192180 9.914135656073626e-01 -5.940785642831456e+00 -5.958299008909179e+00 3.969262596048244e+00 4.868698137845312e+00 9.089458170399979e+03 + 192200 9.475413843000323e-01 -5.867621722984843e+00 -5.972234178001086e+00 4.425133967750314e+00 4.824433062321956e+00 9.131979735640494e+03 + 192220 1.083811598027993e+00 -6.064172428853622e+00 -5.949650956160473e+00 3.374101987258835e+00 5.031702005603524e+00 9.063116075671436e+03 + 192240 1.022055236101889e+00 -5.970775817545753e+00 -5.989628457426127e+00 3.894701777029565e+00 4.786447001399866e+00 9.185214975623114e+03 + 192260 1.045895902066314e+00 -6.006204206501221e+00 -6.016743033935006e+00 3.707493143267219e+00 4.646977565264153e+00 9.268485398693640e+03 + 192280 1.054836371214232e+00 -6.022556134608114e+00 -6.023178296913073e+00 3.579513620801186e+00 4.575941068566799e+00 9.288332071833243e+03 + 192300 9.927763122045824e-01 -5.937845634257643e+00 -5.992658345733844e+00 4.068969009554799e+00 4.754225938018766e+00 9.194534715822792e+03 + 192320 9.781585867857857e-01 -5.924909924266403e+00 -6.023820941389088e+00 4.070528334953129e+00 4.502565968204244e+00 9.290291342562205e+03 + 192340 1.083966655454519e+00 -6.091014697532911e+00 -5.928381193080078e+00 3.242989914612903e+00 5.176856664634544e+00 8.998502727036492e+03 + 192360 1.008689043402150e+00 -5.988547288297667e+00 -6.000845341402888e+00 3.726064855443985e+00 4.655447531396238e+00 9.219641010872132e+03 + 192380 1.069782772453677e+00 -6.090509204607018e+00 -5.992015630449935e+00 3.224500131762195e+00 4.790065476403507e+00 9.192572428216094e+03 + 192400 1.025133814676901e+00 -6.036941687299496e+00 -6.018394357721348e+00 3.490443276355584e+00 4.596944912983288e+00 9.273624103840179e+03 + 192420 9.769782857467225e-01 -5.983293950719691e+00 -6.062173522155101e+00 3.721071797798472e+00 4.268133092042120e+00 9.408903890714517e+03 + 192440 9.963226565744849e-01 -6.032682274703534e+00 -6.011923381589707e+00 3.497264127678369e+00 4.616464904366294e+00 9.253692947416048e+03 + 192460 1.024663660479524e+00 -6.096636259719998e+00 -5.977075953846779e+00 3.183663138326545e+00 4.870196916548110e+00 9.146821954365902e+03 + 192480 9.366637130777166e-01 -5.985330454634335e+00 -6.006639520520225e+00 3.754824984274383e+00 4.632465030390314e+00 9.237427022045109e+03 + 192500 9.768123893811393e-01 -6.063140244343406e+00 -5.999520265392407e+00 3.373052637276699e+00 4.738368401573258e+00 9.215571339665636e+03 + 192520 9.635944512611898e-01 -6.060673283521291e+00 -5.959575578209304e+00 3.341915663946347e+00 4.922434332667118e+00 9.093377192102544e+03 + 192540 9.267701358470029e-01 -6.020120811292458e+00 -5.957056891005687e+00 3.599177169134989e+00 4.961299958531761e+00 9.085680737439441e+03 + 192560 9.653463178301863e-01 -6.087038898686658e+00 -5.945860918956416e+00 3.236584398267775e+00 5.047250205100585e+00 9.051594059885720e+03 + 192580 9.481956209326085e-01 -6.067767636468620e+00 -5.932750228587468e+00 3.356430312933251e+00 5.131721162863165e+00 9.011749544438582e+03 + 192600 9.351148322164566e-01 -6.047587010192227e+00 -5.970851801110917e+00 3.482107669564038e+00 4.922733114844146e+00 9.127740065588563e+03 + 192620 9.203067811598058e-01 -6.015735757067413e+00 -5.993737392552530e+00 3.556989025552121e+00 4.683307038832490e+00 9.197821084898358e+03 + 192640 1.001820739322161e+00 -6.113284355239132e+00 -5.957424486753231e+00 3.120244274421906e+00 5.015215758504652e+00 9.086802383612598e+03 + 192660 1.000605974820876e+00 -6.072915516045265e+00 -5.996736725689759e+00 3.307168508860412e+00 4.744598911711437e+00 9.207030426201934e+03 + 192680 9.960507626230358e-01 -6.020167185454696e+00 -6.004881325119646e+00 3.570210368165276e+00 4.657984143688376e+00 9.232025033193786e+03 + 192700 9.869605595545982e-01 -5.960173318160621e+00 -5.994655991459757e+00 3.919008034332722e+00 4.721003188072638e+00 9.200633458124734e+03 + 192720 1.026235494372035e+00 -5.978041257801868e+00 -5.990275051387788e+00 3.811611421220853e+00 4.741363085277063e+00 9.187207642678673e+03 + 192740 1.016010243727373e+00 -5.931461126226676e+00 -5.999079298458342e+00 4.083872434464885e+00 4.695598425632324e+00 9.214205950806516e+03 + 192760 1.073681819574464e+00 -5.994283359989019e+00 -5.983978309892470e+00 3.720262085991307e+00 4.779435278347041e+00 9.167917546556781e+03 + 192780 1.088324604348222e+00 -6.001179152352902e+00 -5.976675162462174e+00 3.693653282822303e+00 4.834358984755049e+00 9.145575695338510e+03 + 192800 1.027296241753211e+00 -5.901602595771991e+00 -6.014184902526348e+00 4.268112477807249e+00 4.621647450368069e+00 9.260661363020394e+03 + 192820 1.175428552762458e+00 -6.120404337433065e+00 -5.948137031495119e+00 3.090142158362259e+00 5.079327687337390e+00 9.058543975424120e+03 + 192840 1.067879463556149e+00 -5.968715801549084e+00 -5.999312264795931e+00 3.847256574903378e+00 4.671566948152602e+00 9.214916079564540e+03 + 192860 1.073516817506845e+00 -5.990283447684786e+00 -5.973870669297250e+00 3.812570554869245e+00 4.906815268239723e+00 9.136985435138686e+03 + 192880 1.055318189549783e+00 -5.979838009271034e+00 -6.009257622091276e+00 3.805123251199382e+00 4.636191281715178e+00 9.245478286282796e+03 + 192900 9.512430962427483e-01 -5.847642793165337e+00 -6.014294869989222e+00 4.514795845477795e+00 4.557853831029505e+00 9.260970082118094e+03 + 192920 1.019882509866317e+00 -5.974545850987445e+00 -5.961543940253501e+00 3.820398034215432e+00 4.895057017688922e+00 9.099367201377108e+03 + 192940 1.012146726767145e+00 -5.987353586887378e+00 -6.039187202871180e+00 3.752787394040937e+00 4.455150749835795e+00 9.337735944461929e+03 + 192960 1.040733434481756e+00 -6.059493925271433e+00 -6.014464647638792e+00 3.408282702951414e+00 4.666847783376232e+00 9.261520285346744e+03 + 192980 1.009890209951157e+00 -6.044694795525725e+00 -6.007331064984587e+00 3.490853956146126e+00 4.705402278931955e+00 9.239540425208990e+03 + 193000 9.847664257027373e-01 -6.034630982015854e+00 -5.992438255912541e+00 3.510072847620491e+00 4.752350010208980e+00 9.193846810009927e+03 + 193020 9.670736180680626e-01 -6.028939807301863e+00 -5.981712836198326e+00 3.508336870740865e+00 4.779521447167534e+00 9.160994696274862e+03 + 193040 9.951203290611198e-01 -6.084787458629108e+00 -5.969026347300433e+00 3.215846715025275e+00 4.880564930248608e+00 9.122222713877833e+03 + 193060 9.710795297403851e-01 -6.059616009493953e+00 -5.989675452478533e+00 3.369138780750386e+00 4.770748282399149e+00 9.185393967192902e+03 + 193080 9.633297859658231e-01 -6.051108025805366e+00 -5.976418945802575e+00 3.485802961740643e+00 4.914679217214448e+00 9.144804729547250e+03 + 193100 9.069326834820626e-01 -5.965288295374611e+00 -6.020257034377908e+00 3.843414902208264e+00 4.527775896466461e+00 9.279346780882461e+03 + 193120 9.655687604003120e-01 -6.046030872309935e+00 -6.000016221514678e+00 3.476172875996896e+00 4.740396121607454e+00 9.217105376799296e+03 + 193140 1.041468295935831e+00 -6.151503068996021e+00 -5.958084670645651e+00 2.906865429368561e+00 5.017503804096801e+00 9.088836391474573e+03 + 193160 9.739417851935880e-01 -6.044145856610211e+00 -6.010616775426012e+00 3.472285477358446e+00 4.664814650126662e+00 9.249647469869769e+03 + 193180 9.805311240099015e-01 -6.045700473453684e+00 -5.970368600745099e+00 3.441174274705777e+00 4.873741545368101e+00 9.126300118737012e+03 + 193200 1.034190005916360e+00 -6.116005034850783e+00 -5.965822361181056e+00 3.064931445438292e+00 4.927303598343503e+00 9.112442330112377e+03 + 193220 9.229293713899127e-01 -5.941397223734327e+00 -6.019531842499442e+00 4.020398975232439e+00 4.571737902989977e+00 9.277082077490872e+03 + 193240 9.801672979593096e-01 -6.017431603758345e+00 -5.988444510377514e+00 3.567995736294159e+00 4.734444112225092e+00 9.181608438288944e+03 + 193260 9.696902763962316e-01 -5.991857035024513e+00 -5.971882261282204e+00 3.752192309030269e+00 4.866890550944854e+00 9.130917047932264e+03 + 193280 9.739389225255172e-01 -5.987186703938875e+00 -5.950103854706033e+00 3.735356851961163e+00 4.948292310808516e+00 9.064523098738657e+03 + 193300 9.951274654334480e-01 -6.005633275694256e+00 -5.984204543062594e+00 3.663195573498303e+00 4.786242672354966e+00 9.168629386534729e+03 + 193320 1.062969706179940e+00 -6.094077342739375e+00 -5.990054219013460e+00 3.193513928588174e+00 4.790830802548752e+00 9.186553050651204e+03 + 193340 1.018078076739977e+00 -6.017775999465841e+00 -6.006775243000654e+00 3.679234084786329e+00 4.742402130770994e+00 9.237851233191372e+03 + 193360 9.702942807283549e-01 -5.940973707779218e+00 -6.015155364414579e+00 4.070331429646984e+00 4.644368877672477e+00 9.263613389201146e+03 + 193380 9.688024220050900e-01 -5.930786377800341e+00 -5.998015458150506e+00 4.090335732175583e+00 4.704295949138374e+00 9.210940874136080e+03 + 193400 1.018987041986540e+00 -5.996561679828703e+00 -6.021539524073347e+00 3.704809062054102e+00 4.561382415092451e+00 9.283279761461372e+03 + 193420 1.024421939211916e+00 -5.997465736031920e+00 -6.011737870895336e+00 3.744663934548690e+00 4.662711127557220e+00 9.253108431798688e+03 + 193440 9.916123967194218e-01 -5.942288104018143e+00 -6.017306430906819e+00 4.085523825969414e+00 4.654756983926067e+00 9.270229878748065e+03 + 193460 1.047768937905980e+00 -6.019036991245959e+00 -6.024667664254764e+00 3.527014638467303e+00 4.494682442706914e+00 9.292943054506004e+03 + 193480 1.102224493869864e+00 -6.097174432307977e+00 -5.986195345461552e+00 3.149112133947550e+00 4.786371224577906e+00 9.174739749548935e+03 + 193500 9.441099925596823e-01 -5.864809562100755e+00 -6.031450130983070e+00 4.471778810945887e+00 4.514902876878945e+00 9.313843168830312e+03 + 193520 1.001004510901299e+00 -5.952637442167845e+00 -6.057225017188923e+00 3.957067798836481e+00 4.356509758190525e+00 9.393531701507793e+03 + 193540 9.967096223191209e-01 -5.954175004277252e+00 -6.033239149265947e+00 4.003455549764944e+00 4.549456994102959e+00 9.319368780396451e+03 + 193560 9.895606605384756e-01 -5.960361067716853e+00 -6.051108342799441e+00 3.956530332723719e+00 4.435445436104068e+00 9.374613425447937e+03 + 193580 1.008174423190615e+00 -6.013799765279986e+00 -6.007157590035466e+00 3.651042566063875e+00 4.689182964191202e+00 9.239051160248315e+03 + 193600 1.005804469754030e+00 -6.040475994396820e+00 -6.021688078533133e+00 3.497504687317217e+00 4.605387807627089e+00 9.283763586507899e+03 + 193620 9.338292537306065e-01 -5.968409865282092e+00 -6.029111078281796e+00 3.857366100777580e+00 4.508810342250929e+00 9.306639056840113e+03 + 193640 9.460520696367564e-01 -6.017762566395382e+00 -6.042829380416045e+00 3.563383617496416e+00 4.419446092312833e+00 9.349006412634988e+03 + 193660 9.247188775689976e-01 -6.015055394679367e+00 -6.006280148834854e+00 3.647490733694943e+00 4.697879553299037e+00 9.236343741680950e+03 + 193680 9.691338806822474e-01 -6.102782590250664e+00 -5.980455058589200e+00 3.142706926001011e+00 4.845130542925480e+00 9.157133834223834e+03 + 193700 9.334502494999822e-01 -6.063588072726394e+00 -5.994815267802950e+00 3.379269253781014e+00 4.774173342208591e+00 9.201136476267327e+03 + 193720 9.760225308593538e-01 -6.132924403798757e+00 -6.021309482332022e+00 2.950795557711021e+00 4.591705709126293e+00 9.282586296446256e+03 + 193740 9.550894328844052e-01 -6.104256013002096e+00 -6.003929926160472e+00 3.150036038549762e+00 4.726123954606124e+00 9.229124001749171e+03 + 193760 9.175103727070968e-01 -6.044943842263792e+00 -5.986090141853520e+00 3.491375886829171e+00 4.829322942165660e+00 9.174383923560408e+03 + 193780 9.064063177043670e-01 -6.017548024660794e+00 -5.965765406837912e+00 3.667775721189527e+00 4.965119526062727e+00 9.112248874824903e+03 + 193800 9.385623409533291e-01 -6.043065722801518e+00 -5.989397870953392e+00 3.485924054384034e+00 4.794093164769201e+00 9.184524065686453e+03 + 193820 9.631095101226297e-01 -6.047394184726395e+00 -5.982281008687661e+00 3.451720790790708e+00 4.825610723836546e+00 9.162728999343655e+03 + 193840 9.845035350353661e-01 -6.041204028813237e+00 -5.996077153668843e+00 3.465961897553339e+00 4.725087397993807e+00 9.205024314303053e+03 + 193860 1.011973270443129e+00 -6.042349423592677e+00 -6.005004096894947e+00 3.483845792839790e+00 4.698288437908790e+00 9.232428539595761e+03 + 193880 1.010923213516133e+00 -6.005597274863867e+00 -6.047685506803717e+00 3.650195474976687e+00 4.408518334045223e+00 9.364002009699345e+03 + 193900 9.693910680676351e-01 -5.918013099952008e+00 -6.000940631703157e+00 4.126259466920890e+00 4.650076746611725e+00 9.219945380064279e+03 + 193920 1.029913520202660e+00 -5.988634188513677e+00 -6.022580621019340e+00 3.737221973986219e+00 4.542296305345250e+00 9.286500713448257e+03 + 193940 1.035440909488751e+00 -5.983856720197705e+00 -6.007686566537043e+00 3.822077312852814e+00 4.685242647515539e+00 9.240646363420208e+03 + 193960 9.663082919322866e-01 -5.874232118021832e+00 -6.027095098673698e+00 4.366488650171195e+00 4.488725759798374e+00 9.300384571628669e+03 + 193980 1.010579274482758e+00 -5.936099622908695e+00 -6.002388135282966e+00 4.051237348387207e+00 4.670598452220007e+00 9.224372113593570e+03 + 194000 1.059892951378851e+00 -6.008146300558740e+00 -6.036021552278585e+00 3.644849669315108e+00 4.484785660258495e+00 9.327961486405839e+03 + 194020 1.082480710805421e+00 -6.047385779849199e+00 -6.014657164646417e+00 3.400333451548733e+00 4.588266224779942e+00 9.262110906997515e+03 + 194040 9.465953848906453e-01 -5.855224421594428e+00 -5.995284191478500e+00 4.538913520068137e+00 4.734668647214455e+00 9.202567186287308e+03 + 194060 1.066600137788129e+00 -6.042057693467514e+00 -5.940306605881932e+00 3.510648848787838e+00 5.094919339634169e+00 9.034679592430986e+03 + 194080 1.029392208077709e+00 -5.994699947750794e+00 -5.999072099115064e+00 3.720422322493965e+00 4.695316752772092e+00 9.214181199078401e+03 + 194100 1.066974052679534e+00 -6.061460120928082e+00 -5.987503320901893e+00 3.381733751397851e+00 4.806405141926043e+00 9.178703118604319e+03 + 194120 9.511859224585989e-01 -5.902806710083565e+00 -6.012384142438769e+00 4.261928114096671e+00 4.632717540460238e+00 9.255080432256773e+03 + 194140 1.067313346741453e+00 -6.089237135881248e+00 -5.973578303728884e+00 3.251428238742888e+00 4.915559151108200e+00 9.136110405083447e+03 + 194160 9.916534489520434e-01 -5.993312022777951e+00 -5.974984868581823e+00 3.773633593171438e+00 4.878870948683547e+00 9.140427077275726e+03 + 194180 9.452767302319490e-01 -5.942911024110805e+00 -6.052904545833299e+00 4.001207033056957e+00 4.369607209883915e+00 9.380150356301841e+03 + 194200 9.594575731048806e-01 -5.985245195156315e+00 -5.965446926887393e+00 3.827866652610850e+00 4.941551372783116e+00 9.111271795072211e+03 + 194220 9.593670788915641e-01 -6.005962029863641e+00 -5.974666702643014e+00 3.698771222077761e+00 4.878473833914834e+00 9.139422306056786e+03 + 194240 1.020191951319725e+00 -6.120120828163301e+00 -5.966511311361073e+00 3.055279172062803e+00 4.937328788537098e+00 9.114536173416174e+03 + 194260 9.293203137526880e-01 -6.011583876009109e+00 -5.994934615634531e+00 3.665891554866330e+00 4.761494184401871e+00 9.201496154107332e+03 + 194280 9.408498334863892e-01 -6.060434981494996e+00 -5.979410728660303e+00 3.408163232712918e+00 4.873417030952329e+00 9.153942901132928e+03 + 194300 1.030724566801042e+00 -6.230234531569777e+00 -5.939002529876364e+00 2.494997560425857e+00 5.167296782156047e+00 9.030762044014229e+03 + 194320 8.879221992919479e-01 -6.060515483825966e+00 -5.965679183424589e+00 3.458957460326440e+00 5.003522173101205e+00 9.111990611538225e+03 + 194340 8.982500752819944e-01 -6.107620268169081e+00 -5.941503492527950e+00 3.162345815748980e+00 5.116214047968308e+00 9.038355704551099e+03 + 194360 9.163018766293644e-01 -6.156205860470535e+00 -5.986648214702218e+00 2.850795719711229e+00 4.824421960673786e+00 9.176102549062796e+03 + 194380 9.268868833787858e-01 -6.183547977541322e+00 -5.946615531984415e+00 2.698304755967547e+00 5.058807523532757e+00 9.053913133158501e+03 + 194400 8.729208637002845e-01 -6.103384326425672e+00 -5.993225883450548e+00 3.151631873725397e+00 4.784178700252518e+00 9.196285115528615e+03 + 194420 8.807116564566821e-01 -6.103539376806909e+00 -5.973400579471401e+00 3.155695913680231e+00 4.902973026894518e+00 9.135593449869686e+03 + 194440 9.044048316665005e-01 -6.113872148077965e+00 -6.004590331243009e+00 3.072868768165352e+00 4.700381871738164e+00 9.231153851280073e+03 + 194460 9.066388221993771e-01 -6.078592071264975e+00 -6.005382425984306e+00 3.293171646915556e+00 4.713552759273151e+00 9.233585851963257e+03 + 194480 9.043279738532719e-01 -6.027578090662852e+00 -6.003865781485638e+00 3.571842957739974e+00 4.708002706503527e+00 9.228905842170883e+03 + 194500 9.782350369235168e-01 -6.088856131032823e+00 -5.973823433851000e+00 3.231991982771473e+00 4.892527531241857e+00 9.136866396390149e+03 + 194520 9.285596483987033e-01 -5.977291629764057e+00 -6.016578213794135e+00 3.798578249012166e+00 4.572988603932229e+00 9.268020273490109e+03 + 194540 9.852790861076621e-01 -6.036268211214412e+00 -6.011905877696110e+00 3.508898849744166e+00 4.648791138865183e+00 9.253642026274638e+03 + 194560 9.840058634816742e-01 -6.017803076723942e+00 -6.038537597003969e+00 3.556706298563768e+00 4.437645474459210e+00 9.335736231399074e+03 + 194580 1.033749536534455e+00 -6.079355350086628e+00 -6.009894167230584e+00 3.306916110476116e+00 4.705772971518826e+00 9.247457615765919e+03 + 194600 1.005240169449084e+00 -6.027680240681997e+00 -6.005433497271760e+00 3.536913299300653e+00 4.664657542634650e+00 9.233733972761152e+03 + 194620 1.035152405843537e+00 -6.061591457153781e+00 -5.991958025523378e+00 3.370282612105989e+00 4.770128552266486e+00 9.192373095736863e+03 + 194640 1.003667075214549e+00 -6.005443693729010e+00 -6.020128902108904e+00 3.652432466038257e+00 4.568107726992255e+00 9.278937907469022e+03 + 194660 9.398401490689932e-01 -5.903695781970285e+00 -6.021073040924228e+00 4.173180501472359e+00 4.499182116486699e+00 9.281857881983062e+03 + 194680 1.048405968331072e+00 -6.055276524056493e+00 -5.987089284410419e+00 3.381892104922618e+00 4.773433786911612e+00 9.177468668661939e+03 + 194700 1.041723682928530e+00 -6.035969627278400e+00 -5.986876259178812e+00 3.506348779425015e+00 4.788250496227013e+00 9.176814741592525e+03 + 194720 1.052905863466826e+00 -6.045473397828164e+00 -5.991278975726828e+00 3.419753347712193e+00 4.730946105977781e+00 9.190304626784149e+03 + 194740 1.037402052454290e+00 -6.017578345193533e+00 -5.997269478023051e+00 3.575879471739833e+00 4.692496129819779e+00 9.208658792140137e+03 + 194760 9.686789716528641e-01 -5.912895653225706e+00 -6.013520043399431e+00 4.125403859640525e+00 4.547603039688942e+00 9.258585217048649e+03 + 194780 9.727781292771562e-01 -5.914575734373909e+00 -5.985926277154307e+00 4.128839720571797e+00 4.719133862465945e+00 9.173876887526994e+03 + 194800 1.029683696005441e+00 -5.992637791770705e+00 -5.993103054223884e+00 3.775575080226703e+00 4.772903471221418e+00 9.195871794295146e+03 + 194820 1.015825897320712e+00 -5.967138043947833e+00 -6.020851538970549e+00 3.871396613894825e+00 4.562965413337904e+00 9.281172986958933e+03 + 194840 1.068765958031652e+00 -6.043444621146242e+00 -6.001747146178079e+00 3.484617430012412e+00 4.724050783942996e+00 9.222423536987635e+03 + 194860 1.006243143331842e+00 -5.954321011997324e+00 -6.025644525726769e+00 3.892839619279527e+00 4.483288966166973e+00 9.295936775458698e+03 + 194880 9.965546424677431e-01 -5.948456985442180e+00 -5.942917974595797e+00 3.916093003118806e+00 4.947898860557897e+00 9.042614977332827e+03 + 194900 1.039271436786827e+00 -6.019181392409170e+00 -5.944393824617972e+00 3.605568904328476e+00 5.035010691924247e+00 9.047106687109244e+03 + 194920 9.776110221237814e-01 -5.936691553426297e+00 -6.003163224742421e+00 3.979377415461346e+00 4.597686792306268e+00 9.226747981483268e+03 + 194940 9.388572813598552e-01 -5.893009644068782e+00 -5.992348529413742e+00 4.233190103697034e+00 4.662770851403446e+00 9.193549881575127e+03 + 194960 9.881943898300279e-01 -5.980554653697074e+00 -5.973998558868908e+00 3.782076542106890e+00 4.819722653162617e+00 9.137373025246476e+03 + 194980 1.011259948616075e+00 -6.030366414084140e+00 -5.974105217365748e+00 3.522688321425508e+00 4.845748819374570e+00 9.137715227699529e+03 + 195000 1.018714717687006e+00 -6.059977682665144e+00 -5.932580098851861e+00 3.417484548851176e+00 5.149021189819429e+00 9.011208785761766e+03 + 195020 9.512794813648384e-01 -5.978742006522158e+00 -5.961801309624342e+00 3.821089485383350e+00 4.918365588534986e+00 9.100118219538768e+03 + 195040 9.851222100688394e-01 -6.045341819586577e+00 -5.989886669191358e+00 3.438305110037144e+00 4.756737165263283e+00 9.186030501978252e+03 + 195060 9.932674088245751e-01 -6.074461497592939e+00 -5.994663630571507e+00 3.295266411859224e+00 4.753478112976294e+00 9.200671894523484e+03 + 195080 9.660641534990018e-01 -6.051020694101098e+00 -6.022363025091584e+00 3.402285659465789e+00 4.566842429678363e+00 9.285841483414810e+03 + 195100 9.158062118117237e-01 -5.990548797993362e+00 -6.004428025935203e+00 3.731602341046055e+00 4.651905666400422e+00 9.230675070357305e+03 + 195120 1.009719325337959e+00 -6.141730259594245e+00 -5.981203980068356e+00 2.953615354857956e+00 4.875382093257086e+00 9.159448458220540e+03 + 195140 1.006414339536299e+00 -6.147085406726273e+00 -5.952682770899914e+00 2.956974799076497e+00 5.073264817702116e+00 9.072357823386805e+03 + 195160 9.047596820629388e-01 -6.001893078909852e+00 -5.965888747056753e+00 3.681647414311814e+00 4.888389859464655e+00 9.112639672906691e+03 + 195180 8.879737058233469e-01 -5.975077362619087e+00 -6.007373240560547e+00 3.779503989681654e+00 4.594056060770831e+00 9.239665968144833e+03 + 195200 8.925979060735731e-01 -5.972303330574706e+00 -5.968663749732993e+00 3.867102004095574e+00 4.888001040511997e+00 9.121090788257578e+03 + 195220 9.552891373444073e-01 -6.043747504382768e+00 -5.988582313329820e+00 3.519471933109668e+00 4.836238996921426e+00 9.182026026858424e+03 + 195240 9.816457333766435e-01 -6.049077187373987e+00 -6.026634412554426e+00 3.424122099799739e+00 4.552991985821837e+00 9.299007430075013e+03 + 195260 1.006671621922202e+00 -6.045517089183083e+00 -6.015155290766355e+00 3.415649411902916e+00 4.589991556884892e+00 9.263635257913202e+03 + 195280 9.593444198299099e-01 -5.936042306773736e+00 -5.997859998262179e+00 4.059947710698895e+00 4.704980959915415e+00 9.210458162515473e+03 + 195300 1.021225493862118e+00 -5.987658662222856e+00 -5.982700930959740e+00 3.751123305936924e+00 4.779591366056170e+00 9.164020664192820e+03 + 195320 1.025503479272375e+00 -5.959017571020345e+00 -6.025009465692881e+00 3.863534488974814e+00 4.484598817552417e+00 9.293987621940221e+03 + 195340 1.066310121497640e+00 -5.994805685652834e+00 -6.031975319016746e+00 3.706048082081089e+00 4.492614295323332e+00 9.315464501331662e+03 + 195360 1.118920486392026e+00 -6.060098157997365e+00 -5.984737005212866e+00 3.376504482142605e+00 4.809239883531906e+00 9.170260193675802e+03 + 195380 1.022338272832912e+00 -5.911519994195669e+00 -6.034564425659916e+00 4.164334176910518e+00 4.457794010378580e+00 9.323458762469068e+03 + 195400 1.036458528702731e+00 -5.933115401198777e+00 -6.064120361114735e+00 4.012951207089098e+00 4.260700454299637e+00 9.414936180281651e+03 + 195420 1.048368839655583e+00 -5.957290737377544e+00 -6.071604317727990e+00 3.893565408751154e+00 4.237159140409508e+00 9.438186131882103e+03 + 195440 1.034194018145831e+00 -5.951018688672262e+00 -6.000163515377098e+00 3.926933516364589e+00 4.644736316288069e+00 9.217525763071664e+03 + 195460 1.000900478135794e+00 -5.917656042991911e+00 -5.970904085995430e+00 4.109511172947834e+00 4.803752669913600e+00 9.127937204156198e+03 + 195480 1.049007912653091e+00 -6.003051618631785e+00 -6.009753305675066e+00 3.641618765162330e+00 4.603136641077091e+00 9.247038734643462e+03 + 195500 9.781700088673190e-01 -5.916990357450334e+00 -6.060695902141767e+00 4.127752703990240e+00 4.302573228010865e+00 9.404321939147021e+03 + 195520 9.824617563285656e-01 -5.946445213257737e+00 -5.991294808957096e+00 4.010365152046462e+00 4.752831833088238e+00 9.190332577082683e+03 + 195540 9.780075826248805e-01 -5.961882331849758e+00 -5.983334489084895e+00 3.946371173065097e+00 4.823189566510333e+00 9.165942372734960e+03 + 195560 9.939654845631486e-01 -6.003692912290270e+00 -5.985168047720951e+00 3.690537587235346e+00 4.796910226305899e+00 9.171563218291187e+03 + 195580 1.062696435458494e+00 -6.120864198384767e+00 -5.987260749125742e+00 3.029457001069603e+00 4.796628681781884e+00 9.177995117132530e+03 + 195600 9.861607181793353e-01 -6.023738230710810e+00 -6.016106058038739e+00 3.554101671167539e+00 4.597926787725473e+00 9.266563996103199e+03 + 195620 1.003420159773009e+00 -6.064849375077141e+00 -5.974942868821337e+00 3.387040443745005e+00 4.903297515652705e+00 9.140271111922981e+03 + 195640 1.006936461832678e+00 -6.080822655141368e+00 -5.966757271939023e+00 3.285792775073184e+00 4.940773856982055e+00 9.115258390914672e+03 + 195660 9.055283186476669e-01 -5.935985132588241e+00 -6.003492176928086e+00 4.061120985599986e+00 4.673485090319246e+00 9.227766455227276e+03 + 195680 9.418391524037608e-01 -5.991624125180082e+00 -6.034495105450395e+00 3.730656448215139e+00 4.484484645240249e+00 9.323265979452004e+03 + 195700 1.009114335302445e+00 -6.091854968101154e+00 -5.999612277846599e+00 3.193186401915920e+00 4.722858203867760e+00 9.215879207332064e+03 + 195720 9.550614776911082e-01 -6.008376838403665e+00 -5.989771393524393e+00 3.733492282412256e+00 4.840327626092323e+00 9.185643854525842e+03 + 195740 9.499736512690375e-01 -5.992243537432164e+00 -6.022028763733781e+00 3.771175998260776e+00 4.600144619588016e+00 9.284793587155988e+03 + 195760 1.035379646450857e+00 -6.102297002642259e+00 -6.012232586129475e+00 3.160561050204074e+00 4.677724867243893e+00 9.254663756216836e+03 + 195780 1.054541696726983e+00 -6.097142930152711e+00 -6.033021562857563e+00 3.126767456276865e+00 4.494962270035124e+00 9.318710857629167e+03 + 195800 1.023161939910014e+00 -5.993604757360965e+00 -6.017504326097239e+00 3.768501438739963e+00 4.631266416609972e+00 9.270856923176152e+03 + 195820 1.007777868455822e+00 -5.900143476288800e+00 -6.008490523551906e+00 4.222410811186140e+00 4.600265299150010e+00 9.243126705526671e+03 + 195840 1.075914445505571e+00 -5.940726552696990e+00 -5.990791648176040e+00 4.012980719794831e+00 4.725499194005641e+00 9.188781769429612e+03 + 195860 1.109707951799272e+00 -5.951630850359702e+00 -5.963365575703811e+00 3.990174346962669e+00 4.922791738093915e+00 9.104871312495286e+03 + 195880 1.042097413065962e+00 -5.828142016804314e+00 -6.013838715646065e+00 4.529576428311453e+00 4.463277247090848e+00 9.259483609266021e+03 + 195900 1.094437296132860e+00 -5.890937286447214e+00 -5.957827356972853e+00 4.279260331895459e+00 4.895167195732276e+00 9.088010499073818e+03 + 195920 1.103912831286587e+00 -5.900381439605983e+00 -6.038607238243221e+00 4.222441459607938e+00 4.428727533459704e+00 9.335921935429313e+03 + 195940 1.145937512267781e+00 -5.973268057719872e+00 -5.997600008979067e+00 3.869505366872178e+00 4.729787537384594e+00 9.209694450526273e+03 + 195960 1.083835737289040e+00 -5.902348630843024e+00 -6.032298787569095e+00 4.236716007896007e+00 4.490522098253142e+00 9.316458793144357e+03 + 195980 1.076508382362731e+00 -5.925971630866234e+00 -5.996372000924755e+00 4.129120277546182e+00 4.724870458248104e+00 9.205891283607167e+03 + 196000 1.026643128341642e+00 -5.890791915489999e+00 -6.006039832807624e+00 4.277959255305097e+00 4.616187879509725e+00 9.235561494602738e+03 + 196020 1.021165541169524e+00 -5.921358168531308e+00 -5.966663831542059e+00 4.118281625297159e+00 4.858129497260732e+00 9.114975609956584e+03 + 196040 9.805787860140404e-01 -5.894410297802692e+00 -6.032738692237970e+00 4.297168608586884e+00 4.502865561489658e+00 9.317806951234435e+03 + 196060 1.057743567804275e+00 -6.040112724474444e+00 -6.000424538129063e+00 3.499723633759587e+00 4.727619341481752e+00 9.218358488231455e+03 + 196080 1.039124315171952e+00 -6.041664535904888e+00 -5.983959249252897e+00 3.470586104634517e+00 4.801938790454495e+00 9.167868977082349e+03 + 196100 9.656585972063157e-01 -5.957387507657709e+00 -5.991174177154353e+00 3.959632233578511e+00 4.765623948858569e+00 9.189944632902538e+03 + 196120 9.788456759473211e-01 -5.993718202860602e+00 -5.994057083352168e+00 3.724751647203340e+00 4.722805742979183e+00 9.198786716819519e+03 + 196140 1.014229989262649e+00 -6.060035580857191e+00 -5.974358940820917e+00 3.387667435761924e+00 4.879635961267407e+00 9.138502199170796e+03 + 196160 9.244999306360201e-01 -5.938945135223111e+00 -6.000396759315717e+00 4.030625132395195e+00 4.677760397247359e+00 9.218259604762336e+03 + 196180 9.868177074480585e-01 -6.038268894005399e+00 -5.961587475568934e+00 3.479797132231468e+00 4.920113703304802e+00 9.099516275543370e+03 + 196200 9.933425315740908e-01 -6.050725677078359e+00 -5.992560654038739e+00 3.452110809872873e+00 4.786103373174596e+00 9.194198941181050e+03 + 196220 1.004911089331962e+00 -6.067367084587982e+00 -5.968265149412284e+00 3.343307266144673e+00 4.912365913898437e+00 9.119888736378449e+03 + 196240 1.005543278080721e+00 -6.065444516948155e+00 -5.974765881850439e+00 3.360467190974586e+00 4.881157946179100e+00 9.139771916500067e+03 + 196260 9.986416031814210e-01 -6.050135652970084e+00 -6.052680107255915e+00 3.368385422110793e+00 4.353774771848528e+00 9.379490423971896e+03 + 196280 1.024424522627822e+00 -6.082830864128908e+00 -6.001457865745364e+00 3.210178396419209e+00 4.677434745568327e+00 9.221549738970525e+03 + 196300 9.845245004734411e-01 -6.017566414903256e+00 -6.003411901834026e+00 3.581198818446239e+00 4.662476222893576e+00 9.227521616055972e+03 + 196320 9.419419910562526e-01 -5.943289232912045e+00 -6.010092617804518e+00 3.940377739829699e+00 4.556782365986718e+00 9.248041645880890e+03 + 196340 9.693266084521186e-01 -5.963960763503920e+00 -6.016193722760271e+00 3.864571726338383e+00 4.564641991264095e+00 9.266824786194342e+03 + 196360 9.606812473762324e-01 -5.922893538047632e+00 -6.062008329699757e+00 4.041963737934314e+00 4.243145076323378e+00 9.408376901890899e+03 + 196380 1.058001926103443e+00 -6.030924096049105e+00 -5.985170376709587e+00 3.563222669350723e+00 4.825947606163423e+00 9.171595438288616e+03 + 196400 1.050676249627793e+00 -5.980924117432423e+00 -6.014467605588966e+00 3.767774675336474e+00 4.575162775503587e+00 9.261518330223718e+03 + 196420 1.112692136181506e+00 -6.032504438933397e+00 -6.018416909950121e+00 3.502850402924399e+00 4.583743174384440e+00 9.273678786133734e+03 + 196440 1.075161674933484e+00 -5.944563770643599e+00 -6.024130498883313e+00 4.018954891643374e+00 4.562070425179535e+00 9.291263528439176e+03 + 196460 1.070110749078919e+00 -5.914266194208278e+00 -6.020268675847526e+00 4.185092791429872e+00 4.576410138026292e+00 9.279357542598849e+03 + 196480 1.086836737933196e+00 -5.923002859069145e+00 -6.045392817581578e+00 4.040768461553920e+00 4.337986379990662e+00 9.356872293746232e+03 + 196500 1.063765350908134e+00 -5.882912419768585e+00 -5.983161787762685e+00 4.365079833717187e+00 4.789432449155508e+00 9.165402041204641e+03 + 196520 1.055538114352108e+00 -5.874210755132538e+00 -5.983662426551170e+00 4.423587562316857e+00 4.795099127439657e+00 9.166946516208840e+03 + 196540 1.051618388287416e+00 -5.878203699794543e+00 -6.041520903648044e+00 4.296602502451845e+00 4.358809844669429e+00 9.344953799231969e+03 + 196560 1.115458451193030e+00 -5.996223794423486e+00 -5.989011191161680e+00 3.777996710395426e+00 4.819412594471466e+00 9.183349292632141e+03 + 196580 1.033862579646109e+00 -5.911250858712670e+00 -6.002849023699818e+00 4.147106604326715e+00 4.621135766200292e+00 9.225783493539879e+03 + 196600 1.067482220023382e+00 -6.006591471699648e+00 -5.948921644939004e+00 3.654433663764506e+00 4.985582733400976e+00 9.060903279021102e+03 + 196620 1.001309001843889e+00 -5.955028622936048e+00 -5.957653316795782e+00 3.984713486112900e+00 4.969642087800246e+00 9.087478100995009e+03 + 196640 9.663553443466588e-01 -5.939861200482600e+00 -5.992409646777404e+00 3.977219210434471e+00 4.675477899963927e+00 9.193758298196515e+03 + 196660 9.864682861019943e-01 -5.996117088157417e+00 -6.054987010742149e+00 3.697356569391710e+00 4.359316363819106e+00 9.386615653675526e+03 + 196680 9.866292181510660e-01 -6.017747932982147e+00 -6.006458431243194e+00 3.587310822185471e+00 4.652136888215287e+00 9.236899618126414e+03 + 196700 9.213399181871296e-01 -5.931189223530975e+00 -6.023581192197405e+00 4.061771141723238e+00 4.531242160029653e+00 9.289583561160529e+03 + 196720 9.974994271830198e-01 -6.048974735629590e+00 -5.977870233069941e+00 3.414044046153945e+00 4.822337103237658e+00 9.149238909264219e+03 + 196740 9.372145310151810e-01 -5.962242814933930e+00 -5.996508413619376e+00 3.912539290452004e+00 4.715780920215910e+00 9.206285461247051e+03 + 196760 9.279056233827839e-01 -5.947310457490586e+00 -6.014020425483008e+00 3.917079907293330e+00 4.534020947746656e+00 9.260094949201211e+03 + 196780 9.324660087289492e-01 -5.949158082471452e+00 -5.967536018146450e+00 3.926250662843771e+00 4.820721712221579e+00 9.117608915262341e+03 + 196800 9.691260013237579e-01 -5.992676534797638e+00 -5.950140172002222e+00 3.759033450759277e+00 5.003283828411427e+00 9.064610913261837e+03 + 196820 9.814039503164497e-01 -5.996088637448807e+00 -5.978804770235698e+00 3.714757297326284e+00 4.814003937533767e+00 9.152076307009795e+03 + 196840 1.047677099316197e+00 -6.077860326504848e+00 -5.983679945132244e+00 3.276030639420648e+00 4.816828963629057e+00 9.166998701371262e+03 + 196860 1.047747520453599e+00 -6.060897543210794e+00 -5.960941082063933e+00 3.354142953296611e+00 4.928108421414262e+00 9.097563552986076e+03 + 196880 1.022289784596336e+00 -6.008818555388199e+00 -5.992845750577484e+00 3.668072158526428e+00 4.759790475533115e+00 9.195096139647250e+03 + 196900 9.229929960615717e-01 -5.845535916612546e+00 -6.053055999159617e+00 4.516265369474781e+00 4.324652941860511e+00 9.380628717252595e+03 + 196920 1.050814053606426e+00 -6.020025077855585e+00 -6.008298075024983e+00 3.560363964402784e+00 4.627702229403925e+00 9.242545375691092e+03 + 196940 1.043371499551677e+00 -5.995018458764038e+00 -5.994186687777280e+00 3.729568103645593e+00 4.734344261367706e+00 9.199218153115138e+03 + 196960 1.048351363890013e+00 -5.990053585157971e+00 -6.010484992014194e+00 3.763628544024202e+00 4.646308244105780e+00 9.249246344029703e+03 + 196980 9.874874113569309e-01 -5.889677050364088e+00 -6.015752577380118e+00 4.309534529835403e+00 4.585589343584605e+00 9.265469159504757e+03 + 197000 1.079820705247226e+00 -6.017711536696240e+00 -5.987676824663218e+00 3.595407730868390e+00 4.767871695218666e+00 9.179247337686120e+03 + 197020 1.090757564663666e+00 -6.028340538533708e+00 -5.992331734790272e+00 3.561482260634908e+00 4.768250384074089e+00 9.193497506001437e+03 + 197040 1.044083688192767e+00 -5.958009688892636e+00 -5.977395579254579e+00 3.922997560358719e+00 4.811680777943605e+00 9.147773766546354e+03 + 197060 9.997663137644403e-01 -5.894935660164928e+00 -5.980987943983190e+00 4.215571244391156e+00 4.721445714158814e+00 9.158781364357355e+03 + 197080 1.060108581377842e+00 -5.991120285374828e+00 -5.999004175473726e+00 3.688298000577622e+00 4.643027483601708e+00 9.213994365742568e+03 + 197100 9.901753463662631e-01 -5.902191960505883e+00 -6.045070935909322e+00 4.123896820896288e+00 4.303463633679758e+00 9.355920327360420e+03 + 197120 1.020236534807079e+00 -5.970346033454833e+00 -6.022694482894962e+00 3.863316378213017e+00 4.562723480631428e+00 9.286827361780481e+03 + 197140 1.009732137544667e+00 -5.988157177872170e+00 -5.976268229728614e+00 3.721569638007983e+00 4.789837818057059e+00 9.144348688628032e+03 + 197160 9.428450571295194e-01 -5.924106839203908e+00 -5.987727153605924e+00 4.103877355781600e+00 4.738559665273395e+00 9.179404108062769e+03 + 197180 1.034912779845546e+00 -6.093183141932883e+00 -5.971168276171854e+00 3.179195185530944e+00 4.879823426470225e+00 9.128775493968004e+03 + 197200 9.891640301591573e-01 -6.057241984591949e+00 -5.965478607667785e+00 3.431988387838275e+00 4.958907898473509e+00 9.111385903694772e+03 + 197220 9.657594340331794e-01 -6.049174093438138e+00 -5.990994541332087e+00 3.426225518656401e+00 4.760301510105938e+00 9.189399042494322e+03 + 197240 9.339765781687953e-01 -6.019574505798477e+00 -5.998711681669448e+00 3.596648430899665e+00 4.716445995560152e+00 9.213064642070907e+03 + 197260 9.499001586448454e-01 -6.055924515312791e+00 -5.975006439505787e+00 3.447242766104740e+00 4.911886879420318e+00 9.140498009125908e+03 + 197280 9.233242910642313e-01 -6.022291694654089e+00 -5.997722871003016e+00 3.569257369526794e+00 4.710335356944428e+00 9.210066566338732e+03 + 197300 9.496620660420270e-01 -6.060719739300927e+00 -5.956011979606190e+00 3.414897361594151e+00 5.016145521234776e+00 9.082502813236055e+03 + 197320 9.503593608971426e-01 -6.053897022556006e+00 -5.983249272544809e+00 3.377018887998311e+00 4.782689201266589e+00 9.165723319061768e+03 + 197340 9.761143031009127e-01 -6.079580949035935e+00 -5.999664423724060e+00 3.238381680830373e+00 4.697274736213486e+00 9.216022573866338e+03 + 197360 9.346768182604634e-01 -5.998864050798050e+00 -6.021522244778397e+00 3.692938936591987e+00 4.562832080412647e+00 9.283250344106660e+03 + 197380 9.892311127066558e-01 -6.055108835894766e+00 -5.988051731873103e+00 3.378270805893247e+00 4.763323074238945e+00 9.180409483806527e+03 + 197400 9.475529833573469e-01 -5.962392512223929e+00 -5.966188730150639e+00 3.956379215291700e+00 4.934580744493706e+00 9.113500433209887e+03 + 197420 1.048722579066726e+00 -6.073166421074767e+00 -5.994808603576469e+00 3.277150585884818e+00 4.727093299793116e+00 9.201111197472084e+03 + 197440 1.050748489717075e+00 -6.037126385663093e+00 -5.977217549250812e+00 3.543677792050950e+00 4.887683601592745e+00 9.147248592194484e+03 + 197460 9.929795263342298e-01 -5.917928166068546e+00 -6.020714679927558e+00 4.159107294884740e+00 4.568891226144683e+00 9.280748384039072e+03 + 197480 1.030528908472533e+00 -5.947325162502953e+00 -6.005013291818775e+00 4.035322309707878e+00 4.704068143967262e+00 9.232466427690417e+03 + 197500 1.018990311464264e+00 -5.913950968722451e+00 -6.023716022650490e+00 4.226974044454586e+00 4.596686118712583e+00 9.289999916578039e+03 + 197520 1.103125413171622e+00 -6.033279638205990e+00 -5.978291478629676e+00 3.535607080890546e+00 4.851357602567933e+00 9.150513181833465e+03 + 197540 9.918521868153060e-01 -5.868293880123144e+00 -5.991161214522059e+00 4.427615331684855e+00 4.722092083907736e+00 9.189891994335134e+03 + 197560 9.920547105603189e-01 -5.871139024917659e+00 -5.988882591829150e+00 4.369394543554237e+00 4.693292761590369e+00 9.182907631840086e+03 + 197580 9.916333633955182e-01 -5.873602307174070e+00 -5.962438222298370e+00 4.458756620337001e+00 4.948647048379838e+00 9.102039807494270e+03 + 197600 1.033756503283396e+00 -5.939230071460371e+00 -5.966914937219031e+00 3.990664908308536e+00 4.831694124903182e+00 9.115739359301433e+03 + 197620 1.059662956847667e+00 -5.982769069208641e+00 -5.970279183972358e+00 3.829682595239809e+00 4.901401449070038e+00 9.126026637196295e+03 + 197640 1.114696916422550e+00 -6.073508822964579e+00 -5.979698748915194e+00 3.280816907445384e+00 4.819488869698992e+00 9.154850834862209e+03 + 197660 1.088873444844288e+00 -6.052172062010866e+00 -5.967620489041542e+00 3.411659558110119e+00 4.897167774413612e+00 9.117875998016831e+03 + 197680 1.004463468014409e+00 -5.944086418256621e+00 -5.955867022008926e+00 4.052968875870480e+00 4.985322826082205e+00 9.082022820727194e+03 + 197700 9.924027605821176e-01 -5.942523495137124e+00 -5.977513215645520e+00 4.014896585745752e+00 4.813980195944791e+00 9.148116862085810e+03 + 197720 9.799905812762225e-01 -5.937816478924363e+00 -6.008176646201831e+00 4.015742844602350e+00 4.611723875894433e+00 9.242154496518999e+03 + 197740 1.016486507936503e+00 -6.004213476590676e+00 -5.994729787114927e+00 3.664658887791353e+00 4.719115700357310e+00 9.200851550314121e+03 + 197760 1.024897684334583e+00 -6.029821257369699e+00 -5.989162127020075e+00 3.535441262416423e+00 4.768912280864052e+00 9.183816371186842e+03 + 197780 1.003144833351176e+00 -6.011059235592398e+00 -6.007854735074519e+00 3.619858288449541e+00 4.638259026318064e+00 9.241160263625110e+03 + 197800 9.640184593975513e-01 -5.967205765768405e+00 -6.012486127546235e+00 3.843043114696291e+00 4.583036270254652e+00 9.255417607349127e+03 + 197820 9.292015964115172e-01 -5.927906894827223e+00 -6.020028691883120e+00 4.150029645670132e+00 4.621052031173153e+00 9.278627897050830e+03 + 197840 9.969278378842779e-01 -6.038425653113663e+00 -6.011707856469595e+00 3.510095815984067e+00 4.663513538879973e+00 9.253031215391044e+03 + 197860 1.015585866226082e+00 -6.076504741977311e+00 -6.005284742126257e+00 3.284231026357999e+00 4.693187286762107e+00 9.233283746251729e+03 + 197880 9.052103199325080e-01 -5.922557996618851e+00 -6.014025054425375e+00 4.139712794421844e+00 4.614494794015335e+00 9.260139171920477e+03 + 197900 9.628959031997373e-01 -6.017993688652330e+00 -5.999149875244477e+00 3.605347938433688e+00 4.713552031092286e+00 9.214407203227105e+03 + 197920 9.725503214780055e-01 -6.042019212709418e+00 -6.008848160509082e+00 3.464705105197180e+00 4.655178420135244e+00 9.244219486107251e+03 + 197940 9.121817583787587e-01 -5.964084199418634e+00 -6.018497328644591e+00 3.959588819703323e+00 4.647140211283348e+00 9.273916008360336e+03 + 197960 9.895157806835558e-01 -6.092606214624727e+00 -6.029570241624302e+00 3.148647053354223e+00 4.510609365107955e+00 9.308065768254402e+03 + 197980 9.623183552774741e-01 -6.071150850106349e+00 -6.010448068373572e+00 3.349414707395913e+00 4.697979473830632e+00 9.249166694650921e+03 + 198000 9.219195694901473e-01 -6.031484256687113e+00 -5.986864200294160e+00 3.587648495491559e+00 4.843863764231308e+00 9.176748429444106e+03 + 198020 9.257860901456828e-01 -6.053050138978177e+00 -5.951749350964880e+00 3.465985468642824e+00 5.047670269661461e+00 9.069510692116881e+03 + 198040 9.848695055666200e-01 -6.149821997887043e+00 -5.934663431495617e+00 2.934217712869647e+00 5.169691496769756e+00 9.017560926417731e+03 + 198060 9.169650715472569e-01 -6.050085663456841e+00 -5.986274144940001e+00 3.436901950142670e+00 4.803317564266942e+00 9.174938766155332e+03 + 198080 9.153428098125780e-01 -6.042263206337669e+00 -5.970546949950809e+00 3.476794663141194e+00 4.888600505369352e+00 9.126853343151282e+03 + 198100 9.230118481405387e-01 -6.039225976504595e+00 -5.993640798280924e+00 3.483491042564484e+00 4.745248190208333e+00 9.197527933027068e+03 + 198120 9.682070426132244e-01 -6.082865051581861e+00 -5.980530485847439e+00 3.269686567054606e+00 4.857307479724520e+00 9.157375745922451e+03 + 198140 9.409422958646241e-01 -6.010597346153409e+00 -6.032280158021898e+00 3.648815339345968e+00 4.524309278192808e+00 9.316415282154327e+03 + 198160 9.456238154776700e-01 -5.982956535289173e+00 -6.053715304992077e+00 3.798894863917342e+00 4.392587058399039e+00 9.382697071454260e+03 + 198180 9.665147909666656e-01 -5.980338429144319e+00 -6.060867613382381e+00 3.814328932551471e+00 4.351917894805529e+00 9.404844647263137e+03 + 198200 1.057238500661952e+00 -6.085993258131615e+00 -5.996690388231128e+00 3.275311781894115e+00 4.788102680437161e+00 9.206879051063168e+03 + 198220 1.059194223768562e+00 -6.060815167313036e+00 -5.984757246575466e+00 3.408128191045948e+00 4.844864541846269e+00 9.170324514281610e+03 + 198240 1.040616425457865e+00 -6.010643721523284e+00 -6.039488013227714e+00 3.662212994180430e+00 4.496584607573875e+00 9.338654532737906e+03 + 198260 9.964961706761160e-01 -5.927659542858954e+00 -6.072434550655013e+00 4.065352659079077e+00 4.234032160454057e+00 9.440754255724847e+03 + 198280 1.044771250090530e+00 -5.989202092641337e+00 -6.029920233501111e+00 3.770688515755895e+00 4.536878649827138e+00 9.309124202338453e+03 + 198300 1.000101533863586e+00 -5.918555361910573e+00 -6.012538288805040e+00 4.099020859279674e+00 4.559356349240717e+00 9.255585653583408e+03 + 198320 9.569636660291908e-01 -5.852225490752387e+00 -6.032021353279019e+00 4.454855000802558e+00 4.422439334854832e+00 9.315607862567498e+03 + 198340 1.033729659748865e+00 -5.966003819562791e+00 -5.984495017641134e+00 3.884930372651324e+00 4.778751051781821e+00 9.169498870793330e+03 + 198360 1.068080124808481e+00 -6.019844285740517e+00 -6.009428683482852e+00 3.554218769410459e+00 4.614026769383205e+00 9.246006620686147e+03 + 198380 1.010594530450490e+00 -5.942836551660555e+00 -6.003069626272305e+00 4.043787927642594e+00 4.697920292183754e+00 9.226450093924877e+03 + 198400 9.878438663853545e-01 -5.919837954159591e+00 -5.983498196700500e+00 4.186062466665661e+00 4.820515502605066e+00 9.166427411259196e+03 + 198420 1.051304780804985e+00 -6.028779342844048e+00 -5.985859707031013e+00 3.575458449668280e+00 4.821909640298908e+00 9.173675789506657e+03 + 198440 1.019058594488340e+00 -6.004700713912327e+00 -6.031860655810791e+00 3.651820173679865e+00 4.495863584311465e+00 9.315103264697376e+03 + 198460 9.531030557227899e-01 -5.940645356831086e+00 -6.033003233468676e+00 4.011957410800308e+00 4.481624190812045e+00 9.318644195207551e+03 + 198480 9.487234409343656e-01 -5.973289385600593e+00 -6.003489679641627e+00 3.848973946471299e+00 4.675559184607281e+00 9.227772611251210e+03 + 198500 9.843468817542180e-01 -6.066293690406648e+00 -5.998226313135965e+00 3.326052237292759e+00 4.716905650973612e+00 9.211611762490396e+03 + 198520 9.775699798239895e-01 -6.094595020573372e+00 -5.990478948830122e+00 3.190285550784541e+00 4.788136146644314e+00 9.187871525581708e+03 + 198540 9.112889798695463e-01 -6.026822520806770e+00 -6.016127457716182e+00 3.611664122111817e+00 4.673076829433636e+00 9.266640446164918e+03 + 198560 9.550065108479557e-01 -6.113754749086741e+00 -6.008105993155245e+00 3.110780983947523e+00 4.717432489598318e+00 9.241976991816964e+03 + 198580 9.264082384224174e-01 -6.085709525835588e+00 -5.989874208970129e+00 3.278842731173814e+00 4.829143951082639e+00 9.185993707810869e+03 + 198600 8.870629643941131e-01 -6.031288015012554e+00 -6.006949760966275e+00 3.554597117611087e+00 4.694351138677460e+00 9.238399757615698e+03 + 198620 9.150096591345106e-01 -6.066787973804774e+00 -6.006733791003851e+00 3.405251786925606e+00 4.750092197923266e+00 9.237717109580011e+03 + 198640 9.280325586211272e-01 -6.073554042613665e+00 -5.985484618563823e+00 3.306042879494788e+00 4.811751141088309e+00 9.172556617218221e+03 + 198660 9.522651880694178e-01 -6.091807730069959e+00 -6.014699391413894e+00 3.190950652009166e+00 4.633718665049139e+00 9.262259076684508e+03 + 198680 9.652397507033778e-01 -6.093139558566232e+00 -6.024828531319635e+00 3.194031574449522e+00 4.586284063996790e+00 9.293467210357674e+03 + 198700 9.647921822989407e-01 -6.074003634987103e+00 -5.991376330728748e+00 3.373667550685343e+00 4.848126318270825e+00 9.190619774149342e+03 + 198720 9.879549867396080e-01 -6.090124222628625e+00 -5.964910471563664e+00 3.308933221036422e+00 5.027929956416781e+00 9.109644855686305e+03 + 198740 9.757346745331257e-01 -6.053744552690764e+00 -5.981716298887574e+00 3.479293701097414e+00 4.892891080771586e+00 9.161007867643517e+03 + 198760 9.933434004245933e-01 -6.063786927234659e+00 -5.988374112056327e+00 3.392080129147922e+00 4.825112183997339e+00 9.181380286166717e+03 + 198780 9.319522628266075e-01 -5.959474962048544e+00 -5.977904617342761e+00 3.983492206281626e+00 4.877666273602292e+00 9.149319743440697e+03 + 198800 9.540679077867020e-01 -5.977660453623453e+00 -5.975741490210138e+00 3.832755117408694e+00 4.843774102286577e+00 9.142730790887630e+03 + 198820 1.020338983163744e+00 -6.060846574501731e+00 -6.014241206217880e+00 3.355466217165393e+00 4.623081454008698e+00 9.260813631538238e+03 + 198840 1.034631030546345e+00 -6.070454304471387e+00 -5.971458690348827e+00 3.343037524323275e+00 4.911485660136783e+00 9.129659960505542e+03 + 198860 1.032636637383578e+00 -6.056218686564323e+00 -6.022537165324044e+00 3.364999695059459e+00 4.558404202219707e+00 9.286395989618968e+03 + 198880 9.730282110190189e-01 -5.960223865564541e+00 -6.071147203603275e+00 3.861827799923712e+00 4.224888827574212e+00 9.436749984710703e+03 + 198900 9.752407914872872e-01 -5.958775039819126e+00 -6.006756315236792e+00 3.937984888997556e+00 4.662468980470942e+00 9.237817201131245e+03 + 198920 9.580346475055450e-01 -5.927583892409970e+00 -6.016722656839891e+00 4.111675018759516e+00 4.599826439223695e+00 9.268428807085011e+03 + 198940 1.039156479945273e+00 -6.041954699200446e+00 -5.995097587462315e+00 3.461280145737985e+00 4.730340932452939e+00 9.201989876472182e+03 + 198960 9.792529912016147e-01 -5.946938948175706e+00 -6.034209356209880e+00 4.015694870555442e+00 4.514574682571219e+00 9.322342127970962e+03 + 198980 1.045919909573658e+00 -6.040386704984024e+00 -6.022954659725977e+00 3.501467577194148e+00 4.601565078666139e+00 9.287644725282045e+03 + 199000 9.820201902341441e-01 -5.941451892055351e+00 -6.051366364819545e+00 3.973393706130194e+00 4.342247794308504e+00 9.375419298277386e+03 + 199020 1.045387792256588e+00 -6.033096695479033e+00 -6.020713550404889e+00 3.542643986984566e+00 4.613749922285808e+00 9.280746499517512e+03 + 199040 9.835455533475369e-01 -5.942988657796434e+00 -6.058960018596540e+00 3.998275130177628e+00 4.332349629953336e+00 9.398945493800546e+03 + 199060 1.011628037120533e+00 -5.988711021783498e+00 -6.032416896741021e+00 3.767548222569833e+00 4.516582325101449e+00 9.316832958156403e+03 + 199080 1.093986025966084e+00 -6.119036198193902e+00 -6.013918129561304e+00 3.030829310096706e+00 4.634433527153627e+00 9.259847263491227e+03 + 199100 1.016062516621175e+00 -6.019152041969119e+00 -6.018725951344059e+00 3.587655276078587e+00 4.590101954384988e+00 9.274637173343817e+03 + 199120 9.935871484432715e-01 -6.009786784904437e+00 -6.020780801189318e+00 3.650034209824271e+00 4.586904866997959e+00 9.280944768874708e+03 + 199140 9.396478523733792e-01 -5.959916074283486e+00 -6.033236303544082e+00 3.876194623132055e+00 4.455178520448902e+00 9.319367854752243e+03 + 199160 1.007877099675233e+00 -6.092348650485308e+00 -5.989478344398130e+00 3.227329507323285e+00 4.818026724004282e+00 9.184779604655178e+03 + 199180 9.461899773815526e-01 -6.032973235700828e+00 -6.002627685618304e+00 3.540355763785038e+00 4.714604608317587e+00 9.225128874167300e+03 + 199200 9.169446904375247e-01 -6.019126632617641e+00 -5.997209799086605e+00 3.576319367836887e+00 4.702169217591129e+00 9.208489636133518e+03 + 199220 9.655191552051936e-01 -6.113552120495919e+00 -5.926744209665422e+00 3.125824757962981e+00 5.198504690382469e+00 8.993547436383958e+03 + 199240 9.657417036500927e-01 -6.125677031988027e+00 -5.954581422156043e+00 3.056385820498082e+00 5.038843289113387e+00 9.078160732826180e+03 + 199260 9.877273315555719e-01 -6.163001810414066e+00 -5.990981509760339e+00 2.781671000552668e+00 4.769438186961859e+00 9.189401612365369e+03 + 199280 9.164016537739427e-01 -6.057427989294474e+00 -5.970006140233552e+00 3.394534142724440e+00 4.896523928519669e+00 9.125220781308743e+03 + 199300 9.474448171313214e-01 -6.095091760743020e+00 -5.982569132614822e+00 3.191877067034992e+00 4.837999410567528e+00 9.163618069188802e+03 + 199320 9.825702308519964e-01 -6.129777319180471e+00 -5.984787297986816e+00 2.983357250828027e+00 4.815912389655264e+00 9.170418953085722e+03 + 199340 9.233561907968878e-01 -6.017889690848733e+00 -5.983733303433910e+00 3.630539129044245e+00 4.826670391264030e+00 9.167180137520203e+03 + 199360 9.833446666705657e-01 -6.071562030718987e+00 -6.002138341950408e+00 3.277238656398008e+00 4.675880220588303e+00 9.223623351935497e+03 + 199380 9.904879622213187e-01 -6.041612705995380e+00 -5.977971123946595e+00 3.543101385561040e+00 4.908541198188153e+00 9.149553915048507e+03 + 199400 9.531451151255562e-01 -5.944451955308232e+00 -6.020145704520475e+00 4.020207021150083e+00 4.585561799603552e+00 9.278986391660319e+03 + 199420 9.302501168049160e-01 -5.876127504871770e+00 -6.031229636167053e+00 4.436552729181573e+00 4.545932289306807e+00 9.313163269864563e+03 + 199440 1.067356731062996e+00 -6.053025969964114e+00 -6.001881800622634e+00 3.418665160248135e+00 4.712342895141543e+00 9.222807297010597e+03 + 199460 1.049510899882768e+00 -6.009171098342096e+00 -5.962259422337160e+00 3.655704219850209e+00 4.925078323028947e+00 9.101565195316367e+03 + 199480 1.044519255577664e+00 -5.992229978207050e+00 -6.049878297079360e+00 3.710885987918348e+00 4.379860419905029e+00 9.370786156864542e+03 + 199500 9.847609446149433e-01 -5.900903108064672e+00 -6.017893280075429e+00 4.252555905378914e+00 4.580780233522542e+00 9.272040626800444e+03 + 199520 9.726026013727151e-01 -5.881495003585851e+00 -6.036443208744220e+00 4.348750297248522e+00 4.459013725071912e+00 9.329243017857832e+03 + 199540 1.010034818694413e+00 -5.940409035620492e+00 -6.038026222552443e+00 4.013419066226046e+00 4.452886072651932e+00 9.334132119631533e+03 + 199560 1.040614778341884e+00 -5.991255001091267e+00 -6.014165865584546e+00 3.761870949825876e+00 4.630313220460650e+00 9.260570532384259e+03 + 199580 9.876228168731374e-01 -5.920005727090434e+00 -5.986205024750682e+00 4.158082425501370e+00 4.777955814028018e+00 9.174758238441040e+03 + 199600 1.012865828224957e+00 -5.965936366697965e+00 -5.983591445494183e+00 3.864537565495610e+00 4.763159370933115e+00 9.166728018144922e+03 + 199620 9.781413945744000e-01 -5.923538991148838e+00 -5.969799366321246e+00 4.156505310912000e+00 4.890871077902111e+00 9.124570404367860e+03 + 199640 1.099765286334250e+00 -6.114689303161841e+00 -5.986635051507113e+00 3.117695888685802e+00 4.853003218018651e+00 9.176076291045239e+03 + 199660 9.733540898763735e-01 -5.943014965150123e+00 -6.026748203311058e+00 3.953333946392712e+00 4.472524735195893e+00 9.299371258522997e+03 + 199680 1.020419325781833e+00 -6.029875926956803e+00 -6.008154673470141e+00 3.556826355567539e+00 4.681553154441065e+00 9.242086748417116e+03 + 199700 9.810593732039271e-01 -5.990291462713761e+00 -5.967726450473815e+00 3.744230860893893e+00 4.873802653100023e+00 9.118263504756900e+03 + 199720 9.784782707049126e-01 -6.006654552718952e+00 -5.985793021212336e+00 3.668265940296609e+00 4.788056082519161e+00 9.173492287727226e+03 + 199740 9.418235269606751e-01 -5.974755483458068e+00 -6.013514831715964e+00 3.892227035818223e+00 4.669664860131629e+00 9.258555704354141e+03 + 199760 9.832394135578619e-01 -6.060661637263619e+00 -6.009626350201415e+00 3.325320325409244e+00 4.618372841405569e+00 9.246627143084354e+03 + 199780 9.498194638281705e-01 -6.035882868576457e+00 -6.000101480557392e+00 3.474210718137948e+00 4.679672985295322e+00 9.217356306124026e+03 + 199800 9.583864529664586e-01 -6.076119003394955e+00 -6.009708957467579e+00 3.242593120679117e+00 4.623929881315505e+00 9.246899990826470e+03 + 199820 9.904273190776074e-01 -6.154404000245639e+00 -5.941030166708029e+00 2.909664010944320e+00 5.134889582611303e+00 9.036909661193709e+03 + 199840 9.102207622852591e-01 -6.065663616522880e+00 -5.978347946184162e+00 3.372945213680421e+00 4.874325304821653e+00 9.150648183986643e+03 + 199860 8.494642503362303e-01 -6.001629984670598e+00 -6.000908287105964e+00 3.689399501675942e+00 4.693543600774409e+00 9.219824648728385e+03 + 199880 9.124194373292649e-01 -6.115327755301041e+00 -6.013664364930694e+00 3.022386552368757e+00 4.606153472234109e+00 9.259048264012663e+03 + 199900 9.012855081825699e-01 -6.115355873351151e+00 -5.968200087682216e+00 3.132786366069281e+00 4.977777659664543e+00 9.119696429693091e+03 + 199920 8.478880513404523e-01 -6.043267344699284e+00 -5.977625330208900e+00 3.500506679661614e+00 4.877433284934312e+00 9.148497479033846e+03 + 199940 8.660608083304254e-01 -6.064289496109857e+00 -6.010313559354831e+00 3.416172307521693e+00 4.726110489118270e+00 9.248739882428541e+03 + 199960 9.304301216794905e-01 -6.139891398497096e+00 -5.977879919520982e+00 3.023079698606037e+00 4.953374682082232e+00 9.149294637624478e+03 + 199980 9.633635787878904e-01 -6.153324116670857e+00 -5.981484082093043e+00 2.878934939218798e+00 4.865667009924017e+00 9.160317920496162e+03 + 200000 9.635163730977483e-01 -6.102203225911095e+00 -5.997212004084306e+00 3.191924486932165e+00 4.794800330000662e+00 9.208486378845661e+03 +Loop time of 56.3641 on 4 procs for 200000 steps with 256 atoms + +Performance: 1532891.800 tau/day, 3548.361 timesteps/s +98.3% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 25.291 | 28.255 | 31.464 | 44.1 | 50.13 +Neigh | 5.5169 | 5.6888 | 5.8734 | 6.9 | 10.09 +Comm | 11.506 | 14.839 | 17.828 | 63.0 | 26.33 +Output | 5.5139 | 5.5345 | 5.5859 | 1.3 | 9.82 +Modify | 1.4354 | 1.497 | 1.6066 | 5.6 | 2.66 +Other | | 0.5505 | | | 0.98 + +Nlocal: 64 ave 65 max 63 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 1334.5 ave 1343 max 1328 min +Histogram: 1 0 0 1 1 0 0 0 0 1 +Neighs: 4748.25 ave 5438 max 4111 min +Histogram: 1 0 0 0 1 1 0 0 0 1 + +Total # of neighbors = 18993 +Ave neighs/atom = 74.1914 +Neighbor list builds = 19989 +Dangerous builds = 19885 +Total wall time: 0:01:01 -- GitLab From 02373c4c3b932db416869b07da68207d439ecc9b Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 29 Mar 2019 15:22:44 -0400 Subject: [PATCH 009/469] Move HMA bits into USER-HMA package --- src/USER-HMA/Install.sh | 31 ++++++++++++++++++++++++++++++ src/{ => USER-HMA}/compute_hma.cpp | 0 src/{ => USER-HMA}/compute_hma.h | 0 3 files changed, 31 insertions(+) create mode 100644 src/USER-HMA/Install.sh rename src/{ => USER-HMA}/compute_hma.cpp (100%) rename src/{ => USER-HMA}/compute_hma.h (100%) diff --git a/src/USER-HMA/Install.sh b/src/USER-HMA/Install.sh new file mode 100644 index 0000000000..1f8f418ca2 --- /dev/null +++ b/src/USER-HMA/Install.sh @@ -0,0 +1,31 @@ +# Install/Uninstall package files in LAMMPS +# mode = 0/1/2 for uninstall/install/update + +mode=$1 + +# enforce using portable C locale +LC_ALL=C +export LC_ALL + +# arg1 = file, arg2 = file it depends on + +action () { + if (test $mode = 0) then + rm -f ../$1 + elif (! cmp -s $1 ../$1) then + if (test -z "$2" || test -e ../$2) then + cp $1 .. + if (test $mode = 2) then + echo " updating src/$1" + fi + fi + elif (test -n "$2") then + if (test ! -e ../$2) then + rm -f ../$1 + fi + fi +} + +# package files without dependencies +action compute_hma.h +action compute_hma.cpp diff --git a/src/compute_hma.cpp b/src/USER-HMA/compute_hma.cpp similarity index 100% rename from src/compute_hma.cpp rename to src/USER-HMA/compute_hma.cpp diff --git a/src/compute_hma.h b/src/USER-HMA/compute_hma.h similarity index 100% rename from src/compute_hma.h rename to src/USER-HMA/compute_hma.h -- GitLab From d000c6883b205b92425a61e3a86b23116a1f3795 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 29 Mar 2019 15:41:15 -0400 Subject: [PATCH 010/469] Mention need to build HMA as USER pacakge --- doc/src/compute_hma.txt | 8 +++++++- 1 file changed, 7 insertions(+), 1 deletion(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index f71ddc9e2e..c4ade07ad7 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -132,7 +132,13 @@ output"_Howto_output.html doc page for an overview of LAMMPS output options. The vector values calculated by this compute are "extensive". The scalar value will be in energy "units"_units.html. -[Restrictions:] Usage restricted to canonical (NVT) ensemble simulation only. +[Restrictions:] + +This compute is distributed as the USER-HMA package. It is only +enabled if LAMMPS was built with that package. See the "Build +package"_Build_package.html doc page for more info. + +Usage restricted to canonical (NVT) ensemble simulation only. [Related commands:] -- GitLab From 62bfd300f0a7ea8ee5efb2324f42affed303c481 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Tue, 16 Apr 2019 13:43:02 +0200 Subject: [PATCH 011/469] Gitignore update --- src/.gitignore | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/.gitignore b/src/.gitignore index 9670d1ca20..00fff20131 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -760,6 +760,8 @@ /pair_comb3.h /pair_colloid.cpp /pair_colloid.h +/pair_cosine_squared.cpp +/pair_cosine_squared.h /pair_coul_diel.cpp /pair_coul_diel.h /pair_coul_long.cpp -- GitLab From 99430767dfa399dd1b8fd8a0ecf71fdef5544c5d Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Tue, 30 Apr 2019 21:45:21 -0500 Subject: [PATCH 012/469] Start devel of native support for KIM simulator models * CMake change to use KIM-API SimulatorModels branch * Minimal changes to pair_kim to illustrate use of KIM API interface. Only c++ interface is implemented for development. * Added example input: in.kim.simulator-model --- cmake/CMakeLists.txt | 6 +++-- examples/kim/in.kim.simulator-model | 41 +++++++++++++++++++++++++++++ src/KIM/pair_kim.cpp | 21 ++++++++++++++- src/KIM/pair_kim.h | 2 ++ 4 files changed, 67 insertions(+), 3 deletions(-) create mode 100644 examples/kim/in.kim.simulator-model diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index dbbbc7f7ac..6acc61576a 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -738,8 +738,10 @@ if(PKG_KIM) enable_language(Fortran) include(ExternalProject) ExternalProject_Add(kim_build - URL https://s3.openkim.org/kim-api/kim-api-2.0.2.txz - URL_MD5 537d9c0abd30f85b875ebb584f9143fa + GIT_REPOSITORY https://github.com/openkim/kim-api.git + GIT_TAG SimulatorModels + #URL https://s3.openkim.org/kim-api/kim-api-2.0.2.txz + #URL_MD5 537d9c0abd30f85b875ebb584f9143fa BINARY_DIR build CMAKE_ARGS -DCMAKE_C_COMPILER=${CMAKE_C_COMPILER} -DCMAKE_CXX_COMPILER=${CMAKE_CXX_COMPILER} diff --git a/examples/kim/in.kim.simulator-model b/examples/kim/in.kim.simulator-model new file mode 100644 index 0000000000..32baf9d78e --- /dev/null +++ b/examples/kim/in.kim.simulator-model @@ -0,0 +1,41 @@ +# 3d Lennard-Jones melt +# +# This example requires that the example models provided with +# the kim-api package are installed. see the ./lib/kim/README or +# ./lib/kim/Install.py files for details on how to install these +# example models. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable yy equal 20*$y +variable zz equal 20*$z + +units metal +atom_style atomic +newton off + +lattice fcc 4.4300 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +create_box 1 box +create_atoms 1 box + +#pair_style lj/cut 8.1500 +#pair_coeff 1 1 0.0104 3.4000 + +pair_style kim ex_sim_model_Si_mod_tersoff +pair_coeff * * Ar + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index a1c13ae81f..01b435194e 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -87,6 +87,7 @@ PairKIM::PairKIM(LAMMPS *lmp) : chargeUnit(KIM_CHARGE_UNIT_unused), temperatureUnit(KIM_TEMPERATURE_UNIT_unused), timeUnit(KIM_TIME_UNIT_unused), + simulatorModel(NULL), pkim(NULL), pargs(NULL), kim_model_support_for_energy(KIM_SUPPORT_STATUS_notSupported), @@ -396,8 +397,10 @@ void PairKIM::coeff(int narg, char **arg) // Assume all species arguments are valid // errors will be detected by below + std::string atom_type_sym_list; lmps_num_unique_elements = 0; for (i = 2; i < narg; i++) { + atom_type_sym_list += std::string(" ") + arg[i]; for (j = 0; j < lmps_num_unique_elements; j++) if (strcmp(arg[i],lmps_unique_elements[j]) == 0) break; lmps_map_species_to_unique[i-1] = j; @@ -422,6 +425,15 @@ void PairKIM::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); + if (simulatorModel) + { + simulatorModel->AddTemplateMap("atom-type-sym-list", atom_type_sym_list); + simulatorModel->CloseTemplateMap(); + + error->all(FLERR,(simulatorModel->ToString()).c_str()); + } + else + { // setup mapping between LAMMPS unique elements and KIM species codes if (kim_particle_codes_ok) { @@ -449,6 +461,7 @@ void PairKIM::coeff(int narg, char **arg) error->all(FLERR, msg.str().c_str()); } } + } return; } @@ -770,7 +783,13 @@ void PairKIM::kim_init() &requestedUnitsAccepted, &pkim); if (kimerror) - error->all(FLERR,"KIM ModelCreate failed"); + { + kimerror = KIM::SimulatorModel::Create(kim_modelname,&simulatorModel); + if (kimerror) + error->all(FLERR,"KIM ModelCreate failed"); + else + return; + } else { if (!requestedUnitsAccepted) { error->all(FLERR,"KIM Model did not accept the requested unit system"); diff --git a/src/KIM/pair_kim.h b/src/KIM/pair_kim.h index 27bab6c687..dcfb4a8af0 100644 --- a/src/KIM/pair_kim.h +++ b/src/KIM/pair_kim.h @@ -68,6 +68,7 @@ class KIM_API_model; extern "C" { #include "KIM_SimulatorHeaders.h" } +#include "KIM_SimulatorModel.hpp" #include @@ -121,6 +122,7 @@ namespace LAMMPS_NS { KIM_TemperatureUnit temperatureUnit; KIM_TimeUnit timeUnit; + KIM::SimulatorModel * simulatorModel; KIM_Model * pkim; KIM_ComputeArguments * pargs; -- GitLab From 11407a165b1b3d26e09e9f6f3a7c0ac96a6080af Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 7 May 2019 18:21:58 -0400 Subject: [PATCH 013/469] reformat pair style kim to LAMMPS style and add some existing simiulator model code (non-functional) --- src/KIM/pair_kim.cpp | 1465 ++++++++++++++++++++---------------------- src/KIM/pair_kim.h | 201 +++--- 2 files changed, 792 insertions(+), 874 deletions(-) diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index 01b435194e..d75d960355 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -55,6 +55,7 @@ #include #include +#include // includes from LAMMPS #include "pair_kim.h" @@ -74,201 +75,187 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ PairKIM::PairKIM(LAMMPS *lmp) : - Pair(lmp), - settings_call_count(0), - init_style_call_count(0), - kim_modelname(NULL), - lmps_map_species_to_unique(NULL), - lmps_unique_elements(NULL), - lmps_num_unique_elements(0), - lmps_units(METAL), - lengthUnit(KIM_LENGTH_UNIT_unused), - energyUnit(KIM_ENERGY_UNIT_unused), - chargeUnit(KIM_CHARGE_UNIT_unused), - temperatureUnit(KIM_TEMPERATURE_UNIT_unused), - timeUnit(KIM_TIME_UNIT_unused), - simulatorModel(NULL), - pkim(NULL), - pargs(NULL), - kim_model_support_for_energy(KIM_SUPPORT_STATUS_notSupported), - kim_model_support_for_forces(KIM_SUPPORT_STATUS_notSupported), - kim_model_support_for_particleEnergy(KIM_SUPPORT_STATUS_notSupported), - kim_model_support_for_particleVirial(KIM_SUPPORT_STATUS_notSupported), - lmps_local_tot_num_atoms(0), - kim_global_influence_distance(0.0), - kim_number_of_neighbor_lists(0), - kim_cutoff_values(NULL), - modelWillNotRequestNeighborsOfNoncontributingParticles(NULL), - neighborLists(NULL), - kim_particle_codes(NULL), - lmps_maxalloc(0), - kim_particleSpecies(NULL), - kim_particleContributing(NULL), - lmps_stripped_neigh_list(NULL), - lmps_stripped_neigh_ptr(NULL) + Pair(lmp), + settings_call_count(0), + init_style_call_count(0), + kim_modelname(NULL), + lmps_map_species_to_unique(NULL), + lmps_unique_elements(NULL), + lmps_num_unique_elements(0), + lmps_units(METAL), + lengthUnit(KIM_LENGTH_UNIT_unused), + energyUnit(KIM_ENERGY_UNIT_unused), + chargeUnit(KIM_CHARGE_UNIT_unused), + temperatureUnit(KIM_TEMPERATURE_UNIT_unused), + timeUnit(KIM_TIME_UNIT_unused), + simulatorModel(NULL), + pkim(NULL), + pargs(NULL), + kim_model_support_for_energy(KIM_SUPPORT_STATUS_notSupported), + kim_model_support_for_forces(KIM_SUPPORT_STATUS_notSupported), + kim_model_support_for_particleEnergy(KIM_SUPPORT_STATUS_notSupported), + kim_model_support_for_particleVirial(KIM_SUPPORT_STATUS_notSupported), + lmps_local_tot_num_atoms(0), + kim_global_influence_distance(0.0), + kim_number_of_neighbor_lists(0), + kim_cutoff_values(NULL), + modelWillNotRequestNeighborsOfNoncontributingParticles(NULL), + neighborLists(NULL), + kim_particle_codes(NULL), + lmps_maxalloc(0), + kim_particleSpecies(NULL), + kim_particleContributing(NULL), + lmps_stripped_neigh_list(NULL), + lmps_stripped_neigh_ptr(NULL), + simulator_class(NULL), + simulator_style(NULL) { - // Initialize Pair data members to appropriate values - single_enable = 0; // We do not provide the Single() function - restartinfo = 0; // We do not write any restart info - one_coeff = 1; // We only allow one coeff * * call - // set to 1, regardless use of fdotr, to avoid ev_set()'s futzing with - // vflag_global - no_virial_fdotr_compute = 1; - - // BEGIN: initial values that determine the KIM state - // (used by kim_free(), etc.) - kim_init_ok = false; - kim_particle_codes_ok = false; - // END - - return; + // Initialize Pair data members to appropriate values + single_enable = 0; // We do not provide the Single() function + restartinfo = 0; // We do not write any restart info + one_coeff = 1; // We only allow one coeff * * call + // set to 1, regardless use of fdotr, to avoid ev_set()'s futzing with + // vflag_global + no_virial_fdotr_compute = 1; + + // BEGIN: initial values that determine the KIM state + // (used by kim_free(), etc.) + kim_init_ok = false; + kim_particle_codes_ok = false; + // END } /* ---------------------------------------------------------------------- */ PairKIM::~PairKIM() { - // clean up kim_modelname - if (kim_modelname != 0) delete [] kim_modelname; + // clean up kim_modelname + if (kim_modelname != 0) delete [] kim_modelname; + + // clean up lammps atom species number to unique particle names mapping + if (lmps_unique_elements) + for (int i = 0; i < lmps_num_unique_elements; i++) + delete [] lmps_unique_elements[i]; + delete [] lmps_unique_elements; + + if (kim_particle_codes_ok) { + delete [] kim_particle_codes; + kim_particle_codes = NULL; + kim_particle_codes_ok = false; + } - // clean up lammps atom species number to unique particle names mapping - if (lmps_unique_elements) - for (int i = 0; i < lmps_num_unique_elements; i++) - delete [] lmps_unique_elements[i]; - delete [] lmps_unique_elements; + // clean up local memory used to support KIM interface + memory->destroy(kim_particleSpecies); + memory->destroy(kim_particleContributing); + memory->destroy(lmps_stripped_neigh_list); + // clean up lmps_stripped_neigh_ptr + if (lmps_stripped_neigh_ptr) { + delete [] lmps_stripped_neigh_ptr; + lmps_stripped_neigh_ptr = 0; + } - if (kim_particle_codes_ok) - { - delete [] kim_particle_codes; - kim_particle_codes = NULL; - kim_particle_codes_ok = false; - } - - // clean up local memory used to support KIM interface - memory->destroy(kim_particleSpecies); - memory->destroy(kim_particleContributing); - memory->destroy(lmps_stripped_neigh_list); - // clean up lmps_stripped_neigh_ptr - if (lmps_stripped_neigh_ptr) - { - delete [] lmps_stripped_neigh_ptr; - lmps_stripped_neigh_ptr = 0; - } - - // clean up allocated memory for standard Pair class usage - // also, we allocate lmps_map_species_to_uniuqe in the allocate() function - if (allocated) { - memory->destroy(setflag); - memory->destroy(cutsq); - delete [] lmps_map_species_to_unique; - } - - // clean up neighborlist pointers - if (neighborLists) - { - delete [] neighborLists; - neighborLists = 0; - } - - // clean up KIM interface (if necessary) - kim_free(); - - return; + // clean up allocated memory for standard Pair class usage + // also, we allocate lmps_map_species_to_uniuqe in the allocate() function + if (allocated) { + memory->destroy(setflag); + memory->destroy(cutsq); + delete [] lmps_map_species_to_unique; + } + + // clean up neighborlist pointers + if (neighborLists) { + delete [] neighborLists; + neighborLists = 0; + } + + // clean up KIM interface (if necessary) + kim_free(); } /* ---------------------------------------------------------------------- */ + void PairKIM::set_contributing() { int const nall = atom->nlocal + atom->nghost; for (int i = 0; i < nall; ++i) - { kim_particleContributing[i] = ( (i < atom->nlocal) ? 1 : 0 ); - } } /* ---------------------------------------------------------------------- */ -void PairKIM::compute(int eflag , int vflag) +void PairKIM::compute(int eflag, int vflag) { - ev_init(eflag,vflag); - - // grow kim_particleSpecies and kim_particleContributing array if necessary - // needs to be atom->nmax in length - if (atom->nmax > lmps_maxalloc) { - memory->destroy(kim_particleSpecies); - memory->destroy(kim_particleContributing); - - lmps_maxalloc = atom->nmax; - memory->create(kim_particleSpecies,lmps_maxalloc, - "pair:kim_particleSpecies"); - int kimerror = KIM_ComputeArguments_SetArgumentPointerInteger(pargs, - KIM_COMPUTE_ARGUMENT_NAME_particleSpeciesCodes, - kim_particleSpecies); - memory->create(kim_particleContributing,lmps_maxalloc, - "pair:kim_particleContributing"); - kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerInteger( - pargs, - KIM_COMPUTE_ARGUMENT_NAME_particleContributing, - kim_particleContributing); - if (kimerror) - error->all( - FLERR, - "Unable to set KIM particle species codes and/or contributing"); - } - - // kim_particleSpecies = KIM atom species for each LAMMPS atom - - int *species = atom->type; - int nall = atom->nlocal + atom->nghost; - int ielement; - - for (int i = 0; i < nall; i++) { - ielement = lmps_map_species_to_unique[species[i]]; - kim_particleSpecies[i] = kim_particle_codes[ielement]; - } - - // Set kim contributing flags - set_contributing(); - - // pass current atom pointers to KIM - set_argument_pointers(); - - // set number of particles - lmps_local_tot_num_atoms = (int) nall; - - // compute via KIM model - int kimerror = KIM_Model_Compute(pkim, pargs); - if (kimerror) error->all(FLERR,"KIM Compute returned error"); - - // compute virial before reverse comm! - if (vflag_global) - { - virial_fdotr_compute(); - } - - // if newton is off, perform reverse comm - if (!lmps_using_newton) - { - comm->reverse_comm_pair(this); - } - - if ((vflag_atom) && - KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported) - ) - { // flip sign and order of virial if KIM is computing it - double tmp; - for (int i = 0; i < nall; ++i) - { - for (int j = 0; j < 3; ++j) vatom[i][j] = -1.0*vatom[i][j]; - tmp = vatom[i][3]; - vatom[i][3] = -vatom[i][5]; - vatom[i][4] = -vatom[i][4]; - vatom[i][5] = -tmp; - } - } + ev_init(eflag,vflag); + + // grow kim_particleSpecies and kim_particleContributing array if necessary + // needs to be atom->nmax in length + if (atom->nmax > lmps_maxalloc) { + memory->destroy(kim_particleSpecies); + memory->destroy(kim_particleContributing); + + lmps_maxalloc = atom->nmax; + memory->create(kim_particleSpecies,lmps_maxalloc, + "pair:kim_particleSpecies"); + int kimerror = KIM_ComputeArguments_SetArgumentPointerInteger(pargs, + KIM_COMPUTE_ARGUMENT_NAME_particleSpeciesCodes, + kim_particleSpecies); + memory->create(kim_particleContributing,lmps_maxalloc, + "pair:kim_particleContributing"); + kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerInteger( + pargs, + KIM_COMPUTE_ARGUMENT_NAME_particleContributing, + kim_particleContributing); + if (kimerror) + error->all(FLERR, + "Unable to set KIM particle species codes and/or contributing"); + } + + // kim_particleSpecies = KIM atom species for each LAMMPS atom - return; + int *species = atom->type; + int nall = atom->nlocal + atom->nghost; + int ielement; + + for (int i = 0; i < nall; i++) { + ielement = lmps_map_species_to_unique[species[i]]; + kim_particleSpecies[i] = kim_particle_codes[ielement]; + } + + // Set kim contributing flags + set_contributing(); + + // pass current atom pointers to KIM + set_argument_pointers(); + + // set number of particles + lmps_local_tot_num_atoms = (int) nall; + + // compute via KIM model + int kimerror = KIM_Model_Compute(pkim, pargs); + if (kimerror) error->all(FLERR,"KIM Compute returned error"); + + // compute virial before reverse comm! + if (vflag_global) + virial_fdotr_compute(); + + // if newton is off, perform reverse comm + if (!lmps_using_newton) { + comm->reverse_comm_pair(this); + } + + if ((vflag_atom) && + KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported)) { + // flip sign and order of virial if KIM is computing it + double tmp; + for (int i = 0; i < nall; ++i) { + for (int j = 0; j < 3; ++j) vatom[i][j] = -1.0*vatom[i][j]; + tmp = vatom[i][3]; + vatom[i][3] = -vatom[i][5]; + vatom[i][4] = -vatom[i][4]; + vatom[i][5] = -tmp; + } + } } /* ---------------------------------------------------------------------- @@ -277,22 +264,20 @@ void PairKIM::compute(int eflag , int vflag) void PairKIM::allocate() { - int n = atom->ntypes; + int n = atom->ntypes; - // allocate standard Pair class arrays - memory->create(setflag,n+1,n+1,"pair:setflag"); - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; + // allocate standard Pair class arrays + memory->create(setflag,n+1,n+1,"pair:setflag"); + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; - memory->create(cutsq,n+1,n+1,"pair:cutsq"); + memory->create(cutsq,n+1,n+1,"pair:cutsq"); - // allocate mapping array - lmps_map_species_to_unique = new int[n+1]; + // allocate mapping array + lmps_map_species_to_unique = new int[n+1]; - allocated = 1; - - return; + allocated = 1; } /* ---------------------------------------------------------------------- @@ -301,56 +286,54 @@ void PairKIM::allocate() void PairKIM::settings(int narg, char **arg) { - // This is called when "pair_style kim ..." is read from input - // may be called multiple times - ++settings_call_count; - init_style_call_count = 0; - - if (narg != 1) - { - if ((narg > 0) && ((0 == strcmp("KIMvirial", arg[0])) || - (0 == strcmp("LAMMPSvirial", arg[0])))) - { - error->all(FLERR,"'KIMvirial' or 'LAMMPSvirial' not supported with " - "kim-api."); - } - else - error->all(FLERR,"Illegal pair_style command"); - } - // arg[0] is the KIM Model name - - lmps_using_molecular = (atom->molecular > 0); - - // ensure we are in a clean state for KIM (needed on repeated call) - // first time called will do nothing... - kim_free(); - - // make sure things are allocated - if (allocated != 1) allocate(); - - // clear setflag to ensure coeff() is called after settings() - int n = atom->ntypes; - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; - - // set lmps_* bool flags - set_lmps_flags(); - - // set KIM Model name - int nmlen = strlen(arg[0]); - if (kim_modelname != 0) - { - delete [] kim_modelname; - kim_modelname = 0; - } - kim_modelname = new char[nmlen+1]; - strcpy(kim_modelname, arg[0]); - - // initialize KIM Model - kim_init(); - - return; + // This is called when "pair_style kim ..." is read from input + // may be called multiple times + ++settings_call_count; + init_style_call_count = 0; + + if (narg != 1) { + if ((narg > 0) && ((0 == strcmp("KIMvirial", arg[0])) || + (0 == strcmp("LAMMPSvirial", arg[0])))) { + error->all(FLERR,"'KIMvirial' or 'LAMMPSvirial' not supported with " + "kim-api."); + } else error->all(FLERR,"Illegal pair_style command"); + } + // arg[0] is the KIM Model name + + lmps_using_molecular = (atom->molecular > 0); + + // ensure we are in a clean state for KIM (needed on repeated call) + // first time called will do nothing... + kim_free(); + + // make sure things are allocated + if (allocated != 1) allocate(); + + // clear setflag to ensure coeff() is called after settings() + int n = atom->ntypes; + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; + + // set lmps_* bool flags + set_lmps_flags(); + + // set KIM Model name + int nmlen = strlen(arg[0]); + if (kim_modelname != 0) { + delete [] kim_modelname; + kim_modelname = 0; + } + kim_modelname = new char[nmlen+1]; + strcpy(kim_modelname, arg[0]); + + // initialize KIM Model + kim_init(); + + // initialize LAMMPS Simulator model + if (simulatorModel) { + printf("LAMMPS simulator model: %s\n",kim_modelname); + } } /* ---------------------------------------------------------------------- @@ -359,91 +342,85 @@ void PairKIM::settings(int narg, char **arg) void PairKIM::coeff(int narg, char **arg) { - // This is called when "pair_coeff ..." is read from input - // may be called multiple times - - int i,j,n; - - if (!allocated) allocate(); - - if (narg != 2 + atom->ntypes) - error->all(FLERR,"Incorrect args for pair coefficients"); - - // insure I,J args are * * - - if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) - error->all(FLERR,"Incorrect args for pair coefficients"); - - - int ilo,ihi,jlo,jhi; - force->bounds(FLERR,arg[0],atom->ntypes,ilo,ihi); - force->bounds(FLERR,arg[1],atom->ntypes,jlo,jhi); - - // read args that map atom species to KIM elements - // lmps_map_species_to_unique[i] = - // which element the Ith atom type is - // lmps_num_unique_elements = # of unique elements - // lmps_unique_elements = list of element names - - // if called multiple times: update lmps_unique_elements - if (lmps_unique_elements) { - for (i = 0; i < lmps_num_unique_elements; i++) - delete [] lmps_unique_elements[i]; - delete [] lmps_unique_elements; - } - lmps_unique_elements = new char*[atom->ntypes]; - for (i = 0; i < atom->ntypes; i++) lmps_unique_elements[i] = 0; - - - // Assume all species arguments are valid - // errors will be detected by below - std::string atom_type_sym_list; - lmps_num_unique_elements = 0; - for (i = 2; i < narg; i++) { - atom_type_sym_list += std::string(" ") + arg[i]; - for (j = 0; j < lmps_num_unique_elements; j++) - if (strcmp(arg[i],lmps_unique_elements[j]) == 0) break; - lmps_map_species_to_unique[i-1] = j; - if (j == lmps_num_unique_elements) { - n = strlen(arg[i]) + 1; - lmps_unique_elements[j] = new char[n]; - strcpy(lmps_unique_elements[j],arg[i]); - lmps_num_unique_elements++; - } - } - - int count = 0; - for (int i = ilo; i <= ihi; i++) { - for (int j = MAX(jlo,i); j <= jhi; j++) { - if (lmps_map_species_to_unique[i] >= 0 && - lmps_map_species_to_unique[j] >= 0) { - setflag[i][j] = 1; - count++; - } - } - } - - if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); - - if (simulatorModel) - { - simulatorModel->AddTemplateMap("atom-type-sym-list", atom_type_sym_list); - simulatorModel->CloseTemplateMap(); - - error->all(FLERR,(simulatorModel->ToString()).c_str()); - } - else - { - // setup mapping between LAMMPS unique elements and KIM species codes - if (kim_particle_codes_ok) - { - delete [] kim_particle_codes; - kim_particle_codes = NULL; - kim_particle_codes_ok = false; - } - kim_particle_codes = new int[lmps_num_unique_elements]; - kim_particle_codes_ok = true; - for(int i = 0; i < lmps_num_unique_elements; i++){ + // This is called when "pair_coeff ..." is read from input + // may be called multiple times + + int i,j,n; + + if (!allocated) allocate(); + + if (narg != 2 + atom->ntypes) + error->all(FLERR,"Incorrect args for pair coefficients"); + + // insure I,J args are * * + + if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) + error->all(FLERR,"Incorrect args for pair coefficients"); + + int ilo,ihi,jlo,jhi; + force->bounds(FLERR,arg[0],atom->ntypes,ilo,ihi); + force->bounds(FLERR,arg[1],atom->ntypes,jlo,jhi); + + // read args that map atom species to KIM elements + // lmps_map_species_to_unique[i] = + // which element the Ith atom type is + // lmps_num_unique_elements = # of unique elements + // lmps_unique_elements = list of element names + + // if called multiple times: update lmps_unique_elements + if (lmps_unique_elements) { + for (i = 0; i < lmps_num_unique_elements; i++) + delete [] lmps_unique_elements[i]; + delete [] lmps_unique_elements; + } + lmps_unique_elements = new char*[atom->ntypes]; + for (i = 0; i < atom->ntypes; i++) lmps_unique_elements[i] = 0; + + // Assume all species arguments are valid + // errors will be detected by below + std::string atom_type_sym_list; + lmps_num_unique_elements = 0; + for (i = 2; i < narg; i++) { + atom_type_sym_list += std::string(" ") + arg[i]; + for (j = 0; j < lmps_num_unique_elements; j++) + if (strcmp(arg[i],lmps_unique_elements[j]) == 0) break; + lmps_map_species_to_unique[i-1] = j; + if (j == lmps_num_unique_elements) { + n = strlen(arg[i]) + 1; + lmps_unique_elements[j] = new char[n]; + strcpy(lmps_unique_elements[j],arg[i]); + lmps_num_unique_elements++; + } + } + + int count = 0; + for (int i = ilo; i <= ihi; i++) { + for (int j = MAX(jlo,i); j <= jhi; j++) { + if (lmps_map_species_to_unique[i] >= 0 && + lmps_map_species_to_unique[j] >= 0) { + setflag[i][j] = 1; + count++; + } + } + } + + if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); + + if (simulatorModel) { + simulatorModel->AddTemplateMap("atom-type-sym-list", atom_type_sym_list); + simulatorModel->CloseTemplateMap(); + + error->all(FLERR,(simulatorModel->ToString()).c_str()); + } else { + // setup mapping between LAMMPS unique elements and KIM species codes + if (kim_particle_codes_ok) { + delete [] kim_particle_codes; + kim_particle_codes = NULL; + kim_particle_codes_ok = false; + } + kim_particle_codes = new int[lmps_num_unique_elements]; + kim_particle_codes_ok = true; + for(int i = 0; i < lmps_num_unique_elements; i++) { int supported; int code; KIM_Model_GetSpeciesSupportAndCode( @@ -451,19 +428,15 @@ void PairKIM::coeff(int narg, char **arg) KIM_SpeciesName_FromString(lmps_unique_elements[i]), &supported, &code); - if (supported) + if (supported) { kim_particle_codes[i] = code; - else - { - std::stringstream msg; - msg << "create_kim_particle_codes: symbol not found: " - << lmps_unique_elements[i]; - error->all(FLERR, msg.str().c_str()); + } else { + std::string msg("create_kim_particle_codes: symbol not found: "); + msg += lmps_unique_elements[i]; + error->all(FLERR, msg.c_str()); } - } - } - - return; + } + } } /* ---------------------------------------------------------------------- @@ -472,57 +445,48 @@ void PairKIM::coeff(int narg, char **arg) void PairKIM::init_style() { - // This is called for each "run ...", "minimize ...", etc. read from input - ++init_style_call_count; - - if (domain->dimension != 3) - error->all(FLERR,"PairKIM only works with 3D problems"); - - // setup lmps_stripped_neigh_list for neighbors of one atom, if needed - if (lmps_using_molecular) { - memory->destroy(lmps_stripped_neigh_list); - memory->create(lmps_stripped_neigh_list, - kim_number_of_neighbor_lists*neighbor->oneatom, - "pair:lmps_stripped_neigh_list"); - delete [] lmps_stripped_neigh_ptr; - lmps_stripped_neigh_ptr = new int*[kim_number_of_neighbor_lists]; - for (int i = 0; i < kim_number_of_neighbor_lists; ++i) - { - lmps_stripped_neigh_ptr[i] - = &(lmps_stripped_neigh_list[i*(neighbor->oneatom)]); - } + // This is called for each "run ...", "minimize ...", etc. read from input + ++init_style_call_count; + + if (domain->dimension != 3) + error->all(FLERR,"PairKIM only works with 3D problems"); + + // setup lmps_stripped_neigh_list for neighbors of one atom, if needed + if (lmps_using_molecular) { + memory->destroy(lmps_stripped_neigh_list); + memory->create(lmps_stripped_neigh_list, + kim_number_of_neighbor_lists*neighbor->oneatom, + "pair:lmps_stripped_neigh_list"); + delete [] lmps_stripped_neigh_ptr; + lmps_stripped_neigh_ptr = new int*[kim_number_of_neighbor_lists]; + for (int i = 0; i < kim_number_of_neighbor_lists; ++i) + lmps_stripped_neigh_ptr[i] + = &(lmps_stripped_neigh_list[i*(neighbor->oneatom)]); + } + + // make sure comm_reverse expects (at most) 9 values when newton is off + if (!lmps_using_newton) comm_reverse_off = 9; + + // request full neighbor + for (int i = 0; i < kim_number_of_neighbor_lists; ++i) { + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->id = i; + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + + if (modelWillNotRequestNeighborsOfNoncontributingParticles[i]) + neighbor->requests[irequest]->ghost = 0; + else + neighbor->requests[irequest]->ghost = 1; + + // always want all owned/ghost pairs + neighbor->requests[irequest]->newton = 2; - } - - // make sure comm_reverse expects (at most) 9 values when newton is off - if (!lmps_using_newton) comm_reverse_off = 9; - - // request full neighbor - for (int i = 0; i < kim_number_of_neighbor_lists; ++i) - { - int irequest = neighbor->request(this,instance_me); - neighbor->requests[irequest]->id = i; - neighbor->requests[irequest]->half = 0; - neighbor->requests[irequest]->full = 1; - - if (modelWillNotRequestNeighborsOfNoncontributingParticles[i]) - { - neighbor->requests[irequest]->ghost = 0; - } - else - { - neighbor->requests[irequest]->ghost = 1; - - } - // always want all owned/ghost pairs - neighbor->requests[irequest]->newton = 2; - // set cutoff - neighbor->requests[irequest]->cut = 1; - neighbor->requests[irequest]->cutoff - = kim_cutoff_values[i] + neighbor->skin; - } - - return; + // set cutoff + neighbor->requests[irequest]->cut = 1; + neighbor->requests[irequest]->cutoff + = kim_cutoff_values[i] + neighbor->skin; + } } /* ---------------------------------------------------------------------- @@ -541,154 +505,134 @@ void PairKIM::init_list(int id, NeighList *ptr) double PairKIM::init_one(int i, int j) { - // This is called once of each (unordered) i,j pair for each - // "run ...", "minimize ...", etc. read from input + // This is called once of each (unordered) i,j pair for each + // "run ...", "minimize ...", etc. read from input - if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); + if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - return kim_global_influence_distance; + return kim_global_influence_distance; } /* ---------------------------------------------------------------------- */ int PairKIM::pack_reverse_comm(int n, int first, double *buf) { - int i,m,last; - double *fp; - fp = &(atom->f[0][0]); - - m = 0; - last = first + n; - if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, - KIM_SUPPORT_STATUS_notSupported) - && - ((vflag_atom == 0) || - KIM_SupportStatus_Equal(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported))) - { - for (i = first; i < last; i++) - { - buf[m++] = fp[3*i+0]; - buf[m++] = fp[3*i+1]; - buf[m++] = fp[3*i+2]; - } - return m; - } - else if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, - KIM_SUPPORT_STATUS_notSupported) && - (vflag_atom == 1) && - KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported)) - { - double *va=&(vatom[0][0]); - for (i = first; i < last; i++) - { - buf[m++] = fp[3*i+0]; - buf[m++] = fp[3*i+1]; - buf[m++] = fp[3*i+2]; - - buf[m++] = va[6*i+0]; - buf[m++] = va[6*i+1]; - buf[m++] = va[6*i+2]; - buf[m++] = va[6*i+3]; - buf[m++] = va[6*i+4]; - buf[m++] = va[6*i+5]; - } - return m; - } - else if (KIM_SupportStatus_Equal(kim_model_support_for_forces, - KIM_SUPPORT_STATUS_notSupported) - && - (vflag_atom == 1) && - KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported)) - { - double *va=&(vatom[0][0]); - for (i = first; i < last; i++) - { - buf[m++] = va[6*i+0]; - buf[m++] = va[6*i+1]; - buf[m++] = va[6*i+2]; - buf[m++] = va[6*i+3]; - buf[m++] = va[6*i+4]; - buf[m++] = va[6*i+5]; - } - return m; - } - else - return 0; + int i,m,last; + double *fp; + fp = &(atom->f[0][0]); + + m = 0; + last = first + n; + if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, + KIM_SUPPORT_STATUS_notSupported) + && + ((vflag_atom == 0) || + KIM_SupportStatus_Equal(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported))) { + for (i = first; i < last; i++) { + buf[m++] = fp[3*i+0]; + buf[m++] = fp[3*i+1]; + buf[m++] = fp[3*i+2]; + } + return m; + } else if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, + KIM_SUPPORT_STATUS_notSupported) && + (vflag_atom == 1) && + KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported)) { + double *va=&(vatom[0][0]); + for (i = first; i < last; i++) { + buf[m++] = fp[3*i+0]; + buf[m++] = fp[3*i+1]; + buf[m++] = fp[3*i+2]; + + buf[m++] = va[6*i+0]; + buf[m++] = va[6*i+1]; + buf[m++] = va[6*i+2]; + buf[m++] = va[6*i+3]; + buf[m++] = va[6*i+4]; + buf[m++] = va[6*i+5]; + } + return m; + } else if (KIM_SupportStatus_Equal(kim_model_support_for_forces, + KIM_SUPPORT_STATUS_notSupported) + && + (vflag_atom == 1) && + KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported)) { + double *va=&(vatom[0][0]); + for (i = first; i < last; i++) { + buf[m++] = va[6*i+0]; + buf[m++] = va[6*i+1]; + buf[m++] = va[6*i+2]; + buf[m++] = va[6*i+3]; + buf[m++] = va[6*i+4]; + buf[m++] = va[6*i+5]; + } + return m; + } else return 0; } /* ---------------------------------------------------------------------- */ void PairKIM::unpack_reverse_comm(int n, int *list, double *buf) { - int i,j,m; - double *fp; - fp = &(atom->f[0][0]); - - m = 0; - if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, - KIM_SUPPORT_STATUS_notSupported) - && - ((vflag_atom == 0) || - KIM_SupportStatus_Equal(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported))) - { - for (i = 0; i < n; i++) - { - j = list[i]; - fp[3*j+0]+= buf[m++]; - fp[3*j+1]+= buf[m++]; - fp[3*j+2]+= buf[m++]; - } - } - else if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, - KIM_SUPPORT_STATUS_notSupported) - && - (vflag_atom == 1) && - KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported)) - { - double *va=&(vatom[0][0]); - for (i = 0; i < n; i++) - { - j = list[i]; - fp[3*j+0]+= buf[m++]; - fp[3*j+1]+= buf[m++]; - fp[3*j+2]+= buf[m++]; - - va[j*6+0]+=buf[m++]; - va[j*6+1]+=buf[m++]; - va[j*6+2]+=buf[m++]; - va[j*6+3]+=buf[m++]; - va[j*6+4]+=buf[m++]; - va[j*6+5]+=buf[m++]; - } - } - else if (KIM_SupportStatus_Equal(kim_model_support_for_forces, - KIM_SUPPORT_STATUS_notSupported) - && - (vflag_atom == 1) && - KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported)) - { - double *va=&(vatom[0][0]); - for (i = 0; i < n; i++) - { - j = list[i]; - va[j*6+0]+=buf[m++]; - va[j*6+1]+=buf[m++]; - va[j*6+2]+=buf[m++]; - va[j*6+3]+=buf[m++]; - va[j*6+4]+=buf[m++]; - va[j*6+5]+=buf[m++]; - } - } else { - ; // do nothing - } - - return; + int i,j,m; + double *fp; + fp = &(atom->f[0][0]); + + m = 0; + if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, + KIM_SUPPORT_STATUS_notSupported) + && + ((vflag_atom == 0) || + KIM_SupportStatus_Equal(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported))) { + for (i = 0; i < n; i++) { + j = list[i]; + fp[3*j+0]+= buf[m++]; + fp[3*j+1]+= buf[m++]; + fp[3*j+2]+= buf[m++]; + } + } else if (KIM_SupportStatus_NotEqual(kim_model_support_for_forces, + KIM_SUPPORT_STATUS_notSupported) + && + (vflag_atom == 1) && + KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported)) { + double *va=&(vatom[0][0]); + for (i = 0; i < n; i++) { + j = list[i]; + fp[3*j+0]+= buf[m++]; + fp[3*j+1]+= buf[m++]; + fp[3*j+2]+= buf[m++]; + + va[j*6+0]+=buf[m++]; + va[j*6+1]+=buf[m++]; + va[j*6+2]+=buf[m++]; + va[j*6+3]+=buf[m++]; + va[j*6+4]+=buf[m++]; + va[j*6+5]+=buf[m++]; + } + } else if (KIM_SupportStatus_Equal(kim_model_support_for_forces, + KIM_SUPPORT_STATUS_notSupported) + && + (vflag_atom == 1) && + KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported)) { + double *va=&(vatom[0][0]); + for (i = 0; i < n; i++) { + j = list[i]; + va[j*6+0]+=buf[m++]; + va[j*6+1]+=buf[m++]; + va[j*6+2]+=buf[m++]; + va[j*6+3]+=buf[m++]; + va[j*6+4]+=buf[m++]; + va[j*6+5]+=buf[m++]; + } + } else { + ; // do nothing + } } /* ---------------------------------------------------------------------- @@ -697,8 +641,34 @@ void PairKIM::unpack_reverse_comm(int n, int *list, double *buf) double PairKIM::memory_usage() { - double bytes = 2 * lmps_maxalloc * sizeof(int); - return bytes; + double bytes = 2 * lmps_maxalloc * sizeof(int); + return bytes; +} + +/* ---------------------------------------------------------------------- + simulator model support functions +------------------------------------------------------------------------- */ + +void PairKIM::simulator_init() +{ + int dummy; + // do not try with suffixes for now. + simulator_class = force->new_pair("lj/cut",1,dummy); + force->store_style(simulator_style,"lj/cut",1); + printf("Simulator model init: %s -> %s\n", kim_modelname, simulator_style); + char **args = new char*[1]; + args[0] = (char *)"8.1500"; + simulator_class->settings(1,args); + delete[] args; +} + +void PairKIM::simulator_free() +{ + printf("Simulator model free: %s -> %s\n", kim_modelname, simulator_style); + delete[] simulator_style; + simulator_style = NULL; + delete simulator_class; + simulator_class = NULL; } /* ---------------------------------------------------------------------- @@ -708,148 +678,128 @@ double PairKIM::memory_usage() int PairKIM::get_neigh(void const * const dataObject, int const numberOfNeighborLists, double const * const cutoffs, - int const neighborListIndex, int const particleNumber, + int const neighborListIndex, + int const particleNumber, int * const numberOfNeighbors, int const ** const neighborsOfParticle) { - PairKIM const * const Model - = reinterpret_cast(dataObject); - - if (numberOfNeighborLists != Model->kim_number_of_neighbor_lists) - return true; - for (int i = 0; i < numberOfNeighborLists; ++i) - { - if (Model->kim_cutoff_values[i] < cutoffs[i]) return true; - } - - // neighborListIndex and particleNumber are validated by KIM API - - // initialize numNeigh - *numberOfNeighbors = 0; - - NeighList * neiobj = Model->neighborLists[neighborListIndex]; - - int *numneigh, **firstneigh; - numneigh = neiobj->numneigh; // # of J neighbors for each I atom - firstneigh = neiobj->firstneigh; // ptr to 1st J int value of each I atom - - *numberOfNeighbors = numneigh[particleNumber]; - - // strip off neighbor mask for molecular systems - if (!Model->lmps_using_molecular) - *neighborsOfParticle = firstneigh[particleNumber]; - else - { - int n = *numberOfNeighbors; - int *ptr = firstneigh[particleNumber]; - int *lmps_stripped_neigh_list - = Model->lmps_stripped_neigh_ptr[neighborListIndex]; - for (int i = 0; i < n; i++) - lmps_stripped_neigh_list[i] = *(ptr++) & NEIGHMASK; - *neighborsOfParticle = lmps_stripped_neigh_list; - } - return false; + PairKIM const * const Model + = reinterpret_cast(dataObject); + + if (numberOfNeighborLists != Model->kim_number_of_neighbor_lists) + return true; + for (int i = 0; i < numberOfNeighborLists; ++i) { + if (Model->kim_cutoff_values[i] < cutoffs[i]) return true; + } + + // neighborListIndex and particleNumber are validated by KIM API + + // initialize numNeigh + *numberOfNeighbors = 0; + + NeighList * neiobj = Model->neighborLists[neighborListIndex]; + + int *numneigh, **firstneigh; + numneigh = neiobj->numneigh; // # of J neighbors for each I atom + firstneigh = neiobj->firstneigh; // ptr to 1st J int value of each I atom + + *numberOfNeighbors = numneigh[particleNumber]; + + // strip off neighbor mask for molecular systems + if (!Model->lmps_using_molecular) + *neighborsOfParticle = firstneigh[particleNumber]; + else { + int n = *numberOfNeighbors; + int *ptr = firstneigh[particleNumber]; + int *lmps_stripped_neigh_list + = Model->lmps_stripped_neigh_ptr[neighborListIndex]; + for (int i = 0; i < n; i++) + lmps_stripped_neigh_list[i] = *(ptr++) & NEIGHMASK; + *neighborsOfParticle = lmps_stripped_neigh_list; + } + return false; } /* ---------------------------------------------------------------------- */ void PairKIM::kim_free() { - if (kim_init_ok) - { - int kimerror = KIM_Model_ComputeArgumentsDestroy(pkim, &pargs); - if (kimerror) - error->all(FLERR,"Unable to destroy Compute Arguments Object"); - - KIM_Model_Destroy(&pkim); - } - kim_init_ok = false; + if (kim_init_ok) { + int kimerror = KIM_Model_ComputeArgumentsDestroy(pkim, &pargs); + if (kimerror) + error->all(FLERR,"Unable to destroy Compute Arguments Object"); - return; + KIM_Model_Destroy(&pkim); + } + kim_init_ok = false; } /* ---------------------------------------------------------------------- */ void PairKIM::kim_init() { - int kimerror; - - // initialize KIM model - int requestedUnitsAccepted; - kimerror = KIM_Model_Create( - KIM_NUMBERING_zeroBased, - lengthUnit, energyUnit, chargeUnit, temperatureUnit, timeUnit, - kim_modelname, - &requestedUnitsAccepted, - &pkim); - if (kimerror) - { - kimerror = KIM::SimulatorModel::Create(kim_modelname,&simulatorModel); - if (kimerror) - error->all(FLERR,"KIM ModelCreate failed"); - else - return; - } - else { - if (!requestedUnitsAccepted) { - error->all(FLERR,"KIM Model did not accept the requested unit system"); - } - - // check that the model does not require unknown capabilities - kimerror = check_for_routine_compatibility(); - if (kimerror) - { - error->all(FLERR, - "KIM Model requires unknown Routines. Unable to proceed."); - } - - kimerror = KIM_Model_ComputeArgumentsCreate(pkim, &pargs); - if (kimerror) - { - KIM_Model_Destroy(&pkim); - error->all(FLERR,"KIM ComputeArgumentsCreate failed"); - } - else - { - kim_init_ok = true; - } - } - - // determine KIM Model capabilities (used in this function below) - set_kim_model_has_flags(); - - KIM_Model_GetInfluenceDistance(pkim, &kim_global_influence_distance); - KIM_Model_GetNeighborListPointers( - pkim, - &kim_number_of_neighbor_lists, - &kim_cutoff_values, - &modelWillNotRequestNeighborsOfNoncontributingParticles); - if (neighborLists) - { - delete [] neighborLists; - neighborLists = 0; - } - neighborLists = new NeighList*[kim_number_of_neighbor_lists]; - - kimerror = KIM_ComputeArguments_SetArgumentPointerInteger(pargs, - KIM_COMPUTE_ARGUMENT_NAME_numberOfParticles, - &lmps_local_tot_num_atoms); - if (KIM_SupportStatus_NotEqual(kim_model_support_for_energy, - KIM_SUPPORT_STATUS_notSupported)) - kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble(pargs, - KIM_COMPUTE_ARGUMENT_NAME_partialEnergy, - &(eng_vdwl)); - - kimerror = KIM_ComputeArguments_SetCallbackPointer(pargs, - KIM_COMPUTE_CALLBACK_NAME_GetNeighborList, - KIM_LANGUAGE_NAME_cpp, - reinterpret_cast(get_neigh), - reinterpret_cast(this)); - - if (kimerror) - error->all(FLERR,"Unable to register KIM pointers"); - - return; + int kimerror; + + // initialize KIM model + int requestedUnitsAccepted; + kimerror = KIM_Model_Create( + KIM_NUMBERING_zeroBased, + lengthUnit, energyUnit, chargeUnit, temperatureUnit, timeUnit, + kim_modelname, + &requestedUnitsAccepted, + &pkim); + if (kimerror) { + kimerror = KIM::SimulatorModel::Create(kim_modelname,&simulatorModel); + if (kimerror) error->all(FLERR,"KIM ModelCreate failed"); + else return; + } else { + if (!requestedUnitsAccepted) + error->all(FLERR,"KIM Model did not accept the requested unit system"); + + // check that the model does not require unknown capabilities + kimerror = check_for_routine_compatibility(); + if (kimerror) + error->all(FLERR, + "KIM Model requires unknown Routines. Unable to proceed."); + + kimerror = KIM_Model_ComputeArgumentsCreate(pkim, &pargs); + if (kimerror) { + KIM_Model_Destroy(&pkim); + error->all(FLERR,"KIM ComputeArgumentsCreate failed"); + } else kim_init_ok = true; + } + + // determine KIM Model capabilities (used in this function below) + set_kim_model_has_flags(); + + KIM_Model_GetInfluenceDistance(pkim, &kim_global_influence_distance); + KIM_Model_GetNeighborListPointers( + pkim, + &kim_number_of_neighbor_lists, + &kim_cutoff_values, + &modelWillNotRequestNeighborsOfNoncontributingParticles); + if (neighborLists) { + delete [] neighborLists; + neighborLists = 0; + } + neighborLists = new NeighList*[kim_number_of_neighbor_lists]; + + kimerror = KIM_ComputeArguments_SetArgumentPointerInteger(pargs, + KIM_COMPUTE_ARGUMENT_NAME_numberOfParticles, + &lmps_local_tot_num_atoms); + if (KIM_SupportStatus_NotEqual(kim_model_support_for_energy, + KIM_SUPPORT_STATUS_notSupported)) + kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble(pargs, + KIM_COMPUTE_ARGUMENT_NAME_partialEnergy, + &(eng_vdwl)); + + kimerror = KIM_ComputeArguments_SetCallbackPointer(pargs, + KIM_COMPUTE_CALLBACK_NAME_GetNeighborList, + KIM_LANGUAGE_NAME_cpp, + reinterpret_cast(get_neigh), + reinterpret_cast(this)); + + if (kimerror) error->all(FLERR,"Unable to register KIM pointers"); } /* ---------------------------------------------------------------------- */ @@ -858,16 +808,14 @@ void PairKIM::set_argument_pointers() { int kimerror; kimerror = KIM_ComputeArguments_SetArgumentPointerDouble( - pargs, KIM_COMPUTE_ARGUMENT_NAME_coordinates, &(atom->x[0][0])); + pargs, KIM_COMPUTE_ARGUMENT_NAME_coordinates, &(atom->x[0][0])); // Set KIM pointer appropriately for particalEnergy if (KIM_SupportStatus_Equal(kim_model_support_for_particleEnergy, KIM_SUPPORT_STATUS_required) - && (eflag_atom != 1)) - { + && (eflag_atom != 1)) { // reallocate per-atom energy array if necessary - if (atom->nmax > maxeatom) - { + if (atom->nmax > maxeatom) { maxeatom = atom->nmax; memory->destroy(eatom); memory->create(eatom,comm->nthreads*maxeatom,"pair:eatom"); @@ -875,31 +823,25 @@ void PairKIM::set_argument_pointers() } if (KIM_SupportStatus_Equal(kim_model_support_for_particleEnergy, KIM_SUPPORT_STATUS_optional) - && (eflag_atom != 1)) - { + && (eflag_atom != 1)) { kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble( - pargs, - KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy, - reinterpret_cast(NULL)); - } - else if (KIM_SupportStatus_NotEqual(kim_model_support_for_particleEnergy, - KIM_SUPPORT_STATUS_notSupported)) - { + pargs, + KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy, + reinterpret_cast(NULL)); + } else if (KIM_SupportStatus_NotEqual(kim_model_support_for_particleEnergy, + KIM_SUPPORT_STATUS_notSupported)) { kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble( pargs, KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy, eatom); } // Set KIM pointer appropriately for forces if (KIM_SupportStatus_Equal(kim_model_support_for_forces, - KIM_SUPPORT_STATUS_notSupported)) - { + KIM_SUPPORT_STATUS_notSupported)) { kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble( - pargs, - KIM_COMPUTE_ARGUMENT_NAME_partialForces, - reinterpret_cast(NULL)); - } - else - { + pargs, + KIM_COMPUTE_ARGUMENT_NAME_partialForces, + reinterpret_cast(NULL)); + } else { kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble( pargs, KIM_COMPUTE_ARGUMENT_NAME_partialForces, &(atom->f[0][0])); } @@ -907,11 +849,9 @@ void PairKIM::set_argument_pointers() // Set KIM pointer appropriately for particleVirial if (KIM_SupportStatus_Equal(kim_model_support_for_particleVirial, KIM_SUPPORT_STATUS_required) - && (vflag_atom != 1)) - { + && (vflag_atom != 1)) { // reallocate per-atom virial array if necessary - if (atom->nmax > maxeatom) - { + if (atom->nmax > maxeatom) { maxvatom = atom->nmax; memory->destroy(vatom); memory->create(vatom,comm->nthreads*maxvatom,6,"pair:vatom"); @@ -919,84 +859,72 @@ void PairKIM::set_argument_pointers() } if (KIM_SupportStatus_Equal(kim_model_support_for_particleVirial, KIM_SUPPORT_STATUS_optional) - && (vflag_atom != 1)) - { + && (vflag_atom != 1)) { kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble( - pargs, - KIM_COMPUTE_ARGUMENT_NAME_partialParticleVirial, - reinterpret_cast(NULL)); - } - else if (KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, - KIM_SUPPORT_STATUS_notSupported)) - { + pargs, + KIM_COMPUTE_ARGUMENT_NAME_partialParticleVirial, + reinterpret_cast(NULL)); + } else if (KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, + KIM_SUPPORT_STATUS_notSupported)) { kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble( - pargs, KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy, &(vatom[0][0])); + pargs, KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy, &(vatom[0][0])); } - if (kimerror) - { - error->all(FLERR,"Unable to set KIM argument pointers"); - } - - return; + if (kimerror) error->all(FLERR,"Unable to set KIM argument pointers"); } /* ---------------------------------------------------------------------- */ void PairKIM::set_lmps_flags() { - // determint if newton is on or off - lmps_using_newton = (force->newton_pair == 1); - - // determine if running with pair hybrid - if (force->pair_match("hybrid",0)) - { - error->all(FLERR,"pair_kim does not support hybrid"); - } - - // determine unit system and set lmps_units flag - if ((strcmp(update->unit_style,"real")==0)) { - lmps_units = REAL; - lengthUnit = KIM_LENGTH_UNIT_A; - energyUnit = KIM_ENERGY_UNIT_kcal_mol; - chargeUnit = KIM_CHARGE_UNIT_e; - temperatureUnit = KIM_TEMPERATURE_UNIT_K; - timeUnit = KIM_TIME_UNIT_fs; - } else if ((strcmp(update->unit_style,"metal")==0)) { - lmps_units = METAL; - lengthUnit = KIM_LENGTH_UNIT_A; - energyUnit = KIM_ENERGY_UNIT_eV; - chargeUnit = KIM_CHARGE_UNIT_e; - temperatureUnit = KIM_TEMPERATURE_UNIT_K; - timeUnit = KIM_TIME_UNIT_ps; - } else if ((strcmp(update->unit_style,"si")==0)) { - lmps_units = SI; - lengthUnit = KIM_LENGTH_UNIT_m; - energyUnit = KIM_ENERGY_UNIT_J; - chargeUnit = KIM_CHARGE_UNIT_C; - temperatureUnit = KIM_TEMPERATURE_UNIT_K; - timeUnit = KIM_TIME_UNIT_s; - } else if ((strcmp(update->unit_style,"cgs")==0)) { - lmps_units = CGS; - lengthUnit = KIM_LENGTH_UNIT_cm; - energyUnit = KIM_ENERGY_UNIT_erg; - chargeUnit = KIM_CHARGE_UNIT_statC; - temperatureUnit = KIM_TEMPERATURE_UNIT_K; - timeUnit = KIM_TIME_UNIT_s; - } else if ((strcmp(update->unit_style,"electron")==0)) { - lmps_units = ELECTRON; - lengthUnit = KIM_LENGTH_UNIT_Bohr; - energyUnit = KIM_ENERGY_UNIT_Hartree; - chargeUnit = KIM_CHARGE_UNIT_e; - temperatureUnit = KIM_TEMPERATURE_UNIT_K; - timeUnit = KIM_TIME_UNIT_fs; - } else if ((strcmp(update->unit_style,"lj")==0)) { - error->all(FLERR,"LAMMPS unit_style lj not supported by KIM models"); - } else { - error->all(FLERR,"Unknown unit_style"); - } - - return; + // determint if newton is on or off + lmps_using_newton = (force->newton_pair == 1); + + // determine if running with pair hybrid + if (force->pair_match("hybrid",0)) + error->all(FLERR,"pair_kim does not support hybrid"); + + // determine unit system and set lmps_units flag + if ((strcmp(update->unit_style,"real")==0)) { + lmps_units = REAL; + lengthUnit = KIM_LENGTH_UNIT_A; + energyUnit = KIM_ENERGY_UNIT_kcal_mol; + chargeUnit = KIM_CHARGE_UNIT_e; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_fs; + } else if ((strcmp(update->unit_style,"metal")==0)) { + lmps_units = METAL; + lengthUnit = KIM_LENGTH_UNIT_A; + energyUnit = KIM_ENERGY_UNIT_eV; + chargeUnit = KIM_CHARGE_UNIT_e; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_ps; + } else if ((strcmp(update->unit_style,"si")==0)) { + lmps_units = SI; + lengthUnit = KIM_LENGTH_UNIT_m; + energyUnit = KIM_ENERGY_UNIT_J; + chargeUnit = KIM_CHARGE_UNIT_C; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_s; + } else if ((strcmp(update->unit_style,"cgs")==0)) { + lmps_units = CGS; + lengthUnit = KIM_LENGTH_UNIT_cm; + energyUnit = KIM_ENERGY_UNIT_erg; + chargeUnit = KIM_CHARGE_UNIT_statC; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_s; + } else if ((strcmp(update->unit_style,"electron")==0)) { + lmps_units = ELECTRON; + lengthUnit = KIM_LENGTH_UNIT_Bohr; + energyUnit = KIM_ENERGY_UNIT_Hartree; + chargeUnit = KIM_CHARGE_UNIT_e; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_fs; + } else if ((strcmp(update->unit_style,"lj")==0)) { + error->all(FLERR,"LAMMPS unit_style lj not supported by KIM models"); + } else { + error->all(FLERR,"Unknown unit_style"); + } } /* ---------------------------------------------------------------------- */ @@ -1007,8 +935,7 @@ int PairKIM::check_for_routine_compatibility() int numberOfModelRoutineNames; KIM_MODEL_ROUTINE_NAME_GetNumberOfModelRoutineNames( &numberOfModelRoutineNames); - for (int i = 0; i < numberOfModelRoutineNames; ++i) - { + for (int i = 0; i < numberOfModelRoutineNames; ++i) { KIM_ModelRoutineName modelRoutineName; KIM_MODEL_ROUTINE_NAME_GetModelRoutineName(i, &modelRoutineName); @@ -1016,10 +943,9 @@ int PairKIM::check_for_routine_compatibility() int required; int error = KIM_Model_IsRoutinePresent( pkim, modelRoutineName, &present, &required); - if (error) { return true; } + if (error) return true; - if ((present == true) && (required == true)) - { + if ((present == true) && (required == true)) { if (!(KIM_ModelRoutineName_Equal(modelRoutineName, KIM_MODEL_ROUTINE_NAME_Create) || KIM_ModelRoutineName_Equal( @@ -1033,8 +959,9 @@ int PairKIM::check_for_routine_compatibility() modelRoutineName, KIM_MODEL_ROUTINE_NAME_ComputeArgumentsDestroy) || KIM_ModelRoutineName_Equal(modelRoutineName, - KIM_MODEL_ROUTINE_NAME_Destroy))) - { return true; } + KIM_MODEL_ROUTINE_NAME_Destroy))) { + return true; + } } } @@ -1049,8 +976,7 @@ void PairKIM::set_kim_model_has_flags() int numberOfComputeArgumentNames; KIM_COMPUTE_ARGUMENT_NAME_GetNumberOfComputeArgumentNames( &numberOfComputeArgumentNames); - for (int i = 0; i < numberOfComputeArgumentNames; ++i) - { + for (int i = 0; i < numberOfComputeArgumentNames; ++i) { KIM_ComputeArgumentName computeArgumentName; KIM_COMPUTE_ARGUMENT_NAME_GetComputeArgumentName( i, &computeArgumentName); @@ -1059,32 +985,24 @@ void PairKIM::set_kim_model_has_flags() pargs, computeArgumentName, &supportStatus); if (KIM_ComputeArgumentName_Equal(computeArgumentName, - KIM_COMPUTE_ARGUMENT_NAME_partialEnergy) - ) + KIM_COMPUTE_ARGUMENT_NAME_partialEnergy)) kim_model_support_for_energy = supportStatus; else if (KIM_ComputeArgumentName_Equal( - computeArgumentName, KIM_COMPUTE_ARGUMENT_NAME_partialForces) - ) + computeArgumentName, KIM_COMPUTE_ARGUMENT_NAME_partialForces)) kim_model_support_for_forces = supportStatus; - else if - (KIM_ComputeArgumentName_Equal( - computeArgumentName, - KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy)\ - ) + else if (KIM_ComputeArgumentName_Equal( + computeArgumentName, + KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy)) kim_model_support_for_particleEnergy = supportStatus; - else if - (KIM_ComputeArgumentName_Equal( - computeArgumentName, - KIM_COMPUTE_ARGUMENT_NAME_partialParticleVirial) - ) + else if (KIM_ComputeArgumentName_Equal( + computeArgumentName, + KIM_COMPUTE_ARGUMENT_NAME_partialParticleVirial)) kim_model_support_for_particleVirial = supportStatus; - else if (KIM_SupportStatus_Equal(supportStatus, KIM_SUPPORT_STATUS_required) - ) - { - std::stringstream msg; - msg << "KIM Model requires unsupported compute argument: " - << KIM_ComputeArgumentName_ToString(computeArgumentName); - error->all(FLERR, msg.str().c_str()); + else if (KIM_SupportStatus_Equal(supportStatus, + KIM_SUPPORT_STATUS_required)) { + std::string msg("KIM Model requires unsupported compute argument: "); + msg += KIM_ComputeArgumentName_ToString(computeArgumentName); + error->all(FLERR, msg.c_str()); } } @@ -1111,20 +1029,15 @@ void PairKIM::set_kim_model_has_flags() int numberOfComputeCallbackNames; KIM_COMPUTE_CALLBACK_NAME_GetNumberOfComputeCallbackNames( &numberOfComputeCallbackNames); - for (int i = 0; i < numberOfComputeCallbackNames; ++i) - { + for (int i = 0; i < numberOfComputeCallbackNames; ++i) { KIM_ComputeCallbackName computeCallbackName; - KIM_COMPUTE_CALLBACK_NAME_GetComputeCallbackName( - i, &computeCallbackName); + KIM_COMPUTE_CALLBACK_NAME_GetComputeCallbackName(i, &computeCallbackName); KIM_SupportStatus supportStatus; - KIM_ComputeArguments_GetCallbackSupportStatus( - pargs, computeCallbackName, &supportStatus); + KIM_ComputeArguments_GetCallbackSupportStatus(pargs, + computeCallbackName, + &supportStatus); if (KIM_SupportStatus_Equal(supportStatus, KIM_SUPPORT_STATUS_required)) - { error->all(FLERR,"KIM Model requires unsupported compute callback"); - } } - - return; } diff --git a/src/KIM/pair_kim.h b/src/KIM/pair_kim.h index dcfb4a8af0..37a6be1e5b 100644 --- a/src/KIM/pair_kim.h +++ b/src/KIM/pair_kim.h @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing authors: Ryan S. Elliott (UMinn) + Contributing authors: Ryan S. Elliott (UMinn), Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- @@ -65,110 +65,115 @@ PairStyle(kim,PairKIM) // includes from KIM & LAMMPS class KIM_API_model; #include "pair.h" + extern "C" { #include "KIM_SimulatorHeaders.h" } #include "KIM_SimulatorModel.hpp" -#include - namespace LAMMPS_NS { - class PairKIM : public Pair { - public: - PairKIM(class LAMMPS*); - ~PairKIM(); - - // LAMMPS Pair class virtual function prototypes - virtual void compute(int, int); - virtual void settings(int, char**); - virtual void coeff(int, char**); - virtual void init_style(); - virtual void init_list(int id, NeighList *ptr); - virtual double init_one(int, int); - virtual int pack_reverse_comm(int, int, double*); - virtual void unpack_reverse_comm(int, int*, double*); - virtual double memory_usage(); - - protected: - // (nearly) all bool flags are not initialized in constructor, but set - // explicitly in the indicated function. All other data members are - // initialized in constructor - int settings_call_count; - int init_style_call_count; - - // values set in settings() - char* kim_modelname; - - // values set in coeff() - - // values set in allocate(), called by coeff() - virtual void allocate(); - int* lmps_map_species_to_unique; - - // values set in coeff(), after calling allocate() - char** lmps_unique_elements; // names of unique elements given - // in pair_coeff command - int lmps_num_unique_elements; - - // values set in set_lmps_flags(), called from init_style() - bool lmps_using_newton; - bool lmps_using_molecular; - enum unit_sys {REAL, METAL, SI, CGS, ELECTRON}; - unit_sys lmps_units; - KIM_LengthUnit lengthUnit; - KIM_EnergyUnit energyUnit; - KIM_ChargeUnit chargeUnit; - KIM_TemperatureUnit temperatureUnit; - KIM_TimeUnit timeUnit; - - KIM::SimulatorModel * simulatorModel; - KIM_Model * pkim; - KIM_ComputeArguments * pargs; - - // values set in set_kim_model_has_flags(), called by kim_init() - KIM_SupportStatus kim_model_support_for_energy; - KIM_SupportStatus kim_model_support_for_forces; - KIM_SupportStatus kim_model_support_for_particleEnergy; - KIM_SupportStatus kim_model_support_for_particleVirial; - - // values set in kim_init() - bool kim_init_ok; - int lmps_local_tot_num_atoms; - double kim_global_influence_distance; // KIM Model cutoff value - int kim_number_of_neighbor_lists; - double const * kim_cutoff_values; - int const * modelWillNotRequestNeighborsOfNoncontributingParticles; - class NeighList ** neighborLists; - - // values set in init_style() - bool kim_particle_codes_ok; - int *kim_particle_codes; - - // values set in compute() - int lmps_maxalloc; // max allocated memory value - int* kim_particleSpecies; // array of KIM particle species - int* kim_particleContributing; // array of KIM particle contributing - int* lmps_stripped_neigh_list; // neighbors of one atom, used when LAMMPS - // is in molecular mode - int** lmps_stripped_neigh_ptr; // pointer into lists - - // KIM specific helper functions - virtual void set_contributing(); - virtual void kim_init(); - virtual void kim_free(); - virtual void set_argument_pointers(); - virtual void set_lmps_flags(); - virtual void set_kim_model_has_flags(); - virtual int check_for_routine_compatibility(); - // static methods used as callbacks from KIM - static int get_neigh( - void const * const dataObject, - int const numberOfCutoffs, double const * const cutoffs, - int const neighborListIndex, int const particleNumber, - int * const numberOfNeighbors, - int const ** const neighborsOfParticle); - }; +class PairKIM : public Pair { + public: + PairKIM(class LAMMPS*); + ~PairKIM(); + + // LAMMPS Pair class virtual function prototypes + virtual void compute(int, int); + virtual void settings(int, char**); + virtual void coeff(int, char**); + virtual void init_style(); + virtual void init_list(int id, NeighList *ptr); + virtual double init_one(int, int); + virtual int pack_reverse_comm(int, int, double*); + virtual void unpack_reverse_comm(int, int*, double*); + virtual double memory_usage(); + + protected: + // (nearly) all bool flags are not initialized in constructor, but set + // explicitly in the indicated function. All other data members are + // initialized in constructor + int settings_call_count; + int init_style_call_count; + + // values set in settings() + char* kim_modelname; + + // values set in coeff() + + // values set in allocate(), called by coeff() + virtual void allocate(); + int* lmps_map_species_to_unique; + + // values set in coeff(), after calling allocate() + char** lmps_unique_elements; // names of unique elements given + // in pair_coeff command + int lmps_num_unique_elements; + + // values set in set_lmps_flags(), called from init_style() + bool lmps_using_newton; + bool lmps_using_molecular; + enum unit_sys {REAL, METAL, SI, CGS, ELECTRON}; + unit_sys lmps_units; + KIM_LengthUnit lengthUnit; + KIM_EnergyUnit energyUnit; + KIM_ChargeUnit chargeUnit; + KIM_TemperatureUnit temperatureUnit; + KIM_TimeUnit timeUnit; + + KIM::SimulatorModel * simulatorModel; + KIM_Model * pkim; + KIM_ComputeArguments * pargs; + + // values set in set_kim_model_has_flags(), called by kim_init() + KIM_SupportStatus kim_model_support_for_energy; + KIM_SupportStatus kim_model_support_for_forces; + KIM_SupportStatus kim_model_support_for_particleEnergy; + KIM_SupportStatus kim_model_support_for_particleVirial; + + // values set in kim_init() + bool kim_init_ok; + int lmps_local_tot_num_atoms; + double kim_global_influence_distance; // KIM Model cutoff value + int kim_number_of_neighbor_lists; + double const * kim_cutoff_values; + int const * modelWillNotRequestNeighborsOfNoncontributingParticles; + class NeighList ** neighborLists; + + // values set in init_style() + bool kim_particle_codes_ok; + int *kim_particle_codes; + + // values set in compute() + int lmps_maxalloc; // max allocated memory value + int* kim_particleSpecies; // array of KIM particle species + int* kim_particleContributing; // array of KIM particle contributing + int* lmps_stripped_neigh_list; // neighbors of one atom, used when LAMMPS + // is in molecular mode + int** lmps_stripped_neigh_ptr; // pointer into lists + + // LAMMPS Simulator model support + Pair *simulator_class; + char *simulator_style; + virtual void simulator_init(); + virtual void simulator_free(); + + // KIM specific helper functions + virtual void set_contributing(); + virtual void kim_init(); + virtual void kim_free(); + virtual void set_argument_pointers(); + virtual void set_lmps_flags(); + virtual void set_kim_model_has_flags(); + virtual int check_for_routine_compatibility(); + // static methods used as callbacks from KIM + static int get_neigh( + void const * const dataObject, + int const numberOfCutoffs, double const * const cutoffs, + int const neighborListIndex, int const particleNumber, + int * const numberOfNeighbors, + int const ** const neighborsOfParticle); +}; } #endif -- GitLab From 32379d2d840a7b5421823ba1f01aed68028d5c6b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 18 May 2019 21:07:15 -0400 Subject: [PATCH 014/469] add JSON tokenizer to utils library --- src/utils.cpp | 376 +++++++++++++++++++++++++++++++++++++++++++++++++- src/utils.h | 2 + 2 files changed, 376 insertions(+), 2 deletions(-) diff --git a/src/utils.cpp b/src/utils.cpp index c3c173a73f..77ff8ef749 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -12,6 +12,8 @@ ------------------------------------------------------------------------- */ #include +#include +#include #include "utils.h" #include "error.h" @@ -46,9 +48,68 @@ extern "C" { - /** Match text against a (simplified) regular expression - * (regexp will be compiled automatically). */ +/** Match text against a (simplified) regular expression + * (regexp will be compiled automatically). */ static int re_match(const char *text, const char *pattern); + +/** + * JSON type identifier. Basic types are: + * o Object + * o Array + * o String + * o Other primitive: number, boolean (true/false) or null + */ + typedef enum { + JSMN_UNDEFINED = 0, + JSMN_OBJECT = 1, + JSMN_ARRAY = 2, + JSMN_STRING = 3, + JSMN_PRIMITIVE = 4 + } jsmntype_t; + + enum jsmnerr { + /* Not enough tokens were provided */ + JSMN_ERROR_NOMEM = -1, + /* Invalid character inside JSON string */ + JSMN_ERROR_INVAL = -2, + /* The string is not a full JSON packet, more bytes expected */ + JSMN_ERROR_PART = -3 + }; + +/** + * JSON token description. + * type type (object, array, string etc.) + * start start position in JSON data string + * end end position in JSON data string + */ + typedef struct { + jsmntype_t type; + int start; + int end; + int size; + } jsmntok_t; + +/** + * JSON parser. Contains an array of token blocks available. Also stores + * the string being parsed now and current position in that string + */ + typedef struct { + unsigned int pos; /* offset in the JSON string */ + unsigned int toknext; /* next token to allocate */ + int toksuper; /* superior token node, e.g parent object or array */ + } jsmn_parser; + +/** + * Create JSON parser over an array of tokens + */ + static void jsmn_init(jsmn_parser *parser); + +/** + * Run JSON parser. It parses a JSON data string into and array of tokens, each describing + * a single JSON object. + */ + static int jsmn_parse(jsmn_parser *parser, const char *js, size_t len, + jsmntok_t *tokens, unsigned int num_tokens); } using namespace LAMMPS_NS; @@ -121,6 +182,72 @@ void utils::sfgets(const char *srcname, int srcline, char *s, int size, return; } + + +int utils::kim_simulator_json_parse(int argc, char **argv) +{ + FILE *fp; + jsmn_parser p; + jsmntok_t *tok; + char *buf; + size_t nbytes; + + if (argc != 2) { + printf("usage: %s \n",argv[0]); + return 1; + } + + // open JSON file + + fp = fopen(argv[1],"rb"); + if (!fp) { + perror("Error opening JSON file"); + return 2; + } + + // determine file size and allocate suitable buffer + + fseek(fp,0,SEEK_END); + long int flen = ftell(fp); + rewind(fp); + buf = new char[flen]; + nbytes = fread(buf,1,flen,fp); + fclose(fp); + + // parse once to count number of tokens + + jsmn_init(&p); + int ntok = jsmn_parse(&p,buf,nbytes,NULL,1); + if (ntok < 0) { + printf("failed to parse JSON: %d\n",ntok); + return 3; + } + + // allocate token storage and parse again + + jsmn_init(&p); + tok = new jsmntok_t[ntok]; + int retval = jsmn_parse(&p,buf,nbytes,tok,ntok); + if ((retval < 1) || (tok[0].type != JSMN_OBJECT)) { + printf("failed to parse JSON: no root object\n"); + return 4; + } + + for (int i=1; i < retval; ++i) { + printf("key: %.*s\n",tok[i].end-tok[i].start,buf+tok[i].start); + if (tok[i+1].type == JSMN_ARRAY) { + printf("value is array of size %d\n",tok[i+1].size); + i += tok[i+1].size + 1; + } else { + ++i; + } + } + + delete [] buf; + delete [] tok; + return 0; +} + /* ------------------------------------------------------------------ */ extern "C" { @@ -437,4 +564,249 @@ extern "C" { return 0; } + + +/** + * Allocates a fresh unused token from the token pool. + */ + static jsmntok_t *jsmn_alloc_token(jsmn_parser *parser, + jsmntok_t *tokens, size_t num_tokens) { + jsmntok_t *tok; + if (parser->toknext >= num_tokens) { + return NULL; + } + tok = &tokens[parser->toknext++]; + tok->start = tok->end = -1; + tok->size = 0; + return tok; + } + +/** + * Fills token type and boundaries. + */ + static void jsmn_fill_token(jsmntok_t *token, jsmntype_t type, + int start, int end) { + token->type = type; + token->start = start; + token->end = end; + token->size = 0; + } + +/** + * Fills next available token with JSON primitive. + */ + static int jsmn_parse_primitive(jsmn_parser *parser, const char *js, + size_t len, jsmntok_t *tokens, size_t num_tokens) { + jsmntok_t *token; + int start; + + start = parser->pos; + + for (; parser->pos < len && js[parser->pos] != '\0'; parser->pos++) { + switch (js[parser->pos]) { + case '\t' : case '\r' : case '\n' : case ' ' : + case ',' : case ']' : case '}' : + goto found; + } + if (js[parser->pos] < 32 || js[parser->pos] >= 127) { + parser->pos = start; + return JSMN_ERROR_INVAL; + } + } + + found: + if (tokens == NULL) { + parser->pos--; + return 0; + } + token = jsmn_alloc_token(parser, tokens, num_tokens); + if (token == NULL) { + parser->pos = start; + return JSMN_ERROR_NOMEM; + } + jsmn_fill_token(token, JSMN_PRIMITIVE, start, parser->pos); + parser->pos--; + return 0; + } + +/** + * Fills next token with JSON string. + */ + static int jsmn_parse_string(jsmn_parser *parser, const char *js, + size_t len, jsmntok_t *tokens, size_t num_tokens) { + jsmntok_t *token; + + int start = parser->pos; + + parser->pos++; + + /* Skip starting quote */ + for (; parser->pos < len && js[parser->pos] != '\0'; parser->pos++) { + char c = js[parser->pos]; + + /* Quote: end of string */ + if (c == '\"') { + if (tokens == NULL) { + return 0; + } + token = jsmn_alloc_token(parser, tokens, num_tokens); + if (token == NULL) { + parser->pos = start; + return JSMN_ERROR_NOMEM; + } + jsmn_fill_token(token, JSMN_STRING, start+1, parser->pos); + return 0; + } + + /* Backslash: Quoted symbol expected */ + if (c == '\\' && parser->pos + 1 < len) { + int i; + parser->pos++; + switch (js[parser->pos]) { + /* Allowed escaped symbols */ + case '\"': case '/' : case '\\' : case 'b' : + case 'f' : case 'r' : case 'n' : case 't' : + break; + /* Allows escaped symbol \uXXXX */ + case 'u': + parser->pos++; + for(i = 0; i < 4 && parser->pos < len && js[parser->pos] != '\0'; i++) { + /* If it isn't a hex character we have an error */ + if(!((js[parser->pos] >= 48 && js[parser->pos] <= 57) || /* 0-9 */ + (js[parser->pos] >= 65 && js[parser->pos] <= 70) || /* A-F */ + (js[parser->pos] >= 97 && js[parser->pos] <= 102))) { /* a-f */ + parser->pos = start; + return JSMN_ERROR_INVAL; + } + parser->pos++; + } + parser->pos--; + break; + /* Unexpected symbol */ + default: + parser->pos = start; + return JSMN_ERROR_INVAL; + } + } + } + parser->pos = start; + return JSMN_ERROR_PART; + } + +/** + * Parse JSON string and fill tokens. + */ + int jsmn_parse(jsmn_parser *parser, const char *js, size_t len, + jsmntok_t *tokens, unsigned int num_tokens) { + int r; + int i; + jsmntok_t *token; + int count = parser->toknext; + + for (; parser->pos < len && js[parser->pos] != '\0'; parser->pos++) { + char c; + jsmntype_t type; + + c = js[parser->pos]; + switch (c) { + case '{': case '[': + count++; + if (tokens == NULL) { + break; + } + token = jsmn_alloc_token(parser, tokens, num_tokens); + if (token == NULL) + return JSMN_ERROR_NOMEM; + if (parser->toksuper != -1) { + tokens[parser->toksuper].size++; + } + token->type = (c == '{' ? JSMN_OBJECT : JSMN_ARRAY); + token->start = parser->pos; + parser->toksuper = parser->toknext - 1; + break; + case '}': case ']': + if (tokens == NULL) + break; + type = (c == '}' ? JSMN_OBJECT : JSMN_ARRAY); + for (i = parser->toknext - 1; i >= 0; i--) { + token = &tokens[i]; + if (token->start != -1 && token->end == -1) { + if (token->type != type) { + return JSMN_ERROR_INVAL; + } + parser->toksuper = -1; + token->end = parser->pos + 1; + break; + } + } + /* Error if unmatched closing bracket */ + if (i == -1) return JSMN_ERROR_INVAL; + for (; i >= 0; i--) { + token = &tokens[i]; + if (token->start != -1 && token->end == -1) { + parser->toksuper = i; + break; + } + } + break; + case '\"': + r = jsmn_parse_string(parser, js, len, tokens, num_tokens); + if (r < 0) return r; + count++; + if (parser->toksuper != -1 && tokens != NULL) + tokens[parser->toksuper].size++; + break; + case '\t' : case '\r' : case '\n' : case ' ': + break; + case ':': + parser->toksuper = parser->toknext - 1; + break; + case ',': + if (tokens != NULL && parser->toksuper != -1 && + tokens[parser->toksuper].type != JSMN_ARRAY && + tokens[parser->toksuper].type != JSMN_OBJECT) { + for (i = parser->toknext - 1; i >= 0; i--) { + if (tokens[i].type == JSMN_ARRAY || tokens[i].type == JSMN_OBJECT) { + if (tokens[i].start != -1 && tokens[i].end == -1) { + parser->toksuper = i; + break; + } + } + } + } + break; + /* In non-strict mode every unquoted value is a primitive */ + default: + r = jsmn_parse_primitive(parser, js, len, tokens, num_tokens); + if (r < 0) return r; + count++; + if (parser->toksuper != -1 && tokens != NULL) + tokens[parser->toksuper].size++; + break; + + } + } + + if (tokens != NULL) { + for (i = parser->toknext - 1; i >= 0; i--) { + /* Unmatched opened object or array */ + if (tokens[i].start != -1 && tokens[i].end == -1) { + return JSMN_ERROR_PART; + } + } + } + + return count; + } + +/** + * Creates a new parser based over a given buffer with an array of tokens + * available. + */ + void jsmn_init(jsmn_parser *parser) { + parser->pos = 0; + parser->toknext = 0; + parser->toksuper = -1; + } } + diff --git a/src/utils.h b/src/utils.h index 2596fcd774..e908dcae81 100644 --- a/src/utils.h +++ b/src/utils.h @@ -66,6 +66,8 @@ namespace LAMMPS_NS { */ void sfgets(const char *srcname, int srcline, char *s, int size, FILE *fp, const char *filename, Error *error); + + int kim_simulator_json_parse(int argc, char **argv); } } -- GitLab From b779bf524afaf41e95ad4f9fb4fe7c622022825e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 19 May 2019 10:09:25 -0400 Subject: [PATCH 015/469] use KIM-API calls to query simulator model info --- src/KIM/pair_kim.cpp | 45 ++++++++++++++++++++++++++++++++++++++++++-- 1 file changed, 43 insertions(+), 2 deletions(-) diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index d75d960355..fff84a1821 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -13,6 +13,7 @@ /* ---------------------------------------------------------------------- Contributing authors: Ryan S. Elliott (UMinn) + Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- @@ -61,6 +62,7 @@ #include "pair_kim.h" #include "atom.h" #include "comm.h" +#include "universe.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" @@ -132,6 +134,14 @@ PairKIM::~PairKIM() // clean up kim_modelname if (kim_modelname != 0) delete [] kim_modelname; + if (simulatorModel) { + KIM::SimulatorModel::Destroy(&simulatorModel); + + // clean up KIM interface (if necessary) + kim_free(); + return; + } + // clean up lammps atom species number to unique particle names mapping if (lmps_unique_elements) for (int i = 0; i < lmps_num_unique_elements; i++) @@ -330,9 +340,40 @@ void PairKIM::settings(int narg, char **arg) // initialize KIM Model kim_init(); - // initialize LAMMPS Simulator model + // Set up and initialize LAMMPS Simulator model + if (simulatorModel) { - printf("LAMMPS simulator model: %s\n",kim_modelname); + const std::string *sim_name, *sim_version; + simulatorModel->GetSimulatorName(&sim_name); + simulatorModel->GetSimulatorVersion(&sim_version); + + if (comm->me == 0) { + std::string mesg("Using KIM Simulator Model : "); + mesg += kim_modelname; + mesg += "\n"; + mesg += "For Simulator : "; + mesg += *sim_name + " " + *sim_version + "\n"; + mesg += "Running on : LAMMPS "; + mesg += universe->version; + mesg += "\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } + + if (*sim_name != "LAMMPS") + error->all(FLERR,"Incompatible KIM Simulator Model"); + + int sim_fields, sim_lines; + const std::string *sim_field, *sim_value; + simulatorModel->GetNumberOfSimulatorFields(&sim_fields); + printf("sim_fields=%d\n",sim_fields); + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + printf("i=%d: %s (%d)\n",i,sim_field->c_str(),sim_lines); +// for (int j=0; j < +// simulatorModel->GetSimulatorFieldLine(i, + } } } -- GitLab From 56cf97e4970508b42ef4842e6f0de9ecfc1a9618 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 May 2019 13:53:17 -0400 Subject: [PATCH 016/469] hard code creation of simulator model pair style for now --- src/KIM/pair_kim.cpp | 20 ++++++++++++++++++-- 1 file changed, 18 insertions(+), 2 deletions(-) diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index fff84a1821..87a6d636d2 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -371,9 +371,25 @@ void PairKIM::settings(int narg, char **arg) for (int i=0; i < sim_fields; ++i) { simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); printf("i=%d: %s (%d)\n",i,sim_field->c_str(),sim_lines); -// for (int j=0; j < -// simulatorModel->GetSimulatorFieldLine(i, } + // hard code result for now: + + int dummy; + const char *simulator_style = (const char*)"tersoff/mod"; + simulator_class = force->new_pair(simulator_style,1,dummy); + if (simulator_class) { + if (comm->me == 0) { + std::string mesg("Created simulator pair style: "); + mesg += simulator_style; + mesg += "\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } + } else { + error->all(FLERR,"Failure to create simulator model pair style"); + } + simulator_class->settings(0,NULL); } } -- GitLab From 38a8c765f0974799a82cee1a185adff5f3eb06fc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 May 2019 22:54:20 -0400 Subject: [PATCH 017/469] add support species checking --- examples/kim/in.kim.simulator-model | 6 +-- src/KIM/pair_kim.cpp | 79 +++++++++++++++++++---------- 2 files changed, 54 insertions(+), 31 deletions(-) diff --git a/examples/kim/in.kim.simulator-model b/examples/kim/in.kim.simulator-model index 32baf9d78e..109711fffc 100644 --- a/examples/kim/in.kim.simulator-model +++ b/examples/kim/in.kim.simulator-model @@ -20,16 +20,16 @@ newton off lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} -create_box 1 box +create_box 2 box create_atoms 1 box #pair_style lj/cut 8.1500 #pair_coeff 1 1 0.0104 3.4000 pair_style kim ex_sim_model_Si_mod_tersoff -pair_coeff * * Ar +pair_coeff * * Si Si -mass 1 39.95 +mass * 39.95 velocity all create 200.0 232345 loop geom neighbor 0.3 bin diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index 87a6d636d2..2ed9df0aed 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -344,6 +344,8 @@ void PairKIM::settings(int narg, char **arg) if (simulatorModel) { const std::string *sim_name, *sim_version; + std::string atom_type_sym_list; + simulatorModel->GetSimulatorName(&sim_name); simulatorModel->GetSimulatorVersion(&sim_version); @@ -363,33 +365,6 @@ void PairKIM::settings(int narg, char **arg) if (*sim_name != "LAMMPS") error->all(FLERR,"Incompatible KIM Simulator Model"); - - int sim_fields, sim_lines; - const std::string *sim_field, *sim_value; - simulatorModel->GetNumberOfSimulatorFields(&sim_fields); - printf("sim_fields=%d\n",sim_fields); - for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - printf("i=%d: %s (%d)\n",i,sim_field->c_str(),sim_lines); - } - // hard code result for now: - - int dummy; - const char *simulator_style = (const char*)"tersoff/mod"; - simulator_class = force->new_pair(simulator_style,1,dummy); - if (simulator_class) { - if (comm->me == 0) { - std::string mesg("Created simulator pair style: "); - mesg += simulator_style; - mesg += "\n"; - - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); - } - } else { - error->all(FLERR,"Failure to create simulator model pair style"); - } - simulator_class->settings(0,NULL); } } @@ -464,9 +439,57 @@ void PairKIM::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); if (simulatorModel) { - simulatorModel->AddTemplateMap("atom-type-sym-list", atom_type_sym_list); + simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); simulatorModel->CloseTemplateMap(); + int len = strlen(atom_type_sym_list.c_str())+1; + char *strbuf = new char[len]; + char *strword; + + int sim_num_species; + const std::string *sim_species; + simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); + for (int i=0; i < sim_num_species; ++i) { + simulatorModel->GetSupportedSpecies(i, &sim_species); + strcpy(strbuf,atom_type_sym_list.c_str()); + strword = strtok(strbuf," \t"); + while (strword) { + if (strcmp(sim_species->c_str(),strword) != 0) + error->all(FLERR,"Species not supported by KIM Simulator Model"); + strword = strtok(NULL," \t"); + } + } + + int sim_fields, sim_lines; + const std::string *sim_field, *sim_value; + simulatorModel->GetNumberOfSimulatorFields(&sim_fields); + if (comm->me==0) printf("sim_fields=%d\n",sim_fields); + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (comm->me==0) printf("field[%d]=%s\n",i,sim_field->c_str()); + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); + if (comm->me==0) printf("line %d: %s\n",j,sim_value->c_str()); + } + } + // hard code result for now: + + int dummy; + const char *simulator_style = (const char*)"tersoff/mod"; + simulator_class = force->new_pair(simulator_style,1,dummy); + if (simulator_class) { + if (comm->me == 0) { + std::string mesg("Created simulator pair style: "); + mesg += simulator_style; + mesg += "\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } + } else { + error->all(FLERR,"Failure to create simulator model pair style"); + } + simulator_class->settings(0,NULL); error->all(FLERR,(simulatorModel->ToString()).c_str()); } else { // setup mapping between LAMMPS unique elements and KIM species codes -- GitLab From 92b042552e4de87631b5a6a848209a24945f2cac Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 May 2019 22:54:33 -0400 Subject: [PATCH 018/469] Revert "add JSON tokenizer to utils library" This reverts commit 32379d2d840a7b5421823ba1f01aed68028d5c6b. --- src/utils.cpp | 376 +------------------------------------------------- src/utils.h | 2 - 2 files changed, 2 insertions(+), 376 deletions(-) diff --git a/src/utils.cpp b/src/utils.cpp index 77ff8ef749..c3c173a73f 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include -#include #include "utils.h" #include "error.h" @@ -48,68 +46,9 @@ extern "C" { -/** Match text against a (simplified) regular expression - * (regexp will be compiled automatically). */ + /** Match text against a (simplified) regular expression + * (regexp will be compiled automatically). */ static int re_match(const char *text, const char *pattern); - -/** - * JSON type identifier. Basic types are: - * o Object - * o Array - * o String - * o Other primitive: number, boolean (true/false) or null - */ - typedef enum { - JSMN_UNDEFINED = 0, - JSMN_OBJECT = 1, - JSMN_ARRAY = 2, - JSMN_STRING = 3, - JSMN_PRIMITIVE = 4 - } jsmntype_t; - - enum jsmnerr { - /* Not enough tokens were provided */ - JSMN_ERROR_NOMEM = -1, - /* Invalid character inside JSON string */ - JSMN_ERROR_INVAL = -2, - /* The string is not a full JSON packet, more bytes expected */ - JSMN_ERROR_PART = -3 - }; - -/** - * JSON token description. - * type type (object, array, string etc.) - * start start position in JSON data string - * end end position in JSON data string - */ - typedef struct { - jsmntype_t type; - int start; - int end; - int size; - } jsmntok_t; - -/** - * JSON parser. Contains an array of token blocks available. Also stores - * the string being parsed now and current position in that string - */ - typedef struct { - unsigned int pos; /* offset in the JSON string */ - unsigned int toknext; /* next token to allocate */ - int toksuper; /* superior token node, e.g parent object or array */ - } jsmn_parser; - -/** - * Create JSON parser over an array of tokens - */ - static void jsmn_init(jsmn_parser *parser); - -/** - * Run JSON parser. It parses a JSON data string into and array of tokens, each describing - * a single JSON object. - */ - static int jsmn_parse(jsmn_parser *parser, const char *js, size_t len, - jsmntok_t *tokens, unsigned int num_tokens); } using namespace LAMMPS_NS; @@ -182,72 +121,6 @@ void utils::sfgets(const char *srcname, int srcline, char *s, int size, return; } - - -int utils::kim_simulator_json_parse(int argc, char **argv) -{ - FILE *fp; - jsmn_parser p; - jsmntok_t *tok; - char *buf; - size_t nbytes; - - if (argc != 2) { - printf("usage: %s \n",argv[0]); - return 1; - } - - // open JSON file - - fp = fopen(argv[1],"rb"); - if (!fp) { - perror("Error opening JSON file"); - return 2; - } - - // determine file size and allocate suitable buffer - - fseek(fp,0,SEEK_END); - long int flen = ftell(fp); - rewind(fp); - buf = new char[flen]; - nbytes = fread(buf,1,flen,fp); - fclose(fp); - - // parse once to count number of tokens - - jsmn_init(&p); - int ntok = jsmn_parse(&p,buf,nbytes,NULL,1); - if (ntok < 0) { - printf("failed to parse JSON: %d\n",ntok); - return 3; - } - - // allocate token storage and parse again - - jsmn_init(&p); - tok = new jsmntok_t[ntok]; - int retval = jsmn_parse(&p,buf,nbytes,tok,ntok); - if ((retval < 1) || (tok[0].type != JSMN_OBJECT)) { - printf("failed to parse JSON: no root object\n"); - return 4; - } - - for (int i=1; i < retval; ++i) { - printf("key: %.*s\n",tok[i].end-tok[i].start,buf+tok[i].start); - if (tok[i+1].type == JSMN_ARRAY) { - printf("value is array of size %d\n",tok[i+1].size); - i += tok[i+1].size + 1; - } else { - ++i; - } - } - - delete [] buf; - delete [] tok; - return 0; -} - /* ------------------------------------------------------------------ */ extern "C" { @@ -564,249 +437,4 @@ extern "C" { return 0; } - - -/** - * Allocates a fresh unused token from the token pool. - */ - static jsmntok_t *jsmn_alloc_token(jsmn_parser *parser, - jsmntok_t *tokens, size_t num_tokens) { - jsmntok_t *tok; - if (parser->toknext >= num_tokens) { - return NULL; - } - tok = &tokens[parser->toknext++]; - tok->start = tok->end = -1; - tok->size = 0; - return tok; - } - -/** - * Fills token type and boundaries. - */ - static void jsmn_fill_token(jsmntok_t *token, jsmntype_t type, - int start, int end) { - token->type = type; - token->start = start; - token->end = end; - token->size = 0; - } - -/** - * Fills next available token with JSON primitive. - */ - static int jsmn_parse_primitive(jsmn_parser *parser, const char *js, - size_t len, jsmntok_t *tokens, size_t num_tokens) { - jsmntok_t *token; - int start; - - start = parser->pos; - - for (; parser->pos < len && js[parser->pos] != '\0'; parser->pos++) { - switch (js[parser->pos]) { - case '\t' : case '\r' : case '\n' : case ' ' : - case ',' : case ']' : case '}' : - goto found; - } - if (js[parser->pos] < 32 || js[parser->pos] >= 127) { - parser->pos = start; - return JSMN_ERROR_INVAL; - } - } - - found: - if (tokens == NULL) { - parser->pos--; - return 0; - } - token = jsmn_alloc_token(parser, tokens, num_tokens); - if (token == NULL) { - parser->pos = start; - return JSMN_ERROR_NOMEM; - } - jsmn_fill_token(token, JSMN_PRIMITIVE, start, parser->pos); - parser->pos--; - return 0; - } - -/** - * Fills next token with JSON string. - */ - static int jsmn_parse_string(jsmn_parser *parser, const char *js, - size_t len, jsmntok_t *tokens, size_t num_tokens) { - jsmntok_t *token; - - int start = parser->pos; - - parser->pos++; - - /* Skip starting quote */ - for (; parser->pos < len && js[parser->pos] != '\0'; parser->pos++) { - char c = js[parser->pos]; - - /* Quote: end of string */ - if (c == '\"') { - if (tokens == NULL) { - return 0; - } - token = jsmn_alloc_token(parser, tokens, num_tokens); - if (token == NULL) { - parser->pos = start; - return JSMN_ERROR_NOMEM; - } - jsmn_fill_token(token, JSMN_STRING, start+1, parser->pos); - return 0; - } - - /* Backslash: Quoted symbol expected */ - if (c == '\\' && parser->pos + 1 < len) { - int i; - parser->pos++; - switch (js[parser->pos]) { - /* Allowed escaped symbols */ - case '\"': case '/' : case '\\' : case 'b' : - case 'f' : case 'r' : case 'n' : case 't' : - break; - /* Allows escaped symbol \uXXXX */ - case 'u': - parser->pos++; - for(i = 0; i < 4 && parser->pos < len && js[parser->pos] != '\0'; i++) { - /* If it isn't a hex character we have an error */ - if(!((js[parser->pos] >= 48 && js[parser->pos] <= 57) || /* 0-9 */ - (js[parser->pos] >= 65 && js[parser->pos] <= 70) || /* A-F */ - (js[parser->pos] >= 97 && js[parser->pos] <= 102))) { /* a-f */ - parser->pos = start; - return JSMN_ERROR_INVAL; - } - parser->pos++; - } - parser->pos--; - break; - /* Unexpected symbol */ - default: - parser->pos = start; - return JSMN_ERROR_INVAL; - } - } - } - parser->pos = start; - return JSMN_ERROR_PART; - } - -/** - * Parse JSON string and fill tokens. - */ - int jsmn_parse(jsmn_parser *parser, const char *js, size_t len, - jsmntok_t *tokens, unsigned int num_tokens) { - int r; - int i; - jsmntok_t *token; - int count = parser->toknext; - - for (; parser->pos < len && js[parser->pos] != '\0'; parser->pos++) { - char c; - jsmntype_t type; - - c = js[parser->pos]; - switch (c) { - case '{': case '[': - count++; - if (tokens == NULL) { - break; - } - token = jsmn_alloc_token(parser, tokens, num_tokens); - if (token == NULL) - return JSMN_ERROR_NOMEM; - if (parser->toksuper != -1) { - tokens[parser->toksuper].size++; - } - token->type = (c == '{' ? JSMN_OBJECT : JSMN_ARRAY); - token->start = parser->pos; - parser->toksuper = parser->toknext - 1; - break; - case '}': case ']': - if (tokens == NULL) - break; - type = (c == '}' ? JSMN_OBJECT : JSMN_ARRAY); - for (i = parser->toknext - 1; i >= 0; i--) { - token = &tokens[i]; - if (token->start != -1 && token->end == -1) { - if (token->type != type) { - return JSMN_ERROR_INVAL; - } - parser->toksuper = -1; - token->end = parser->pos + 1; - break; - } - } - /* Error if unmatched closing bracket */ - if (i == -1) return JSMN_ERROR_INVAL; - for (; i >= 0; i--) { - token = &tokens[i]; - if (token->start != -1 && token->end == -1) { - parser->toksuper = i; - break; - } - } - break; - case '\"': - r = jsmn_parse_string(parser, js, len, tokens, num_tokens); - if (r < 0) return r; - count++; - if (parser->toksuper != -1 && tokens != NULL) - tokens[parser->toksuper].size++; - break; - case '\t' : case '\r' : case '\n' : case ' ': - break; - case ':': - parser->toksuper = parser->toknext - 1; - break; - case ',': - if (tokens != NULL && parser->toksuper != -1 && - tokens[parser->toksuper].type != JSMN_ARRAY && - tokens[parser->toksuper].type != JSMN_OBJECT) { - for (i = parser->toknext - 1; i >= 0; i--) { - if (tokens[i].type == JSMN_ARRAY || tokens[i].type == JSMN_OBJECT) { - if (tokens[i].start != -1 && tokens[i].end == -1) { - parser->toksuper = i; - break; - } - } - } - } - break; - /* In non-strict mode every unquoted value is a primitive */ - default: - r = jsmn_parse_primitive(parser, js, len, tokens, num_tokens); - if (r < 0) return r; - count++; - if (parser->toksuper != -1 && tokens != NULL) - tokens[parser->toksuper].size++; - break; - - } - } - - if (tokens != NULL) { - for (i = parser->toknext - 1; i >= 0; i--) { - /* Unmatched opened object or array */ - if (tokens[i].start != -1 && tokens[i].end == -1) { - return JSMN_ERROR_PART; - } - } - } - - return count; - } - -/** - * Creates a new parser based over a given buffer with an array of tokens - * available. - */ - void jsmn_init(jsmn_parser *parser) { - parser->pos = 0; - parser->toknext = 0; - parser->toksuper = -1; - } } - diff --git a/src/utils.h b/src/utils.h index e908dcae81..2596fcd774 100644 --- a/src/utils.h +++ b/src/utils.h @@ -66,8 +66,6 @@ namespace LAMMPS_NS { */ void sfgets(const char *srcname, int srcline, char *s, int size, FILE *fp, const char *filename, Error *error); - - int kim_simulator_json_parse(int argc, char **argv); } } -- GitLab From 1e2ceb88daa631e50d68d79c581193a8bd52bdad Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 21 May 2019 15:57:14 -0400 Subject: [PATCH 019/469] complete basic simulator model proxy class creation and setup. --- src/KIM/pair_kim.cpp | 118 +++++++++++++++++++++++++++++++++++-------- 1 file changed, 96 insertions(+), 22 deletions(-) diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index 2ed9df0aed..626b7ccb1c 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -64,6 +64,7 @@ #include "comm.h" #include "universe.h" #include "force.h" +#include "input.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" @@ -71,6 +72,7 @@ #include "memory.h" #include "domain.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -136,6 +138,7 @@ PairKIM::~PairKIM() if (simulatorModel) { KIM::SimulatorModel::Destroy(&simulatorModel); + delete simulator_class; // clean up KIM interface (if necessary) kim_free(); @@ -446,6 +449,8 @@ void PairKIM::coeff(int narg, char **arg) char *strbuf = new char[len]; char *strword; + // validate species selection + int sim_num_species; const std::string *sim_species; simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); @@ -454,7 +459,7 @@ void PairKIM::coeff(int narg, char **arg) strcpy(strbuf,atom_type_sym_list.c_str()); strword = strtok(strbuf," \t"); while (strword) { - if (strcmp(sim_species->c_str(),strword) != 0) + if ((strcmp(strword,"NULL") != 0) && (strcmp(sim_species->c_str(),strword) != 0)) error->all(FLERR,"Species not supported by KIM Simulator Model"); strword = strtok(NULL," \t"); } @@ -463,33 +468,102 @@ void PairKIM::coeff(int narg, char **arg) int sim_fields, sim_lines; const std::string *sim_field, *sim_value; simulatorModel->GetNumberOfSimulatorFields(&sim_fields); - if (comm->me==0) printf("sim_fields=%d\n",sim_fields); for (int i=0; i < sim_fields; ++i) { simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (comm->me==0) printf("field[%d]=%s\n",i,sim_field->c_str()); - for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); - if (comm->me==0) printf("line %d: %s\n",j,sim_value->c_str()); + if (*sim_field == "units") { + simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); + if (*sim_value != update->unit_style) + error->all(FLERR,"Incompatible units for KIM Simulator Model"); + break; + } + } + + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "model-init") { + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); + input->one(sim_value->c_str()); + } + break; + } + } + + int sim_model_idx=-1; + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "model-defn") { + sim_model_idx = i; + break; } } - // hard code result for now: - - int dummy; - const char *simulator_style = (const char*)"tersoff/mod"; - simulator_class = force->new_pair(simulator_style,1,dummy); - if (simulator_class) { - if (comm->me == 0) { - std::string mesg("Created simulator pair style: "); - mesg += simulator_style; - mesg += "\n"; - - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); + + if (sim_model_idx < 0) + error->all(FLERR,"KIM Simulator Model has no Model definition"); + else { + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); + if (utils::strmatch(*sim_value,"^pair_style")) { + char *ptr,*sim_style; + char *style_args[64]; + int style_narg = 0; + int len = strlen(sim_value->c_str())+1; + char *stylecmd = new char[len]; + strcpy(stylecmd,sim_value->c_str()); + + // ignore first word (pair_style) + strtok(stylecmd," \t"); + ptr = sim_style = strtok(NULL," \t"); + while (ptr && (style_narg < 63)) { + ptr = strtok(NULL," \t"); + if (!ptr) break; + style_args[style_narg] = ptr; + ++style_narg; + } + + int dummy; + delete simulator_class; + simulator_class = force->new_pair(sim_style,1,dummy); + if (simulator_class) { + if (comm->me == 0) { + std::string mesg("Created KIM Simulator Model pair style: "); + mesg += sim_style; + mesg += "\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } + } else { + error->all(FLERR,"Failure to create simulator model pair style"); + } + simulator_class->settings(style_narg,style_args); + delete[] stylecmd; + } + } + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); + if (utils::strmatch(*sim_value,"^pair_coeff")) { + char *ptr; + char *coeff_args[64]; + int coeff_narg = 0; + int len = strlen(sim_value->c_str())+1; + char *coeffcmd = new char[len]; + strcpy(coeffcmd,sim_value->c_str()); + + // ignore first word (pair_coeff) + strtok(coeffcmd," \t"); + ptr = strtok(NULL," \t"); + while (ptr && (coeff_narg < 63)) { + coeff_args[coeff_narg] = ptr; + ++coeff_narg; + ptr = strtok(NULL," \t"); + } + + simulator_class->coeff(coeff_narg,coeff_args); + delete[] coeffcmd; + } } - } else { - error->all(FLERR,"Failure to create simulator model pair style"); } - simulator_class->settings(0,NULL); error->all(FLERR,(simulatorModel->ToString()).c_str()); } else { // setup mapping between LAMMPS unique elements and KIM species codes -- GitLab From ce46d52c8a9ab27383d797fc29c9108f4ed59ccd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 May 2019 10:23:26 -0400 Subject: [PATCH 020/469] add new 'kim_style' command as front end for KIM simulator (and regular) models --- examples/kim/in.kim.simulator-model | 4 +- src/KIM/fix_store_kim.cpp | 127 ++++++++++++ src/KIM/fix_store_kim.h | 98 ++++++++++ src/KIM/kim_query.cpp | 1 - src/KIM/kim_style.cpp | 286 ++++++++++++++++++++++++++++ src/KIM/kim_style.h | 87 +++++++++ src/modify.cpp | 2 +- 7 files changed, 600 insertions(+), 5 deletions(-) create mode 100644 src/KIM/fix_store_kim.cpp create mode 100644 src/KIM/fix_store_kim.h create mode 100644 src/KIM/kim_style.cpp create mode 100644 src/KIM/kim_style.h diff --git a/examples/kim/in.kim.simulator-model b/examples/kim/in.kim.simulator-model index 109711fffc..1e6e9dec89 100644 --- a/examples/kim/in.kim.simulator-model +++ b/examples/kim/in.kim.simulator-model @@ -16,7 +16,6 @@ variable zz equal 20*$z units metal atom_style atomic -newton off lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} @@ -26,8 +25,7 @@ create_atoms 1 box #pair_style lj/cut 8.1500 #pair_coeff 1 1 0.0104 3.4000 -pair_style kim ex_sim_model_Si_mod_tersoff -pair_coeff * * Si Si +kim_style define ex_sim_model_Si_mod_tersoff Si Si mass * 39.95 velocity all create 200.0 232345 loop geom diff --git a/src/KIM/fix_store_kim.cpp b/src/KIM/fix_store_kim.cpp new file mode 100644 index 0000000000..8e9946c20d --- /dev/null +++ b/src/KIM/fix_store_kim.cpp @@ -0,0 +1,127 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Axel Kohlmeyer (Temple U), + Ryan S. Elliott (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.0.2 (and newer) package +------------------------------------------------------------------------- */ + +#include +#include "fix_store_kim.h" +#include "KIM_SimulatorModel.hpp" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + +/* ---------------------------------------------------------------------- */ + +FixStoreKIM::FixStoreKIM(LAMMPS *lmp, int narg, char **arg) + : Fix(lmp, narg, arg), simulator_model(NULL), model_name(NULL) +{ + if (narg != 3) error->all(FLERR,"Illegal fix STORE/KIM command"); +} + +/* ---------------------------------------------------------------------- */ + +FixStoreKIM::~FixStoreKIM() +{ + // free associated storage + + if (simulator_model) { + KIM::SimulatorModel *sm = (KIM::SimulatorModel *)simulator_model; + KIM::SimulatorModel::Destroy(&sm); + simulator_model = NULL; + } + + if (model_name) { + char *mn = (char *)model_name; + delete[] mn; + model_name = NULL; + } +} + +/* ---------------------------------------------------------------------- */ + +int FixStoreKIM::setmask() +{ + int mask = 0; + return mask; +} + + +/* ---------------------------------------------------------------------- */ + +void FixStoreKIM::setptr(const char *name, void *ptr) +{ + if (strcmp(name,"simulator_model") == 0) { + if (simulator_model) { + KIM::SimulatorModel *sm = (KIM::SimulatorModel *)simulator_model; + KIM::SimulatorModel::Destroy(&sm); + } + simulator_model = ptr; + } else if (strcmp(name,"model_name") == 0) { + if (model_name) { + char *mn = (char *)model_name; + delete[] mn; + } + model_name = ptr; + } +} + +/* ---------------------------------------------------------------------- */ + +void *FixStoreKIM::getptr(const char *name) +{ + if (strcmp(name,"simulator_model") == 0) return simulator_model; + else if (strcmp(name,"model_name") == 0) return model_name; + else return NULL; +} diff --git a/src/KIM/fix_store_kim.h b/src/KIM/fix_store_kim.h new file mode 100644 index 0000000000..04081fd6dc --- /dev/null +++ b/src/KIM/fix_store_kim.h @@ -0,0 +1,98 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Axel Kohlmeyer (Temple U), + Ryan S. Elliott (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.0.2 (and newer) package +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS + +FixStyle(STORE/KIM,FixStoreKIM) + +#else + +#ifndef LMP_FIX_STORE_KIM_H +#define LMP_FIX_STORE_KIM_H + +#include +#include "fix.h" + +namespace LAMMPS_NS { + +class FixStoreKIM : public Fix { + public: + FixStoreKIM(class LAMMPS *, int, char **); + ~FixStoreKIM(); + int setmask(); + + void setptr(const char *, void *); + void *getptr(const char *); + + private: + void *simulator_model; // pointer to KIM simulator model class + void *model_name; // string of KIM model name +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index fedc976110..e4818abc94 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ - /* ---------------------------------------------------------------------- Contributing authors: Axel Kohlmeyer (Temple U), Ryan S. Elliott (UMN) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp new file mode 100644 index 0000000000..865f6827ab --- /dev/null +++ b/src/KIM/kim_style.cpp @@ -0,0 +1,286 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Axel Kohlmeyer (Temple U), + Ryan S. Elliott (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.0.2 (and newer) package +------------------------------------------------------------------------- */ + +#include +#include +#include "kim_style.h" +#include "error.h" +#include "atom.h" +#include "comm.h" +#include "domain.h" +#include "modify.h" +#include "update.h" +#include "universe.h" +#include "input.h" +#include "fix_store_kim.h" + +#include "KIM_SimulatorModel.hpp" + + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +void KimStyle::command(int narg, char **arg) +{ + if (narg < 2) error->all(FLERR,"Illegal kim_style command"); + + if (strcmp(arg[0],"init") == 0) { + if (narg > 2) error->all(FLERR,"Illegal kim_style init command"); + if (domain->box_exist) + error->all(FLERR,"Must use 'kim_style init' command before " + "simulation box is defined"); + int len = strlen(arg[1])+1; + char *model = new char[len]; + strcpy(model,arg[1]); + do_init(model); + } else if (strcmp(arg[0],"define") == 0) { + if (!domain->box_exist) + error->all(FLERR,"Must use 'kim_style define' command after " + "simulation box is defined"); + do_defn(narg-1,arg+1); + } else error->all(FLERR,"Illegal kim_style command"); +} + + +/* ---------------------------------------------------------------------- */ + +void KimStyle::do_init(char *model) +{ + // create storage proxy fix. delete existing fix, if needed. + + int ifix = modify->find_fix("KIM_MODEL_STORE"); + if (ifix >= 0) modify->delete_fix(ifix); + input->one("fix KIM_MODEL_STORE all STORE/KIM"); + ifix = modify->find_fix("KIM_MODEL_STORE"); + + FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; + fix_store->setptr("model_name", (void *) model); + + int kimerror; + KIM::SimulatorModel * simulatorModel; + kimerror = KIM::SimulatorModel::Create(model,&simulatorModel); + + // not a Kim Simulator Model; nothing else to do here. + if (kimerror) return; + + fix_store->setptr("simulator_model", (void *) simulatorModel); + + // need to call this to have access to (some) simulator model init data. + simulatorModel->CloseTemplateMap(); + + int sim_fields, sim_lines; + const std::string *sim_field, *sim_value; + simulatorModel->GetNumberOfSimulatorFields(&sim_fields); + + // set units + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "units") { + simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); + std::string cmd("units "); + cmd += *sim_value; + input->one(cmd.c_str()); + break; + } + } + + // init model + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "model-init") { + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); + input->one(sim_value->c_str()); + } + break; + } + } + + // reset template map. + simulatorModel->ClearTemplateMap(); +} + +/* ---------------------------------------------------------------------- */ + +void KimStyle::do_defn(int narg, char **arg) +{ + if (narg != atom->ntypes + 1) + error->all(FLERR,"Incorrect number of arguments for kim_style define command"); + + char *model = arg[0]; + KIM::SimulatorModel *simulatorModel(NULL); + int kimerror; + + // check if we had a kim_style init command by finding fix STORE/KIM + // retrieve model name and pointer to simulator model class instance. + // validate model name if not given as NULL. + // if kim_style init wasn't run try to initialize simulator model now. + + int ifix = modify->find_fix("KIM_MODEL_STORE"); + if (ifix >= 0) { + FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; + if (strcmp(model,"NULL") == 0) + model = (char *)fix_store->getptr("model_name"); + else if (strcmp(model,(const char*)fix_store->getptr("model_name")) != 0) + error->all(FLERR,"Inconsistent KIM model name"); + + simulatorModel = (KIM::SimulatorModel *)fix_store->getptr("simulator_model"); + } else { + + kimerror = KIM::SimulatorModel::Create(model,&simulatorModel); + if (kimerror) simulatorModel = NULL; + } + + if (simulatorModel) { + + const std::string *sim_name, *sim_version; + std::string atom_type_sym_list; + + simulatorModel->GetSimulatorName(&sim_name); + simulatorModel->GetSimulatorVersion(&sim_version); + + if (comm->me == 0) { + std::string mesg("Using KIM Simulator Model : "); + mesg += model; + mesg += "\n"; + mesg += "For Simulator : "; + mesg += *sim_name + " " + *sim_version + "\n"; + mesg += "Running on : LAMMPS "; + mesg += universe->version; + mesg += "\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } + + if (*sim_name != "LAMMPS") + error->all(FLERR,"Incompatible KIM Simulator Model"); + + for (int i = 1; i < narg; i++) + atom_type_sym_list += std::string(" ") + arg[i]; + + simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); + simulatorModel->CloseTemplateMap(); + + int len = strlen(atom_type_sym_list.c_str())+1; + char *strbuf = new char[len]; + char *strword; + + // validate species selection + + int sim_num_species; + const std::string *sim_species; + simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); + for (int i=0; i < sim_num_species; ++i) { + simulatorModel->GetSupportedSpecies(i, &sim_species); + strcpy(strbuf,atom_type_sym_list.c_str()); + strword = strtok(strbuf," \t"); + while (strword) { + if ((strcmp(strword,"NULL") != 0) && (strcmp(sim_species->c_str(),strword) != 0)) + error->all(FLERR,"Species not supported by KIM Simulator Model"); + strword = strtok(NULL," \t"); + } + } + delete[] strbuf; + + int sim_fields, sim_lines; + const std::string *sim_field, *sim_value; + simulatorModel->GetNumberOfSimulatorFields(&sim_fields); + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "units") { + simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); + if (*sim_value != update->unit_style) + error->all(FLERR,"Incompatible units for KIM Simulator Model"); + break; + } + } + + int sim_model_idx=-1; + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "model-defn") { + sim_model_idx = i; + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); + input->one(sim_value->c_str()); + } + } + } + + if (sim_model_idx < 0) + error->all(FLERR,"KIM Simulator Model has no Model definition"); + + } else { + + // not a simulator model. issue pair_style and pair_coeff commands. + // NOTE: all references to arg must appear before calls to input->one() + // as that will reset the argument vector. + + std::string cmd1("pair_style kim "); + cmd1 += model; + + std::string cmd2("pair_coeff * * "); + for (int i=1; i < narg; ++i) { + cmd2 += arg[i]; + cmd2 += " "; + } + + input->one(cmd1.c_str()); + input->one(cmd2.c_str()); + } +} diff --git a/src/KIM/kim_style.h b/src/KIM/kim_style.h new file mode 100644 index 0000000000..588de6e620 --- /dev/null +++ b/src/KIM/kim_style.h @@ -0,0 +1,87 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Axel Kohlmeyer (Temple U), + Ryan S. Elliott (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.0.2 (and newer) package +------------------------------------------------------------------------- */ + +#ifdef COMMAND_CLASS + +CommandStyle(kim_style,KimStyle) + +#else + +#ifndef LMP_KIM_STYLE_H +#define LMP_KIM_STYLE_H + +#include "pointers.h" + +namespace LAMMPS_NS { + +class KimStyle : protected Pointers { + public: + KimStyle(class LAMMPS *lmp) : Pointers(lmp) {}; + void command(int, char **); + private: + void do_init(char *); + void do_defn(int, char **); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + + +*/ diff --git a/src/modify.cpp b/src/modify.cpp index 7f43f035d2..9f0457c9d0 100644 --- a/src/modify.cpp +++ b/src/modify.cpp @@ -793,7 +793,7 @@ void Modify::add_fix(int narg, char **arg, int trysuffix) const char *exceptions[] = {"GPU", "OMP", "INTEL", "property/atom", "cmap", "cmap3", "rx", - "deprecated", NULL}; + "deprecated", "STORE/KIM", NULL}; if (domain->box_exist == 0) { int m; -- GitLab From b91b3c18cffff347ca58f2d5cdef7052adf5875b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 May 2019 11:52:38 -0400 Subject: [PATCH 021/469] remove references to simulator models from pair style kim --- src/KIM/pair_kim.cpp | 269 ++++++------------------------------------- src/KIM/pair_kim.h | 13 +-- 2 files changed, 41 insertions(+), 241 deletions(-) diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index 626b7ccb1c..6251ebb6c7 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -92,7 +92,6 @@ PairKIM::PairKIM(LAMMPS *lmp) : chargeUnit(KIM_CHARGE_UNIT_unused), temperatureUnit(KIM_TEMPERATURE_UNIT_unused), timeUnit(KIM_TIME_UNIT_unused), - simulatorModel(NULL), pkim(NULL), pargs(NULL), kim_model_support_for_energy(KIM_SUPPORT_STATUS_notSupported), @@ -110,9 +109,7 @@ PairKIM::PairKIM(LAMMPS *lmp) : kim_particleSpecies(NULL), kim_particleContributing(NULL), lmps_stripped_neigh_list(NULL), - lmps_stripped_neigh_ptr(NULL), - simulator_class(NULL), - simulator_style(NULL) + lmps_stripped_neigh_ptr(NULL) { // Initialize Pair data members to appropriate values single_enable = 0; // We do not provide the Single() function @@ -136,15 +133,6 @@ PairKIM::~PairKIM() // clean up kim_modelname if (kim_modelname != 0) delete [] kim_modelname; - if (simulatorModel) { - KIM::SimulatorModel::Destroy(&simulatorModel); - delete simulator_class; - - // clean up KIM interface (if necessary) - kim_free(); - return; - } - // clean up lammps atom species number to unique particle names mapping if (lmps_unique_elements) for (int i = 0; i < lmps_num_unique_elements; i++) @@ -342,33 +330,6 @@ void PairKIM::settings(int narg, char **arg) // initialize KIM Model kim_init(); - - // Set up and initialize LAMMPS Simulator model - - if (simulatorModel) { - const std::string *sim_name, *sim_version; - std::string atom_type_sym_list; - - simulatorModel->GetSimulatorName(&sim_name); - simulatorModel->GetSimulatorVersion(&sim_version); - - if (comm->me == 0) { - std::string mesg("Using KIM Simulator Model : "); - mesg += kim_modelname; - mesg += "\n"; - mesg += "For Simulator : "; - mesg += *sim_name + " " + *sim_version + "\n"; - mesg += "Running on : LAMMPS "; - mesg += universe->version; - mesg += "\n"; - - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); - } - - if (*sim_name != "LAMMPS") - error->all(FLERR,"Incompatible KIM Simulator Model"); - } } /* ---------------------------------------------------------------------- @@ -441,154 +402,29 @@ void PairKIM::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); - if (simulatorModel) { - simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); - simulatorModel->CloseTemplateMap(); - - int len = strlen(atom_type_sym_list.c_str())+1; - char *strbuf = new char[len]; - char *strword; - - // validate species selection - - int sim_num_species; - const std::string *sim_species; - simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); - for (int i=0; i < sim_num_species; ++i) { - simulatorModel->GetSupportedSpecies(i, &sim_species); - strcpy(strbuf,atom_type_sym_list.c_str()); - strword = strtok(strbuf," \t"); - while (strword) { - if ((strcmp(strword,"NULL") != 0) && (strcmp(sim_species->c_str(),strword) != 0)) - error->all(FLERR,"Species not supported by KIM Simulator Model"); - strword = strtok(NULL," \t"); - } - } - - int sim_fields, sim_lines; - const std::string *sim_field, *sim_value; - simulatorModel->GetNumberOfSimulatorFields(&sim_fields); - for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "units") { - simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); - if (*sim_value != update->unit_style) - error->all(FLERR,"Incompatible units for KIM Simulator Model"); - break; - } - } - - for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "model-init") { - for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); - input->one(sim_value->c_str()); - } - break; - } - } - - int sim_model_idx=-1; - for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "model-defn") { - sim_model_idx = i; - break; - } - } - - if (sim_model_idx < 0) - error->all(FLERR,"KIM Simulator Model has no Model definition"); - else { - for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); - if (utils::strmatch(*sim_value,"^pair_style")) { - char *ptr,*sim_style; - char *style_args[64]; - int style_narg = 0; - int len = strlen(sim_value->c_str())+1; - char *stylecmd = new char[len]; - strcpy(stylecmd,sim_value->c_str()); - - // ignore first word (pair_style) - strtok(stylecmd," \t"); - ptr = sim_style = strtok(NULL," \t"); - while (ptr && (style_narg < 63)) { - ptr = strtok(NULL," \t"); - if (!ptr) break; - style_args[style_narg] = ptr; - ++style_narg; - } - - int dummy; - delete simulator_class; - simulator_class = force->new_pair(sim_style,1,dummy); - if (simulator_class) { - if (comm->me == 0) { - std::string mesg("Created KIM Simulator Model pair style: "); - mesg += sim_style; - mesg += "\n"; - - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); - } - } else { - error->all(FLERR,"Failure to create simulator model pair style"); - } - simulator_class->settings(style_narg,style_args); - delete[] stylecmd; - } - } - for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); - if (utils::strmatch(*sim_value,"^pair_coeff")) { - char *ptr; - char *coeff_args[64]; - int coeff_narg = 0; - int len = strlen(sim_value->c_str())+1; - char *coeffcmd = new char[len]; - strcpy(coeffcmd,sim_value->c_str()); - - // ignore first word (pair_coeff) - strtok(coeffcmd," \t"); - ptr = strtok(NULL," \t"); - while (ptr && (coeff_narg < 63)) { - coeff_args[coeff_narg] = ptr; - ++coeff_narg; - ptr = strtok(NULL," \t"); - } - - simulator_class->coeff(coeff_narg,coeff_args); - delete[] coeffcmd; - } - } - } - error->all(FLERR,(simulatorModel->ToString()).c_str()); - } else { - // setup mapping between LAMMPS unique elements and KIM species codes - if (kim_particle_codes_ok) { - delete [] kim_particle_codes; - kim_particle_codes = NULL; - kim_particle_codes_ok = false; - } - kim_particle_codes = new int[lmps_num_unique_elements]; - kim_particle_codes_ok = true; - for(int i = 0; i < lmps_num_unique_elements; i++) { - int supported; - int code; - KIM_Model_GetSpeciesSupportAndCode( - pkim, - KIM_SpeciesName_FromString(lmps_unique_elements[i]), - &supported, - &code); - if (supported) { - kim_particle_codes[i] = code; - } else { - std::string msg("create_kim_particle_codes: symbol not found: "); - msg += lmps_unique_elements[i]; - error->all(FLERR, msg.c_str()); - } + // setup mapping between LAMMPS unique elements and KIM species codes + if (kim_particle_codes_ok) { + delete [] kim_particle_codes; + kim_particle_codes = NULL; + kim_particle_codes_ok = false; + } + kim_particle_codes = new int[lmps_num_unique_elements]; + kim_particle_codes_ok = true; + + for(int i = 0; i < lmps_num_unique_elements; i++) { + int supported; + int code; + KIM_Model_GetSpeciesSupportAndCode( + pkim, + KIM_SpeciesName_FromString(lmps_unique_elements[i]), + &supported, + &code); + if (supported) { + kim_particle_codes[i] = code; + } else { + std::string msg("create_kim_particle_codes: symbol not found: "); + msg += lmps_unique_elements[i]; + error->all(FLERR, msg.c_str()); } } } @@ -799,32 +635,6 @@ double PairKIM::memory_usage() return bytes; } -/* ---------------------------------------------------------------------- - simulator model support functions -------------------------------------------------------------------------- */ - -void PairKIM::simulator_init() -{ - int dummy; - // do not try with suffixes for now. - simulator_class = force->new_pair("lj/cut",1,dummy); - force->store_style(simulator_style,"lj/cut",1); - printf("Simulator model init: %s -> %s\n", kim_modelname, simulator_style); - char **args = new char*[1]; - args[0] = (char *)"8.1500"; - simulator_class->settings(1,args); - delete[] args; -} - -void PairKIM::simulator_free() -{ - printf("Simulator model free: %s -> %s\n", kim_modelname, simulator_style); - delete[] simulator_style; - simulator_style = NULL; - delete simulator_class; - simulator_class = NULL; -} - /* ---------------------------------------------------------------------- KIM-specific interface ------------------------------------------------------------------------- */ @@ -902,26 +712,21 @@ void PairKIM::kim_init() kim_modelname, &requestedUnitsAccepted, &pkim); - if (kimerror) { - kimerror = KIM::SimulatorModel::Create(kim_modelname,&simulatorModel); - if (kimerror) error->all(FLERR,"KIM ModelCreate failed"); - else return; - } else { - if (!requestedUnitsAccepted) - error->all(FLERR,"KIM Model did not accept the requested unit system"); + if (kimerror) error->all(FLERR,"KIM ModelCreate failed"); + else if (!requestedUnitsAccepted) + error->all(FLERR,"KIM Model did not accept the requested unit system"); - // check that the model does not require unknown capabilities - kimerror = check_for_routine_compatibility(); - if (kimerror) - error->all(FLERR, - "KIM Model requires unknown Routines. Unable to proceed."); + // check that the model does not require unknown capabilities + kimerror = check_for_routine_compatibility(); + if (kimerror) + error->all(FLERR, + "KIM Model requires unknown Routines. Unable to proceed."); - kimerror = KIM_Model_ComputeArgumentsCreate(pkim, &pargs); - if (kimerror) { - KIM_Model_Destroy(&pkim); - error->all(FLERR,"KIM ComputeArgumentsCreate failed"); - } else kim_init_ok = true; - } + kimerror = KIM_Model_ComputeArgumentsCreate(pkim, &pargs); + if (kimerror) { + KIM_Model_Destroy(&pkim); + error->all(FLERR,"KIM ComputeArgumentsCreate failed"); + } else kim_init_ok = true; // determine KIM Model capabilities (used in this function below) set_kim_model_has_flags(); diff --git a/src/KIM/pair_kim.h b/src/KIM/pair_kim.h index 37a6be1e5b..aa33b9b271 100644 --- a/src/KIM/pair_kim.h +++ b/src/KIM/pair_kim.h @@ -69,7 +69,6 @@ class KIM_API_model; extern "C" { #include "KIM_SimulatorHeaders.h" } -#include "KIM_SimulatorModel.hpp" namespace LAMMPS_NS { @@ -121,7 +120,6 @@ class PairKIM : public Pair { KIM_TemperatureUnit temperatureUnit; KIM_TimeUnit timeUnit; - KIM::SimulatorModel * simulatorModel; KIM_Model * pkim; KIM_ComputeArguments * pargs; @@ -152,12 +150,6 @@ class PairKIM : public Pair { // is in molecular mode int** lmps_stripped_neigh_ptr; // pointer into lists - // LAMMPS Simulator model support - Pair *simulator_class; - char *simulator_style; - virtual void simulator_init(); - virtual void simulator_free(); - // KIM specific helper functions virtual void set_contributing(); virtual void kim_init(); @@ -191,7 +183,10 @@ The KIM model was unable, for some reason, to complete the computation. E: 'KIMvirial' or 'LAMMPSvirial' not supported with kim-api. -"KIMvirial or "LAMMPSvirial" found on the pair_style line. These keys are not supported kim-api. (The virial computation is always performed by LAMMPS.) Please remove these keys, make sure the KIM model you are using supports kim-api, and rerun. +"KIMvirial or "LAMMPSvirial" found on the pair_style line. These keys +are not supported kim-api. (The virial computation is always performed +by LAMMPS.) Please remove these keys, make sure the KIM model you are +using supports kim-api, and rerun. E: Illegal pair_style command -- GitLab From fc8a639d585c7325eb08e2044a274a3b514043d8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 May 2019 19:39:15 -0400 Subject: [PATCH 022/469] add documentation for kim_style command. update a few KIM related doc files --- doc/src/Commands_all.txt | 1 + doc/src/Packages_details.txt | 11 +++-- doc/src/commands_list.txt | 1 + doc/src/kim_query.txt | 3 +- doc/src/kim_style.txt | 81 ++++++++++++++++++++++++++++++++++++ doc/src/lammps.book | 1 + doc/src/pair_kim.txt | 3 +- src/KIM/README | 6 +-- 8 files changed, 99 insertions(+), 8 deletions(-) create mode 100644 doc/src/kim_style.txt diff --git a/doc/src/Commands_all.txt b/doc/src/Commands_all.txt index 52c2e67e2e..d76ffac14c 100644 --- a/doc/src/Commands_all.txt +++ b/doc/src/Commands_all.txt @@ -69,6 +69,7 @@ An alphabetic list of all general LAMMPS commands. "include"_include.html, "jump"_jump.html, "kim_query"_kim_query.html, +"kim_style"_kim_style.html, "kspace_modify"_kspace_modify.html, "kspace_style"_kspace_style.html, "label"_label.html, diff --git a/doc/src/Packages_details.txt b/doc/src/Packages_details.txt index 352a38af84..19c7e96fe9 100644 --- a/doc/src/Packages_details.txt +++ b/doc/src/Packages_details.txt @@ -342,7 +342,10 @@ A "pair_style kim"_pair_kim.html command which is a wrapper on the Knowledge Base for Interatomic Models (KIM) repository of interatomic potentials, enabling any of them to be used in LAMMPS simulations. Also a "kim_query"_kim_query.html command, which allows to query -the OpenKIM database for stored properties. +the OpenKIM database for stored properties, and a +"kim_style"_kim_style.html command, which serves as a front end to +generating LAMMPS input on-the-fly for KIM simulator models and native +KIM models. To use this package you must have the KIM library available on your system. @@ -352,8 +355,10 @@ https://openkim.org. The KIM project is led by Ellad Tadmor and Ryan Elliott (U Minnesota). [Authors:] Ryan Elliott (U Minnesota) is the main developer for the KIM -API which the "pair_style kim"_pair_kim.html command uses. He -developed the pair style. +API which the "pair_style kim"_pair_kim.html command uses. He developed +the pair style. Axel Kohlmeyer (Temple U) contributed the +"kim_query"_kim_query.html and "kim_style"_kim_style.html commands in +close collaboration with Ryan. [Install:] diff --git a/doc/src/commands_list.txt b/doc/src/commands_list.txt index cf716df9ac..39d2f7c7d0 100644 --- a/doc/src/commands_list.txt +++ b/doc/src/commands_list.txt @@ -54,6 +54,7 @@ Commands :h1 info jump kim_query + kim_style kspace_modify kspace_style label diff --git a/doc/src/kim_query.txt b/doc/src/kim_query.txt index c581de0ebb..84eca6e676 100644 --- a/doc/src/kim_query.txt +++ b/doc/src/kim_query.txt @@ -43,4 +43,5 @@ See the "Build package"_Build_package.html doc page for more info. [Related commands:] -"pair_style kim"_pair_kim.html, "variable"_variable.html +"pair_style kim"_pair_kim.html, "kim_style"_kim_style.html, +"variable"_variable.html diff --git a/doc/src/kim_style.txt b/doc/src/kim_style.txt new file mode 100644 index 0000000000..ab605c017a --- /dev/null +++ b/doc/src/kim_style.txt @@ -0,0 +1,81 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Commands_all.html) + +:line + +kim_style command :h3 + +[Syntax:] + +kim_style mode model args :pre + +mode = {init} or {define} +model = name of the KIM model (potential or simulator model) or NULL +args = atom type to species mapping ({define} option only, one entry per atom type) :ul + +[Examples:] + +kim_style init ex_sim_model_Si_mod_tersoff +kim_style define NULL Si Si +kim_style define LennardJones_Ar Ar :pre + +[Description:] + +The kim_style command is a high-level wrapper around the +"Knowledge Base for Interatomic Models (OpenKIM)"_https://openkim.org +repository of interatomic potentials, so that they can be used by +LAMMPS scripts. It does not implement any computations directly, but +rather will generate LAMMPS input commands based on the information +retrieved from the OpenKIM repository. It is primarily meant to realize +so-called "KIM Simulator Models", which are OpenKIM repository entries +of models using native features of the simulation engine, i.e. LAMMPS +in this case, but it also supports realizing conventional KIM models +via the "pair_style kim"_pair_kim.html command. + +The kim_style command has two modes, {init} and {define}, indicated by +the first argument to the kim_style command. An {init} mode command +must be issued [before] the simulation box is created, while the {define} +mode version may only be used [after] the simulation box exists. The +{init} mode version is only required, if the KIM model requires it. +The second argument to the kim_style command is the KIM model ID. It +can be set to NULL in the kim_style define command, if it was already +set in a kim_style init command. Otherwise, the two model IDs must match. + +Only the kim_style define command allows additional arguments. Those +are used to map the atom types in LAMMPS to the available species in +the KIM model. This is equivalent to the arguments following +"pair_coeff * *" in a "kim"_pair_kim.html pair style. Thus the command + +kim_style define LennardJones_Ar Ar :pre + +will generate the LAMMPS input commands: + +pair_style kim LennardJones_Ar +pair_coeff * * Ar :pre + +For simulator models, the generated input commands may be more complex +and require that LAMMPS is built with the required packages included. +The commands generated by the kim_style command, can be copied to the +screen or log file, through the "echo"_echo.html command. +The kim_style command will also validate, that the selected simulator +model was generated for the LAMMPS MD code and not some other software. +In addition, the version strings for LAMMPS version used for defining +the simulator model and the LAMMPS version being currently run are +printed, so that it can be tracked down, if there are any incompatible +changes to input script or command syntax between the two LAMMPS versions. + +[Restrictions:] + +This command is part of the KIM package. It is only enabled if +LAMMPS was built with that package. Furthermore, its correct +functioning depends on compiling LAMMPS with all required packages +installed that are required by the commands embedded in any KIM +simulator models used. +See the "Build package"_Build_package.html doc page for more info. + +[Related commands:] + +"pair_style kim"_pair_kim.html, "kim_query"_kim_query.html diff --git a/doc/src/lammps.book b/doc/src/lammps.book index 500690597d..cedb6ea709 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -168,6 +168,7 @@ include.html info.html jump.html kim_query.html +kim_style.html label.html lattice.html log.html diff --git a/doc/src/pair_kim.txt b/doc/src/pair_kim.txt index a415ac606b..523bd89d7c 100644 --- a/doc/src/pair_kim.txt +++ b/doc/src/pair_kim.txt @@ -112,6 +112,7 @@ kim-api package version 2.0.0 and higher. [Related commands:] -"pair_coeff"_pair_coeff.html +"pair_coeff"_pair_coeff.html, "kim_style"_kim_style.html, +"kim_query"_kim_query.html [Default:] none diff --git a/src/KIM/README b/src/KIM/README index a69206596f..4f52d69a67 100644 --- a/src/KIM/README +++ b/src/KIM/README @@ -13,8 +13,8 @@ Using this package requires the KIM library and its models system. The library can be downloaded and built in lib/kim or elsewhere on your system, which must be done before bulding LAMMPS with this package. Details of the download, build, and install -process for KIM are given in the lib/kim/README file, and scripts will -soon be provided to help automate the process. Also see the LAMMPS +process for KIM are given in the lib/kim/README file, and scripts +are provided to help automate the process. Also see the LAMMPS manual for general information on building LAMMPS with external libraries. The settings in the Makefile.lammps file in lib/kim must be correct for LAMMPS to build correctly with this package installed. @@ -24,6 +24,6 @@ Makefile.lammps file usually will not need to be changed. Once you have successfully built LAMMPS with this package and the KIM library you can test it using an input file from the examples dir: -./lmp_serial < lammps/examples/kim/in.kim.lj +./lmp_serial -in lammps/examples/kim/in.kim.lj This pair_style was written by Ryan S. Elliott (U Minn). -- GitLab From ee5fa04732588646047111488bd5f4fec2870772 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 May 2019 22:41:28 -0400 Subject: [PATCH 023/469] create internal fix via modify->add_fix() so it does not get logged --- src/KIM/kim_style.cpp | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index 865f6827ab..53bf2958b3 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -104,7 +104,11 @@ void KimStyle::do_init(char *model) int ifix = modify->find_fix("KIM_MODEL_STORE"); if (ifix >= 0) modify->delete_fix(ifix); - input->one("fix KIM_MODEL_STORE all STORE/KIM"); + char *fixarg[3]; + fixarg[0] = (char *)"KIM_MODEL_STORE"; + fixarg[1] = (char *)"all"; + fixarg[2] = (char *)"STORE/KIM"; + modify->add_fix(3,fixarg); ifix = modify->find_fix("KIM_MODEL_STORE"); FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; -- GitLab From 5a929aff6ed77043341a396ecf30b25d14add523 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 May 2019 22:42:40 -0400 Subject: [PATCH 024/469] error out if kim_style init is required but wasn't called --- src/KIM/kim_style.cpp | 14 ++++++++++++-- 1 file changed, 12 insertions(+), 2 deletions(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index 53bf2958b3..d906d56041 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -240,17 +240,27 @@ void KimStyle::do_defn(int narg, char **arg) } } delete[] strbuf; - + + // check if units are unchanged, and if kim_style init was required + int sim_fields, sim_lines; const std::string *sim_field, *sim_value; simulatorModel->GetNumberOfSimulatorFields(&sim_fields); for (int i=0; i < sim_fields; ++i) { simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "units") { simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); if (*sim_value != update->unit_style) error->all(FLERR,"Incompatible units for KIM Simulator Model"); - break; + } + + if ((ifix < 0) && ( *sim_field == "model-init")) { + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); + if (*sim_value != "") + error->all(FLERR,"Must use 'kim_style init' with this model"); + } } } -- GitLab From c3897212e2fe7531c6cd37d0165b2c7a419f54da Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 May 2019 22:44:03 -0400 Subject: [PATCH 025/469] must call ClearTemplateMap(), so kim_style define may be called multiple times --- src/KIM/kim_style.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index d906d56041..323832fbad 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -279,6 +279,7 @@ void KimStyle::do_defn(int narg, char **arg) if (sim_model_idx < 0) error->all(FLERR,"KIM Simulator Model has no Model definition"); + simulatorModel->ClearTemplateMap(); } else { // not a simulator model. issue pair_style and pair_coeff commands. -- GitLab From 264f6e1630e3d4730953c9ca4b169a5631de3d34 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 May 2019 22:44:41 -0400 Subject: [PATCH 026/469] whitespace cleanup --- src/KIM/kim_style.cpp | 9 +++++++-- 1 file changed, 7 insertions(+), 2 deletions(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index 323832fbad..e8aee77b66 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -113,17 +113,19 @@ void KimStyle::do_init(char *model) FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; fix_store->setptr("model_name", (void *) model); - + int kimerror; KIM::SimulatorModel * simulatorModel; kimerror = KIM::SimulatorModel::Create(model,&simulatorModel); // not a Kim Simulator Model; nothing else to do here. + if (kimerror) return; fix_store->setptr("simulator_model", (void *) simulatorModel); // need to call this to have access to (some) simulator model init data. + simulatorModel->CloseTemplateMap(); int sim_fields, sim_lines; @@ -131,6 +133,7 @@ void KimStyle::do_init(char *model) simulatorModel->GetNumberOfSimulatorFields(&sim_fields); // set units + for (int i=0; i < sim_fields; ++i) { simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); if (*sim_field == "units") { @@ -143,6 +146,7 @@ void KimStyle::do_init(char *model) } // init model + for (int i=0; i < sim_fields; ++i) { simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); if (*sim_field == "model-init") { @@ -155,6 +159,7 @@ void KimStyle::do_init(char *model) } // reset template map. + simulatorModel->ClearTemplateMap(); } @@ -281,7 +286,7 @@ void KimStyle::do_defn(int narg, char **arg) simulatorModel->ClearTemplateMap(); } else { - + // not a simulator model. issue pair_style and pair_coeff commands. // NOTE: all references to arg must appear before calls to input->one() // as that will reset the argument vector. -- GitLab From 4619018eadc0f9e23bc347d5df53b745a15b60d0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 27 May 2019 23:26:26 -0400 Subject: [PATCH 027/469] provide more simulator model variant input examples --- examples/kim/data.VOH | 118 ++++++++++++++++++ examples/kim/in.kim.VOH.simulator.model | 24 ++++ examples/kim/in.kim.ex_si_1.simulator_model | 69 ++++++++++ examples/kim/in.kim.ex_si_2.simulator_model | 69 ++++++++++ ...ulator-model => in.kim.lj.simulator-model} | 7 +- 5 files changed, 284 insertions(+), 3 deletions(-) create mode 100644 examples/kim/data.VOH create mode 100644 examples/kim/in.kim.VOH.simulator.model create mode 100644 examples/kim/in.kim.ex_si_1.simulator_model create mode 100644 examples/kim/in.kim.ex_si_2.simulator_model rename examples/kim/{in.kim.simulator-model => in.kim.lj.simulator-model} (88%) diff --git a/examples/kim/data.VOH b/examples/kim/data.VOH new file mode 100644 index 0000000000..c093705adc --- /dev/null +++ b/examples/kim/data.VOH @@ -0,0 +1,118 @@ +# VOH example + +100 atoms +4 atom types + +0 25.000 xlo xhi +0 25.000 ylo yhi +0 25.000 zlo zhi + +Masses + +1 1.0080 +2 12.0107 +3 15.9994 +4 50.9415 + +Atoms + + 1 2 0.0 12.35333 12.56112 11.08925 + 2 4 0.0 12.32916 12.62071 13.13099 + 3 3 0.0 14.09425 12.56218 13.76130 + 4 3 0.0 11.42814 11.10330 13.76732 + 5 3 0.0 11.63260 13.89286 13.64097 + 6 1 0.0 10.61647 11.29221 14.30535 + 7 1 0.0 14.38026 13.34626 14.29055 + 8 1 0.0 11.32479 12.58820 10.70253 + 9 1 0.0 12.90918 13.42567 10.69612 + 10 1 0.0 12.84043 11.63643 10.74688 + 11 2 0.0 0.93670 23.74637 24.45218 + 12 4 0.0 2.18151 24.36876 0.94725 + 13 3 0.0 3.93452 24.44779 0.28384 + 14 3 0.0 2.13668 23.10529 2.33362 + 15 3 0.0 1.76108 0.74666 1.48323 + 16 1 0.0 1.82070 23.45305 3.20745 + 17 1 0.0 4.35555 0.34186 0.31083 + 18 1 0.0 24.90472 23.68735 24.82586 + 19 1 0.0 0.97611 24.45631 23.61244 + 20 1 0.0 1.24583 22.75250 24.09589 + 21 2 0.0 2.25730 12.18969 18.74792 + 22 4 0.0 0.67140 13.31162 19.37385 + 23 3 0.0 0.71106 13.43250 21.24545 + 24 3 0.0 24.08603 12.44025 18.87949 + 25 3 0.0 0.70486 14.71920 18.75808 + 26 1 0.0 23.49516 12.95430 18.26686 + 27 1 0.0 0.79723 14.34808 21.60818 + 28 1 0.0 2.24383 12.10285 17.65239 + 29 1 0.0 3.19860 12.66607 19.06030 + 30 1 0.0 2.20214 11.18299 19.18774 + 31 2 0.0 9.32237 8.16220 23.74501 + 32 4 0.0 9.41775 7.26178 21.91463 + 33 3 0.0 8.54752 8.34565 20.65588 + 34 3 0.0 8.50942 5.62151 22.00137 + 35 3 0.0 10.87539 7.02683 21.48455 + 36 1 0.0 9.06507 4.82324 21.80615 + 37 1 0.0 9.11458 8.67119 19.91477 + 38 1 0.0 9.82196 7.53487 24.49616 + 39 1 0.0 9.81855 9.14254 23.70532 + 40 1 0.0 8.27176 8.30387 24.03831 + 41 2 0.0 9.10113 13.98748 23.44281 + 42 4 0.0 8.84954 12.89163 21.73780 + 43 3 0.0 10.01387 13.54293 20.42005 + 44 3 0.0 7.08992 13.11522 21.12954 + 45 3 0.0 9.12937 11.39982 21.99065 + 46 1 0.0 6.55309 12.28287 21.08224 + 47 1 0.0 10.67858 12.89258 20.08249 + 48 1 0.0 8.42108 13.62252 24.22498 + 49 1 0.0 10.13926 13.89766 23.79639 + 50 1 0.0 8.88118 15.04646 23.24289 + 51 2 0.0 17.73225 3.40708 8.28945 + 52 4 0.0 18.49877 5.29835 8.37599 + 53 3 0.0 19.48472 5.62627 6.81505 + 54 3 0.0 19.66498 5.40961 9.84118 + 55 3 0.0 17.38120 6.34466 8.51889 + 56 1 0.0 19.41208 6.07779 10.52927 + 57 1 0.0 19.15960 6.37609 6.25924 + 58 1 0.0 17.15579 3.19557 9.20103 + 59 1 0.0 17.07197 3.31049 7.41454 + 60 1 0.0 18.54903 2.67524 8.20436 + 61 2 0.0 5.18346 20.97409 24.28840 + 62 4 0.0 7.06396 20.17968 24.34847 + 63 3 0.0 7.63220 19.82889 22.59578 + 64 3 0.0 7.00272 18.55243 0.28036 + 65 3 0.0 8.05085 21.13715 0.03620 + 66 1 0.0 7.56109 18.51690 1.09952 + 67 1 0.0 8.44257 20.31624 22.30833 + 68 1 0.0 4.83239 21.17976 0.30904 + 69 1 0.0 5.19182 21.91237 23.71419 + 70 1 0.0 4.49282 20.26573 23.80772 + 71 2 0.0 21.82701 12.79861 20.63056 + 72 4 0.0 21.27646 11.09990 19.63611 + 73 3 0.0 19.52930 10.64327 20.13923 + 74 3 0.0 22.41924 9.70346 20.14638 + 75 3 0.0 21.34556 11.30206 18.11274 + 76 1 0.0 22.94464 9.30084 19.40876 + 77 1 0.0 18.86743 10.62817 19.40629 + 78 1 0.0 22.85378 13.07853 20.35349 + 79 1 0.0 21.14666 13.62206 20.37063 + 80 1 0.0 21.78702 12.62668 21.71522 + 81 2 0.0 4.84801 10.63893 5.85720 + 82 4 0.0 2.99668 11.06158 5.10490 + 83 3 0.0 3.09505 11.09458 3.23258 + 84 3 0.0 2.48053 12.76555 5.69567 + 85 3 0.0 1.96195 10.01780 5.55634 + 86 1 0.0 1.65323 12.78746 6.24245 + 87 1 0.0 2.52753 10.43264 2.76734 + 88 1 0.0 4.80984 10.62196 6.95551 + 89 1 0.0 5.18492 9.65688 5.49273 + 90 1 0.0 5.56737 11.40648 5.53568 + 91 2 0.0 13.58126 9.47098 19.40329 + 92 4 0.0 14.17691 10.17243 21.22692 + 93 3 0.0 14.44428 12.02521 21.10583 + 94 3 0.0 15.81206 9.37183 21.67632 + 95 3 0.0 13.12907 9.86545 22.30960 + 96 1 0.0 15.80034 8.83149 22.50703 + 97 1 0.0 13.87232 12.57457 21.69672 + 98 1 0.0 13.42563 8.38456 19.45392 + 99 1 0.0 12.63978 9.95672 19.10431 + 100 1 0.0 14.35123 9.68789 18.64825 diff --git a/examples/kim/in.kim.VOH.simulator.model b/examples/kim/in.kim.VOH.simulator.model new file mode 100644 index 0000000000..3803ceceba --- /dev/null +++ b/examples/kim/in.kim.VOH.simulator.model @@ -0,0 +1,24 @@ +# REAX potential for VOH system +# ..... + +units real +atom_style charge + +kim_style init Sim_LAMMPS_ReaxFF_ChenowethVanDuinPersson_2008_CHOV__SM_429148913211_000 + +read_data data.VOH + +kim_style define NULL H C O V + +neighbor 2 bin +neigh_modify every 10 delay 0 check no + +fix 1 all nve +fix 2 all qeq/reax 1 0.0 10.0 1e-6 param.qeq +fix 3 all temp/berendsen 500.0 500.0 100.0 + +timestep 0.25 + +#dump 1 all atom 30 dump.reax.voh + +run 300 diff --git a/examples/kim/in.kim.ex_si_1.simulator_model b/examples/kim/in.kim.ex_si_1.simulator_model new file mode 100644 index 0000000000..03f9c25a33 --- /dev/null +++ b/examples/kim/in.kim.ex_si_1.simulator_model @@ -0,0 +1,69 @@ + +units metal +kim_style init ex_sim_model_Si_mod_tersoff + +atom_style atomic +atom_modify map array +boundary p p p + +# temperatures +variable tlo equal 1800.0 +variable thi equal 2400.0 + +# coordination number cutoff + +variable r equal 2.835 + +# minimization parameters + +variable etol equal 1.0e-5 +variable ftol equal 1.0e-5 +variable maxiter equal 100 +variable maxeval equal 100 +variable dmax equal 1.0e-1 + +# diamond unit cell + +variable a equal 5.431 +lattice custom $a & + a1 1.0 0.0 0.0 & + a2 0.0 1.0 0.0 & + a3 0.0 0.0 1.0 & + basis 0.0 0.0 0.0 & + basis 0.0 0.5 0.5 & + basis 0.5 0.0 0.5 & + basis 0.5 0.5 0.0 & + basis 0.25 0.25 0.25 & + basis 0.25 0.75 0.75 & + basis 0.75 0.25 0.75 & + basis 0.75 0.75 0.25 + +region myreg block 0 4 & + 0 4 & + 0 4 +create_box 1 myreg +create_atoms 1 region myreg + +mass 1 28.06 + +group Si type 1 + +velocity all create ${thi} 5287286 mom yes rot yes dist gaussian + +# make a vacancy + +group del id 300 +delete_atoms group del +kim_style define ex_sim_model_Si_mod_tersoff Si + +thermo 10 + +fix 1 all nve +fix 2 all langevin ${thi} ${thi} 0.1 48278 + +timestep 1.0e-3 +neighbor 1.0 bin +neigh_modify every 1 delay 10 check yes + +run 100 + diff --git a/examples/kim/in.kim.ex_si_2.simulator_model b/examples/kim/in.kim.ex_si_2.simulator_model new file mode 100644 index 0000000000..18efd94222 --- /dev/null +++ b/examples/kim/in.kim.ex_si_2.simulator_model @@ -0,0 +1,69 @@ + +units metal +kim_style init ex_sim_model_Si_mod_tersoff + +atom_style atomic +atom_modify map array +boundary p p p + +# temperatures +variable tlo equal 1800.0 +variable thi equal 2400.0 + +# coordination number cutoff + +variable r equal 2.835 + +# minimization parameters + +variable etol equal 1.0e-5 +variable ftol equal 1.0e-5 +variable maxiter equal 100 +variable maxeval equal 100 +variable dmax equal 1.0e-1 + +# diamond unit cell + +variable a equal 5.431 +lattice custom $a & + a1 1.0 0.0 0.0 & + a2 0.0 1.0 0.0 & + a3 0.0 0.0 1.0 & + basis 0.0 0.0 0.0 & + basis 0.0 0.5 0.5 & + basis 0.5 0.0 0.5 & + basis 0.5 0.5 0.0 & + basis 0.25 0.25 0.25 & + basis 0.25 0.75 0.75 & + basis 0.75 0.25 0.75 & + basis 0.75 0.75 0.25 + +region myreg block 0 4 & + 0 4 & + 0 4 +create_box 1 myreg +create_atoms 1 region myreg + +mass 1 28.06 + +group Si type 1 + +velocity all create ${thi} 5287286 mom yes rot yes dist gaussian + +# make a vacancy + +group del id 300 +delete_atoms group del +kim_style define NULL Si + +thermo 10 + +fix 1 all nve +fix 2 all langevin ${thi} ${thi} 0.1 48278 + +timestep 1.0e-3 +neighbor 1.0 bin +neigh_modify every 1 delay 10 check yes + +run 100 + diff --git a/examples/kim/in.kim.simulator-model b/examples/kim/in.kim.lj.simulator-model similarity index 88% rename from examples/kim/in.kim.simulator-model rename to examples/kim/in.kim.lj.simulator-model index 1e6e9dec89..21d60a48d9 100644 --- a/examples/kim/in.kim.simulator-model +++ b/examples/kim/in.kim.lj.simulator-model @@ -16,18 +16,19 @@ variable zz equal 20*$z units metal atom_style atomic +newton on lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} -create_box 2 box +create_box 1 box create_atoms 1 box #pair_style lj/cut 8.1500 #pair_coeff 1 1 0.0104 3.4000 -kim_style define ex_sim_model_Si_mod_tersoff Si Si +kim_style define LennardJones_Ar Ar -mass * 39.95 +mass 1 39.95 velocity all create 200.0 232345 loop geom neighbor 0.3 bin -- GitLab From eb6287d2e8877c3b56af90b89a692c64d9a00036 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 27 May 2019 23:26:46 -0400 Subject: [PATCH 028/469] correctly check for supported species --- src/KIM/kim_style.cpp | 25 +++++++++++++++++-------- 1 file changed, 17 insertions(+), 8 deletions(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index e8aee77b66..eac16f1a8a 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -232,17 +232,26 @@ void KimStyle::do_defn(int narg, char **arg) // validate species selection int sim_num_species; + bool species_is_supported; const std::string *sim_species; simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); - for (int i=0; i < sim_num_species; ++i) { - simulatorModel->GetSupportedSpecies(i, &sim_species); - strcpy(strbuf,atom_type_sym_list.c_str()); - strword = strtok(strbuf," \t"); - while (strword) { - if ((strcmp(strword,"NULL") != 0) && (strcmp(sim_species->c_str(),strword) != 0)) - error->all(FLERR,"Species not supported by KIM Simulator Model"); - strword = strtok(NULL," \t"); + strcpy(strbuf,atom_type_sym_list.c_str()); + strword = strtok(strbuf," \t"); + while (strword) { + species_is_supported = false; + if (strcmp(strword,"NULL") == 0) continue; + for (int i=0; i < sim_num_species; ++i) { + simulatorModel->GetSupportedSpecies(i, &sim_species); + if (strcmp(sim_species->c_str(),strword) == 0) + species_is_supported = true; } + if (!species_is_supported) { + std::string msg("Species '"); + msg += strword; + msg += "' is not supported by this KIM Simulator Model"; + error->all(FLERR,msg.c_str()); + } + strword = strtok(NULL," \t"); } delete[] strbuf; -- GitLab From b3a01694b7312989554f24817bd94e8ccca2a83d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 27 May 2019 23:34:05 -0400 Subject: [PATCH 029/469] remove leftover fix qeq/reax command --- examples/kim/in.kim.VOH.simulator.model | 1 - 1 file changed, 1 deletion(-) diff --git a/examples/kim/in.kim.VOH.simulator.model b/examples/kim/in.kim.VOH.simulator.model index 3803ceceba..a2dd6983c0 100644 --- a/examples/kim/in.kim.VOH.simulator.model +++ b/examples/kim/in.kim.VOH.simulator.model @@ -14,7 +14,6 @@ neighbor 2 bin neigh_modify every 10 delay 0 check no fix 1 all nve -fix 2 all qeq/reax 1 0.0 10.0 1e-6 param.qeq fix 3 all temp/berendsen 500.0 500.0 100.0 timestep 0.25 -- GitLab From 113b8b4be23bdbcfde5031144110a26d178f29a0 Mon Sep 17 00:00:00 2001 From: "Dan S. Bolintineanu" Date: Thu, 30 May 2019 14:21:11 -0600 Subject: [PATCH 030/469] Fixes two bugs in pair granular: 1. User-set cutoffs did not work 2. Restarts not working --- src/GRANULAR/pair_granular.cpp | 7 ++++--- 1 file changed, 4 insertions(+), 3 deletions(-) diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 903ed303b0..913f6f8b59 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -890,6 +890,7 @@ void PairGranular::coeff(int narg, char **arg) if (iarg + 1 >= narg) error->all(FLERR, "Illegal pair_coeff command, not enough parameters"); cutoff_one = force->numeric(FLERR,arg[iarg+1]); + iarg += 2; } else error->all(FLERR, "Illegal pair coeff command"); } @@ -1234,7 +1235,7 @@ void PairGranular::write_restart(FILE *fp) fwrite(&tangential_coeffs[i][j],sizeof(double),3,fp); fwrite(&roll_coeffs[i][j],sizeof(double),3,fp); fwrite(&twist_coeffs[i][j],sizeof(double),3,fp); - fwrite(&cut[i][j],sizeof(double),1,fp); + fwrite(&cutoff_type[i][j],sizeof(double),1,fp); } } } @@ -1264,7 +1265,7 @@ void PairGranular::read_restart(FILE *fp) fread(&tangential_coeffs[i][j],sizeof(double),3,fp); fread(&roll_coeffs[i][j],sizeof(double),3,fp); fread(&twist_coeffs[i][j],sizeof(double),3,fp); - fread(&cut[i][j],sizeof(double),1,fp); + fread(&cutoff_type[i][j],sizeof(double),1,fp); } MPI_Bcast(&normal_model[i][j],1,MPI_INT,0,world); MPI_Bcast(&damping_model[i][j],1,MPI_INT,0,world); @@ -1275,7 +1276,7 @@ void PairGranular::read_restart(FILE *fp) MPI_Bcast(&tangential_coeffs[i][j],3,MPI_DOUBLE,0,world); MPI_Bcast(&roll_coeffs[i][j],3,MPI_DOUBLE,0,world); MPI_Bcast(&twist_coeffs[i][j],3,MPI_DOUBLE,0,world); - MPI_Bcast(&cut[i][j],1,MPI_DOUBLE,0,world); + MPI_Bcast(&cutoff_type[i][j],1,MPI_DOUBLE,0,world); } } } -- GitLab From 24a63f0f31446f5a98a32325248cced2d1c6d21a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 May 2019 21:51:13 -0400 Subject: [PATCH 031/469] update kim_style command semantics as discussed in PR #1440 this also adds documentation of error messages in the kim_style header --- doc/src/kim_style.txt | 54 ++++++++------- ...lator.model => in.kim.VOH.simulator_model} | 2 +- ...tor_model => in.kim.ex_si.simulator_model} | 2 +- examples/kim/in.kim.ex_si_1.simulator_model | 69 ------------------- ...ulator-model => in.kim.lj.simulator_model} | 4 +- src/KIM/kim_style.cpp | 33 +++------ src/KIM/kim_style.h | 36 ++++++++++ 7 files changed, 81 insertions(+), 119 deletions(-) rename examples/kim/{in.kim.VOH.simulator.model => in.kim.VOH.simulator_model} (92%) rename examples/kim/{in.kim.ex_si_2.simulator_model => in.kim.ex_si.simulator_model} (98%) delete mode 100644 examples/kim/in.kim.ex_si_1.simulator_model rename examples/kim/{in.kim.lj.simulator-model => in.kim.lj.simulator_model} (92%) diff --git a/doc/src/kim_style.txt b/doc/src/kim_style.txt index ab605c017a..dcdfae1cdc 100644 --- a/doc/src/kim_style.txt +++ b/doc/src/kim_style.txt @@ -10,17 +10,18 @@ kim_style command :h3 [Syntax:] -kim_style mode model args :pre +kim_style mode args :pre -mode = {init} or {define} -model = name of the KIM model (potential or simulator model) or NULL -args = atom type to species mapping ({define} option only, one entry per atom type) :ul +mode = {init model} or {define typeargs} +model = name of the KIM model (KIM potential or KIM simulator model) +typeargs = atom type to species mapping (one entry per atom type) :ul [Examples:] kim_style init ex_sim_model_Si_mod_tersoff -kim_style define NULL Si Si -kim_style define LennardJones_Ar Ar :pre +kim_style define Si Si +kim_style init LennardJones_Ar +kim_style define Ar :pre [Description:] @@ -29,27 +30,34 @@ The kim_style command is a high-level wrapper around the repository of interatomic potentials, so that they can be used by LAMMPS scripts. It does not implement any computations directly, but rather will generate LAMMPS input commands based on the information -retrieved from the OpenKIM repository. It is primarily meant to realize -so-called "KIM Simulator Models", which are OpenKIM repository entries -of models using native features of the simulation engine, i.e. LAMMPS +retrieved from the OpenKIM repository. It is able to realize so-called +"KIM Simulator Models", which are OpenKIM repository entries of models +using native features of the simulation engine in use, i.e. LAMMPS in this case, but it also supports realizing conventional KIM models -via the "pair_style kim"_pair_kim.html command. +implicitly via generating a "pair_style kim"_pair_kim.html command +followed by a suitable "pair_coeff"_pair_coeff.html command. The kim_style command has two modes, {init} and {define}, indicated by the first argument to the kim_style command. An {init} mode command must be issued [before] the simulation box is created, while the {define} -mode version may only be used [after] the simulation box exists. The -{init} mode version is only required, if the KIM model requires it. -The second argument to the kim_style command is the KIM model ID. It -can be set to NULL in the kim_style define command, if it was already -set in a kim_style init command. Otherwise, the two model IDs must match. - -Only the kim_style define command allows additional arguments. Those -are used to map the atom types in LAMMPS to the available species in -the KIM model. This is equivalent to the arguments following -"pair_coeff * *" in a "kim"_pair_kim.html pair style. Thus the command - -kim_style define LennardJones_Ar Ar :pre +mode version may only be used [after] the simulation box exists. Both +are required. The {init} mode version sets the model name and may issue +additional commands changing LAMMPS default settings that are required +for using a selected simulator model. If needed, those settings can be +overridden. The second argument to the {kim_style init} command is the +KIM model ID. + +The {kim_style define} command will issue commands that will realize +the selected model (through generating pair_style and pair_coeff commands, +but also other commands, as required). It has to be issued [after] the +the simulation box is defined. The {kim_style define} command allows a +varying numbver of additional arguments. Those are used to map the atom +types in LAMMPS to the available species in the KIM model. This is +equivalent to the arguments following "pair_coeff * *" in a +"kim"_pair_kim.html pair style. Thus the commands: + +kim_style init LennardJones_Ar +kim_style define Ar :pre will generate the LAMMPS input commands: @@ -60,7 +68,7 @@ For simulator models, the generated input commands may be more complex and require that LAMMPS is built with the required packages included. The commands generated by the kim_style command, can be copied to the screen or log file, through the "echo"_echo.html command. -The kim_style command will also validate, that the selected simulator +The kim_style command will also validate, that a selected simulator model was generated for the LAMMPS MD code and not some other software. In addition, the version strings for LAMMPS version used for defining the simulator model and the LAMMPS version being currently run are diff --git a/examples/kim/in.kim.VOH.simulator.model b/examples/kim/in.kim.VOH.simulator_model similarity index 92% rename from examples/kim/in.kim.VOH.simulator.model rename to examples/kim/in.kim.VOH.simulator_model index a2dd6983c0..8696cf265a 100644 --- a/examples/kim/in.kim.VOH.simulator.model +++ b/examples/kim/in.kim.VOH.simulator_model @@ -8,7 +8,7 @@ kim_style init Sim_LAMMPS_ReaxFF_ChenowethVanDuinPersson_2008_CHOV__SM_429148913 read_data data.VOH -kim_style define NULL H C O V +kim_style define H C O V neighbor 2 bin neigh_modify every 10 delay 0 check no diff --git a/examples/kim/in.kim.ex_si_2.simulator_model b/examples/kim/in.kim.ex_si.simulator_model similarity index 98% rename from examples/kim/in.kim.ex_si_2.simulator_model rename to examples/kim/in.kim.ex_si.simulator_model index 18efd94222..2f9e79ef4e 100644 --- a/examples/kim/in.kim.ex_si_2.simulator_model +++ b/examples/kim/in.kim.ex_si.simulator_model @@ -54,7 +54,7 @@ velocity all create ${thi} 5287286 mom yes rot yes dist gaussian group del id 300 delete_atoms group del -kim_style define NULL Si +kim_style define Si thermo 10 diff --git a/examples/kim/in.kim.ex_si_1.simulator_model b/examples/kim/in.kim.ex_si_1.simulator_model deleted file mode 100644 index 03f9c25a33..0000000000 --- a/examples/kim/in.kim.ex_si_1.simulator_model +++ /dev/null @@ -1,69 +0,0 @@ - -units metal -kim_style init ex_sim_model_Si_mod_tersoff - -atom_style atomic -atom_modify map array -boundary p p p - -# temperatures -variable tlo equal 1800.0 -variable thi equal 2400.0 - -# coordination number cutoff - -variable r equal 2.835 - -# minimization parameters - -variable etol equal 1.0e-5 -variable ftol equal 1.0e-5 -variable maxiter equal 100 -variable maxeval equal 100 -variable dmax equal 1.0e-1 - -# diamond unit cell - -variable a equal 5.431 -lattice custom $a & - a1 1.0 0.0 0.0 & - a2 0.0 1.0 0.0 & - a3 0.0 0.0 1.0 & - basis 0.0 0.0 0.0 & - basis 0.0 0.5 0.5 & - basis 0.5 0.0 0.5 & - basis 0.5 0.5 0.0 & - basis 0.25 0.25 0.25 & - basis 0.25 0.75 0.75 & - basis 0.75 0.25 0.75 & - basis 0.75 0.75 0.25 - -region myreg block 0 4 & - 0 4 & - 0 4 -create_box 1 myreg -create_atoms 1 region myreg - -mass 1 28.06 - -group Si type 1 - -velocity all create ${thi} 5287286 mom yes rot yes dist gaussian - -# make a vacancy - -group del id 300 -delete_atoms group del -kim_style define ex_sim_model_Si_mod_tersoff Si - -thermo 10 - -fix 1 all nve -fix 2 all langevin ${thi} ${thi} 0.1 48278 - -timestep 1.0e-3 -neighbor 1.0 bin -neigh_modify every 1 delay 10 check yes - -run 100 - diff --git a/examples/kim/in.kim.lj.simulator-model b/examples/kim/in.kim.lj.simulator_model similarity index 92% rename from examples/kim/in.kim.lj.simulator-model rename to examples/kim/in.kim.lj.simulator_model index 21d60a48d9..15b26c3c64 100644 --- a/examples/kim/in.kim.lj.simulator-model +++ b/examples/kim/in.kim.lj.simulator_model @@ -18,6 +18,8 @@ units metal atom_style atomic newton on +kim_style init LennardJones_Ar + lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} create_box 1 box @@ -26,7 +28,7 @@ create_atoms 1 box #pair_style lj/cut 8.1500 #pair_coeff 1 1 0.0104 3.4000 -kim_style define LennardJones_Ar Ar +kim_style define Ar mass 1 39.95 velocity all create 200.0 232345 loop geom diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index eac16f1a8a..856fb94c9e 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -79,7 +79,7 @@ void KimStyle::command(int narg, char **arg) if (narg < 2) error->all(FLERR,"Illegal kim_style command"); if (strcmp(arg[0],"init") == 0) { - if (narg > 2) error->all(FLERR,"Illegal kim_style init command"); + if (narg > 2) error->all(FLERR,"Illegal kim_style command"); if (domain->box_exist) error->all(FLERR,"Must use 'kim_style init' command before " "simulation box is defined"); @@ -167,10 +167,10 @@ void KimStyle::do_init(char *model) void KimStyle::do_defn(int narg, char **arg) { - if (narg != atom->ntypes + 1) - error->all(FLERR,"Incorrect number of arguments for kim_style define command"); + if (narg != atom->ntypes) + error->all(FLERR,"Illegal kim_style command"); - char *model = arg[0]; + char *model = NULL; KIM::SimulatorModel *simulatorModel(NULL); int kimerror; @@ -182,17 +182,9 @@ void KimStyle::do_defn(int narg, char **arg) int ifix = modify->find_fix("KIM_MODEL_STORE"); if (ifix >= 0) { FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; - if (strcmp(model,"NULL") == 0) - model = (char *)fix_store->getptr("model_name"); - else if (strcmp(model,(const char*)fix_store->getptr("model_name")) != 0) - error->all(FLERR,"Inconsistent KIM model name"); - + model = (char *)fix_store->getptr("model_name"); simulatorModel = (KIM::SimulatorModel *)fix_store->getptr("simulator_model"); - } else { - - kimerror = KIM::SimulatorModel::Create(model,&simulatorModel); - if (kimerror) simulatorModel = NULL; - } + } else error->all(FLERR,"Must use 'kim_style init' before 'kim_style define'"); if (simulatorModel) { @@ -219,7 +211,7 @@ void KimStyle::do_defn(int narg, char **arg) if (*sim_name != "LAMMPS") error->all(FLERR,"Incompatible KIM Simulator Model"); - for (int i = 1; i < narg; i++) + for (int i = 0; i < narg; i++) atom_type_sym_list += std::string(" ") + arg[i]; simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); @@ -268,14 +260,6 @@ void KimStyle::do_defn(int narg, char **arg) if (*sim_value != update->unit_style) error->all(FLERR,"Incompatible units for KIM Simulator Model"); } - - if ((ifix < 0) && ( *sim_field == "model-init")) { - for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); - if (*sim_value != "") - error->all(FLERR,"Must use 'kim_style init' with this model"); - } - } } int sim_model_idx=-1; @@ -294,6 +278,7 @@ void KimStyle::do_defn(int narg, char **arg) error->all(FLERR,"KIM Simulator Model has no Model definition"); simulatorModel->ClearTemplateMap(); + } else { // not a simulator model. issue pair_style and pair_coeff commands. @@ -304,7 +289,7 @@ void KimStyle::do_defn(int narg, char **arg) cmd1 += model; std::string cmd2("pair_coeff * * "); - for (int i=1; i < narg; ++i) { + for (int i=0; i < narg; ++i) { cmd2 += arg[i]; cmd2 += " "; } diff --git a/src/KIM/kim_style.h b/src/KIM/kim_style.h index 588de6e620..eddc22eebc 100644 --- a/src/KIM/kim_style.h +++ b/src/KIM/kim_style.h @@ -83,5 +83,41 @@ class KimStyle : protected Pointers { /* ERROR/WARNING messages: +E: Illegal kim_style command + +Incorrect number or kind of arguments to kim_style + +E: Must use 'kim_style init' command before simulation box is defined + +Self-explanatory + +E: Must use 'kim_style define' command after simulation box is defined + +Self-explanatory + +E: Must use 'kim_style init' command before 'kim_style define' + +Self-explanatory + +E: Incompatible KIM Simulator Model + +The requested KIM Simulator Model was defined for a different MD code +and thus is not compatible with LAMMPS + +E: Species XXX is not supported by this KIM Simulator Model + +The kim_style define command was referencing a species that is not +present in the requested KIM Simulator Model + +E: Incompatible units for KIM Simulator Model + +The selected unit style is not compatible with the requested KIM +Simulator Model + +E: KIM Simulator Model has no Model definition + +There is no model definition (key: model-defn) in the KIM Simulator +Model. Please contact the OpenKIM database maintainers to verify +and potentially correct this. */ -- GitLab From c9fe5810c1c0029e42fa3ef1d1b4d6b0ea0f1c32 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 May 2019 21:52:23 -0400 Subject: [PATCH 032/469] add log outputs for updated kim_style command input examples --- ...og.30Apr2019.kim.VOH.simulator_model.g++.1 | 92 ++++++++++++ ....30Apr2019.kim.ex_si.simulator_model.g++.1 | 132 ++++++++++++++++++ ....30Apr2019.kim.ex_si.simulator_model.g++.4 | 132 ++++++++++++++++++ ...log.30Apr2019.kim.lj.simulator_model.g++.1 | 104 ++++++++++++++ ...log.30Apr2019.kim.lj.simulator_model.g++.4 | 104 ++++++++++++++ 5 files changed, 564 insertions(+) create mode 100644 examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 create mode 100644 examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 create mode 100644 examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 create mode 100644 examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 create mode 100644 examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 diff --git a/examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 b/examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 new file mode 100644 index 0000000000..e9d1f17d76 --- /dev/null +++ b/examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 @@ -0,0 +1,92 @@ +LAMMPS (30 Apr 2019) + using 1 OpenMP thread(s) per MPI task +# REAX potential for VOH system +# ..... + +units real +atom_style charge + +kim_style init Sim_LAMMPS_ReaxFF_ChenowethVanDuinPersson_2008_CHOV__SM_429148913211_000 +units real +atom_style charge +neigh_modify one 4000 + +read_data data.VOH + orthogonal box = (0 0 0) to (25 25 25) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 100 atoms + read_data CPU = 0.000217199 secs + +kim_style define H C O V +Using KIM Simulator Model : Sim_LAMMPS_ReaxFF_ChenowethVanDuinPersson_2008_CHOV__SM_429148913211_000 +For Simulator : LAMMPS 28-Feb-2019 +Running on : LAMMPS 30 Apr 2019 +pair_style reax/c /tmp/kim-simulator-model-parameter-file-XXXXXXFRmlac safezone 2.0 mincap 100 +pair_coeff * * /tmp/kim-simulator-model-parameter-file-XXXXXX363kge H C O V +Reading potential file /tmp/kim-simulator-model-parameter-file-XXXXXX363kge with DATE: 2011-02-18 +WARNING: Changed valency_val to valency_boc for X (src/USER-REAXC/reaxc_ffield.cpp:311) +fix reaxqeq all qeq/reax 1 0.0 10.0 1.0e-6 /tmp/kim-simulator-model-parameter-file-XXXXXXzgDl49 + +neighbor 2 bin +neigh_modify every 10 delay 0 check no + +fix 1 all nve +fix 3 all temp/berendsen 500.0 500.0 100.0 + +timestep 0.25 + +#dump 1 all atom 30 dump.reax.voh + +run 300 +Neighbor list info ... + update every 10 steps, delay 0 steps, check no + max neighbors/atom: 4000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair reax/c, perpetual + attributes: half, newton off, ghost + pair build: half/bin/newtoff/ghost + stencil: half/ghost/bin/3d/newtoff + bin: standard + (2) fix qeq/reax, perpetual, copy from (1) + attributes: half, newton off, ghost + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 25.97 | 25.97 | 25.97 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -10246.825 0 -10246.825 42.256089 + 300 199.45773 -10218.342 0 -10159.482 -66.730725 +Loop time of 1.06721 on 1 procs for 300 steps with 100 atoms + +Performance: 6.072 ns/day, 3.953 hours/ns, 281.107 timesteps/s +98.8% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.93954 | 0.93954 | 0.93954 | 0.0 | 88.04 +Neigh | 0.029087 | 0.029087 | 0.029087 | 0.0 | 2.73 +Comm | 0.0018935 | 0.0018935 | 0.0018935 | 0.0 | 0.18 +Output | 1.8358e-05 | 1.8358e-05 | 1.8358e-05 | 0.0 | 0.00 +Modify | 0.096112 | 0.096112 | 0.096112 | 0.0 | 9.01 +Other | | 0.0005522 | | | 0.05 + +Nlocal: 100 ave 100 max 100 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 608 ave 608 max 608 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 3441 ave 3441 max 3441 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 3441 +Ave neighs/atom = 34.41 +Neighbor list builds = 30 +Dangerous builds not checked + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:01 diff --git a/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 b/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 new file mode 100644 index 0000000000..a6d1c4a955 --- /dev/null +++ b/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 @@ -0,0 +1,132 @@ +LAMMPS (30 Apr 2019) + using 1 OpenMP thread(s) per MPI task + +units metal +kim_style init ex_sim_model_Si_mod_tersoff +units metal +newton on + +atom_style atomic +atom_modify map array +boundary p p p + +# temperatures +variable tlo equal 1800.0 +variable thi equal 2400.0 + +# coordination number cutoff + +variable r equal 2.835 + +# minimization parameters + +variable etol equal 1.0e-5 +variable ftol equal 1.0e-5 +variable maxiter equal 100 +variable maxeval equal 100 +variable dmax equal 1.0e-1 + +# diamond unit cell + +variable a equal 5.431 +lattice custom $a a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 +lattice custom 5.431 a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 +Lattice spacing in x,y,z = 5.431 5.431 5.431 + +region myreg block 0 4 0 4 0 4 +create_box 1 myreg +Created orthogonal box = (0 0 0) to (21.724 21.724 21.724) + 1 by 1 by 1 MPI processor grid +create_atoms 1 region myreg +Created 512 atoms + create_atoms CPU = 0.000393867 secs + +mass 1 28.06 + +group Si type 1 +512 atoms in group Si + +velocity all create ${thi} 5287286 mom yes rot yes dist gaussian +velocity all create 2400 5287286 mom yes rot yes dist gaussian + +# make a vacancy + +group del id 300 +1 atoms in group del +delete_atoms group del +Deleted 1 atoms, new total = 511 +kim_style define Si +Using KIM Simulator Model : ex_sim_model_Si_mod_tersoff +For Simulator : LAMMPS 12-Dec-2018 +Running on : LAMMPS 30 Apr 2019 +pair_style tersoff/mod +pair_coeff * * /tmp/kim-simulator-model-parameter-file-XXXXXXVWG8uV Si +Reading potential file /tmp/kim-simulator-model-parameter-file-XXXXXXVWG8uV with DATE: 2013-07-26 + +thermo 10 + +fix 1 all nve +fix 2 all langevin ${thi} ${thi} 0.1 48278 +fix 2 all langevin 2400 ${thi} 0.1 48278 +fix 2 all langevin 2400 2400 0.1 48278 + +timestep 1.0e-3 +neighbor 1.0 bin +neigh_modify every 1 delay 10 check yes + +run 100 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.3 + ghost atom cutoff = 4.3 + binsize = 2.15, bins = 11 11 11 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair tersoff/mod, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.11 | 3.11 | 3.11 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 2397.3877 -2363.0694 0 -2205.0272 15086.224 + 10 1328.4035 -2289.1682 0 -2201.5963 29164.666 + 20 1086.1557 -2254.4447 0 -2182.8424 31906.878 + 30 1528.8439 -2270.2968 0 -2169.5113 21610.528 + 40 1345.227 -2250.3915 0 -2161.7105 22146.886 + 50 1300.3329 -2235.8593 0 -2150.1379 23557.875 + 60 1546.1664 -2241.3019 0 -2139.3744 21648.774 + 70 1662.2896 -2236.2369 0 -2126.6543 23958.738 + 80 1631.7284 -2223.45 0 -2115.8821 28842.194 + 90 1795.3629 -2225.2998 0 -2106.9447 29522.37 + 100 1830.156 -2224.3733 0 -2103.7245 28805.09 +Loop time of 0.201725 on 1 procs for 100 steps with 511 atoms + +Performance: 42.831 ns/day, 0.560 hours/ns, 495.724 timesteps/s +99.3% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.19292 | 0.19292 | 0.19292 | 0.0 | 95.63 +Neigh | 0.0037313 | 0.0037313 | 0.0037313 | 0.0 | 1.85 +Comm | 0.00074744 | 0.00074744 | 0.00074744 | 0.0 | 0.37 +Output | 0.00026727 | 0.00026727 | 0.00026727 | 0.0 | 0.13 +Modify | 0.0036564 | 0.0036564 | 0.0036564 | 0.0 | 1.81 +Other | | 0.0004075 | | | 0.20 + +Nlocal: 511 ave 511 max 511 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 970 ave 970 max 970 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 9174 ave 9174 max 9174 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 9174 +Ave neighs/atom = 17.953 +Neighbor list builds = 4 +Dangerous builds = 0 + +Total wall time: 0:00:00 diff --git a/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 b/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 new file mode 100644 index 0000000000..dcb170aeb6 --- /dev/null +++ b/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 @@ -0,0 +1,132 @@ +LAMMPS (30 Apr 2019) + using 1 OpenMP thread(s) per MPI task + +units metal +kim_style init ex_sim_model_Si_mod_tersoff +units metal +newton on + +atom_style atomic +atom_modify map array +boundary p p p + +# temperatures +variable tlo equal 1800.0 +variable thi equal 2400.0 + +# coordination number cutoff + +variable r equal 2.835 + +# minimization parameters + +variable etol equal 1.0e-5 +variable ftol equal 1.0e-5 +variable maxiter equal 100 +variable maxeval equal 100 +variable dmax equal 1.0e-1 + +# diamond unit cell + +variable a equal 5.431 +lattice custom $a a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 +lattice custom 5.431 a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 +Lattice spacing in x,y,z = 5.431 5.431 5.431 + +region myreg block 0 4 0 4 0 4 +create_box 1 myreg +Created orthogonal box = (0 0 0) to (21.724 21.724 21.724) + 1 by 2 by 2 MPI processor grid +create_atoms 1 region myreg +Created 512 atoms + create_atoms CPU = 0.102434 secs + +mass 1 28.06 + +group Si type 1 +512 atoms in group Si + +velocity all create ${thi} 5287286 mom yes rot yes dist gaussian +velocity all create 2400 5287286 mom yes rot yes dist gaussian + +# make a vacancy + +group del id 300 +1 atoms in group del +delete_atoms group del +Deleted 1 atoms, new total = 511 +kim_style define Si +Using KIM Simulator Model : ex_sim_model_Si_mod_tersoff +For Simulator : LAMMPS 12-Dec-2018 +Running on : LAMMPS 30 Apr 2019 +pair_style tersoff/mod +pair_coeff * * /tmp/kim-simulator-model-parameter-file-XXXXXXqDlERL Si +Reading potential file /tmp/kim-simulator-model-parameter-file-XXXXXXqDlERL with DATE: 2013-07-26 + +thermo 10 + +fix 1 all nve +fix 2 all langevin ${thi} ${thi} 0.1 48278 +fix 2 all langevin 2400 ${thi} 0.1 48278 +fix 2 all langevin 2400 2400 0.1 48278 + +timestep 1.0e-3 +neighbor 1.0 bin +neigh_modify every 1 delay 10 check yes + +run 100 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.3 + ghost atom cutoff = 4.3 + binsize = 2.15, bins = 11 11 11 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair tersoff/mod, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.082 | 3.082 | 3.082 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 2397.5824 -2363.0694 0 -2205.0143 15087.562 + 10 1298.5003 -2292.5456 0 -2206.945 28361.893 + 20 1114.7065 -2260.7006 0 -2187.2161 30574.077 + 30 1504.9472 -2271.8639 0 -2172.6537 20395.651 + 40 1357.5949 -2248.6066 0 -2159.1103 21779.773 + 50 1351.7212 -2235.0803 0 -2145.9713 23404.844 + 60 1582.4191 -2238.3233 0 -2134.006 21711.26 + 70 1654.3988 -2230.0965 0 -2121.0341 24276.504 + 80 1654.9629 -2218.6654 0 -2109.5658 27571.472 + 90 1815.7206 -2219.2065 0 -2099.5093 28475.757 + 100 1901.1544 -2216.5428 0 -2091.2137 28962.04 +Loop time of 4.36959 on 4 procs for 100 steps with 511 atoms + +Performance: 1.977 ns/day, 12.138 hours/ns, 22.885 timesteps/s +47.8% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.051784 | 0.056551 | 0.064825 | 2.1 | 1.29 +Neigh | 0.00093389 | 0.001028 | 0.0011392 | 0.3 | 0.02 +Comm | 2.8964 | 2.9342 | 3.016 | 2.8 | 67.15 +Output | 0.673 | 0.68159 | 0.69707 | 1.1 | 15.60 +Modify | 0.0011303 | 0.0029655 | 0.0081694 | 5.5 | 0.07 +Other | | 0.6933 | | | 15.87 + +Nlocal: 127.75 ave 134 max 123 min +Histogram: 1 0 0 2 0 0 0 0 0 1 +Nghost: 495 ave 498 max 489 min +Histogram: 1 0 0 0 0 0 0 1 1 1 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 2302 ave 2443 max 2194 min +Histogram: 1 0 0 2 0 0 0 0 0 1 + +Total # of neighbors = 9208 +Ave neighs/atom = 18.0196 +Neighbor list builds = 4 +Dangerous builds = 0 + +Total wall time: 0:00:05 diff --git a/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 b/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 new file mode 100644 index 0000000000..94aaf1aaef --- /dev/null +++ b/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 @@ -0,0 +1,104 @@ +LAMMPS (30 Apr 2019) + using 1 OpenMP thread(s) per MPI task +# 3d Lennard-Jones melt +# +# This example requires that the example models provided with +# the kim-api package are installed. see the ./lib/kim/README or +# ./lib/kim/Install.py files for details on how to install these +# example models. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +units metal +atom_style atomic +newton on + +kim_style init LennardJones_Ar + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.00314307 secs + +#pair_style lj/cut 8.1500 +#pair_coeff 1 1 0.0104 3.4000 + +kim_style define Ar +pair_style kim LennardJones_Ar +WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:980) +WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:985) +pair_coeff * * Ar + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.45 + ghost atom cutoff = 8.45 + binsize = 4.225, bins = 21 21 21 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 8.45 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 28.12 | 28.12 | 28.12 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 6290.8194 0 7118.0584 129712.25 + 100 95.179725 6718.814 0 7112.496 133346.59 +Loop time of 4.91804 on 1 procs for 100 steps with 32000 atoms + +Performance: 1.757 ns/day, 13.661 hours/ns, 20.333 timesteps/s +99.7% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 4.3033 | 4.3033 | 4.3033 | 0.0 | 87.50 +Neigh | 0.53176 | 0.53176 | 0.53176 | 0.0 | 10.81 +Comm | 0.024606 | 0.024606 | 0.024606 | 0.0 | 0.50 +Output | 0.00016403 | 0.00016403 | 0.00016403 | 0.0 | 0.00 +Modify | 0.038671 | 0.038671 | 0.038671 | 0.0 | 0.79 +Other | | 0.01951 | | | 0.40 + +Nlocal: 32000 ave 32000 max 32000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 19911 ave 19911 max 19911 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 4.25375e+06 ave 4.25375e+06 max 4.25375e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 4253750 +Ave neighs/atom = 132.93 +Neighbor list builds = 3 +Dangerous builds = 0 +Total wall time: 0:00:05 diff --git a/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 b/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 new file mode 100644 index 0000000000..3377f22d02 --- /dev/null +++ b/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 @@ -0,0 +1,104 @@ +LAMMPS (30 Apr 2019) + using 1 OpenMP thread(s) per MPI task +# 3d Lennard-Jones melt +# +# This example requires that the example models provided with +# the kim-api package are installed. see the ./lib/kim/README or +# ./lib/kim/Install.py files for details on how to install these +# example models. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +units metal +atom_style atomic +newton on + +kim_style init LennardJones_Ar + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.0979962 secs + +#pair_style lj/cut 8.1500 +#pair_coeff 1 1 0.0104 3.4000 + +kim_style define Ar +pair_style kim LennardJones_Ar +WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:980) +WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:985) +pair_coeff * * Ar + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.45 + ghost atom cutoff = 8.45 + binsize = 4.225, bins = 21 21 21 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 8.45 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 9.789 | 9.789 | 9.789 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 6290.8194 0 7118.0584 129712.25 + 100 95.179725 6718.814 0 7112.496 133346.59 +Loop time of 6.29539 on 4 procs for 100 steps with 32000 atoms + +Performance: 1.372 ns/day, 17.487 hours/ns, 15.885 timesteps/s +48.4% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.9399 | 2.079 | 2.2181 | 9.1 | 33.02 +Neigh | 0.25924 | 0.26632 | 0.2692 | 0.8 | 4.23 +Comm | 2.5011 | 2.6605 | 2.751 | 5.9 | 42.26 +Output | 0.069904 | 0.07097 | 0.071545 | 0.3 | 1.13 +Modify | 0.011383 | 0.012206 | 0.01419 | 1.0 | 0.19 +Other | | 1.206 | | | 19.16 + +Nlocal: 8000 ave 8018 max 7967 min +Histogram: 1 0 0 0 0 0 1 0 0 2 +Nghost: 9131 ave 9164 max 9113 min +Histogram: 2 0 0 1 0 0 0 0 0 1 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 1.06344e+06 ave 1.06594e+06 max 1.05881e+06 min +Histogram: 1 0 0 0 0 0 1 0 0 2 + +Total # of neighbors = 4253750 +Ave neighs/atom = 132.93 +Neighbor list builds = 3 +Dangerous builds = 0 +Total wall time: 0:00:07 -- GitLab From df1308ad922c4fd47bcd90bb5253540902ac2aff Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 May 2019 21:58:18 -0400 Subject: [PATCH 033/469] add kim_style error messages to Errors_messages.txt doc file --- doc/src/Errors_messages.txt | 33 +++++++++++++++++++++++++++++++++ src/KIM/kim_style.h | 14 +++++++------- 2 files changed, 40 insertions(+), 7 deletions(-) diff --git a/doc/src/Errors_messages.txt b/doc/src/Errors_messages.txt index fb5003e602..7f6e80948c 100644 --- a/doc/src/Errors_messages.txt +++ b/doc/src/Errors_messages.txt @@ -5729,6 +5729,16 @@ definitions. :dd The data file header lists improper but no improper types. :dd +{Incompatible KIM Simulator Model} :dt + +The requested KIM Simulator Model was defined for a different MD code +and thus is not compatible with LAMMPS. :dd + +{Incompatible units for KIM Simulator Model} :dt + +The selected unit style is not compatible with the requested KIM +Simulator Model. :dd + {Incomplete use of variables in create_atoms command} :dt The var and set options must be used together. :dd @@ -6988,6 +6998,12 @@ The atom style defined does not have this attribute. :dd The atom style defined does not have these attributes. :dd +{KIM Simulator Model has no Model definition} :dt + +There is no model definition (key: model-defn) in the KIM Simulator +Model. Please contact the OpenKIM database maintainers to verify +and potentially correct this. :dd + {KOKKOS package does not yet support comm_style tiled} :dt Self-explanatory. :dd @@ -7475,6 +7491,18 @@ Self-explanatory. :dd Self-explanatory. :dd +{Must use 'kim_style init' command before simulation box is defined} :dt + +Self-explanatory. :dd + +{Must use 'kim_style define' command after simulation box is defined} :dt + +Self-explanatory. :dd + +{Must use 'kim_style init' command before 'kim_style define'} :dt + +Self-explanatory. :dd + {Must use 'kspace_modify pressure/scalar no' for rRESPA with kspace_style MSM} :dt The kspace scalar pressure option cannot (yet) be used with rRESPA. :dd @@ -9418,6 +9446,11 @@ See the "read_data extra/special/per/atom" command for info on how to leave space in the special bonds list to allow for additional bonds to be formed. :dd +{Species XXX is not supported by this KIM Simulator Model} :dt + +The kim_style define command was referencing a species that is not +present in the requested KIM Simulator Model. :dd + {Specified processors != physical processors} :dt The 3d grid of processors defined by the processors command does not diff --git a/src/KIM/kim_style.h b/src/KIM/kim_style.h index eddc22eebc..f8c0602beb 100644 --- a/src/KIM/kim_style.h +++ b/src/KIM/kim_style.h @@ -85,34 +85,34 @@ class KimStyle : protected Pointers { E: Illegal kim_style command -Incorrect number or kind of arguments to kim_style +Incorrect number or kind of arguments to kim_style. E: Must use 'kim_style init' command before simulation box is defined -Self-explanatory +Self-explanatory. E: Must use 'kim_style define' command after simulation box is defined -Self-explanatory +Self-explanatory. E: Must use 'kim_style init' command before 'kim_style define' -Self-explanatory +Self-explanatory. E: Incompatible KIM Simulator Model The requested KIM Simulator Model was defined for a different MD code -and thus is not compatible with LAMMPS +and thus is not compatible with LAMMPS. E: Species XXX is not supported by this KIM Simulator Model The kim_style define command was referencing a species that is not -present in the requested KIM Simulator Model +present in the requested KIM Simulator Model. E: Incompatible units for KIM Simulator Model The selected unit style is not compatible with the requested KIM -Simulator Model +Simulator Model. E: KIM Simulator Model has no Model definition -- GitLab From edecd2b7601f900e99b6eaeb9c3acb25dfe35edc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 May 2019 22:19:47 -0400 Subject: [PATCH 034/469] fix typo and update list of false positives for updated docs --- doc/src/kim_style.txt | 2 +- doc/utils/sphinx-config/false_positives.txt | 2 ++ 2 files changed, 3 insertions(+), 1 deletion(-) diff --git a/doc/src/kim_style.txt b/doc/src/kim_style.txt index dcdfae1cdc..afa7a19fab 100644 --- a/doc/src/kim_style.txt +++ b/doc/src/kim_style.txt @@ -51,7 +51,7 @@ The {kim_style define} command will issue commands that will realize the selected model (through generating pair_style and pair_coeff commands, but also other commands, as required). It has to be issued [after] the the simulation box is defined. The {kim_style define} command allows a -varying numbver of additional arguments. Those are used to map the atom +varying number of additional arguments. Those are used to map the atom types in LAMMPS to the available species in the KIM model. This is equivalent to the arguments following "pair_coeff * *" in a "kim"_pair_kim.html pair style. Thus the commands: diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 7160800c50..a8bfa8f193 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -521,6 +521,7 @@ decrementing deeppink deepskyblue defgrad +defn deformable del deleteIDs @@ -2792,6 +2793,7 @@ txt typeI typeJ typeN +typeargs Tz Tzou ub -- GitLab From ad8fd4a2a46c004dba1313f9daa7896be8052077 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 10 Jun 2019 16:13:09 -0400 Subject: [PATCH 035/469] Clean up comments --- src/USER-HMA/compute_hma.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/USER-HMA/compute_hma.cpp b/src/USER-HMA/compute_hma.cpp index c0a7901640..ad86577ba1 100644 --- a/src/USER-HMA/compute_hma.cpp +++ b/src/USER-HMA/compute_hma.cpp @@ -119,6 +119,7 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : extvec.push_back(1); } else if (!strcasecmp(arg[iarg], "anharmonic")) { + // the first time we're called, we'll grab lattice pressure and energy returnAnharmonic = -1; } else { @@ -333,9 +334,7 @@ void ComputeHMA::compute_vector() } } -//adding PE for this processor - -//adding the energies of all processors + // compute and sum up properties across processors double fdrTotal; MPI_Allreduce(&fdr,&fdrTotal,1,MPI_DOUBLE,MPI_SUM,world); @@ -383,6 +382,7 @@ void ComputeHMA::compute_vector() } } if (returnAnharmonic == -1) { + // we have our lattice properties returnAnharmonic = 1; } } -- GitLab From 5c9c15025afffecd365bbbf40d5fc9cdc437cd6e Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 10 Jun 2019 16:13:34 -0400 Subject: [PATCH 036/469] Add bits to Packages_details, Packages_user, fix up typos --- doc/src/Packages_details.txt | 20 ++++++++++++++++++++ doc/src/Packages_user.txt | 1 + doc/src/compute_hma.txt | 6 +++--- 3 files changed, 24 insertions(+), 3 deletions(-) diff --git a/doc/src/Packages_details.txt b/doc/src/Packages_details.txt index 0ab1b5e4fd..b5050b8c4b 100644 --- a/doc/src/Packages_details.txt +++ b/doc/src/Packages_details.txt @@ -76,6 +76,7 @@ as contained in the file name. "USER-EFF"_#PKG-USER-EFF, "USER-FEP"_#PKG-USER-FEP, "USER-H5MD"_#PKG-USER-H5MD, +"USER-HMA"_#PKG-USER-HMA, "USER-INTEL"_#PKG-USER-INTEL, "USER-LB"_#PKG-USER-LB, "USER-MANIFOLD"_#PKG-USER-MANIFOLD, @@ -1373,6 +1374,25 @@ lib/h5md/README :line +USER-HMA package :link(PKG-USER-HMA),h4 + +[Contents:] + +Harmonically mapped averaging for efficient calculation of properties of +crystalline solids. The compute hma can specify use of HMA for calculation of +potential energy, pressure and heat capacity. + +[Author:] Apoorva Purohit, Andrew Schultz and David Kofke (University at +Buffalo, NY, USA) + +[Supporting info:] + +examples/USER/hma/README +src/USER-HMA/README +"compute hma"_compute_hma.html :ul + +:line + USER-INTEL package :link(PKG-USER-INTEL),h4 [Contents:] diff --git a/doc/src/Packages_user.txt b/doc/src/Packages_user.txt index 4210f617ef..3ce2a458b6 100644 --- a/doc/src/Packages_user.txt +++ b/doc/src/Packages_user.txt @@ -51,6 +51,7 @@ Package, Description, Doc page, Example, Library "USER-EFF"_Packages_details.html#PKG-USER-EFF, electron force field,"pair_style eff/cut"_pair_eff.html, USER/eff, no "USER-FEP"_Packages_details.html#PKG-USER-FEP, free energy perturbation,"compute fep"_compute_fep.html, USER/fep, no "USER-H5MD"_Packages_details.html#PKG-USER-H5MD, dump output via HDF5,"dump h5md"_dump_h5md.html, n/a, ext +"USER-HMA"_Packages_details.html#PKG-USER-HMA, compute properties via HMA,"compute hma"_compute_hma.html, USER/hma, no "USER-INTEL"_Packages_details.html#PKG-USER-INTEL, optimized Intel CPU and KNL styles,"Speed intel"_Speed_intel.html, "Benchmarks"_http://lammps.sandia.gov/bench.html, no "USER-LB"_Packages_details.html#PKG-USER-LB, Lattice Boltzmann fluid,"fix lb/fluid"_fix_lb_fluid.html, USER/lb, no "USER-MANIFOLD"_Packages_details.html#PKG-USER-MANIFOLD, motion on 2d surfaces,"fix manifoldforce"_fix_manifoldforce.html, USER/manifold, no diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index c4ade07ad7..340881bf68 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -61,7 +61,7 @@ The pressure is computed by the formula: \end\{equation\} where \(\rho\) is the number density of the system, \(\Delta \hat P\) is the -difference between theh harmonic and lattice pressure, and \(P_\{vir\}\) is +difference between the harmonic and lattice pressure, and \(P_\{vir\}\) is the virial pressure computed as the sum of pair, bond, angle, dihedral, improper, kspace (long-range), and fix contributions to the force on each atom. Although the method will work for any value of \(\Delta \hat P\) @@ -76,13 +76,13 @@ U_\{HMA\}^2 \right> - \left^2 \right)/T + \frac\{1\}\{4 T\} \left< F\bullet\Delta r + \Delta r \bullet \Phi \bullet \Delta r \right> \end\{equation\} -where \(\Phi\) is the Hessian of second derivatives. The compute hma command +where \(\Phi\) is the Hessian matrix. The compute hma command computes the full expression for \(C_V\) except for the \(\left^2\) in the variance term, which can be obtained by passing the {u} keyword; you must add this extra contribution to the \(C_V\) value reported by this compute. The variance term can cause significant roundoff error when computing \(C_V\). To address this, the {anharmonic} -keyword can be passed and/or the output format can be speicified with more +keyword can be passed and/or the output format can be specified with more digits. thermo_modify format float '%22.15e' :pre -- GitLab From e438d46ee2c54bdb5cb9927991329f071f5e87c2 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 10 Jun 2019 16:14:28 -0400 Subject: [PATCH 037/469] Add README in src directory --- src/USER-HMA/README | 30 ++++++++++++++++++++++++++++++ 1 file changed, 30 insertions(+) create mode 100644 src/USER-HMA/README diff --git a/src/USER-HMA/README b/src/USER-HMA/README new file mode 100644 index 0000000000..b27999341b --- /dev/null +++ b/src/USER-HMA/README @@ -0,0 +1,30 @@ +The HMA package implements the compute hma command for LAMMPS, which implements +harmonically-mapped averaging for crystalline solids. The current +implementation handles atomic crystals. + +Computing the heat capacity relies on being able to compute the second +derivative of the energy with respect to atom positions. This capability is +provided by the single2 method in Pair, but is currently only implemented for +the shifted-force LJ potential (lj/smooth/linear). Pair::single2 takes a single +pair and (like Pair::single) returns the energy and sets the force as an out +parameter, but also sets the elements of 6-element double array out parameter, +which are the unique components of the atomic Hessian tensor for the pair. A +helper method exists (Pair::pairTensor), which will compute the tensor from +linear derivatives and the vector between the positions. HMA Heat capacity can +be computed for other models by implementing single2 in those Pair classes. + +More information about HMA is available in these publications: + +A. J. Schultz, D. A. Kofke, “Comprehensive high-precision high-accuracy +equation of state and coexistence properties for classical Lennard-Jones +crystals and low-temperature fluid phases”, J. Chem. Phys. 149, 204508 (2018) +https://dx.doi.org/10.1063/1.5053714 + +S. G. Moustafa, A. J. Schultz, D. A. Kofke, “Harmonically Assisted Methods for +Computing the Free Energy of Classical Crystals by Molecular Simulation: A +Comparative Study”, J. Chem. Theory Comput. 13, 825-834 (2017) +https://dx.doi.org/10.1021/acs.jctc.6b01082 + +S. G. Moustafa, A. J. Schultz, D. A. Kofke, “Very fast averaging of thermal +properties of crystals by molecular simulation”, Phys. Rev. E 92, 043303 (2015) +https://dx.doi.org/10.1103/PhysRevE.92.043303 -- GitLab From b195ccfb27e0037e5e6f1836724d8ae042000ce0 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 10 Jun 2019 17:08:40 -0400 Subject: [PATCH 038/469] Unbreak compute.txt --- doc/src/compute.txt | 14 ++++++++++++-- 1 file changed, 12 insertions(+), 2 deletions(-) diff --git a/doc/src/compute.txt b/doc/src/compute.txt index c8456fb342..52ae5df0eb 100644 --- a/doc/src/compute.txt +++ b/doc/src/compute.txt @@ -169,7 +169,7 @@ There are also additional accelerated compute styles included in the LAMMPS distribution for faster performance on CPUs, GPUs, and KNLs. The individual style names on the "Commands compute"_Commands_compute.html doc page are followed by one or more of -(g,i,k,o,t) to indicate which accerlerated styles exist. +(g,i,k,o,t) to indicate which accelerated styles exist. "ackland/atom"_compute_ackland_atom.html - "adf"_compute_adf.html - angular distribution function of triples of atoms @@ -184,6 +184,7 @@ compute"_Commands_compute.html doc page are followed by one or more of "bond/local"_compute_bond_local.html - distance and energy of each bond "centro/atom"_compute_centro_atom.html - centro-symmetry parameter for each atom "chunk/atom"_compute_chunk_atom.html - assign chunk IDs to each atom +"chunk/spread/atom"_compute_chunk_spread_atom.html - spreads chunk values to each atom in chunk "cluster/atom"_compute_cluster_atom.html - cluster ID for each atom "cna/atom"_compute_cna_atom.html - common neighbor analysis (CNA) for each atom "cnp/atom"_compute_cnp_atom.html - @@ -223,6 +224,12 @@ compute"_Commands_compute.html doc page are followed by one or more of "inertia/chunk"_compute_inertia_chunk.html - inertia tensor for each chunk "ke"_compute_ke.html - translational kinetic energy "ke/atom"_compute_ke_atom.html - kinetic energy for each atom +"ke/atom/eff"_compute_ke_atom_eff.html - +"ke/eff"_compute_ke_eff.html - +"ke/rigid"_compute_ke_rigid.html - translational kinetic energy of rigid bodies +"meso/e/atom"_compute_meso_e_atom.html - +"meso/rho/atom"_compute_meso_rho_atom.html - +"meso/t/atom"_compute_meso_t_atom.html - "msd"_compute_msd.html - mean-squared displacement of group of atoms "msd/chunk"_compute_msd_chunk.html - mean-squared displacement for each chunk "msd/nongauss"_compute_msd_nongauss.html - MSD and non-Gaussian parameter of group of atoms @@ -239,10 +246,12 @@ compute"_Commands_compute.html doc page are followed by one or more of "pressure/cylinder"_compute_pressure_cylinder.html - "pressure/uef"_compute_pressure_uef.html - "property/atom"_compute_property_atom.html - convert atom attributes to per-atom vectors/arrays +"property/chunk"_compute_property_chunk.html - extract various per-chunk attributes "property/local"_compute_property_local.html - convert local attributes to localvectors/arrays "ptm/atom"_compute_ptm_atom.html - "rdf"_compute_rdf.html - radial distribution function g(r) histogram of group of atoms "reduce"_compute_reduce.html - combine per-atom quantities into a single global value +"reduce/chunk"_compute_reduce_chunk.html - reduce per-atom quantities within each chunk "reduce/region"_compute_reduce.html - same as compute reduce, within a region "rigid/local"_compute_rigid_local.html - extract rigid body attributes "saed"_compute_saed.html - @@ -299,7 +308,8 @@ compute"_Commands_compute.html doc page are followed by one or more of "torque/chunk"_compute_torque_chunk.html - torque applied on each chunk "vacf"_compute_vacf.html - velocity auto-correlation function of group of atoms "vcm/chunk"_compute_vcm_chunk.html - velocity of center-of-mass for each chunk -"voronoi/atom"_compute_voronoi_atom.html - Voronoi volume and neighbors for each atom :ul +"voronoi/atom"_compute_voronoi_atom.html - Voronoi volume and neighbors for each atom +"xrd"_compute_xrd.html - :ul [Restrictions:] none -- GitLab From 2d90bb994795f1a56fda0a4abb5a784c27a925fa Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 10 Jun 2019 17:12:01 -0400 Subject: [PATCH 039/469] Unbreak computes.txt --- doc/src/computes.txt | 8 +++++++- 1 file changed, 7 insertions(+), 1 deletion(-) diff --git a/doc/src/computes.txt b/doc/src/computes.txt index c636633b38..f3a552b740 100644 --- a/doc/src/computes.txt +++ b/doc/src/computes.txt @@ -6,6 +6,7 @@ Computes :h1 :maxdepth: 1 compute_ackland_atom + compute_adf compute_angle compute_angle_local compute_angmom_chunk @@ -15,6 +16,7 @@ Computes :h1 compute_bond_local compute_centro_atom compute_chunk_atom + compute_chunk_spread_atom compute_cluster_atom compute_cna_atom compute_cnp_atom @@ -67,12 +69,15 @@ Computes :h1 compute_pe_atom compute_plasticity_atom compute_pressure + compute_pressure_cylinder compute_pressure_uef compute_property_atom compute_property_chunk compute_property_local + compute_ptm_atom compute_rdf compute_reduce + compute_reduce_chunk compute_rigid_local compute_saed compute_slice @@ -90,7 +95,7 @@ Computes :h1 compute_smd_tlsph_strain compute_smd_tlsph_strain_rate compute_smd_tlsph_stress - compute_smd_triangle_mesh_vertices + compute_smd_triangle_vertices compute_smd_ulsph_num_neighs compute_smd_ulsph_strain compute_smd_ulsph_strain_rate @@ -99,6 +104,7 @@ Computes :h1 compute_sna_atom compute_spin compute_stress_atom + compute_stress_mop compute_tally compute_tdpd_cc_atom compute_temp -- GitLab From 8858846e399a0086d922bbc5bd7c03cb9262a1ca Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 10 Jun 2019 17:13:16 -0400 Subject: [PATCH 040/469] Unbreak pair.h --- src/pair.h | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/pair.h b/src/pair.h index 7ebf56173c..3947f4cd81 100644 --- a/src/pair.h +++ b/src/pair.h @@ -221,6 +221,10 @@ class Pair : protected Pointers { typedef union {int i; float f;} union_int_float_t; + // Accessor for the user-intel package to determine virial calc for hybrid + + inline int fdotr_is_set() const { return vflag_fdotr; } + protected: int vflag_fdotr; int maxeatom,maxvatom; -- GitLab From 22fd12b56c803e6e0e5939bb0a950adf080c31a9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 10 Jun 2019 17:14:17 -0400 Subject: [PATCH 041/469] support storing unit conversion variable setting between kim_style calls --- src/KIM/fix_store_kim.cpp | 29 ++++++++++++++++++++++++++++- src/KIM/fix_store_kim.h | 2 ++ 2 files changed, 30 insertions(+), 1 deletion(-) diff --git a/src/KIM/fix_store_kim.cpp b/src/KIM/fix_store_kim.cpp index 8e9946c20d..6423a57e18 100644 --- a/src/KIM/fix_store_kim.cpp +++ b/src/KIM/fix_store_kim.cpp @@ -65,7 +65,8 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ FixStoreKIM::FixStoreKIM(LAMMPS *lmp, int narg, char **arg) - : Fix(lmp, narg, arg), simulator_model(NULL), model_name(NULL) + : Fix(lmp, narg, arg), simulator_model(NULL), model_name(NULL), + units_from(NULL), units_to(NULL) { if (narg != 3) error->all(FLERR,"Illegal fix STORE/KIM command"); } @@ -87,6 +88,18 @@ FixStoreKIM::~FixStoreKIM() delete[] mn; model_name = NULL; } + + if (units_from) { + char *uf = (char *)units_from; + delete[] uf; + units_from = NULL; + } + + if (units_to) { + char *ut = (char *)units_to; + delete[] ut; + units_to = NULL; + } } /* ---------------------------------------------------------------------- */ @@ -114,6 +127,18 @@ void FixStoreKIM::setptr(const char *name, void *ptr) delete[] mn; } model_name = ptr; + } else if (strcmp(name,"units_from") == 0) { + if (units_from) { + char *uf = (char *)units_from; + delete[] uf; + } + units_from = ptr; + } else if (strcmp(name,"units_to") == 0) { + if (units_to) { + char *ut = (char *)units_to; + delete[] ut; + } + units_to = ptr; } } @@ -123,5 +148,7 @@ void *FixStoreKIM::getptr(const char *name) { if (strcmp(name,"simulator_model") == 0) return simulator_model; else if (strcmp(name,"model_name") == 0) return model_name; + else if (strcmp(name,"units_from") == 0) return units_from; + else if (strcmp(name,"units_to") == 0) return units_to; else return NULL; } diff --git a/src/KIM/fix_store_kim.h b/src/KIM/fix_store_kim.h index 04081fd6dc..5bca2a3dd0 100644 --- a/src/KIM/fix_store_kim.h +++ b/src/KIM/fix_store_kim.h @@ -80,6 +80,8 @@ class FixStoreKIM : public Fix { private: void *simulator_model; // pointer to KIM simulator model class void *model_name; // string of KIM model name + void *units_from; // string of unit conversion origin or NULL + void *units_to; // string of unit conversion target or NULL }; } -- GitLab From 9a428217d9f9d864e7ff66618645dfab4be04341 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 10 Jun 2019 17:19:18 -0400 Subject: [PATCH 042/469] prototype implementation of unit conversion variable support --- src/KIM/kim_style.cpp | 161 +++++++++++++++++++++++++++++++++++++++++- src/KIM/kim_style.h | 4 ++ 2 files changed, 162 insertions(+), 3 deletions(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index 856fb94c9e..814da6b188 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -65,6 +65,7 @@ #include "update.h" #include "universe.h" #include "input.h" +#include "variable.h" #include "fix_store_kim.h" #include "KIM_SimulatorModel.hpp" @@ -78,20 +79,33 @@ void KimStyle::command(int narg, char **arg) { if (narg < 2) error->all(FLERR,"Illegal kim_style command"); + units_from = NULL; + units_to = NULL; + if (strcmp(arg[0],"init") == 0) { - if (narg > 2) error->all(FLERR,"Illegal kim_style command"); if (domain->box_exist) error->all(FLERR,"Must use 'kim_style init' command before " "simulation box is defined"); int len = strlen(arg[1])+1; char *model = new char[len]; strcpy(model,arg[1]); + + int args_done = do_units(narg-2,arg-2); + if (narg > (args_done + 2)) + error->all(FLERR,"Illegal kim_style command"); do_init(model); + do_variables(); } else if (strcmp(arg[0],"define") == 0) { if (!domain->box_exist) error->all(FLERR,"Must use 'kim_style define' command after " "simulation box is defined"); - do_defn(narg-1,arg+1); + int args_done = do_units(narg-1,arg-1); + do_defn(narg - (args_done+1),arg + (args_done+1)); + } else if (strcmp(arg[0],"unit_variables") == 0) { + int args_done = do_units(narg,arg); + if (narg > args_done) + error->all(FLERR,"Illegal kim_style command"); + do_variables(); } else error->all(FLERR,"Illegal kim_style command"); } @@ -113,6 +127,8 @@ void KimStyle::do_init(char *model) FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; fix_store->setptr("model_name", (void *) model); + fix_store->setptr("units_from", (void *) units_from); + fix_store->setptr("units_to", (void *) units_to); int kimerror; KIM::SimulatorModel * simulatorModel; @@ -172,7 +188,6 @@ void KimStyle::do_defn(int narg, char **arg) char *model = NULL; KIM::SimulatorModel *simulatorModel(NULL); - int kimerror; // check if we had a kim_style init command by finding fix STORE/KIM // retrieve model name and pointer to simulator model class instance. @@ -298,3 +313,143 @@ void KimStyle::do_defn(int narg, char **arg) input->one(cmd2.c_str()); } } + +/* ---------------------------------------------------------------------- */ + +int KimStyle::do_units(int narg, char **arg) +{ + // retrieve custom units setting if kim_style had been called before + + int ifix = modify->find_fix("KIM_MODEL_STORE"); + FixStoreKIM *fix_store = NULL; + if (ifix >= 0) { + fix_store = (FixStoreKIM *) modify->fix[ifix]; + units_from = (char *)fix_store->getptr("units_from"); + units_to = (char *)fix_store->getptr("units_to"); + } + + if (narg < 2) return 0; + int iarg=0; + for (iarg = 0; iarg < narg; iarg += 2) { + if (strcmp(arg[iarg],"unit_variables") == 0) { + if (narg > iarg+2) error->all(FLERR,"Illegal kim_style command"); + if (strcmp(arg[iarg+1],"NULL") == 0) { + delete[] units_to; + units_to = NULL; + } else { + int len = strlen(arg[iarg+1])+1; + delete[] units_to; + units_to = new char[len]; + strcpy(units_to,arg[iarg+1]); + } + if (fix_store) fix_store->setptr("units_to",units_to); + } else if (strcmp(arg[iarg],"unit_from") == 0) { + if (narg > iarg+2) error->all(FLERR,"Illegal kim_style command"); + if (strcmp(arg[iarg+1],"NULL") == 0) { + delete[] units_from; + units_from = NULL; + } else { + int len = strlen(arg[iarg+1])+1; + delete[] units_from; + units_from = new char[len]; + strcpy(units_from,arg[iarg+1]); + } + if (fix_store) fix_store->setptr("units_from",units_from); + } else return iarg; + } + return iarg; +} + +/* ---------------------------------------------------------------------- */ + +void KimStyle::do_variables() +{ + char *from, *to; + Variable *variable = input->variable; + + if (units_from) from = units_from; + else from = update->unit_style; + if (units_to) to = units_to; + else to = update->unit_style; + + // refuse convertion from or to reduced units + + if ((strcmp(from,"lj") == 0) || (strcmp(to,"lj") == 0)) + error->all(FLERR,"Cannot set up conversion variables for 'lj' units"); + + // get index to internal style variables. create, if needed. + // default to conversion factor 1.0 for newly created variables + + int v_length, v_mass, v_time; + char *args[3]; + args[1] = (char *)"internal"; + args[2] = (char *)"1.0"; + + args[0] = (char *)"_u_length"; + v_length = variable->find(args[0]); + if (v_length < 0) { + variable->set(3,args); + v_length = variable->find(args[0]); + } + + args[0] = (char *)"_u_mass"; + v_mass = variable->find(args[0]); + if (v_mass < 0) { + variable->set(3,args); + v_mass = variable->find(args[0]); + } + + args[0] = (char *)"_u_time"; + v_time = variable->find(args[0]); + if (v_time < 0) { + variable->set(3,args); + v_time = variable->find(args[0]); + } + + // special case: both unit styles are the same => conversion factor 1.0 + + if (strcmp(from,to) == 0) { + variable->internal_set(v_length,1.0); + variable->internal_set(v_mass,1.0); + variable->internal_set(v_time,1.0); + return; + } + + if (strcmp(from,"real") == 0) { + if (strcmp(to,"metal") == 0) { + variable->internal_set(v_length,1.0); + variable->internal_set(v_mass,1.0); + variable->internal_set(v_time,0.001); + } else { + std::string err("Do not know how to set up conversion variables "); + err += "between '"; + err += from; + err += "' and '"; + err += to; + err += "' units"; + error->all(FLERR,err.c_str()); + } + } else if (strcmp(from,"metal") == 0) { + if (strcmp(to,"real") == 0) { + variable->internal_set(v_length,1.0); + variable->internal_set(v_mass,1.0); + variable->internal_set(v_time,1000.0); + } else { + std::string err("Do not know how to set up conversion variables "); + err += "between '"; + err += from; + err += "' and '"; + err += to; + err += "' units"; + error->all(FLERR,err.c_str()); + } + } else { + std::string err("Do not know how to set up conversion variables "); + err += "between '"; + err += from; + err += "' and '"; + err += to; + err += "' units"; + error->all(FLERR,err.c_str()); + } +} diff --git a/src/KIM/kim_style.h b/src/KIM/kim_style.h index f8c0602beb..36084183ee 100644 --- a/src/KIM/kim_style.h +++ b/src/KIM/kim_style.h @@ -72,8 +72,12 @@ class KimStyle : protected Pointers { KimStyle(class LAMMPS *lmp) : Pointers(lmp) {}; void command(int, char **); private: + char *units_from; + char *units_to; void do_init(char *); void do_defn(int, char **); + int do_units(int, char **); + void do_variables(); }; } -- GitLab From 664b938ed12cafc2fa232a34abccd4d79278a494 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 10 Jun 2019 17:45:07 -0400 Subject: [PATCH 043/469] document kim_style changes --- doc/src/kim_style.txt | 26 ++++++++++++++++++++++---- 1 file changed, 22 insertions(+), 4 deletions(-) diff --git a/doc/src/kim_style.txt b/doc/src/kim_style.txt index afa7a19fab..c24cfe8581 100644 --- a/doc/src/kim_style.txt +++ b/doc/src/kim_style.txt @@ -12,15 +12,18 @@ kim_style command :h3 kim_style mode args :pre -mode = {init model} or {define typeargs} +mode = {init model} or {define typeargs} or no mode chosen model = name of the KIM model (KIM potential or KIM simulator model) -typeargs = atom type to species mapping (one entry per atom type) :ul +typeargs = atom type to species mapping (one entry per atom type) +args = {unit_variables unit_style} or {unit_from unit_style} (optional):ul [Examples:] -kim_style init ex_sim_model_Si_mod_tersoff +kim_style init ex_sim_model_Si_mod_tersoff unit_variables metal kim_style define Si Si -kim_style init LennardJones_Ar +kim_style unit_variables real +kim_style init LennardJones_Ar unit_variables metal +kim_style unit_variables real unit_from metal kim_style define Ar :pre [Description:] @@ -47,6 +50,21 @@ for using a selected simulator model. If needed, those settings can be overridden. The second argument to the {kim_style init} command is the KIM model ID. +In both modes, the keywords {unit_variables} and {unit_from} may be +added. They control the values of a set of +"internal style variables"_variable.html that can be used to convert +between different unit styles in LAMMPS. The argument to +each keyword is a LAMMPS unit style or NULL, which means to look up +the unit style from what was set with the "units"_units.html command. +Please note, that KIM simulator models will set their preferred unit style. +By default all conversion variables are set to 1.0. Converting to or +from the "lj" unit style is not supported. The following variables are defined: + +_u_length +_u_mass +_u_time :ul + + The {kim_style define} command will issue commands that will realize the selected model (through generating pair_style and pair_coeff commands, but also other commands, as required). It has to be issued [after] the -- GitLab From 36ebf4d47ab3c6e6263bcdde2a7402089b04e524 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Tue, 11 Jun 2019 10:22:55 -0400 Subject: [PATCH 044/469] Make cmake aware of HMA --- cmake/CMakeLists.txt | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 911b6f0f15..c2356002b2 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -177,8 +177,8 @@ set(DEFAULT_PACKAGES ASPHERE BODY CLASS2 COLLOID COMPRESS CORESHELL DIPOLE GRANULAR KSPACE LATTE MANYBODY MC MESSAGE MISC MOLECULE PERI POEMS QEQ REPLICA RIGID SHOCK SPIN SNAP SRD KIM PYTHON MSCG MPIIO VORONOI USER-ATC USER-AWPMD USER-BOCS USER-CGDNA USER-MESO USER-CGSDK USER-COLVARS - USER-DIFFRACTION USER-DPD USER-DRUDE USER-EFF USER-FEP USER-H5MD USER-LB - USER-MANIFOLD USER-MEAMC USER-MGPT USER-MISC USER-MOFFF USER-MOLFILE + USER-DIFFRACTION USER-DPD USER-DRUDE USER-EFF USER-FEP USER-H5MD USER-HMA + USER-LB USER-MANIFOLD USER-MEAMC USER-MGPT USER-MISC USER-MOFFF USER-MOLFILE USER-NETCDF USER-PHONON USER-PLUMED USER-PTM USER-QTB USER-REAXC USER-SCAFACOS USER-SDPD USER-SMD USER-SMTBQ USER-SPH USER-TALLY USER-UEF USER-VTK USER-QUIP USER-QMMM USER-YAFF USER-ADIOS) -- GitLab From d9206127fb3bc2309d9260e06644d1025f7545a1 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 12 Jun 2019 11:40:21 -0400 Subject: [PATCH 045/469] Add hyphen to roundoff, fix false positives --- doc/src/compute_hma.txt | 2 +- doc/utils/sphinx-config/false_positives.txt | 6 ++++++ 2 files changed, 7 insertions(+), 1 deletion(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index 340881bf68..c203c281ed 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -81,7 +81,7 @@ computes the full expression for \(C_V\) except for the \(\left^2\) in the variance term, which can be obtained by passing the {u} keyword; you must add this extra contribution to the \(C_V\) value reported by this compute. The variance term can cause significant -roundoff error when computing \(C_V\). To address this, the {anharmonic} +round-off error when computing \(C_V\). To address this, the {anharmonic} keyword can be passed and/or the output format can be specified with more digits. diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 7b7c4d11b2..4d3ea22491 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -98,6 +98,7 @@ antisymmetry anton Antonelli api +Apoorva Appl Apu arccos @@ -1064,6 +1065,7 @@ Hilger histo histogrammed histogramming +hma hmaktulga hoc Hochbruck @@ -1320,6 +1322,7 @@ kmax Kmax Knizhnik knl +Kofke Kohlmeyer Kohn kokkos @@ -1701,6 +1704,7 @@ Morteza Mosayebi Moseler Moskalev +Moustafa mov mpi MPI @@ -2200,6 +2204,7 @@ PTM ptr pu purdue +Purohit pushstore pvar pw @@ -2413,6 +2418,7 @@ Ryckaert Rycroft Rydbergs Rz +Sabry saddlebrown Sadigh saed -- GitLab From 56ae35fb1a4e23aff8238c7baccd747667f3a962 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 12 Jun 2019 13:09:33 -0400 Subject: [PATCH 046/469] Address feedback on PR #1503 --- src/USER-HMA/compute_hma.cpp | 47 ++++++++++++++++++----------------- src/pair.cpp | 2 +- src/pair_lj_smooth_linear.cpp | 4 +-- 3 files changed, 27 insertions(+), 26 deletions(-) diff --git a/src/USER-HMA/compute_hma.cpp b/src/USER-HMA/compute_hma.cpp index ad86577ba1..8edff5aa59 100644 --- a/src/USER-HMA/compute_hma.cpp +++ b/src/USER-HMA/compute_hma.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include +#include #include -#include -#include #include "compute_hma.h" #include "atom.h" #include "update.h" @@ -100,25 +100,29 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : computeU = computeP = computeCv = -1; returnAnharmonic = 0; - std::vector extvec; + size_vector = 0; + memory->create(extlist, 3, "hma:extlist"); for (int iarg=4; iarg-1) continue; + computeU = size_vector; + extlist[size_vector] = 1; } - else if (!strcasecmp(arg[iarg], "p")) { + else if (!strcmp(arg[iarg], "p")) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix hma command"); - computeP = extvec.size(); + if (computeP>-1) continue; + computeP = size_vector; deltaPcap = force->numeric(FLERR, arg[iarg+1]); - extvec.push_back(0); + extlist[size_vector] = 0; iarg++; } - else if (!strcasecmp(arg[iarg], "cv")) { - computeCv = extvec.size(); + else if (!strcmp(arg[iarg], "cv")) { + if (computeCv>-1) continue; + computeCv = size_vector; comm_forward = 3; - extvec.push_back(1); + extlist[size_vector] = 1; } - else if (!strcasecmp(arg[iarg], "anharmonic")) { + else if (!strcmp(arg[iarg], "anharmonic")) { // the first time we're called, we'll grab lattice pressure and energy returnAnharmonic = -1; } @@ -127,18 +131,16 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : } } - if (extvec.size() == 0) { + if (size_vector == 0) { error->all(FLERR,"Illegal fix hma command"); } - size_vector = extvec.size(); - memory->create(vector, size_vector, "hma::vector"); - extlist = new int[size_vector]; - for (int i=0; igrow(extlist, size_vector, "hma:extlist"); } + memory->create(vector, size_vector, "hma:vector"); if (computeU>-1 || computeCv>-1) { - peflag = 1; + peflag = 1; } if (computeP>-1) { pressflag = 1; @@ -156,7 +158,7 @@ ComputeHMA::~ComputeHMA() delete [] id_fix; delete [] id_temp; - delete [] extlist; + memory->destroy(extlist); memory->destroy(vector); memory->destroy(deltaR); } @@ -184,11 +186,10 @@ void ComputeHMA::setup() if (temperat==NULL) error->all(FLERR,"Could not find compute hma temperature ID"); finaltemp = * temperat; - // set fix which stores original atom coords int ifix2 = modify->find_fix(id_fix); - if (ifix2 < 0) error->all(FLERR,"Could not find compute hma ID"); + if (ifix2 < 0) error->all(FLERR,"Could not find hma store fix ID"); fix = (FixStore *) modify->fix[ifix2]; } diff --git a/src/pair.cpp b/src/pair.cpp index c393e7b12b..15efa62c59 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -307,7 +307,7 @@ void Pair::init_style() specific pair style can override this function ------------------------------------------------------------------------- */ -void Pair::init_list(int which, NeighList *ptr) +void Pair::init_list(int /*which*/, NeighList *ptr) { list = ptr; } diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 370caeddf7..d2bb6a1cc4 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -325,7 +325,7 @@ void PairLJSmoothLinear::read_restart_settings(FILE *fp) /* ---------------------------------------------------------------------- */ -double PairLJSmoothLinear::single(int i, int j, int itype, int jtype, +double PairLJSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq, double factor_coul, double factor_lj, double &fforce) @@ -347,7 +347,7 @@ double PairLJSmoothLinear::single(int i, int j, int itype, int jtype, return factor_lj*philj; } -double PairLJSmoothLinear::single2(int i, int j, int itype, int jtype, double rsq, +double PairLJSmoothLinear::single2(int /*i*/, int /*j*/, int itype, int jtype, double rsq, double delr[3], double factor_coul, double factor_lj, double &fforce, double d2u[6]) { -- GitLab From 053ac654c31f33c97a3648fc2ef0864acff84de2 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 12 Jun 2019 20:32:22 -0400 Subject: [PATCH 047/469] Install.sh not needed --- src/USER-HMA/Install.sh | 31 ------------------------------- 1 file changed, 31 deletions(-) delete mode 100644 src/USER-HMA/Install.sh diff --git a/src/USER-HMA/Install.sh b/src/USER-HMA/Install.sh deleted file mode 100644 index 1f8f418ca2..0000000000 --- a/src/USER-HMA/Install.sh +++ /dev/null @@ -1,31 +0,0 @@ -# Install/Uninstall package files in LAMMPS -# mode = 0/1/2 for uninstall/install/update - -mode=$1 - -# enforce using portable C locale -LC_ALL=C -export LC_ALL - -# arg1 = file, arg2 = file it depends on - -action () { - if (test $mode = 0) then - rm -f ../$1 - elif (! cmp -s $1 ../$1) then - if (test -z "$2" || test -e ../$2) then - cp $1 .. - if (test $mode = 2) then - echo " updating src/$1" - fi - fi - elif (test -n "$2") then - if (test ! -e ../$2) then - rm -f ../$1 - fi - fi -} - -# package files without dependencies -action compute_hma.h -action compute_hma.cpp -- GitLab From 7fab12c36f847efddd6d6e6c0d1939c0036be0eb Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Fri, 14 Jun 2019 16:53:26 +0200 Subject: [PATCH 048/469] Add keyword hybridpair for compute_pressure only on a certain pair of a hybrid pair --- src/compute_pressure.cpp | 17 +++++++++++++++++ src/compute_pressure.h | 1 + src/pair_hybrid.h | 1 + 3 files changed, 19 insertions(+) diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index dde02a5aed..8381e04fa8 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -22,6 +22,7 @@ #include "fix.h" #include "force.h" #include "pair.h" +#include "pair_hybrid.h" #include "bond.h" #include "angle.h" #include "dihedral.h" @@ -66,6 +67,7 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : // process optional args + hybridpairflag = 0; if (narg == 4) { keflag = 1; pairflag = 1; @@ -79,6 +81,8 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : int iarg = 4; while (iarg < narg) { if (strcmp(arg[iarg],"ke") == 0) keflag = 1; + else if (strcmp(arg[iarg],"hybridpair") == 0) + hybridpairflag = force->inumeric(FLERR, arg[++iarg]); else if (strcmp(arg[iarg],"pair") == 0) pairflag = 1; else if (strcmp(arg[iarg],"bond") == 0) bondflag = 1; else if (strcmp(arg[iarg],"angle") == 0) angleflag = 1; @@ -140,6 +144,12 @@ void ComputePressure::init() nvirial = 0; vptr = NULL; + if (hybridpairflag > 0 && force->pair) { + if (strstr(force->pair_style, "hybrid")) { + PairHybrid *ph = (PairHybrid *) force->pair; + if (hybridpairflag <= ph->nstyles) nvirial++; + } + } if (pairflag && force->pair) nvirial++; if (bondflag && atom->molecular && force->bond) nvirial++; if (angleflag && atom->molecular && force->angle) nvirial++; @@ -152,6 +162,13 @@ void ComputePressure::init() if (nvirial) { vptr = new double*[nvirial]; nvirial = 0; + if (hybridpairflag > 0 && force->pair) { + if (strstr(force->pair_style, "hybrid")) { + PairHybrid *ph = (PairHybrid *) force->pair; + if (hybridpairflag <= ph->nstyles) + vptr[nvirial++] = ph->styles[hybridpairflag-1]->virial; + } + } if (pairflag && force->pair) vptr[nvirial++] = force->pair->virial; if (bondflag && force->bond) vptr[nvirial++] = force->bond->virial; if (angleflag && force->angle) vptr[nvirial++] = force->angle->virial; diff --git a/src/compute_pressure.h b/src/compute_pressure.h index a59a64e634..3259377bd8 100644 --- a/src/compute_pressure.h +++ b/src/compute_pressure.h @@ -41,6 +41,7 @@ class ComputePressure : public Compute { Compute *temperature; char *id_temp; double virial[6]; + int hybridpairflag; int keflag,pairflag,bondflag,angleflag,dihedralflag,improperflag; int fixflag,kspaceflag; diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index e313e16f18..1e0130ba3d 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -33,6 +33,7 @@ class PairHybrid : public Pair { friend class Respa; friend class Info; friend class PairDeprecated; + friend class ComputePressure; public: PairHybrid(class LAMMPS *); virtual ~PairHybrid(); -- GitLab From db3de8a31bbf16063cf19b6e71939aa933cbeb39 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 14 Jun 2019 13:48:31 -0400 Subject: [PATCH 049/469] rename Pair::single to single2nd --- src/USER-HMA/compute_hma.cpp | 2 +- src/pair.h | 2 +- src/pair_lj_smooth_linear.cpp | 2 +- src/pair_lj_smooth_linear.h | 2 +- 4 files changed, 4 insertions(+), 4 deletions(-) diff --git a/src/USER-HMA/compute_hma.cpp b/src/USER-HMA/compute_hma.cpp index 8edff5aa59..75ba335879 100644 --- a/src/USER-HMA/compute_hma.cpp +++ b/src/USER-HMA/compute_hma.cpp @@ -318,7 +318,7 @@ void ComputeHMA::compute_vector() if (rsq < cutsq[itype][jtype]) { double* jdr = deltaR[j]; double fforce, d2u[6]; - force->pair->single2(i, j, itype, jtype, rsq, delr, factor_coul, factor_lj, fforce, d2u); + force->pair->single2nd(i, j, itype, jtype, rsq, delr, factor_coul, factor_lj, fforce, d2u); int m = 0; for (int k=0; k<3; k++) { double a = fac; diff --git a/src/pair.h b/src/pair.h index 3947f4cd81..ae5bebf23a 100644 --- a/src/pair.h +++ b/src/pair.h @@ -149,7 +149,7 @@ class Pair : protected Pointers { void pairTensor(double fforce, double dfac, double delr[3], double phiTensor[6]); - virtual double single2(int, int, int, int, + virtual double single2nd(int, int, int, int, double, double[3], double, double, double& fforce, double d2u[6]) { fforce = 0.0; diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index d2bb6a1cc4..57f72dc28e 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -347,7 +347,7 @@ double PairLJSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, return factor_lj*philj; } -double PairLJSmoothLinear::single2(int /*i*/, int /*j*/, int itype, int jtype, double rsq, +double PairLJSmoothLinear::single2nd(int /*i*/, int /*j*/, int itype, int jtype, double rsq, double delr[3], double factor_coul, double factor_lj, double &fforce, double d2u[6]) { diff --git a/src/pair_lj_smooth_linear.h b/src/pair_lj_smooth_linear.h index 9cee9f2951..a43cbc23e2 100644 --- a/src/pair_lj_smooth_linear.h +++ b/src/pair_lj_smooth_linear.h @@ -38,7 +38,7 @@ class PairLJSmoothLinear : public Pair { void write_restart_settings(FILE *); void read_restart_settings(FILE *); double single(int, int, int, int, double, double, double, double &); - double single2(int, int, int, int, double, double[3], double, double, double&, double[6]); + double single2nd(int, int, int, int, double, double[3], double, double, double&, double[6]); protected: double cut_global; -- GitLab From 3611cfdaf8c153750ce8cc45ac239c1145eb0a2b Mon Sep 17 00:00:00 2001 From: mkanski Date: Fri, 14 Jun 2019 19:58:31 +0200 Subject: [PATCH 050/469] All styles support setting molecules' orientation --- doc/src/create_atoms.txt | 5 ++--- src/create_atoms.cpp | 10 ++++++---- 2 files changed, 8 insertions(+), 7 deletions(-) diff --git a/doc/src/create_atoms.txt b/doc/src/create_atoms.txt index d80e2d45f1..e673849793 100644 --- a/doc/src/create_atoms.txt +++ b/doc/src/create_atoms.txt @@ -242,9 +242,8 @@ write_dump all atom sinusoid.lammpstrj :pre :c,image(JPG/sinusoid_small.jpg,JPG/sinusoid.jpg) -The {rotate} keyword can only be used with the {single} style and -when adding a single molecule. It allows to specify the orientation -at which the molecule is inserted. The axis of rotation is +The {rotate} keyword allows to specify the orientation +at which molecules are inserted. The axis of rotation is determined by the rotation vector (Rx,Ry,Rz) that goes through the insertion point. The specified {theta} determines the angle of rotation around that axis. Note that the direction of rotation for diff --git a/src/create_atoms.cpp b/src/create_atoms.cpp index 52e4256fca..8869171115 100644 --- a/src/create_atoms.cpp +++ b/src/create_atoms.cpp @@ -176,8 +176,6 @@ void CreateAtoms::command(int narg, char **arg) } else error->all(FLERR,"Illegal create_atoms command"); iarg += 3; } else if (strcmp(arg[iarg],"rotate") == 0) { - if (style != SINGLE) - error->all(FLERR,"Cannot use create_atoms rotate unless single style"); if (iarg+5 > narg) error->all(FLERR,"Illegal create_atoms command"); double thetaone; double axisone[3]; @@ -678,7 +676,9 @@ void CreateAtoms::add_random() coord[1] >= sublo[1] && coord[1] < subhi[1] && coord[2] >= sublo[2] && coord[2] < subhi[2]) { if (mode == ATOM) atom->avec->create_atom(ntype,xone); - else add_molecule(xone); + else if (quatone[0] == 0 && quatone[1] == 0 && quatone[2] == 0) + add_molecule(xone); + else add_molecule(xone, quatone); } } @@ -832,7 +832,9 @@ void CreateAtoms::add_lattice() // add the atom or entire molecule to my list of atoms if (mode == ATOM) atom->avec->create_atom(basistype[m],x); - else add_molecule(x); + else if (quatone[0] == 0 && quatone[1] == 0 && quatone[2] == 0) + add_molecule(x); + else add_molecule(x,quatone); } } } -- GitLab From 343bc728e205f9e33a739aac149c087faec093ee Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 14 Jun 2019 14:11:15 -0400 Subject: [PATCH 051/469] Cleanup: s/fix/compute/ and properly increment size_vector --- src/USER-HMA/compute_hma.cpp | 9 ++++++--- 1 file changed, 6 insertions(+), 3 deletions(-) diff --git a/src/USER-HMA/compute_hma.cpp b/src/USER-HMA/compute_hma.cpp index 75ba335879..9f6a976332 100644 --- a/src/USER-HMA/compute_hma.cpp +++ b/src/USER-HMA/compute_hma.cpp @@ -107,13 +107,15 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : if (computeU>-1) continue; computeU = size_vector; extlist[size_vector] = 1; + size_vector++; } else if (!strcmp(arg[iarg], "p")) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix hma command"); + if (iarg+2 > narg) error->all(FLERR,"Illegal compute hma command"); if (computeP>-1) continue; computeP = size_vector; deltaPcap = force->numeric(FLERR, arg[iarg+1]); extlist[size_vector] = 0; + size_vector++; iarg++; } else if (!strcmp(arg[iarg], "cv")) { @@ -121,18 +123,19 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : computeCv = size_vector; comm_forward = 3; extlist[size_vector] = 1; + size_vector++; } else if (!strcmp(arg[iarg], "anharmonic")) { // the first time we're called, we'll grab lattice pressure and energy returnAnharmonic = -1; } else { - error->all(FLERR,"Illegal fix hma command"); + error->all(FLERR,"Illegal compute hma command"); } } if (size_vector == 0) { - error->all(FLERR,"Illegal fix hma command"); + error->all(FLERR,"Illegal compute hma command"); } if (size_vector<3) { memory->grow(extlist, size_vector, "hma:extlist"); -- GitLab From 622cfd571818edc57f1b91443ed38c49f2c24e73 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 14 Jun 2019 14:12:09 -0400 Subject: [PATCH 052/469] Add single2nd_enable flag for Pair --- src/USER-HMA/compute_hma.cpp | 7 +++++++ src/pair.cpp | 1 + src/pair.h | 1 + src/pair_lj_smooth_linear.cpp | 4 +++- 4 files changed, 12 insertions(+), 1 deletion(-) diff --git a/src/USER-HMA/compute_hma.cpp b/src/USER-HMA/compute_hma.cpp index 9f6a976332..bedcda769d 100644 --- a/src/USER-HMA/compute_hma.cpp +++ b/src/USER-HMA/compute_hma.cpp @@ -169,6 +169,13 @@ ComputeHMA::~ComputeHMA() /* ---------------------------------------------------------------------- */ void ComputeHMA::init() { + if (computeCv>-1) { + if (force->pair == NULL) + error->all(FLERR,"No pair style is defined for compute hma cv"); + if (force->pair->single_enable == 0) + error->all(FLERR,"Pair style does not support compute hma cv"); + } + int irequest = neighbor->request(this,instance_me); neighbor->requests[irequest]->pair = 0; neighbor->requests[irequest]->compute = 1; diff --git a/src/pair.cpp b/src/pair.cpp index 15efa62c59..448df7f511 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -60,6 +60,7 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) comm_forward = comm_reverse = comm_reverse_off = 0; single_enable = 1; + single2nd_enable = 0; restartinfo = 1; respa_enable = 0; one_coeff = 0; diff --git a/src/pair.h b/src/pair.h index ae5bebf23a..d831e3010e 100644 --- a/src/pair.h +++ b/src/pair.h @@ -46,6 +46,7 @@ class Pair : protected Pointers { int comm_reverse_off; // size of reverse comm even if newton off int single_enable; // 1 if single() routine exists + int single2nd_enable; // 1 if single2nd() routine exists int restartinfo; // 1 if pair style writes restart info int respa_enable; // 1 if inner/middle/outer rRESPA routines int one_coeff; // 1 if allows only one coeff * * call diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 57f72dc28e..0aa19570f2 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -30,7 +30,9 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -PairLJSmoothLinear::PairLJSmoothLinear(LAMMPS *lmp) : Pair(lmp) {} +PairLJSmoothLinear::PairLJSmoothLinear(LAMMPS *lmp) : Pair(lmp) { + single2nd_enable = 1; +} /* ---------------------------------------------------------------------- */ -- GitLab From 959da9de013d29d9e58bb4d2c4b6d8a48308bdc5 Mon Sep 17 00:00:00 2001 From: Rupert Nash Date: Sat, 16 Feb 2019 14:49:44 +0000 Subject: [PATCH 053/469] Create a compute for the momentum of a group of atoms --- src/Makefile.list | 4 +-- src/compute_momentum.cpp | 59 ++++++++++++++++++++++++++++++++++++++++ src/compute_momentum.h | 36 ++++++++++++++++++++++++ 3 files changed, 97 insertions(+), 2 deletions(-) create mode 100644 src/compute_momentum.cpp create mode 100644 src/compute_momentum.h diff --git a/src/Makefile.list b/src/Makefile.list index 65bbebca09..6e4c9726a6 100644 --- a/src/Makefile.list +++ b/src/Makefile.list @@ -7,9 +7,9 @@ SHELL = /bin/sh ROOT = lmp EXE = $(ROOT)_$@ -SRC = angle.cpp angle_charmm.cpp angle_cosine.cpp angle_cosine_delta.cpp angle_cosine_squared.cpp angle_harmonic.cpp angle_hybrid.cpp angle_table.cpp atom.cpp atom_vec.cpp atom_vec_angle.cpp atom_vec_atomic.cpp atom_vec_bond.cpp atom_vec_charge.cpp atom_vec_full.cpp atom_vec_hybrid.cpp atom_vec_molecular.cpp bond.cpp bond_fene.cpp bond_fene_expand.cpp bond_harmonic.cpp bond_hybrid.cpp bond_morse.cpp bond_nonlinear.cpp bond_quartic.cpp bond_table.cpp change_box.cpp comm.cpp compute.cpp compute_angle_local.cpp compute_bond_local.cpp compute_centro_atom.cpp compute_cna_atom.cpp compute_com.cpp compute_com_molecule.cpp compute_coord_atom.cpp compute_dihedral_local.cpp compute_displace_atom.cpp compute_erotate_sphere.cpp compute_group_group.cpp compute_gyration.cpp compute_gyration_molecule.cpp compute_heat_flux.cpp compute_improper_local.cpp compute_ke.cpp compute_ke_atom.cpp compute_msd.cpp compute_msd_molecule.cpp compute_pair_local.cpp compute_pe.cpp compute_pe_atom.cpp compute_pressure.cpp compute_property_atom.cpp compute_property_local.cpp compute_property_molecule.cpp compute_rdf.cpp compute_reduce.cpp compute_reduce_region.cpp compute_stress_atom.cpp compute_temp.cpp compute_temp_com.cpp compute_temp_deform.cpp compute_temp_partial.cpp compute_temp_profile.cpp compute_temp_ramp.cpp compute_temp_region.cpp compute_temp_sphere.cpp create_atoms.cpp create_box.cpp delete_atoms.cpp delete_bonds.cpp dihedral.cpp dihedral_charmm.cpp dihedral_harmonic.cpp dihedral_helix.cpp dihedral_hybrid.cpp dihedral_multi_harmonic.cpp dihedral_opls.cpp displace_atoms.cpp displace_box.cpp domain.cpp dump.cpp dump_atom.cpp dump_cfg.cpp dump_custom.cpp dump_dcd.cpp dump_local.cpp dump_xyz.cpp error.cpp ewald.cpp fft3d.cpp fft3d_wrap.cpp finish.cpp fix.cpp fix_adapt.cpp fix_addforce.cpp fix_ave_atom.cpp fix_ave_correlate.cpp fix_ave_histo.cpp fix_ave_spatial.cpp fix_ave_time.cpp fix_aveforce.cpp fix_bond_break.cpp fix_bond_create.cpp fix_bond_swap.cpp fix_box_relax.cpp fix_deform.cpp fix_deposit.cpp fix_drag.cpp fix_dt_reset.cpp fix_efield.cpp fix_enforce2d.cpp fix_evaporate.cpp fix_gravity.cpp fix_heat.cpp fix_indent.cpp fix_langevin.cpp fix_lineforce.cpp fix_minimize.cpp fix_momentum.cpp fix_move.cpp fix_nh.cpp fix_nh_sphere.cpp fix_nph.cpp fix_nph_sphere.cpp fix_npt.cpp fix_npt_sphere.cpp fix_nve.cpp fix_nve_limit.cpp fix_nve_noforce.cpp fix_nve_sphere.cpp fix_nvt.cpp fix_nvt_sllod.cpp fix_nvt_sphere.cpp fix_orient_fcc.cpp fix_planeforce.cpp fix_press_berendsen.cpp fix_print.cpp fix_qeq_comb.cpp fix_recenter.cpp fix_respa.cpp fix_rigid.cpp fix_rigid_nve.cpp fix_rigid_nvt.cpp fix_setforce.cpp fix_shake.cpp fix_shear_history.cpp fix_spring.cpp fix_spring_rg.cpp fix_spring_self.cpp fix_store_force.cpp fix_store_state.cpp fix_temp_berendsen.cpp fix_temp_rescale.cpp fix_thermal_conductivity.cpp fix_tmd.cpp fix_ttm.cpp fix_viscosity.cpp fix_viscous.cpp fix_wall.cpp fix_wall_harmonic.cpp fix_wall_lj126.cpp fix_wall_lj93.cpp fix_wall_reflect.cpp fix_wall_region.cpp force.cpp group.cpp improper.cpp improper_cvff.cpp improper_harmonic.cpp improper_hybrid.cpp input.cpp integrate.cpp kspace.cpp lammps.cpp lattice.cpp library.cpp main.cpp memory.cpp min.cpp min_cg.cpp min_hftn.cpp min_linesearch.cpp min_sd.cpp minimize.cpp modify.cpp neigh_bond.cpp neigh_derive.cpp neigh_full.cpp neigh_gran.cpp neigh_half_bin.cpp neigh_half_multi.cpp neigh_half_nsq.cpp neigh_list.cpp neigh_request.cpp neigh_respa.cpp neigh_stencil.cpp neighbor.cpp output.cpp pack.cpp pair.cpp pair_airebo.cpp pair_born_coul_long.cpp pair_buck.cpp pair_buck_coul_cut.cpp pair_buck_coul_long.cpp pair_comb.cpp pair_coul_cut.cpp pair_coul_debye.cpp pair_coul_long.cpp pair_dpd.cpp pair_dpd_tstat.cpp pair_eam.cpp pair_eam_alloy.cpp pair_eam_fs.cpp pair_eim.cpp pair_hybrid.cpp pair_hybrid_overlay.cpp pair_lj96_cut.cpp pair_lj_charmm_coul_charmm.cpp pair_lj_charmm_coul_charmm_implicit.cpp pair_lj_charmm_coul_long.cpp pair_lj_cut.cpp pair_lj_cut_coul_cut.cpp pair_lj_cut_coul_debye.cpp pair_lj_cut_coul_long.cpp pair_lj_cut_coul_long_tip4p.cpp pair_lj_expand.cpp pair_lj_gromacs.cpp pair_lj_gromacs_coul_gromacs.cpp pair_lj_smooth.cpp pair_morse.cpp pair_soft.cpp pair_sw.cpp pair_table.cpp pair_tersoff.cpp pair_tersoff_zbl.cpp pair_yukawa.cpp pppm.cpp pppm_tip4p.cpp random_mars.cpp random_park.cpp read_data.cpp read_restart.cpp region.cpp region_block.cpp region_cone.cpp region_cylinder.cpp region_intersect.cpp region_plane.cpp region_prism.cpp region_sphere.cpp region_union.cpp remap.cpp remap_wrap.cpp replicate.cpp respa.cpp run.cpp set.cpp shell.cpp special.cpp temper.cpp thermo.cpp timer.cpp universe.cpp update.cpp variable.cpp velocity.cpp verlet.cpp write_restart.cpp +SRC = angle.cpp angle_charmm.cpp angle_cosine.cpp angle_cosine_delta.cpp angle_cosine_squared.cpp angle_harmonic.cpp angle_hybrid.cpp angle_table.cpp atom.cpp atom_vec.cpp atom_vec_angle.cpp atom_vec_atomic.cpp atom_vec_bond.cpp atom_vec_charge.cpp atom_vec_full.cpp atom_vec_hybrid.cpp atom_vec_molecular.cpp bond.cpp bond_fene.cpp bond_fene_expand.cpp bond_harmonic.cpp bond_hybrid.cpp bond_morse.cpp bond_nonlinear.cpp bond_quartic.cpp bond_table.cpp change_box.cpp comm.cpp compute.cpp compute_angle_local.cpp compute_bond_local.cpp compute_centro_atom.cpp compute_cna_atom.cpp compute_com.cpp compute_com_molecule.cpp compute_coord_atom.cpp compute_dihedral_local.cpp compute_displace_atom.cpp compute_erotate_sphere.cpp compute_group_group.cpp compute_gyration.cpp compute_gyration_molecule.cpp compute_heat_flux.cpp compute_improper_local.cpp compute_ke.cpp compute_ke_atom.cpp compute_momentum.cpp compute_msd.cpp compute_msd_molecule.cpp compute_pair_local.cpp compute_pe.cpp compute_pe_atom.cpp compute_pressure.cpp compute_property_atom.cpp compute_property_local.cpp compute_property_molecule.cpp compute_rdf.cpp compute_reduce.cpp compute_reduce_region.cpp compute_stress_atom.cpp compute_temp.cpp compute_temp_com.cpp compute_temp_deform.cpp compute_temp_partial.cpp compute_temp_profile.cpp compute_temp_ramp.cpp compute_temp_region.cpp compute_temp_sphere.cpp create_atoms.cpp create_box.cpp delete_atoms.cpp delete_bonds.cpp dihedral.cpp dihedral_charmm.cpp dihedral_harmonic.cpp dihedral_helix.cpp dihedral_hybrid.cpp dihedral_multi_harmonic.cpp dihedral_opls.cpp displace_atoms.cpp displace_box.cpp domain.cpp dump.cpp dump_atom.cpp dump_cfg.cpp dump_custom.cpp dump_dcd.cpp dump_local.cpp dump_xyz.cpp error.cpp ewald.cpp fft3d.cpp fft3d_wrap.cpp finish.cpp fix.cpp fix_adapt.cpp fix_addforce.cpp fix_ave_atom.cpp fix_ave_correlate.cpp fix_ave_histo.cpp fix_ave_spatial.cpp fix_ave_time.cpp fix_aveforce.cpp fix_bond_break.cpp fix_bond_create.cpp fix_bond_swap.cpp fix_box_relax.cpp fix_deform.cpp fix_deposit.cpp fix_drag.cpp fix_dt_reset.cpp fix_efield.cpp fix_enforce2d.cpp fix_evaporate.cpp fix_gravity.cpp fix_heat.cpp fix_indent.cpp fix_langevin.cpp fix_lineforce.cpp fix_minimize.cpp fix_momentum.cpp fix_move.cpp fix_nh.cpp fix_nh_sphere.cpp fix_nph.cpp fix_nph_sphere.cpp fix_npt.cpp fix_npt_sphere.cpp fix_nve.cpp fix_nve_limit.cpp fix_nve_noforce.cpp fix_nve_sphere.cpp fix_nvt.cpp fix_nvt_sllod.cpp fix_nvt_sphere.cpp fix_orient_fcc.cpp fix_planeforce.cpp fix_press_berendsen.cpp fix_print.cpp fix_qeq_comb.cpp fix_recenter.cpp fix_respa.cpp fix_rigid.cpp fix_rigid_nve.cpp fix_rigid_nvt.cpp fix_setforce.cpp fix_shake.cpp fix_shear_history.cpp fix_spring.cpp fix_spring_rg.cpp fix_spring_self.cpp fix_store_force.cpp fix_store_state.cpp fix_temp_berendsen.cpp fix_temp_rescale.cpp fix_thermal_conductivity.cpp fix_tmd.cpp fix_ttm.cpp fix_viscosity.cpp fix_viscous.cpp fix_wall.cpp fix_wall_harmonic.cpp fix_wall_lj126.cpp fix_wall_lj93.cpp fix_wall_reflect.cpp fix_wall_region.cpp force.cpp group.cpp improper.cpp improper_cvff.cpp improper_harmonic.cpp improper_hybrid.cpp input.cpp integrate.cpp kspace.cpp lammps.cpp lattice.cpp library.cpp main.cpp memory.cpp min.cpp min_cg.cpp min_hftn.cpp min_linesearch.cpp min_sd.cpp minimize.cpp modify.cpp neigh_bond.cpp neigh_derive.cpp neigh_full.cpp neigh_gran.cpp neigh_half_bin.cpp neigh_half_multi.cpp neigh_half_nsq.cpp neigh_list.cpp neigh_request.cpp neigh_respa.cpp neigh_stencil.cpp neighbor.cpp output.cpp pack.cpp pair.cpp pair_airebo.cpp pair_born_coul_long.cpp pair_buck.cpp pair_buck_coul_cut.cpp pair_buck_coul_long.cpp pair_comb.cpp pair_coul_cut.cpp pair_coul_debye.cpp pair_coul_long.cpp pair_dpd.cpp pair_dpd_tstat.cpp pair_eam.cpp pair_eam_alloy.cpp pair_eam_fs.cpp pair_eim.cpp pair_hybrid.cpp pair_hybrid_overlay.cpp pair_lj96_cut.cpp pair_lj_charmm_coul_charmm.cpp pair_lj_charmm_coul_charmm_implicit.cpp pair_lj_charmm_coul_long.cpp pair_lj_cut.cpp pair_lj_cut_coul_cut.cpp pair_lj_cut_coul_debye.cpp pair_lj_cut_coul_long.cpp pair_lj_cut_coul_long_tip4p.cpp pair_lj_expand.cpp pair_lj_gromacs.cpp pair_lj_gromacs_coul_gromacs.cpp pair_lj_smooth.cpp pair_morse.cpp pair_soft.cpp pair_sw.cpp pair_table.cpp pair_tersoff.cpp pair_tersoff_zbl.cpp pair_yukawa.cpp pppm.cpp pppm_tip4p.cpp random_mars.cpp random_park.cpp read_data.cpp read_restart.cpp region.cpp region_block.cpp region_cone.cpp region_cylinder.cpp region_intersect.cpp region_plane.cpp region_prism.cpp region_sphere.cpp region_union.cpp remap.cpp remap_wrap.cpp replicate.cpp respa.cpp run.cpp set.cpp shell.cpp special.cpp temper.cpp thermo.cpp timer.cpp universe.cpp update.cpp variable.cpp velocity.cpp verlet.cpp write_restart.cpp -INC = angle.h angle_charmm.h angle_cosine.h angle_cosine_delta.h angle_cosine_squared.h angle_harmonic.h angle_hybrid.h angle_table.h atom.h atom_vec.h atom_vec_angle.h atom_vec_atomic.h atom_vec_bond.h atom_vec_charge.h atom_vec_full.h atom_vec_hybrid.h atom_vec_molecular.h bond.h bond_fene.h bond_fene_expand.h bond_harmonic.h bond_hybrid.h bond_morse.h bond_nonlinear.h bond_quartic.h bond_table.h change_box.h comm.h compute.h compute_angle_local.h compute_bond_local.h compute_centro_atom.h compute_cna_atom.h compute_com.h compute_com_molecule.h compute_coord_atom.h compute_dihedral_local.h compute_displace_atom.h compute_erotate_sphere.h compute_group_group.h compute_gyration.h compute_gyration_molecule.h compute_heat_flux.h compute_improper_local.h compute_ke.h compute_ke_atom.h compute_msd.h compute_msd_molecule.h compute_pair_local.h compute_pe.h compute_pe_atom.h compute_pressure.h compute_property_atom.h compute_property_local.h compute_property_molecule.h compute_rdf.h compute_reduce.h compute_reduce_region.h compute_stress_atom.h compute_temp.h compute_temp_com.h compute_temp_deform.h compute_temp_partial.h compute_temp_profile.h compute_temp_ramp.h compute_temp_region.h compute_temp_sphere.h create_atoms.h create_box.h delete_atoms.h delete_bonds.h dihedral.h dihedral_charmm.h dihedral_harmonic.h dihedral_helix.h dihedral_hybrid.h dihedral_multi_harmonic.h dihedral_opls.h displace_atoms.h displace_box.h domain.h dump.h dump_atom.h dump_cfg.h dump_custom.h dump_dcd.h dump_local.h dump_xyz.h error.h ewald.h fft3d.h fft3d_wrap.h finish.h fix.h fix_adapt.h fix_addforce.h fix_ave_atom.h fix_ave_correlate.h fix_ave_histo.h fix_ave_spatial.h fix_ave_time.h fix_aveforce.h fix_bond_break.h fix_bond_create.h fix_bond_swap.h fix_box_relax.h fix_deform.h fix_deposit.h fix_drag.h fix_dt_reset.h fix_efield.h fix_enforce2d.h fix_evaporate.h fix_gravity.h fix_heat.h fix_indent.h fix_langevin.h fix_lineforce.h fix_minimize.h fix_momentum.h fix_move.h fix_nh.h fix_nh_sphere.h fix_nph.h fix_nph_sphere.h fix_npt.h fix_npt_sphere.h fix_nve.h fix_nve_limit.h fix_nve_noforce.h fix_nve_sphere.h fix_nvt.h fix_nvt_sllod.h fix_nvt_sphere.h fix_orient_fcc.h fix_planeforce.h fix_press_berendsen.h fix_print.h fix_qeq_comb.h fix_recenter.h fix_respa.h fix_rigid.h fix_rigid_nve.h fix_rigid_nvt.h fix_setforce.h fix_shake.h fix_shear_history.h fix_spring.h fix_spring_rg.h fix_spring_self.h fix_store_force.h fix_store_state.h fix_temp_berendsen.h fix_temp_rescale.h fix_thermal_conductivity.h fix_tmd.h fix_ttm.h fix_viscosity.h fix_viscous.h fix_wall.h fix_wall_harmonic.h fix_wall_lj126.h fix_wall_lj93.h fix_wall_reflect.h fix_wall_region.h force.h group.h improper.h improper_cvff.h improper_harmonic.h improper_hybrid.h input.h integrate.h kspace.h lammps.h lattice.h library.h math_extra.h memory.h min.h min_cg.h min_hftn.h min_linesearch.h min_sd.h minimize.h modify.h neigh_list.h neigh_request.h neighbor.h output.h pack.h pair.h pair_airebo.h pair_born_coul_long.h pair_buck.h pair_buck_coul_cut.h pair_buck_coul_long.h pair_comb.h pair_coul_cut.h pair_coul_debye.h pair_coul_long.h pair_dpd.h pair_dpd_tstat.h pair_eam.h pair_eam_alloy.h pair_eam_fs.h pair_eim.h pair_hybrid.h pair_hybrid_overlay.h pair_lj96_cut.h pair_lj_charmm_coul_charmm.h pair_lj_charmm_coul_charmm_implicit.h pair_lj_charmm_coul_long.h pair_lj_cut.h pair_lj_cut_coul_cut.h pair_lj_cut_coul_debye.h pair_lj_cut_coul_long.h pair_lj_cut_coul_long_tip4p.h pair_lj_expand.h pair_lj_gromacs.h pair_lj_gromacs_coul_gromacs.h pair_lj_smooth.h pair_morse.h pair_soft.h pair_sw.h pair_table.h pair_tersoff.h pair_tersoff_zbl.h pair_yukawa.h pointers.h pppm.h pppm_tip4p.h random_mars.h random_park.h read_data.h read_restart.h region.h region_block.h region_cone.h region_cylinder.h region_intersect.h region_plane.h region_prism.h region_sphere.h region_union.h remap.h remap_wrap.h replicate.h respa.h run.h set.h shell.h special.h style_angle.h style_atom.h style_bond.h style_command.h style_compute.h style_dihedral.h style_dump.h style_fix.h style_improper.h style_integrate.h style_kspace.h style_minimize.h style_pair.h style_region.h temper.h thermo.h timer.h universe.h update.h variable.h velocity.h verlet.h version.h write_restart.h +INC = angle.h angle_charmm.h angle_cosine.h angle_cosine_delta.h angle_cosine_squared.h angle_harmonic.h angle_hybrid.h angle_table.h atom.h atom_vec.h atom_vec_angle.h atom_vec_atomic.h atom_vec_bond.h atom_vec_charge.h atom_vec_full.h atom_vec_hybrid.h atom_vec_molecular.h bond.h bond_fene.h bond_fene_expand.h bond_harmonic.h bond_hybrid.h bond_morse.h bond_nonlinear.h bond_quartic.h bond_table.h change_box.h comm.h compute.h compute_angle_local.h compute_bond_local.h compute_centro_atom.h compute_cna_atom.h compute_com.h compute_com_molecule.h compute_coord_atom.h compute_dihedral_local.h compute_displace_atom.h compute_erotate_sphere.h compute_group_group.h compute_gyration.h compute_gyration_molecule.h compute_heat_flux.h compute_improper_local.h compute_ke.h compute_ke_atom.h compute_momentum.h compute_msd.h compute_msd_molecule.h compute_pair_local.h compute_pe.h compute_pe_atom.h compute_pressure.h compute_property_atom.h compute_property_local.h compute_property_molecule.h compute_rdf.h compute_reduce.h compute_reduce_region.h compute_stress_atom.h compute_temp.h compute_temp_com.h compute_temp_deform.h compute_temp_partial.h compute_temp_profile.h compute_temp_ramp.h compute_temp_region.h compute_temp_sphere.h create_atoms.h create_box.h delete_atoms.h delete_bonds.h dihedral.h dihedral_charmm.h dihedral_harmonic.h dihedral_helix.h dihedral_hybrid.h dihedral_multi_harmonic.h dihedral_opls.h displace_atoms.h displace_box.h domain.h dump.h dump_atom.h dump_cfg.h dump_custom.h dump_dcd.h dump_local.h dump_xyz.h error.h ewald.h fft3d.h fft3d_wrap.h finish.h fix.h fix_adapt.h fix_addforce.h fix_ave_atom.h fix_ave_correlate.h fix_ave_histo.h fix_ave_spatial.h fix_ave_time.h fix_aveforce.h fix_bond_break.h fix_bond_create.h fix_bond_swap.h fix_box_relax.h fix_deform.h fix_deposit.h fix_drag.h fix_dt_reset.h fix_efield.h fix_enforce2d.h fix_evaporate.h fix_gravity.h fix_heat.h fix_indent.h fix_langevin.h fix_lineforce.h fix_minimize.h fix_momentum.h fix_move.h fix_nh.h fix_nh_sphere.h fix_nph.h fix_nph_sphere.h fix_npt.h fix_npt_sphere.h fix_nve.h fix_nve_limit.h fix_nve_noforce.h fix_nve_sphere.h fix_nvt.h fix_nvt_sllod.h fix_nvt_sphere.h fix_orient_fcc.h fix_planeforce.h fix_press_berendsen.h fix_print.h fix_qeq_comb.h fix_recenter.h fix_respa.h fix_rigid.h fix_rigid_nve.h fix_rigid_nvt.h fix_setforce.h fix_shake.h fix_shear_history.h fix_spring.h fix_spring_rg.h fix_spring_self.h fix_store_force.h fix_store_state.h fix_temp_berendsen.h fix_temp_rescale.h fix_thermal_conductivity.h fix_tmd.h fix_ttm.h fix_viscosity.h fix_viscous.h fix_wall.h fix_wall_harmonic.h fix_wall_lj126.h fix_wall_lj93.h fix_wall_reflect.h fix_wall_region.h force.h group.h improper.h improper_cvff.h improper_harmonic.h improper_hybrid.h input.h integrate.h kspace.h lammps.h lattice.h library.h math_extra.h memory.h min.h min_cg.h min_hftn.h min_linesearch.h min_sd.h minimize.h modify.h neigh_list.h neigh_request.h neighbor.h output.h pack.h pair.h pair_airebo.h pair_born_coul_long.h pair_buck.h pair_buck_coul_cut.h pair_buck_coul_long.h pair_comb.h pair_coul_cut.h pair_coul_debye.h pair_coul_long.h pair_dpd.h pair_dpd_tstat.h pair_eam.h pair_eam_alloy.h pair_eam_fs.h pair_eim.h pair_hybrid.h pair_hybrid_overlay.h pair_lj96_cut.h pair_lj_charmm_coul_charmm.h pair_lj_charmm_coul_charmm_implicit.h pair_lj_charmm_coul_long.h pair_lj_cut.h pair_lj_cut_coul_cut.h pair_lj_cut_coul_debye.h pair_lj_cut_coul_long.h pair_lj_cut_coul_long_tip4p.h pair_lj_expand.h pair_lj_gromacs.h pair_lj_gromacs_coul_gromacs.h pair_lj_smooth.h pair_morse.h pair_soft.h pair_sw.h pair_table.h pair_tersoff.h pair_tersoff_zbl.h pair_yukawa.h pointers.h pppm.h pppm_tip4p.h random_mars.h random_park.h read_data.h read_restart.h region.h region_block.h region_cone.h region_cylinder.h region_intersect.h region_plane.h region_prism.h region_sphere.h region_union.h remap.h remap_wrap.h replicate.h respa.h run.h set.h shell.h special.h style_angle.h style_atom.h style_bond.h style_command.h style_compute.h style_dihedral.h style_dump.h style_fix.h style_improper.h style_integrate.h style_kspace.h style_minimize.h style_pair.h style_region.h temper.h thermo.h timer.h universe.h update.h variable.h velocity.h verlet.h version.h write_restart.h OBJ = $(SRC:.cpp=.o) diff --git a/src/compute_momentum.cpp b/src/compute_momentum.cpp new file mode 100644 index 0000000000..f8fc0ec6ab --- /dev/null +++ b/src/compute_momentum.cpp @@ -0,0 +1,59 @@ + +#include +#include "compute_momentum.h" +#include "atom.h" +#include "update.h" +#include "force.h" +#include "domain.h" +#include "group.h" +#include "error.h" + +using namespace LAMMPS_NS; + +ComputeMomentum::ComputeMomentum(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg) +{ + if (narg != 3) error->all(FLERR,"Illegal compute momentum command"); + + vector_flag = 1; + size_vector = 3; + extvector = 1; + vector = new double[size_vector]; +} + +ComputeMomentum::~ComputeMomentum() { + delete[] vector; +} + +void ComputeMomentum::init() +{ +} + +void ComputeMomentum::compute_vector() +{ + invoked_vector = update->ntimestep; + + double **v = atom->v; + double *rmass = atom->rmass; + double *mass = atom->mass; + int *mask = atom->mask; + int *type = atom->type; + int nlocal = atom->nlocal; + + double mom[3] = {0.0, 0.0, 0.0}; + + if (rmass) { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + for(int j = 0; j < 3; ++j) + mom[j] += rmass[i] * v[i][j]; + } + } else { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) + for(int j = 0; j < 3; ++j) + mom[j] += mass[type[i]] * v[i][j]; + } + + MPI_Allreduce(&mom, vector, 3, MPI_DOUBLE, MPI_SUM, world); +} diff --git a/src/compute_momentum.h b/src/compute_momentum.h new file mode 100644 index 0000000000..1e0c52c045 --- /dev/null +++ b/src/compute_momentum.h @@ -0,0 +1,36 @@ +#ifdef COMPUTE_CLASS + +ComputeStyle(momentum,ComputeMomentum) + +#else + +#ifndef LMP_COMPUTE_MOMENTUM_H +#define LMP_COMPUTE_MOMENTUM_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeMomentum : public Compute { + public: + ComputeMomentum(class LAMMPS *, int, char **); + virtual ~ComputeMomentum(); + + virtual void init(); + virtual void compute_vector(); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ -- GitLab From 26347ec80ce8a33a4162d5d5275d8be52d6666fa Mon Sep 17 00:00:00 2001 From: Rupert Nash Date: Wed, 19 Jun 2019 13:55:10 +0100 Subject: [PATCH 054/469] Add docs for compute momentum --- doc/src/Commands_compute.txt | 1 + doc/src/compute.txt | 1 + doc/src/compute_momentum.txt | 45 ++++++++++++++++++++++++++++++++++++ doc/src/computes.txt | 1 + doc/src/lammps.book | 1 + 5 files changed, 49 insertions(+) create mode 100644 doc/src/compute_momentum.txt diff --git a/doc/src/Commands_compute.txt b/doc/src/Commands_compute.txt index f566702609..0817f44adf 100644 --- a/doc/src/Commands_compute.txt +++ b/doc/src/Commands_compute.txt @@ -80,6 +80,7 @@ KOKKOS, o = USER-OMP, t = OPT. "meso/e/atom"_compute_meso_e_atom.html, "meso/rho/atom"_compute_meso_rho_atom.html, "meso/t/atom"_compute_meso_t_atom.html, +"momentum"_compute_momentum.html, "msd"_compute_msd.html, "msd/chunk"_compute_msd_chunk.html, "msd/nongauss"_compute_msd_nongauss.html, diff --git a/doc/src/compute.txt b/doc/src/compute.txt index 87dbee57d6..12c6b141b7 100644 --- a/doc/src/compute.txt +++ b/doc/src/compute.txt @@ -229,6 +229,7 @@ compute"_Commands_compute.html doc page are followed by one or more of "meso/e/atom"_compute_meso_e_atom.html - "meso/rho/atom"_compute_meso_rho_atom.html - "meso/t/atom"_compute_meso_t_atom.html - +"momentum"_compute_momentum.html - translational momentum "msd"_compute_msd.html - mean-squared displacement of group of atoms "msd/chunk"_compute_msd_chunk.html - mean-squared displacement for each chunk "msd/nongauss"_compute_msd_nongauss.html - MSD and non-Gaussian parameter of group of atoms diff --git a/doc/src/compute_momentum.txt b/doc/src/compute_momentum.txt new file mode 100644 index 0000000000..4db171d42d --- /dev/null +++ b/doc/src/compute_momentum.txt @@ -0,0 +1,45 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Commands_all.html) + +:line + +compute momentum command :h3 + +[Syntax:] + +compute ID group-ID momentum :pre + +ID, group-ID are documented in "compute"_compute.html command +momentum = style name of this compute command :ul + +[Examples:] + +compute 1 all momentum :pre + +[Description:] + +Define a computation that calculates the translational momentum +of a group of particles. + +The momentum of each particles is computed as m v, where m and v are +the mass and velocity of the particle. + +[Output info:] + +This compute calculates a global vector (the summed momentum) on +length 3. This value can be used by any command that uses a global +vector value from a compute as input. See the "Howto +output"_Howto_output.html doc page for an overview of LAMMPS output +options. + +The vector value calculated by this compute is "extensive". The vector +value will be in momentum "units"_units.html. + +[Restrictions:] none + +[Related commands:] + +[Default:] none diff --git a/doc/src/computes.txt b/doc/src/computes.txt index 926b8da222..1c914365b1 100644 --- a/doc/src/computes.txt +++ b/doc/src/computes.txt @@ -57,6 +57,7 @@ Computes :h1 compute_meso_e_atom compute_meso_rho_atom compute_meso_t_atom + compute_momentum compute_msd compute_msd_chunk compute_msd_nongauss diff --git a/doc/src/lammps.book b/doc/src/lammps.book index 2738c9b051..816acd3521 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -468,6 +468,7 @@ compute_ke_rigid.html compute_meso_e_atom.html compute_meso_rho_atom.html compute_meso_t_atom.html +compute_momentum.html compute_msd.html compute_msd_chunk.html compute_msd_nongauss.html -- GitLab From 52a3d825ef32729f101d2fe09703b519e3c06b0a Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 19 Jun 2019 13:35:35 -0400 Subject: [PATCH 055/469] Explain more about advantages of HMA, restrictions, point to examples/hma --- doc/src/compute_hma.txt | 24 +++++++++++++++++++++--- 1 file changed, 21 insertions(+), 3 deletions(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index c203c281ed..58934be054 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -37,8 +37,24 @@ energy, pressure or heat capacity), using the harmonically-mapped averaging (HMA) method. This command yields much higher precision than the equivalent compute commands ("compute pe"_compute_pe.html, "compute pressure"_compute_pressure.html, etc.) -commands during a canonical simulation of an atomic crystal. - +commands during a canonical simulation of an atomic crystal. Specifically, +near melting HMA can yield averages of a given precision an order of magnitude +faster than conventional methods, and this only improves as the temperatures is +lowered. This is particularly important for evaluating the free energy by +thermodynamic integration, where the low-temperature contributions are the +greatest source of statistical uncertainty. Moreover, HMA has other +advantages, including smaller potential-truncation effects, finite-size +effects, smaller timestep inaccuracy, faster equilibration and shorter +decorrelation time. + +HMA should not be used if atoms are expected to diffuse. It is also +restricted to simulations in the NVT ensemble. + +Computation of the heat capacity with this compute is presently restricted to +the "lj_smooth_linear"_lj_smooth_linear.html pair style. Use with other pair +styles requires an additional method (single2nd) to be implemented in the +corresponding Pair class. Computation of the energy and pressure does not +have this restriction. In this method, the analytically known harmonic behavior of a crystal is removed from the traditional ensemble averages, which leads to an accurate and precise measurement of the anharmonic contributions without contamination @@ -119,7 +135,9 @@ NOTE: Compute hma should be used when the atoms of the solid do not diffuse. Dif NOTE: The "fix_modify energy yes"_fix_modify.html command must also be specified if a fix is to contribute potential energy to this command. -:line +An example input script that uses this compute is included in +examples/USER/hma/ along with corresponding LAMMPS output showing that the HMA +properties fluctuate less than the corresponding conventional properties. [Output info:] -- GitLab From 04cfaae54f99e7a6dc4e1cd4e10408a54f551a64 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 19 Jun 2019 13:37:41 -0400 Subject: [PATCH 056/469] Fold HMA README into source code in preparation for move to MISC --- src/USER-HMA/README | 30 ------------------------------ src/USER-HMA/compute_hma.cpp | 32 ++++++++++++++++++++++++++++++++ 2 files changed, 32 insertions(+), 30 deletions(-) delete mode 100644 src/USER-HMA/README diff --git a/src/USER-HMA/README b/src/USER-HMA/README deleted file mode 100644 index b27999341b..0000000000 --- a/src/USER-HMA/README +++ /dev/null @@ -1,30 +0,0 @@ -The HMA package implements the compute hma command for LAMMPS, which implements -harmonically-mapped averaging for crystalline solids. The current -implementation handles atomic crystals. - -Computing the heat capacity relies on being able to compute the second -derivative of the energy with respect to atom positions. This capability is -provided by the single2 method in Pair, but is currently only implemented for -the shifted-force LJ potential (lj/smooth/linear). Pair::single2 takes a single -pair and (like Pair::single) returns the energy and sets the force as an out -parameter, but also sets the elements of 6-element double array out parameter, -which are the unique components of the atomic Hessian tensor for the pair. A -helper method exists (Pair::pairTensor), which will compute the tensor from -linear derivatives and the vector between the positions. HMA Heat capacity can -be computed for other models by implementing single2 in those Pair classes. - -More information about HMA is available in these publications: - -A. J. Schultz, D. A. Kofke, “Comprehensive high-precision high-accuracy -equation of state and coexistence properties for classical Lennard-Jones -crystals and low-temperature fluid phases”, J. Chem. Phys. 149, 204508 (2018) -https://dx.doi.org/10.1063/1.5053714 - -S. G. Moustafa, A. J. Schultz, D. A. Kofke, “Harmonically Assisted Methods for -Computing the Free Energy of Classical Crystals by Molecular Simulation: A -Comparative Study”, J. Chem. Theory Comput. 13, 825-834 (2017) -https://dx.doi.org/10.1021/acs.jctc.6b01082 - -S. G. Moustafa, A. J. Schultz, D. A. Kofke, “Very fast averaging of thermal -properties of crystals by molecular simulation”, Phys. Rev. E 92, 043303 (2015) -https://dx.doi.org/10.1103/PhysRevE.92.043303 diff --git a/src/USER-HMA/compute_hma.cpp b/src/USER-HMA/compute_hma.cpp index bedcda769d..15cadbdd45 100644 --- a/src/USER-HMA/compute_hma.cpp +++ b/src/USER-HMA/compute_hma.cpp @@ -11,6 +11,38 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- +This compute implements harmonically-mapped averaging for crystalline solids. +The current implementation handles atomic crystals. + +Computing the heat capacity relies on being able to compute the second +derivative of the energy with respect to atom positions. This capability is +provided by the single2 method in Pair, but is currently only implemented for +the shifted-force LJ potential (lj/smooth/linear). Pair::single2 takes a single +pair and (like Pair::single) returns the energy and sets the force as an out +parameter, but also sets the elements of 6-element double array out parameter, +which are the unique components of the atomic Hessian tensor for the pair. A +helper method exists (Pair::pairTensor), which will compute the tensor from +linear derivatives and the vector between the positions. HMA Heat capacity can +be computed for other models by implementing single2 in those Pair classes. + +More information about HMA is available in these publications: + +A. J. Schultz, D. A. Kofke, “Comprehensive high-precision high-accuracy +equation of state and coexistence properties for classical Lennard-Jones +crystals and low-temperature fluid phases”, J. Chem. Phys. 149, 204508 (2018) +https://dx.doi.org/10.1063/1.5053714 + +S. G. Moustafa, A. J. Schultz, D. A. Kofke, “Harmonically Assisted Methods for +Computing the Free Energy of Classical Crystals by Molecular Simulation: A +Comparative Study”, J. Chem. Theory Comput. 13, 825-834 (2017) +https://dx.doi.org/10.1021/acs.jctc.6b01082 + +S. G. Moustafa, A. J. Schultz, D. A. Kofke, “Very fast averaging of thermal +properties of crystals by molecular simulation”, Phys. Rev. E 92, 043303 (2015) +https://dx.doi.org/10.1103/PhysRevE.92.043303 +------------------------------------------------------------------------- */ + #include #include #include -- GitLab From 395a9d3739eef12917d172525de3414b6178ee5c Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 19 Jun 2019 16:12:15 -0400 Subject: [PATCH 057/469] Fold hma compute into USER-MISC --- cmake/CMakeLists.txt | 4 ++-- doc/src/Packages_details.txt | 20 ------------------- doc/src/Packages_user.txt | 1 - examples/USER/{ => misc}/hma/README | 0 examples/USER/{ => misc}/hma/hma.in | 0 .../USER/{ => misc}/hma/log.6Nov18.hma.g++.1 | 0 .../USER/{ => misc}/hma/log.6Nov18.hma.g++.4 | 0 src/{USER-HMA => USER-MISC}/compute_hma.cpp | 0 src/{USER-HMA => USER-MISC}/compute_hma.h | 0 9 files changed, 2 insertions(+), 23 deletions(-) rename examples/USER/{ => misc}/hma/README (100%) rename examples/USER/{ => misc}/hma/hma.in (100%) rename examples/USER/{ => misc}/hma/log.6Nov18.hma.g++.1 (100%) rename examples/USER/{ => misc}/hma/log.6Nov18.hma.g++.4 (100%) rename src/{USER-HMA => USER-MISC}/compute_hma.cpp (100%) rename src/{USER-HMA => USER-MISC}/compute_hma.h (100%) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index c2356002b2..911b6f0f15 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -177,8 +177,8 @@ set(DEFAULT_PACKAGES ASPHERE BODY CLASS2 COLLOID COMPRESS CORESHELL DIPOLE GRANULAR KSPACE LATTE MANYBODY MC MESSAGE MISC MOLECULE PERI POEMS QEQ REPLICA RIGID SHOCK SPIN SNAP SRD KIM PYTHON MSCG MPIIO VORONOI USER-ATC USER-AWPMD USER-BOCS USER-CGDNA USER-MESO USER-CGSDK USER-COLVARS - USER-DIFFRACTION USER-DPD USER-DRUDE USER-EFF USER-FEP USER-H5MD USER-HMA - USER-LB USER-MANIFOLD USER-MEAMC USER-MGPT USER-MISC USER-MOFFF USER-MOLFILE + USER-DIFFRACTION USER-DPD USER-DRUDE USER-EFF USER-FEP USER-H5MD USER-LB + USER-MANIFOLD USER-MEAMC USER-MGPT USER-MISC USER-MOFFF USER-MOLFILE USER-NETCDF USER-PHONON USER-PLUMED USER-PTM USER-QTB USER-REAXC USER-SCAFACOS USER-SDPD USER-SMD USER-SMTBQ USER-SPH USER-TALLY USER-UEF USER-VTK USER-QUIP USER-QMMM USER-YAFF USER-ADIOS) diff --git a/doc/src/Packages_details.txt b/doc/src/Packages_details.txt index 12f63e2e3b..1528adc420 100644 --- a/doc/src/Packages_details.txt +++ b/doc/src/Packages_details.txt @@ -76,7 +76,6 @@ as contained in the file name. "USER-EFF"_#PKG-USER-EFF, "USER-FEP"_#PKG-USER-FEP, "USER-H5MD"_#PKG-USER-H5MD, -"USER-HMA"_#PKG-USER-HMA, "USER-INTEL"_#PKG-USER-INTEL, "USER-LB"_#PKG-USER-LB, "USER-MANIFOLD"_#PKG-USER-MANIFOLD, @@ -1375,25 +1374,6 @@ lib/h5md/README :line -USER-HMA package :link(PKG-USER-HMA),h4 - -[Contents:] - -Harmonically mapped averaging for efficient calculation of properties of -crystalline solids. The compute hma can specify use of HMA for calculation of -potential energy, pressure and heat capacity. - -[Author:] Apoorva Purohit, Andrew Schultz and David Kofke (University at -Buffalo, NY, USA) - -[Supporting info:] - -examples/USER/hma/README -src/USER-HMA/README -"compute hma"_compute_hma.html :ul - -:line - USER-INTEL package :link(PKG-USER-INTEL),h4 [Contents:] diff --git a/doc/src/Packages_user.txt b/doc/src/Packages_user.txt index 3ce2a458b6..4210f617ef 100644 --- a/doc/src/Packages_user.txt +++ b/doc/src/Packages_user.txt @@ -51,7 +51,6 @@ Package, Description, Doc page, Example, Library "USER-EFF"_Packages_details.html#PKG-USER-EFF, electron force field,"pair_style eff/cut"_pair_eff.html, USER/eff, no "USER-FEP"_Packages_details.html#PKG-USER-FEP, free energy perturbation,"compute fep"_compute_fep.html, USER/fep, no "USER-H5MD"_Packages_details.html#PKG-USER-H5MD, dump output via HDF5,"dump h5md"_dump_h5md.html, n/a, ext -"USER-HMA"_Packages_details.html#PKG-USER-HMA, compute properties via HMA,"compute hma"_compute_hma.html, USER/hma, no "USER-INTEL"_Packages_details.html#PKG-USER-INTEL, optimized Intel CPU and KNL styles,"Speed intel"_Speed_intel.html, "Benchmarks"_http://lammps.sandia.gov/bench.html, no "USER-LB"_Packages_details.html#PKG-USER-LB, Lattice Boltzmann fluid,"fix lb/fluid"_fix_lb_fluid.html, USER/lb, no "USER-MANIFOLD"_Packages_details.html#PKG-USER-MANIFOLD, motion on 2d surfaces,"fix manifoldforce"_fix_manifoldforce.html, USER/manifold, no diff --git a/examples/USER/hma/README b/examples/USER/misc/hma/README similarity index 100% rename from examples/USER/hma/README rename to examples/USER/misc/hma/README diff --git a/examples/USER/hma/hma.in b/examples/USER/misc/hma/hma.in similarity index 100% rename from examples/USER/hma/hma.in rename to examples/USER/misc/hma/hma.in diff --git a/examples/USER/hma/log.6Nov18.hma.g++.1 b/examples/USER/misc/hma/log.6Nov18.hma.g++.1 similarity index 100% rename from examples/USER/hma/log.6Nov18.hma.g++.1 rename to examples/USER/misc/hma/log.6Nov18.hma.g++.1 diff --git a/examples/USER/hma/log.6Nov18.hma.g++.4 b/examples/USER/misc/hma/log.6Nov18.hma.g++.4 similarity index 100% rename from examples/USER/hma/log.6Nov18.hma.g++.4 rename to examples/USER/misc/hma/log.6Nov18.hma.g++.4 diff --git a/src/USER-HMA/compute_hma.cpp b/src/USER-MISC/compute_hma.cpp similarity index 100% rename from src/USER-HMA/compute_hma.cpp rename to src/USER-MISC/compute_hma.cpp diff --git a/src/USER-HMA/compute_hma.h b/src/USER-MISC/compute_hma.h similarity index 100% rename from src/USER-HMA/compute_hma.h rename to src/USER-MISC/compute_hma.h -- GitLab From fe5e952319a082deb831be24d27e425b8121aca8 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 19 Jun 2019 19:17:20 -0400 Subject: [PATCH 058/469] Fix docs issues --- doc/src/compute_hma.txt | 2 +- doc/utils/sphinx-config/false_positives.txt | 1 + 2 files changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index 58934be054..581e4afeb4 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -51,7 +51,7 @@ HMA should not be used if atoms are expected to diffuse. It is also restricted to simulations in the NVT ensemble. Computation of the heat capacity with this compute is presently restricted to -the "lj_smooth_linear"_lj_smooth_linear.html pair style. Use with other pair +the "pair_lj_smooth_linear"_pair_lj_smooth_linear.html pair style. Use with other pair styles requires an additional method (single2nd) to be implemented in the corresponding Pair class. Computation of the energy and pressure does not have this restriction. diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 3166544b10..07a0e4eaf0 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -518,6 +518,7 @@ Dcut de dE De +decorrelation debye Debye Decius -- GitLab From 128d021c10c2c0d4fd54bd81d7c49f82bf2dc0a9 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Thu, 20 Jun 2019 13:13:13 -0500 Subject: [PATCH 059/469] Update to latest prototype for SimulatorModel interface --- src/KIM/kim_style.cpp | 11 ++++++----- 1 file changed, 6 insertions(+), 5 deletions(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index 814da6b188..b67360ce82 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -68,8 +68,9 @@ #include "variable.h" #include "fix_store_kim.h" +//@@@@@ Need to switch to c-bindings when they are available. #include "KIM_SimulatorModel.hpp" - +//@@@@@ using namespace LAMMPS_NS; @@ -131,6 +132,7 @@ void KimStyle::do_init(char *model) fix_store->setptr("units_to", (void *) units_to); int kimerror; + // @@@@@ switch to c-bindings when they are available KIM::SimulatorModel * simulatorModel; kimerror = KIM::SimulatorModel::Create(model,&simulatorModel); @@ -176,7 +178,7 @@ void KimStyle::do_init(char *model) // reset template map. - simulatorModel->ClearTemplateMap(); + simulatorModel->OpenAndInitializeTemplateMap(); } /* ---------------------------------------------------------------------- */ @@ -206,8 +208,7 @@ void KimStyle::do_defn(int narg, char **arg) const std::string *sim_name, *sim_version; std::string atom_type_sym_list; - simulatorModel->GetSimulatorName(&sim_name); - simulatorModel->GetSimulatorVersion(&sim_version); + simulatorModel->GetSimulatorNameAndVersion(&sim_name, &sim_version); if (comm->me == 0) { std::string mesg("Using KIM Simulator Model : "); @@ -292,7 +293,7 @@ void KimStyle::do_defn(int narg, char **arg) if (sim_model_idx < 0) error->all(FLERR,"KIM Simulator Model has no Model definition"); - simulatorModel->ClearTemplateMap(); + simulatorModel->OpenAndInitializeTemplateMap(); } else { -- GitLab From 0613c10395ab286a0dd7c82e1f0ab092bdacbb5a Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Thu, 20 Jun 2019 16:45:45 -0500 Subject: [PATCH 060/469] Work on kim_style for latest definition prototype --- examples/kim/in.kim.lj.simulator_model | 9 +- src/KIM/kim_style.cpp | 288 ++++++++++++++++--------- src/KIM/kim_style.h | 34 ++- 3 files changed, 218 insertions(+), 113 deletions(-) diff --git a/examples/kim/in.kim.lj.simulator_model b/examples/kim/in.kim.lj.simulator_model index 15b26c3c64..01ee5aa64c 100644 --- a/examples/kim/in.kim.lj.simulator_model +++ b/examples/kim/in.kim.lj.simulator_model @@ -14,12 +14,11 @@ variable xx equal 20*$x variable yy equal 20*$y variable zz equal 20*$z -units metal -atom_style atomic +echo both +#kim_style model LennardJones_Ar metal +kim_style model Sim_LAMMPS_LJcut_AkersonElliott_Alchemy_PbAu real unit_conversion_mode newton on -kim_style init LennardJones_Ar - lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} create_box 1 box @@ -28,7 +27,7 @@ create_atoms 1 box #pair_style lj/cut 8.1500 #pair_coeff 1 1 0.0104 3.4000 -kim_style define Ar +kim_style setup Au mass 1 39.95 velocity all create 200.0 232345 loop geom diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index b67360ce82..fcc3f33aa2 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -51,7 +51,7 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Designed for use with the kim-api-2.0.2 (and newer) package + Designed for use with the kim-api-2.1.0 (and newer) package ------------------------------------------------------------------------- */ #include @@ -68,6 +68,9 @@ #include "variable.h" #include "fix_store_kim.h" +extern "C" { +#include "KIM_SimulatorHeaders.h" +} //@@@@@ Need to switch to c-bindings when they are available. #include "KIM_SimulatorModel.hpp" //@@@@@ @@ -78,42 +81,188 @@ using namespace LAMMPS_NS; void KimStyle::command(int narg, char **arg) { - if (narg < 2) error->all(FLERR,"Illegal kim_style command"); - - units_from = NULL; - units_to = NULL; + if ((narg < 2) || (narg > 4)) error->all(FLERR,"Illegal kim_style command"); - if (strcmp(arg[0],"init") == 0) { + if (strcmp(arg[0],"model") == 0) { if (domain->box_exist) - error->all(FLERR,"Must use 'kim_style init' command before " + error->all(FLERR,"Must use 'kim_style model' command before " "simulation box is defined"); - int len = strlen(arg[1])+1; - char *model = new char[len]; - strcpy(model,arg[1]); - - int args_done = do_units(narg-2,arg-2); - if (narg > (args_done + 2)) - error->all(FLERR,"Illegal kim_style command"); - do_init(model); - do_variables(); - } else if (strcmp(arg[0],"define") == 0) { + int len1 = strlen(arg[1])+1; + int len2 = strlen(arg[2])+1; + char *model_name = new char[len1]; strcpy(model_name,arg[1]); + char *user_units = new char[len2]; strcpy(user_units,arg[2]); + if (narg == 4) { + if (strcmp(arg[3],"unit_conversion_mode")==0) unit_conversion_mode = true; + else { error->all(FLERR,"Illegal kim_style command"); } + } else unit_conversion_mode = false; + + char *model_units; + determine_model_type_and_units(model_name, user_units, &model_units); + + do_init(model_name, user_units, model_units); + if (unit_conversion_mode) do_variables(user_units, model_units); + } else if (strcmp(arg[0],"setup") == 0) { if (!domain->box_exist) - error->all(FLERR,"Must use 'kim_style define' command after " + error->all(FLERR,"Must use 'kim_style setup' command after " "simulation box is defined"); - int args_done = do_units(narg-1,arg-1); - do_defn(narg - (args_done+1),arg + (args_done+1)); - } else if (strcmp(arg[0],"unit_variables") == 0) { - int args_done = do_units(narg,arg); - if (narg > args_done) - error->all(FLERR,"Illegal kim_style command"); - do_variables(); + do_setup(narg-1,++arg); } else error->all(FLERR,"Illegal kim_style command"); } +/* ---------------------------------------------------------------------- */ +namespace { +void get_kim_unit_names( + char const * const system, + KIM_LengthUnit & lengthUnit, + KIM_EnergyUnit & energyUnit, + KIM_ChargeUnit & chargeUnit, + KIM_TemperatureUnit & temperatureUnit, + KIM_TimeUnit & timeUnit, + Error * error) +{ + if ((strcmp(system,"real")==0)) { + lengthUnit = KIM_LENGTH_UNIT_A; + energyUnit = KIM_ENERGY_UNIT_kcal_mol; + chargeUnit = KIM_CHARGE_UNIT_e; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_fs; + } else if ((strcmp(system,"metal")==0)) { + lengthUnit = KIM_LENGTH_UNIT_A; + energyUnit = KIM_ENERGY_UNIT_eV; + chargeUnit = KIM_CHARGE_UNIT_e; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_ps; + } else if ((strcmp(system,"si")==0)) { + lengthUnit = KIM_LENGTH_UNIT_m; + energyUnit = KIM_ENERGY_UNIT_J; + chargeUnit = KIM_CHARGE_UNIT_C; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_s; + } else if ((strcmp(system,"cgs")==0)) { + lengthUnit = KIM_LENGTH_UNIT_cm; + energyUnit = KIM_ENERGY_UNIT_erg; + chargeUnit = KIM_CHARGE_UNIT_statC; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_s; + } else if ((strcmp(system,"electron")==0)) { + lengthUnit = KIM_LENGTH_UNIT_Bohr; + energyUnit = KIM_ENERGY_UNIT_Hartree; + chargeUnit = KIM_CHARGE_UNIT_e; + temperatureUnit = KIM_TEMPERATURE_UNIT_K; + timeUnit = KIM_TIME_UNIT_fs; + } else if ((strcmp(system,"lj")==0)) { + error->all(FLERR,"LAMMPS unit_style lj not supported by KIM models"); + } else { + error->all(FLERR,"Unknown unit_style"); + } +} +} // namespace +void KimStyle::determine_model_type_and_units(char * model_name, + char * user_units, + char ** model_units) +{ + KIM_LengthUnit lengthUnit; + KIM_EnergyUnit energyUnit; + KIM_ChargeUnit chargeUnit; + KIM_TemperatureUnit temperatureUnit; + KIM_TimeUnit timeUnit; + int units_accepted; + KIM_Model * kim_MO; + + get_kim_unit_names(user_units, lengthUnit, energyUnit, + chargeUnit, temperatureUnit, timeUnit, error); + int kim_error = KIM_Model_Create(KIM_NUMBERING_zeroBased, + lengthUnit, + energyUnit, + chargeUnit, + temperatureUnit, + timeUnit, + model_name, + &units_accepted, + &kim_MO); + + if (!kim_error) // model is an MO + { + model_type = MO; + KIM_Model_Destroy(&kim_MO); + + if (units_accepted) + { + int len=strlen(user_units); + *model_units = new char[len]; strcpy(*model_units,user_units); + return; + } + else if (unit_conversion_mode) + { + int const num_systems = 5; + char const * const systems[num_systems] + = {"metal", "real", "si", "cgs", "electron"}; + for (int i=0; i < num_systems; ++i) + { + get_kim_unit_names(systems[i], lengthUnit, energyUnit, + chargeUnit, temperatureUnit, timeUnit, error); + kim_error = KIM_Model_Create(KIM_NUMBERING_zeroBased, + lengthUnit, + energyUnit, + chargeUnit, + temperatureUnit, + timeUnit, + model_name, + &units_accepted, + &kim_MO); + KIM_Model_Destroy(&kim_MO); + if (units_accepted) + { + int len=strlen(systems[i]); + *model_units = new char[len]; strcpy(*model_units,systems[i]); + return; + } + } + error->all(FLERR,"KIM Model does not support any lammps unit system"); + } + else + { + error->all(FLERR,"KIM Model does not support the requested unit system"); + } + } + + KIM::SimulatorModel * kim_SM; + kim_error = KIM::SimulatorModel::Create(model_name, &kim_SM); + if (kim_error) + { + error->all(FLERR,"KIM model name not found"); + } + model_type = SM; + + int sim_fields; + int sim_lines; + std::string const * sim_field; + std::string const * sim_value; + kim_SM->GetNumberOfSimulatorFields(&sim_fields); + kim_SM->CloseTemplateMap(); + for (int i=0; i < sim_fields; ++i) { + kim_SM->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + + if (*sim_field == "units") { + kim_SM->GetSimulatorFieldLine(i,0,&sim_value); + int len=(*sim_value).length(); + *model_units = new char[len]; strcpy(*model_units,sim_value->c_str()); + break; + } + } + KIM::SimulatorModel::Destroy(&kim_SM); + + if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) + { + error->all(FLERR,"Incompatible units for KIM Simulator Model"); + } +} + + /* ---------------------------------------------------------------------- */ -void KimStyle::do_init(char *model) +void KimStyle::do_init(char *model_name, char *user_units, char* model_units) { // create storage proxy fix. delete existing fix, if needed. @@ -127,14 +276,20 @@ void KimStyle::do_init(char *model) ifix = modify->find_fix("KIM_MODEL_STORE"); FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; - fix_store->setptr("model_name", (void *) model); - fix_store->setptr("units_from", (void *) units_from); - fix_store->setptr("units_to", (void *) units_to); + fix_store->setptr("model_name", (void *) model_name); + fix_store->setptr("user_units", (void *) user_units); + fix_store->setptr("model_units", (void *) model_units); + + // set units + + std::string cmd("units "); + cmd += model_units; + input->one(cmd.c_str()); int kimerror; // @@@@@ switch to c-bindings when they are available KIM::SimulatorModel * simulatorModel; - kimerror = KIM::SimulatorModel::Create(model,&simulatorModel); + kimerror = KIM::SimulatorModel::Create(model_name,&simulatorModel); // not a Kim Simulator Model; nothing else to do here. @@ -150,19 +305,6 @@ void KimStyle::do_init(char *model) const std::string *sim_field, *sim_value; simulatorModel->GetNumberOfSimulatorFields(&sim_fields); - // set units - - for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "units") { - simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); - std::string cmd("units "); - cmd += *sim_value; - input->one(cmd.c_str()); - break; - } - } - // init model for (int i=0; i < sim_fields; ++i) { @@ -183,7 +325,7 @@ void KimStyle::do_init(char *model) /* ---------------------------------------------------------------------- */ -void KimStyle::do_defn(int narg, char **arg) +void KimStyle::do_setup(int narg, char **arg) { if (narg != atom->ntypes) error->all(FLERR,"Illegal kim_style command"); @@ -201,7 +343,7 @@ void KimStyle::do_defn(int narg, char **arg) FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; model = (char *)fix_store->getptr("model_name"); simulatorModel = (KIM::SimulatorModel *)fix_store->getptr("simulator_model"); - } else error->all(FLERR,"Must use 'kim_style init' before 'kim_style define'"); + } else error->all(FLERR,"Must use 'kim_style model' before 'kim_style setup'"); if (simulatorModel) { @@ -317,62 +459,11 @@ void KimStyle::do_defn(int narg, char **arg) /* ---------------------------------------------------------------------- */ -int KimStyle::do_units(int narg, char **arg) -{ - // retrieve custom units setting if kim_style had been called before - - int ifix = modify->find_fix("KIM_MODEL_STORE"); - FixStoreKIM *fix_store = NULL; - if (ifix >= 0) { - fix_store = (FixStoreKIM *) modify->fix[ifix]; - units_from = (char *)fix_store->getptr("units_from"); - units_to = (char *)fix_store->getptr("units_to"); - } - - if (narg < 2) return 0; - int iarg=0; - for (iarg = 0; iarg < narg; iarg += 2) { - if (strcmp(arg[iarg],"unit_variables") == 0) { - if (narg > iarg+2) error->all(FLERR,"Illegal kim_style command"); - if (strcmp(arg[iarg+1],"NULL") == 0) { - delete[] units_to; - units_to = NULL; - } else { - int len = strlen(arg[iarg+1])+1; - delete[] units_to; - units_to = new char[len]; - strcpy(units_to,arg[iarg+1]); - } - if (fix_store) fix_store->setptr("units_to",units_to); - } else if (strcmp(arg[iarg],"unit_from") == 0) { - if (narg > iarg+2) error->all(FLERR,"Illegal kim_style command"); - if (strcmp(arg[iarg+1],"NULL") == 0) { - delete[] units_from; - units_from = NULL; - } else { - int len = strlen(arg[iarg+1])+1; - delete[] units_from; - units_from = new char[len]; - strcpy(units_from,arg[iarg+1]); - } - if (fix_store) fix_store->setptr("units_from",units_from); - } else return iarg; - } - return iarg; -} - -/* ---------------------------------------------------------------------- */ - -void KimStyle::do_variables() +void KimStyle::do_variables(char *user_units, char *model_units) { - char *from, *to; + char *from = user_units, *to = model_units; Variable *variable = input->variable; - if (units_from) from = units_from; - else from = update->unit_style; - if (units_to) to = units_to; - else to = update->unit_style; - // refuse convertion from or to reduced units if ((strcmp(from,"lj") == 0) || (strcmp(to,"lj") == 0)) @@ -381,6 +472,7 @@ void KimStyle::do_variables() // get index to internal style variables. create, if needed. // default to conversion factor 1.0 for newly created variables + // @@@@@@ below needs to be updated to use Ellad's luc. int v_length, v_mass, v_time; char *args[3]; args[1] = (char *)"internal"; diff --git a/src/KIM/kim_style.h b/src/KIM/kim_style.h index 36084183ee..b7ff47404f 100644 --- a/src/KIM/kim_style.h +++ b/src/KIM/kim_style.h @@ -51,7 +51,7 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Designed for use with the kim-api-2.0.2 (and newer) package + Designed for use with the kim-api-2.1.0 (and newer) package ------------------------------------------------------------------------- */ #ifdef COMMAND_CLASS @@ -72,12 +72,14 @@ class KimStyle : protected Pointers { KimStyle(class LAMMPS *lmp) : Pointers(lmp) {}; void command(int, char **); private: - char *units_from; - char *units_to; - void do_init(char *); - void do_defn(int, char **); - int do_units(int, char **); - void do_variables(); + enum model_type_enum {MO, SM}; + model_type_enum model_type; + bool unit_conversion_mode; + + void determine_model_type_and_units(char *, char *, char **); + void do_init(char *, char *, char *); + void do_setup(int, char **); + void do_variables(char*, char*); }; } @@ -91,15 +93,27 @@ E: Illegal kim_style command Incorrect number or kind of arguments to kim_style. -E: Must use 'kim_style init' command before simulation box is defined +E: Must use 'kim_style model' command before simulation box is defined Self-explanatory. -E: Must use 'kim_style define' command after simulation box is defined +E: Must use 'kim_style setup' command after simulation box is defined Self-explanatory. -E: Must use 'kim_style init' command before 'kim_style define' +E: Must use 'kim_style model' command before 'kim_style setup' + +Self-explanatory. + +E: KIM Model does not support the requested unit system + +Self-explanatory. + +E: KIM Model does not support any lammps unit system + +Self-explanatory. + +E: KIM model name not found Self-explanatory. -- GitLab From 1bb18ebde4dec8dab43741b4b9c005f732200214 Mon Sep 17 00:00:00 2001 From: Rupert Nash Date: Fri, 21 Jun 2019 15:50:52 +0100 Subject: [PATCH 061/469] rollback unneeded change to Makefile.list per review --- src/Makefile.list | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/Makefile.list b/src/Makefile.list index 6e4c9726a6..65bbebca09 100644 --- a/src/Makefile.list +++ b/src/Makefile.list @@ -7,9 +7,9 @@ SHELL = /bin/sh ROOT = lmp EXE = $(ROOT)_$@ -SRC = angle.cpp angle_charmm.cpp angle_cosine.cpp angle_cosine_delta.cpp angle_cosine_squared.cpp angle_harmonic.cpp angle_hybrid.cpp angle_table.cpp atom.cpp atom_vec.cpp atom_vec_angle.cpp atom_vec_atomic.cpp atom_vec_bond.cpp atom_vec_charge.cpp atom_vec_full.cpp atom_vec_hybrid.cpp atom_vec_molecular.cpp bond.cpp bond_fene.cpp bond_fene_expand.cpp bond_harmonic.cpp bond_hybrid.cpp bond_morse.cpp bond_nonlinear.cpp bond_quartic.cpp bond_table.cpp change_box.cpp comm.cpp compute.cpp compute_angle_local.cpp compute_bond_local.cpp compute_centro_atom.cpp compute_cna_atom.cpp compute_com.cpp compute_com_molecule.cpp compute_coord_atom.cpp compute_dihedral_local.cpp compute_displace_atom.cpp compute_erotate_sphere.cpp compute_group_group.cpp compute_gyration.cpp compute_gyration_molecule.cpp compute_heat_flux.cpp compute_improper_local.cpp compute_ke.cpp compute_ke_atom.cpp compute_momentum.cpp compute_msd.cpp compute_msd_molecule.cpp compute_pair_local.cpp compute_pe.cpp compute_pe_atom.cpp compute_pressure.cpp compute_property_atom.cpp compute_property_local.cpp compute_property_molecule.cpp compute_rdf.cpp compute_reduce.cpp compute_reduce_region.cpp compute_stress_atom.cpp compute_temp.cpp compute_temp_com.cpp compute_temp_deform.cpp compute_temp_partial.cpp compute_temp_profile.cpp compute_temp_ramp.cpp compute_temp_region.cpp compute_temp_sphere.cpp create_atoms.cpp create_box.cpp delete_atoms.cpp delete_bonds.cpp dihedral.cpp dihedral_charmm.cpp dihedral_harmonic.cpp dihedral_helix.cpp dihedral_hybrid.cpp dihedral_multi_harmonic.cpp dihedral_opls.cpp displace_atoms.cpp displace_box.cpp domain.cpp dump.cpp dump_atom.cpp dump_cfg.cpp dump_custom.cpp dump_dcd.cpp dump_local.cpp dump_xyz.cpp error.cpp ewald.cpp fft3d.cpp fft3d_wrap.cpp finish.cpp fix.cpp fix_adapt.cpp fix_addforce.cpp fix_ave_atom.cpp fix_ave_correlate.cpp fix_ave_histo.cpp fix_ave_spatial.cpp fix_ave_time.cpp fix_aveforce.cpp fix_bond_break.cpp fix_bond_create.cpp fix_bond_swap.cpp fix_box_relax.cpp fix_deform.cpp fix_deposit.cpp fix_drag.cpp fix_dt_reset.cpp fix_efield.cpp fix_enforce2d.cpp fix_evaporate.cpp fix_gravity.cpp fix_heat.cpp fix_indent.cpp fix_langevin.cpp fix_lineforce.cpp fix_minimize.cpp fix_momentum.cpp fix_move.cpp fix_nh.cpp fix_nh_sphere.cpp fix_nph.cpp fix_nph_sphere.cpp fix_npt.cpp fix_npt_sphere.cpp fix_nve.cpp fix_nve_limit.cpp fix_nve_noforce.cpp fix_nve_sphere.cpp fix_nvt.cpp fix_nvt_sllod.cpp fix_nvt_sphere.cpp fix_orient_fcc.cpp fix_planeforce.cpp fix_press_berendsen.cpp fix_print.cpp fix_qeq_comb.cpp fix_recenter.cpp fix_respa.cpp fix_rigid.cpp fix_rigid_nve.cpp fix_rigid_nvt.cpp fix_setforce.cpp fix_shake.cpp fix_shear_history.cpp fix_spring.cpp fix_spring_rg.cpp fix_spring_self.cpp fix_store_force.cpp fix_store_state.cpp fix_temp_berendsen.cpp fix_temp_rescale.cpp fix_thermal_conductivity.cpp fix_tmd.cpp fix_ttm.cpp fix_viscosity.cpp fix_viscous.cpp fix_wall.cpp fix_wall_harmonic.cpp fix_wall_lj126.cpp fix_wall_lj93.cpp fix_wall_reflect.cpp fix_wall_region.cpp force.cpp group.cpp improper.cpp improper_cvff.cpp improper_harmonic.cpp improper_hybrid.cpp input.cpp integrate.cpp kspace.cpp lammps.cpp lattice.cpp library.cpp main.cpp memory.cpp min.cpp min_cg.cpp min_hftn.cpp min_linesearch.cpp min_sd.cpp minimize.cpp modify.cpp neigh_bond.cpp neigh_derive.cpp neigh_full.cpp neigh_gran.cpp neigh_half_bin.cpp neigh_half_multi.cpp neigh_half_nsq.cpp neigh_list.cpp neigh_request.cpp neigh_respa.cpp neigh_stencil.cpp neighbor.cpp output.cpp pack.cpp pair.cpp pair_airebo.cpp pair_born_coul_long.cpp pair_buck.cpp pair_buck_coul_cut.cpp pair_buck_coul_long.cpp pair_comb.cpp pair_coul_cut.cpp pair_coul_debye.cpp pair_coul_long.cpp pair_dpd.cpp pair_dpd_tstat.cpp pair_eam.cpp pair_eam_alloy.cpp pair_eam_fs.cpp pair_eim.cpp pair_hybrid.cpp pair_hybrid_overlay.cpp pair_lj96_cut.cpp pair_lj_charmm_coul_charmm.cpp pair_lj_charmm_coul_charmm_implicit.cpp pair_lj_charmm_coul_long.cpp pair_lj_cut.cpp pair_lj_cut_coul_cut.cpp pair_lj_cut_coul_debye.cpp pair_lj_cut_coul_long.cpp pair_lj_cut_coul_long_tip4p.cpp pair_lj_expand.cpp pair_lj_gromacs.cpp pair_lj_gromacs_coul_gromacs.cpp pair_lj_smooth.cpp pair_morse.cpp pair_soft.cpp pair_sw.cpp pair_table.cpp pair_tersoff.cpp pair_tersoff_zbl.cpp pair_yukawa.cpp pppm.cpp pppm_tip4p.cpp random_mars.cpp random_park.cpp read_data.cpp read_restart.cpp region.cpp region_block.cpp region_cone.cpp region_cylinder.cpp region_intersect.cpp region_plane.cpp region_prism.cpp region_sphere.cpp region_union.cpp remap.cpp remap_wrap.cpp replicate.cpp respa.cpp run.cpp set.cpp shell.cpp special.cpp temper.cpp thermo.cpp timer.cpp universe.cpp update.cpp variable.cpp velocity.cpp verlet.cpp write_restart.cpp +SRC = angle.cpp angle_charmm.cpp angle_cosine.cpp angle_cosine_delta.cpp angle_cosine_squared.cpp angle_harmonic.cpp angle_hybrid.cpp angle_table.cpp atom.cpp atom_vec.cpp atom_vec_angle.cpp atom_vec_atomic.cpp atom_vec_bond.cpp atom_vec_charge.cpp atom_vec_full.cpp atom_vec_hybrid.cpp atom_vec_molecular.cpp bond.cpp bond_fene.cpp bond_fene_expand.cpp bond_harmonic.cpp bond_hybrid.cpp bond_morse.cpp bond_nonlinear.cpp bond_quartic.cpp bond_table.cpp change_box.cpp comm.cpp compute.cpp compute_angle_local.cpp compute_bond_local.cpp compute_centro_atom.cpp compute_cna_atom.cpp compute_com.cpp compute_com_molecule.cpp compute_coord_atom.cpp compute_dihedral_local.cpp compute_displace_atom.cpp compute_erotate_sphere.cpp compute_group_group.cpp compute_gyration.cpp compute_gyration_molecule.cpp compute_heat_flux.cpp compute_improper_local.cpp compute_ke.cpp compute_ke_atom.cpp compute_msd.cpp compute_msd_molecule.cpp compute_pair_local.cpp compute_pe.cpp compute_pe_atom.cpp compute_pressure.cpp compute_property_atom.cpp compute_property_local.cpp compute_property_molecule.cpp compute_rdf.cpp compute_reduce.cpp compute_reduce_region.cpp compute_stress_atom.cpp compute_temp.cpp compute_temp_com.cpp compute_temp_deform.cpp compute_temp_partial.cpp compute_temp_profile.cpp compute_temp_ramp.cpp compute_temp_region.cpp compute_temp_sphere.cpp create_atoms.cpp create_box.cpp delete_atoms.cpp delete_bonds.cpp dihedral.cpp dihedral_charmm.cpp dihedral_harmonic.cpp dihedral_helix.cpp dihedral_hybrid.cpp dihedral_multi_harmonic.cpp dihedral_opls.cpp displace_atoms.cpp displace_box.cpp domain.cpp dump.cpp dump_atom.cpp dump_cfg.cpp dump_custom.cpp dump_dcd.cpp dump_local.cpp dump_xyz.cpp error.cpp ewald.cpp fft3d.cpp fft3d_wrap.cpp finish.cpp fix.cpp fix_adapt.cpp fix_addforce.cpp fix_ave_atom.cpp fix_ave_correlate.cpp fix_ave_histo.cpp fix_ave_spatial.cpp fix_ave_time.cpp fix_aveforce.cpp fix_bond_break.cpp fix_bond_create.cpp fix_bond_swap.cpp fix_box_relax.cpp fix_deform.cpp fix_deposit.cpp fix_drag.cpp fix_dt_reset.cpp fix_efield.cpp fix_enforce2d.cpp fix_evaporate.cpp fix_gravity.cpp fix_heat.cpp fix_indent.cpp fix_langevin.cpp fix_lineforce.cpp fix_minimize.cpp fix_momentum.cpp fix_move.cpp fix_nh.cpp fix_nh_sphere.cpp fix_nph.cpp fix_nph_sphere.cpp fix_npt.cpp fix_npt_sphere.cpp fix_nve.cpp fix_nve_limit.cpp fix_nve_noforce.cpp fix_nve_sphere.cpp fix_nvt.cpp fix_nvt_sllod.cpp fix_nvt_sphere.cpp fix_orient_fcc.cpp fix_planeforce.cpp fix_press_berendsen.cpp fix_print.cpp fix_qeq_comb.cpp fix_recenter.cpp fix_respa.cpp fix_rigid.cpp fix_rigid_nve.cpp fix_rigid_nvt.cpp fix_setforce.cpp fix_shake.cpp fix_shear_history.cpp fix_spring.cpp fix_spring_rg.cpp fix_spring_self.cpp fix_store_force.cpp fix_store_state.cpp fix_temp_berendsen.cpp fix_temp_rescale.cpp fix_thermal_conductivity.cpp fix_tmd.cpp fix_ttm.cpp fix_viscosity.cpp fix_viscous.cpp fix_wall.cpp fix_wall_harmonic.cpp fix_wall_lj126.cpp fix_wall_lj93.cpp fix_wall_reflect.cpp fix_wall_region.cpp force.cpp group.cpp improper.cpp improper_cvff.cpp improper_harmonic.cpp improper_hybrid.cpp input.cpp integrate.cpp kspace.cpp lammps.cpp lattice.cpp library.cpp main.cpp memory.cpp min.cpp min_cg.cpp min_hftn.cpp min_linesearch.cpp min_sd.cpp minimize.cpp modify.cpp neigh_bond.cpp neigh_derive.cpp neigh_full.cpp neigh_gran.cpp neigh_half_bin.cpp neigh_half_multi.cpp neigh_half_nsq.cpp neigh_list.cpp neigh_request.cpp neigh_respa.cpp neigh_stencil.cpp neighbor.cpp output.cpp pack.cpp pair.cpp pair_airebo.cpp pair_born_coul_long.cpp pair_buck.cpp pair_buck_coul_cut.cpp pair_buck_coul_long.cpp pair_comb.cpp pair_coul_cut.cpp pair_coul_debye.cpp pair_coul_long.cpp pair_dpd.cpp pair_dpd_tstat.cpp pair_eam.cpp pair_eam_alloy.cpp pair_eam_fs.cpp pair_eim.cpp pair_hybrid.cpp pair_hybrid_overlay.cpp pair_lj96_cut.cpp pair_lj_charmm_coul_charmm.cpp pair_lj_charmm_coul_charmm_implicit.cpp pair_lj_charmm_coul_long.cpp pair_lj_cut.cpp pair_lj_cut_coul_cut.cpp pair_lj_cut_coul_debye.cpp pair_lj_cut_coul_long.cpp pair_lj_cut_coul_long_tip4p.cpp pair_lj_expand.cpp pair_lj_gromacs.cpp pair_lj_gromacs_coul_gromacs.cpp pair_lj_smooth.cpp pair_morse.cpp pair_soft.cpp pair_sw.cpp pair_table.cpp pair_tersoff.cpp pair_tersoff_zbl.cpp pair_yukawa.cpp pppm.cpp pppm_tip4p.cpp random_mars.cpp random_park.cpp read_data.cpp read_restart.cpp region.cpp region_block.cpp region_cone.cpp region_cylinder.cpp region_intersect.cpp region_plane.cpp region_prism.cpp region_sphere.cpp region_union.cpp remap.cpp remap_wrap.cpp replicate.cpp respa.cpp run.cpp set.cpp shell.cpp special.cpp temper.cpp thermo.cpp timer.cpp universe.cpp update.cpp variable.cpp velocity.cpp verlet.cpp write_restart.cpp -INC = angle.h angle_charmm.h angle_cosine.h angle_cosine_delta.h angle_cosine_squared.h angle_harmonic.h angle_hybrid.h angle_table.h atom.h atom_vec.h atom_vec_angle.h atom_vec_atomic.h atom_vec_bond.h atom_vec_charge.h atom_vec_full.h atom_vec_hybrid.h atom_vec_molecular.h bond.h bond_fene.h bond_fene_expand.h bond_harmonic.h bond_hybrid.h bond_morse.h bond_nonlinear.h bond_quartic.h bond_table.h change_box.h comm.h compute.h compute_angle_local.h compute_bond_local.h compute_centro_atom.h compute_cna_atom.h compute_com.h compute_com_molecule.h compute_coord_atom.h compute_dihedral_local.h compute_displace_atom.h compute_erotate_sphere.h compute_group_group.h compute_gyration.h compute_gyration_molecule.h compute_heat_flux.h compute_improper_local.h compute_ke.h compute_ke_atom.h compute_momentum.h compute_msd.h compute_msd_molecule.h compute_pair_local.h compute_pe.h compute_pe_atom.h compute_pressure.h compute_property_atom.h compute_property_local.h compute_property_molecule.h compute_rdf.h compute_reduce.h compute_reduce_region.h compute_stress_atom.h compute_temp.h compute_temp_com.h compute_temp_deform.h compute_temp_partial.h compute_temp_profile.h compute_temp_ramp.h compute_temp_region.h compute_temp_sphere.h create_atoms.h create_box.h delete_atoms.h delete_bonds.h dihedral.h dihedral_charmm.h dihedral_harmonic.h dihedral_helix.h dihedral_hybrid.h dihedral_multi_harmonic.h dihedral_opls.h displace_atoms.h displace_box.h domain.h dump.h dump_atom.h dump_cfg.h dump_custom.h dump_dcd.h dump_local.h dump_xyz.h error.h ewald.h fft3d.h fft3d_wrap.h finish.h fix.h fix_adapt.h fix_addforce.h fix_ave_atom.h fix_ave_correlate.h fix_ave_histo.h fix_ave_spatial.h fix_ave_time.h fix_aveforce.h fix_bond_break.h fix_bond_create.h fix_bond_swap.h fix_box_relax.h fix_deform.h fix_deposit.h fix_drag.h fix_dt_reset.h fix_efield.h fix_enforce2d.h fix_evaporate.h fix_gravity.h fix_heat.h fix_indent.h fix_langevin.h fix_lineforce.h fix_minimize.h fix_momentum.h fix_move.h fix_nh.h fix_nh_sphere.h fix_nph.h fix_nph_sphere.h fix_npt.h fix_npt_sphere.h fix_nve.h fix_nve_limit.h fix_nve_noforce.h fix_nve_sphere.h fix_nvt.h fix_nvt_sllod.h fix_nvt_sphere.h fix_orient_fcc.h fix_planeforce.h fix_press_berendsen.h fix_print.h fix_qeq_comb.h fix_recenter.h fix_respa.h fix_rigid.h fix_rigid_nve.h fix_rigid_nvt.h fix_setforce.h fix_shake.h fix_shear_history.h fix_spring.h fix_spring_rg.h fix_spring_self.h fix_store_force.h fix_store_state.h fix_temp_berendsen.h fix_temp_rescale.h fix_thermal_conductivity.h fix_tmd.h fix_ttm.h fix_viscosity.h fix_viscous.h fix_wall.h fix_wall_harmonic.h fix_wall_lj126.h fix_wall_lj93.h fix_wall_reflect.h fix_wall_region.h force.h group.h improper.h improper_cvff.h improper_harmonic.h improper_hybrid.h input.h integrate.h kspace.h lammps.h lattice.h library.h math_extra.h memory.h min.h min_cg.h min_hftn.h min_linesearch.h min_sd.h minimize.h modify.h neigh_list.h neigh_request.h neighbor.h output.h pack.h pair.h pair_airebo.h pair_born_coul_long.h pair_buck.h pair_buck_coul_cut.h pair_buck_coul_long.h pair_comb.h pair_coul_cut.h pair_coul_debye.h pair_coul_long.h pair_dpd.h pair_dpd_tstat.h pair_eam.h pair_eam_alloy.h pair_eam_fs.h pair_eim.h pair_hybrid.h pair_hybrid_overlay.h pair_lj96_cut.h pair_lj_charmm_coul_charmm.h pair_lj_charmm_coul_charmm_implicit.h pair_lj_charmm_coul_long.h pair_lj_cut.h pair_lj_cut_coul_cut.h pair_lj_cut_coul_debye.h pair_lj_cut_coul_long.h pair_lj_cut_coul_long_tip4p.h pair_lj_expand.h pair_lj_gromacs.h pair_lj_gromacs_coul_gromacs.h pair_lj_smooth.h pair_morse.h pair_soft.h pair_sw.h pair_table.h pair_tersoff.h pair_tersoff_zbl.h pair_yukawa.h pointers.h pppm.h pppm_tip4p.h random_mars.h random_park.h read_data.h read_restart.h region.h region_block.h region_cone.h region_cylinder.h region_intersect.h region_plane.h region_prism.h region_sphere.h region_union.h remap.h remap_wrap.h replicate.h respa.h run.h set.h shell.h special.h style_angle.h style_atom.h style_bond.h style_command.h style_compute.h style_dihedral.h style_dump.h style_fix.h style_improper.h style_integrate.h style_kspace.h style_minimize.h style_pair.h style_region.h temper.h thermo.h timer.h universe.h update.h variable.h velocity.h verlet.h version.h write_restart.h +INC = angle.h angle_charmm.h angle_cosine.h angle_cosine_delta.h angle_cosine_squared.h angle_harmonic.h angle_hybrid.h angle_table.h atom.h atom_vec.h atom_vec_angle.h atom_vec_atomic.h atom_vec_bond.h atom_vec_charge.h atom_vec_full.h atom_vec_hybrid.h atom_vec_molecular.h bond.h bond_fene.h bond_fene_expand.h bond_harmonic.h bond_hybrid.h bond_morse.h bond_nonlinear.h bond_quartic.h bond_table.h change_box.h comm.h compute.h compute_angle_local.h compute_bond_local.h compute_centro_atom.h compute_cna_atom.h compute_com.h compute_com_molecule.h compute_coord_atom.h compute_dihedral_local.h compute_displace_atom.h compute_erotate_sphere.h compute_group_group.h compute_gyration.h compute_gyration_molecule.h compute_heat_flux.h compute_improper_local.h compute_ke.h compute_ke_atom.h compute_msd.h compute_msd_molecule.h compute_pair_local.h compute_pe.h compute_pe_atom.h compute_pressure.h compute_property_atom.h compute_property_local.h compute_property_molecule.h compute_rdf.h compute_reduce.h compute_reduce_region.h compute_stress_atom.h compute_temp.h compute_temp_com.h compute_temp_deform.h compute_temp_partial.h compute_temp_profile.h compute_temp_ramp.h compute_temp_region.h compute_temp_sphere.h create_atoms.h create_box.h delete_atoms.h delete_bonds.h dihedral.h dihedral_charmm.h dihedral_harmonic.h dihedral_helix.h dihedral_hybrid.h dihedral_multi_harmonic.h dihedral_opls.h displace_atoms.h displace_box.h domain.h dump.h dump_atom.h dump_cfg.h dump_custom.h dump_dcd.h dump_local.h dump_xyz.h error.h ewald.h fft3d.h fft3d_wrap.h finish.h fix.h fix_adapt.h fix_addforce.h fix_ave_atom.h fix_ave_correlate.h fix_ave_histo.h fix_ave_spatial.h fix_ave_time.h fix_aveforce.h fix_bond_break.h fix_bond_create.h fix_bond_swap.h fix_box_relax.h fix_deform.h fix_deposit.h fix_drag.h fix_dt_reset.h fix_efield.h fix_enforce2d.h fix_evaporate.h fix_gravity.h fix_heat.h fix_indent.h fix_langevin.h fix_lineforce.h fix_minimize.h fix_momentum.h fix_move.h fix_nh.h fix_nh_sphere.h fix_nph.h fix_nph_sphere.h fix_npt.h fix_npt_sphere.h fix_nve.h fix_nve_limit.h fix_nve_noforce.h fix_nve_sphere.h fix_nvt.h fix_nvt_sllod.h fix_nvt_sphere.h fix_orient_fcc.h fix_planeforce.h fix_press_berendsen.h fix_print.h fix_qeq_comb.h fix_recenter.h fix_respa.h fix_rigid.h fix_rigid_nve.h fix_rigid_nvt.h fix_setforce.h fix_shake.h fix_shear_history.h fix_spring.h fix_spring_rg.h fix_spring_self.h fix_store_force.h fix_store_state.h fix_temp_berendsen.h fix_temp_rescale.h fix_thermal_conductivity.h fix_tmd.h fix_ttm.h fix_viscosity.h fix_viscous.h fix_wall.h fix_wall_harmonic.h fix_wall_lj126.h fix_wall_lj93.h fix_wall_reflect.h fix_wall_region.h force.h group.h improper.h improper_cvff.h improper_harmonic.h improper_hybrid.h input.h integrate.h kspace.h lammps.h lattice.h library.h math_extra.h memory.h min.h min_cg.h min_hftn.h min_linesearch.h min_sd.h minimize.h modify.h neigh_list.h neigh_request.h neighbor.h output.h pack.h pair.h pair_airebo.h pair_born_coul_long.h pair_buck.h pair_buck_coul_cut.h pair_buck_coul_long.h pair_comb.h pair_coul_cut.h pair_coul_debye.h pair_coul_long.h pair_dpd.h pair_dpd_tstat.h pair_eam.h pair_eam_alloy.h pair_eam_fs.h pair_eim.h pair_hybrid.h pair_hybrid_overlay.h pair_lj96_cut.h pair_lj_charmm_coul_charmm.h pair_lj_charmm_coul_charmm_implicit.h pair_lj_charmm_coul_long.h pair_lj_cut.h pair_lj_cut_coul_cut.h pair_lj_cut_coul_debye.h pair_lj_cut_coul_long.h pair_lj_cut_coul_long_tip4p.h pair_lj_expand.h pair_lj_gromacs.h pair_lj_gromacs_coul_gromacs.h pair_lj_smooth.h pair_morse.h pair_soft.h pair_sw.h pair_table.h pair_tersoff.h pair_tersoff_zbl.h pair_yukawa.h pointers.h pppm.h pppm_tip4p.h random_mars.h random_park.h read_data.h read_restart.h region.h region_block.h region_cone.h region_cylinder.h region_intersect.h region_plane.h region_prism.h region_sphere.h region_union.h remap.h remap_wrap.h replicate.h respa.h run.h set.h shell.h special.h style_angle.h style_atom.h style_bond.h style_command.h style_compute.h style_dihedral.h style_dump.h style_fix.h style_improper.h style_integrate.h style_kspace.h style_minimize.h style_pair.h style_region.h temper.h thermo.h timer.h universe.h update.h variable.h velocity.h verlet.h version.h write_restart.h OBJ = $(SRC:.cpp=.o) -- GitLab From 88994d813aeba181736d7c80f2578e74731238df Mon Sep 17 00:00:00 2001 From: "Ellad B. Tadmor" Date: Fri, 21 Jun 2019 18:38:48 -0500 Subject: [PATCH 062/469] Ignore kim.log in examples/kim --- examples/kim/.gitignore | 1 + 1 file changed, 1 insertion(+) create mode 100644 examples/kim/.gitignore diff --git a/examples/kim/.gitignore b/examples/kim/.gitignore new file mode 100644 index 0000000000..63421e4217 --- /dev/null +++ b/examples/kim/.gitignore @@ -0,0 +1 @@ +/kim.log -- GitLab From 08cee18f3207b6cea777dbbd24e17ca1a1f39ded Mon Sep 17 00:00:00 2001 From: "Ellad B. Tadmor" Date: Fri, 21 Jun 2019 18:39:18 -0500 Subject: [PATCH 063/469] Added code to define unit conversion factors --- src/KIM/kim_style.cpp | 219 ++++--- src/KIM/kim_style.h | 2 + src/KIM/kim_units.cpp | 1411 +++++++++++++++++++++++++++++++++++++++++ src/KIM/kim_units.h | 59 ++ 4 files changed, 1596 insertions(+), 95 deletions(-) create mode 100644 src/KIM/kim_units.cpp create mode 100644 src/KIM/kim_units.h diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index fcc3f33aa2..44d5c411ab 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -56,6 +56,7 @@ #include #include +#include #include "kim_style.h" #include "error.h" #include "atom.h" @@ -67,6 +68,7 @@ #include "input.h" #include "variable.h" #include "fix_store_kim.h" +#include "kim_units.h" extern "C" { #include "KIM_SimulatorHeaders.h" @@ -100,7 +102,6 @@ void KimStyle::command(int narg, char **arg) determine_model_type_and_units(model_name, user_units, &model_units); do_init(model_name, user_units, model_units); - if (unit_conversion_mode) do_variables(user_units, model_units); } else if (strcmp(arg[0],"setup") == 0) { if (!domain->box_exist) error->all(FLERR,"Must use 'kim_style setup' command after " @@ -255,7 +256,10 @@ void KimStyle::determine_model_type_and_units(char * model_name, if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) { - error->all(FLERR,"Incompatible units for KIM Simulator Model"); + std::stringstream mesg; + mesg << "Incompatible units for KIM Simulator Model, required units = " + << *model_units; + error->all(FLERR,mesg.str().c_str()); } } @@ -280,17 +284,43 @@ void KimStyle::do_init(char *model_name, char *user_units, char* model_units) fix_store->setptr("user_units", (void *) user_units); fix_store->setptr("model_units", (void *) model_units); + int kimerror; + // @@@@@ switch to c-bindings when they are available + KIM::SimulatorModel * simulatorModel; + kimerror = KIM::SimulatorModel::Create(model_name,&simulatorModel); + + const std::string *sim_name, *sim_version; + simulatorModel->GetSimulatorNameAndVersion(&sim_name, &sim_version); + + if (*sim_name != "LAMMPS") + error->all(FLERR,"Incompatible KIM Simulator Model"); + + // Begin output to log file + kim_style_log_delimiter("begin","model"); + if (comm->me == 0) { + std::string mesg("# Using KIM Simulator Model : "); + mesg += model_name; + mesg += "\n"; + mesg += "# For Simulator : "; + mesg += *sim_name + " " + *sim_version + "\n"; + mesg += "# Running on : LAMMPS "; + mesg += universe->version; + mesg += "\n"; + mesg += "#\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } + + // Define unit conversion factor variables and print to log + if (unit_conversion_mode) do_variables(user_units, model_units); + // set units std::string cmd("units "); cmd += model_units; input->one(cmd.c_str()); - int kimerror; - // @@@@@ switch to c-bindings when they are available - KIM::SimulatorModel * simulatorModel; - kimerror = KIM::SimulatorModel::Create(model_name,&simulatorModel); - // not a Kim Simulator Model; nothing else to do here. if (kimerror) return; @@ -318,13 +348,36 @@ void KimStyle::do_init(char *model_name, char *user_units, char* model_units) } } - // reset template map. + // End output to log file + kim_style_log_delimiter("end","model"); + // reset template map. simulatorModel->OpenAndInitializeTemplateMap(); } /* ---------------------------------------------------------------------- */ +void KimStyle::kim_style_log_delimiter(std::string begin_end, + std::string model_setup) +{ + if (comm->me == 0) { + std::string mesg; + if ((begin_end == "begin") && (model_setup == "model")) mesg = + "#=== BEGIN kim-style MODEL ==================================\n"; + else if ((begin_end == "begin") && (model_setup == "setup")) mesg = + "#=== BEGIN kim-style SETUP ==================================\n"; + else if ((begin_end == "end") && (model_setup == "model")) mesg = + "#=== END kim-style MODEL ====================================\n\n"; + else if ((begin_end == "end") && (model_setup == "setup")) mesg = + "#=== END kim-style SETUP ====================================\n\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } +} + +/* ---------------------------------------------------------------------- */ + void KimStyle::do_setup(int narg, char **arg) { if (narg != atom->ntypes) @@ -345,30 +398,13 @@ void KimStyle::do_setup(int narg, char **arg) simulatorModel = (KIM::SimulatorModel *)fix_store->getptr("simulator_model"); } else error->all(FLERR,"Must use 'kim_style model' before 'kim_style setup'"); + // Begin output to log file + kim_style_log_delimiter("begin","setup"); + if (simulatorModel) { - const std::string *sim_name, *sim_version; std::string atom_type_sym_list; - simulatorModel->GetSimulatorNameAndVersion(&sim_name, &sim_version); - - if (comm->me == 0) { - std::string mesg("Using KIM Simulator Model : "); - mesg += model; - mesg += "\n"; - mesg += "For Simulator : "; - mesg += *sim_name + " " + *sim_version + "\n"; - mesg += "Running on : LAMMPS "; - mesg += universe->version; - mesg += "\n"; - - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); - } - - if (*sim_name != "LAMMPS") - error->all(FLERR,"Incompatible KIM Simulator Model"); - for (int i = 0; i < narg; i++) atom_type_sym_list += std::string(" ") + arg[i]; @@ -455,6 +491,10 @@ void KimStyle::do_setup(int narg, char **arg) input->one(cmd1.c_str()); input->one(cmd2.c_str()); } + + // End output to log file + kim_style_log_delimiter("end","setup"); + } /* ---------------------------------------------------------------------- */ @@ -464,85 +504,74 @@ void KimStyle::do_variables(char *user_units, char *model_units) char *from = user_units, *to = model_units; Variable *variable = input->variable; - // refuse convertion from or to reduced units + // refuse conversion from or to reduced units if ((strcmp(from,"lj") == 0) || (strcmp(to,"lj") == 0)) error->all(FLERR,"Cannot set up conversion variables for 'lj' units"); // get index to internal style variables. create, if needed. - // default to conversion factor 1.0 for newly created variables - - // @@@@@@ below needs to be updated to use Ellad's luc. - int v_length, v_mass, v_time; + // set conversion factors for newly created variables. + double conversion_factor; + int ier; char *args[3]; + std::string var_str; args[1] = (char *)"internal"; args[2] = (char *)"1.0"; - - args[0] = (char *)"_u_length"; - v_length = variable->find(args[0]); - if (v_length < 0) { - variable->set(3,args); - v_length = variable->find(args[0]); + int v_unit; + int const nunits = 14; + char *units[nunits] = {(char *)"mass", + (char *)"distance", + (char *)"time", + (char *)"energy", + (char *)"velocity", + (char *)"force", + (char *)"torque", + (char *)"temperature", + (char *)"pressure", + (char *)"viscosity", + (char *)"charge", + (char *)"dipole", + (char *)"efield", + (char *)"density"}; + + if (comm->me == 0) { + std::stringstream mesg; + mesg << "# Conversion factors from " << from << " to " << to + << ":" << std::endl; + if (screen) fputs(mesg.str().c_str(),screen); + if (logfile) fputs(mesg.str().c_str(),logfile); } - args[0] = (char *)"_u_mass"; - v_mass = variable->find(args[0]); - if (v_mass < 0) { - variable->set(3,args); - v_mass = variable->find(args[0]); - } - - args[0] = (char *)"_u_time"; - v_time = variable->find(args[0]); - if (v_time < 0) { - variable->set(3,args); - v_time = variable->find(args[0]); - } - - // special case: both unit styles are the same => conversion factor 1.0 - - if (strcmp(from,to) == 0) { - variable->internal_set(v_length,1.0); - variable->internal_set(v_mass,1.0); - variable->internal_set(v_time,1.0); - return; - } - - if (strcmp(from,"real") == 0) { - if (strcmp(to,"metal") == 0) { - variable->internal_set(v_length,1.0); - variable->internal_set(v_mass,1.0); - variable->internal_set(v_time,0.001); - } else { - std::string err("Do not know how to set up conversion variables "); - err += "between '"; - err += from; - err += "' and '"; - err += to; - err += "' units"; - error->all(FLERR,err.c_str()); + for (int i = 0; i < nunits; i++) + { + var_str = std::string("_u_") + std::string(units[i]); + args[0] = (char *)var_str.c_str(); + v_unit = variable->find(args[0]); + if (v_unit < 0) { + variable->set(3,args); + v_unit = variable->find(args[0]); } - } else if (strcmp(from,"metal") == 0) { - if (strcmp(to,"real") == 0) { - variable->internal_set(v_length,1.0); - variable->internal_set(v_mass,1.0); - variable->internal_set(v_time,1000.0); - } else { - std::string err("Do not know how to set up conversion variables "); - err += "between '"; - err += from; - err += "' and '"; - err += to; - err += "' units"; + ier = lammps_unit_conversion(units[i], + from, + to, + conversion_factor); + if (ier != 0) { + std::string err = std::string("Unable to obtain conversion factor: ") + + "unit = " + units[i] + "; " + "from = " + from + "; " + "to = " + to + "."; error->all(FLERR,err.c_str()); } - } else { - std::string err("Do not know how to set up conversion variables "); - err += "between '"; - err += from; - err += "' and '"; - err += to; - err += "' units"; - error->all(FLERR,err.c_str()); + variable->internal_set(v_unit,conversion_factor); + if (comm->me == 0) { + std::stringstream mesg; + mesg << "# " << var_str << " = " << conversion_factor << std::endl; + if (screen) fputs(mesg.str().c_str(),screen); + if (logfile) fputs(mesg.str().c_str(),logfile); + } + } + if (comm->me == 0) { + if (screen) fputs("#\n",screen); + if (logfile) fputs("#\n",logfile); } } diff --git a/src/KIM/kim_style.h b/src/KIM/kim_style.h index b7ff47404f..b18f6627ea 100644 --- a/src/KIM/kim_style.h +++ b/src/KIM/kim_style.h @@ -80,6 +80,8 @@ class KimStyle : protected Pointers { void do_init(char *, char *, char *); void do_setup(int, char **); void do_variables(char*, char*); + void kim_style_log_delimiter(std::string begin_end, + std::string model_setup); }; } diff --git a/src/KIM/kim_units.cpp b/src/KIM/kim_units.cpp new file mode 100644 index 0000000000..fe90d58e9e --- /dev/null +++ b/src/KIM/kim_units.cpp @@ -0,0 +1,1411 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Ellad B. Tadmor (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.0.2 (and newer) package +------------------------------------------------------------------------- */ + +#include +#include +#include +#include +using namespace std; + +namespace +{ + +// Constants of nature and basic conversion factors +// Source: https://physics.nist.gov/cuu/Constants/Table/allascii.txt +// Working with NIST values even when there are newer values for +// compatibility with LAMMPS + +/*---------------------- + Fundamental constants +------------------------ */ +double const boltz_si = 1.38064852e-23; // [J K^-1] Boltzmann's factor + // (NIST value) +double const Nav = 6.022140857e23; // [unitless] Avogadro's number + // (NIST value) +// double const Nav = 6.02214076e23; // [unitless] Avogadro's number + // (official value May 2019) +double const me = 9.10938356e-31; // [kg] electron rest mass + // (NIST value) +// double me = 9.10938291e-31; // [kg] electron rest mass +double const e_si = 1.6021766208e-19; // [C] elementary charge + // (charge of an electron/proton) + // (NIST value) + +/*---------------------- + Distance units +------------------------ */ +double const bohr_si = 5.2917721067e-11; // [m] Bohr unit (distance between + // nucleus and electron in H) + // (NIST value) +double const angstrom_si = 1e-10; // [m] Angstrom +double const centimeter_si = 1e-2; // [m] centimeter +double const micrometer_si = 1e-6; // [m] micrometer (micron) +double const nanometer_si = 1e-9; // [m] nanometer + +/*---------------------- + Mass units +------------------------ */ +double const gram_per_mole_si = 1e-3/Nav; // [kg] gram per mole +double const amu_si = 1e-3/Nav; // [kg] atomic mass unit (molecular + // weight) For example, the mean + // molecular weight of water + // is 18.015 atomic mass units + // (amu), so one mole of water + // weight 18.015 grams. +double const gram_si = 1e-3; // [kg] gram +double const picogram_si = 1e-15; // [kg] picogram +double const attogram_si = 1e-21; // [kg[ attogram + +/*---------------------- + Time units +------------------------ */ +double const atu_si = 2.418884326509e-17; // [s] atomic time unit + // ( = hbar/E_h where E_h is the + // Hartree energy) (NIST value) +double const atu_electron_si = atu_si*sqrt(amu_si/me); // [s] atomic time unit + // used in electron system (see https://sourceforge.net/p/lammps/mailman/lammps-users/thread/BCA2BDB2-BA03-4280-896F-1E6120EF47B2%40caltech.edu/) +double const microsecond_si = 1e-6; // [s] microsecond +double const nanosecond_si = 1e-9; // [s] nanosecond +double const picosecond_si = 1e-12; // [s] picosecond +double const femtosecond_si = 1e-15; // [s] femtosecond + +/*---------------------- + Density units +------------------------ */ +double const gram_per_centimetercu_si = + gram_si/pow(centimeter_si,3); // [kg/m^3] gram/centimeter^3 +double const amu_per_bohrcu_si = amu_si/pow(bohr_si,3); // [kg/m^3] amu/bohr^3 +double const picogram_per_micrometercu_si = + picogram_si/pow(micrometer_si,3); // [kg/m^3] picogram/micrometer^3 +double const attogram_per_nanometercu_si = + attogram_si/pow(nanometer_si,3); // [kg/m^3] attogram/ + // nanomaterial^3 + +/*---------------------- + Energy/torque units +------------------------ */ +double const kcal_si = 4184.0; // [J] kilocalroie (heat energy + // involved in warming up one + // kilogram of water by one + // degree Kelvin) +double const ev_si = 1.6021766208e-19; // [J] electon volt (amount of + // energy gained or lost by the + // charge of a single electron + // moving across an electric + // potential difference of one + // volt.) (NIST value) +double const hartree_si = 4.359744650e-18; // [J] Hartree (approximately the + // electric potential energy of + // the hydrogen atom in its + // ground state) (NIST value) +double const kcal_per_mole_si = kcal_si/Nav;// [J] kcal/mole +double const erg_si = 1e-7; // [J] erg +double const dyne_centimeter_si = 1e-7; // [J[ dyne*centimeter +double const picogram_micrometersq_per_microsecondsq_si = + picogram_si*pow(micrometer_si,2)/pow(microsecond_si,2); + // [J] pigogram*micrometer^2/ + // micorsecond^2 +double const attogram_nanometersq_per_nanosecondsq_si = + attogram_si*pow(nanometer_si,2)/pow(nanosecond_si,2); + // [J] attogram*nanometer^2/ + // nanosecond^2 + +/*---------------------- + Velocity units +------------------------ */ +double const angstrom_per_femtosecond_si = + angstrom_si/femtosecond_si; // [m/s] Angstrom/femtosecond +double const angstrom_per_picosecond_si = + angstrom_si/picosecond_si; // [m/s] Angstrom/picosecond +double const micrometer_per_microsecond_si = + micrometer_si/microsecond_si; // [m/s] micrometer/microsecond +double const nanometer_per_nanosecond_si = + nanometer_si/nanosecond_si; // [m/s] nanometer/nanosecond +double const centimeter_per_second_si = + centimeter_si; // [m/s] centimeter/second +double const bohr_per_atu_si = + bohr_si/atu_electron_si; // [m/s] bohr/atu + +/*---------------------- + Force units +------------------------ */ +double const kcal_per_mole_angstrom_si = + kcal_per_mole_si/angstrom_si; // [N] kcal/(mole*Angstrom) +double const ev_per_angstrom_si = + ev_si/angstrom_si; // [N] eV/Angstrom +double const dyne_si = + dyne_centimeter_si/centimeter_si; // [N] dyne +double const hartree_per_bohr_si = + hartree_si/bohr_si; // [N] hartree/bohr +double const picogram_micrometer_per_microsecondsq_si = + picogram_si*micrometer_si/pow(microsecond_si,2); + // [N] picogram*micrometer/ + // microsecond^2 +double const attogram_nanometer_per_nanosecondsq_si = + attogram_si*nanometer_si/pow(nanosecond_si,2); + // [N] attogram*nanometer/ + // nanosecond^2 + +/*---------------------- + Pressure units +------------------------ */ +double const atmosphere_si = 101325.0; // [Pa] standard atmosphere (NIST value) +double const bar_si = 1e5; // [Pa] bar +double const dyne_per_centimetersq_si = + dyne_centimeter_si/pow(centimeter_si,3); + // [Pa] dyne/centimeter^2 +double const picogram_per_micrometer_microsecondsq_si = + picogram_si/(micrometer_si*pow(microsecond_si,2)); + // [Pa] picogram/(micrometer* + // microsecond^2) +double const attogram_per_nanometer_nanosecondsq_si = + attogram_si/(nanometer_si*pow(nanosecond_si,2)); + // [Pa] attogram/(nanometer*nanosecond^2) + +/*---------------------- + Viscosity units +------------------------ */ +double const poise_si = 0.1; // [Pa*s] Poise +double const amu_per_bohr_femtosecond_si = + amu_si/(bohr_si*femtosecond_si); // [Pa*s] amu/(bohr*femtosecond) +double const picogram_per_micrometer_microsecond_si = + picogram_si/(micrometer_si*microsecond_si); + // [Pa*s] picogram/(micrometer* + // microsecond) +double const attogram_per_nanometer_nanosecond_si = + attogram_si/(nanometer_si*nanosecond_si); + // [Pa*s] attogram/(nanometer* + // nanosecond) + +/*---------------------- + Charge units +------------------------ */ +double const echarge_si = e_si; // [C] electron charge unit +double const statcoulomb_si = e_si/4.8032044e-10; // [C] Statcoulomb or esu + // (value from LAMMPS units + // documentation) +double const picocoulomb_si = 1e-12; // [C] picocoulomb + +/*---------------------- + Dipole units +------------------------ */ +double const electron_angstrom_si = echarge_si*angstrom_si; + // [C*m] electron*angstrom +double const statcoulomb_centimeter_si = statcoulomb_si*centimeter_si; + // [C*m] statcoulomb*centimeter +double const debye_si = 1e-18*statcoulomb_centimeter_si; + // [C*m] Debye +double const picocoulomb_micrometer_si = picocoulomb_si*micrometer_si; + // [C*m] picocoulomb*micrometer +double const electron_nanometer_si = echarge_si*nanometer_si; + // [C*m] electron*nanometer + +/*---------------------- + Electric field units +------------------------ */ +double const volt_per_angstrom_si = 1.0/angstrom_si;// [V/m] volt/angstrom +double const statvolt_per_centimeter_si = + erg_si/(statcoulomb_si*centimeter_si); // [V/m] statvolt/centimeter +double const volt_per_centimeter_si = + 1.0/centimeter_si; // [V/m] volt/centimeter +double const volt_per_micrometer_si = + 1.0/micrometer_si; // [V/m] volt/micrometer +double const volt_per_nanometer_si = + 1.0/nanometer_si; // [V/m] volt/nanometer + +// Define enumerations +enum sys_type +{ + real = 1, + metal = 2, + si = 3, + cgs = 4, + electron = 5, + micro = 6, + nano = 7 +}; + +enum unit_type +{ + mass = 1, + distance = 2, + time = 3, + energy = 4, + velocity = 5, + force = 6, + torque = 7, + temperature = 8, + pressure = 9, + viscosity = 10, + charge = 11, + dipole = 12, + efield = 13, + density = 14 +}; + +enum units +{ + // mass + gram_per_mole = 101, + kilogram = 102, + gram = 103, + amu = 104, + picogram = 105, + attogram = 106, + // distance + angstrom = 201, + meter = 202, + centimeter = 203, + bohr = 204, + micrometer = 205, + nanometer = 206, + // time + femtosecond = 301, + picosecond = 302, + second = 303, + microsecond = 304, + nanosecond = 305, + // energy + kcal_per_mole = 401, + ev = 402, + joule = 403, + erg = 404, + hartree = 405, + picogram_micrometersq_per_microsecondsq = 406, + attogram_nanometersq_per_nanosecondsq = 407, + // velocity + angstrom_per_femtosecond = 501, + angstrom_per_picosecond = 502, + meter_per_second = 503, + centimeter_per_second = 504, + bohr_per_atu = 505, + micrometer_per_microsecond = 506, + nanometer_per_nanosecond = 507, + // force + kcal_per_mole_angstrom = 601, + ev_per_angstrom = 602, + newton = 603, + dyne = 604, + hartree_per_bohr = 605, + picogram_micrometer_per_microsecondsq = 606, + attogram_nanometer_per_nanosecondsq = 607, + // torque + newton_meter = 701, + dyne_centimeter = 702, + // temperature + kelvin = 801, + // pressure + atmosphere = 901, + bar = 902, + pascal = 903, + dyne_per_centimetersq = 904, + picogram_per_micrometer_microsecondsq = 905, + attogram_per_nanometer_nanosecondsq = 906, + // viscosity + poise = 1001, + pascal_second = 1002, + amu_per_bohr_femtosecond = 1003, // electron system, not in docs, GUESSED + picogram_per_micrometer_microsecond = 1004, + attogram_per_nanometer_nanosecond = 1005, + // charge + echarge = 1101, + coulomb = 1102, + statcoulomb = 1103, + picocoulomb = 1104, + // dipole + electron_angstrom = 1201, + coulomb_meter = 1202, + statcoulomb_centimeter = 1203, + debye = 1204, + picocoulomb_micrometer = 1205, + electron_nanometer = 1206, + // electric field + volt_per_angstrom = 1301, + volt_per_meter = 1302, + statvolt_per_centimeter = 1303, + volt_per_centimeter = 1304, + volt_per_micrometer = 1305, + volt_per_nanometer = 1306, + // density + gram_per_centimetercu = 1401, + kilogram_per_metercu = 1402, + amu_per_bohrcu = 1403, // electron system, not in docs, GUESSED + picogram_per_micrometercu = 1404, + attogram_per_nanometercu = 1405 +}; + +// Define dictionaries +map system_dic; +map unit_dic; +map units_real_dic; +map units_metal_dic; +map units_si_dic; +map units_cgs_dic; +map units_electron_dic; +map units_micro_dic; +map units_nano_dic; + +/* ---------------------------------------------------------------------- */ + +void initialize_dictionaries() +{ + system_dic["real"] = real; + system_dic["metal"] = metal; + system_dic["si"] = si; + system_dic["cgs"] = cgs; + system_dic["electron"] = electron; + system_dic["micro"] = micro; + system_dic["nano"] = nano; + + unit_dic["mass"] = mass; + unit_dic["distance"] = distance; + unit_dic["time"] = time; + unit_dic["energy"] = energy; + unit_dic["velocity"] = velocity; + unit_dic["force"] = force; + unit_dic["torque"] = torque; + unit_dic["temperature"]= temperature; + unit_dic["pressure"] = pressure; + unit_dic["viscosity"] = viscosity; + unit_dic["charge"] = charge; + unit_dic["dipole"] = dipole; + unit_dic["efield"] = efield; + unit_dic["density"] = density; + + units_real_dic[mass] = gram_per_mole; + units_real_dic[distance] = angstrom; + units_real_dic[time] = femtosecond; + units_real_dic[energy] = kcal_per_mole; + units_real_dic[velocity] = angstrom_per_femtosecond; + units_real_dic[force] = kcal_per_mole_angstrom; + units_real_dic[torque] = kcal_per_mole; + units_real_dic[temperature]= kelvin; + units_real_dic[pressure] = atmosphere; + units_real_dic[viscosity] = poise; + units_real_dic[charge] = echarge; + units_real_dic[dipole] = electron_angstrom; + units_real_dic[efield] = volt_per_angstrom; + units_real_dic[density] = gram_per_centimetercu; + + units_metal_dic[mass] = gram_per_mole; + units_metal_dic[distance] = angstrom; + units_metal_dic[time] = picosecond; + units_metal_dic[energy] = ev; + units_metal_dic[velocity] = angstrom_per_picosecond; + units_metal_dic[force] = ev_per_angstrom; + units_metal_dic[torque] = ev; + units_metal_dic[temperature]= kelvin; + units_metal_dic[pressure] = bar; + units_metal_dic[viscosity] = poise; + units_metal_dic[charge] = echarge; + units_metal_dic[dipole] = electron_angstrom; + units_metal_dic[efield] = volt_per_angstrom; + units_metal_dic[density] = gram_per_centimetercu; + + units_si_dic[mass] = kilogram; + units_si_dic[distance] = meter; + units_si_dic[time] = second; + units_si_dic[energy] = joule; + units_si_dic[velocity] = meter_per_second; + units_si_dic[force] = newton; + units_si_dic[torque] = newton_meter; + units_si_dic[temperature]= kelvin; + units_si_dic[pressure] = pascal; + units_si_dic[viscosity] = pascal_second; + units_si_dic[charge] = coulomb; + units_si_dic[dipole] = coulomb_meter; + units_si_dic[efield] = volt_per_meter; + units_si_dic[density] = kilogram_per_metercu; + + units_cgs_dic[mass] = gram; + units_cgs_dic[distance] = centimeter; + units_cgs_dic[time] = second; + units_cgs_dic[energy] = erg; + units_cgs_dic[velocity] = centimeter_per_second; + units_cgs_dic[force] = dyne; + units_cgs_dic[torque] = dyne_centimeter; + units_cgs_dic[temperature]= kelvin; + units_cgs_dic[pressure] = dyne_per_centimetersq; + units_cgs_dic[viscosity] = poise; + units_cgs_dic[charge] = statcoulomb; + units_cgs_dic[dipole] = statcoulomb_centimeter; + units_cgs_dic[efield] = statvolt_per_centimeter; + units_cgs_dic[density] = gram_per_centimetercu; + + units_electron_dic[mass] = amu; + units_electron_dic[distance] = bohr; + units_electron_dic[time] = femtosecond; + units_electron_dic[energy] = hartree; + units_electron_dic[velocity] = bohr_per_atu; + units_electron_dic[force] = hartree_per_bohr; + units_electron_dic[torque] = hartree; // unknown, GUESSED + units_electron_dic[temperature]= kelvin; + units_electron_dic[pressure] = pascal; + units_electron_dic[viscosity] = pascal_second; // unknown, GUESSED + units_electron_dic[charge] = echarge; + units_electron_dic[dipole] = debye; + units_electron_dic[efield] = volt_per_centimeter; + units_electron_dic[density] = amu_per_bohrcu; // unknown, GUESSED + + units_micro_dic[mass] = picogram; + units_micro_dic[distance] = micrometer; + units_micro_dic[time] = microsecond; + units_micro_dic[energy] = picogram_micrometersq_per_microsecondsq; + units_micro_dic[velocity] = micrometer_per_microsecond; + units_micro_dic[force] = picogram_micrometer_per_microsecondsq; + units_micro_dic[torque] = picogram_micrometersq_per_microsecondsq; + units_micro_dic[temperature]= kelvin; + units_micro_dic[pressure] = picogram_per_micrometer_microsecondsq; + units_micro_dic[viscosity] = picogram_per_micrometer_microsecond; + units_micro_dic[charge] = picocoulomb; + units_micro_dic[dipole] = picocoulomb_micrometer; + units_micro_dic[efield] = volt_per_micrometer; + units_micro_dic[density] = picogram_per_micrometercu; + + units_nano_dic[mass] = attogram; + units_nano_dic[distance] = nanometer; + units_nano_dic[time] = nanosecond; + units_nano_dic[energy] = attogram_nanometersq_per_nanosecondsq; + units_nano_dic[velocity] = nanometer_per_nanosecond; + units_nano_dic[force] = attogram_nanometer_per_nanosecondsq; + units_nano_dic[torque] = attogram_nanometersq_per_nanosecondsq; + units_nano_dic[temperature]= kelvin; + units_nano_dic[pressure] = attogram_per_nanometer_nanosecondsq; + units_nano_dic[viscosity] = attogram_per_nanometer_nanosecond; + units_nano_dic[charge] = echarge; + units_nano_dic[dipole] = electron_nanometer; + units_nano_dic[efield] = volt_per_nanometer; + units_nano_dic[density] = attogram_per_nanometercu; + +} + +/* ---------------------------------------------------------------------- */ + +// Get the enumeration for the unit of type `unit_type_enum` +// for LAMMPS system `system_enum`. +units get_lammps_system_unit(sys_type system_enum, unit_type unit_type_enum) +{ + switch(system_enum) { + case real : + return units_real_dic[unit_type_enum]; + case metal : + return units_metal_dic[unit_type_enum]; + case si : + return units_si_dic[unit_type_enum]; + case cgs : + return units_cgs_dic[unit_type_enum]; + case electron : + return units_electron_dic[unit_type_enum]; + case micro : + return units_micro_dic[unit_type_enum]; + case nano : + default : // This is here to a prevent a compiler warning + return units_nano_dic[unit_type_enum]; + } +} + +/* ---------------------------------------------------------------------- */ + +// Mass conversion +double get_mass_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[kilogram][kilogram] = 1.0; + conv[kilogram][gram_per_mole] = 1.0/gram_per_mole_si; + conv[kilogram][gram] = 1.0/gram_si; + conv[kilogram][amu] = 1.0/amu_si; + conv[kilogram][picogram] = 1.0/picogram_si; + conv[kilogram][attogram] = 1.0/attogram_si; + + to_si = 1.0/conv[kilogram][gram_per_mole]; + conv[gram_per_mole][kilogram] = to_si*conv[kilogram][kilogram]; + conv[gram_per_mole][gram_per_mole] = 1.0; + conv[gram_per_mole][gram] = to_si*conv[kilogram][gram]; + conv[gram_per_mole][amu] = to_si*conv[kilogram][amu]; + conv[gram_per_mole][picogram] = to_si*conv[kilogram][picogram]; + conv[gram_per_mole][attogram] = to_si*conv[kilogram][attogram]; + + to_si = 1.0/conv[kilogram][gram]; + conv[gram][kilogram] = to_si*conv[kilogram][kilogram]; + conv[gram][gram_per_mole] = to_si*conv[kilogram][gram_per_mole]; + conv[gram][gram] = 1.0; + conv[gram][amu] = to_si*conv[kilogram][amu]; + conv[gram][picogram] = to_si*conv[kilogram][picogram]; + conv[gram][attogram] = to_si*conv[kilogram][attogram]; + + to_si = 1.0/conv[kilogram][amu]; + conv[amu][kilogram] = to_si*conv[kilogram][kilogram]; + conv[amu][gram_per_mole] = to_si*conv[kilogram][gram_per_mole]; + conv[amu][gram] = to_si*conv[kilogram][gram]; + conv[amu][amu] = 1.0; + conv[amu][picogram] = to_si*conv[kilogram][picogram]; + conv[amu][attogram] = to_si*conv[kilogram][attogram]; + + to_si = 1.0/conv[kilogram][picogram]; + conv[picogram][kilogram] = to_si*conv[kilogram][kilogram]; + conv[picogram][gram_per_mole] = to_si*conv[kilogram][gram_per_mole]; + conv[picogram][gram] = to_si*conv[kilogram][gram]; + conv[picogram][amu] = to_si*conv[kilogram][amu]; + conv[picogram][picogram] = 1.0; + conv[picogram][attogram] = to_si*conv[kilogram][attogram]; + + to_si = 1.0/conv[kilogram][attogram]; + conv[attogram][kilogram] = to_si*conv[kilogram][kilogram]; + conv[attogram][gram_per_mole] = to_si*conv[kilogram][gram_per_mole]; + conv[attogram][gram] = to_si*conv[kilogram][gram]; + conv[attogram][amu] = to_si*conv[kilogram][amu]; + conv[attogram][picogram] = to_si*conv[kilogram][picogram]; + conv[attogram][attogram] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Distance conversion +double get_distance_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[meter][meter] = 1.0; + conv[meter][angstrom] = 1.0/angstrom_si; + conv[meter][centimeter] = 1.0/centimeter_si; + conv[meter][bohr] = 1.0/bohr_si; + conv[meter][micrometer] = 1.0/micrometer_si; + conv[meter][nanometer] = 1.0/nanometer_si; + + to_si = 1.0/conv[meter][angstrom]; + conv[angstrom][meter] = to_si*conv[meter][meter]; + conv[angstrom][angstrom] = 1.0; + conv[angstrom][centimeter] = to_si*conv[meter][centimeter]; + conv[angstrom][bohr] = to_si*conv[meter][bohr]; + conv[angstrom][micrometer] = to_si*conv[meter][micrometer]; + conv[angstrom][nanometer] = to_si*conv[meter][nanometer]; + + to_si = 1.0/conv[meter][centimeter]; + conv[centimeter][meter] = to_si*conv[meter][meter]; + conv[centimeter][angstrom] = to_si*conv[meter][angstrom]; + conv[centimeter][centimeter] = 1.0; + conv[centimeter][bohr] = to_si*conv[meter][bohr]; + conv[centimeter][micrometer] = to_si*conv[meter][micrometer]; + conv[centimeter][nanometer] = to_si*conv[meter][nanometer]; + + to_si = 1.0/conv[meter][bohr]; + conv[bohr][meter] = to_si*conv[meter][meter]; + conv[bohr][angstrom] = to_si*conv[meter][angstrom]; + conv[bohr][centimeter] = to_si*conv[meter][centimeter]; + conv[bohr][bohr] = 1.0; + conv[bohr][micrometer] = to_si*conv[meter][micrometer]; + conv[bohr][nanometer] = to_si*conv[meter][nanometer]; + + to_si = 1.0/conv[meter][micrometer]; + conv[micrometer][meter] = to_si*conv[meter][meter]; + conv[micrometer][angstrom] = to_si*conv[meter][angstrom]; + conv[micrometer][centimeter] = to_si*conv[meter][centimeter]; + conv[micrometer][bohr] = to_si*conv[meter][bohr]; + conv[micrometer][micrometer] = 1.0; + conv[micrometer][nanometer] = to_si*conv[meter][nanometer]; + + to_si = 1.0/conv[meter][nanometer]; + conv[nanometer][meter] = to_si*conv[meter][meter]; + conv[nanometer][angstrom] = to_si*conv[meter][angstrom]; + conv[nanometer][centimeter] = to_si*conv[meter][centimeter]; + conv[nanometer][bohr] = to_si*conv[meter][bohr]; + conv[nanometer][micrometer] = to_si*conv[meter][micrometer]; + conv[nanometer][nanometer] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Time conversion +double get_time_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[second][second] = 1.0; + conv[second][femtosecond] = 1.0/femtosecond_si; + conv[second][picosecond] = 1.0/picosecond_si; + conv[second][microsecond] = 1.0/microsecond_si; + conv[second][nanosecond] = 1.0/nanosecond_si; + + to_si = 1.0/conv[second][femtosecond]; + conv[femtosecond][second] = to_si*conv[second][second]; + conv[femtosecond][femtosecond] = 1.0; + conv[femtosecond][picosecond] = to_si*conv[second][picosecond]; + conv[femtosecond][microsecond] = to_si*conv[second][microsecond]; + conv[femtosecond][nanosecond] = to_si*conv[second][nanosecond]; + + to_si = 1.0/conv[second][picosecond]; + conv[picosecond][second] = to_si*conv[second][second]; + conv[picosecond][femtosecond] = to_si*conv[second][femtosecond]; + conv[picosecond][picosecond] = 1.0; + conv[picosecond][microsecond] = to_si*conv[second][microsecond]; + conv[picosecond][nanosecond] = to_si*conv[second][nanosecond]; + + to_si = 1.0/conv[second][microsecond]; + conv[microsecond][second] = to_si*conv[second][second]; + conv[microsecond][femtosecond] = to_si*conv[second][femtosecond]; + conv[microsecond][picosecond] = to_si*conv[second][picosecond]; + conv[microsecond][microsecond] = 1.0; + conv[microsecond][nanosecond] = to_si*conv[second][nanosecond]; + + to_si = 1.0/conv[second][nanosecond]; + conv[nanosecond][second] = to_si*conv[second][second]; + conv[nanosecond][femtosecond] = to_si*conv[second][femtosecond]; + conv[nanosecond][picosecond] = to_si*conv[second][picosecond]; + conv[nanosecond][microsecond] = to_si*conv[second][microsecond]; + conv[nanosecond][nanosecond] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Energy conversion +double get_energy_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + + map > conv; + double to_si; + + conv[joule][joule] = 1.0; + conv[joule][kcal_per_mole] = 1.0/kcal_per_mole_si; + conv[joule][ev] = 1.0/ev_si; + conv[joule][erg] = 1.0/erg_si; + conv[joule][hartree] = 1.0/hartree_si; + conv[joule][picogram_micrometersq_per_microsecondsq] = 1.0/picogram_micrometersq_per_microsecondsq_si; + conv[joule][attogram_nanometersq_per_nanosecondsq] = 1.0/attogram_nanometersq_per_nanosecondsq_si; + + to_si = 1.0/conv[joule][kcal_per_mole]; + conv[kcal_per_mole][joule] = to_si*conv[joule][joule]; + conv[kcal_per_mole][kcal_per_mole] = 1.0; + conv[kcal_per_mole][ev] = to_si*conv[joule][ev]; + conv[kcal_per_mole][erg] = to_si*conv[joule][erg]; + conv[kcal_per_mole][hartree] = to_si*conv[joule][hartree]; + conv[kcal_per_mole][picogram_micrometersq_per_microsecondsq] = to_si*conv[joule][picogram_micrometersq_per_microsecondsq]; + conv[kcal_per_mole][attogram_nanometersq_per_nanosecondsq] = to_si*conv[joule][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[joule][ev]; + conv[ev][joule] = to_si*conv[joule][joule]; + conv[ev][kcal_per_mole] = to_si*conv[joule][kcal_per_mole]; + conv[ev][ev] = 1.0; + conv[ev][erg] = to_si*conv[joule][erg]; + conv[ev][hartree] = to_si*conv[joule][hartree]; + conv[ev][picogram_micrometersq_per_microsecondsq] = to_si*conv[joule][picogram_micrometersq_per_microsecondsq]; + conv[ev][attogram_nanometersq_per_nanosecondsq] = to_si*conv[joule][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[joule][erg]; + conv[erg][joule] = to_si*conv[joule][joule]; + conv[erg][kcal_per_mole] = to_si*conv[joule][kcal_per_mole]; + conv[erg][ev] = to_si*conv[joule][ev]; + conv[erg][erg] = 1.0; + conv[erg][hartree] = to_si*conv[joule][hartree]; + conv[erg][picogram_micrometersq_per_microsecondsq] = to_si*conv[joule][picogram_micrometersq_per_microsecondsq]; + conv[erg][attogram_nanometersq_per_nanosecondsq] = to_si*conv[joule][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[joule][hartree]; + conv[hartree][joule] = to_si*conv[joule][joule]; + conv[hartree][kcal_per_mole] = to_si*conv[joule][kcal_per_mole]; + conv[hartree][ev] = to_si*conv[joule][ev]; + conv[hartree][erg] = to_si*conv[joule][erg]; + conv[hartree][hartree] = 1.0; + conv[hartree][picogram_micrometersq_per_microsecondsq] = to_si*conv[joule][picogram_micrometersq_per_microsecondsq]; + conv[hartree][attogram_nanometersq_per_nanosecondsq] = to_si*conv[joule][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[joule][picogram_micrometersq_per_microsecondsq]; + conv[picogram_micrometersq_per_microsecondsq][joule] = to_si*conv[joule][joule]; + conv[picogram_micrometersq_per_microsecondsq][kcal_per_mole] = to_si*conv[joule][kcal_per_mole]; + conv[picogram_micrometersq_per_microsecondsq][ev] = to_si*conv[joule][ev]; + conv[picogram_micrometersq_per_microsecondsq][erg] = to_si*conv[joule][erg]; + conv[picogram_micrometersq_per_microsecondsq][hartree] = to_si*conv[joule][hartree]; + conv[picogram_micrometersq_per_microsecondsq][picogram_micrometersq_per_microsecondsq] = 1.0; + conv[picogram_micrometersq_per_microsecondsq][attogram_nanometersq_per_nanosecondsq] = to_si*conv[joule][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[joule][attogram_nanometersq_per_nanosecondsq]; + conv[attogram_nanometersq_per_nanosecondsq][joule] = to_si*conv[joule][joule]; + conv[attogram_nanometersq_per_nanosecondsq][kcal_per_mole] = to_si*conv[joule][kcal_per_mole]; + conv[attogram_nanometersq_per_nanosecondsq][ev] = to_si*conv[joule][ev]; + conv[attogram_nanometersq_per_nanosecondsq][erg] = to_si*conv[joule][erg]; + conv[attogram_nanometersq_per_nanosecondsq][hartree] = to_si*conv[joule][hartree]; + conv[attogram_nanometersq_per_nanosecondsq][picogram_micrometersq_per_microsecondsq] = to_si*conv[joule][picogram_micrometersq_per_microsecondsq]; + conv[attogram_nanometersq_per_nanosecondsq][attogram_nanometersq_per_nanosecondsq] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Velocity conversion +double get_velocity_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[meter_per_second][meter_per_second] = 1.0; + conv[meter_per_second][angstrom_per_femtosecond] = 1.0/angstrom_per_femtosecond_si; + conv[meter_per_second][angstrom_per_picosecond] = 1.0/angstrom_per_picosecond_si; + conv[meter_per_second][centimeter_per_second] = 1.0/centimeter_per_second_si; + conv[meter_per_second][bohr_per_atu] = 1.0/bohr_per_atu_si; + conv[meter_per_second][micrometer_per_microsecond] = 1.0/micrometer_per_microsecond_si; + conv[meter_per_second][nanometer_per_nanosecond] = 1.0/nanometer_per_nanosecond_si; + + to_si = 1.0/conv[meter_per_second][angstrom_per_femtosecond]; + conv[angstrom_per_femtosecond][meter_per_second] = to_si*conv[meter_per_second][meter_per_second]; + conv[angstrom_per_femtosecond][angstrom_per_femtosecond] = 1.0; + conv[angstrom_per_femtosecond][angstrom_per_picosecond] = to_si*conv[meter_per_second][angstrom_per_picosecond]; + conv[angstrom_per_femtosecond][centimeter_per_second] = to_si*conv[meter_per_second][centimeter_per_second]; + conv[angstrom_per_femtosecond][bohr_per_atu] = to_si*conv[meter_per_second][bohr_per_atu]; + conv[angstrom_per_femtosecond][micrometer_per_microsecond] = to_si*conv[meter_per_second][micrometer_per_microsecond]; + conv[angstrom_per_femtosecond][nanometer_per_nanosecond] = to_si*conv[meter_per_second][nanometer_per_nanosecond]; + + to_si = 1.0/conv[meter_per_second][angstrom_per_picosecond]; + conv[angstrom_per_picosecond][meter_per_second] = to_si*conv[meter_per_second][meter_per_second]; + conv[angstrom_per_picosecond][angstrom_per_femtosecond] = to_si*conv[meter_per_second][angstrom_per_femtosecond]; + conv[angstrom_per_picosecond][angstrom_per_picosecond] = 1.0; + conv[angstrom_per_picosecond][centimeter_per_second] = to_si*conv[meter_per_second][centimeter_per_second]; + conv[angstrom_per_picosecond][bohr_per_atu] = to_si*conv[meter_per_second][bohr_per_atu]; + conv[angstrom_per_picosecond][micrometer_per_microsecond] = to_si*conv[meter_per_second][micrometer_per_microsecond]; + conv[angstrom_per_picosecond][nanometer_per_nanosecond] = to_si*conv[meter_per_second][nanometer_per_nanosecond]; + + to_si = 1.0/conv[meter_per_second][centimeter_per_second]; + conv[centimeter_per_second][meter_per_second] = to_si*conv[meter_per_second][meter_per_second]; + conv[centimeter_per_second][angstrom_per_femtosecond] = to_si*conv[meter_per_second][angstrom_per_femtosecond]; + conv[centimeter_per_second][angstrom_per_picosecond] = to_si*conv[meter_per_second][angstrom_per_picosecond]; + conv[centimeter_per_second][centimeter_per_second] = 1.0; + conv[centimeter_per_second][bohr_per_atu] = to_si*conv[meter_per_second][bohr_per_atu]; + conv[centimeter_per_second][micrometer_per_microsecond] = to_si*conv[meter_per_second][micrometer_per_microsecond]; + conv[centimeter_per_second][nanometer_per_nanosecond] = to_si*conv[meter_per_second][nanometer_per_nanosecond]; + + to_si = 1.0/conv[meter_per_second][bohr_per_atu]; + conv[bohr_per_atu][meter_per_second] = to_si*conv[meter_per_second][meter_per_second]; + conv[bohr_per_atu][angstrom_per_femtosecond] = to_si*conv[meter_per_second][angstrom_per_femtosecond]; + conv[bohr_per_atu][angstrom_per_picosecond] = to_si*conv[meter_per_second][angstrom_per_picosecond]; + conv[bohr_per_atu][centimeter_per_second] = to_si*conv[meter_per_second][centimeter_per_second]; + conv[bohr_per_atu][bohr_per_atu] = 1.0; + conv[bohr_per_atu][micrometer_per_microsecond] = to_si*conv[meter_per_second][micrometer_per_microsecond]; + conv[bohr_per_atu][nanometer_per_nanosecond] = to_si*conv[meter_per_second][nanometer_per_nanosecond]; + + to_si = 1.0/conv[meter_per_second][micrometer_per_microsecond]; + conv[micrometer_per_microsecond][meter_per_second] = to_si*conv[meter_per_second][meter_per_second]; + conv[micrometer_per_microsecond][angstrom_per_femtosecond] = to_si*conv[meter_per_second][angstrom_per_femtosecond]; + conv[micrometer_per_microsecond][angstrom_per_picosecond] = to_si*conv[meter_per_second][angstrom_per_picosecond]; + conv[micrometer_per_microsecond][centimeter_per_second] = to_si*conv[meter_per_second][centimeter_per_second]; + conv[micrometer_per_microsecond][bohr_per_atu] = to_si*conv[meter_per_second][bohr_per_atu]; + conv[micrometer_per_microsecond][micrometer_per_microsecond] = 1.0; + conv[micrometer_per_microsecond][nanometer_per_nanosecond] = to_si*conv[meter_per_second][nanometer_per_nanosecond]; + + to_si = 1.0/conv[meter_per_second][nanometer_per_nanosecond]; + conv[nanometer_per_nanosecond][meter_per_second] = to_si*conv[meter_per_second][meter_per_second]; + conv[nanometer_per_nanosecond][angstrom_per_femtosecond] = to_si*conv[meter_per_second][angstrom_per_femtosecond]; + conv[nanometer_per_nanosecond][angstrom_per_picosecond] = to_si*conv[meter_per_second][angstrom_per_picosecond]; + conv[nanometer_per_nanosecond][centimeter_per_second] = to_si*conv[meter_per_second][centimeter_per_second]; + conv[nanometer_per_nanosecond][bohr_per_atu] = to_si*conv[meter_per_second][bohr_per_atu]; + conv[nanometer_per_nanosecond][micrometer_per_microsecond] = to_si*conv[meter_per_second][micrometer_per_microsecond]; + conv[nanometer_per_nanosecond][nanometer_per_nanosecond] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Force conversion +double get_force_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[newton][newton] = 1.0; + conv[newton][kcal_per_mole_angstrom] = 1.0/kcal_per_mole_angstrom_si; + conv[newton][ev_per_angstrom] = 1.0/ev_per_angstrom_si; + conv[newton][dyne] = 1.0/dyne_si; + conv[newton][hartree_per_bohr] = 1.0/hartree_per_bohr_si; + conv[newton][picogram_micrometer_per_microsecondsq] = 1.0/picogram_micrometer_per_microsecondsq_si; + conv[newton][attogram_nanometer_per_nanosecondsq] = 1.0/attogram_nanometer_per_nanosecondsq_si; + + to_si = 1.0/conv[newton][kcal_per_mole_angstrom]; + conv[kcal_per_mole_angstrom][newton] = to_si*conv[newton][newton]; + conv[kcal_per_mole_angstrom][kcal_per_mole_angstrom] = 1.0; + conv[kcal_per_mole_angstrom][ev_per_angstrom] = to_si*conv[newton][ev_per_angstrom]; + conv[kcal_per_mole_angstrom][dyne] = to_si*conv[newton][dyne]; + conv[kcal_per_mole_angstrom][hartree_per_bohr] = to_si*conv[newton][hartree_per_bohr]; + conv[kcal_per_mole_angstrom][picogram_micrometer_per_microsecondsq] = to_si*conv[newton][picogram_micrometer_per_microsecondsq]; + conv[kcal_per_mole_angstrom][attogram_nanometer_per_nanosecondsq] = to_si*conv[newton][attogram_nanometer_per_nanosecondsq]; + + to_si = 1.0/conv[newton][ev_per_angstrom]; + conv[ev_per_angstrom][newton] = to_si*conv[newton][newton]; + conv[ev_per_angstrom][kcal_per_mole_angstrom] = to_si*conv[newton][kcal_per_mole_angstrom]; + conv[ev_per_angstrom][ev_per_angstrom] = 1.0; + conv[ev_per_angstrom][dyne] = to_si*conv[newton][dyne]; + conv[ev_per_angstrom][hartree_per_bohr] = to_si*conv[newton][hartree_per_bohr]; + conv[ev_per_angstrom][picogram_micrometer_per_microsecondsq] = to_si*conv[newton][picogram_micrometer_per_microsecondsq]; + conv[ev_per_angstrom][attogram_nanometer_per_nanosecondsq] = to_si*conv[newton][attogram_nanometer_per_nanosecondsq]; + + to_si = 1.0/conv[newton][dyne]; + conv[dyne][newton] = to_si*conv[newton][newton]; + conv[dyne][kcal_per_mole_angstrom] = to_si*conv[newton][kcal_per_mole_angstrom]; + conv[dyne][ev_per_angstrom] = to_si*conv[newton][ev_per_angstrom]; + conv[dyne][dyne] = 1.0; + conv[dyne][hartree_per_bohr] = to_si*conv[newton][hartree_per_bohr]; + conv[dyne][picogram_micrometer_per_microsecondsq] = to_si*conv[newton][picogram_micrometer_per_microsecondsq]; + conv[dyne][attogram_nanometer_per_nanosecondsq] = to_si*conv[newton][attogram_nanometer_per_nanosecondsq]; + + to_si = 1.0/conv[newton][hartree_per_bohr]; + conv[hartree_per_bohr][newton] = to_si*conv[newton][newton]; + conv[hartree_per_bohr][kcal_per_mole_angstrom] = to_si*conv[newton][kcal_per_mole_angstrom]; + conv[hartree_per_bohr][ev_per_angstrom] = to_si*conv[newton][ev_per_angstrom]; + conv[hartree_per_bohr][dyne] = to_si*conv[newton][dyne]; + conv[hartree_per_bohr][hartree_per_bohr] = 1.0; + conv[hartree_per_bohr][picogram_micrometer_per_microsecondsq] = to_si*conv[newton][picogram_micrometer_per_microsecondsq]; + conv[hartree_per_bohr][attogram_nanometer_per_nanosecondsq] = to_si*conv[newton][attogram_nanometer_per_nanosecondsq]; + + to_si = 1.0/conv[newton][picogram_micrometer_per_microsecondsq]; + conv[picogram_micrometer_per_microsecondsq][newton] = to_si*conv[newton][newton]; + conv[picogram_micrometer_per_microsecondsq][kcal_per_mole_angstrom] = to_si*conv[newton][kcal_per_mole_angstrom]; + conv[picogram_micrometer_per_microsecondsq][ev_per_angstrom] = to_si*conv[newton][ev_per_angstrom]; + conv[picogram_micrometer_per_microsecondsq][dyne] = to_si*conv[newton][dyne]; + conv[picogram_micrometer_per_microsecondsq][hartree_per_bohr] = to_si*conv[newton][hartree_per_bohr]; + conv[picogram_micrometer_per_microsecondsq][picogram_micrometer_per_microsecondsq] = 1.0; + conv[picogram_micrometer_per_microsecondsq][attogram_nanometer_per_nanosecondsq] = to_si*conv[newton][attogram_nanometer_per_nanosecondsq]; + + to_si = 1.0/conv[newton][attogram_nanometer_per_nanosecondsq]; + conv[attogram_nanometer_per_nanosecondsq][newton] = to_si*conv[newton][newton]; + conv[attogram_nanometer_per_nanosecondsq][kcal_per_mole_angstrom] = to_si*conv[newton][kcal_per_mole_angstrom]; + conv[attogram_nanometer_per_nanosecondsq][ev_per_angstrom] = to_si*conv[newton][ev_per_angstrom]; + conv[attogram_nanometer_per_nanosecondsq][dyne] = to_si*conv[newton][dyne]; + conv[attogram_nanometer_per_nanosecondsq][hartree_per_bohr] = to_si*conv[newton][hartree_per_bohr]; + conv[attogram_nanometer_per_nanosecondsq][picogram_micrometer_per_microsecondsq] = to_si*conv[newton][picogram_micrometer_per_microsecondsq]; + conv[attogram_nanometer_per_nanosecondsq][attogram_nanometer_per_nanosecondsq] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Torque conversion +double get_torque_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[newton_meter][newton_meter] = 1.0; + conv[newton_meter][kcal_per_mole] = 1.0/kcal_per_mole_si; + conv[newton_meter][ev] = 1.0/ev_si; + conv[newton_meter][dyne_centimeter] = 1.0/dyne_centimeter_si; + conv[newton_meter][hartree] = 1.0/hartree_si; + conv[newton_meter][picogram_micrometersq_per_microsecondsq] = 1.0/picogram_micrometersq_per_microsecondsq_si; + conv[newton_meter][attogram_nanometersq_per_nanosecondsq] = 1.0/attogram_nanometersq_per_nanosecondsq_si; + + to_si = 1.0/conv[newton_meter][kcal_per_mole]; + conv[kcal_per_mole][newton_meter] = to_si*conv[newton_meter][newton_meter]; + conv[kcal_per_mole][kcal_per_mole] = 1.0; + conv[kcal_per_mole][ev] = to_si*conv[newton_meter][ev]; + conv[kcal_per_mole][dyne_centimeter] = to_si*conv[newton_meter][dyne_centimeter]; + conv[kcal_per_mole][hartree] = to_si*conv[newton_meter][hartree]; + conv[kcal_per_mole][picogram_micrometersq_per_microsecondsq] = to_si*conv[newton_meter][picogram_micrometersq_per_microsecondsq]; + conv[kcal_per_mole][attogram_nanometersq_per_nanosecondsq] = to_si*conv[newton_meter][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[newton_meter][ev]; + conv[ev][newton_meter] = to_si*conv[newton_meter][newton_meter]; + conv[ev][kcal_per_mole] = to_si*conv[newton_meter][kcal_per_mole]; + conv[ev][ev] = 1.0; + conv[ev][dyne_centimeter] = to_si*conv[newton_meter][dyne_centimeter]; + conv[ev][hartree] = to_si*conv[newton_meter][hartree]; + conv[ev][picogram_micrometersq_per_microsecondsq] = to_si*conv[newton_meter][picogram_micrometersq_per_microsecondsq]; + conv[ev][attogram_nanometersq_per_nanosecondsq] = to_si*conv[newton_meter][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[newton_meter][dyne_centimeter]; + conv[dyne_centimeter][newton_meter] = to_si*conv[newton_meter][newton_meter]; + conv[dyne_centimeter][kcal_per_mole] = to_si*conv[newton_meter][kcal_per_mole]; + conv[dyne_centimeter][ev] = to_si*conv[newton_meter][ev]; + conv[dyne_centimeter][dyne_centimeter] = 1.0; + conv[dyne_centimeter][hartree] = to_si*conv[newton_meter][hartree]; + conv[dyne_centimeter][picogram_micrometersq_per_microsecondsq] = to_si*conv[newton_meter][picogram_micrometersq_per_microsecondsq]; + conv[dyne_centimeter][attogram_nanometersq_per_nanosecondsq] = to_si*conv[newton_meter][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[newton_meter][hartree]; + conv[hartree][newton_meter] = to_si*conv[newton_meter][newton_meter]; + conv[hartree][kcal_per_mole] = to_si*conv[newton_meter][kcal_per_mole]; + conv[hartree][ev] = to_si*conv[newton_meter][ev]; + conv[hartree][dyne_centimeter] = to_si*conv[newton_meter][dyne_centimeter]; + conv[hartree][hartree] = 1.0; + conv[hartree][picogram_micrometersq_per_microsecondsq] = to_si*conv[newton_meter][picogram_micrometersq_per_microsecondsq]; + conv[hartree][attogram_nanometersq_per_nanosecondsq] = to_si*conv[newton_meter][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[newton_meter][picogram_micrometersq_per_microsecondsq]; + conv[picogram_micrometersq_per_microsecondsq][newton_meter] = to_si*conv[newton_meter][newton_meter]; + conv[picogram_micrometersq_per_microsecondsq][kcal_per_mole] = to_si*conv[newton_meter][kcal_per_mole]; + conv[picogram_micrometersq_per_microsecondsq][ev] = to_si*conv[newton_meter][ev]; + conv[picogram_micrometersq_per_microsecondsq][dyne_centimeter] = to_si*conv[newton_meter][dyne_centimeter]; + conv[picogram_micrometersq_per_microsecondsq][hartree] = to_si*conv[newton_meter][hartree]; + conv[picogram_micrometersq_per_microsecondsq][picogram_micrometersq_per_microsecondsq] = 1.0; + conv[picogram_micrometersq_per_microsecondsq][attogram_nanometersq_per_nanosecondsq] = to_si*conv[newton_meter][attogram_nanometersq_per_nanosecondsq]; + + to_si = 1.0/conv[newton_meter][attogram_nanometersq_per_nanosecondsq]; + conv[attogram_nanometersq_per_nanosecondsq][newton_meter] = to_si*conv[newton_meter][newton_meter]; + conv[attogram_nanometersq_per_nanosecondsq][kcal_per_mole] = to_si*conv[newton_meter][kcal_per_mole]; + conv[attogram_nanometersq_per_nanosecondsq][ev] = to_si*conv[newton_meter][ev]; + conv[attogram_nanometersq_per_nanosecondsq][dyne_centimeter] = to_si*conv[newton_meter][dyne_centimeter]; + conv[attogram_nanometersq_per_nanosecondsq][hartree] = to_si*conv[newton_meter][hartree]; + conv[attogram_nanometersq_per_nanosecondsq][picogram_micrometersq_per_microsecondsq] = to_si*conv[newton_meter][picogram_micrometersq_per_microsecondsq]; + conv[attogram_nanometersq_per_nanosecondsq][attogram_nanometersq_per_nanosecondsq] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Temperature conversion +double get_temperature_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[kelvin][kelvin] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Pressure conversion +double get_pressure_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[pascal][pascal] = 1.0; + conv[pascal][atmosphere] = 1.0/atmosphere_si; + conv[pascal][bar] = 1.0/bar_si; + conv[pascal][dyne_per_centimetersq] = 1.0/dyne_per_centimetersq_si; + conv[pascal][picogram_per_micrometer_microsecondsq] = 1.0/picogram_per_micrometer_microsecondsq_si; + conv[pascal][attogram_per_nanometer_nanosecondsq] = 1.0/attogram_per_nanometer_nanosecondsq_si; + + to_si = 1.0/conv[pascal][atmosphere]; + conv[atmosphere][pascal] = to_si*conv[pascal][pascal]; + conv[atmosphere][atmosphere] = 1.0; + conv[atmosphere][bar] = to_si*conv[pascal][bar]; + conv[atmosphere][dyne_per_centimetersq] = to_si*conv[pascal][dyne_per_centimetersq]; + conv[atmosphere][picogram_per_micrometer_microsecondsq] = to_si*conv[pascal][picogram_per_micrometer_microsecondsq]; + conv[atmosphere][attogram_per_nanometer_nanosecondsq] = to_si*conv[pascal][attogram_per_nanometer_nanosecondsq]; + + to_si = 1.0/conv[pascal][bar]; + conv[bar][pascal] = to_si*conv[pascal][pascal]; + conv[bar][atmosphere] = to_si*conv[pascal][atmosphere]; + conv[bar][bar] = 1.0; + conv[bar][dyne_per_centimetersq] = to_si*conv[pascal][dyne_per_centimetersq]; + conv[bar][picogram_per_micrometer_microsecondsq] = to_si*conv[pascal][picogram_per_micrometer_microsecondsq]; + conv[bar][attogram_per_nanometer_nanosecondsq] = to_si*conv[pascal][attogram_per_nanometer_nanosecondsq]; + + to_si = 1.0/conv[pascal][dyne_per_centimetersq]; + conv[dyne_per_centimetersq][pascal] = to_si*conv[pascal][pascal]; + conv[dyne_per_centimetersq][atmosphere] = to_si*conv[pascal][atmosphere]; + conv[dyne_per_centimetersq][bar] = to_si*conv[pascal][bar]; + conv[dyne_per_centimetersq][dyne_per_centimetersq] = 1.0; + conv[dyne_per_centimetersq][picogram_per_micrometer_microsecondsq] = to_si*conv[pascal][picogram_per_micrometer_microsecondsq]; + conv[dyne_per_centimetersq][attogram_per_nanometer_nanosecondsq] = to_si*conv[pascal][attogram_per_nanometer_nanosecondsq]; + + to_si = 1.0/conv[pascal][picogram_per_micrometer_microsecondsq]; + conv[picogram_per_micrometer_microsecondsq][pascal] = to_si*conv[pascal][pascal]; + conv[picogram_per_micrometer_microsecondsq][atmosphere] = to_si*conv[pascal][atmosphere]; + conv[picogram_per_micrometer_microsecondsq][bar] = to_si*conv[pascal][bar]; + conv[picogram_per_micrometer_microsecondsq][dyne_per_centimetersq] = to_si*conv[pascal][dyne_per_centimetersq]; + conv[picogram_per_micrometer_microsecondsq][picogram_per_micrometer_microsecondsq] = 1.0; + conv[picogram_per_micrometer_microsecondsq][attogram_per_nanometer_nanosecondsq] = to_si*conv[pascal][attogram_per_nanometer_nanosecondsq]; + + to_si = 1.0/conv[pascal][attogram_per_nanometer_nanosecondsq]; + conv[attogram_per_nanometer_nanosecondsq][pascal] = to_si*conv[pascal][pascal]; + conv[attogram_per_nanometer_nanosecondsq][atmosphere] = to_si*conv[pascal][atmosphere]; + conv[attogram_per_nanometer_nanosecondsq][bar] = to_si*conv[pascal][bar]; + conv[attogram_per_nanometer_nanosecondsq][dyne_per_centimetersq] = to_si*conv[pascal][dyne_per_centimetersq]; + conv[attogram_per_nanometer_nanosecondsq][picogram_per_micrometer_microsecondsq] = to_si*conv[pascal][picogram_per_micrometer_microsecondsq]; + conv[attogram_per_nanometer_nanosecondsq][attogram_per_nanometer_nanosecondsq] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Viscosity conversion +double get_viscosity_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[pascal_second][pascal_second] = 1.0; + conv[pascal_second][poise] = 1.0/poise_si; + conv[pascal_second][amu_per_bohr_femtosecond] = 1.0/amu_per_bohr_femtosecond_si; + conv[pascal_second][picogram_per_micrometer_microsecond] = 1.0/picogram_per_micrometer_microsecond_si; + conv[pascal_second][attogram_per_nanometer_nanosecond] = 1.0/attogram_per_nanometer_nanosecond_si; + + to_si = 1.0/conv[pascal_second][poise]; + conv[poise][pascal_second] = to_si*conv[pascal_second][pascal_second]; + conv[poise][poise] = 1.0; + conv[poise][amu_per_bohr_femtosecond] = to_si*conv[pascal_second][amu_per_bohr_femtosecond]; + conv[poise][picogram_per_micrometer_microsecond] = to_si*conv[pascal_second][picogram_per_micrometer_microsecond]; + conv[poise][attogram_per_nanometer_nanosecond] = to_si*conv[pascal_second][attogram_per_nanometer_nanosecond]; + + to_si = 1.0/conv[pascal_second][amu_per_bohr_femtosecond]; + conv[amu_per_bohr_femtosecond][pascal_second] = to_si*conv[pascal_second][pascal_second]; + conv[amu_per_bohr_femtosecond][poise] = to_si*conv[pascal_second][poise]; + conv[amu_per_bohr_femtosecond][amu_per_bohr_femtosecond] = 1.0; + conv[amu_per_bohr_femtosecond][picogram_per_micrometer_microsecond] = to_si*conv[pascal_second][picogram_per_micrometer_microsecond]; + conv[amu_per_bohr_femtosecond][attogram_per_nanometer_nanosecond] = to_si*conv[pascal_second][attogram_per_nanometer_nanosecond]; + + to_si = 1.0/conv[pascal_second][picogram_per_micrometer_microsecond]; + conv[picogram_per_micrometer_microsecond][pascal_second] = to_si*conv[pascal_second][pascal_second]; + conv[picogram_per_micrometer_microsecond][poise] = to_si*conv[pascal_second][poise]; + conv[picogram_per_micrometer_microsecond][amu_per_bohr_femtosecond] = to_si*conv[pascal_second][amu_per_bohr_femtosecond]; + conv[picogram_per_micrometer_microsecond][picogram_per_micrometer_microsecond] = 1.0; + conv[picogram_per_micrometer_microsecond][attogram_per_nanometer_nanosecond] = to_si*conv[pascal_second][attogram_per_nanometer_nanosecond]; + + to_si = 1.0/conv[pascal_second][attogram_per_nanometer_nanosecond]; + conv[attogram_per_nanometer_nanosecond][pascal_second] = to_si*conv[pascal_second][pascal_second]; + conv[attogram_per_nanometer_nanosecond][poise] = to_si*conv[pascal_second][poise]; + conv[attogram_per_nanometer_nanosecond][amu_per_bohr_femtosecond] = to_si*conv[pascal_second][amu_per_bohr_femtosecond]; + conv[attogram_per_nanometer_nanosecond][picogram_per_micrometer_microsecond] = to_si*conv[pascal_second][picogram_per_micrometer_microsecond]; + conv[attogram_per_nanometer_nanosecond][attogram_per_nanometer_nanosecond] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Charge conversion +double get_charge_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[coulomb][coulomb] = 1.0; + conv[coulomb][echarge] = 1.0/echarge_si; + conv[coulomb][statcoulomb] = 1.0/statcoulomb_si; + conv[coulomb][picocoulomb] = 1.0/picocoulomb_si; + + to_si = 1.0/conv[coulomb][echarge]; + conv[echarge][coulomb] = to_si*conv[coulomb][coulomb]; + conv[echarge][echarge] = 1.0; + conv[echarge][statcoulomb] = to_si*conv[coulomb][statcoulomb]; + conv[echarge][picocoulomb] = to_si*conv[coulomb][picocoulomb]; + + to_si = 1.0/conv[coulomb][statcoulomb]; + conv[statcoulomb][coulomb] = to_si*conv[coulomb][coulomb]; + conv[statcoulomb][echarge] = to_si*conv[coulomb][echarge]; + conv[statcoulomb][statcoulomb] = 1.0; + conv[statcoulomb][picocoulomb] = to_si*conv[coulomb][picocoulomb]; + + to_si = 1.0/conv[coulomb][picocoulomb]; + conv[picocoulomb][coulomb] = to_si*conv[coulomb][coulomb]; + conv[picocoulomb][echarge] = to_si*conv[coulomb][echarge]; + conv[picocoulomb][statcoulomb] = to_si*conv[coulomb][statcoulomb]; + conv[picocoulomb][picocoulomb] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Dipole conversion +double get_dipole_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[coulomb_meter][coulomb_meter] = 1.0; + conv[coulomb_meter][electron_angstrom] = 1.0/electron_angstrom_si; + conv[coulomb_meter][statcoulomb_centimeter] = 1.0/statcoulomb_centimeter_si; + conv[coulomb_meter][debye] = 1.0/debye_si; + conv[coulomb_meter][picocoulomb_micrometer] = 1.0/picocoulomb_micrometer_si; + conv[coulomb_meter][electron_nanometer] = 1.0/electron_nanometer_si; + + to_si = 1.0/conv[coulomb_meter][electron_angstrom]; + conv[electron_angstrom][coulomb_meter] = to_si*conv[coulomb_meter][coulomb_meter]; + conv[electron_angstrom][electron_angstrom] = 1.0; + conv[electron_angstrom][statcoulomb_centimeter] = to_si*conv[coulomb_meter][statcoulomb_centimeter]; + conv[electron_angstrom][debye] = to_si*conv[coulomb_meter][debye]; + conv[electron_angstrom][picocoulomb_micrometer] = to_si*conv[coulomb_meter][picocoulomb_micrometer]; + conv[electron_angstrom][electron_nanometer] = to_si*conv[coulomb_meter][electron_nanometer]; + + to_si = 1.0/conv[coulomb_meter][statcoulomb_centimeter]; + conv[statcoulomb_centimeter][coulomb_meter] = to_si*conv[coulomb_meter][coulomb_meter]; + conv[statcoulomb_centimeter][electron_angstrom] = to_si*conv[coulomb_meter][electron_angstrom]; + conv[statcoulomb_centimeter][statcoulomb_centimeter] = 1.0; + conv[statcoulomb_centimeter][debye] = to_si*conv[coulomb_meter][debye]; + conv[statcoulomb_centimeter][picocoulomb_micrometer] = to_si*conv[coulomb_meter][picocoulomb_micrometer]; + conv[statcoulomb_centimeter][electron_nanometer] = to_si*conv[coulomb_meter][electron_nanometer]; + + to_si = 1.0/conv[coulomb_meter][debye]; + conv[debye][coulomb_meter] = to_si*conv[coulomb_meter][coulomb_meter]; + conv[debye][electron_angstrom] = to_si*conv[coulomb_meter][electron_angstrom]; + conv[debye][statcoulomb_centimeter] = to_si*conv[coulomb_meter][statcoulomb_centimeter]; + conv[debye][debye] = 1.0; + conv[debye][picocoulomb_micrometer] = to_si*conv[coulomb_meter][picocoulomb_micrometer]; + conv[debye][electron_nanometer] = to_si*conv[coulomb_meter][electron_nanometer]; + + to_si = 1.0/conv[coulomb_meter][picocoulomb_micrometer]; + conv[picocoulomb_micrometer][coulomb_meter] = to_si*conv[coulomb_meter][coulomb_meter]; + conv[picocoulomb_micrometer][electron_angstrom] = to_si*conv[coulomb_meter][electron_angstrom]; + conv[picocoulomb_micrometer][statcoulomb_centimeter] = to_si*conv[coulomb_meter][statcoulomb_centimeter]; + conv[picocoulomb_micrometer][debye] = to_si*conv[coulomb_meter][debye]; + conv[picocoulomb_micrometer][picocoulomb_micrometer] = 1.0; + conv[picocoulomb_micrometer][electron_nanometer] = to_si*conv[coulomb_meter][electron_nanometer]; + + to_si = 1.0/conv[coulomb_meter][electron_nanometer]; + conv[electron_nanometer][coulomb_meter] = to_si*conv[coulomb_meter][coulomb_meter]; + conv[electron_nanometer][electron_angstrom] = to_si*conv[coulomb_meter][electron_angstrom]; + conv[electron_nanometer][statcoulomb_centimeter] = to_si*conv[coulomb_meter][statcoulomb_centimeter]; + conv[electron_nanometer][debye] = to_si*conv[coulomb_meter][debye]; + conv[electron_nanometer][picocoulomb_micrometer] = to_si*conv[coulomb_meter][picocoulomb_micrometer]; + conv[electron_nanometer][electron_nanometer] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Electric field conversion +double get_efield_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[volt_per_meter][volt_per_meter] = 1.0; + conv[volt_per_meter][volt_per_angstrom] = 1.0/volt_per_angstrom_si; + conv[volt_per_meter][statvolt_per_centimeter] = 1.0/statvolt_per_centimeter_si; + conv[volt_per_meter][volt_per_centimeter] = 1.0/volt_per_centimeter_si; + conv[volt_per_meter][volt_per_micrometer] = 1.0/volt_per_micrometer_si; + conv[volt_per_meter][volt_per_nanometer] = 1.0/volt_per_nanometer_si; + + to_si = 1.0/conv[volt_per_meter][volt_per_angstrom]; + conv[volt_per_angstrom][volt_per_meter] = to_si*conv[volt_per_meter][volt_per_meter]; + conv[volt_per_angstrom][volt_per_angstrom] = 1.0; + conv[volt_per_angstrom][statvolt_per_centimeter] = to_si*conv[volt_per_meter][statvolt_per_centimeter]; + conv[volt_per_angstrom][volt_per_centimeter] = to_si*conv[volt_per_meter][volt_per_centimeter]; + conv[volt_per_angstrom][volt_per_micrometer] = to_si*conv[volt_per_meter][volt_per_micrometer]; + conv[volt_per_angstrom][volt_per_nanometer] = to_si*conv[volt_per_meter][volt_per_nanometer]; + + to_si = 1.0/conv[volt_per_meter][statvolt_per_centimeter]; + conv[statvolt_per_centimeter][volt_per_meter] = to_si*conv[volt_per_meter][volt_per_meter]; + conv[statvolt_per_centimeter][volt_per_angstrom] = to_si*conv[volt_per_meter][volt_per_angstrom]; + conv[statvolt_per_centimeter][statvolt_per_centimeter] = 1.0; + conv[statvolt_per_centimeter][volt_per_centimeter] = to_si*conv[volt_per_meter][volt_per_centimeter]; + conv[statvolt_per_centimeter][volt_per_micrometer] = to_si*conv[volt_per_meter][volt_per_micrometer]; + conv[statvolt_per_centimeter][volt_per_nanometer] = to_si*conv[volt_per_meter][volt_per_nanometer]; + + to_si = 1.0/conv[volt_per_meter][volt_per_centimeter]; + conv[volt_per_centimeter][volt_per_meter] = to_si*conv[volt_per_meter][volt_per_meter]; + conv[volt_per_centimeter][volt_per_angstrom] = to_si*conv[volt_per_meter][volt_per_angstrom]; + conv[volt_per_centimeter][statvolt_per_centimeter] = to_si*conv[volt_per_meter][statvolt_per_centimeter]; + conv[volt_per_centimeter][volt_per_centimeter] = 1.0; + conv[volt_per_centimeter][volt_per_micrometer] = to_si*conv[volt_per_meter][volt_per_micrometer]; + conv[volt_per_centimeter][volt_per_nanometer] = to_si*conv[volt_per_meter][volt_per_nanometer]; + + to_si = 1.0/conv[volt_per_meter][volt_per_micrometer]; + conv[volt_per_micrometer][volt_per_meter] = to_si*conv[volt_per_meter][volt_per_meter]; + conv[volt_per_micrometer][volt_per_angstrom] = to_si*conv[volt_per_meter][volt_per_angstrom]; + conv[volt_per_micrometer][statvolt_per_centimeter] = to_si*conv[volt_per_meter][statvolt_per_centimeter]; + conv[volt_per_micrometer][volt_per_centimeter] = to_si*conv[volt_per_meter][volt_per_centimeter]; + conv[volt_per_micrometer][volt_per_micrometer] = 1.0; + conv[volt_per_micrometer][volt_per_nanometer] = to_si*conv[volt_per_meter][volt_per_nanometer]; + + to_si = 1.0/conv[volt_per_meter][volt_per_nanometer]; + conv[volt_per_nanometer][volt_per_meter] = to_si*conv[volt_per_meter][volt_per_meter]; + conv[volt_per_nanometer][volt_per_angstrom] = to_si*conv[volt_per_meter][volt_per_angstrom]; + conv[volt_per_nanometer][statvolt_per_centimeter] = to_si*conv[volt_per_meter][statvolt_per_centimeter]; + conv[volt_per_nanometer][volt_per_centimeter] = to_si*conv[volt_per_meter][volt_per_centimeter]; + conv[volt_per_nanometer][volt_per_micrometer] = to_si*conv[volt_per_meter][volt_per_micrometer]; + conv[volt_per_nanometer][volt_per_nanometer] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// Demsity conversion +double get_density_conversion_factor(units from_unit_enum, units to_unit_enum) +{ + map > conv; + double to_si; + + conv[kilogram_per_metercu][kilogram_per_metercu] = 1.0; + conv[kilogram_per_metercu][gram_per_centimetercu] = 1.0/gram_per_centimetercu_si; + conv[kilogram_per_metercu][amu_per_bohrcu] = 1.0/amu_per_bohrcu_si; + conv[kilogram_per_metercu][picogram_per_micrometercu] = 1.0/picogram_per_micrometercu_si; + conv[kilogram_per_metercu][attogram_per_nanometercu] = 1.0/attogram_per_nanometercu_si; + + to_si = 1.0/conv[kilogram_per_metercu][gram_per_centimetercu]; + conv[gram_per_centimetercu][kilogram_per_metercu] = to_si*conv[kilogram_per_metercu][kilogram_per_metercu]; + conv[gram_per_centimetercu][gram_per_centimetercu] = 1.0; + conv[gram_per_centimetercu][amu_per_bohrcu] = to_si*conv[kilogram_per_metercu][amu_per_bohrcu]; + conv[gram_per_centimetercu][picogram_per_micrometercu] = to_si*conv[kilogram_per_metercu][picogram_per_micrometercu]; + conv[gram_per_centimetercu][attogram_per_nanometercu] = to_si*conv[kilogram_per_metercu][attogram_per_nanometercu]; + + to_si = 1.0/conv[kilogram_per_metercu][amu_per_bohrcu]; + conv[amu_per_bohrcu][kilogram_per_metercu] = to_si*conv[kilogram_per_metercu][kilogram_per_metercu]; + conv[amu_per_bohrcu][gram_per_centimetercu] = to_si*conv[kilogram_per_metercu][gram_per_centimetercu]; + conv[amu_per_bohrcu][amu_per_bohrcu] = 1.0; + conv[amu_per_bohrcu][picogram_per_micrometercu] = to_si*conv[kilogram_per_metercu][picogram_per_micrometercu]; + conv[amu_per_bohrcu][attogram_per_nanometercu] = to_si*conv[kilogram_per_metercu][attogram_per_nanometercu]; + + to_si = 1.0/conv[kilogram_per_metercu][picogram_per_micrometercu]; + conv[picogram_per_micrometercu][kilogram_per_metercu] = to_si*conv[kilogram_per_metercu][kilogram_per_metercu]; + conv[picogram_per_micrometercu][gram_per_centimetercu] = to_si*conv[kilogram_per_metercu][gram_per_centimetercu]; + conv[picogram_per_micrometercu][amu_per_bohrcu] = to_si*conv[kilogram_per_metercu][amu_per_bohrcu]; + conv[picogram_per_micrometercu][picogram_per_micrometercu] = 1.0; + conv[picogram_per_micrometercu][attogram_per_nanometercu] = to_si*conv[kilogram_per_metercu][attogram_per_nanometercu]; + + to_si = 1.0/conv[kilogram_per_metercu][attogram_per_nanometercu]; + conv[attogram_per_nanometercu][kilogram_per_metercu] = to_si*conv[kilogram_per_metercu][kilogram_per_metercu]; + conv[attogram_per_nanometercu][gram_per_centimetercu] = to_si*conv[kilogram_per_metercu][gram_per_centimetercu]; + conv[attogram_per_nanometercu][amu_per_bohrcu] = to_si*conv[kilogram_per_metercu][amu_per_bohrcu]; + conv[attogram_per_nanometercu][picogram_per_micrometercu] = to_si*conv[kilogram_per_metercu][picogram_per_micrometercu]; + conv[attogram_per_nanometercu][attogram_per_nanometercu] = 1.0; + + return conv[from_unit_enum][to_unit_enum]; +} + +/* ---------------------------------------------------------------------- */ + +// This routine returns the unit conversion factor between the +// `from_system_enum` to the `to_system_enum` for the `unit_type_enum`. +double get_unit_conversion_factor(unit_type &unit_type_enum, + sys_type from_system_enum, + sys_type to_system_enum) +{ + units from_unit = get_lammps_system_unit(from_system_enum, unit_type_enum); + units to_unit = get_lammps_system_unit(to_system_enum, unit_type_enum); + switch(unit_type_enum) { + case mass : + return get_mass_conversion_factor(from_unit, to_unit); + case distance : + return get_distance_conversion_factor(from_unit, to_unit); + case time : + return get_time_conversion_factor(from_unit, to_unit); + case energy : + return get_energy_conversion_factor(from_unit, to_unit); + case velocity : + return get_velocity_conversion_factor(from_unit, to_unit); + case force : + return get_force_conversion_factor(from_unit, to_unit); + case torque : + return get_torque_conversion_factor(from_unit, to_unit); + case temperature : + return get_temperature_conversion_factor(from_unit, to_unit); + case pressure : + return get_pressure_conversion_factor(from_unit, to_unit); + case viscosity : + return get_viscosity_conversion_factor(from_unit, to_unit); + case charge : + return get_charge_conversion_factor(from_unit, to_unit); + case dipole : + return get_dipole_conversion_factor(from_unit, to_unit); + case efield : + return get_efield_conversion_factor(from_unit, to_unit); + case density : + default : // This is here to a prevent a compiler warning + return get_density_conversion_factor(from_unit, to_unit); + } +} + +} // end of anonymous name space + +/* ---------------------------------------------------------------------- */ + +// Wrapper to the routine that gets the unit conversion. Translates strings +// to enumerations and then call get_unit_conversion_factor() +int lammps_unit_conversion(string const &unit_type_str, + string const &from_system_str, + string const &to_system_str, + double &conversion_factor) +{ + // initialize + conversion_factor = 0.0; + initialize_dictionaries(); + + // convert input to enumeration + unit_type unit_type_enum; + { + map::const_iterator itr = unit_dic.find(unit_type_str); + if (itr != unit_dic.end()) unit_type_enum = itr->second; + else return 1; // error + } + sys_type from_system_enum; + { + map::const_iterator + itr = system_dic.find(from_system_str); + if (itr != system_dic.end()) from_system_enum = itr->second; + else return 1; // error + } + sys_type to_system_enum; + { + map::const_iterator + itr = system_dic.find(to_system_str); + if (itr != system_dic.end()) to_system_enum = itr->second; + else return 1; + } + + // process unit conversions + conversion_factor = get_unit_conversion_factor(unit_type_enum, + from_system_enum, + to_system_enum); + return 0; +} + + diff --git a/src/KIM/kim_units.h b/src/KIM/kim_units.h new file mode 100644 index 0000000000..97e81a6222 --- /dev/null +++ b/src/KIM/kim_units.h @@ -0,0 +1,59 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Ellad B. Tadmor (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.0.2 (and newer) package +------------------------------------------------------------------------- */ + +int lammps_unit_conversion(std::string const &unit_type_str, + std::string const &from_system_str, + std::string const &to_system_str, + double &conversion_factor); -- GitLab From dbfd1fd0e739aa9ff263fe5e6d88f73d44d2569d Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Fri, 21 Jun 2019 22:11:58 -0500 Subject: [PATCH 064/469] Added atom-type-num-list mapping to kim_style --- src/KIM/kim_style.cpp | 156 +++++++++++++++++++++++++++++++++++++++--- src/KIM/kim_style.h | 5 +- 2 files changed, 149 insertions(+), 12 deletions(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index 44d5c411ab..161bc31643 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -77,6 +77,10 @@ extern "C" { #include "KIM_SimulatorModel.hpp" //@@@@@ +#define SNUM(x) \ + static_cast(std::ostringstream() \ + << std::dec << x).str() + using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ @@ -257,7 +261,7 @@ void KimStyle::determine_model_type_and_units(char * model_name, if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) { std::stringstream mesg; - mesg << "Incompatible units for KIM Simulator Model, required units = " + mesg << "Incompatible units for KIM Simulator Model, required units = " << *model_units; error->all(FLERR,mesg.str().c_str()); } @@ -357,18 +361,18 @@ void KimStyle::do_init(char *model_name, char *user_units, char* model_units) /* ---------------------------------------------------------------------- */ -void KimStyle::kim_style_log_delimiter(std::string begin_end, - std::string model_setup) +void KimStyle::kim_style_log_delimiter(std::string const begin_end, + std::string const model_setup) const { if (comm->me == 0) { std::string mesg; - if ((begin_end == "begin") && (model_setup == "model")) mesg = + if ((begin_end == "begin") && (model_setup == "model")) mesg = "#=== BEGIN kim-style MODEL ==================================\n"; - else if ((begin_end == "begin") && (model_setup == "setup")) mesg = + else if ((begin_end == "begin") && (model_setup == "setup")) mesg = "#=== BEGIN kim-style SETUP ==================================\n"; - else if ((begin_end == "end") && (model_setup == "model")) mesg = + else if ((begin_end == "end") && (model_setup == "model")) mesg = "#=== END kim-style MODEL ====================================\n\n"; - else if ((begin_end == "end") && (model_setup == "setup")) mesg = + else if ((begin_end == "end") && (model_setup == "setup")) mesg = "#=== END kim-style SETUP ====================================\n\n"; if (screen) fputs(mesg.c_str(),screen); @@ -403,12 +407,19 @@ void KimStyle::do_setup(int narg, char **arg) if (simulatorModel) { + std::string delimiter(""); std::string atom_type_sym_list; + std::string atom_type_num_list; for (int i = 0; i < narg; i++) - atom_type_sym_list += std::string(" ") + arg[i]; + { + atom_type_sym_list += delimiter + arg[i]; + atom_type_num_list += delimiter + SNUM(species_to_atomic_no(arg[i])); + delimiter = " "; + } simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); + simulatorModel->AddTemplateMap("atom-type-num-list",atom_type_num_list); simulatorModel->CloseTemplateMap(); int len = strlen(atom_type_sym_list.c_str())+1; @@ -533,10 +544,10 @@ void KimStyle::do_variables(char *user_units, char *model_units) (char *)"dipole", (char *)"efield", (char *)"density"}; - + if (comm->me == 0) { std::stringstream mesg; - mesg << "# Conversion factors from " << from << " to " << to + mesg << "# Conversion factors from " << from << " to " << to << ":" << std::endl; if (screen) fputs(mesg.str().c_str(),screen); if (logfile) fputs(mesg.str().c_str(),logfile); @@ -575,3 +586,128 @@ void KimStyle::do_variables(char *user_units, char *model_units) if (logfile) fputs("#\n",logfile); } } + +/* ---------------------------------------------------------------------- */ + +int KimStyle::species_to_atomic_no(std::string const species) const +{ + if (species == "H") return 1; + else if (species == "He") return 2; + else if (species == "Li") return 3; + else if (species == "Be") return 4; + else if (species == "B") return 5; + else if (species == "C") return 6; + else if (species == "N") return 7; + else if (species == "O") return 8; + else if (species == "F") return 9; + else if (species == "Ne") return 10; + else if (species == "Na") return 11; + else if (species == "Mg") return 12; + else if (species == "Al") return 13; + else if (species == "Si") return 14; + else if (species == "P") return 15; + else if (species == "S") return 16; + else if (species == "Cl") return 17; + else if (species == "Ar") return 18; + else if (species == "K") return 19; + else if (species == "Ca") return 20; + else if (species == "Sc") return 21; + else if (species == "Ti") return 22; + else if (species == "V") return 23; + else if (species == "Cr") return 24; + else if (species == "Mn") return 25; + else if (species == "Fe") return 26; + else if (species == "Co") return 27; + else if (species == "Ni") return 28; + else if (species == "Cu") return 29; + else if (species == "Zn") return 30; + else if (species == "Ga") return 31; + else if (species == "Ge") return 32; + else if (species == "As") return 33; + else if (species == "Se") return 34; + else if (species == "Br") return 35; + else if (species == "Kr") return 36; + else if (species == "Rb") return 37; + else if (species == "Sr") return 38; + else if (species == "Y") return 39; + else if (species == "Zr") return 40; + else if (species == "Nb") return 41; + else if (species == "Mo") return 42; + else if (species == "Tc") return 43; + else if (species == "Ru") return 44; + else if (species == "Rh") return 45; + else if (species == "Pd") return 46; + else if (species == "Ag") return 47; + else if (species == "Cd") return 48; + else if (species == "In") return 49; + else if (species == "Sn") return 50; + else if (species == "Sb") return 51; + else if (species == "Te") return 52; + else if (species == "I") return 53; + else if (species == "Xe") return 54; + else if (species == "Cs") return 55; + else if (species == "Ba") return 56; + else if (species == "La") return 57; + else if (species == "Ce") return 58; + else if (species == "Pr") return 59; + else if (species == "Nd") return 60; + else if (species == "Pm") return 61; + else if (species == "Sm") return 62; + else if (species == "Eu") return 63; + else if (species == "Gd") return 64; + else if (species == "Tb") return 65; + else if (species == "Dy") return 66; + else if (species == "Ho") return 67; + else if (species == "Er") return 68; + else if (species == "Tm") return 69; + else if (species == "Yb") return 70; + else if (species == "Lu") return 71; + else if (species == "Hf") return 72; + else if (species == "Ta") return 73; + else if (species == "W") return 74; + else if (species == "Re") return 75; + else if (species == "Os") return 76; + else if (species == "Ir") return 77; + else if (species == "Pt") return 78; + else if (species == "Au") return 79; + else if (species == "Hg") return 80; + else if (species == "Tl") return 81; + else if (species == "Pb") return 82; + else if (species == "Bi") return 83; + else if (species == "Po") return 84; + else if (species == "At") return 85; + else if (species == "Rn") return 86; + else if (species == "Fr") return 87; + else if (species == "Ra") return 88; + else if (species == "Ac") return 89; + else if (species == "Th") return 90; + else if (species == "Pa") return 91; + else if (species == "U") return 92; + else if (species == "Np") return 93; + else if (species == "Pu") return 94; + else if (species == "Am") return 95; + else if (species == "Cm") return 96; + else if (species == "Bk") return 97; + else if (species == "Cf") return 98; + else if (species == "Es") return 99; + else if (species == "Fm") return 100; + else if (species == "Md") return 101; + else if (species == "No") return 102; + else if (species == "Lr") return 103; + else if (species == "Rf") return 104; + else if (species == "Db") return 105; + else if (species == "Sg") return 106; + else if (species == "Bh") return 107; + else if (species == "Hs") return 108; + else if (species == "Mt") return 109; + else if (species == "Ds") return 110; + else if (species == "Rg") return 111; + else if (species == "Cn") return 112; + else if (species == "Nh") return 113; + else if (species == "Fl") return 114; + else if (species == "Mc") return 115; + else if (species == "Lv") return 116; + else if (species == "Ts") return 117; + else if (species == "Og") return 118; + else return -1; +} diff --git a/src/KIM/kim_style.h b/src/KIM/kim_style.h index b18f6627ea..626f2395bc 100644 --- a/src/KIM/kim_style.h +++ b/src/KIM/kim_style.h @@ -80,8 +80,9 @@ class KimStyle : protected Pointers { void do_init(char *, char *, char *); void do_setup(int, char **); void do_variables(char*, char*); - void kim_style_log_delimiter(std::string begin_end, - std::string model_setup); + int species_to_atomic_no(std::string const species) const; + void kim_style_log_delimiter(std::string const begin_end, + std::string const model_setup) const; }; } -- GitLab From f81c9c5322aa0d8e067f240639528b0292f83bb8 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sat, 22 Jun 2019 10:21:05 -0500 Subject: [PATCH 065/469] Changed _u_* output to log to variable commands --- src/KIM/kim_style.cpp | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_style.cpp index 161bc31643..a583908fc7 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_style.cpp @@ -576,7 +576,8 @@ void KimStyle::do_variables(char *user_units, char *model_units) variable->internal_set(v_unit,conversion_factor); if (comm->me == 0) { std::stringstream mesg; - mesg << "# " << var_str << " = " << conversion_factor << std::endl; + mesg << "variable " << var_str << " internal " << conversion_factor + << std::endl; if (screen) fputs(mesg.str().c_str(),screen); if (logfile) fputs(mesg.str().c_str(),logfile); } -- GitLab From 4a22e3bf70d03dd292319bdab315f2731da41eab Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Sat, 22 Jun 2019 15:21:57 -0500 Subject: [PATCH 066/469] Implement kim_init, kim_interactions & various updates --- src/KIM/README | 27 +- src/KIM/{kim_style.cpp => kim_init.cpp} | 421 +++++------------------- src/KIM/{kim_style.h => kim_init.h} | 35 +- src/KIM/kim_interactions.cpp | 367 +++++++++++++++++++++ src/KIM/kim_interactions.h | 116 +++++++ 5 files changed, 590 insertions(+), 376 deletions(-) rename src/KIM/{kim_style.cpp => kim_init.cpp} (52%) rename src/KIM/{kim_style.h => kim_init.h} (82%) create mode 100644 src/KIM/kim_interactions.cpp create mode 100644 src/KIM/kim_interactions.h diff --git a/src/KIM/README b/src/KIM/README index 4f52d69a67..e61f47426f 100644 --- a/src/KIM/README +++ b/src/KIM/README @@ -1,29 +1,30 @@ -This package provides a pair_style kim command which is a wrapper on -the Knowledge Base for Interatomic Models (KIM) repository of -interatomic potentials, so that they can be used by LAMMPS scripts. +This package provides the kim_init, kim_query, kim_interactions, and +the pair_style kim command which are wrappers on the Knowledgebase of +Interatomic Models (KIM) repository of interatomic potentials, so that +they can be used by LAMMPS scripts. Information about the KIM project can be found at https://openkim.org. -The KIM project is lead by Ellad Tadmor and Ryan Elliott (U Minn) and -James Sethna (Cornell U). Ryan Elliott is the main developer for the -KIM API and he also maintains the code that implements the pair_style -kim command. +The KIM project is lead by Ellad B. Tadmor and Ryan S. Elliott (UMN). +Ryan Elliott is the main developer for the KIM API and he also +maintains the code that implements these commands. -Using this package requires the KIM library and its models +Using this package requires the KIM-API library and its models (interatomic potentials) to be downloaded and installed on your system. The library can be downloaded and built in lib/kim or elsewhere on your system, which must be done before bulding LAMMPS with this package. Details of the download, build, and install -process for KIM are given in the lib/kim/README file, and scripts -are provided to help automate the process. Also see the LAMMPS -manual for general information on building LAMMPS with external +process for the KIM-API are given in the lib/kim/README file, and +scripts are provided to help automate the process. Also see the +LAMMPS manual for general information on building LAMMPS with external libraries. The settings in the Makefile.lammps file in lib/kim must be correct for LAMMPS to build correctly with this package installed. However, the default settings should be correct in most cases and the Makefile.lammps file usually will not need to be changed. Once you have successfully built LAMMPS with this package and the KIM -library you can test it using an input file from the examples dir: +library you can test it using an input files in the examples dir: ./lmp_serial -in lammps/examples/kim/in.kim.lj -This pair_style was written by Ryan S. Elliott (U Minn). +These commands were written by Ryan S. Elliott (UMN), Ellad B. Tadmor +(UMN) and Axel Kohlmeyer (Temple U). diff --git a/src/KIM/kim_style.cpp b/src/KIM/kim_init.cpp similarity index 52% rename from src/KIM/kim_style.cpp rename to src/KIM/kim_init.cpp index a583908fc7..695db0aa0d 100644 --- a/src/KIM/kim_style.cpp +++ b/src/KIM/kim_init.cpp @@ -14,6 +14,7 @@ /* ---------------------------------------------------------------------- Contributing authors: Axel Kohlmeyer (Temple U), Ryan S. Elliott (UMN) + Ellad B. Tadmor (UMN) ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- @@ -57,7 +58,8 @@ #include #include #include -#include "kim_style.h" +#include +#include "kim_init.h" #include "error.h" #include "atom.h" #include "comm.h" @@ -85,33 +87,26 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -void KimStyle::command(int narg, char **arg) +void KimInit::command(int narg, char **arg) { - if ((narg < 2) || (narg > 4)) error->all(FLERR,"Illegal kim_style command"); - - if (strcmp(arg[0],"model") == 0) { - if (domain->box_exist) - error->all(FLERR,"Must use 'kim_style model' command before " - "simulation box is defined"); - int len1 = strlen(arg[1])+1; - int len2 = strlen(arg[2])+1; - char *model_name = new char[len1]; strcpy(model_name,arg[1]); - char *user_units = new char[len2]; strcpy(user_units,arg[2]); - if (narg == 4) { - if (strcmp(arg[3],"unit_conversion_mode")==0) unit_conversion_mode = true; - else { error->all(FLERR,"Illegal kim_style command"); } - } else unit_conversion_mode = false; - - char *model_units; - determine_model_type_and_units(model_name, user_units, &model_units); - - do_init(model_name, user_units, model_units); - } else if (strcmp(arg[0],"setup") == 0) { - if (!domain->box_exist) - error->all(FLERR,"Must use 'kim_style setup' command after " - "simulation box is defined"); - do_setup(narg-1,++arg); - } else error->all(FLERR,"Illegal kim_style command"); + if ((narg < 2) || (narg > 3)) error->all(FLERR,"Illegal kim_init command"); + + if (domain->box_exist) + error->all(FLERR,"Must use 'kim_init' command before " + "simulation box is defined"); + int len0 = strlen(arg[0])+1; + int len1 = strlen(arg[1])+1; + char *model_name = new char[len0]; strcpy(model_name,arg[0]); + char *user_units = new char[len1]; strcpy(user_units,arg[1]); + if (narg == 3) { + if (strcmp(arg[2],"unit_conversion_mode")==0) unit_conversion_mode = true; + else { error->all(FLERR,"Illegal kim_init command"); } + } else unit_conversion_mode = false; + + char *model_units; + determine_model_type_and_units(model_name, user_units, &model_units); + + do_init(model_name, user_units, model_units); } @@ -163,9 +158,9 @@ void get_kim_unit_names( } } } // namespace -void KimStyle::determine_model_type_and_units(char * model_name, - char * user_units, - char ** model_units) +void KimInit::determine_model_type_and_units(char * model_name, + char * user_units, + char ** model_units) { KIM_LengthUnit lengthUnit; KIM_EnergyUnit energyUnit; @@ -270,7 +265,7 @@ void KimStyle::determine_model_type_and_units(char * model_name, /* ---------------------------------------------------------------------- */ -void KimStyle::do_init(char *model_name, char *user_units, char* model_units) +void KimInit::do_init(char *model_name, char *user_units, char* model_units) { // create storage proxy fix. delete existing fix, if needed. @@ -288,229 +283,102 @@ void KimStyle::do_init(char *model_name, char *user_units, char* model_units) fix_store->setptr("user_units", (void *) user_units); fix_store->setptr("model_units", (void *) model_units); + // Begin output to log file + kim_init_log_delimiter("begin"); + int kimerror; // @@@@@ switch to c-bindings when they are available KIM::SimulatorModel * simulatorModel; - kimerror = KIM::SimulatorModel::Create(model_name,&simulatorModel); - - const std::string *sim_name, *sim_version; - simulatorModel->GetSimulatorNameAndVersion(&sim_name, &sim_version); - - if (*sim_name != "LAMMPS") - error->all(FLERR,"Incompatible KIM Simulator Model"); - - // Begin output to log file - kim_style_log_delimiter("begin","model"); - if (comm->me == 0) { - std::string mesg("# Using KIM Simulator Model : "); - mesg += model_name; - mesg += "\n"; - mesg += "# For Simulator : "; - mesg += *sim_name + " " + *sim_version + "\n"; - mesg += "# Running on : LAMMPS "; - mesg += universe->version; - mesg += "\n"; - mesg += "#\n"; - - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); - } - - // Define unit conversion factor variables and print to log - if (unit_conversion_mode) do_variables(user_units, model_units); - - // set units - - std::string cmd("units "); - cmd += model_units; - input->one(cmd.c_str()); - - // not a Kim Simulator Model; nothing else to do here. - - if (kimerror) return; - - fix_store->setptr("simulator_model", (void *) simulatorModel); - - // need to call this to have access to (some) simulator model init data. - - simulatorModel->CloseTemplateMap(); - - int sim_fields, sim_lines; - const std::string *sim_field, *sim_value; - simulatorModel->GetNumberOfSimulatorFields(&sim_fields); - - // init model - - for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "model-init") { - for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); - input->one(sim_value->c_str()); - } - break; - } - } - - // End output to log file - kim_style_log_delimiter("end","model"); + if (model_type == SM) + { + kimerror = KIM::SimulatorModel::Create(model_name,&simulatorModel); - // reset template map. - simulatorModel->OpenAndInitializeTemplateMap(); -} + const std::string *sim_name, *sim_version; + simulatorModel->GetSimulatorNameAndVersion(&sim_name, &sim_version); -/* ---------------------------------------------------------------------- */ + if (*sim_name != "LAMMPS") + error->all(FLERR,"Incompatible KIM Simulator Model"); -void KimStyle::kim_style_log_delimiter(std::string const begin_end, - std::string const model_setup) const -{ if (comm->me == 0) { - std::string mesg; - if ((begin_end == "begin") && (model_setup == "model")) mesg = - "#=== BEGIN kim-style MODEL ==================================\n"; - else if ((begin_end == "begin") && (model_setup == "setup")) mesg = - "#=== BEGIN kim-style SETUP ==================================\n"; - else if ((begin_end == "end") && (model_setup == "model")) mesg = - "#=== END kim-style MODEL ====================================\n\n"; - else if ((begin_end == "end") && (model_setup == "setup")) mesg = - "#=== END kim-style SETUP ====================================\n\n"; + std::string mesg("# Using KIM Simulator Model : "); + mesg += model_name; + mesg += "\n"; + mesg += "# For Simulator : "; + mesg += *sim_name + " " + *sim_version + "\n"; + mesg += "# Running on : LAMMPS "; + mesg += universe->version; + mesg += "\n"; + mesg += "#\n"; if (screen) fputs(mesg.c_str(),screen); if (logfile) fputs(mesg.c_str(),logfile); } -} - -/* ---------------------------------------------------------------------- */ - -void KimStyle::do_setup(int narg, char **arg) -{ - if (narg != atom->ntypes) - error->all(FLERR,"Illegal kim_style command"); - char *model = NULL; - KIM::SimulatorModel *simulatorModel(NULL); + fix_store->setptr("simulator_model", (void *) simulatorModel); - // check if we had a kim_style init command by finding fix STORE/KIM - // retrieve model name and pointer to simulator model class instance. - // validate model name if not given as NULL. - // if kim_style init wasn't run try to initialize simulator model now. + // need to call this to have access to (some) simulator model init data. - int ifix = modify->find_fix("KIM_MODEL_STORE"); - if (ifix >= 0) { - FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; - model = (char *)fix_store->getptr("model_name"); - simulatorModel = (KIM::SimulatorModel *)fix_store->getptr("simulator_model"); - } else error->all(FLERR,"Must use 'kim_style model' before 'kim_style setup'"); - - // Begin output to log file - kim_style_log_delimiter("begin","setup"); - - if (simulatorModel) { - - std::string delimiter(""); - std::string atom_type_sym_list; - std::string atom_type_num_list; - - for (int i = 0; i < narg; i++) - { - atom_type_sym_list += delimiter + arg[i]; - atom_type_num_list += delimiter + SNUM(species_to_atomic_no(arg[i])); - delimiter = " "; - } - - simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); - simulatorModel->AddTemplateMap("atom-type-num-list",atom_type_num_list); simulatorModel->CloseTemplateMap(); + } - int len = strlen(atom_type_sym_list.c_str())+1; - char *strbuf = new char[len]; - char *strword; - - // validate species selection - - int sim_num_species; - bool species_is_supported; - const std::string *sim_species; - simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); - strcpy(strbuf,atom_type_sym_list.c_str()); - strword = strtok(strbuf," \t"); - while (strword) { - species_is_supported = false; - if (strcmp(strword,"NULL") == 0) continue; - for (int i=0; i < sim_num_species; ++i) { - simulatorModel->GetSupportedSpecies(i, &sim_species); - if (strcmp(sim_species->c_str(),strword) == 0) - species_is_supported = true; - } - if (!species_is_supported) { - std::string msg("Species '"); - msg += strword; - msg += "' is not supported by this KIM Simulator Model"; - error->all(FLERR,msg.c_str()); - } - strword = strtok(NULL," \t"); - } - delete[] strbuf; + // Define unit conversion factor variables and print to log + if (unit_conversion_mode) do_variables(user_units, model_units); - // check if units are unchanged, and if kim_style init was required + // set units + std::string cmd("units "); + cmd += model_units; + input->one(cmd.c_str()); + + if (model_type == SM) + { int sim_fields, sim_lines; const std::string *sim_field, *sim_value; simulatorModel->GetNumberOfSimulatorFields(&sim_fields); - for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "units") { - simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); - if (*sim_value != update->unit_style) - error->all(FLERR,"Incompatible units for KIM Simulator Model"); - } - } + // init model - int sim_model_idx=-1; for (int i=0; i < sim_fields; ++i) { simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "model-defn") { - sim_model_idx = i; + if (*sim_field == "model-init") { for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); + simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); input->one(sim_value->c_str()); } + break; } } - if (sim_model_idx < 0) - error->all(FLERR,"KIM Simulator Model has no Model definition"); - + // reset template map. simulatorModel->OpenAndInitializeTemplateMap(); + } - } else { + // End output to log file + kim_init_log_delimiter("end"); - // not a simulator model. issue pair_style and pair_coeff commands. - // NOTE: all references to arg must appear before calls to input->one() - // as that will reset the argument vector. +} - std::string cmd1("pair_style kim "); - cmd1 += model; +/* ---------------------------------------------------------------------- */ - std::string cmd2("pair_coeff * * "); - for (int i=0; i < narg; ++i) { - cmd2 += arg[i]; - cmd2 += " "; - } +void KimInit::kim_init_log_delimiter(std::string const begin_end) const +{ + if (comm->me == 0) { + std::string mesg; + if (begin_end == "begin") + mesg = + "#=== BEGIN kim-init ==========================================\n"; + else if (begin_end == "end") + mesg = + "#=== END kim-init ============================================\n\n"; - input->one(cmd1.c_str()); - input->one(cmd2.c_str()); + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); } - - // End output to log file - kim_style_log_delimiter("end","setup"); - } /* ---------------------------------------------------------------------- */ -void KimStyle::do_variables(char *user_units, char *model_units) +void KimInit::do_variables(char *user_units, char *model_units) { char *from = user_units, *to = model_units; Variable *variable = input->variable; @@ -576,7 +444,9 @@ void KimStyle::do_variables(char *user_units, char *model_units) variable->internal_set(v_unit,conversion_factor); if (comm->me == 0) { std::stringstream mesg; - mesg << "variable " << var_str << " internal " << conversion_factor + mesg << "variable " << std::setw(15) << std::left << var_str + << " internal " + << std::setprecision(12) << std::scientific << conversion_factor << std::endl; if (screen) fputs(mesg.str().c_str(),screen); if (logfile) fputs(mesg.str().c_str(),logfile); @@ -587,128 +457,3 @@ void KimStyle::do_variables(char *user_units, char *model_units) if (logfile) fputs("#\n",logfile); } } - -/* ---------------------------------------------------------------------- */ - -int KimStyle::species_to_atomic_no(std::string const species) const -{ - if (species == "H") return 1; - else if (species == "He") return 2; - else if (species == "Li") return 3; - else if (species == "Be") return 4; - else if (species == "B") return 5; - else if (species == "C") return 6; - else if (species == "N") return 7; - else if (species == "O") return 8; - else if (species == "F") return 9; - else if (species == "Ne") return 10; - else if (species == "Na") return 11; - else if (species == "Mg") return 12; - else if (species == "Al") return 13; - else if (species == "Si") return 14; - else if (species == "P") return 15; - else if (species == "S") return 16; - else if (species == "Cl") return 17; - else if (species == "Ar") return 18; - else if (species == "K") return 19; - else if (species == "Ca") return 20; - else if (species == "Sc") return 21; - else if (species == "Ti") return 22; - else if (species == "V") return 23; - else if (species == "Cr") return 24; - else if (species == "Mn") return 25; - else if (species == "Fe") return 26; - else if (species == "Co") return 27; - else if (species == "Ni") return 28; - else if (species == "Cu") return 29; - else if (species == "Zn") return 30; - else if (species == "Ga") return 31; - else if (species == "Ge") return 32; - else if (species == "As") return 33; - else if (species == "Se") return 34; - else if (species == "Br") return 35; - else if (species == "Kr") return 36; - else if (species == "Rb") return 37; - else if (species == "Sr") return 38; - else if (species == "Y") return 39; - else if (species == "Zr") return 40; - else if (species == "Nb") return 41; - else if (species == "Mo") return 42; - else if (species == "Tc") return 43; - else if (species == "Ru") return 44; - else if (species == "Rh") return 45; - else if (species == "Pd") return 46; - else if (species == "Ag") return 47; - else if (species == "Cd") return 48; - else if (species == "In") return 49; - else if (species == "Sn") return 50; - else if (species == "Sb") return 51; - else if (species == "Te") return 52; - else if (species == "I") return 53; - else if (species == "Xe") return 54; - else if (species == "Cs") return 55; - else if (species == "Ba") return 56; - else if (species == "La") return 57; - else if (species == "Ce") return 58; - else if (species == "Pr") return 59; - else if (species == "Nd") return 60; - else if (species == "Pm") return 61; - else if (species == "Sm") return 62; - else if (species == "Eu") return 63; - else if (species == "Gd") return 64; - else if (species == "Tb") return 65; - else if (species == "Dy") return 66; - else if (species == "Ho") return 67; - else if (species == "Er") return 68; - else if (species == "Tm") return 69; - else if (species == "Yb") return 70; - else if (species == "Lu") return 71; - else if (species == "Hf") return 72; - else if (species == "Ta") return 73; - else if (species == "W") return 74; - else if (species == "Re") return 75; - else if (species == "Os") return 76; - else if (species == "Ir") return 77; - else if (species == "Pt") return 78; - else if (species == "Au") return 79; - else if (species == "Hg") return 80; - else if (species == "Tl") return 81; - else if (species == "Pb") return 82; - else if (species == "Bi") return 83; - else if (species == "Po") return 84; - else if (species == "At") return 85; - else if (species == "Rn") return 86; - else if (species == "Fr") return 87; - else if (species == "Ra") return 88; - else if (species == "Ac") return 89; - else if (species == "Th") return 90; - else if (species == "Pa") return 91; - else if (species == "U") return 92; - else if (species == "Np") return 93; - else if (species == "Pu") return 94; - else if (species == "Am") return 95; - else if (species == "Cm") return 96; - else if (species == "Bk") return 97; - else if (species == "Cf") return 98; - else if (species == "Es") return 99; - else if (species == "Fm") return 100; - else if (species == "Md") return 101; - else if (species == "No") return 102; - else if (species == "Lr") return 103; - else if (species == "Rf") return 104; - else if (species == "Db") return 105; - else if (species == "Sg") return 106; - else if (species == "Bh") return 107; - else if (species == "Hs") return 108; - else if (species == "Mt") return 109; - else if (species == "Ds") return 110; - else if (species == "Rg") return 111; - else if (species == "Cn") return 112; - else if (species == "Nh") return 113; - else if (species == "Fl") return 114; - else if (species == "Mc") return 115; - else if (species == "Lv") return 116; - else if (species == "Ts") return 117; - else if (species == "Og") return 118; - else return -1; -} diff --git a/src/KIM/kim_style.h b/src/KIM/kim_init.h similarity index 82% rename from src/KIM/kim_style.h rename to src/KIM/kim_init.h index 626f2395bc..c22e2be720 100644 --- a/src/KIM/kim_style.h +++ b/src/KIM/kim_init.h @@ -14,6 +14,7 @@ /* ---------------------------------------------------------------------- Contributing authors: Axel Kohlmeyer (Temple U), Ryan S. Elliott (UMN) + Ellad B. Tadmor (UMN) ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- @@ -56,20 +57,20 @@ #ifdef COMMAND_CLASS -CommandStyle(kim_style,KimStyle) +CommandStyle(kim_init,KimInit) #else -#ifndef LMP_KIM_STYLE_H -#define LMP_KIM_STYLE_H +#ifndef LMP_KIM_INIT_H +#define LMP_KIM_INIT_H #include "pointers.h" namespace LAMMPS_NS { -class KimStyle : protected Pointers { +class KimInit : protected Pointers { public: - KimStyle(class LAMMPS *lmp) : Pointers(lmp) {}; + KimInit(class LAMMPS *lmp) : Pointers(lmp) {}; void command(int, char **); private: enum model_type_enum {MO, SM}; @@ -78,11 +79,8 @@ class KimStyle : protected Pointers { void determine_model_type_and_units(char *, char *, char **); void do_init(char *, char *, char *); - void do_setup(int, char **); void do_variables(char*, char*); - int species_to_atomic_no(std::string const species) const; - void kim_style_log_delimiter(std::string const begin_end, - std::string const model_setup) const; + void kim_init_log_delimiter(std::string const begin_end) const; }; } @@ -92,19 +90,11 @@ class KimStyle : protected Pointers { /* ERROR/WARNING messages: -E: Illegal kim_style command +E: Illegal kim_init command -Incorrect number or kind of arguments to kim_style. +Incorrect number or kind of arguments to kim_init. -E: Must use 'kim_style model' command before simulation box is defined - -Self-explanatory. - -E: Must use 'kim_style setup' command after simulation box is defined - -Self-explanatory. - -E: Must use 'kim_style model' command before 'kim_style setup' +E: Must use 'kim_init' command before simulation box is defined Self-explanatory. @@ -125,11 +115,6 @@ E: Incompatible KIM Simulator Model The requested KIM Simulator Model was defined for a different MD code and thus is not compatible with LAMMPS. -E: Species XXX is not supported by this KIM Simulator Model - -The kim_style define command was referencing a species that is not -present in the requested KIM Simulator Model. - E: Incompatible units for KIM Simulator Model The selected unit style is not compatible with the requested KIM diff --git a/src/KIM/kim_interactions.cpp b/src/KIM/kim_interactions.cpp new file mode 100644 index 0000000000..491d406ae6 --- /dev/null +++ b/src/KIM/kim_interactions.cpp @@ -0,0 +1,367 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Axel Kohlmeyer (Temple U), + Ryan S. Elliott (UMN) + Ellad B. Tadmor (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.1.0 (and newer) package +------------------------------------------------------------------------- */ + +#include +#include +#include +#include "kim_interactions.h" +#include "error.h" +#include "atom.h" +#include "comm.h" +#include "domain.h" +#include "modify.h" +#include "update.h" +#include "universe.h" +#include "input.h" +#include "variable.h" +#include "fix_store_kim.h" + +extern "C" { +#include "KIM_SimulatorHeaders.h" +} +//@@@@@ Need to switch to c-bindings when they are available. +#include "KIM_SimulatorModel.hpp" +//@@@@@ + +#define SNUM(x) \ + static_cast(std::ostringstream() \ + << std::dec << x).str() + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +void KimInteractions::command(int narg, char **arg) +{ + if (narg < 1) error->all(FLERR,"Illegal kim_interactions command"); + + if (!domain->box_exist) + error->all(FLERR,"Must use 'kim_interactions' command after " + "simulation box is defined"); + do_setup(narg,arg); +} + +/* ---------------------------------------------------------------------- */ + +void KimInteractions::kim_interactions_log_delimiter( + std::string const begin_end) const +{ + if (comm->me == 0) { + std::string mesg; + if (begin_end == "begin") + mesg = + "#=== BEGIN kim_interactions ==================================\n"; + else if (begin_end == "end") + mesg = + "#=== END kim_interactions ====================================\n\n"; + + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); + } +} + +/* ---------------------------------------------------------------------- */ + +void KimInteractions::do_setup(int narg, char **arg) +{ + if (narg != atom->ntypes) + error->all(FLERR,"Illegal kim_interactions command"); + + char *model_name = NULL; + KIM::SimulatorModel *simulatorModel(NULL); + + // check if we had a kim_init command by finding fix STORE/KIM + // retrieve model name and pointer to simulator model class instance. + // validate model name if not given as NULL. + + int ifix = modify->find_fix("KIM_MODEL_STORE"); + if (ifix >= 0) { + FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; + model_name = (char *)fix_store->getptr("model_name"); + simulatorModel = (KIM::SimulatorModel *)fix_store->getptr("simulator_model"); + } else error->all(FLERR,"Must use 'kim_init' before 'kim_interactions'"); + + // Begin output to log file + kim_interactions_log_delimiter("begin"); + + if (simulatorModel) { + + std::string delimiter(""); + std::string atom_type_sym_list; + std::string atom_type_num_list; + + for (int i = 0; i < narg; i++) + { + atom_type_sym_list += delimiter + arg[i]; + atom_type_num_list += delimiter + SNUM(species_to_atomic_no(arg[i])); + delimiter = " "; + } + + simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); + simulatorModel->AddTemplateMap("atom-type-num-list",atom_type_num_list); + simulatorModel->CloseTemplateMap(); + + int len = strlen(atom_type_sym_list.c_str())+1; + char *strbuf = new char[len]; + char *strword; + + // validate species selection + + int sim_num_species; + bool species_is_supported; + const std::string *sim_species; + simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); + strcpy(strbuf,atom_type_sym_list.c_str()); + strword = strtok(strbuf," \t"); + while (strword) { + species_is_supported = false; + if (strcmp(strword,"NULL") == 0) continue; + for (int i=0; i < sim_num_species; ++i) { + simulatorModel->GetSupportedSpecies(i, &sim_species); + if (strcmp(sim_species->c_str(),strword) == 0) + species_is_supported = true; + } + if (!species_is_supported) { + std::string msg("Species '"); + msg += strword; + msg += "' is not supported by this KIM Simulator Model"; + error->all(FLERR,msg.c_str()); + } + strword = strtok(NULL," \t"); + } + delete[] strbuf; + + // check if units are unchanged + + int sim_fields, sim_lines; + const std::string *sim_field, *sim_value; + simulatorModel->GetNumberOfSimulatorFields(&sim_fields); + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + + if (*sim_field == "units") { + simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); + if (*sim_value != update->unit_style) + error->all(FLERR,"Incompatible units for KIM Simulator Model"); + } + } + + int sim_model_idx=-1; + for (int i=0; i < sim_fields; ++i) { + simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + if (*sim_field == "model-defn") { + sim_model_idx = i; + for (int j=0; j < sim_lines; ++j) { + simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); + input->one(sim_value->c_str()); + } + } + } + + if (sim_model_idx < 0) + error->all(FLERR,"KIM Simulator Model has no Model definition"); + + simulatorModel->OpenAndInitializeTemplateMap(); + + } else { + + // not a simulator model. issue pair_style and pair_coeff commands. + // NOTE: all references to arg must appear before calls to input->one() + // as that will reset the argument vector. + + std::string cmd1("pair_style kim "); + cmd1 += model_name; + + std::string cmd2("pair_coeff * * "); + for (int i=0; i < narg; ++i) { + cmd2 += arg[i]; + cmd2 += " "; + } + + input->one(cmd1.c_str()); + input->one(cmd2.c_str()); + } + + // End output to log file + kim_interactions_log_delimiter("end"); + +} + +/* ---------------------------------------------------------------------- */ + +int KimInteractions::species_to_atomic_no(std::string const species) const +{ + if (species == "H") return 1; + else if (species == "He") return 2; + else if (species == "Li") return 3; + else if (species == "Be") return 4; + else if (species == "B") return 5; + else if (species == "C") return 6; + else if (species == "N") return 7; + else if (species == "O") return 8; + else if (species == "F") return 9; + else if (species == "Ne") return 10; + else if (species == "Na") return 11; + else if (species == "Mg") return 12; + else if (species == "Al") return 13; + else if (species == "Si") return 14; + else if (species == "P") return 15; + else if (species == "S") return 16; + else if (species == "Cl") return 17; + else if (species == "Ar") return 18; + else if (species == "K") return 19; + else if (species == "Ca") return 20; + else if (species == "Sc") return 21; + else if (species == "Ti") return 22; + else if (species == "V") return 23; + else if (species == "Cr") return 24; + else if (species == "Mn") return 25; + else if (species == "Fe") return 26; + else if (species == "Co") return 27; + else if (species == "Ni") return 28; + else if (species == "Cu") return 29; + else if (species == "Zn") return 30; + else if (species == "Ga") return 31; + else if (species == "Ge") return 32; + else if (species == "As") return 33; + else if (species == "Se") return 34; + else if (species == "Br") return 35; + else if (species == "Kr") return 36; + else if (species == "Rb") return 37; + else if (species == "Sr") return 38; + else if (species == "Y") return 39; + else if (species == "Zr") return 40; + else if (species == "Nb") return 41; + else if (species == "Mo") return 42; + else if (species == "Tc") return 43; + else if (species == "Ru") return 44; + else if (species == "Rh") return 45; + else if (species == "Pd") return 46; + else if (species == "Ag") return 47; + else if (species == "Cd") return 48; + else if (species == "In") return 49; + else if (species == "Sn") return 50; + else if (species == "Sb") return 51; + else if (species == "Te") return 52; + else if (species == "I") return 53; + else if (species == "Xe") return 54; + else if (species == "Cs") return 55; + else if (species == "Ba") return 56; + else if (species == "La") return 57; + else if (species == "Ce") return 58; + else if (species == "Pr") return 59; + else if (species == "Nd") return 60; + else if (species == "Pm") return 61; + else if (species == "Sm") return 62; + else if (species == "Eu") return 63; + else if (species == "Gd") return 64; + else if (species == "Tb") return 65; + else if (species == "Dy") return 66; + else if (species == "Ho") return 67; + else if (species == "Er") return 68; + else if (species == "Tm") return 69; + else if (species == "Yb") return 70; + else if (species == "Lu") return 71; + else if (species == "Hf") return 72; + else if (species == "Ta") return 73; + else if (species == "W") return 74; + else if (species == "Re") return 75; + else if (species == "Os") return 76; + else if (species == "Ir") return 77; + else if (species == "Pt") return 78; + else if (species == "Au") return 79; + else if (species == "Hg") return 80; + else if (species == "Tl") return 81; + else if (species == "Pb") return 82; + else if (species == "Bi") return 83; + else if (species == "Po") return 84; + else if (species == "At") return 85; + else if (species == "Rn") return 86; + else if (species == "Fr") return 87; + else if (species == "Ra") return 88; + else if (species == "Ac") return 89; + else if (species == "Th") return 90; + else if (species == "Pa") return 91; + else if (species == "U") return 92; + else if (species == "Np") return 93; + else if (species == "Pu") return 94; + else if (species == "Am") return 95; + else if (species == "Cm") return 96; + else if (species == "Bk") return 97; + else if (species == "Cf") return 98; + else if (species == "Es") return 99; + else if (species == "Fm") return 100; + else if (species == "Md") return 101; + else if (species == "No") return 102; + else if (species == "Lr") return 103; + else if (species == "Rf") return 104; + else if (species == "Db") return 105; + else if (species == "Sg") return 106; + else if (species == "Bh") return 107; + else if (species == "Hs") return 108; + else if (species == "Mt") return 109; + else if (species == "Ds") return 110; + else if (species == "Rg") return 111; + else if (species == "Cn") return 112; + else if (species == "Nh") return 113; + else if (species == "Fl") return 114; + else if (species == "Mc") return 115; + else if (species == "Lv") return 116; + else if (species == "Ts") return 117; + else if (species == "Og") return 118; + else return -1; +} diff --git a/src/KIM/kim_interactions.h b/src/KIM/kim_interactions.h new file mode 100644 index 0000000000..6da1880f84 --- /dev/null +++ b/src/KIM/kim_interactions.h @@ -0,0 +1,116 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: Axel Kohlmeyer (Temple U), + Ryan S. Elliott (UMN) + Ellad B. Tadmor (UMN) +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + This program is free software; you can redistribute it and/or modify it + under the terms of the GNU General Public License as published by the Free + Software Foundation; either version 2 of the License, or (at your option) + any later version. + + This program is distributed in the hope that it will be useful, but WITHOUT + ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or + FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for + more details. + + You should have received a copy of the GNU General Public License along with + this program; if not, see . + + Linking LAMMPS statically or dynamically with other modules is making a + combined work based on LAMMPS. Thus, the terms and conditions of the GNU + General Public License cover the whole combination. + + In addition, as a special exception, the copyright holders of LAMMPS give + you permission to combine LAMMPS with free software programs or libraries + that are released under the GNU LGPL and with code included in the standard + release of the "kim-api" under the CDDL (or modified versions of such code, + with unchanged license). You may copy and distribute such a system following + the terms of the GNU GPL for LAMMPS and the licenses of the other code + concerned, provided that you include the source code of that other code + when and as the GNU GPL requires distribution of source code. + + Note that people who make modified versions of LAMMPS are not obligated to + grant this special exception for their modified versions; it is their choice + whether to do so. The GNU General Public License gives permission to release + a modified version without this exception; this exception also makes it + possible to release a modified version which carries forward this exception. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Designed for use with the kim-api-2.1.0 (and newer) package +------------------------------------------------------------------------- */ + +#ifdef COMMAND_CLASS + +CommandStyle(kim_interactions,KimInteractions) + +#else + +#ifndef LMP_KIM_INTERACTIONS_H +#define LMP_KIM_INTERACTIONS_H + +#include "pointers.h" + +namespace LAMMPS_NS { + +class KimInteractions : protected Pointers { + public: + KimInteractions(class LAMMPS *lmp) : Pointers(lmp) {}; + void command(int, char **); + private: + void do_setup(int, char **); + int species_to_atomic_no(std::string const species) const; + void kim_interactions_log_delimiter(std::string const begin_end) const; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal kim_interactions command + +Incorrect number or kind of arguments to kim_interactions. + +E: Must use 'kim_interactions' command after simulation box is defined + +Self-explanatory. + +E: Must use 'kim_init' command before 'kim_interactions' + +Self-explanatory. + +E: Species XXX is not supported by this KIM Simulator Model + +The kim_interactions command was referencing a species that is not +present in the requested KIM Simulator Model. + +E: Incompatible units for KIM Simulator Model + +The selected unit style is not compatible with the requested KIM +Simulator Model. + +E: KIM Simulator Model has no Model definition + +There is no model definition (key: model-defn) in the KIM Simulator +Model. Please contact the OpenKIM database maintainers to verify +and potentially correct this. + +*/ -- GitLab From 17fa2f787b58cb4c17bc6aa04b1015a9b2778a93 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sat, 22 Jun 2019 15:25:21 -0500 Subject: [PATCH 067/469] Added kim_command documentation structure --- doc/src/Commands_all.txt | 5 +- doc/src/commands_list.txt | 3 +- doc/src/kim_commands.txt | 108 ++++++++++++++++++++++++++++++++++++++ 3 files changed, 112 insertions(+), 4 deletions(-) create mode 100644 doc/src/kim_commands.txt diff --git a/doc/src/Commands_all.txt b/doc/src/Commands_all.txt index d76ffac14c..a201fd3f2d 100644 --- a/doc/src/Commands_all.txt +++ b/doc/src/Commands_all.txt @@ -68,8 +68,9 @@ An alphabetic list of all general LAMMPS commands. "improper_style"_improper_style.html, "include"_include.html, "jump"_jump.html, -"kim_query"_kim_query.html, -"kim_style"_kim_style.html, +"kim_init"_kim_commands.html, +"kim_interactions"_kim_commands.html, +"kim_query"_kim_commands.html, "kspace_modify"_kspace_modify.html, "kspace_style"_kspace_style.html, "label"_label.html, diff --git a/doc/src/commands_list.txt b/doc/src/commands_list.txt index 39d2f7c7d0..a5c9b568ed 100644 --- a/doc/src/commands_list.txt +++ b/doc/src/commands_list.txt @@ -53,8 +53,7 @@ Commands :h1 include info jump - kim_query - kim_style + kim_commands kspace_modify kspace_style label diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt new file mode 100644 index 0000000000..4c53746317 --- /dev/null +++ b/doc/src/kim_commands.txt @@ -0,0 +1,108 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Commands_all.html) + +:line + +kim_commands :h3 + +[Syntax:] + +kim_init model user_units :pre +kim_interactions typeargs :pre + +mode = {init model} or {define typeargs} or no mode chosen +model = name of the KIM model (KIM potential or KIM simulator model) +typeargs = atom type to species mapping (one entry per atom type) +args = {unit_variables unit_style} or {unit_from unit_style} (optional):ul + +[Examples:] + +kim_style init ex_sim_model_Si_mod_tersoff unit_variables metal +kim_style define Si Si +kim_style unit_variables real +kim_style init LennardJones_Ar unit_variables metal +kim_style unit_variables real unit_from metal +kim_style define Ar :pre + +[Description:] + +The kim_style command is a high-level wrapper around the +"Knowledge Base for Interatomic Models (OpenKIM)"_https://openkim.org +repository of interatomic potentials, so that they can be used by +LAMMPS scripts. It does not implement any computations directly, but +rather will generate LAMMPS input commands based on the information +retrieved from the OpenKIM repository. It is able to realize so-called +"KIM Simulator Models", which are OpenKIM repository entries of models +using native features of the simulation engine in use, i.e. LAMMPS +in this case, but it also supports realizing conventional KIM models +implicitly via generating a "pair_style kim"_pair_kim.html command +followed by a suitable "pair_coeff"_pair_coeff.html command. + +The kim_style command has two modes, {init} and {define}, indicated by +the first argument to the kim_style command. An {init} mode command +must be issued [before] the simulation box is created, while the {define} +mode version may only be used [after] the simulation box exists. Both +are required. The {init} mode version sets the model name and may issue +additional commands changing LAMMPS default settings that are required +for using a selected simulator model. If needed, those settings can be +overridden. The second argument to the {kim_style init} command is the +KIM model ID. + +In both modes, the keywords {unit_variables} and {unit_from} may be +added. They control the values of a set of +"internal style variables"_variable.html that can be used to convert +between different unit styles in LAMMPS. The argument to +each keyword is a LAMMPS unit style or NULL, which means to look up +the unit style from what was set with the "units"_units.html command. +Please note, that KIM simulator models will set their preferred unit style. +By default all conversion variables are set to 1.0. Converting to or +from the "lj" unit style is not supported. The following variables are defined: + +_u_length +_u_mass +_u_time :ul + + +The {kim_style define} command will issue commands that will realize +the selected model (through generating pair_style and pair_coeff commands, +but also other commands, as required). It has to be issued [after] the +the simulation box is defined. The {kim_style define} command allows a +varying number of additional arguments. Those are used to map the atom +types in LAMMPS to the available species in the KIM model. This is +equivalent to the arguments following "pair_coeff * *" in a +"kim"_pair_kim.html pair style. Thus the commands: + +kim_style init LennardJones_Ar +kim_style define Ar :pre + +will generate the LAMMPS input commands: + +pair_style kim LennardJones_Ar +pair_coeff * * Ar :pre + +For simulator models, the generated input commands may be more complex +and require that LAMMPS is built with the required packages included. +The commands generated by the kim_style command, can be copied to the +screen or log file, through the "echo"_echo.html command. +The kim_style command will also validate, that a selected simulator +model was generated for the LAMMPS MD code and not some other software. +In addition, the version strings for LAMMPS version used for defining +the simulator model and the LAMMPS version being currently run are +printed, so that it can be tracked down, if there are any incompatible +changes to input script or command syntax between the two LAMMPS versions. + +[Restrictions:] + +This command is part of the KIM package. It is only enabled if +LAMMPS was built with that package. Furthermore, its correct +functioning depends on compiling LAMMPS with all required packages +installed that are required by the commands embedded in any KIM +simulator models used. +See the "Build package"_Build_package.html doc page for more info. + +[Related commands:] + +"pair_style kim"_pair_kim.html, "kim_query"_kim_query.html -- GitLab From 33be7f259be9446edf9f75e17309d8bfe7f05e84 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sat, 22 Jun 2019 21:49:29 -0500 Subject: [PATCH 068/469] Working on kim_commands documentation --- doc/src/kim_commands.txt | 232 +++++++++++++++++++++++++++++++++++++-- 1 file changed, 221 insertions(+), 11 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 4c53746317..06ad841240 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -10,25 +10,235 @@ kim_commands :h3 [Syntax:] -kim_init model user_units :pre -kim_interactions typeargs :pre +kim_init model user_units unitarg +kim_interactions typeargs +kim_query variable query_function web_query_flags :pre -mode = {init model} or {define typeargs} or no mode chosen -model = name of the KIM model (KIM potential or KIM simulator model) +model = designation of the KIM interatomic model (the KIM ID for models archived in OpenKIM) +user_units = the LAMMPS "units"_units.html style assumed in the user input script +unitarg = {unit_conversion_mode} (optional) typeargs = atom type to species mapping (one entry per atom type) -args = {unit_variables unit_style} or {unit_from unit_style} (optional):ul +variable = name of a (string style) variable where the result of the query is stored +query_function = name of the OpenKIM web API query function to be used +web_query_flags = a series of keyword=value pairs that represent the web query; supported keywords depend on query function :ul + [Examples:] -kim_style init ex_sim_model_Si_mod_tersoff unit_variables metal -kim_style define Si Si -kim_style unit_variables real -kim_style init LennardJones_Ar unit_variables metal -kim_style unit_variables real unit_from metal -kim_style define Ar :pre +kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 metal +kim_interactions Si +kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real +kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 metal unit_conversion_mode +kim_interactions C H O +kim_query NEED EXAMPLES :pre [Description:] +The "Open Knowledgebase for Interatomic Models (OpenKIM)"_https://openkim.org +archives interatomic models (IMs) (potentials and force fields) in a format +that can be directly used with LAMMPS using the commands documented on this +page. + +Benefits of Using OpenKIM IMs :h4 + +Employing OpenKIM IMs provides LAMMPS users with multiple benefits: + +Reliability :h5 + +All content archived in OpenKIM is subject to quality control by the "KIM Editor"_https://openkim.org/governance/. +IMs in OpenKIM are archived with full provenance control. Each is associated with a maintainer responsible for the integrity of the content. All changes are tracked and recorded. +IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/getting-started/kim-tests/ that compute a host of material properties, and "KIM Verification Checks"_https://openkim.org/about-verification-checks/ that provide the user with information on various aspects of the IM behavior and coding correctness. This information is displayed on the IM's page on "OpenKIM"_https://openkim.org. :ul + +Reproducibility :h5 + +Each IM in OpenKIM is issued a unique identifier ("KIM ID"_https://openkim.org/about-kim-ids/), which includes a version number (last three digits). Any changes that can result in different numerical values lead to a version increment in the KIM ID. This makes it possible to reproduce simulations since the specific version of a specific IM used can be retrieved using its KIM ID. +OpenKIM is a member organization of "DataCite"_https://datacite.org/ and issues digitial object identifiers (DOIs) to all IMs archived in OpenKIM. This makes it possible to cite the IM code used in a simulation in a publications to give credit to the developers and further facilitate reproducibility. :ul + +Convenience :h5 + +IMs in OpenKIM are distributed in binary form along with LAMMPS and can be used in a LAMMPS input script simply by providing their KIM ID in the {kim_init} command documented on this page. (For more on using KIM with LAMMPS, see the KIM section of the "Packages details"_Packages_details.html doc page.) +The {kim_query} web query tool provides the ability to use the predictions of IMs for supported material properties (computed via "KIM Tests"https://openkim.org/getting-started/kim-tests/) as part of a LAMMPS input script setup and analysis. +Support is provided for unit conversion between the "units"_units.html system used in the LAMMPS input script and the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the liklihood of errors due to incompatible units. :ul + +Types of KIM IMs :h4 + +There are two types of IMs archived in OpenKIM: + +The first type is called a {KIM Model}. A KIM Model is an independent computer implemention of an IM written in one of the languages supported by KIM (C, C++, Fortran, Python), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that support the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). +The second type is called a {KIM Simulator Model} (SM). In this case, the IM is implemented natively within the simulation code ({simulator}), i.e. LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol + +With these two IM tpes, OpenKIM can archive and test almost all IMs that +can be used by LAMMPS. (It is easy to contribute new IMs to OpenKIM, see +the "upload instructions"_https://openkim.org/getting-started/adding-content/.) + +OpenKIM IMs are uniquely identified by a +"KIM ID"_https://openkim.org/about-kim-ids/. The extended KIM ID consists of +a human-readable prefix identifying the type of IM, authors, publication year, +and supported species, separated by two underscores from the KIM ID itself, +which begins with an IM code +({MO} for a KIM Model, and {SM} for a KIM Simulator Model) +followed by a unique 12-digit code and a 3-digit version identifier. +By convension SM prefixes begin with {SM} to readily identify them. + +SW_StillingerWeber_1985_Si__MO_405512056662_005 +Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 :pre + +NOTE: It is also possible to locally install IMs not archived in OpenKIM, +in which case their designation does not have to conform to the KIM ID format. + +Using OpenKIM IMs with LAMMPS :h4 + +Two commands are employed when using OpenKIM IMs, one to select the +IM and perform necessary initializations ({kim_init}), and the second +to set up the IM for use by executing any necessary LAMMPS commands +({kim_interactions}). + +OpenKIM IM Initialization :h5 + +The kim_init command must be located at the top of the input script +before any other commands. Input scripts containing a kim_init command +shoud {not} include a "units"_units.html command or an +"atom_style"_atom_style.html command. These are set by the kim_init +command based on its arguments. + +The required arguments of kim_init are the {model} designation of the +IM to be used in the simulation (for an IM archived in OpenKIM this is +its "extended KIM ID"_https://openkim.org/about-kim-ids/), and +the {user_units}, which are the LAMMPS "units"_units.html system used +in the input script. (Any numerical values in the input script and values +read in from files are expected to be in the {user_units} system.) + +Based on the selected model kim_init may modify "atom_style"_atom_style.html. +Some SMs have requirements for this variable. If this is the case, then +atom_style will be set to the required style. Otherwise, the value is left +unchanged (which in the absence of an atom_style command in the input script +is the default LAMMPS value). + +Regarding units, the kim_init command behaves in different ways depending +on whether or not "unit conversion mode" is activated as indicated by the +optional {unitarg} argument. +If unit conversion mode is {not} active, then {user_units} must +either match the required units of the IM or the IM must be able +to adjust its units to match. (The latter is only possible with some KIM Models; +SMs can never adjust their units.) If a match is possible, the LAMMPS +"units"_units.html command is called to set the units to +{user_units}. If the match fails, the simulation is terminated with +an error. + +If unit conversion mode {is} active, then the LAMMPS "units"_units.html +command is called to set the units to the IM's required or preferred units. +Conversion factors between the IM's units and the {user_units} are +defined for all "physical quantities"_units.html (mass, distance, etc.). +These factors are stored as internal "variables"_variable.html with +standard names: + +_u_mass +_u_distance +_u_time +_u_energy +_u_velocity +_u_force +_u_torque +_u_temperature +_u_pressure +_u_viscosity +_u_charge +_u_dipole +_u_efield +_u_density :pre + +If desired, the input script can be designed to work with these conversion +factors so that the script will work without change with any OpenKIM IM. +(This approach is used in the +"OpenKIM Testing Framework"_https://openkim.org/getting-started/kim-tests/.) +For example, the following simple script constructs an fcc lattice with +a lattice parameter defined in meters, computes the total energy, +and prints the cohesive energy in Joules regardless of the units of the IM. + +kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 si unit_conversion_mode +boundary p p p +lattice fcc 4.032e-10*$\{_u_distance\} +region simbox block 0 1 0 1 0 1 units lattice +create_box 1 simbox +create_atoms 1 box +mass 1 4.480134e-26*$\{_u_mass\} +kim_interactions Al +run 0 +variable Ec_in_J equal (pe/count(all))/$\{_u_energy\} +print "Cohesive Energy = $\{Ec_in_J\} J" :pre + +Note the multiplication by $\{_u_distance\} and $\{_u_mass\} to convert +from SI units (specified in the kim_init command) to whatever units the +IM uses (metal in this case), and the division by $\{_u_energy\} +to convert from the IM's energy units to SI units (Joule). This script +will work correctly for any IM for Al (KIM Model or SM) selected by the +kim_init command. + +Care must be taken to apply unit conversion to dimensional variables read in +from a file. For example if a configuration of atoms is read in from a +dump file using the "read_dump"_read_dump.html command, the following can +be done to convert the box and all atomic positions to the correct units: + +change_box all x scale $\{_u_distance\} y scale $\{_u_distance\} z scale $\{_u_distance\} remap :pre + +NOTE: Unit conversion will only work if the conversion factors are placed in +all appropriate places in the input script. It is up to the user to do this +correctly. + +OpenKIM IM Execution :h5 + +The second and final step in using an OpenKIM IM is to execute the +kim_interaction command. This command must be preceded by a kim_init +command and must follow the "create_box"_create_box.html command, +which defines the number of atom types {N}. +The kim_interaction command has one argument {typeargs}, which contains +a list of {N} chemical species that are mapped to the atom types. + +For example, imagine the OpenKIM IM supports Si and C species. +If the LAMMPS simulation has 4 atom types and you want the first three to be Si, +and the fourth to be C, you would use the following kim_interaction command: + +kim_interaction Si Si Si C :pre + +The kim_interaction command performs all the necessary steps to set up +the OpenKIM IM set in the kim_init command. The specific actions depend +on whether the IM is a KIM Model or a KIM SM. For a KIM Model, +a "pair_style kim"_pair_kim.html command will be executed followed by +the appropriate pair_coeff command. + +For a KIM SM, the set of commands defined in the SM speficiation file +will be executed. For example, consider the ReaxFF SM due to +Strachan et al. (2003) executed by the following commands: + +kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real +... +... box specification lines skipped +... +kim_interactions C H N O :pre + +The kim_interactions command executes the following commands defined for this +SM: + +pair_style reax/c lmp_control safezone 2.0 mincap 100 +pair_coeff * * ffield.reax.rdx C H N O +fix reaxqeq all qeq/reax 1 0.0 10.0 1.0e-6 param.qeq :pre + +Note that the files lmp_control, ffield.reax.rdx and param.qeq are specific +to Strachan et al. (2003) ReaxFF parameterization and are archived as part +of the SM package in OpenKIM. Note also that parameters like cutoff radii +and charge tolerances that have an effect on IM predictions are also +included in the SM definition ensuring reproducibility. + +NOTE: Clearly when using using kim_init and kim_interactions to select +and set up an OpenKIM IM, other LAMMPS commands +for the same functions (such as pair_style, pair_coeff, bond_style, +bond_coeff, fixes related to charge equilibration, etc.) should not +appear in the input script. + +Using OpenKIM Web Queries in LAMMPS :h4 + +@@@@@@@@@ + The kim_style command is a high-level wrapper around the "Knowledge Base for Interatomic Models (OpenKIM)"_https://openkim.org repository of interatomic potentials, so that they can be used by -- GitLab From c11caf45095d96aeb2a1477ce78d6e0c03ea7505 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Sun, 23 Jun 2019 10:34:43 -0500 Subject: [PATCH 069/469] update kim examples to temp. current state of code --- examples/kim/data.VOH | 118 ---------------------- examples/kim/in.kim.VOH.simulator_model | 23 ----- examples/kim/in.kim.ex_si.simulator_model | 69 ------------- examples/kim/in.kim.lj.simulator_model | 10 +- 4 files changed, 2 insertions(+), 218 deletions(-) delete mode 100644 examples/kim/data.VOH delete mode 100644 examples/kim/in.kim.VOH.simulator_model delete mode 100644 examples/kim/in.kim.ex_si.simulator_model diff --git a/examples/kim/data.VOH b/examples/kim/data.VOH deleted file mode 100644 index c093705adc..0000000000 --- a/examples/kim/data.VOH +++ /dev/null @@ -1,118 +0,0 @@ -# VOH example - -100 atoms -4 atom types - -0 25.000 xlo xhi -0 25.000 ylo yhi -0 25.000 zlo zhi - -Masses - -1 1.0080 -2 12.0107 -3 15.9994 -4 50.9415 - -Atoms - - 1 2 0.0 12.35333 12.56112 11.08925 - 2 4 0.0 12.32916 12.62071 13.13099 - 3 3 0.0 14.09425 12.56218 13.76130 - 4 3 0.0 11.42814 11.10330 13.76732 - 5 3 0.0 11.63260 13.89286 13.64097 - 6 1 0.0 10.61647 11.29221 14.30535 - 7 1 0.0 14.38026 13.34626 14.29055 - 8 1 0.0 11.32479 12.58820 10.70253 - 9 1 0.0 12.90918 13.42567 10.69612 - 10 1 0.0 12.84043 11.63643 10.74688 - 11 2 0.0 0.93670 23.74637 24.45218 - 12 4 0.0 2.18151 24.36876 0.94725 - 13 3 0.0 3.93452 24.44779 0.28384 - 14 3 0.0 2.13668 23.10529 2.33362 - 15 3 0.0 1.76108 0.74666 1.48323 - 16 1 0.0 1.82070 23.45305 3.20745 - 17 1 0.0 4.35555 0.34186 0.31083 - 18 1 0.0 24.90472 23.68735 24.82586 - 19 1 0.0 0.97611 24.45631 23.61244 - 20 1 0.0 1.24583 22.75250 24.09589 - 21 2 0.0 2.25730 12.18969 18.74792 - 22 4 0.0 0.67140 13.31162 19.37385 - 23 3 0.0 0.71106 13.43250 21.24545 - 24 3 0.0 24.08603 12.44025 18.87949 - 25 3 0.0 0.70486 14.71920 18.75808 - 26 1 0.0 23.49516 12.95430 18.26686 - 27 1 0.0 0.79723 14.34808 21.60818 - 28 1 0.0 2.24383 12.10285 17.65239 - 29 1 0.0 3.19860 12.66607 19.06030 - 30 1 0.0 2.20214 11.18299 19.18774 - 31 2 0.0 9.32237 8.16220 23.74501 - 32 4 0.0 9.41775 7.26178 21.91463 - 33 3 0.0 8.54752 8.34565 20.65588 - 34 3 0.0 8.50942 5.62151 22.00137 - 35 3 0.0 10.87539 7.02683 21.48455 - 36 1 0.0 9.06507 4.82324 21.80615 - 37 1 0.0 9.11458 8.67119 19.91477 - 38 1 0.0 9.82196 7.53487 24.49616 - 39 1 0.0 9.81855 9.14254 23.70532 - 40 1 0.0 8.27176 8.30387 24.03831 - 41 2 0.0 9.10113 13.98748 23.44281 - 42 4 0.0 8.84954 12.89163 21.73780 - 43 3 0.0 10.01387 13.54293 20.42005 - 44 3 0.0 7.08992 13.11522 21.12954 - 45 3 0.0 9.12937 11.39982 21.99065 - 46 1 0.0 6.55309 12.28287 21.08224 - 47 1 0.0 10.67858 12.89258 20.08249 - 48 1 0.0 8.42108 13.62252 24.22498 - 49 1 0.0 10.13926 13.89766 23.79639 - 50 1 0.0 8.88118 15.04646 23.24289 - 51 2 0.0 17.73225 3.40708 8.28945 - 52 4 0.0 18.49877 5.29835 8.37599 - 53 3 0.0 19.48472 5.62627 6.81505 - 54 3 0.0 19.66498 5.40961 9.84118 - 55 3 0.0 17.38120 6.34466 8.51889 - 56 1 0.0 19.41208 6.07779 10.52927 - 57 1 0.0 19.15960 6.37609 6.25924 - 58 1 0.0 17.15579 3.19557 9.20103 - 59 1 0.0 17.07197 3.31049 7.41454 - 60 1 0.0 18.54903 2.67524 8.20436 - 61 2 0.0 5.18346 20.97409 24.28840 - 62 4 0.0 7.06396 20.17968 24.34847 - 63 3 0.0 7.63220 19.82889 22.59578 - 64 3 0.0 7.00272 18.55243 0.28036 - 65 3 0.0 8.05085 21.13715 0.03620 - 66 1 0.0 7.56109 18.51690 1.09952 - 67 1 0.0 8.44257 20.31624 22.30833 - 68 1 0.0 4.83239 21.17976 0.30904 - 69 1 0.0 5.19182 21.91237 23.71419 - 70 1 0.0 4.49282 20.26573 23.80772 - 71 2 0.0 21.82701 12.79861 20.63056 - 72 4 0.0 21.27646 11.09990 19.63611 - 73 3 0.0 19.52930 10.64327 20.13923 - 74 3 0.0 22.41924 9.70346 20.14638 - 75 3 0.0 21.34556 11.30206 18.11274 - 76 1 0.0 22.94464 9.30084 19.40876 - 77 1 0.0 18.86743 10.62817 19.40629 - 78 1 0.0 22.85378 13.07853 20.35349 - 79 1 0.0 21.14666 13.62206 20.37063 - 80 1 0.0 21.78702 12.62668 21.71522 - 81 2 0.0 4.84801 10.63893 5.85720 - 82 4 0.0 2.99668 11.06158 5.10490 - 83 3 0.0 3.09505 11.09458 3.23258 - 84 3 0.0 2.48053 12.76555 5.69567 - 85 3 0.0 1.96195 10.01780 5.55634 - 86 1 0.0 1.65323 12.78746 6.24245 - 87 1 0.0 2.52753 10.43264 2.76734 - 88 1 0.0 4.80984 10.62196 6.95551 - 89 1 0.0 5.18492 9.65688 5.49273 - 90 1 0.0 5.56737 11.40648 5.53568 - 91 2 0.0 13.58126 9.47098 19.40329 - 92 4 0.0 14.17691 10.17243 21.22692 - 93 3 0.0 14.44428 12.02521 21.10583 - 94 3 0.0 15.81206 9.37183 21.67632 - 95 3 0.0 13.12907 9.86545 22.30960 - 96 1 0.0 15.80034 8.83149 22.50703 - 97 1 0.0 13.87232 12.57457 21.69672 - 98 1 0.0 13.42563 8.38456 19.45392 - 99 1 0.0 12.63978 9.95672 19.10431 - 100 1 0.0 14.35123 9.68789 18.64825 diff --git a/examples/kim/in.kim.VOH.simulator_model b/examples/kim/in.kim.VOH.simulator_model deleted file mode 100644 index 8696cf265a..0000000000 --- a/examples/kim/in.kim.VOH.simulator_model +++ /dev/null @@ -1,23 +0,0 @@ -# REAX potential for VOH system -# ..... - -units real -atom_style charge - -kim_style init Sim_LAMMPS_ReaxFF_ChenowethVanDuinPersson_2008_CHOV__SM_429148913211_000 - -read_data data.VOH - -kim_style define H C O V - -neighbor 2 bin -neigh_modify every 10 delay 0 check no - -fix 1 all nve -fix 3 all temp/berendsen 500.0 500.0 100.0 - -timestep 0.25 - -#dump 1 all atom 30 dump.reax.voh - -run 300 diff --git a/examples/kim/in.kim.ex_si.simulator_model b/examples/kim/in.kim.ex_si.simulator_model deleted file mode 100644 index 2f9e79ef4e..0000000000 --- a/examples/kim/in.kim.ex_si.simulator_model +++ /dev/null @@ -1,69 +0,0 @@ - -units metal -kim_style init ex_sim_model_Si_mod_tersoff - -atom_style atomic -atom_modify map array -boundary p p p - -# temperatures -variable tlo equal 1800.0 -variable thi equal 2400.0 - -# coordination number cutoff - -variable r equal 2.835 - -# minimization parameters - -variable etol equal 1.0e-5 -variable ftol equal 1.0e-5 -variable maxiter equal 100 -variable maxeval equal 100 -variable dmax equal 1.0e-1 - -# diamond unit cell - -variable a equal 5.431 -lattice custom $a & - a1 1.0 0.0 0.0 & - a2 0.0 1.0 0.0 & - a3 0.0 0.0 1.0 & - basis 0.0 0.0 0.0 & - basis 0.0 0.5 0.5 & - basis 0.5 0.0 0.5 & - basis 0.5 0.5 0.0 & - basis 0.25 0.25 0.25 & - basis 0.25 0.75 0.75 & - basis 0.75 0.25 0.75 & - basis 0.75 0.75 0.25 - -region myreg block 0 4 & - 0 4 & - 0 4 -create_box 1 myreg -create_atoms 1 region myreg - -mass 1 28.06 - -group Si type 1 - -velocity all create ${thi} 5287286 mom yes rot yes dist gaussian - -# make a vacancy - -group del id 300 -delete_atoms group del -kim_style define Si - -thermo 10 - -fix 1 all nve -fix 2 all langevin ${thi} ${thi} 0.1 48278 - -timestep 1.0e-3 -neighbor 1.0 bin -neigh_modify every 1 delay 10 check yes - -run 100 - diff --git a/examples/kim/in.kim.lj.simulator_model b/examples/kim/in.kim.lj.simulator_model index 01ee5aa64c..cb7a2e14ed 100644 --- a/examples/kim/in.kim.lj.simulator_model +++ b/examples/kim/in.kim.lj.simulator_model @@ -14,9 +14,7 @@ variable xx equal 20*$x variable yy equal 20*$y variable zz equal 20*$z -echo both -#kim_style model LennardJones_Ar metal -kim_style model Sim_LAMMPS_LJcut_AkersonElliott_Alchemy_PbAu real unit_conversion_mode +kim_init Sim_LAMMPS_LJcut_AkersonElliott_Alchemy_PbAu real unit_conversion_mode newton on lattice fcc 4.4300 @@ -24,10 +22,7 @@ region box block 0 ${xx} 0 ${yy} 0 ${zz} create_box 1 box create_atoms 1 box -#pair_style lj/cut 8.1500 -#pair_coeff 1 1 0.0104 3.4000 - -kim_style setup Au +kim_interactions Au mass 1 39.95 velocity all create 200.0 232345 loop geom @@ -36,6 +31,5 @@ neighbor 0.3 bin neigh_modify delay 0 every 1 check yes fix 1 all nve -#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 run 100 -- GitLab From d08867ce0a05e090056f9dea1e3bbdd2fc4c6afa Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 11:39:06 -0500 Subject: [PATCH 070/469] Completed first version of kim_commands documentation --- doc/src/kim_commands.txt | 318 +++++++++++++++++++++++---------------- 1 file changed, 189 insertions(+), 129 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 06ad841240..c3ab799821 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -12,15 +12,15 @@ kim_commands :h3 kim_init model user_units unitarg kim_interactions typeargs -kim_query variable query_function web_query_flags :pre +kim_query variable query_function queryargs :pre -model = designation of the KIM interatomic model (the KIM ID for models archived in OpenKIM) -user_units = the LAMMPS "units"_units.html style assumed in the user input script +model = name of the KIM interatomic model (the KIM ID for models archived in OpenKIM) +user_units = the LAMMPS "units"_units.html style assumed in the LAMMPS input script unitarg = {unit_conversion_mode} (optional) typeargs = atom type to species mapping (one entry per atom type) variable = name of a (string style) variable where the result of the query is stored query_function = name of the OpenKIM web API query function to be used -web_query_flags = a series of keyword=value pairs that represent the web query; supported keywords depend on query function :ul +queryargs = a series of {keyword=value} pairs that represent the web query; supported keywords depend on the query function :ul [Examples:] @@ -30,14 +30,20 @@ kim_interactions Si kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 metal unit_conversion_mode kim_interactions C H O -kim_query NEED EXAMPLES :pre +kim_query a0 get_lattice_constant_fcc units=\["angstrom"\] :pre + [Description:] -The "Open Knowledgebase for Interatomic Models (OpenKIM)"_https://openkim.org -archives interatomic models (IMs) (potentials and force fields) in a format -that can be directly used with LAMMPS using the commands documented on this -page. +The set of {kim_commands} provide a high-level wrapper around the +"Open Knowledgebase of Interatomic Models (OpenKIM)"_https://openkim.org +repository of interatomic models (IMs) (potentials and force fields), +so that they can be used by LAMMPS scripts. These commands do not implement +any computations directly, but rather generate LAMMPS input commands based +on the information retrieved from the OpenKIM repository to initialize and +activate OpenKIM IMs and query their predictions for use in the LAMMPS script. +All LAMMPS input commands executed by {kim_commands} are echoed to the +LAMMPS log file. Benefits of Using OpenKIM IMs :h4 @@ -52,22 +58,23 @@ IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/get Reproducibility :h5 Each IM in OpenKIM is issued a unique identifier ("KIM ID"_https://openkim.org/about-kim-ids/), which includes a version number (last three digits). Any changes that can result in different numerical values lead to a version increment in the KIM ID. This makes it possible to reproduce simulations since the specific version of a specific IM used can be retrieved using its KIM ID. -OpenKIM is a member organization of "DataCite"_https://datacite.org/ and issues digitial object identifiers (DOIs) to all IMs archived in OpenKIM. This makes it possible to cite the IM code used in a simulation in a publications to give credit to the developers and further facilitate reproducibility. :ul +OpenKIM is a member organization of "DataCite"_https://datacite.org/ and issues digital object identifiers (DOIs) to all IMs archived in OpenKIM. This makes it possible to cite the IM code used in a simulation in a publications to give credit to the developers and further facilitate reproducibility. :ul Convenience :h5 -IMs in OpenKIM are distributed in binary form along with LAMMPS and can be used in a LAMMPS input script simply by providing their KIM ID in the {kim_init} command documented on this page. (For more on using KIM with LAMMPS, see the KIM section of the "Packages details"_Packages_details.html doc page.) +IMs in OpenKIM are distributed in binary form along with LAMMPS and can be used in a LAMMPS input script simply by providing their KIM ID in the {kim_init} command documented on this page. The {kim_query} web query tool provides the ability to use the predictions of IMs for supported material properties (computed via "KIM Tests"https://openkim.org/getting-started/kim-tests/) as part of a LAMMPS input script setup and analysis. -Support is provided for unit conversion between the "units"_units.html system used in the LAMMPS input script and the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the liklihood of errors due to incompatible units. :ul +Support is provided for unit conversion between the "units style"_units.html used in the LAMMPS input script and the units required by the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the likelihood of errors due to incompatible units. :ul +:link(IM_types) Types of KIM IMs :h4 There are two types of IMs archived in OpenKIM: -The first type is called a {KIM Model}. A KIM Model is an independent computer implemention of an IM written in one of the languages supported by KIM (C, C++, Fortran, Python), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that support the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). +The first type is called a {KIM Model}. A KIM Model is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran, Python), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that support the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). The second type is called a {KIM Simulator Model} (SM). In this case, the IM is implemented natively within the simulation code ({simulator}), i.e. LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol -With these two IM tpes, OpenKIM can archive and test almost all IMs that +With these two IM types, OpenKIM can archive and test almost all IMs that can be used by LAMMPS. (It is easy to contribute new IMs to OpenKIM, see the "upload instructions"_https://openkim.org/getting-started/adding-content/.) @@ -78,46 +85,59 @@ and supported species, separated by two underscores from the KIM ID itself, which begins with an IM code ({MO} for a KIM Model, and {SM} for a KIM Simulator Model) followed by a unique 12-digit code and a 3-digit version identifier. -By convension SM prefixes begin with {SM} to readily identify them. +By convention SM prefixes begin with {Sim_} to readily identify them. SW_StillingerWeber_1985_Si__MO_405512056662_005 Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 :pre NOTE: It is also possible to locally install IMs not archived in OpenKIM, -in which case their designation does not have to conform to the KIM ID format. +in which case their names do not have to conform to the KIM ID format. Using OpenKIM IMs with LAMMPS :h4 Two commands are employed when using OpenKIM IMs, one to select the IM and perform necessary initializations ({kim_init}), and the second to set up the IM for use by executing any necessary LAMMPS commands -({kim_interactions}). +({kim_interactions}). Both are required. -OpenKIM IM Initialization :h5 +OpenKIM IM Initialization ({kim_init}) :h5 -The kim_init command must be located at the top of the input script -before any other commands. Input scripts containing a kim_init command -shoud {not} include a "units"_units.html command or an -"atom_style"_atom_style.html command. These are set by the kim_init -command based on its arguments. +The {kim_init} mode command must be issued [before] +the simulation box is created (normally at the top of the file). +This command sets the OpenKIM IM that will be used and may issue +additional commands changing LAMMPS default settings that are required +for using the selected IM (such as "units"_units.html or +"atom_style"_atom_style.html). If needed, those settings can be overridden, +however, typically a script containing a {kim_init} command +would not include {units} and {atom_style} commands. -The required arguments of kim_init are the {model} designation of the +The required arguments of {kim_init} are the {model} name of the IM to be used in the simulation (for an IM archived in OpenKIM this is its "extended KIM ID"_https://openkim.org/about-kim-ids/), and -the {user_units}, which are the LAMMPS "units"_units.html system used -in the input script. (Any numerical values in the input script and values -read in from files are expected to be in the {user_units} system.) - -Based on the selected model kim_init may modify "atom_style"_atom_style.html. +the {user_units}, which are the LAMMPS "units style"_units.html used +in the input script. (Any dimensioned numerical values in the input +script and values read in from files are expected to be in the +{user_units} system.) + +The selected IM can be either a "KIM Model or a KIM SM"_#IM_types. +For a KIM SM, the {kim_init} command verifies that the SM is designed +to work with LAMMPS (and not another simulation code). +In addition, the version strings for the LAMMPS version used for defining +the SM and the LAMMPS version being currently run are +printed, to help diagnose any incompatible changes to input script or +command syntax between the two LAMMPS versions. + +Based on the selected model {kim_init} may modify the +"atom_style"_atom_style.html. Some SMs have requirements for this variable. If this is the case, then -atom_style will be set to the required style. Otherwise, the value is left -unchanged (which in the absence of an atom_style command in the input script -is the default LAMMPS value). +{atom_style} will be set to the required style. Otherwise, the value is left +unchanged (which in the absence of an {atom_style} command in the input script +is the "default atom_style value"_atom_style.html). -Regarding units, the kim_init command behaves in different ways depending -on whether or not "unit conversion mode" is activated as indicated by the +Regarding units, the {kim_init} command behaves in different ways depending +on whether or not {unit conversion mode} is activated as indicated by the optional {unitarg} argument. -If unit conversion mode is {not} active, then {user_units} must +If unit conversion mode is [not] active, then {user_units} must either match the required units of the IM or the IM must be able to adjust its units to match. (The latter is only possible with some KIM Models; SMs can never adjust their units.) If a match is possible, the LAMMPS @@ -129,7 +149,8 @@ If unit conversion mode {is} active, then the LAMMPS "units"_units.html command is called to set the units to the IM's required or preferred units. Conversion factors between the IM's units and the {user_units} are defined for all "physical quantities"_units.html (mass, distance, etc.). -These factors are stored as internal "variables"_variable.html with +(Note that converting to or from the "lj" unit style is not supported.) +These factors are stored as "internal style variables"_variable.html with standard names: _u_mass @@ -168,11 +189,11 @@ variable Ec_in_J equal (pe/count(all))/$\{_u_energy\} print "Cohesive Energy = $\{Ec_in_J\} J" :pre Note the multiplication by $\{_u_distance\} and $\{_u_mass\} to convert -from SI units (specified in the kim_init command) to whatever units the +from SI units (specified in the {kim_init} command) to whatever units the IM uses (metal in this case), and the division by $\{_u_energy\} to convert from the IM's energy units to SI units (Joule). This script will work correctly for any IM for Al (KIM Model or SM) selected by the -kim_init command. +{kim_init} command. Care must be taken to apply unit conversion to dimensional variables read in from a file. For example if a configuration of atoms is read in from a @@ -185,30 +206,47 @@ NOTE: Unit conversion will only work if the conversion factors are placed in all appropriate places in the input script. It is up to the user to do this correctly. -OpenKIM IM Execution :h5 +OpenKIM IM Execution ({kim_interactions}) :h5 The second and final step in using an OpenKIM IM is to execute the -kim_interaction command. This command must be preceded by a kim_init -command and must follow the "create_box"_create_box.html command, +{kim_interaction} command. This command must be preceded by a {kim_init} +command and a "create_box"_create_box.html command, which defines the number of atom types {N}. -The kim_interaction command has one argument {typeargs}, which contains -a list of {N} chemical species that are mapped to the atom types. +The {kim_interaction} command has one argument {typeargs}. This argument +contains a list of {N} chemical species, which defines a mapping between +atom types in LAMMPS to the available species in the OpenKIM IM. -For example, imagine the OpenKIM IM supports Si and C species. -If the LAMMPS simulation has 4 atom types and you want the first three to be Si, -and the fourth to be C, you would use the following kim_interaction command: +For example, consider an OpenKIM IM that supports Si and C species. +If the LAMMPS simulation has four atom types, where the first three are Si, +and the fourth is C, the following {kim_interaction} command would be used: kim_interaction Si Si Si C :pre -The kim_interaction command performs all the necessary steps to set up -the OpenKIM IM set in the kim_init command. The specific actions depend +The {kim_interaction} command performs all the necessary steps to set up +the OpenKIM IM selected in the {kim_init} command. The specific actions depend on whether the IM is a KIM Model or a KIM SM. For a KIM Model, -a "pair_style kim"_pair_kim.html command will be executed followed by -the appropriate pair_coeff command. +a "pair_style kim"_pair_kim.html command is executed followed by +the appropriate {pair_coeff} command. For example, for the +Ercolessi and Adams (1994) KIM Model for Al set by the following commands: + +kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal +... +... box specification lines skipped +... +kim_interactions Al :pre + +the {kim_interactions} command executes the following LAMMPS input commands: -For a KIM SM, the set of commands defined in the SM speficiation file -will be executed. For example, consider the ReaxFF SM due to -Strachan et al. (2003) executed by the following commands: +pair_style kim EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 +pair_coeff * * Al :pre + +For a KIM SM, the generated input commands may be more complex +and require that LAMMPS is built with the required packages included +for the type of potential being used. The set of commands to be executed +is defined in the SM specification file, which is part of the SM package +on "OpenKIM"_https://openkim.org. +For example, for the Strachan et al. (2003) ReaxFF SM +set by the following commands: kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real ... @@ -216,103 +254,125 @@ kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657 ... kim_interactions C H N O :pre -The kim_interactions command executes the following commands defined for this -SM: +the {kim_interactions} command executes the following LAMMPS input commands: pair_style reax/c lmp_control safezone 2.0 mincap 100 pair_coeff * * ffield.reax.rdx C H N O fix reaxqeq all qeq/reax 1 0.0 10.0 1.0e-6 param.qeq :pre -Note that the files lmp_control, ffield.reax.rdx and param.qeq are specific -to Strachan et al. (2003) ReaxFF parameterization and are archived as part -of the SM package in OpenKIM. Note also that parameters like cutoff radii -and charge tolerances that have an effect on IM predictions are also -included in the SM definition ensuring reproducibility. +Note that the files {lmp_control}, {ffield.reax.rdx} and {param.qeq} +are specific to the Strachan et al. (2003) ReaxFF parameterization +and are archived as part of the SM package in OpenKIM. +Note also that parameters like cutoff radii and charge tolerances, +which have an effect on IM predictions, are also included in the +SM definition ensuring reproducibility. -NOTE: Clearly when using using kim_init and kim_interactions to select +NOTE: When using using {kim_init} and {kim_interactions} to select and set up an OpenKIM IM, other LAMMPS commands for the same functions (such as pair_style, pair_coeff, bond_style, -bond_coeff, fixes related to charge equilibration, etc.) should not -appear in the input script. - -Using OpenKIM Web Queries in LAMMPS :h4 - -@@@@@@@@@ - -The kim_style command is a high-level wrapper around the -"Knowledge Base for Interatomic Models (OpenKIM)"_https://openkim.org -repository of interatomic potentials, so that they can be used by -LAMMPS scripts. It does not implement any computations directly, but -rather will generate LAMMPS input commands based on the information -retrieved from the OpenKIM repository. It is able to realize so-called -"KIM Simulator Models", which are OpenKIM repository entries of models -using native features of the simulation engine in use, i.e. LAMMPS -in this case, but it also supports realizing conventional KIM models -implicitly via generating a "pair_style kim"_pair_kim.html command -followed by a suitable "pair_coeff"_pair_coeff.html command. - -The kim_style command has two modes, {init} and {define}, indicated by -the first argument to the kim_style command. An {init} mode command -must be issued [before] the simulation box is created, while the {define} -mode version may only be used [after] the simulation box exists. Both -are required. The {init} mode version sets the model name and may issue -additional commands changing LAMMPS default settings that are required -for using a selected simulator model. If needed, those settings can be -overridden. The second argument to the {kim_style init} command is the -KIM model ID. - -In both modes, the keywords {unit_variables} and {unit_from} may be -added. They control the values of a set of -"internal style variables"_variable.html that can be used to convert -between different unit styles in LAMMPS. The argument to -each keyword is a LAMMPS unit style or NULL, which means to look up -the unit style from what was set with the "units"_units.html command. -Please note, that KIM simulator models will set their preferred unit style. -By default all conversion variables are set to 1.0. Converting to or -from the "lj" unit style is not supported. The following variables are defined: - -_u_length -_u_mass -_u_time :ul +bond_coeff, fixes related to charge equilibration, etc.) should normally +not appear in the input script. + +Using OpenKIM Web Queries in LAMMPS ({kim_query}) :h5 +The {kim_query} command performs a web query to retrieve the predictions +of the IM set by {kim_init} for material properties archived in +"OpenKIM"_https://openkim.org. The {kim_query} command must be preceded +by a {kim_init} command. The result of the query is stored in a +"string style variable"_variable.html, the name of which is given as the first +argument of the {kim_query command}. The second required argument +{query_function} is the name of the query function to be called +(e.g. {get_lattice_constant_fcc}). +All following arguments are parameters handed over to the web query +in the format {keyword=value}. The list of supported keywords and +and the type and format of their values depend on the query function +used. -The {kim_style define} command will issue commands that will realize -the selected model (through generating pair_style and pair_coeff commands, -but also other commands, as required). It has to be issued [after] the -the simulation box is defined. The {kim_style define} command allows a -varying number of additional arguments. Those are used to map the atom -types in LAMMPS to the available species in the KIM model. This is -equivalent to the arguments following "pair_coeff * *" in a -"kim"_pair_kim.html pair style. Thus the commands: +NOTE: The current list of supported query functions is available on the OpenKIM +webpage at "https://query.openkim.org"_https://query.openkim.org/ -kim_style init LennardJones_Ar -kim_style define Ar :pre +The data obtained by {kim_query} commands can be used as part of the setup +or analysis phases of LAMMPS simulations. Some examples are given below. -will generate the LAMMPS input commands: +[Define a crystal at its equilibrium lattice constant] -pair_style kim LennardJones_Ar -pair_coeff * * Ar :pre +kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal +boundary p p p +kim_query a0 get_lattice_constant_fcc units=\["angstrom"\] +lattice fcc $\{a0\} +... :pre + +The {kim_query} command retrieves from "OpenKIM"_https://openkim.org +the equilibrium lattice constant predicted by the Ercolessi and Adams (1994) +potential for the face-centered cubic (fcc) structure and places it in +variable {a0}. This variable is then used on the next line to set up the +crystal. By using {kim_query}, the user is saved the trouble and possible +error of tracking this value down, or of having to perform an energy +minimization to find the equilibrium lattice constant. + +[Define a crystal at finite temperature accounting for thermal expansion] + +kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal +boundary p p p +kim_query a0 get_lattice_constant_fcc units=\["angstrom"\] +kim_query alpha get_linear_thermal_expansion_fcc +variable DeltaT equal 300 +lattice fcc $\{a0\}*$\{alpha\}*$\{DeltaT\} +... :pre + +As in the previous example, the equilibrium lattice constant is obtained +for the Ercolessi and Adams (1994) potential. However, in this case the +crystal is scaled to the appropriate lattice constant at 300 K by using +the linear thermal expansion coefficient predicted by the potential. + +[Compute defect formation energy] + +kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal +... +... Build fcc crystal containing some defect and compute the total energy +... which is stored in the variable {Etot} +... +kim_query Ec get_cohesive_energy_fcc units=\["eV"\] +variable Eform equal $\{Etot\} - count(all)*$\{Ec\} +... :pre + +The defect formation energy {Eform} is computed by subtracting from {Etot} the +ideal fcc cohesive energy of the atoms in the system obtained from +"OpenKIM"_https://openkim.org for the Ercolessi and Adams (1994) potential. + +Citation of OpenKIM IMs :h4 + +When publishing results obtained using OpenKIM IMs researchers are requested +to cite the OpenKIM project "(Tadmor)"_#kim-mainpaper and KIM API +"(Elliott)"_#kim-api as well as the specific IM codes used in the simulations. +The citation format for an IM is displayed on its page on +"OpenKIM"_https://openkim.org along with the corresponding BibTex file. + +Citing the codes used in the simulation gives credit +to the researchers who developed them and enables open source efforts like +OpenKIM to function. -For simulator models, the generated input commands may be more complex -and require that LAMMPS is built with the required packages included. -The commands generated by the kim_style command, can be copied to the -screen or log file, through the "echo"_echo.html command. -The kim_style command will also validate, that a selected simulator -model was generated for the LAMMPS MD code and not some other software. -In addition, the version strings for LAMMPS version used for defining -the simulator model and the LAMMPS version being currently run are -printed, so that it can be tracked down, if there are any incompatible -changes to input script or command syntax between the two LAMMPS versions. [Restrictions:] -This command is part of the KIM package. It is only enabled if +The set of {kim_commands} is part of the KIM package. It is only enabled if LAMMPS was built with that package. Furthermore, its correct functioning depends on compiling LAMMPS with all required packages installed that are required by the commands embedded in any KIM -simulator models used. +SM used. See the "Build package"_Build_package.html doc page for more info. [Related commands:] -"pair_style kim"_pair_kim.html, "kim_query"_kim_query.html +"pair_style kim"_pair_kim.html + +:line + +:link(kim-mainpaper) +[(Tadmor)] Tadmor, Elliott, Sethna, Miller and Becker, JOM, 63, 17 (2011). +doi: "https://doi.org/10.1007/s11837-011-0102-6"_https://doi.org/10.1007/s11837-011-0102-6 + +:link(kim-api) +[(Elliott)] Elliott, Tadmor and Bernstein, "https://openkim.org/kim-api"_https://openkim.org/kim-api (2011) +doi: "https://doi.org/10.25950/FF8F563A"_https://doi.org/10.25950/FF8F563A + -- GitLab From a6f6c9bed0c804f039e83943cb9c22a1a66d1429 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 12:41:29 -0400 Subject: [PATCH 071/469] fix up links, spelling issues, and inconsistent names in kim commands docs --- doc/src/Build_extras.txt | 2 +- doc/src/Packages_details.txt | 14 ++++----- doc/src/kim_commands.txt | 34 +++++++++++---------- doc/src/pair_kim.txt | 4 +-- doc/utils/sphinx-config/false_positives.txt | 6 ++++ 5 files changed, 34 insertions(+), 26 deletions(-) diff --git a/doc/src/Build_extras.txt b/doc/src/Build_extras.txt index 17d18243f2..220e9420fc 100644 --- a/doc/src/Build_extras.txt +++ b/doc/src/Build_extras.txt @@ -173,7 +173,7 @@ KIM package :h4,link(kim) To build with this package, the KIM library with API v2 must be downloaded and built on your system. It must include the KIM models that you want to -use with LAMMPS. If you want to use the "kim_query"_kim_query.html +use with LAMMPS. If you want to use the "kim_query"_kim_commands.html command, you also need to have libcurl installed with the matching development headers and the curl-config tool. diff --git a/doc/src/Packages_details.txt b/doc/src/Packages_details.txt index 19c7e96fe9..d6e8f8639f 100644 --- a/doc/src/Packages_details.txt +++ b/doc/src/Packages_details.txt @@ -341,11 +341,11 @@ KIM package :link(PKG-KIM),h4 A "pair_style kim"_pair_kim.html command which is a wrapper on the Knowledge Base for Interatomic Models (KIM) repository of interatomic potentials, enabling any of them to be used in LAMMPS simulations. -Also a "kim_query"_kim_query.html command, which allows to query -the OpenKIM database for stored properties, and a -"kim_style"_kim_style.html command, which serves as a front end to -generating LAMMPS input on-the-fly for KIM simulator models and native -KIM models. +Also a "kim_query"_kim_commands.html command, which allows to query +the OpenKIM database for stored properties, and the commands +"kim_init and kim_interactions"_kim_commands.html, which serve as +front end to generating LAMMPS input on-the-fly for KIM simulator +models and native KIM models. To use this package you must have the KIM library available on your system. @@ -357,8 +357,8 @@ Elliott (U Minnesota). [Authors:] Ryan Elliott (U Minnesota) is the main developer for the KIM API which the "pair_style kim"_pair_kim.html command uses. He developed the pair style. Axel Kohlmeyer (Temple U) contributed the -"kim_query"_kim_query.html and "kim_style"_kim_style.html commands in -close collaboration with Ryan. +"kim_query"_kim_commands.html and "kim_init"_kim_commands.html commands +in close collaboration with Ryan. [Install:] diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 06ad841240..7377c0186c 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -30,7 +30,8 @@ kim_interactions Si kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 metal unit_conversion_mode kim_interactions C H O -kim_query NEED EXAMPLES :pre +kim_query latconst get_test_result test=TE_156715955670 model=MO_800509458712 & + prop=structure-cubic-crystal-npt species=\["Al"\] keys=\["a"\] units=\["angstrom"\] :pre [Description:] @@ -52,22 +53,22 @@ IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/get Reproducibility :h5 Each IM in OpenKIM is issued a unique identifier ("KIM ID"_https://openkim.org/about-kim-ids/), which includes a version number (last three digits). Any changes that can result in different numerical values lead to a version increment in the KIM ID. This makes it possible to reproduce simulations since the specific version of a specific IM used can be retrieved using its KIM ID. -OpenKIM is a member organization of "DataCite"_https://datacite.org/ and issues digitial object identifiers (DOIs) to all IMs archived in OpenKIM. This makes it possible to cite the IM code used in a simulation in a publications to give credit to the developers and further facilitate reproducibility. :ul +OpenKIM is a member organization of "DataCite"_https://datacite.org/ and issues digital object identifiers (DOIs) to all IMs archived in OpenKIM. This makes it possible to cite the IM code used in a simulation in a publications to give credit to the developers and further facilitate reproducibility. :ul Convenience :h5 IMs in OpenKIM are distributed in binary form along with LAMMPS and can be used in a LAMMPS input script simply by providing their KIM ID in the {kim_init} command documented on this page. (For more on using KIM with LAMMPS, see the KIM section of the "Packages details"_Packages_details.html doc page.) The {kim_query} web query tool provides the ability to use the predictions of IMs for supported material properties (computed via "KIM Tests"https://openkim.org/getting-started/kim-tests/) as part of a LAMMPS input script setup and analysis. -Support is provided for unit conversion between the "units"_units.html system used in the LAMMPS input script and the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the liklihood of errors due to incompatible units. :ul +Support is provided for unit conversion between the "units"_units.html system used in the LAMMPS input script and the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the likelihood of errors due to incompatible units. :ul Types of KIM IMs :h4 There are two types of IMs archived in OpenKIM: -The first type is called a {KIM Model}. A KIM Model is an independent computer implemention of an IM written in one of the languages supported by KIM (C, C++, Fortran, Python), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that support the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). +The first type is called a {KIM Model}. A KIM Model is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran, Python), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that support the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). The second type is called a {KIM Simulator Model} (SM). In this case, the IM is implemented natively within the simulation code ({simulator}), i.e. LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol -With these two IM tpes, OpenKIM can archive and test almost all IMs that +With these two IM types, OpenKIM can archive and test almost all IMs that can be used by LAMMPS. (It is easy to contribute new IMs to OpenKIM, see the "upload instructions"_https://openkim.org/getting-started/adding-content/.) @@ -78,7 +79,7 @@ and supported species, separated by two underscores from the KIM ID itself, which begins with an IM code ({MO} for a KIM Model, and {SM} for a KIM Simulator Model) followed by a unique 12-digit code and a 3-digit version identifier. -By convension SM prefixes begin with {SM} to readily identify them. +By convention SM prefixes begin with {SM} to readily identify them. SW_StillingerWeber_1985_Si__MO_405512056662_005 Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 :pre @@ -89,7 +90,7 @@ in which case their designation does not have to conform to the KIM ID format. Using OpenKIM IMs with LAMMPS :h4 Two commands are employed when using OpenKIM IMs, one to select the -IM and perform necessary initializations ({kim_init}), and the second +IM and perform necessary initialization ({kim_init}), and the second to set up the IM for use by executing any necessary LAMMPS commands ({kim_interactions}). @@ -97,7 +98,7 @@ OpenKIM IM Initialization :h5 The kim_init command must be located at the top of the input script before any other commands. Input scripts containing a kim_init command -shoud {not} include a "units"_units.html command or an +should {not} include a "units"_units.html command or an "atom_style"_atom_style.html command. These are set by the kim_init command based on its arguments. @@ -188,25 +189,26 @@ correctly. OpenKIM IM Execution :h5 The second and final step in using an OpenKIM IM is to execute the -kim_interaction command. This command must be preceded by a kim_init +kim_interactions command. This command must be preceded by a kim_init command and must follow the "create_box"_create_box.html command, which defines the number of atom types {N}. -The kim_interaction command has one argument {typeargs}, which contains +The kim_interactions command has one argument {typeargs}, which contains a list of {N} chemical species that are mapped to the atom types. For example, imagine the OpenKIM IM supports Si and C species. If the LAMMPS simulation has 4 atom types and you want the first three to be Si, -and the fourth to be C, you would use the following kim_interaction command: +and the fourth to be C, you would use the following kim_interactions command: -kim_interaction Si Si Si C :pre +kim_interactions Si Si Si C +:pre -The kim_interaction command performs all the necessary steps to set up +The kim_interactions command performs all the necessary steps to set up the OpenKIM IM set in the kim_init command. The specific actions depend on whether the IM is a KIM Model or a KIM SM. For a KIM Model, a "pair_style kim"_pair_kim.html command will be executed followed by the appropriate pair_coeff command. -For a KIM SM, the set of commands defined in the SM speficiation file +For a KIM SM, the set of commands defined in the SM specification file will be executed. For example, consider the ReaxFF SM due to Strachan et al. (2003) executed by the following commands: @@ -306,7 +308,7 @@ changes to input script or command syntax between the two LAMMPS versions. [Restrictions:] -This command is part of the KIM package. It is only enabled if +These commands are part of the KIM package. It is only enabled if LAMMPS was built with that package. Furthermore, its correct functioning depends on compiling LAMMPS with all required packages installed that are required by the commands embedded in any KIM @@ -315,4 +317,4 @@ See the "Build package"_Build_package.html doc page for more info. [Related commands:] -"pair_style kim"_pair_kim.html, "kim_query"_kim_query.html +"pair_style kim"_pair_kim.html, "units"_units.html diff --git a/doc/src/pair_kim.txt b/doc/src/pair_kim.txt index 523bd89d7c..7e399b7ce0 100644 --- a/doc/src/pair_kim.txt +++ b/doc/src/pair_kim.txt @@ -112,7 +112,7 @@ kim-api package version 2.0.0 and higher. [Related commands:] -"pair_coeff"_pair_coeff.html, "kim_style"_kim_style.html, -"kim_query"_kim_query.html +"pair_coeff"_pair_coeff.html, "kim_init"_kim_commands.html, +"kim_interactions"_kim_commands, "kim_query"_kim_commands.html [Default:] none diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index a8bfa8f193..6a75f0555a 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -1606,6 +1606,7 @@ meso mesoparticle mesoscale mesoscopic +metadata metadynamics Metadynamics Methfessel @@ -2271,6 +2272,7 @@ rcutfac rdc rdf RDideal +rdx README realtime reamin @@ -2297,6 +2299,8 @@ Rensselaer reparameterizing repo representable +Reproducibility +reproducibility repuls rescale rescaled @@ -2585,6 +2589,7 @@ Stoll stopstep Stouch Straatsma +Strachan Stratford Strathclyde Straub @@ -2822,6 +2827,7 @@ undump uniaxial uniaxially unimodal +unitarg unitless Universite unix -- GitLab From c9cb6e3658e66f4cf9086e9ed50232e477f7ed3e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 13:12:23 -0400 Subject: [PATCH 072/469] remove obsolete files --- doc/src/kim_query.txt | 47 ------------------- doc/src/kim_style.txt | 107 ------------------------------------------ 2 files changed, 154 deletions(-) delete mode 100644 doc/src/kim_query.txt delete mode 100644 doc/src/kim_style.txt diff --git a/doc/src/kim_query.txt b/doc/src/kim_query.txt deleted file mode 100644 index 84eca6e676..0000000000 --- a/doc/src/kim_query.txt +++ /dev/null @@ -1,47 +0,0 @@ -"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c - -:link(lws,http://lammps.sandia.gov) -:link(ld,Manual.html) -:link(lc,Commands_all.html) - -:line - -kim_query command :h3 - -[Syntax:] - -kim_query variable query_function web_query_flags :pre - -variable = name of a (string style) variable where the result of the query is stored -query_function = name of the OpenKIM web API query function to be used -web_query_flags = a series of keyword=value pairs that represent the web query; supported keywords depend on query function :ul - -[Examples:] - -kim_query latconst get_test_result test=TE_156715955670 model=MO_800509458712 & - prop=structure-cubic-crystal-npt species=\["Al"\] keys=\["a"\] units=\["angstrom"\] :pre - -[Description:] - -The kim_query command allows to retrieve properties from the OpenKIM -through a web query. The result is stored in a string style -"variable"_variable.html, the name of which must be given as the first -argument of the kim_query command. The second required argument is the -name of the actual query function (e.g. {get_test_result}). All following -arguments are parameters handed over to the web query in the format -{keyword=value}. The list of supported keywords and the type of how -the value has to be encoded depends on the query function used. This -mirrors the functionality available on the OpenKIM webpage at -"https://query.openkim.org"_https://query.openkim.org/ - -[Restrictions:] - -This command is part of the KIM package. It is only enabled if -LAMMPS was built with that package. Furthermore, its correct -functioning depends on compiling LAMMPS with libcurl support. -See the "Build package"_Build_package.html doc page for more info. - -[Related commands:] - -"pair_style kim"_pair_kim.html, "kim_style"_kim_style.html, -"variable"_variable.html diff --git a/doc/src/kim_style.txt b/doc/src/kim_style.txt deleted file mode 100644 index c24cfe8581..0000000000 --- a/doc/src/kim_style.txt +++ /dev/null @@ -1,107 +0,0 @@ -"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c - -:link(lws,http://lammps.sandia.gov) -:link(ld,Manual.html) -:link(lc,Commands_all.html) - -:line - -kim_style command :h3 - -[Syntax:] - -kim_style mode args :pre - -mode = {init model} or {define typeargs} or no mode chosen -model = name of the KIM model (KIM potential or KIM simulator model) -typeargs = atom type to species mapping (one entry per atom type) -args = {unit_variables unit_style} or {unit_from unit_style} (optional):ul - -[Examples:] - -kim_style init ex_sim_model_Si_mod_tersoff unit_variables metal -kim_style define Si Si -kim_style unit_variables real -kim_style init LennardJones_Ar unit_variables metal -kim_style unit_variables real unit_from metal -kim_style define Ar :pre - -[Description:] - -The kim_style command is a high-level wrapper around the -"Knowledge Base for Interatomic Models (OpenKIM)"_https://openkim.org -repository of interatomic potentials, so that they can be used by -LAMMPS scripts. It does not implement any computations directly, but -rather will generate LAMMPS input commands based on the information -retrieved from the OpenKIM repository. It is able to realize so-called -"KIM Simulator Models", which are OpenKIM repository entries of models -using native features of the simulation engine in use, i.e. LAMMPS -in this case, but it also supports realizing conventional KIM models -implicitly via generating a "pair_style kim"_pair_kim.html command -followed by a suitable "pair_coeff"_pair_coeff.html command. - -The kim_style command has two modes, {init} and {define}, indicated by -the first argument to the kim_style command. An {init} mode command -must be issued [before] the simulation box is created, while the {define} -mode version may only be used [after] the simulation box exists. Both -are required. The {init} mode version sets the model name and may issue -additional commands changing LAMMPS default settings that are required -for using a selected simulator model. If needed, those settings can be -overridden. The second argument to the {kim_style init} command is the -KIM model ID. - -In both modes, the keywords {unit_variables} and {unit_from} may be -added. They control the values of a set of -"internal style variables"_variable.html that can be used to convert -between different unit styles in LAMMPS. The argument to -each keyword is a LAMMPS unit style or NULL, which means to look up -the unit style from what was set with the "units"_units.html command. -Please note, that KIM simulator models will set their preferred unit style. -By default all conversion variables are set to 1.0. Converting to or -from the "lj" unit style is not supported. The following variables are defined: - -_u_length -_u_mass -_u_time :ul - - -The {kim_style define} command will issue commands that will realize -the selected model (through generating pair_style and pair_coeff commands, -but also other commands, as required). It has to be issued [after] the -the simulation box is defined. The {kim_style define} command allows a -varying number of additional arguments. Those are used to map the atom -types in LAMMPS to the available species in the KIM model. This is -equivalent to the arguments following "pair_coeff * *" in a -"kim"_pair_kim.html pair style. Thus the commands: - -kim_style init LennardJones_Ar -kim_style define Ar :pre - -will generate the LAMMPS input commands: - -pair_style kim LennardJones_Ar -pair_coeff * * Ar :pre - -For simulator models, the generated input commands may be more complex -and require that LAMMPS is built with the required packages included. -The commands generated by the kim_style command, can be copied to the -screen or log file, through the "echo"_echo.html command. -The kim_style command will also validate, that a selected simulator -model was generated for the LAMMPS MD code and not some other software. -In addition, the version strings for LAMMPS version used for defining -the simulator model and the LAMMPS version being currently run are -printed, so that it can be tracked down, if there are any incompatible -changes to input script or command syntax between the two LAMMPS versions. - -[Restrictions:] - -This command is part of the KIM package. It is only enabled if -LAMMPS was built with that package. Furthermore, its correct -functioning depends on compiling LAMMPS with all required packages -installed that are required by the commands embedded in any KIM -simulator models used. -See the "Build package"_Build_package.html doc page for more info. - -[Related commands:] - -"pair_style kim"_pair_kim.html, "kim_query"_kim_query.html -- GitLab From ac82aa754b583886e193471bc042635c9c82955c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 13:13:05 -0400 Subject: [PATCH 073/469] correct off-by-one error and simplify code by using std::string instead of std::stringstream --- src/KIM/kim_init.cpp | 17 +++++++++-------- 1 file changed, 9 insertions(+), 8 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 695db0aa0d..6339f7397e 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -246,7 +246,7 @@ void KimInit::determine_model_type_and_units(char * model_name, if (*sim_field == "units") { kim_SM->GetSimulatorFieldLine(i,0,&sim_value); - int len=(*sim_value).length(); + int len=(*sim_value).length()+1; *model_units = new char[len]; strcpy(*model_units,sim_value->c_str()); break; } @@ -414,15 +414,16 @@ void KimInit::do_variables(char *user_units, char *model_units) (char *)"density"}; if (comm->me == 0) { - std::stringstream mesg; - mesg << "# Conversion factors from " << from << " to " << to - << ":" << std::endl; - if (screen) fputs(mesg.str().c_str(),screen); - if (logfile) fputs(mesg.str().c_str(),logfile); + std::string mesg("# Conversion factors from "); + mesg += from; + mesg += " to "; + mesg += to; + mesg += ":\n"; + if (screen) fputs(mesg.c_str(),screen); + if (logfile) fputs(mesg.c_str(),logfile); } - for (int i = 0; i < nunits; i++) - { + for (int i = 0; i < nunits; i++) { var_str = std::string("_u_") + std::string(units[i]); args[0] = (char *)var_str.c_str(); v_unit = variable->find(args[0]); -- GitLab From c557c7492b4ce0ab90ca80e2ba6c100b9a83c825 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 13:31:12 -0400 Subject: [PATCH 074/469] adapt names of stored properties to code that uses fix STORE/KIM --- src/KIM/fix_store_kim.cpp | 43 ++++++++++++++++++--------------------- src/KIM/fix_store_kim.h | 4 ++-- 2 files changed, 22 insertions(+), 25 deletions(-) diff --git a/src/KIM/fix_store_kim.cpp b/src/KIM/fix_store_kim.cpp index 6423a57e18..8209a6d13e 100644 --- a/src/KIM/fix_store_kim.cpp +++ b/src/KIM/fix_store_kim.cpp @@ -66,7 +66,7 @@ using namespace FixConst; FixStoreKIM::FixStoreKIM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), simulator_model(NULL), model_name(NULL), - units_from(NULL), units_to(NULL) + model_units(NULL), user_units(NULL) { if (narg != 3) error->all(FLERR,"Illegal fix STORE/KIM command"); } @@ -89,16 +89,15 @@ FixStoreKIM::~FixStoreKIM() model_name = NULL; } - if (units_from) { - char *uf = (char *)units_from; - delete[] uf; - units_from = NULL; + if (model_units) { + char *mu = (char *)model_units; + delete[] mu; + model_units = NULL; } - - if (units_to) { - char *ut = (char *)units_to; - delete[] ut; - units_to = NULL; + if (user_units) { + char *uu = (char *)user_units; + delete[] uu; + user_units = NULL; } } @@ -127,19 +126,17 @@ void FixStoreKIM::setptr(const char *name, void *ptr) delete[] mn; } model_name = ptr; - } else if (strcmp(name,"units_from") == 0) { - if (units_from) { - char *uf = (char *)units_from; - delete[] uf; + } else if (strcmp(name,"model_units") == 0) { + if (model_units) { + char *mu = (char *)model_units; + delete[] mu; } - units_from = ptr; - } else if (strcmp(name,"units_to") == 0) { - if (units_to) { - char *ut = (char *)units_to; - delete[] ut; + } else if (strcmp(name,"user_units") == 0) { + if (user_units) { + char *uu = (char *)user_units; + delete[] uu; } - units_to = ptr; - } + } else error->all(FLERR,"Unknown property in fix STORE/KIM"); } /* ---------------------------------------------------------------------- */ @@ -148,7 +145,7 @@ void *FixStoreKIM::getptr(const char *name) { if (strcmp(name,"simulator_model") == 0) return simulator_model; else if (strcmp(name,"model_name") == 0) return model_name; - else if (strcmp(name,"units_from") == 0) return units_from; - else if (strcmp(name,"units_to") == 0) return units_to; + else if (strcmp(name,"model_units") == 0) return model_units; + else if (strcmp(name,"user_units") == 0) return user_units; else return NULL; } diff --git a/src/KIM/fix_store_kim.h b/src/KIM/fix_store_kim.h index 5bca2a3dd0..655be83ad0 100644 --- a/src/KIM/fix_store_kim.h +++ b/src/KIM/fix_store_kim.h @@ -80,8 +80,8 @@ class FixStoreKIM : public Fix { private: void *simulator_model; // pointer to KIM simulator model class void *model_name; // string of KIM model name - void *units_from; // string of unit conversion origin or NULL - void *units_to; // string of unit conversion target or NULL + void *model_units; // string of unit conversion origin or NULL + void *user_units; // string of unit conversion target or NULL }; } -- GitLab From 065638edba999ab91b078e089b807d58c205b6ae Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 13:31:43 -0400 Subject: [PATCH 075/469] remove unused macro and reformat to closer match LAMMPS programming style --- src/KIM/kim_init.cpp | 11 ++--------- 1 file changed, 2 insertions(+), 9 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 6339f7397e..0d8849c51c 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -79,10 +79,6 @@ extern "C" { #include "KIM_SimulatorModel.hpp" //@@@@@ -#define SNUM(x) \ - static_cast(std::ostringstream() \ - << std::dec << x).str() - using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ @@ -187,14 +183,11 @@ void KimInit::determine_model_type_and_units(char * model_name, model_type = MO; KIM_Model_Destroy(&kim_MO); - if (units_accepted) - { + if (units_accepted) { int len=strlen(user_units); *model_units = new char[len]; strcpy(*model_units,user_units); return; - } - else if (unit_conversion_mode) - { + } else if (unit_conversion_mode) { int const num_systems = 5; char const * const systems[num_systems] = {"metal", "real", "si", "cgs", "electron"}; -- GitLab From 27d1f79fe37e5ba2153590731092997d0bdf9890 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 13:39:12 -0400 Subject: [PATCH 076/469] simplify another case of stringstream to use plain std::string --- src/KIM/kim_init.cpp | 11 +++++------ 1 file changed, 5 insertions(+), 6 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 0d8849c51c..1ca55d7adc 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -246,12 +246,11 @@ void KimInit::determine_model_type_and_units(char * model_name, } KIM::SimulatorModel::Destroy(&kim_SM); - if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) - { - std::stringstream mesg; - mesg << "Incompatible units for KIM Simulator Model, required units = " - << *model_units; - error->all(FLERR,mesg.str().c_str()); + if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) { + std::string mesg("Incompatible units for KIM Simulator Model, " + "required units = "); + mesg += *model_units; + error->all(FLERR,mesg.c_str()); } } -- GitLab From c6d0f807b569bdf6ab6e9ed0665ca81d80f1d3d5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 14:13:24 -0400 Subject: [PATCH 077/469] output messages that would otherwise only show up in logs only when logs are enable for screen or logfile --- src/KIM/kim_init.cpp | 16 ++++++++-------- src/KIM/kim_interactions.cpp | 4 ++-- src/input.h | 6 ++++-- 3 files changed, 14 insertions(+), 12 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 1ca55d7adc..ce1b944792 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -363,8 +363,8 @@ void KimInit::kim_init_log_delimiter(std::string const begin_end) const mesg = "#=== END kim-init ============================================\n\n"; - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); + if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); + if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); } } @@ -411,8 +411,8 @@ void KimInit::do_variables(char *user_units, char *model_units) mesg += " to "; mesg += to; mesg += ":\n"; - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); + if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); + if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); } for (int i = 0; i < nunits; i++) { @@ -441,12 +441,12 @@ void KimInit::do_variables(char *user_units, char *model_units) << " internal " << std::setprecision(12) << std::scientific << conversion_factor << std::endl; - if (screen) fputs(mesg.str().c_str(),screen); - if (logfile) fputs(mesg.str().c_str(),logfile); + if ((screen) && (input->echo_screen)) fputs(mesg.str().c_str(),screen); + if ((logfile) && (input->echo_log)) fputs(mesg.str().c_str(),logfile); } } if (comm->me == 0) { - if (screen) fputs("#\n",screen); - if (logfile) fputs("#\n",logfile); + if ((screen) && (input->echo_screen)) fputs("#\n",screen); + if ((logfile) && (input->echo_log)) fputs("#\n",logfile); } } diff --git a/src/KIM/kim_interactions.cpp b/src/KIM/kim_interactions.cpp index 491d406ae6..4771272ff8 100644 --- a/src/KIM/kim_interactions.cpp +++ b/src/KIM/kim_interactions.cpp @@ -109,8 +109,8 @@ void KimInteractions::kim_interactions_log_delimiter( mesg = "#=== END kim_interactions ====================================\n\n"; - if (screen) fputs(mesg.c_str(),screen); - if (logfile) fputs(mesg.c_str(),logfile); + if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); + if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); } } diff --git a/src/input.h b/src/input.h index 47ad7779f1..ebd015619c 100644 --- a/src/input.h +++ b/src/input.h @@ -25,6 +25,8 @@ class Input : protected Pointers { friend class Info; friend class Error; friend class Deprecated; + friend class KimInit; + friend class KimInteractions; public: int narg; // # of command args @@ -42,14 +44,14 @@ class Input : protected Pointers { protected: char *command; // ptr to current command + int echo_screen; // 0 = no, 1 = yes + int echo_log; // 0 = no, 1 = yes private: int me; // proc ID int maxarg; // max # of args in arg char *line,*copy,*work; // input line & copy and work string int maxline,maxcopy,maxwork; // max lengths of char strings - int echo_screen; // 0 = no, 1 = yes - int echo_log; // 0 = no, 1 = yes int nfile,maxfile; // current # and max # of open input files int label_active; // 0 = no label, 1 = looking for label char *labelstr; // label string being looked for -- GitLab From 493269431c354d5177a10acaec2b94c3aed18b67 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 14:16:38 -0400 Subject: [PATCH 078/469] add a few more false positives --- doc/utils/sphinx-config/false_positives.txt | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 6a75f0555a..5ea7388cd6 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -570,6 +570,7 @@ Dihedrals dihydride Dij dimdim +dimensioned dimensionality dimgray dipolar @@ -599,6 +600,7 @@ Dobson Dodds dodgerblue dof +doi Donadio dotc Doty @@ -749,6 +751,7 @@ equilibrating equilibration Equilibria equilization +Ercolessi eradius erate erc @@ -2243,6 +2246,7 @@ quati quatj quatk quatw +queryargs Queteschiner qw qx -- GitLab From b2ba0550d70d6829fa3b2b40a86025e2faf95a2e Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Sun, 23 Jun 2019 13:18:57 -0500 Subject: [PATCH 079/469] Some minor typo fixes in kim_commands.txt --- doc/src/kim_commands.txt | 7 +++---- 1 file changed, 3 insertions(+), 4 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 2e94271763..e51aec5dc7 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -71,7 +71,7 @@ Types of KIM IMs :h4 There are two types of IMs archived in OpenKIM: -The first type is called a {KIM Model}. A KIM Model is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran, Python), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that support the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). +The first type is called a {KIM Model}. A KIM Model is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that supports the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). The second type is called a {KIM Simulator Model} (SM). In this case, the IM is implemented natively within the simulation code ({simulator}), i.e. LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol With these two IM types, OpenKIM can archive and test almost all IMs that @@ -212,13 +212,13 @@ The second and final step in using an OpenKIM IM is to execute the {kim_interactions} command. This command must be preceded by a {kim_init} command and a "create_box"_create_box.html command, which defines the number of atom types {N}. -The {kim_interaction} command has one argument {typeargs}. This argument +The {kim_interactions} command has one argument {typeargs}. This argument contains a list of {N} chemical species, which defines a mapping between atom types in LAMMPS to the available species in the OpenKIM IM. For example, consider an OpenKIM IM that supports Si and C species. If the LAMMPS simulation has four atom types, where the first three are Si, -and the fourth is C, the following {kim_interaction} command would be used: +and the fourth is C, the following {kim_interactions} command would be used: kim_interactions Si Si Si C :pre @@ -376,4 +376,3 @@ doi: "https://doi.org/10.1007/s11837-011-0102-6"_https://doi.org/10.1007/s11837- :link(kim-api) [(Elliott)] Elliott, Tadmor and Bernstein, "https://openkim.org/kim-api"_https://openkim.org/kim-api (2011) doi: "https://doi.org/10.25950/FF8F563A"_https://doi.org/10.25950/FF8F563A - -- GitLab From e42e1e64a894e7b52c3c75a8b830918819cfdafa Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 14:50:52 -0500 Subject: [PATCH 080/469] Added explanation on Model and SM pages --- doc/src/kim_commands.txt | 18 ++++++++++++++++++ 1 file changed, 18 insertions(+) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index e51aec5dc7..5a50a76879 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -90,6 +90,24 @@ By convention SM prefixes begin with {Sim_} to readily identify them. SW_StillingerWeber_1985_Si__MO_405512056662_005 Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 :pre +Each OpenKIM IM has a dedicated page on "OpenKIM"_https://openkim.org +providing all the information on the IM including a title, description, +authorship and citation information, test and verification check results, +visualizations of results, a wiki with documentation and user comments, and +access to raw files, and other information. +This is referred to as the "Model Page" or "SM Page". +The URL for such a page is constructed from the +"extended KIM ID"_https://openkim.org/about-kim-ids/ of the IM: + +https://openkim.org/id/extended_KIM_ID +:pre + +For example for the Stillinger-Weber potential +listed above the Model Page is located at: + +"https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005"_https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005 +:pre + NOTE: It is also possible to locally install IMs not archived in OpenKIM, in which case their names do not have to conform to the KIM ID format. -- GitLab From 36649f0534d3b20211953c1dbecedc33e7dd3857 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 16:47:12 -0400 Subject: [PATCH 081/469] add workaround for handline include files --- src/input.cpp | 7 +++++++ src/input.h | 1 + 2 files changed, 8 insertions(+) diff --git a/src/input.cpp b/src/input.cpp index f88c8ca0c0..dd445b10f3 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -77,6 +77,7 @@ Input::Input(LAMMPS *lmp, int argc, char **argv) : Pointers(lmp) echo_screen = 0; echo_log = 1; + eof_return = 0; label_active = 0; labelstr = NULL; @@ -205,6 +206,7 @@ void Input::file() MPI_Bcast(&n,1,MPI_INT,0,world); if (n == 0) { if (label_active) error->all(FLERR,"Label wasn't found in input script"); + if (eof_return) break; if (me == 0) { if (infile != stdin) { fclose(infile); @@ -1051,6 +1053,11 @@ void Input::include() error->one(FLERR,str); } infiles[nfile++] = infile; + eof_return = 1; + file(); + eof_return = 0; + nfile--; + infile = infiles[nfile-1]; } } diff --git a/src/input.h b/src/input.h index ebd015619c..7fb125ffb5 100644 --- a/src/input.h +++ b/src/input.h @@ -46,6 +46,7 @@ class Input : protected Pointers { char *command; // ptr to current command int echo_screen; // 0 = no, 1 = yes int echo_log; // 0 = no, 1 = yes + int eof_return; // if 1: at EOF return from parsing in file() private: int me; // proc ID -- GitLab From bfe6cc29e81b84c6dada9bc9cbd942b3d0a21c93 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 17:52:43 -0400 Subject: [PATCH 082/469] fix bug of not storing pointers --- src/KIM/fix_store_kim.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/KIM/fix_store_kim.cpp b/src/KIM/fix_store_kim.cpp index 8209a6d13e..c9a99acca9 100644 --- a/src/KIM/fix_store_kim.cpp +++ b/src/KIM/fix_store_kim.cpp @@ -131,11 +131,13 @@ void FixStoreKIM::setptr(const char *name, void *ptr) char *mu = (char *)model_units; delete[] mu; } + model_units = ptr; } else if (strcmp(name,"user_units") == 0) { if (user_units) { char *uu = (char *)user_units; delete[] uu; } + user_units = ptr; } else error->all(FLERR,"Unknown property in fix STORE/KIM"); } -- GitLab From 6d54cf6a07d38d97be5157d4977ea831c10d9f48 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 17:53:12 -0400 Subject: [PATCH 083/469] programming style changes --- src/KIM/kim_init.cpp | 39 +++++++++++++++------------------------ 1 file changed, 15 insertions(+), 24 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index ce1b944792..080e3dac3f 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -90,10 +90,10 @@ void KimInit::command(int narg, char **arg) if (domain->box_exist) error->all(FLERR,"Must use 'kim_init' command before " "simulation box is defined"); - int len0 = strlen(arg[0])+1; - int len1 = strlen(arg[1])+1; - char *model_name = new char[len0]; strcpy(model_name,arg[0]); - char *user_units = new char[len1]; strcpy(user_units,arg[1]); + char *model_name = new char[strlen(arg[0])+1]; + strcpy(model_name,arg[0]); + char *user_units = new char[strlen(arg[1])+1]; + strcpy(user_units,arg[1]); if (narg == 3) { if (strcmp(arg[2],"unit_conversion_mode")==0) unit_conversion_mode = true; else { error->all(FLERR,"Illegal kim_init command"); } @@ -178,21 +178,19 @@ void KimInit::determine_model_type_and_units(char * model_name, &units_accepted, &kim_MO); - if (!kim_error) // model is an MO - { + if (!kim_error) { // model is an MO model_type = MO; KIM_Model_Destroy(&kim_MO); if (units_accepted) { - int len=strlen(user_units); - *model_units = new char[len]; strcpy(*model_units,user_units); + *model_units = new char[strlen(user_units)+1]; + strcpy(*model_units,user_units); return; } else if (unit_conversion_mode) { int const num_systems = 5; char const * const systems[num_systems] = {"metal", "real", "si", "cgs", "electron"}; - for (int i=0; i < num_systems; ++i) - { + for (int i=0; i < num_systems; ++i) { get_kim_unit_names(systems[i], lengthUnit, energyUnit, chargeUnit, temperatureUnit, timeUnit, error); kim_error = KIM_Model_Create(KIM_NUMBERING_zeroBased, @@ -205,17 +203,13 @@ void KimInit::determine_model_type_and_units(char * model_name, &units_accepted, &kim_MO); KIM_Model_Destroy(&kim_MO); - if (units_accepted) - { - int len=strlen(systems[i]); - *model_units = new char[len]; strcpy(*model_units,systems[i]); + if (units_accepted) { + *model_units = new char[strlen(systems[i])+1]; + strcpy(*model_units,systems[i]); return; } - } - error->all(FLERR,"KIM Model does not support any lammps unit system"); - } - else - { + } error->all(FLERR,"KIM Model does not support any lammps unit system"); + } else { error->all(FLERR,"KIM Model does not support the requested unit system"); } } @@ -223,9 +217,7 @@ void KimInit::determine_model_type_and_units(char * model_name, KIM::SimulatorModel * kim_SM; kim_error = KIM::SimulatorModel::Create(model_name, &kim_SM); if (kim_error) - { error->all(FLERR,"KIM model name not found"); - } model_type = SM; int sim_fields; @@ -257,7 +249,7 @@ void KimInit::determine_model_type_and_units(char * model_name, /* ---------------------------------------------------------------------- */ -void KimInit::do_init(char *model_name, char *user_units, char* model_units) +void KimInit::do_init(char *model_name, char *user_units, char *model_units) { // create storage proxy fix. delete existing fix, if needed. @@ -322,8 +314,7 @@ void KimInit::do_init(char *model_name, char *user_units, char* model_units) cmd += model_units; input->one(cmd.c_str()); - if (model_type == SM) - { + if (model_type == SM) { int sim_fields, sim_lines; const std::string *sim_field, *sim_value; simulatorModel->GetNumberOfSimulatorFields(&sim_fields); -- GitLab From d10fdda6765c6cbe905509bf3eae7888cadb00ad Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 23 Jun 2019 17:53:52 -0400 Subject: [PATCH 084/469] simplify nested include file handling --- src/input.cpp | 17 ++--------------- src/input.h | 1 - 2 files changed, 2 insertions(+), 16 deletions(-) diff --git a/src/input.cpp b/src/input.cpp index dd445b10f3..268be5b774 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -77,7 +77,6 @@ Input::Input(LAMMPS *lmp, int argc, char **argv) : Pointers(lmp) echo_screen = 0; echo_log = 1; - eof_return = 0; label_active = 0; labelstr = NULL; @@ -206,18 +205,7 @@ void Input::file() MPI_Bcast(&n,1,MPI_INT,0,world); if (n == 0) { if (label_active) error->all(FLERR,"Label wasn't found in input script"); - if (eof_return) break; - if (me == 0) { - if (infile != stdin) { - fclose(infile); - infile = NULL; - } - nfile--; - } - MPI_Bcast(&nfile,1,MPI_INT,0,world); - if (nfile == 0) break; - if (me == 0) infile = infiles[nfile-1]; - continue; + break; } if (n > maxline) reallocate(line,maxline,n); @@ -1053,9 +1041,8 @@ void Input::include() error->one(FLERR,str); } infiles[nfile++] = infile; - eof_return = 1; file(); - eof_return = 0; + fclose(infile); nfile--; infile = infiles[nfile-1]; } diff --git a/src/input.h b/src/input.h index 7fb125ffb5..ebd015619c 100644 --- a/src/input.h +++ b/src/input.h @@ -46,7 +46,6 @@ class Input : protected Pointers { char *command; // ptr to current command int echo_screen; // 0 = no, 1 = yes int echo_log; // 0 = no, 1 = yes - int eof_return; // if 1: at EOF return from parsing in file() private: int me; // proc ID -- GitLab From b5d4cf4bfdff3b33a76198bcdb070798bbe908ab Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 17:23:21 -0500 Subject: [PATCH 085/469] Updated KIM package information --- doc/src/Packages_details.txt | 51 ++++++++++++++++++++++-------------- 1 file changed, 31 insertions(+), 20 deletions(-) diff --git a/doc/src/Packages_details.txt b/doc/src/Packages_details.txt index d6e8f8639f..bf71e058f5 100644 --- a/doc/src/Packages_details.txt +++ b/doc/src/Packages_details.txt @@ -338,27 +338,37 @@ KIM package :link(PKG-KIM),h4 [Contents:] -A "pair_style kim"_pair_kim.html command which is a wrapper on the -Knowledge Base for Interatomic Models (KIM) repository of interatomic -potentials, enabling any of them to be used in LAMMPS simulations. -Also a "kim_query"_kim_commands.html command, which allows to query -the OpenKIM database for stored properties, and the commands -"kim_init and kim_interactions"_kim_commands.html, which serve as -front end to generating LAMMPS input on-the-fly for KIM simulator -models and native KIM models. - -To use this package you must have the KIM library available on your -system. +This package contains a set of commands that serve as a wrapper on the +"Open Knowledgebase of Interatomic Models (OpenKIM)"_https://openkim.org +repository of interatomic models (IMs) +enabling compatible ones to be used in LAMMPS simulations. +This includes "kim_init and kim_interactions"_kim_commands.html +commands to select, initialize and instantiate the IM, and a +"kim_query"_kim_commands.html command to perform web queries +for material property predictions of OpenKIM IMs. +Support for KIM IMs that conform to the +"KIM Application Programming Interface (API)"_https://openkim.org/kim-api/ +is provided by the "pair_style kim"_pair_kim.html command. + +NOTE: The command {pair_style kim} is called by {kim_interactions} and +is not recommended to be directly used in input scripts. + +To use this package you must have the KIM API library available on your +system. The KIM API is available for download on the +"OpenKIM website"_https://openkim.org/kim-api/. +When installing LAMMPS from binary, the kim-api package +is a dependency that is automatically downloaded and installed. Information about the KIM project can be found at its website: -https://openkim.org. The KIM project is led by Ellad Tadmor and Ryan -Elliott (U Minnesota). +"https://openkim.org"_https://openkim.org. +The KIM project is led by Ellad Tadmor and Ryan Elliott (U Minnesota) +and is funded by the "National Science Foundation"_https://www.nsf.gov/. [Authors:] Ryan Elliott (U Minnesota) is the main developer for the KIM -API which the "pair_style kim"_pair_kim.html command uses. He developed -the pair style. Axel Kohlmeyer (Temple U) contributed the -"kim_query"_kim_commands.html and "kim_init"_kim_commands.html commands -in close collaboration with Ryan. +API and the {pair_style kim} command. Axel Kohlmeyer (Temple U) and +Ellad Tadmor (U Minnesota) contributed to the "kim_commands"_kim_commands.html +interface in close collaboration with Ryan Elliott. + [Install:] @@ -368,10 +378,11 @@ extras"_Build_extras.html doc page. [Supporting info:] +"kim_commands"_kim_commands.html +"pair_style kim"_pair_kim.html src/KIM: filenames -> commands src/KIM/README lib/kim/README -"pair_style kim"_pair_kim.html examples/kim :ul :line @@ -987,9 +998,9 @@ USER-ADIOS package :link(PKG-USER-ADIOS),h4 [Contents:] -ADIOS is a high-performance I/O library. This package implements the +ADIOS is a high-performance I/O library. This package implements the dump "atom/adios" and dump "custom/adios" commands to write data using -the ADIOS library. +the ADIOS library. [Authors:] Norbert Podhorszki (ORNL) from the ADIOS developer team. -- GitLab From 881f9ff04337c6e743f2fa9a7e0b71af28e85107 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 17:36:10 -0500 Subject: [PATCH 086/469] Updated the pair_kim docs --- doc/src/pair_kim.txt | 85 ++++++++++++++++++++------------------------ 1 file changed, 39 insertions(+), 46 deletions(-) diff --git a/doc/src/pair_kim.txt b/doc/src/pair_kim.txt index 7e399b7ce0..86d13808b0 100644 --- a/doc/src/pair_kim.txt +++ b/doc/src/pair_kim.txt @@ -12,76 +12,71 @@ pair_style kim command :h3 pair_style kim model :pre -model = name of KIM model (potential) +model = name of a KIM model (the KIM ID for models archived in OpenKIM) [Examples:] -pair_style kim ex_model_Ar_P_LJ -pair_coeff * * Ar Ar :pre +pair_style kim SW_StillingerWeber_1985_Si__MO_405512056662_005 +pair_coeff * * Si :pre [Description:] -This pair style is a wrapper on the "Knowledge Base for Interatomic +This pair style is a wrapper on the "Open Knowledgebase of Interatomic Models (OpenKIM)"_https://openkim.org repository of interatomic -potentials, so that they can be used by LAMMPS scripts. +potentials to enable their use in LAMMPS scripts. -Note that in LAMMPS lingo, a KIM model driver is a pair style -(e.g. EAM or Tersoff). A KIM model is a pair style for a particular -element or alloy and set of parameters, e.g. EAM for Cu with a -specific EAM potential file. +The preferred interface for using interatomic models archived in +OpenKIM is the "kim_commands interface"_kim_commands.html. That +interface supports both "KIM Models" that conform to the KIM API +and can be used by any KIM-compliant simulation code, and +"KIM Simulator Models" that are natively implemented within a single +simulation code (like LAMMPS) and can only be used with it. +The {pair_style kim} command is limited to KIM Models. It is +used by the "kim_commands interface"_kim_commands.html as needed. -See the current list of "KIM model -drivers"_https://openkim.org/browse/model-drivers/alphabetical. +NOTE: Since {pair_style kim} is called by {kim_interactions} as needed, +is not recommended to be directly used in input scripts. -See the current list of all "KIM -models"_https://openkim.org/browse/models/by-model-drivers - -To use this pair style, you must first download and install the KIM -API library from the "OpenKIM website"_https://openkim.org. The KIM -section of the "Packages details"_Packages_details.html doc page has -instructions on how to do this with a simple make command, when -building LAMMPS. - -See the examples/kim dir for an input script that uses a KIM model -(potential) for Lennard-Jones. - :line The argument {model} is the name of the KIM model for a specific -potential as KIM defines it. In principle, LAMMPS can invoke any KIM -model. You should get an error or warning message from either LAMMPS -or KIM if there is an incompatibility. - -Only a single pair_coeff command is used with the {kim} style which -specifies the mapping of LAMMPS atom types to KIM elements. This is -done by specifying N additional arguments after the * * in the -pair_coeff command, where N is the number of LAMMPS atom types: +potential as KIM defines it. For potentials archived in OpenKIM +this is the extended KIM ID (see "kim_commands"_kim_commands.html +for details). LAMMPS can invoke any KIM Model, however there can +be incompatibilities (for example unit matching issues). +In the event of an incompatibility, the code will terminate with +an error message. Check both the LAMMPS and KIM log files for details. + +Only a single {pair_coeff} command is used with the {kim} style, which +specifies the mapping of LAMMPS atom types to the species supported by +the KIM Model. This is done by specifying {N} additional arguments +after the * * in the {pair_coeff} command, where {N} is the number of +LAMMPS atom types: N element names = mapping of KIM elements to atom types :ul -As an example, imagine the KIM model supports Si and C atoms. If your -LAMMPS simulation has 4 atom types and you want the 1st 3 to be Si, -and the 4th to be C, you would use the following pair_coeff command: +For example, consider a KIM Model that supports Si and C species. +If the LAMMPS simulation has four atom types, where the first three are Si, +and the fourth is C, the following {pair_coeff} command would be used: pair_coeff * * Si Si Si C :pre -The 1st 2 arguments must be * * so as to span all LAMMPS atom types. -The first three Si arguments map LAMMPS atom types 1,2,3 to Si as -defined within KIM. The final C argument maps LAMMPS atom type 4 to C -as defined within KIM. +The first two arguments must be * * so as to span all LAMMPS atom types. +The first three Si arguments map LAMMPS atom types 1, 2, and 3 to Si as +defined within KIM Model. The final C argument maps LAMMPS atom type 4 to C. :line In addition to the usual LAMMPS error messages, the KIM library itself may generate errors, which should be printed to the screen. In this -case it is also useful to check the kim.log file for additional error +case it is also useful to check the {kim.log} file for additional error information. The file kim.log should be generated in the same directory where LAMMPS is running. To download, build, and install the KIM library on your system, see -the lib/kim/README file. Once you have done this and built LAMMPS +the {lib/kim/README} file. Once you have done this and built LAMMPS with the KIM package installed you can run the example input scripts -in examples/kim. +in {examples/kim}. :line @@ -103,16 +98,14 @@ This pair style can only be used via the {pair} keyword of the [Restrictions:] -This pair style is part of the KIM package. It is only enabled if -LAMMPS was built with that package. See the "Build -package"_Build_package.html doc page for more info. +This pair style is part of the KIM package. See details on +restrictions in "kim_commands"_kim_commands.html. This current version of pair_style kim is compatible with the kim-api package version 2.0.0 and higher. [Related commands:] -"pair_coeff"_pair_coeff.html, "kim_init"_kim_commands.html, -"kim_interactions"_kim_commands, "kim_query"_kim_commands.html +"pair_coeff"_pair_coeff.html, "kim_commands"_kim_commands.html [Default:] none -- GitLab From 94e1f87cb81ecd3b6f0d89e457ab94ae82f2641b Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 17:36:36 -0500 Subject: [PATCH 087/469] Moved some content from pair_kim docs to kim_commands --- doc/src/kim_commands.txt | 24 ++++++++++++++++++------ 1 file changed, 18 insertions(+), 6 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 5a50a76879..99ed068c44 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -67,7 +67,7 @@ The {kim_query} web query tool provides the ability to use the predictions of IM Support is provided for unit conversion between the "unit style"_units.html used in the LAMMPS input script and the units required by the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the likelihood of errors due to incompatible units. :ul :link(IM_types) -Types of KIM IMs :h4 +Types of IMs in OpenKIM :h4 There are two types of IMs archived in OpenKIM: @@ -108,6 +108,10 @@ listed above the Model Page is located at: "https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005"_https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005 :pre +See the "current list of KIM Models and SMs archived in OpenKIM"_https://openkim.org/browse/models/by-species. +This list is sorted by species and can be filtered to display only +IMs for certain species combinations. + NOTE: It is also possible to locally install IMs not archived in OpenKIM, in which case their names do not have to conform to the KIM ID format. @@ -118,6 +122,9 @@ IM and perform necessary initialization ({kim_init}), and the second to set up the IM for use by executing any necessary LAMMPS commands ({kim_interactions}). Both are required. +See the {examples/kim} directory for example input scripts that use KIM Models +and KIM SMs. + OpenKIM IM Initialization ({kim_init}) :h5 The {kim_init} mode command must be issued [before] @@ -375,11 +382,16 @@ OpenKIM to function. [Restrictions:] The set of {kim_commands} is part of the KIM package. It is only enabled if -LAMMPS was built with that package. Furthermore, its correct -functioning depends on compiling LAMMPS with all required packages -installed that are required by the commands embedded in any KIM -SM used. -See the "Build package"_Build_package.html doc page for more info. +LAMMPS is built with that package. A requirement for the KIM package, +is the KIM API library that must be downloaded from the +"OpenKIM website"_https://openkim.org/kim-api/ and installed before +LAMMPS is compiled. When installing LAMMPS from binary, the kim-api package +is a dependency that is automatically downloaded and installed. See the KIM +section of the "Packages details"_Packages_details.html for details. + +Furthermore, when using {kim_commands} to run KIM SMs, any packages required +by the native potential being used or other commands or fixes that it invokes +must be installed. [Related commands:] -- GitLab From d150feb41aa7c13858d56d8dd7ac18212e626492 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 17:46:00 -0500 Subject: [PATCH 088/469] Small change to KIM package build --- doc/src/Build_extras.txt | 7 ++++--- 1 file changed, 4 insertions(+), 3 deletions(-) diff --git a/doc/src/Build_extras.txt b/doc/src/Build_extras.txt index 220e9420fc..38d50522bb 100644 --- a/doc/src/Build_extras.txt +++ b/doc/src/Build_extras.txt @@ -177,11 +177,12 @@ use with LAMMPS. If you want to use the "kim_query"_kim_commands.html command, you also need to have libcurl installed with the matching development headers and the curl-config tool. -Note that in LAMMPS lingo, a KIM model driver is a pair style +Note that in LAMMPS jargon, a KIM model driver is a pair style (e.g. EAM or Tersoff). A KIM model is a pair style for a particular element or alloy and set of parameters, e.g. EAM for Cu with a -specific EAM potential file. Also note that downloading and installing -the KIM API library with all its models, may take a long time (10s of +specific EAM potential file. Also note that when downloading and +installing from source +the KIM API library with all its models, may take a long time (tens of minutes to hours) to build. Of course you only need to do that once. See the list of KIM model drivers here: -- GitLab From cf008c163def0bf64d77c8602b092cf4268261ed Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 18:01:35 -0500 Subject: [PATCH 089/469] Corrected box rescaling --- doc/src/kim_commands.txt | 11 ++++++++++- 1 file changed, 10 insertions(+), 1 deletion(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 99ed068c44..f039202e4e 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -225,7 +225,16 @@ from a file. For example if a configuration of atoms is read in from a dump file using the "read_dump"_read_dump.html command, the following can be done to convert the box and all atomic positions to the correct units: -change_box all x scale $\{_u_distance\} y scale $\{_u_distance\} z scale $\{_u_distance\} remap :pre +variable xyfinal equal xy*$\{_u_distance\} +variable xzfinal equal xz*$\{_u_distance\} +variable yzfinal equal yz*$\{_u_distance\} +change_box all x scale $\{_u_distance\} & +               y scale $\{_u_distance\} & +               z scale $\{_u_distance\} & +               xy final $\{xyfinal\} & +               xz final $\{xzfinal\} & +               yz final $\{yzfinal\} & +               remap :pre NOTE: Unit conversion will only work if the conversion factors are placed in all appropriate places in the input script. It is up to the user to do this -- GitLab From bfd0c4228d3505da1fad1028cb1629cab68375a6 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Sun, 23 Jun 2019 18:29:59 -0500 Subject: [PATCH 090/469] Added text that ADP potentials are available in KIM as well as NIST --- doc/src/pair_adp.txt | 16 +++++++++------- 1 file changed, 9 insertions(+), 7 deletions(-) diff --git a/doc/src/pair_adp.txt b/doc/src/pair_adp.txt index fc888ffbff..d5b07e8431 100644 --- a/doc/src/pair_adp.txt +++ b/doc/src/pair_adp.txt @@ -42,16 +42,18 @@ the ADP potential files themselves. Likewise, the ADP potential files list atomic masses; thus you do not need to use the "mass"_mass.html command to specify them. -The NIST WWW site distributes and documents ADP potentials: +[ADP potentials are available from:] -http://www.ctcms.nist.gov/potentials :pre +The NIST WWW site at http://www.ctcms.nist.gov/potentials. +Note that ADP potentials obtained from NIST must be converted +into the extended DYNAMO {setfl} format discussed below. +:l -Note that these must be converted into the extended DYNAMO {setfl} -format discussed below. +The OpenKIM Project at https://openkim.org provides ADP potentials +as Simulator Models that can be used directly in LAMMPS with +the "kim_commands interface"_kim_commands.html. +:l -The NIST site is maintained by Chandler Becker (cbecker at nist.gov) -who is good resource for info on interatomic potentials and file -formats. :line -- GitLab From 7afcfccf48fb06deccf9d185cabc377a5124d437 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 24 Jun 2019 13:51:41 -0400 Subject: [PATCH 091/469] follow convention to list all commands in a file as header --- doc/src/kim_commands.txt | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index f039202e4e..2aa705b483 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -6,7 +6,9 @@ :line -kim_commands :h3 +kim_init command :h3 +kim_interactions command :h3 +kim_query command :h3 [Syntax:] -- GitLab From 826a14f54ab8bef2472ef16876706ee2f95897e5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 24 Jun 2019 14:16:00 -0400 Subject: [PATCH 092/469] add workaround for handline include files # Conflicts: # src/input.h --- src/input.cpp | 7 +++++++ 1 file changed, 7 insertions(+) diff --git a/src/input.cpp b/src/input.cpp index 0111cb5738..32b6b697b1 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -78,6 +78,7 @@ Input::Input(LAMMPS *lmp, int argc, char **argv) : Pointers(lmp) echo_screen = 0; echo_log = 1; + eof_return = 0; label_active = 0; labelstr = NULL; @@ -206,6 +207,7 @@ void Input::file() MPI_Bcast(&n,1,MPI_INT,0,world); if (n == 0) { if (label_active) error->all(FLERR,"Label wasn't found in input script"); + if (eof_return) break; if (me == 0) { if (infile != stdin) { fclose(infile); @@ -1057,6 +1059,11 @@ void Input::include() error->one(FLERR,str); } infiles[nfile++] = infile; + eof_return = 1; + file(); + eof_return = 0; + nfile--; + infile = infiles[nfile-1]; } } -- GitLab From 7f26862f9841ebaab34961288eca4a5ba1187e9c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 24 Jun 2019 14:16:51 -0400 Subject: [PATCH 093/469] simplify nested include file handling # Conflicts: # src/input.h --- src/input.cpp | 17 ++--------------- 1 file changed, 2 insertions(+), 15 deletions(-) diff --git a/src/input.cpp b/src/input.cpp index 32b6b697b1..e5fbec6d5a 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -78,7 +78,6 @@ Input::Input(LAMMPS *lmp, int argc, char **argv) : Pointers(lmp) echo_screen = 0; echo_log = 1; - eof_return = 0; label_active = 0; labelstr = NULL; @@ -207,18 +206,7 @@ void Input::file() MPI_Bcast(&n,1,MPI_INT,0,world); if (n == 0) { if (label_active) error->all(FLERR,"Label wasn't found in input script"); - if (eof_return) break; - if (me == 0) { - if (infile != stdin) { - fclose(infile); - infile = NULL; - } - nfile--; - } - MPI_Bcast(&nfile,1,MPI_INT,0,world); - if (nfile == 0) break; - if (me == 0) infile = infiles[nfile-1]; - continue; + break; } if (n > maxline) reallocate(line,maxline,n); @@ -1059,9 +1047,8 @@ void Input::include() error->one(FLERR,str); } infiles[nfile++] = infile; - eof_return = 1; file(); - eof_return = 0; + fclose(infile); nfile--; infile = infiles[nfile-1]; } -- GitLab From 13237155c8f3d01be9a7b9375672d56bd2e787d5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 24 Jun 2019 14:24:54 -0400 Subject: [PATCH 094/469] make processing of Input::file(const char* filename) more like processing an include file --- src/input.cpp | 31 +++++++++++++++++++++++-------- 1 file changed, 23 insertions(+), 8 deletions(-) diff --git a/src/input.cpp b/src/input.cpp index e5fbec6d5a..644446710f 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -240,8 +240,8 @@ void Input::file() } /* ---------------------------------------------------------------------- - process all input from filename - called from library interface + process all input from file at filename + mostly called from library interface ------------------------------------------------------------------------- */ void Input::file(const char *filename) @@ -251,21 +251,30 @@ void Input::file(const char *filename) // call to file() will close filename and decrement nfile if (me == 0) { - if (nfile > 1) - error->one(FLERR,"Invalid use of library file() function"); + if (nfile == maxfile) { + maxfile++; + infiles = (FILE **) + memory->srealloc(infiles,maxfile*sizeof(FILE *),"input:infiles"); + } - if (infile && infile != stdin) fclose(infile); infile = fopen(filename,"r"); if (infile == NULL) { char str[128]; snprintf(str,128,"Cannot open input script %s",filename); error->one(FLERR,str); } - infiles[0] = infile; - nfile = 1; + infiles[nfile++] = infile; } + // process contents of file + file(); + + if (me == 0) { + fclose(infile); + nfile--; + infile = infiles[nfile-1]; + } } /* ---------------------------------------------------------------------- @@ -1047,7 +1056,13 @@ void Input::include() error->one(FLERR,str); } infiles[nfile++] = infile; - file(); + } + + // process contents of file + + file(); + + if (me == 0) { fclose(infile); nfile--; infile = infiles[nfile-1]; -- GitLab From f2380a24ef90945f421a90e5d482c58e0bef49b5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 24 Jun 2019 14:27:05 -0400 Subject: [PATCH 095/469] fix parallel processing input include bug --- src/input.cpp | 31 +++++++++++++++++++++++-------- 1 file changed, 23 insertions(+), 8 deletions(-) diff --git a/src/input.cpp b/src/input.cpp index 268be5b774..2f617d2cd0 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -239,8 +239,8 @@ void Input::file() } /* ---------------------------------------------------------------------- - process all input from filename - called from library interface + process all input from file at filename + mostly called from library interface ------------------------------------------------------------------------- */ void Input::file(const char *filename) @@ -250,21 +250,30 @@ void Input::file(const char *filename) // call to file() will close filename and decrement nfile if (me == 0) { - if (nfile > 1) - error->one(FLERR,"Invalid use of library file() function"); + if (nfile == maxfile) { + maxfile++; + infiles = (FILE **) + memory->srealloc(infiles,maxfile*sizeof(FILE *),"input:infiles"); + } - if (infile && infile != stdin) fclose(infile); infile = fopen(filename,"r"); if (infile == NULL) { char str[128]; snprintf(str,128,"Cannot open input script %s",filename); error->one(FLERR,str); } - infiles[0] = infile; - nfile = 1; + infiles[nfile++] = infile; } + // process contents of file + file(); + + if (me == 0) { + fclose(infile); + nfile--; + infile = infiles[nfile-1]; + } } /* ---------------------------------------------------------------------- @@ -1041,7 +1050,13 @@ void Input::include() error->one(FLERR,str); } infiles[nfile++] = infile; - file(); + } + + // process contents of file + + file(); + + if (me == 0) { fclose(infile); nfile--; infile = infiles[nfile-1]; -- GitLab From 0ddcc023a5074e10b7e5974011e15542a2c5b105 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Mon, 24 Jun 2019 13:54:55 -0500 Subject: [PATCH 096/469] Improvements and additions to kim_commands doc --- doc/src/kim_commands.txt | 54 +++++++++++++++++++++++++++++++++------- 1 file changed, 45 insertions(+), 9 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index f039202e4e..68306ad6b7 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -170,10 +170,30 @@ SMs can never adjust their units.) If a match is possible, the LAMMPS {user_units}. If the match fails, the simulation is terminated with an error. -If unit conversion mode {is} active, then the LAMMPS "units"_units.html -command is called to set the units to the IM's required or preferred units. -Conversion factors between the IM's units and the {user_units} are -defined for all "physical quantities"_units.html (mass, distance, etc.). +Here is an example of a LAMMPS script to compute the cohesive energy +of a face-centered cubic (fcc) lattice for the Ercolessi and Adams (1994) +potential for Al: + +kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal +boundary p p p +lattice fcc 4.032 +region simbox block 0 1 0 1 0 1 units lattice +create_box 1 simbox +create_atoms 1 box +mass 1 26.981539 +kim_interactions Al +run 0 +variable Ec equal (pe/count(all))/$\{_u_energy\} +print "Cohesive Energy = $\{EcJ\} eV" +:pre + +The above script will end with an error in the {kim_init} line if the +IM is changed to another potential for Al that does not work with {metal} +units. To address this {kim_init} offers the {unit_conversion_mode}. +If unit conversion mode {is} active, then {kim_init} calls the LAMMPS +"units"_units.html command to set the units to the IM's required or +preferred units. Conversion factors between the IM's units and the {user_units} +are defined for all "physical quantities"_units.html (mass, distance, etc.). (Note that converting to or from the "lj" unit style is not supported.) These factors are stored as "internal style variables"_variable.html with standard names: @@ -197,9 +217,11 @@ If desired, the input script can be designed to work with these conversion factors so that the script will work without change with any OpenKIM IM. (This approach is used in the "OpenKIM Testing Framework"_https://openkim.org/getting-started/kim-tests/.) -For example, the following simple script constructs an fcc lattice with -a lattice parameter defined in meters, computes the total energy, -and prints the cohesive energy in Joules regardless of the units of the IM. +For example, the script given above for the cohesive energy of fcc Al +can be rewritten to work with any IM regardless of units. The following +script constructs an fcc lattice with a lattice parameter defined in +meters, computes the total energy, and prints the cohesive energy in +Joules regardless of the units of the IM. kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 si unit_conversion_mode boundary p p p @@ -339,18 +361,23 @@ lattice fcc $\{a0\} The {kim_query} command retrieves from "OpenKIM"_https://openkim.org the equilibrium lattice constant predicted by the Ercolessi and Adams (1994) -potential for the face-centered cubic (fcc) structure and places it in +potential for the fcc structure and places it in variable {a0}. This variable is then used on the next line to set up the crystal. By using {kim_query}, the user is saved the trouble and possible error of tracking this value down, or of having to perform an energy minimization to find the equilibrium lattice constant. +Note that in {unit_conversion_mode} the results obtained from a +{kim_query} would need to be converted to the appropriate units system. +For example, in the above script, the lattice command would need to be +changed to: "lattice fcc $\{a0\}*$\{_u_distance\}". + [Define a crystal at finite temperature accounting for thermal expansion] kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal boundary p p p kim_query a0 get_lattice_constant_fcc units=\["angstrom"\] -kim_query alpha get_linear_thermal_expansion_fcc +kim_query alpha get_linear_thermal_expansion_fcc units=\{"1/K"\} variable DeltaT equal 300 lattice fcc $\{a0\}*$\{alpha\}*$\{DeltaT\} ... :pre @@ -375,6 +402,15 @@ The defect formation energy {Eform} is computed by subtracting from {Etot} the ideal fcc cohesive energy of the atoms in the system obtained from "OpenKIM"_https://openkim.org for the Ercolessi and Adams (1994) potential. +NOTE: {kim_query} commands return results archived in +"OpenKIM"_https://openkim.org. These results are obtained +using programs for computing material properties +(KIM Tests and KIM Test Drivers) that were contributed to OpenKIM. +In order to give credit to Test developers, the number of times results +from these programs are queried is tracked. No other information about +the nature of the query or its source is recorded. + + Citation of OpenKIM IMs :h4 When publishing results obtained using OpenKIM IMs researchers are requested -- GitLab From 1047d8f80e10a8c267eb4b022720da8f61f844c0 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Mon, 24 Jun 2019 14:32:40 -0500 Subject: [PATCH 097/469] Change of terminology to "KIM Portable Model" and streamlining --- doc/src/kim_commands.txt | 55 ++++++++++++++++++++-------------------- 1 file changed, 28 insertions(+), 27 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index d42b509449..9be4a79db5 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -44,8 +44,8 @@ so that they can be used by LAMMPS scripts. These commands do not implement any computations directly, but rather generate LAMMPS input commands based on the information retrieved from the OpenKIM repository to initialize and activate OpenKIM IMs and query their predictions for use in the LAMMPS script. -All LAMMPS input commands executed by {kim_commands} are echoed to the -LAMMPS log file. +All LAMMPS input commands generated and executed by {kim_commands} are +echoed to the LAMMPS log file. Benefits of Using OpenKIM IMs :h4 @@ -65,7 +65,7 @@ OpenKIM is a member organization of "DataCite"_https://datacite.org/ and issues Convenience :h5 IMs in OpenKIM are distributed in binary form along with LAMMPS and can be used in a LAMMPS input script simply by providing their KIM ID in the {kim_init} command documented on this page. -The {kim_query} web query tool provides the ability to use the predictions of IMs for supported material properties (computed via "KIM Tests"https://openkim.org/getting-started/kim-tests/) as part of a LAMMPS input script setup and analysis. +The {kim_query} web query tool provides the ability to use the predictions of IMs for supported material properties (computed via "KIM Tests"_https://openkim.org/getting-started/kim-tests/) as part of a LAMMPS input script setup and analysis. Support is provided for unit conversion between the "unit style"_units.html used in the LAMMPS input script and the units required by the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the likelihood of errors due to incompatible units. :ul :link(IM_types) @@ -73,8 +73,8 @@ Types of IMs in OpenKIM :h4 There are two types of IMs archived in OpenKIM: -The first type is called a {KIM Model}. A KIM Model is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/). A KIM Model will work seamlessly with any simulation code that supports the KIM API (including LAMMPS; see "complete list of supported code"_https://openkim.org/projects-using-kim/). -The second type is called a {KIM Simulator Model} (SM). In this case, the IM is implemented natively within the simulation code ({simulator}), i.e. LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol +The first type is called a {KIM Portable Model} (PM). A KIM PM is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/) Portable Model Interface (PMI) standard. A KIM PM will work seamlessly with any simulation code that supports the KIM API/PMI standard (including LAMMPS; see "complete list of supported codes"_https://openkim.org/projects-using-kim/). +The second type is called a {KIM Simulator Model} (SM). A KIM SM is an IM that is implemented natively within a simulation code ({simulator}) that supports the KIM API/SMI (Simulator Model Interface); in this case LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol With these two IM types, OpenKIM can archive and test almost all IMs that can be used by LAMMPS. (It is easy to contribute new IMs to OpenKIM, see @@ -85,7 +85,7 @@ OpenKIM IMs are uniquely identified by a a human-readable prefix identifying the type of IM, authors, publication year, and supported species, separated by two underscores from the KIM ID itself, which begins with an IM code -({MO} for a KIM Model, and {SM} for a KIM Simulator Model) +({MO} for a KIM Portable Model, and {SM} for a KIM Simulator Model) followed by a unique 12-digit code and a 3-digit version identifier. By convention SM prefixes begin with {Sim_} to readily identify them. @@ -97,7 +97,7 @@ providing all the information on the IM including a title, description, authorship and citation information, test and verification check results, visualizations of results, a wiki with documentation and user comments, and access to raw files, and other information. -This is referred to as the "Model Page" or "SM Page". +This is referred to as the "PM Page" or "SM Page". The URL for such a page is constructed from the "extended KIM ID"_https://openkim.org/about-kim-ids/ of the IM: @@ -110,7 +110,7 @@ listed above the Model Page is located at: "https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005"_https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005 :pre -See the "current list of KIM Models and SMs archived in OpenKIM"_https://openkim.org/browse/models/by-species. +See the "current list of KIM PMs and SMs archived in OpenKIM"_https://openkim.org/browse/models/by-species. This list is sorted by species and can be filtered to display only IMs for certain species combinations. @@ -124,7 +124,7 @@ IM and perform necessary initialization ({kim_init}), and the second to set up the IM for use by executing any necessary LAMMPS commands ({kim_interactions}). Both are required. -See the {examples/kim} directory for example input scripts that use KIM Models +See the {examples/kim} directory for example input scripts that use KIM PMs and KIM SMs. OpenKIM IM Initialization ({kim_init}) :h5 @@ -146,17 +146,17 @@ in the input script. (Any dimensioned numerical values in the input script and values read in from files are expected to be in the {user_units} system.) -The selected IM can be either a "KIM Model or a KIM SM"_#IM_types. +The selected IM can be either a "KIM PM or a KIM SM"_#IM_types. For a KIM SM, the {kim_init} command verifies that the SM is designed to work with LAMMPS (and not another simulation code). -In addition, the version strings for the LAMMPS version used for defining +In addition, the LAMMPS version used for defining the SM and the LAMMPS version being currently run are -printed, to help diagnose any incompatible changes to input script or +printed to help diagnose any incompatible changes to input script or command syntax between the two LAMMPS versions. Based on the selected model {kim_init} may modify the "atom_style"_atom_style.html. -Some SMs have requirements for this variable. If this is the case, then +Some SMs have requirements for this setting. If this is the case, then {atom_style} will be set to the required style. Otherwise, the value is left unchanged (which in the absence of an {atom_style} command in the input script is the "default atom_style value"_atom_style.html). @@ -166,7 +166,7 @@ on whether or not {unit conversion mode} is activated as indicated by the optional {unitarg} argument. If unit conversion mode is [not] active, then {user_units} must either match the required units of the IM or the IM must be able -to adjust its units to match. (The latter is only possible with some KIM Models; +to adjust its units to match. (The latter is only possible with some KIM PMs; SMs can never adjust their units.) If a match is possible, the LAMMPS "units"_units.html command is called to set the units to {user_units}. If the match fails, the simulation is terminated with @@ -198,7 +198,7 @@ preferred units. Conversion factors between the IM's units and the {user_units} are defined for all "physical quantities"_units.html (mass, distance, etc.). (Note that converting to or from the "lj" unit style is not supported.) These factors are stored as "internal style variables"_variable.html with -standard names: +the following standard names: _u_mass _u_distance @@ -241,7 +241,7 @@ Note the multiplication by $\{_u_distance\} and $\{_u_mass\} to convert from SI units (specified in the {kim_init} command) to whatever units the IM uses (metal in this case), and the division by $\{_u_energy\} to convert from the IM's energy units to SI units (Joule). This script -will work correctly for any IM for Al (KIM Model or SM) selected by the +will work correctly for any IM for Al (KIM PM or SM) selected by the {kim_init} command. Care must be taken to apply unit conversion to dimensional variables read in @@ -283,10 +283,10 @@ kim_interactions Si Si Si C The {kim_interactions} command performs all the necessary steps to set up the OpenKIM IM selected in the {kim_init} command. The specific actions depend -on whether the IM is a KIM Model or a KIM SM. For a KIM Model, +on whether the IM is a KIM PM or a KIM SM. For a KIM PM, a "pair_style kim"_pair_kim.html command is executed followed by the appropriate {pair_coeff} command. For example, for the -Ercolessi and Adams (1994) KIM Model for Al set by the following commands: +Ercolessi and Adams (1994) KIM PM for Al set by the following commands: kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal ... @@ -302,8 +302,7 @@ pair_coeff * * Al :pre For a KIM SM, the generated input commands may be more complex and require that LAMMPS is built with the required packages included for the type of potential being used. The set of commands to be executed -is defined in the SM specification file, which is part of the SM package -on "OpenKIM"_https://openkim.org. +is defined in the SM specification file, which is part of the SM package. For example, for the Strachan et al. (2003) ReaxFF SM set by the following commands: @@ -416,14 +415,16 @@ the nature of the query or its source is recorded. Citation of OpenKIM IMs :h4 When publishing results obtained using OpenKIM IMs researchers are requested -to cite the OpenKIM project "(Tadmor)"_#kim-mainpaper and KIM API -"(Elliott)"_#kim-api as well as the specific IM codes used in the simulations. +to cite the OpenKIM project "(Tadmor)"_#kim-mainpaper, KIM API +"(Elliott)"_#kim-api, and the specific IM codes used in the simulations, +in addition to the relevant scientific references for the IM. The citation format for an IM is displayed on its page on -"OpenKIM"_https://openkim.org along with the corresponding BibTex file. +"OpenKIM"_https://openkim.org along with the corresponding BibTex file, +and is automatically added to the LAMMPS {log.cite} file. -Citing the codes used in the simulation gives credit -to the researchers who developed them and enables open source efforts like -OpenKIM to function. +Citing the IM software (KIM infrastucture and specific PM or SM codes) +used in the simulation gives credit to the researchers who developed them +and enables open source efforts like OpenKIM to function. [Restrictions:] @@ -442,7 +443,7 @@ must be installed. [Related commands:] -"pair_style kim"_pair_kim.html, "units"_units.html +"pair_style kim"_pair_kim.html :line -- GitLab From b6535367501e4f9c3e85c32ade7cea6ef6cd6f9d Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Mon, 24 Jun 2019 14:38:44 -0500 Subject: [PATCH 098/469] Switched pair_style kim doc to "KIM Portable Model" terminology --- doc/src/pair_kim.txt | 23 ++++++++++++----------- 1 file changed, 12 insertions(+), 11 deletions(-) diff --git a/doc/src/pair_kim.txt b/doc/src/pair_kim.txt index 86d13808b0..41593675ba 100644 --- a/doc/src/pair_kim.txt +++ b/doc/src/pair_kim.txt @@ -27,11 +27,12 @@ potentials to enable their use in LAMMPS scripts. The preferred interface for using interatomic models archived in OpenKIM is the "kim_commands interface"_kim_commands.html. That -interface supports both "KIM Models" that conform to the KIM API -and can be used by any KIM-compliant simulation code, and +interface supports both "KIM Portable Models" (PMs) that conform to the +KIM API Portable Model Interface (PMI) and can be used by any +simulation code that conforms to the KIM API/PMI, and "KIM Simulator Models" that are natively implemented within a single simulation code (like LAMMPS) and can only be used with it. -The {pair_style kim} command is limited to KIM Models. It is +The {pair_style kim} command is limited to KIM PMs. It is used by the "kim_commands interface"_kim_commands.html as needed. NOTE: Since {pair_style kim} is called by {kim_interactions} as needed, @@ -39,23 +40,23 @@ is not recommended to be directly used in input scripts. :line -The argument {model} is the name of the KIM model for a specific -potential as KIM defines it. For potentials archived in OpenKIM +The argument {model} is the name of the KIM PM. +For potentials archived in OpenKIM this is the extended KIM ID (see "kim_commands"_kim_commands.html -for details). LAMMPS can invoke any KIM Model, however there can -be incompatibilities (for example unit matching issues). +for details). LAMMPS can invoke any KIM PM, however there can +be incompatibilities (for example due to unit matching issues). In the event of an incompatibility, the code will terminate with an error message. Check both the LAMMPS and KIM log files for details. Only a single {pair_coeff} command is used with the {kim} style, which specifies the mapping of LAMMPS atom types to the species supported by -the KIM Model. This is done by specifying {N} additional arguments +the KIM PM. This is done by specifying {N} additional arguments after the * * in the {pair_coeff} command, where {N} is the number of LAMMPS atom types: N element names = mapping of KIM elements to atom types :ul -For example, consider a KIM Model that supports Si and C species. +For example, consider a KIM PM that supports Si and C species. If the LAMMPS simulation has four atom types, where the first three are Si, and the fourth is C, the following {pair_coeff} command would be used: @@ -63,14 +64,14 @@ pair_coeff * * Si Si Si C :pre The first two arguments must be * * so as to span all LAMMPS atom types. The first three Si arguments map LAMMPS atom types 1, 2, and 3 to Si as -defined within KIM Model. The final C argument maps LAMMPS atom type 4 to C. +defined within KIM PM. The final C argument maps LAMMPS atom type 4 to C. :line In addition to the usual LAMMPS error messages, the KIM library itself may generate errors, which should be printed to the screen. In this case it is also useful to check the {kim.log} file for additional error -information. The file kim.log should be generated in the same +information. The file {kim.log} should be generated in the same directory where LAMMPS is running. To download, build, and install the KIM library on your system, see -- GitLab From 4284a4fac41a36d0d897ff9a3f079719f57973a0 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Mon, 24 Jun 2019 14:51:35 -0500 Subject: [PATCH 099/469] Changed me to me_si and fixed some typos in comments --- src/KIM/kim_units.cpp | 18 +++++++++--------- 1 file changed, 9 insertions(+), 9 deletions(-) diff --git a/src/KIM/kim_units.cpp b/src/KIM/kim_units.cpp index fe90d58e9e..40f4917601 100644 --- a/src/KIM/kim_units.cpp +++ b/src/KIM/kim_units.cpp @@ -76,9 +76,9 @@ double const Nav = 6.022140857e23; // [unitless] Avogadro's number // (NIST value) // double const Nav = 6.02214076e23; // [unitless] Avogadro's number // (official value May 2019) -double const me = 9.10938356e-31; // [kg] electron rest mass +double const me_si = 9.10938356e-31; // [kg] electron rest mass // (NIST value) -// double me = 9.10938291e-31; // [kg] electron rest mass +// double me_si = 9.10938291e-31; // [kg] electron rest mass double const e_si = 1.6021766208e-19; // [C] elementary charge // (charge of an electron/proton) // (NIST value) @@ -114,8 +114,9 @@ double const attogram_si = 1e-21; // [kg[ attogram double const atu_si = 2.418884326509e-17; // [s] atomic time unit // ( = hbar/E_h where E_h is the // Hartree energy) (NIST value) -double const atu_electron_si = atu_si*sqrt(amu_si/me); // [s] atomic time unit - // used in electron system (see https://sourceforge.net/p/lammps/mailman/lammps-users/thread/BCA2BDB2-BA03-4280-896F-1E6120EF47B2%40caltech.edu/) +double const atu_electron_si = atu_si*sqrt(amu_si/me_si); + // [s] atomic time unit + // used in electron system (see https://sourceforge.net/p/lammps/mailman/lammps-users/thread/BCA2BDB2-BA03-4280-896F-1E6120EF47B2%40caltech.edu/) double const microsecond_si = 1e-6; // [s] microsecond double const nanosecond_si = 1e-9; // [s] nanosecond double const picosecond_si = 1e-12; // [s] picosecond @@ -130,13 +131,12 @@ double const amu_per_bohrcu_si = amu_si/pow(bohr_si,3); // [kg/m^3] amu/bohr^3 double const picogram_per_micrometercu_si = picogram_si/pow(micrometer_si,3); // [kg/m^3] picogram/micrometer^3 double const attogram_per_nanometercu_si = - attogram_si/pow(nanometer_si,3); // [kg/m^3] attogram/ - // nanomaterial^3 + attogram_si/pow(nanometer_si,3); // [kg/m^3] attogram/nanometer^3 /*---------------------- Energy/torque units ------------------------ */ -double const kcal_si = 4184.0; // [J] kilocalroie (heat energy +double const kcal_si = 4184.0; // [J] kilocalorie (heat energy // involved in warming up one // kilogram of water by one // degree Kelvin) @@ -155,8 +155,8 @@ double const erg_si = 1e-7; // [J] erg double const dyne_centimeter_si = 1e-7; // [J[ dyne*centimeter double const picogram_micrometersq_per_microsecondsq_si = picogram_si*pow(micrometer_si,2)/pow(microsecond_si,2); - // [J] pigogram*micrometer^2/ - // micorsecond^2 + // [J] picogram*micrometer^2/ + // microsecond^2 double const attogram_nanometersq_per_nanosecondsq_si = attogram_si*pow(nanometer_si,2)/pow(nanosecond_si,2); // [J] attogram*nanometer^2/ -- GitLab From 86d878a7eb4b73432eab53538a2c114571be63e0 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Mon, 24 Jun 2019 15:26:41 -0500 Subject: [PATCH 100/469] Updated language on availability of ADP potentials in OpenKIM --- doc/src/pair_adp.txt | 7 +++---- 1 file changed, 3 insertions(+), 4 deletions(-) diff --git a/doc/src/pair_adp.txt b/doc/src/pair_adp.txt index d5b07e8431..de6717a6c3 100644 --- a/doc/src/pair_adp.txt +++ b/doc/src/pair_adp.txt @@ -49,12 +49,11 @@ Note that ADP potentials obtained from NIST must be converted into the extended DYNAMO {setfl} format discussed below. :l -The OpenKIM Project at https://openkim.org provides ADP potentials -as Simulator Models that can be used directly in LAMMPS with -the "kim_commands interface"_kim_commands.html. +The OpenKIM Project at https://openkim.org/browse/models/by-type provides +ADP potentials that can be used directly in LAMMPS with the "kim_commands +interface"_kim_commands.html. :l - :line Only a single pair_coeff command is used with the {adp} style which -- GitLab From 6a6d08e18ef9f47e679dd79b841bdc1faf05d849 Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Tue, 25 Jun 2019 12:01:29 +0200 Subject: [PATCH 101/469] Better compute_pressure hybrid and doc --- doc/src/compute_pressure.txt | 8 ++++-- src/compute_pressure.cpp | 50 ++++++++++++++++++++++++++---------- 2 files changed, 42 insertions(+), 16 deletions(-) diff --git a/doc/src/compute_pressure.txt b/doc/src/compute_pressure.txt index bd6e38e392..fd9bfb7aff 100644 --- a/doc/src/compute_pressure.txt +++ b/doc/src/compute_pressure.txt @@ -16,12 +16,13 @@ ID, group-ID are documented in "compute"_compute.html command pressure = style name of this compute command temp-ID = ID of compute that calculates temperature, can be NULL if not needed zero or more keywords may be appended -keyword = {ke} or {pair} or {bond} or {angle} or {dihedral} or {improper} or {kspace} or {fix} or {virial} :ul +keyword = {ke} or {pair} or {bond} or {angle} or {dihedral} or {improper} or {kspace} or {fix} or {virial} or {hybridpair} :ul [Examples:] compute 1 all pressure thermo_temp -compute 1 all pressure NULL pair bond :pre +compute 1 all pressure NULL pair bond +compute 1 all pressure NULL hybridpair lj/cut :pre [Description:] @@ -67,6 +68,9 @@ extra keywords are listed, then only those components are summed to compute temperature or ke and/or the virial. The {virial} keyword means include all terms except the kinetic energy {ke}. +The {hybridpair} keyword means to only include contribution +from a subpair in a {hybrid} or {hybrid/overlay} pair style. + Details of how LAMMPS computes the virial efficiently for the entire system, including for many-body potentials and accounting for the effects of periodic boundary conditions are discussed in diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index 8381e04fa8..96f577219d 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -81,8 +81,37 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : int iarg = 4; while (iarg < narg) { if (strcmp(arg[iarg],"ke") == 0) keflag = 1; - else if (strcmp(arg[iarg],"hybridpair") == 0) - hybridpairflag = force->inumeric(FLERR, arg[++iarg]); + else if (strcmp(arg[iarg],"hybridpair") == 0) { + int n = strlen(arg[++iarg]) + 1; + if (lmp->suffix) n += strlen(lmp->suffix) + 1; + pstyle = new char[n]; + strcpy(pstyle,arg[iarg++]); + + nsub = 0; + + if (narg > iarg) { + if (isdigit(arg[iarg][0])) { + nsub = force->inumeric(FLERR,arg[iarg]); + ++iarg; + if (nsub <= 0) + error->all(FLERR,"Illegal compute pressure command"); + } + } + + // check if pair style with and without suffix exists + + hybridpair = (Pair *) force->pair_match(pstyle,1,nsub); + if (!hybridpair && lmp->suffix) { + strcat(pstyle,"/"); + strcat(pstyle,lmp->suffix); + hybridpair = (Pair *) force->pair_match(pstyle,1,nsub); + } + + if (!hybridpair) + error->all(FLERR,"Unrecognized pair style in compute pressure command"); + + hybridpairflag = 1; + } else if (strcmp(arg[iarg],"pair") == 0) pairflag = 1; else if (strcmp(arg[iarg],"bond") == 0) bondflag = 1; else if (strcmp(arg[iarg],"angle") == 0) angleflag = 1; @@ -144,12 +173,7 @@ void ComputePressure::init() nvirial = 0; vptr = NULL; - if (hybridpairflag > 0 && force->pair) { - if (strstr(force->pair_style, "hybrid")) { - PairHybrid *ph = (PairHybrid *) force->pair; - if (hybridpairflag <= ph->nstyles) nvirial++; - } - } + if (hybridpairflag && force->pair) nvirial++; if (pairflag && force->pair) nvirial++; if (bondflag && atom->molecular && force->bond) nvirial++; if (angleflag && atom->molecular && force->angle) nvirial++; @@ -162,12 +186,10 @@ void ComputePressure::init() if (nvirial) { vptr = new double*[nvirial]; nvirial = 0; - if (hybridpairflag > 0 && force->pair) { - if (strstr(force->pair_style, "hybrid")) { - PairHybrid *ph = (PairHybrid *) force->pair; - if (hybridpairflag <= ph->nstyles) - vptr[nvirial++] = ph->styles[hybridpairflag-1]->virial; - } + if (hybridpairflag && force->pair) { + PairHybrid *ph = (PairHybrid *) force->pair; + ph->no_virial_fdotr_compute = 1; + vptr[nvirial++] = hybridpair->virial; } if (pairflag && force->pair) vptr[nvirial++] = force->pair->virial; if (bondflag && force->bond) vptr[nvirial++] = force->bond->virial; -- GitLab From 61ddc98a5a9ef9d53dc7f3227262b755c20fb7f7 Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Tue, 25 Jun 2019 13:30:41 +0200 Subject: [PATCH 102/469] Missing compute_pressure.h --- src/compute_pressure.h | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/src/compute_pressure.h b/src/compute_pressure.h index 3259377bd8..31983e8e2c 100644 --- a/src/compute_pressure.h +++ b/src/compute_pressure.h @@ -42,10 +42,15 @@ class ComputePressure : public Compute { char *id_temp; double virial[6]; int hybridpairflag; + class Pair *hybridpair; int keflag,pairflag,bondflag,angleflag,dihedralflag,improperflag; int fixflag,kspaceflag; void virial_compute(int, int); + + private: + int nsub; + char *pstyle; }; } -- GitLab From 2fd924562b94c9fb4d1b6a933211416e07b3b869 Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Tue, 25 Jun 2019 15:15:30 +0200 Subject: [PATCH 103/469] Spell correction --- doc/src/compute_pressure.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_pressure.txt b/doc/src/compute_pressure.txt index fd9bfb7aff..070376075e 100644 --- a/doc/src/compute_pressure.txt +++ b/doc/src/compute_pressure.txt @@ -69,7 +69,7 @@ compute temperature or ke and/or the virial. The {virial} keyword means include all terms except the kinetic energy {ke}. The {hybridpair} keyword means to only include contribution -from a subpair in a {hybrid} or {hybrid/overlay} pair style. +from a sub-style in a {hybrid} or {hybrid/overlay} pair style. Details of how LAMMPS computes the virial efficiently for the entire system, including for many-body potentials and accounting for the -- GitLab From e08146c31fa887300dbba54ee01e3f69782440e5 Mon Sep 17 00:00:00 2001 From: "Dan S. Bolintineanu" Date: Tue, 25 Jun 2019 12:06:18 -0600 Subject: [PATCH 104/469] Allow twisting torque to be used without rolling torque in pair granular --- src/GRANULAR/pair_granular.cpp | 39 +++++++++++++++++----------------- 1 file changed, 20 insertions(+), 19 deletions(-) diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 913f6f8b59..77b1981786 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -475,16 +475,12 @@ void PairGranular::compute(int eflag, int vflag) fs3 = -Ft*vtr3; } - //**************************************** - // rolling resistance - //**************************************** - - if (roll_model[itype][jtype] != ROLL_NONE) { + if (roll_model[itype][jtype] != ROLL_NONE || + twist_model[itype][jtype] != TWIST_NONE){ relrot1 = omega[i][0] - omega[j][0]; relrot2 = omega[i][1] - omega[j][1]; relrot3 = omega[i][2] - omega[j][2]; - - // rolling velocity, + // rolling velocity, // see eq. 31 of Wang et al, Particuology v 23, p 49 (2015) // this is different from the Marshall papers, // which use the Bagi/Kuhn formulation @@ -492,7 +488,12 @@ void PairGranular::compute(int eflag, int vflag) // - 0.5*((radj-radi)/radsum)*vtr1; // - 0.5*((radj-radi)/radsum)*vtr2; // - 0.5*((radj-radi)/radsum)*vtr3; + } + //**************************************** + // rolling resistance + //**************************************** + if (roll_model[itype][jtype] != ROLL_NONE) { vrl1 = Reff*(relrot2*nz - relrot3*ny); vrl2 = Reff*(relrot3*nx - relrot1*nz); vrl3 = Reff*(relrot1*ny - relrot2*nx); @@ -1231,10 +1232,10 @@ void PairGranular::write_restart(FILE *fp) fwrite(&tangential_model[i][j],sizeof(int),1,fp); fwrite(&roll_model[i][j],sizeof(int),1,fp); fwrite(&twist_model[i][j],sizeof(int),1,fp); - fwrite(&normal_coeffs[i][j],sizeof(double),4,fp); - fwrite(&tangential_coeffs[i][j],sizeof(double),3,fp); - fwrite(&roll_coeffs[i][j],sizeof(double),3,fp); - fwrite(&twist_coeffs[i][j],sizeof(double),3,fp); + fwrite(normal_coeffs[i][j],sizeof(double),4,fp); + fwrite(tangential_coeffs[i][j],sizeof(double),3,fp); + fwrite(roll_coeffs[i][j],sizeof(double),3,fp); + fwrite(twist_coeffs[i][j],sizeof(double),3,fp); fwrite(&cutoff_type[i][j],sizeof(double),1,fp); } } @@ -1261,10 +1262,10 @@ void PairGranular::read_restart(FILE *fp) fread(&tangential_model[i][j],sizeof(int),1,fp); fread(&roll_model[i][j],sizeof(int),1,fp); fread(&twist_model[i][j],sizeof(int),1,fp); - fread(&normal_coeffs[i][j],sizeof(double),4,fp); - fread(&tangential_coeffs[i][j],sizeof(double),3,fp); - fread(&roll_coeffs[i][j],sizeof(double),3,fp); - fread(&twist_coeffs[i][j],sizeof(double),3,fp); + fread(normal_coeffs[i][j],sizeof(double),4,fp); + fread(tangential_coeffs[i][j],sizeof(double),3,fp); + fread(roll_coeffs[i][j],sizeof(double),3,fp); + fread(twist_coeffs[i][j],sizeof(double),3,fp); fread(&cutoff_type[i][j],sizeof(double),1,fp); } MPI_Bcast(&normal_model[i][j],1,MPI_INT,0,world); @@ -1272,10 +1273,10 @@ void PairGranular::read_restart(FILE *fp) MPI_Bcast(&tangential_model[i][j],1,MPI_INT,0,world); MPI_Bcast(&roll_model[i][j],1,MPI_INT,0,world); MPI_Bcast(&twist_model[i][j],1,MPI_INT,0,world); - MPI_Bcast(&normal_coeffs[i][j],4,MPI_DOUBLE,0,world); - MPI_Bcast(&tangential_coeffs[i][j],3,MPI_DOUBLE,0,world); - MPI_Bcast(&roll_coeffs[i][j],3,MPI_DOUBLE,0,world); - MPI_Bcast(&twist_coeffs[i][j],3,MPI_DOUBLE,0,world); + MPI_Bcast(normal_coeffs[i][j],4,MPI_DOUBLE,0,world); + MPI_Bcast(tangential_coeffs[i][j],3,MPI_DOUBLE,0,world); + MPI_Bcast(roll_coeffs[i][j],3,MPI_DOUBLE,0,world); + MPI_Bcast(twist_coeffs[i][j],3,MPI_DOUBLE,0,world); MPI_Bcast(&cutoff_type[i][j],1,MPI_DOUBLE,0,world); } } -- GitLab From f6319146b04b04e4887fdfe44a47ebc45544d97a Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Tue, 25 Jun 2019 15:03:24 -0500 Subject: [PATCH 105/469] Update kim_query to new interface --- src/KIM/kim_query.cpp | 24 ++++++++++++++++++++---- src/KIM/kim_query.h | 3 +-- 2 files changed, 21 insertions(+), 6 deletions(-) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index e4818abc94..2bb404ec26 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -51,7 +51,7 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Designed for use with the kim-api-2.0.2 (and newer) package + Designed for use with the kim-api-2.1.0 (and newer) package ------------------------------------------------------------------------- */ #include @@ -61,7 +61,9 @@ #include "comm.h" #include "error.h" #include "input.h" +#include "modify.h" #include "variable.h" +#include "fix_store_kim.h" #if defined(LMP_KIM_CURL) #include @@ -77,7 +79,7 @@ struct WriteBuf { size_t sizeleft; }; -static char *do_query(char *, int, char **, int, MPI_Comm); +static char *do_query(char *, char *, int, char **, int, MPI_Comm); static size_t write_callback(void *, size_t, size_t, void *); #endif @@ -90,12 +92,23 @@ void KimQuery::command(int narg, char **arg) if (narg < 2) error->all(FLERR,"Illegal kim_query command"); + // check if we had a kim_init command by finding fix STORE/KIM + // retrieve model name. + char * model_name; + + int ifix = modify->find_fix("KIM_MODEL_STORE"); + if (ifix >= 0) { + FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; + model_name = (char *)fix_store->getptr("model_name"); + } else error->all(FLERR,"Must use 'kim_init' before 'kim_query'"); + + varname = arg[0]; function = arg[1]; #if defined(LMP_KIM_CURL) - value = do_query(function, narg-2, arg+2, comm->me, world); + value = do_query(function, model_name, narg-2, arg+2, comm->me, world); // check for valid result // on error the content of "value" is a '\0' byte @@ -147,7 +160,8 @@ size_t write_callback(void *data, size_t size, size_t nmemb, void *userp) return 0; // done } -char *do_query(char *qfunction, int narg, char **arg, int rank, MPI_Comm comm) +char *do_query(char *qfunction, char * model_name, int narg, char **arg, + int rank, MPI_Comm comm) { char value[512], *retval; @@ -173,6 +187,8 @@ char *do_query(char *qfunction, int narg, char **arg, int rank, MPI_Comm comm) url += qfunction; std::string query(arg[0]); + query += "&model="; + query += model_name; for (int i=1; i < narg; ++i) { query += '&'; query += arg[i]; diff --git a/src/KIM/kim_query.h b/src/KIM/kim_query.h index 3644e4519b..b5433def79 100644 --- a/src/KIM/kim_query.h +++ b/src/KIM/kim_query.h @@ -51,7 +51,7 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Designed for use with the kim-api-2.0.2 (and newer) package + Designed for use with the kim-api-2.1.0 (and newer) package ------------------------------------------------------------------------- */ #ifdef COMMAND_CLASS @@ -71,7 +71,6 @@ class KimQuery : protected Pointers { public: KimQuery(class LAMMPS *lmp) : Pointers(lmp) {}; void command(int, char **); - }; } -- GitLab From f1dfcaf514948935724df4b0b754adecfca3cf04 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Tue, 25 Jun 2019 14:47:21 -0600 Subject: [PATCH 106/469] WIP --- src/KOKKOS/pair_snap_kokkos.h | 25 +- src/KOKKOS/pair_snap_kokkos_impl.h | 379 ++++--- src/KOKKOS/sna_kokkos.h | 51 +- src/KOKKOS/sna_kokkos_impl.h | 1465 +++++++++++++++++----------- 4 files changed, 1184 insertions(+), 736 deletions(-) diff --git a/src/KOKKOS/pair_snap_kokkos.h b/src/KOKKOS/pair_snap_kokkos.h index b2019879ed..8be0bf9afb 100644 --- a/src/KOKKOS/pair_snap_kokkos.h +++ b/src/KOKKOS/pair_snap_kokkos.h @@ -31,7 +31,10 @@ PairStyle(snap/kk/host,PairSNAPKokkos) namespace LAMMPS_NS { template -struct TagPairSNAP{}; +struct TagPairSNAPCompute{}; + +struct TagPairSNAPBeta{}; +struct TagPairSNAPBispectrum{}; template class PairSNAPKokkos : public PairSNAP { @@ -53,11 +56,17 @@ public: template KOKKOS_INLINE_FUNCTION - void operator() (TagPairSNAP,const typename Kokkos::TeamPolicy >::member_type& team) const; + void operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team) const; template KOKKOS_INLINE_FUNCTION - void operator() (TagPairSNAP,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT&) const; + void operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT&) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPBeta,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPBispectrum,const typename Kokkos::TeamPolicy::member_type& team) const; template KOKKOS_INLINE_FUNCTION @@ -82,10 +91,14 @@ protected: SNAKokkos snaKK; // How much parallelism to use within an interaction - int vector_length; + int vector_length,team_size; + int team_scratch_size; + int thread_scratch_size; int eflag,vflag; + void compute_beta(); + void compute_bispectrum(); void allocate(); //void read_files(char *, char *); /*template @@ -117,7 +130,9 @@ inline double dist2(double* x,double* y); Kokkos::View d_radelem; // element radii Kokkos::View d_wjelem; // elements weights Kokkos::View d_coeffelem; // element bispectrum coefficients - Kokkos::View d_map; // mapping from atom types to elements + Kokkos::View d_map; // mapping from atom types to elements + Kokkos::View d_beta; // betas for all atoms in list + Kokkos::View d_bispectrum; // bispectrum components for all atoms in list typedef Kokkos::DualView tdual_fparams; tdual_fparams k_cutsq; diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index 0ec4ed0995..687c9dc7cb 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -186,31 +186,45 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) snaKK.nmax = max_neighs; - T_INT team_scratch_size = snaKK.size_team_scratch_arrays(); - T_INT thread_scratch_size = snaKK.size_thread_scratch_arrays(); + team_scratch_size = snaKK.size_team_scratch_arrays(); + thread_scratch_size = snaKK.size_thread_scratch_arrays(); //printf("Sizes: %i %i\n",team_scratch_size/1024,thread_scratch_size/1024); int team_size_max = Kokkos::TeamPolicy::team_size_max(*this); - int vector_length = 8; + vector_length = 8; #ifdef KOKKOS_ENABLE_CUDA - int team_size = 32;//max_neighs; + team_size = 32;//max_neighs; if (team_size*vector_length > team_size_max) team_size = team_size_max/vector_length; #else - int team_size = 1; + team_size = 1; #endif + if (beta_max < list->inum) { // TODO: no init + d_beta = Kokkos::View("PairSNAPKokkos:beta", + list->inum,ncoeff); + d_bispectrum = Kokkos::View("PairSNAPKokkos:bispectrum", + list->inum,ncoeff); + beta_max = list->inum; + } + + // compute dE_i/dB_i = beta_i for all i in list + + if (quadraticflag || eflag) + compute_bispectrum(); + compute_beta(); + EV_FLOAT ev; if (eflag) { if (neighflag == HALF) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); + typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); Kokkos::parallel_reduce(policy .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) ,*this,ev); } else if (neighflag == HALFTHREAD) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); + typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); Kokkos::parallel_reduce(policy .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) @@ -218,13 +232,13 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) } } else { if (neighflag == HALF) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); + typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); Kokkos::parallel_for(policy .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) ,*this); } else if (neighflag == HALFTHREAD) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); + typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); Kokkos::parallel_for(policy .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) @@ -232,11 +246,6 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) } } -//static int step =0; -//step++; -//if (step%10==0) -// printf(" %e %e %e %e %e (%e %e): %e\n",t1,t2,t3,t4,t5,t6,t7,t1+t2+t3+t4+t5); - if (need_dup) Kokkos::Experimental::contribute(f, dup_f); @@ -275,6 +284,153 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) } } +/* ---------------------------------------------------------------------- + compute beta +------------------------------------------------------------------------- */ + +template +void PairSNAPKokkos::compute_beta() +{ + // TODO: use RangePolicy instead, or thread over ncoeff? + int inum = list->inum; + typename Kokkos::TeamPolicy policy(inum,team_size,vector_length); + Kokkos::parallel_for(policy + .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) + .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) + ,*this); +} + +/* ---------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokkos::TeamPolicy::member_type& team) const { + + const int ii = team.league_rank(); + const int i = d_ilist[ii]; + const int itype = type[i]; + const int ielem = map[itype]; + Kokkos::View> + d_coeffi(d_coeffelem,ielem,Kokkos::ALL); + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + d_beta(ii,icoeff) = d_coeffi[icoeff+1]; + + if (quadraticflag) { + int k = ncoeff+1; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = d_bispectrum(ii,icoeff); + d_beta(ii,icoeff) += d_coeffi[k]*bveci; + k++; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = d_bispectrum(ii,jcoeff); + d_beta(ii,icoeff) += d_coeffi[k]*bvecj; + d_beta(ii,jcoeff) += d_coeffi[k]*bveci; + k++; + } + } + } +} + +/* ---------------------------------------------------------------------- + compute bispectrum +------------------------------------------------------------------------- */ + +template +void PairSNAPKokkos::compute_bispectrum() +{ + int inum = list->inum; + typename Kokkos::TeamPolicy policy(inum,team_size,vector_length); + Kokkos::parallel_for(policy + .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) + .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) + ,*this); +} + +/* ---------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPBispectrum,const typename Kokkos::TeamPolicy::member_type& team) const { + + const int ii = team.league_rank(); + const int i = d_ilist[ii]; + SNAKokkos my_sna(snaKK,team); + const double xtmp = x(i,0); + const double ytmp = x(i,1); + const double ztmp = x(i,2); + const int itype = type[i]; + const int ielem = d_map[itype]; + const double radi = d_radelem[ielem]; + + const int num_neighs = d_numneigh[i]; + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // wj = weights for neighbors of I within cutoff + // rcutij = cutoffs for neighbors of I within cutoff + // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi + + int ninside = 0; + Kokkos::parallel_reduce(Kokkos::TeamThreadRange(team,num_neighs), + [&] (const int jj, int& count) { + Kokkos::single(Kokkos::PerThread(team), [&] (){ + T_INT j = d_neighbors(i,jj); + const F_FLOAT dx = x(j,0) - xtmp; + const F_FLOAT dy = x(j,1) - ytmp; + const F_FLOAT dz = x(j,2) - ztmp; + + const int jtype = type(j); + const F_FLOAT rsq = dx*dx + dy*dy + dz*dz; + const int elem_j = d_map[jtype]; + + if ( rsq < rnd_cutsq(itype,jtype) ) + count++; + }); + },ninside); + + if (team.team_rank() == 0) + Kokkos::parallel_scan(Kokkos::ThreadVectorRange(team,num_neighs), + [&] (const int jj, int& offset, bool final) { + //for (int jj = 0; jj < num_neighs; jj++) { + T_INT j = d_neighbors(i,jj); + const F_FLOAT dx = x(j,0) - xtmp; + const F_FLOAT dy = x(j,1) - ytmp; + const F_FLOAT dz = x(j,2) - ztmp; + + const int jtype = type(j); + const F_FLOAT rsq = dx*dx + dy*dy + dz*dz; + const int elem_j = d_map[jtype]; + + if ( rsq < rnd_cutsq(itype,jtype) ) { + if (final) { + my_sna.rij(offset,0) = dx; + my_sna.rij(offset,1) = dy; + my_sna.rij(offset,2) = dz; + my_sna.inside[offset] = j; + my_sna.wj[offset] = d_wjelem[elem_j]; + my_sna.rcutij[offset] = (radi + d_radelem[elem_j])*rcutfac; + } + offset++; + } + }); + team.team_barrier(); + + // compute Ui, Zi, and Bi for atom I + + my_sna.compute_ui(team,ninside); + team.team_barrier(); + + my_sna.compute_zi(team); + team.team_barrier(); + + my_sna.compute_bi(team); + team.team_barrier(); + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + d_bispectrum(ii,icoeff) = my_sna.blist[icoeff]; +} + /* ---------------------------------------------------------------------- allocate all arrays ------------------------------------------------------------------------- */ @@ -354,7 +510,7 @@ void PairSNAPKokkos::coeff(int narg, char **arg) template template KOKKOS_INLINE_FUNCTION -void PairSNAPKokkos::operator() (TagPairSNAP,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT& ev) const { +void PairSNAPKokkos::operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT& ev) const { // The f array is duplicated for OpenMP, atomic for CUDA, and neither for Serial @@ -364,12 +520,12 @@ void PairSNAPKokkos::operator() (TagPairSNAP,const const int ii = team.league_rank(); const int i = d_ilist[ii]; SNAKokkos my_sna(snaKK,team); - const double x_i = x(i,0); - const double y_i = x(i,1); - const double z_i = x(i,2); - const int type_i = type[i]; - const int elem_i = d_map[type_i]; - const double radi = d_radelem[elem_i]; + const double xtmp = x(i,0); + const double ytmp = x(i,1); + const double ztmp = x(i,2); + const int itype = type[i]; + const int ielem = d_map[itype]; + const double radi = d_radelem[ielem]; const int num_neighs = d_numneigh[i]; @@ -379,41 +535,38 @@ void PairSNAPKokkos::operator() (TagPairSNAP,const // rcutij = cutoffs for neighbors of I within cutoff // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi - //Kokkos::Timer timer; int ninside = 0; Kokkos::parallel_reduce(Kokkos::TeamThreadRange(team,num_neighs), [&] (const int jj, int& count) { Kokkos::single(Kokkos::PerThread(team), [&] (){ T_INT j = d_neighbors(i,jj); - const F_FLOAT dx = x(j,0) - x_i; - const F_FLOAT dy = x(j,1) - y_i; - const F_FLOAT dz = x(j,2) - z_i; + const F_FLOAT dx = x(j,0) - xtmp; + const F_FLOAT dy = x(j,1) - ytmp; + const F_FLOAT dz = x(j,2) - ztmp; - const int type_j = type(j); + const int jtype = type(j); const F_FLOAT rsq = dx*dx + dy*dy + dz*dz; - const int elem_j = d_map[type_j]; + const int elem_j = d_map[jtype]; - if ( rsq < rnd_cutsq(type_i,type_j) ) + if ( rsq < rnd_cutsq(itype,jtype) ) count++; }); },ninside); - //t1 += timer.seconds(); timer.reset(); - if (team.team_rank() == 0) Kokkos::parallel_scan(Kokkos::ThreadVectorRange(team,num_neighs), - [&] (const int jj, int& offset, bool final){ + [&] (const int jj, int& offset, bool final) { //for (int jj = 0; jj < num_neighs; jj++) { T_INT j = d_neighbors(i,jj); - const F_FLOAT dx = x(j,0) - x_i; - const F_FLOAT dy = x(j,1) - y_i; - const F_FLOAT dz = x(j,2) - z_i; + const F_FLOAT dx = x(j,0) - xtmp; + const F_FLOAT dy = x(j,1) - ytmp; + const F_FLOAT dz = x(j,2) - ztmp; - const int type_j = type(j); + const int jtype = type(j); const F_FLOAT rsq = dx*dx + dy*dy + dz*dz; - const int elem_j = d_map[type_j]; + const int elem_j = d_map[jtype]; - if ( rsq < rnd_cutsq(type_i,type_j) ) { + if ( rsq < rnd_cutsq(itype,jtype) ) { if (final) { my_sna.rij(offset,0) = dx; my_sna.rij(offset,1) = dy; @@ -425,157 +578,85 @@ void PairSNAPKokkos::operator() (TagPairSNAP,const offset++; } }); + team.team_barrier(); - //t2 += timer.seconds(); timer.reset(); + // compute Ui, Yi for atom I - team.team_barrier(); - // compute Ui, Zi, and Bi for atom I my_sna.compute_ui(team,ninside); - //t3 += timer.seconds(); timer.reset(); team.team_barrier(); - my_sna.compute_zi(team); - //t4 += timer.seconds(); timer.reset(); - team.team_barrier(); - - if (quadraticflag) { - my_sna.compute_bi(team); - team.team_barrier(); - my_sna.copy_bi2bvec(team); - team.team_barrier(); - } // for neighbors of I within cutoff: - // compute dUi/drj and dBi/drj - // Fij = dEi/dRj = -dEi/dRi => add to Fi, subtract from Fj + // compute Fij = dEi/dRj = -dEi/dRi + // add to Fi, subtract from Fj + + my_sna.compute_yi(team,d_beta,ii); + team.team_barrier(); Kokkos::View> - d_coeffi(d_coeffelem,elem_i,Kokkos::ALL); + d_coeffi(d_coeffelem,ielem,Kokkos::ALL); Kokkos::parallel_for (Kokkos::TeamThreadRange(team,ninside), [&] (const int jj) { //for (int jj = 0; jj < ninside; jj++) { int j = my_sna.inside[jj]; - //Kokkos::Timer timer2; my_sna.compute_duidrj(team,&my_sna.rij(jj,0), my_sna.wj[jj],my_sna.rcutij[jj]); - //t6 += timer2.seconds(); timer2.reset(); - my_sna.compute_dbidrj(team); - //t7 += timer2.seconds(); timer2.reset(); - my_sna.copy_dbi2dbvec(team); Kokkos::single(Kokkos::PerThread(team), [&] (){ - F_FLOAT fij[3]; - - fij[0] = 0.0; - fij[1] = 0.0; - fij[2] = 0.0; - // linear contributions - - for (int k = 1; k <= ncoeff; k++) { - double bgb = d_coeffi[k]; - fij[0] += bgb*my_sna.dbvec(k-1,0); - fij[1] += bgb*my_sna.dbvec(k-1,1); - fij[2] += bgb*my_sna.dbvec(k-1,2); - } - - if (quadraticflag) { - - int k = ncoeff+1; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = my_sna.bvec[icoeff]; - double fack = d_coeffi[k]*bveci; - double dbvecix = my_sna.dbvec(icoeff,0); - double dbveciy = my_sna.dbvec(icoeff,1); - double dbveciz = my_sna.dbvec(icoeff,2); - fij[0] += fack*dbvecix; - fij[1] += fack*dbveciy; - fij[2] += fack*dbveciz; - k++; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double facki = d_coeffi[k]*bveci; - double fackj = d_coeffi[k]*my_sna.bvec[jcoeff]; - fij[0] += facki*my_sna.dbvec(jcoeff,0)+fackj*dbvecix; - fij[1] += facki*my_sna.dbvec(jcoeff,1)+fackj*dbveciy; - fij[2] += facki*my_sna.dbvec(jcoeff,2)+fackj*dbveciz; - k++; + F_FLOAT fij[3]; + my_sna.compute_deidrj(team,fij); + + a_f(i,0) += fij[0]; + a_f(i,1) += fij[1]; + a_f(i,2) += fij[2]; + a_f(j,0) -= fij[0]; + a_f(j,1) -= fij[1]; + a_f(j,2) -= fij[2]; + + // tally global and per-atom virial contribution + + if (EVFLAG) { + if (vflag_either) { + v_tally_xyz(ev,i,j, + fij[0],fij[1],fij[2], + -my_sna.rij(jj,0),-my_sna.rij(jj,1), + -my_sna.rij(jj,2)); } } - } - - // Hard-coded ZBL potential - //const double dx = my_sna.rij(jj,0); - //const double dy = my_sna.rij(jj,1); - //const double dz = my_sna.rij(jj,2); - //const double fdivr = -1.5e6/pow(dx*dx + dy*dy + dz*dz,7.0); - //fij[0] += dx*fdivr; - //fij[1] += dy*fdivr; - //fij[2] += dz*fdivr; - - //OK - //printf("%lf %lf %lf %lf %lf %lf %lf %lf %lf SNAP-COMPARE: FIJ\n" - // ,x(i,0),x(i,1),x(i,2),x(j,0),x(j,1),x(j,2),fij[0],fij[1],fij[2] ); - a_f(i,0) += fij[0]; - a_f(i,1) += fij[1]; - a_f(i,2) += fij[2]; - a_f(j,0) -= fij[0]; - a_f(j,1) -= fij[1]; - a_f(j,2) -= fij[2]; - - // tally global and per-atom virial contribution - - if (EVFLAG) { - if (vflag_either) { - v_tally_xyz(ev,i,j, - fij[0],fij[1],fij[2], - -my_sna.rij(jj,0),-my_sna.rij(jj,1), - -my_sna.rij(jj,2)); - } - } - + }); }); - //t5 += timer.seconds(); timer.reset(); // tally energy contribution if (EVFLAG) { if (eflag_either) { - if (!quadraticflag) { - my_sna.compute_bi(team); - team.team_barrier(); - my_sna.copy_bi2bvec(team); - team.team_barrier(); - } - - // E = beta.B + 0.5*B^t.alpha.B - // coeff[k] = beta[k-1] or - // coeff[k] = alpha_ii or - // coeff[k] = alpha_ij = alpha_ji, j != i - Kokkos::single(Kokkos::PerTeam(team), [&] () { // evdwl = energy of atom I, sum over coeffs_k * Bi_k double evdwl = d_coeffi[0]; - + + // E = beta.B + 0.5*B^t.alpha.B + // linear contributions - // could use thread vector range on this loop - - for (int k = 1; k <= ncoeff; k++) - evdwl += d_coeffi[k]*my_sna.bvec[k-1]; - + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + evdwl += d_coeffi[icoeff+1]*d_bispectrum(ii,icoeff); + // quadratic contributions - + if (quadraticflag) { int k = ncoeff+1; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = my_sna.bvec[icoeff]; + double bveci = d_bispectrum(ii,icoeff); evdwl += 0.5*d_coeffi[k++]*bveci*bveci; for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - evdwl += d_coeffi[k++]*bveci*my_sna.bvec[jcoeff]; + double bvecj = d_bispectrum(ii,jcoeff); + evdwl += d_coeffi[k++]*bveci*bvecj; } } } @@ -591,9 +672,9 @@ void PairSNAPKokkos::operator() (TagPairSNAP,const template template KOKKOS_INLINE_FUNCTION -void PairSNAPKokkos::operator() (TagPairSNAP,const typename Kokkos::TeamPolicy >::member_type& team) const { +void PairSNAPKokkos::operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team) const { EV_FLOAT ev; - this->template operator()(TagPairSNAP(), team, ev); + this->template operator()(TagPairSNAPCompute(), team, ev); } /* ---------------------------------------------------------------------- */ diff --git a/src/KOKKOS/sna_kokkos.h b/src/KOKKOS/sna_kokkos.h index 40e5fe0ad4..ff2541dca3 100644 --- a/src/KOKKOS/sna_kokkos.h +++ b/src/KOKKOS/sna_kokkos.h @@ -25,7 +25,11 @@ namespace LAMMPS_NS { -struct SNAKK_LOOPINDICES { +struct SNAKK_ZINDICES { + int j1, j2, j, ma1min, ma2max, mb1min, mb2max, na, nb, jju; +}; + +struct SNAKK_BINDICES { int j1, j2, j; }; @@ -35,9 +39,9 @@ class SNAKokkos { public: typedef Kokkos::View t_sna_1i; typedef Kokkos::View t_sna_1d; + typedef Kokkos::View > t_sna_1d_atomic; typedef Kokkos::View t_sna_2d; typedef Kokkos::View t_sna_3d; - typedef Kokkos::View > t_sna_3d_atomic; typedef Kokkos::View t_sna_4d; typedef Kokkos::View t_sna_3d3; typedef Kokkos::View t_sna_5d; @@ -76,9 +80,10 @@ inline KOKKOS_INLINE_FUNCTION void compute_zi(const typename Kokkos::TeamPolicy::member_type& team); // ForceSNAP KOKKOS_INLINE_FUNCTION - void compute_bi(const typename Kokkos::TeamPolicy::member_type& team); // ForceSNAP + void compute_yi(const typename Kokkos::TeamPolicy::member_type& team, + const Kokkos::View &beta, const int ii); // ForceSNAP KOKKOS_INLINE_FUNCTION - void copy_bi2bvec(const typename Kokkos::TeamPolicy::member_type& team); //ForceSNAP + void compute_bi(const typename Kokkos::TeamPolicy::member_type& team); // ForceSNAP // functions for derivatives @@ -87,7 +92,7 @@ inline KOKKOS_INLINE_FUNCTION void compute_dbidrj(const typename Kokkos::TeamPolicy::member_type& team); //ForceSNAP KOKKOS_INLINE_FUNCTION - void copy_dbi2dbvec(const typename Kokkos::TeamPolicy::member_type& team); //ForceSNAP + void compute_deidrj(const typename Kokkos::TeamPolicy::member_type& team, double *); // ForceSNAP KOKKOS_INLINE_FUNCTION double compute_sfac(double, double); // add_uarraytot, compute_duarray KOKKOS_INLINE_FUNCTION @@ -114,37 +119,41 @@ inline int twojmax, diagonalstyle; // Per InFlight Particle - t_sna_3d barray; - t_sna_3d uarraytot_r, uarraytot_i; - t_sna_3d_atomic uarraytot_r_a, uarraytot_i_a; - t_sna_5d zarray_r, zarray_i; + t_sna_1d blist; + t_sna_1d ulisttot_r, ulisttot_i; + t_sna_1d_atomic ulisttot_r_a, ulisttot_i_a; + t_sna_1d zlist_r, zlist_i; // Per InFlight Interaction - t_sna_3d uarray_r, uarray_i; - - Kokkos::View bvec; + t_sna_1d ulist_r, ulist_i; + t_sna_1d ylist_r, ylist_i; // derivatives of data - Kokkos::View dbvec; - t_sna_4d duarray_r, duarray_i; - t_sna_4d dbarray; + t_sna_2d dulist_r, dulist_i; + t_sna_2d dblist; private: double rmin0, rfac0; //use indexlist instead of loops, constructor generates these - // Same accross all SNAKokkos - Kokkos::View idxj,idxj_full; - int idxj_max,idxj_full_max; + // Same across all SNAKokkos + Kokkos::View idxz; + Kokkos::View idxb; + int idxcg_max, idxu_max, idxz_max, idxb_max; + Kokkos::View idxcg_block; + Kokkos::View idxu_block; + Kokkos::View idxz_block; + Kokkos::View idxb_block; + // data for bispectrum coefficients // Same accross all SNAKokkos - t_sna_5d cgarray; + t_sna_1d cglist; t_sna_2d rootpqarray; - static const int nmaxfactorial = 167; - KOKKOS_INLINE_FUNCTION + static const double nfac_table[]; + inline double factorial(int); KOKKOS_INLINE_FUNCTION diff --git a/src/KOKKOS/sna_kokkos_impl.h b/src/KOKKOS/sna_kokkos_impl.h index c43003af97..4ca8ae4471 100644 --- a/src/KOKKOS/sna_kokkos_impl.h +++ b/src/KOKKOS/sna_kokkos_impl.h @@ -47,13 +47,13 @@ SNAKokkos::SNAKokkos(double rfac0_in, build_indexlist(); - int jdim = twojmax + 1; + int jdimpq = twojmax + 2; + rootpqarray = t_sna_2d("SNAKokkos::rootpqarray",jdimpq,jdimpq); - cgarray = t_sna_5d("SNAKokkos::cgarray",jdim,jdim,jdim,jdim,jdim); - rootpqarray = t_sna_2d("SNAKokkos::rootpqarray",jdim+1,jdim+1); + cglist = t_sna_1d("SNAKokkos::cglist",idxcg_max); if (bzero_flag) { - bzero = Kokkos::View("sna:bzero",jdim); + bzero = Kokkos::View("sna:bzero",twojmax+1); auto h_bzero = Kokkos::create_mirror_view(bzero); double www = wself*wself*wself; @@ -77,11 +77,17 @@ SNAKokkos::SNAKokkos(const SNAKokkos& sna, const typenam ncoeff = sna.ncoeff; nmax = sna.nmax; - idxj = sna.idxj; - idxj_max = sna.idxj_max; - idxj_full = sna.idxj_full; - idxj_full_max = sna.idxj_full_max; - cgarray = sna.cgarray; + idxz = sna.idxz; + idxb = sna.idxb; + idxcg_max = sna.idxcg_max; + idxu_max = sna.idxu_max; + idxz_max = sna.idxz_max; + idxb_max = sna.idxb_max; + idxcg_block = sna.idxcg_block; + idxu_block = sna.idxu_block; + idxz_block = sna.idxz_block; + idxb_block = sna.idxb_block; + cglist = sna.cglist; rootpqarray = sna.rootpqarray; bzero = sna.bzero; create_team_scratch_arrays(team); @@ -100,47 +106,133 @@ template inline void SNAKokkos::build_indexlist() { - int idxj_count = 0; - int idxj_full_count = 0; + // index list for cglist + + int jdim = twojmax + 1; + idxcg_block = Kokkos::View("SNAKokkos::idxcg_block",jdim,jdim,jdim); + auto h_idxcg_block = Kokkos::create_mirror_view(idxcg_block); + int idxcg_count = 0; for(int j1 = 0; j1 <= twojmax; j1++) for(int j2 = 0; j2 <= j1; j2++) - for(int j = abs(j1 - j2); j <= MIN(twojmax, j1 + j2); j += 2) { - if (j >= j1) idxj_count++; - idxj_full_count++; + for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) { + h_idxcg_block(j1,j2,j) = idxcg_count; + for (int m1 = 0; m1 <= j1; m1++) + for (int m2 = 0; m2 <= j2; m2++) + idxcg_count++; } + idxcg_max = idxcg_count; + Kokkos::deep_copy(idxcg_block,h_idxcg_block); + + // index list for uarray + // need to include both halves + + idxu_block = Kokkos::View("SNAKokkos::idxu_block",jdim); + auto h_idxu_block = Kokkos::create_mirror_view(idxu_block); + + int idxu_count = 0; + + for(int j = 0; j <= twojmax; j++) { + h_idxu_block[j] = idxu_count; + for(int mb = 0; mb <= j; mb++) + for(int ma = 0; ma <= j; ma++) + idxu_count++; + } + idxu_max = idxu_count; + Kokkos::deep_copy(idxu_block,h_idxu_block); - // indexList can be changed here + // index list for beta and B - idxj = Kokkos::View("SNAKokkos::idxj",idxj_count); - idxj_full = Kokkos::View("SNAKokkos::idxj_full",idxj_full_count); - auto h_idxj = Kokkos::create_mirror_view(idxj); - auto h_idxj_full = Kokkos::create_mirror_view(idxj_full); + int idxb_count = 0; + for(int j1 = 0; j1 <= twojmax; j1++) + for(int j2 = 0; j2 <= j1; j2++) + for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) + if (j >= j1) idxb_count++; + + idxb_max = idxb_count; + idxb = Kokkos::View("SNAKokkos::idxb",idxb_max); + auto h_idxb = Kokkos::create_mirror_view(idxb); + + idxb_count = 0; + for(int j1 = 0; j1 <= twojmax; j1++) + for(int j2 = 0; j2 <= j1; j2++) + for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) + if (j >= j1) { + h_idxb[idxb_count].j1 = j1; + h_idxb[idxb_count].j2 = j2; + h_idxb[idxb_count].j = j; + idxb_count++; + } + Kokkos::deep_copy(idxb,h_idxb); - idxj_max = idxj_count; - idxj_full_max = idxj_full_count; + // reverse index list for beta and b - idxj_count = 0; - idxj_full_count = 0; + idxb_block = Kokkos::View("SNAKokkos::idxb_block",jdim,jdim,jdim); + auto h_idxb_block = Kokkos::create_mirror_view(idxb_block); + idxb_count = 0; for(int j1 = 0; j1 <= twojmax; j1++) for(int j2 = 0; j2 <= j1; j2++) - for(int j = abs(j1 - j2); j <= MIN(twojmax, j1 + j2); j += 2) { - if (j >= j1) { - h_idxj[idxj_count].j1 = j1; - h_idxj[idxj_count].j2 = j2; - h_idxj[idxj_count].j = j; - idxj_count++; - } - h_idxj_full[idxj_full_count].j1 = j1; - h_idxj_full[idxj_full_count].j2 = j2; - h_idxj_full[idxj_full_count].j = j; - idxj_full_count++; + for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) { + if (j >= j1) { + h_idxb_block(j1,j2,j) = idxb_count; + idxb_count++; + } } - Kokkos::deep_copy(idxj,h_idxj); - Kokkos::deep_copy(idxj_full,h_idxj_full); + Kokkos::deep_copy(idxb_block,h_idxb_block); + + // index list for zlist + int idxz_count = 0; + + for(int j1 = 0; j1 <= twojmax; j1++) + for(int j2 = 0; j2 <= j1; j2++) + for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) + for (int mb = 0; 2*mb <= j; mb++) + for (int ma = 0; ma <= j; ma++) + idxz_count++; + + idxz_max = idxz_count; + idxz = Kokkos::View("SNAKokkos::idxz",idxz_max); + auto h_idxz = Kokkos::create_mirror_view(idxz); + + idxz_block = Kokkos::View("SNAKokkos::idxz_block", jdim,jdim,jdim); + auto h_idxz_block = Kokkos::create_mirror_view(idxz_block); + + idxz_count = 0; + for(int j1 = 0; j1 <= twojmax; j1++) + for(int j2 = 0; j2 <= j1; j2++) + for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) { + h_idxz_block(j1,j2,j) = idxz_count; + + // find right beta(ii,jjb) entry + // multiply and divide by j+1 factors + // account for multiplicity of 1, 2, or 3 + + for (int mb = 0; 2*mb <= j; mb++) + for (int ma = 0; ma <= j; ma++) { + h_idxz[idxz_count].j1 = j1; + h_idxz[idxz_count].j2 = j2; + h_idxz[idxz_count].j = j; + h_idxz[idxz_count].ma1min = MAX(0, (2 * ma - j - j2 + j1) / 2); + h_idxz[idxz_count].ma2max = (2 * ma - j - (2 * h_idxz[idxz_count].ma1min - j1) + j2) / 2; + h_idxz[idxz_count].na = MIN(j1, (2 * ma - j + j2 + j1) / 2) - h_idxz[idxz_count].ma1min + 1; + h_idxz[idxz_count].mb1min = MAX(0, (2 * mb - j - j2 + j1) / 2); + h_idxz[idxz_count].mb2max = (2 * mb - j - (2 * h_idxz[idxz_count].mb1min - j1) + j2) / 2; + h_idxz[idxz_count].nb = MIN(j1, (2 * mb - j + j2 + j1) / 2) - h_idxz[idxz_count].mb1min + 1; + + // apply to z(j1,j2,j,ma,mb) to unique element of y(j) + + const int jju = idxu_block[j] + (j+1)*mb + ma; + h_idxz[idxz_count].jju = jju; + + idxz_count++; + } + } + Kokkos::deep_copy(idxz,h_idxz); + Kokkos::deep_copy(idxz_block,h_idxz_block); } + /* ---------------------------------------------------------------------- */ template @@ -166,6 +258,7 @@ template KOKKOS_INLINE_FUNCTION void SNAKokkos::compute_ui(const typename Kokkos::TeamPolicy::member_type& team, int jnum) { + //printf("jnum %i\n",jnum); double rsq, r, x, y, z, z0, theta0; // utot(j,ma,mb) = 0 for all j,ma,ma @@ -211,93 +304,234 @@ template KOKKOS_INLINE_FUNCTION void SNAKokkos::compute_zi(const typename Kokkos::TeamPolicy::member_type& team) { - // for j1 = 0,...,twojmax - // for j2 = 0,twojmax - // for j = |j1-j2|,Min(twojmax,j1+j2),2 - // for ma = 0,...,j - // for mb = 0,...,jmid - // z(j1,j2,j,ma,mb) = 0 - // for ma1 = Max(0,ma+(j1-j2-j)/2),Min(j1,ma+(j1+j2-j)/2) - // sumb1 = 0 - // ma2 = ma-ma1+(j1+j2-j)/2; - // for mb1 = Max(0,mb+(j1-j2-j)/2),Min(j1,mb+(j1+j2-j)/2) - // mb2 = mb-mb1+(j1+j2-j)/2; - // sumb1 += cg(j1,mb1,j2,mb2,j) * - // u(j1,ma1,mb1) * u(j2,ma2,mb2) - // z(j1,j2,j,ma,mb) += sumb1*cg(j1,ma1,j2,ma2,j) - -#ifdef TIMING_INFO - clock_gettime(CLOCK_REALTIME, &starttime); -#endif - - // compute_dbidrj() requires full j1/j2/j chunk of z elements - // use zarray j1/j2 symmetry - - Kokkos::parallel_for(Kokkos::TeamThreadRange(team,idxj_full_max), - [&] (const int& idx) { - const int j1 = idxj_full(idx).j1; - const int j2 = idxj_full(idx).j2; - const int j = idxj_full(idx).j; + Kokkos::parallel_for(Kokkos::TeamThreadRange(team,idxz_max), + [&] (const int& jjz) { + //for(int jjz = 0; jjz < idxz_max; jjz++) { + const int j1 = idxz[jjz].j1; + const int j2 = idxz[jjz].j2; + const int j = idxz[jjz].j; + const int ma1min = idxz[jjz].ma1min; + const int ma2max = idxz[jjz].ma2max; + const int na = idxz[jjz].na; + const int mb1min = idxz[jjz].mb1min; + const int mb2max = idxz[jjz].mb2max; + const int nb = idxz[jjz].nb; + + const double* cgblock = cglist.data() + idxcg_block(j1,j2,j); + + zlist_r[jjz] = 0.0; + zlist_i[jjz] = 0.0; + + int jju1 = idxu_block[j1] + (j1+1)*mb1min; + int jju2 = idxu_block[j2] + (j2+1)*mb2max; + int icgb = mb1min*(j2+1) + mb2max; + for(int ib = 0; ib < nb; ib++) { + + double suma1_r = 0.0; + double suma1_i = 0.0; + + const double* u1_r = ulisttot_r.data() + jju1; + const double* u1_i = ulisttot_i.data() + jju1; + const double* u2_r = ulisttot_r.data() + jju2; + const double* u2_i = ulisttot_i.data() + jju2; + + int ma1 = ma1min; + int ma2 = ma2max; + int icga = ma1min*(j2+1) + ma2max; + for(int ia = 0; ia < na; ia++) { + suma1_r += cgblock[icga] * (u1_r[ma1] * u2_r[ma2] - u1_i[ma1] * u2_i[ma2]); + suma1_i += cgblock[icga] * (u1_r[ma1] * u2_i[ma2] + u1_i[ma1] * u2_r[ma2]); + ma1++; + ma2--; + icga += j2; + } // end loop over ia + + zlist_r[jjz] += cgblock[icgb] * suma1_r; + zlist_i[jjz] += cgblock[icgb] * suma1_i; + //printf("%i %i %i %g %g\n",j1,j2,j,cgblock[icgb],suma1_r); + jju1 += j1+1; + jju2 -= j2+1; + icgb += j2; + } // end loop over ib + + }); // end loop over jjz +} - const int bound = (j+2)/2; - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,(j+1)*bound), - [&] (const int mbma ) { - //for(int mb = 0; 2*mb <= j; mb++) - //for(int ma = 0; ma <= j; ma++) { - const int ma = mbma%(j+1); - const int mb = mbma/(j+1); - - //zarray_r(j1,j2,j,ma,mb) = 0.0; - //zarray_i(j1,j2,j,ma,mb) = 0.0; - double z_r = 0.0; - double z_i = 0.0; - - for(int ma1 = MAX(0, (2 * ma - j - j2 + j1) / 2); - ma1 <= MIN(j1, (2 * ma - j + j2 + j1) / 2); ma1++) { - double sumb1_r = 0.0; - double sumb1_i = 0.0; - - const int ma2 = (2 * ma - j - (2 * ma1 - j1) + j2) / 2; - - for(int mb1 = MAX( 0, (2 * mb - j - j2 + j1) / 2); - mb1 <= MIN(j1, (2 * mb - j + j2 + j1) / 2); mb1++) { - - const int mb2 = (2 * mb - j - (2 * mb1 - j1) + j2) / 2; - const double cga = cgarray(j1,j2,j,mb1,mb2); - const double uat1_r = uarraytot_r(j1,ma1,mb1); - const double uat1_i = uarraytot_i(j1,ma1,mb1); - const double uat2_r = uarraytot_r(j2,ma2,mb2); - const double uat2_i = uarraytot_i(j2,ma2,mb2); - sumb1_r += cga * (uat1_r * uat2_r - uat1_i * uat2_i); - sumb1_i += cga * (uat1_r * uat2_i + uat1_i * uat2_r); - /*sumb1_r += cgarray(j1,j2,j,mb1,mb2) * - (uarraytot_r(j1,ma1,mb1) * uarraytot_r(j2,ma2,mb2) - - uarraytot_i(j1,ma1,mb1) * uarraytot_i(j2,ma2,mb2)); - sumb1_i += cgarray(j1,j2,j,mb1,mb2) * - (uarraytot_r(j1,ma1,mb1) * uarraytot_i(j2,ma2,mb2) + - uarraytot_i(j1,ma1,mb1) * uarraytot_r(j2,ma2,mb2));*/ - } // end loop over mb1 - - const double cga = cgarray(j1,j2,j,ma1,ma2); - z_r += sumb1_r * cga;//rray(j1,j2,j,ma1,ma2); - z_i += sumb1_i * cga;//rray(j1,j2,j,ma1,ma2); - } // end loop over ma1 - zarray_r(j1,j2,j,mb,ma) = z_r; - zarray_i(j1,j2,j,mb,ma) = z_i; - }); // end loop over ma, mb - // } - //} - }); - //} // end loop over j - //} // end loop over j1, j2 +/* ---------------------------------------------------------------------- + compute Yi from Ui without storing Zi, looping over zlist indices +------------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void SNAKokkos::compute_yi(const typename Kokkos::TeamPolicy::member_type& team, + const Kokkos::View &beta, const int ii) +{ + int j; + int jjz; + int jju; + double betaj; + + { + double* const ptr = ylist_r.data(); + Kokkos::parallel_for(Kokkos::TeamThreadRange(team,ylist_r.span()), + [&] (const int& i) { + ptr[i] = 0.0; + }); + } + { + double* const ptr = ylist_i.data(); + Kokkos::parallel_for(Kokkos::TeamThreadRange(team,ylist_i.span()), + [&] (const int& i) { + ptr[i] = 0.0; + }); + } + + Kokkos::parallel_for(Kokkos::TeamThreadRange(team,idxz_max), + [&] (const int& jjz) { + //for(int jjz = 0; jjz < idxz_max; jjz++) { + const int j1 = idxz[jjz].j1; + const int j2 = idxz[jjz].j2; + const int j = idxz[jjz].j; + const int ma1min = idxz[jjz].ma1min; + const int ma2max = idxz[jjz].ma2max; + const int na = idxz[jjz].na; + const int mb1min = idxz[jjz].mb1min; + const int mb2max = idxz[jjz].mb2max; + const int nb = idxz[jjz].nb; + + const double* cgblock = cglist.data() + idxcg_block(j1,j2,j); + int mb = (2 * (mb1min+mb2max) - j1 - j2 + j) / 2; + int ma = (2 * (ma1min+ma2max) - j1 - j2 + j) / 2; + + double ztmp_r = 0.0; + double ztmp_i = 0.0; + + int jju1 = idxu_block[j1] + (j1+1)*mb1min; + int jju2 = idxu_block[j2] + (j2+1)*mb2max; + int icgb = mb1min*(j2+1) + mb2max; + for(int ib = 0; ib < nb; ib++) { + + double suma1_r = 0.0; + double suma1_i = 0.0; + + const double* u1_r = ulisttot_r.data() + jju1; + const double* u1_i = ulisttot_i.data() + jju1; + const double* u2_r = ulisttot_r.data() + jju2; + const double* u2_i = ulisttot_i.data() + jju2; + + int ma1 = ma1min; + int ma2 = ma2max; + int icga = ma1min*(j2+1) + ma2max; + + for(int ia = 0; ia < na; ia++) { + suma1_r += cgblock[icga] * (u1_r[ma1] * u2_r[ma2] - u1_i[ma1] * u2_i[ma2]); + suma1_i += cgblock[icga] * (u1_r[ma1] * u2_i[ma2] + u1_i[ma1] * u2_r[ma2]); ma1++; + ma2--; + icga += j2; + } // end loop over ia + + ztmp_r += cgblock[icgb] * suma1_r; + ztmp_i += cgblock[icgb] * suma1_i; + jju1 += j1+1; + jju2 -= j2+1; + icgb += j2; + } // end loop over ib + + // apply to z(j1,j2,j,ma,mb) to unique element of y(j) + // find right y_list[jju] and beta(ii,jjb) entries + // multiply and divide by j+1 factors + // account for multiplicity of 1, 2, or 3 + + const int jju = idxz[jjz].jju; + + // pick out right beta value + + if (j >= j1) { + const int jjb = idxb_block(j1,j2,j); + if (j1 == j) { + if (j2 == j) betaj = 3*beta(ii,jjb); + else betaj = 2*beta(ii,jjb); + } else betaj = beta(ii,jjb); + } else if (j >= j2) { + const int jjb = idxb_block(j,j2,j1); + if (j2 == j) betaj = 2*beta(ii,jjb)*(j1+1)/(j+1.0); + else betaj = beta(ii,jjb)*(j1+1)/(j+1.0); + } else { + const int jjb = idxb_block(j2,j,j1); + betaj = beta(ii,jjb)*(j1+1)/(j+1.0); + } + + ylist_r[jju] += betaj*ztmp_r; + ylist_i[jju] += betaj*ztmp_i; + //printf("yi %i %g %g\n",jju,ylist_r[jju],ylist_i[jju]); -#ifdef TIMING_INFO - clock_gettime(CLOCK_REALTIME, &endtime); - timers[1] += (endtime.tv_sec - starttime.tv_sec + 1.0 * - (endtime.tv_nsec - starttime.tv_nsec) / 1000000000); -#endif + }); // end loop over jjz } +/* ---------------------------------------------------------------------- + compute dEidRj +------------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void SNAKokkos::compute_deidrj(const typename Kokkos::TeamPolicy::member_type& team, double* dedr) +{ + + for(int k = 0; k < 3; k++) + dedr[k] = 0.0; + + // TODO: which loop is faster to parallelize? + Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,twojmax+1), + [&] (const int& j) { + //for(int j = 0; j <= twojmax; j++) { + int jju = idxu_block[j]; + + for(int mb = 0; 2*mb < j; mb++) + for(int ma = 0; ma <= j; ma++) { + + double jjjmambyarray_r = ylist_r[jju]; + double jjjmambyarray_i = ylist_i[jju]; + + for(int k = 0; k < 3; k++) + dedr[k] += + dulist_r(jju,k) * jjjmambyarray_r + + dulist_i(jju,k) * jjjmambyarray_i; + jju++; + } //end loop over ma mb + + // For j even, handle middle column + + if (j%2 == 0) { + + int mb = j/2; + for(int ma = 0; ma < mb; ma++) { + double jjjmambyarray_r = ylist_r[jju]; + double jjjmambyarray_i = ylist_i[jju]; + + for(int k = 0; k < 3; k++) + dedr[k] += + dulist_r(jju,k) * jjjmambyarray_r + + dulist_i(jju,k) * jjjmambyarray_i; + jju++; + } + + int ma = mb; + double jjjmambyarray_r = ylist_r[jju]; + double jjjmambyarray_i = ylist_i[jju]; + + for(int k = 0; k < 3; k++) + dedr[k] += + (dulist_r(jju,k) * jjjmambyarray_r + + dulist_i(jju,k) * jjjmambyarray_i)*0.5; + } // end if jeven + + }); // end loop over j + + for(int k = 0; k < 3; k++) + dedr[k] *= 2.0; + + //printf("dedr %g %g %g\n",dedr[0],dedr[1],dedr[2]); +} /* ---------------------------------------------------------------------- compute Bi by summing conj(Ui)*Zi @@ -316,31 +550,33 @@ void SNAKokkos::compute_bi(const typename Kokkos::TeamPolicy::compute_bi(const typename Kokkos::TeamPolicy -KOKKOS_INLINE_FUNCTION -void SNAKokkos::copy_bi2bvec(const typename Kokkos::TeamPolicy::member_type& team) -{ - /* int ncount, j1, j2, j; - - ncount = 0; - - for(j1 = 0; j1 <= twojmax; j1++) { - for(j2 = 0; j2 <= j1; j2++) - for(j = abs(j1 - j2); - j <= MIN(twojmax, j1 + j2); j += 2) - if (j >= j1) {*/ - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,idxj_max), - [&] (const int& JJ) { - //for(int JJ = 0; JJ < idxj_max; JJ++) { - const int j1 = idxj[JJ].j1; - const int j2 = idxj[JJ].j2; - const int j = idxj[JJ].j; - bvec(JJ) = barray(j1,j2,j); - //ncount++; - }); -} - -/* ---------------------------------------------------------------------- - calculate derivative of Ui w.r.t. atom j -------------------------------------------------------------------------- */ - -template -KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, - double* rij, double wj, double rcut) -{ - double rsq, r, x, y, z, z0, theta0, cs, sn; - double dz0dr; - - x = rij[0]; - y = rij[1]; - z = rij[2]; - rsq = x * x + y * y + z * z; - r = sqrt(rsq); - double rscale0 = rfac0 * MY_PI / (rcut - rmin0); - theta0 = (r - rmin0) * rscale0; - cs = cos(theta0); - sn = sin(theta0); - z0 = r * cs / sn; - dz0dr = z0 / r - (r*rscale0) * (rsq + z0 * z0) / rsq; - -#ifdef TIMING_INFO - clock_gettime(CLOCK_REALTIME, &starttime); -#endif - - compute_duarray(team, x, y, z, z0, r, dz0dr, wj, rcut); - -#ifdef TIMING_INFO - clock_gettime(CLOCK_REALTIME, &endtime); - timers[3] += (endtime.tv_sec - starttime.tv_sec + 1.0 * - (endtime.tv_nsec - starttime.tv_nsec) / 1000000000); -#endif - } /* ---------------------------------------------------------------------- @@ -478,21 +649,18 @@ void SNAKokkos::compute_dbidrj(const typename Kokkos::TeamPolicy::compute_dbidrj(const typename Kokkos::TeamPolicy dbdr,sumzdu_r; // Sum terms Conj(dudr(j,ma,mb))*z(j1,j2,j,ma,mb) - // use zarray j1/j2 symmetry (optional) - - int j_,j1_,j2_; - if (j1 >= j2) { - //jjjzarray_r = &zarray_r(j1,j2,j); - //jjjzarray_i = &zarray_i(j1,j2,j); - j1_ = j1; - j2_ = j2; - j_ = j; - } else { - j1_ = j2; - j2_ = j1; - j_ = j; - //jjjzarray_r = &zarray_r(j2,j1,j); - //jjjzarray_i = &zarray_i(j2,j1,j); - } + int jjz = idxz_block(j1,j2,j); + int jju = idxu_block[j]; for(int mb = 0; 2*mb < j; mb++) for(int ma = 0; ma <= j; ma++) { - - dudr_r = &duarray_r(j,mb,ma,0); - dudr_i = &duarray_i(j,mb,ma,0); - jjjmambzarray_r = zarray_r(j1_,j2_,j_,mb,ma); - jjjmambzarray_i = zarray_i(j1_,j2_,j_,mb,ma); - sumzdu_r.x += (dudr_r[0] * jjjmambzarray_r + dudr_i[0] * jjjmambzarray_i); - sumzdu_r.y += (dudr_r[1] * jjjmambzarray_r + dudr_i[1] * jjjmambzarray_i); - sumzdu_r.z += (dudr_r[2] * jjjmambzarray_r + dudr_i[2] * jjjmambzarray_i); - + const int jju_index = jju+mb*(j+1)+ma; + const int jjz_index = jjz+mb*(j+1)+ma; + sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); + sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); + sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); } //end loop over ma mb // For j even, handle middle column @@ -535,14 +685,19 @@ void SNAKokkos::compute_dbidrj(const typename Kokkos::TeamPolicy::compute_dbidrj(const typename Kokkos::TeamPolicy= j2) { - j1_ = j; - j2_ = j2; - j_ = j1; - - //jjjzarray_r = zarray_r(j,j2,j1); - //jjjzarray_i = zarray_i(j,j2,j1); - } else { - j1_ = j2; - j2_ = j; - j_ = j1; - //jjjzarray_r = zarray_r(j2,j,j1); - //jjjzarray_i = zarray_i(j2,j,j1); - } - - for(int mb1 = 0; 2*mb1 < j1; mb1++) - for(int ma1 = 0; ma1 <= j1; ma1++) { + sumzdu_r.x = 0.0; sumzdu_r.y = 0.0; sumzdu_r.z = 0.0; - dudr_r = &duarray_r(j1,mb1,ma1,0); - dudr_i = &duarray_i(j1,mb1,ma1,0); - jjjmambzarray_r = zarray_r(j1_,j2_,j_,mb1,ma1); - jjjmambzarray_i = zarray_i(j1_,j2_,j_,mb1,ma1); - sumzdu_r.x += (dudr_r[0] * jjjmambzarray_r + dudr_i[0] * jjjmambzarray_i); - sumzdu_r.y += (dudr_r[1] * jjjmambzarray_r + dudr_i[1] * jjjmambzarray_i); - sumzdu_r.z += (dudr_r[2] * jjjmambzarray_r + dudr_i[2] * jjjmambzarray_i); + for(int mb = 0; 2*mb < j1; mb++) + for(int ma = 0; ma <= j1; ma++) { + const int jju_index = jju+mb*(j1+1)+ma; + const int jjz_index = jjz+mb*(j1+1)+ma; + sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); + sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); + sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); } //end loop over ma1 mb1 // For j1 even, handle middle column if (j1%2 == 0) { - const int mb1 = j1/2; - for(int ma1 = 0; ma1 <= mb1; ma1++) { - dudr_r = &duarray_r(j1,mb1,ma1,0); - dudr_i = &duarray_i(j1,mb1,ma1,0); - const double factor = ma1==mb1?0.5:1.0; - jjjmambzarray_r = zarray_r(j1_,j2_,j_,mb1,ma1) * factor; - jjjmambzarray_i = zarray_i(j1_,j2_,j_,mb1,ma1) * factor; - sumzdu_r.x += (dudr_r[0] * jjjmambzarray_r + dudr_i[0] * jjjmambzarray_i); - sumzdu_r.y += (dudr_r[1] * jjjmambzarray_r + dudr_i[1] * jjjmambzarray_i); - sumzdu_r.z += (dudr_r[2] * jjjmambzarray_r + dudr_i[2] * jjjmambzarray_i); + const int mb = j1/2; + for(int ma = 0; ma <= mb; ma++) { + const int jju_index = jju+(mb-1)*(j1+1)+(j1+1)+ma; + const int jjz_index = jjz+(mb-1)*(j1+1)+(j1+1)+ma; + sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); + sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); + sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); + } + int ma = mb; + const int jju_index = jju+(mb-1)*(j1+1)+(j1+1)+ma; + const int jjz_index = jjz+(mb-1)*(j1+1)+(j1+1)+ma; + for(int k = 0; k < 3; k++) { + sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz] + dulist_i(jju_index,0) * zlist_i[jjz_index])*0.5; + sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz] + dulist_i(jju_index,1) * zlist_i[jjz_index])*0.5; + sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz] + dulist_i(jju_index,2) * zlist_i[jjz_index])*0.5; } } // end if j1even @@ -605,94 +748,74 @@ void SNAKokkos::compute_dbidrj(const typename Kokkos::TeamPolicy= j) { - j1_ = j1; - j2_ = j; - j_ = j2; - //jjjzarray_r = zarray_r(j1,j,j2); - //jjjzarray_i = zarray_i(j1,j,j2); - } else { - j1_ = j; - j2_ = j1; - j_ = j2; - //jjjzarray_r = zarray_r(j,j1,j2); - //jjjzarray_i = zarray_i(j,j1,j2); - } + jjz = idxz_block(j,j1,j2); + jju = idxu_block[j2]; - for(int mb2 = 0; 2*mb2 < j2; mb2++) - for(int ma2 = 0; ma2 <= j2; ma2++) { + sumzdu_r.x = 0.0; sumzdu_r.y = 0.0; sumzdu_r.z = 0.0; - dudr_r = &duarray_r(j2,mb2,ma2,0); - dudr_i = &duarray_i(j2,mb2,ma2,0); - jjjmambzarray_r = zarray_r(j1_,j2_,j_,mb2,ma2); - jjjmambzarray_i = zarray_i(j1_,j2_,j_,mb2,ma2); - sumzdu_r.x += (dudr_r[0] * jjjmambzarray_r + dudr_i[0] * jjjmambzarray_i); - sumzdu_r.y += (dudr_r[1] * jjjmambzarray_r + dudr_i[1] * jjjmambzarray_i); - sumzdu_r.z += (dudr_r[2] * jjjmambzarray_r + dudr_i[2] * jjjmambzarray_i); + for(int mb = 0; 2*mb < j2; mb++) + for(int ma = 0; ma <= j2; ma++) { + const int jju_index = jju+mb*(j2+1)+ma; + const int jjz_index = jjz+mb*(j2+1)+ma; + sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); + sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); + sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); } //end loop over ma2 mb2 // For j2 even, handle middle column if (j2%2 == 0) { - const int mb2 = j2/2; - for(int ma2 = 0; ma2 <= mb2; ma2++) { - dudr_r = &duarray_r(j2,mb2,ma2,0); - dudr_i = &duarray_i(j2,mb2,ma2,0); - const double factor = ma2==mb2?0.5:1.0; - jjjmambzarray_r = zarray_r(j1_,j2_,j_,mb2,ma2) * factor; - jjjmambzarray_i = zarray_i(j1_,j2_,j_,mb2,ma2) * factor; - sumzdu_r.x += (dudr_r[0] * jjjmambzarray_r + dudr_i[0] * jjjmambzarray_i); - sumzdu_r.y += (dudr_r[1] * jjjmambzarray_r + dudr_i[1] * jjjmambzarray_i); - sumzdu_r.z += (dudr_r[2] * jjjmambzarray_r + dudr_i[2] * jjjmambzarray_i); + const int mb = j2/2; + for(int ma = 0; ma <= mb; ma++) { + const int jju_index = jju+(mb-1)*(j2+1)+(j2+1)+ma; + const int jjz_index = jjz+(mb-1)*(j2+1)+(j2+1)+ma; + sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); + sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); + sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); + } + int ma = mb; + const int jju_index = jju+(mb-1)*(j2+1)+(j2+1)+ma; + const int jjz_index = jjz+(mb-1)*(j2+1)+(j2+1)+ma; + for(int k = 0; k < 3; k++) { + sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz] + dulist_i(jju_index,0) * zlist_i[jjz_index])*0.5; + sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz] + dulist_i(jju_index,1) * zlist_i[jjz_index])*0.5; + sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz] + dulist_i(jju_index,2) * zlist_i[jjz_index])*0.5; } } // end if j2even dbdr += 2.0*sumzdu_r*j2fac; - dbarray(j1,j2,j,0) = dbdr.x; - dbarray(j1,j2,j,1) = dbdr.y; - dbarray(j1,j2,j,2) = dbdr.z; - }); //end loop over j1 j2 j - -#ifdef TIMING_INFO - clock_gettime(CLOCK_REALTIME, &endtime); - timers[4] += (endtime.tv_sec - starttime.tv_sec + 1.0 * - (endtime.tv_nsec - starttime.tv_nsec) / 1000000000); -#endif + dblist(jjb,0) = dbdr.x; + dblist(jjb,1) = dbdr.y; + dblist(jjb,2) = dbdr.z; + }); //end loop over j1 j2 j } /* ---------------------------------------------------------------------- - copy Bi derivatives into a vector + calculate derivative of Ui w.r.t. atom j ------------------------------------------------------------------------- */ template KOKKOS_INLINE_FUNCTION -void SNAKokkos::copy_dbi2dbvec(const typename Kokkos::TeamPolicy::member_type& team) +void SNAKokkos::compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, + double* rij, double wj, double rcut) { - /* int ncount, j1, j2, j; + double rsq, r, x, y, z, z0, theta0, cs, sn; + double dz0dr; - ncount = 0; + x = rij[0]; + y = rij[1]; + z = rij[2]; + rsq = x * x + y * y + z * z; + r = sqrt(rsq); + double rscale0 = rfac0 * MY_PI / (rcut - rmin0); + theta0 = (r - rmin0) * rscale0; + cs = cos(theta0); + sn = sin(theta0); + z0 = r * cs / sn; + dz0dr = z0 / r - (r*rscale0) * (rsq + z0 * z0) / rsq; - for(j1 = 0; j1 <= twojmax; j1++) { - for(j2 = 0; j2 <= j1; j2++) - for(j = abs(j1 - j2); - j <= MIN(twojmax, j1 + j2); j += 2) - if (j >= j1) {*/ - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,idxj_max), - [&] (const int& JJ) { - //for(int JJ = 0; JJ < idxj_max; JJ++) { - const int j1 = idxj[JJ].j1; - const int j2 = idxj[JJ].j2; - const int j = idxj[JJ].j; - dbvec(JJ,0) = dbarray(j1,j2,j,0); - dbvec(JJ,1) = dbarray(j1,j2,j,1); - dbvec(JJ,2) = dbarray(j1,j2,j,2); - //ncount++; - }); + compute_duarray(team, x, y, z, z0, r, dz0dr, wj, rcut); } /* ---------------------------------------------------------------------- */ @@ -702,15 +825,15 @@ KOKKOS_INLINE_FUNCTION void SNAKokkos::zero_uarraytot(const typename Kokkos::TeamPolicy::member_type& team) { { - double* const ptr = uarraytot_r.data(); - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,uarraytot_r.span()), + double* const ptr = ulisttot_r.data(); + Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot_r.span()), [&] (const int& i) { ptr[i] = 0.0; }); } { - double* const ptr = uarraytot_i.data(); - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,uarraytot_r.span()), + double* const ptr = ulisttot_i.data(); + Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot_i.span()), [&] (const int& i) { ptr[i] = 0.0; }); @@ -723,12 +846,14 @@ template KOKKOS_INLINE_FUNCTION void SNAKokkos::addself_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double wself_in) { - //for (int j = 0; j <= twojmax; j++) Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,twojmax+1), [&] (const int& j) { + //for (int j = 0; j <= twojmax; j++) + int jju = idxu_block[j]; for (int ma = 0; ma <= j; ma++) { - uarraytot_r(j,ma,ma) = wself_in; - uarraytot_i(j,ma,ma) = 0.0; + ulisttot_r[jju] = wself_in; + ulisttot_i[jju] = 0.0; + jju += j+2; } }); } @@ -743,20 +868,11 @@ void SNAKokkos::add_uarraytot(const typename Kokkos::TeamPolicy::compute_uarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION void SNAKokkos::create_team_scratch_arrays(const typename Kokkos::TeamPolicy::member_type& team) { - int jdim = twojmax + 1; - uarraytot_r_a = uarraytot_r = t_sna_3d(team.team_scratch(1),jdim,jdim,jdim); - uarraytot_i_a = uarraytot_i = t_sna_3d(team.team_scratch(1),jdim,jdim,jdim); - zarray_r = t_sna_5d(team.team_scratch(1),jdim,jdim,jdim,jdim,jdim); - zarray_i = t_sna_5d(team.team_scratch(1),jdim,jdim,jdim,jdim,jdim); - bvec = Kokkos::View(team.team_scratch(1),ncoeff); - barray = t_sna_3d(team.team_scratch(1),jdim,jdim,jdim); + ulisttot_r_a = ulisttot_r = t_sna_1d(team.team_scratch(1),idxu_max); + ulisttot_i_a = ulisttot_i = t_sna_1d(team.team_scratch(1),idxu_max); + ylist_r = t_sna_1d(team.team_scratch(1),idxu_max); + ylist_i = t_sna_1d(team.team_scratch(1),idxu_max); + zlist_r = t_sna_1d(team.team_scratch(1),idxz_max); + zlist_i = t_sna_1d(team.team_scratch(1),idxz_max); + blist = t_sna_1d(team.team_scratch(1),idxb_max); + dblist = t_sna_2d(team.team_scratch(1),idxb_max,3); rij = t_sna_2d(team.team_scratch(1),nmax,3); rcutij = t_sna_1d(team.team_scratch(1),nmax); @@ -1043,19 +1184,16 @@ void SNAKokkos::create_team_scratch_arrays(const typename Kokkos::Te inside = t_sna_1i(team.team_scratch(1),nmax); } - template inline T_INT SNAKokkos::size_team_scratch_arrays() { T_INT size = 0; - int jdim = twojmax + 1; - size += t_sna_3d::shmem_size(jdim,jdim,jdim); // uarraytot_r_a - size += t_sna_3d::shmem_size(jdim,jdim,jdim); // uarraytot_i_a - size += t_sna_5d::shmem_size(jdim,jdim,jdim,jdim,jdim); // zarray_r - size += t_sna_5d::shmem_size(jdim,jdim,jdim,jdim,jdim); // zarray_i - size += Kokkos::View::shmem_size(ncoeff); // bvec - size += t_sna_3d::shmem_size(jdim,jdim,jdim); // barray + size += t_sna_1d::shmem_size(idxu_max)*2; // ulisttot + size += t_sna_1d::shmem_size(idxu_max)*2; // ylist + size += t_sna_1d::shmem_size(idxz_max)*2; // zlist + size += t_sna_1d::shmem_size(idxb_max); // blist + size += t_sna_2d::shmem_size(idxb_max,3); // dblist size += t_sna_2d::shmem_size(nmax,3); // rij size += t_sna_1d::shmem_size(nmax); // rcutij @@ -1071,53 +1209,225 @@ template KOKKOS_INLINE_FUNCTION void SNAKokkos::create_thread_scratch_arrays(const typename Kokkos::TeamPolicy::member_type& team) { - int jdim = twojmax + 1; - - dbvec = Kokkos::View(team.thread_scratch(1),ncoeff); - dbarray = t_sna_4d(team.thread_scratch(1),jdim,jdim,jdim); + dblist = t_sna_2d(team.thread_scratch(1),idxb_max,3); - uarray_r = t_sna_3d(team.thread_scratch(1),jdim,jdim,jdim); - uarray_i = t_sna_3d(team.thread_scratch(1),jdim,jdim,jdim); - duarray_r = t_sna_4d(team.thread_scratch(1),jdim,jdim,jdim); - duarray_i = t_sna_4d(team.thread_scratch(1),jdim,jdim,jdim); + ulist_r = t_sna_1d(team.thread_scratch(1),idxu_max); + ulist_i = t_sna_1d(team.thread_scratch(1),idxu_max); + dulist_r = t_sna_2d(team.thread_scratch(1),idxu_max,3); + dulist_i = t_sna_2d(team.thread_scratch(1),idxu_max,3); } template inline T_INT SNAKokkos::size_thread_scratch_arrays() { T_INT size = 0; - int jdim = twojmax + 1; - size += Kokkos::View::shmem_size(ncoeff); // dbvec - size += t_sna_4d::shmem_size(jdim,jdim,jdim); // dbarray + size += t_sna_2d::shmem_size(idxb_max,3); // dblist - size += t_sna_3d::shmem_size(jdim,jdim,jdim); // uarray_r - size += t_sna_3d::shmem_size(jdim,jdim,jdim); // uarray_i - size += t_sna_4d::shmem_size(jdim,jdim,jdim); // duarray_r - size += t_sna_4d::shmem_size(jdim,jdim,jdim); // duarray_i + size += t_sna_1d::shmem_size(idxu_max)*2; // ulist + size += t_sna_2d::shmem_size(idxu_max,3)*2; // dulist return size; } /* ---------------------------------------------------------------------- - factorial n + factorial n, wrapper for precomputed table ------------------------------------------------------------------------- */ template -KOKKOS_INLINE_FUNCTION +inline double SNAKokkos::factorial(int n) { - double result = 1.0; - for(int i=1; i<=n; i++) - result *= 1.0*i; - return result; + //if (n < 0 || n > nmaxfactorial) { + // char str[128]; + // sprintf(str, "Invalid argument to factorial %d", n); + // error->all(FLERR, str); + //} + + return nfac_table[n]; } +/* ---------------------------------------------------------------------- + factorial n table, size SNA::nmaxfactorial+1 +------------------------------------------------------------------------- */ + +template +const double SNAKokkos::nfac_table[] = { + 1, + 1, + 2, + 6, + 24, + 120, + 720, + 5040, + 40320, + 362880, + 3628800, + 39916800, + 479001600, + 6227020800, + 87178291200, + 1307674368000, + 20922789888000, + 355687428096000, + 6.402373705728e+15, + 1.21645100408832e+17, + 2.43290200817664e+18, + 5.10909421717094e+19, + 1.12400072777761e+21, + 2.5852016738885e+22, + 6.20448401733239e+23, + 1.5511210043331e+25, + 4.03291461126606e+26, + 1.08888694504184e+28, + 3.04888344611714e+29, + 8.8417619937397e+30, + 2.65252859812191e+32, + 8.22283865417792e+33, + 2.63130836933694e+35, + 8.68331761881189e+36, + 2.95232799039604e+38, + 1.03331479663861e+40, + 3.71993326789901e+41, + 1.37637530912263e+43, + 5.23022617466601e+44, + 2.03978820811974e+46, + 8.15915283247898e+47, + 3.34525266131638e+49, + 1.40500611775288e+51, + 6.04152630633738e+52, + 2.65827157478845e+54, + 1.1962222086548e+56, + 5.50262215981209e+57, + 2.58623241511168e+59, + 1.24139155925361e+61, + 6.08281864034268e+62, + 3.04140932017134e+64, + 1.55111875328738e+66, + 8.06581751709439e+67, + 4.27488328406003e+69, + 2.30843697339241e+71, + 1.26964033536583e+73, + 7.10998587804863e+74, + 4.05269195048772e+76, + 2.35056133128288e+78, + 1.3868311854569e+80, + 8.32098711274139e+81, + 5.07580213877225e+83, + 3.14699732603879e+85, + 1.98260831540444e+87, + 1.26886932185884e+89, + 8.24765059208247e+90, + 5.44344939077443e+92, + 3.64711109181887e+94, + 2.48003554243683e+96, + 1.71122452428141e+98, + 1.19785716699699e+100, + 8.50478588567862e+101, + 6.12344583768861e+103, + 4.47011546151268e+105, + 3.30788544151939e+107, + 2.48091408113954e+109, + 1.88549470166605e+111, + 1.45183092028286e+113, + 1.13242811782063e+115, + 8.94618213078297e+116, + 7.15694570462638e+118, + 5.79712602074737e+120, + 4.75364333701284e+122, + 3.94552396972066e+124, + 3.31424013456535e+126, + 2.81710411438055e+128, + 2.42270953836727e+130, + 2.10775729837953e+132, + 1.85482642257398e+134, + 1.65079551609085e+136, + 1.48571596448176e+138, + 1.3520015276784e+140, + 1.24384140546413e+142, + 1.15677250708164e+144, + 1.08736615665674e+146, + 1.03299784882391e+148, + 9.91677934870949e+149, + 9.61927596824821e+151, + 9.42689044888324e+153, + 9.33262154439441e+155, + 9.33262154439441e+157, + 9.42594775983835e+159, + 9.61446671503512e+161, + 9.90290071648618e+163, + 1.02990167451456e+166, + 1.08139675824029e+168, + 1.14628056373471e+170, + 1.22652020319614e+172, + 1.32464181945183e+174, + 1.44385958320249e+176, + 1.58824554152274e+178, + 1.76295255109024e+180, + 1.97450685722107e+182, + 2.23119274865981e+184, + 2.54355973347219e+186, + 2.92509369349301e+188, + 3.3931086844519e+190, + 3.96993716080872e+192, + 4.68452584975429e+194, + 5.5745857612076e+196, + 6.68950291344912e+198, + 8.09429852527344e+200, + 9.8750442008336e+202, + 1.21463043670253e+205, + 1.50614174151114e+207, + 1.88267717688893e+209, + 2.37217324288005e+211, + 3.01266001845766e+213, + 3.8562048236258e+215, + 4.97450422247729e+217, + 6.46685548922047e+219, + 8.47158069087882e+221, + 1.118248651196e+224, + 1.48727070609069e+226, + 1.99294274616152e+228, + 2.69047270731805e+230, + 3.65904288195255e+232, + 5.01288874827499e+234, + 6.91778647261949e+236, + 9.61572319694109e+238, + 1.34620124757175e+241, + 1.89814375907617e+243, + 2.69536413788816e+245, + 3.85437071718007e+247, + 5.5502938327393e+249, + 8.04792605747199e+251, + 1.17499720439091e+254, + 1.72724589045464e+256, + 2.55632391787286e+258, + 3.80892263763057e+260, + 5.71338395644585e+262, + 8.62720977423323e+264, + 1.31133588568345e+267, + 2.00634390509568e+269, + 3.08976961384735e+271, + 4.78914290146339e+273, + 7.47106292628289e+275, + 1.17295687942641e+278, + 1.85327186949373e+280, + 2.94670227249504e+282, + 4.71472363599206e+284, + 7.59070505394721e+286, + 1.22969421873945e+289, + 2.0044015765453e+291, + 3.28721858553429e+293, + 5.42391066613159e+295, + 9.00369170577843e+297, + 1.503616514865e+300, // nmaxfactorial = 167 +}; + /* ---------------------------------------------------------------------- the function delta given by VMK Eq. 8.2(1) ------------------------------------------------------------------------- */ template -KOKKOS_INLINE_FUNCTION +inline double SNAKokkos::deltacg(int j1, int j2, int j) { double sfaccg = factorial((j1 + j2 + j) / 2 + 1); @@ -1135,33 +1445,39 @@ template inline void SNAKokkos::init_clebsch_gordan() { + auto h_cglist = Kokkos::create_mirror_view(cglist); + double sum,dcg,sfaccg; int m, aa2, bb2, cc2; int ifac; - auto h_cgarray = Kokkos::create_mirror_view(cgarray); - for (int j1 = 0; j1 <= twojmax; j1++) - for (int j2 = 0; j2 <= twojmax; j2++) - for (int j = abs(j1 - j2); j <= MIN(twojmax, j1 + j2); j += 2) - for (int m1 = 0; m1 <= j1; m1 += 1) { + int idxcg_count = 0; + for(int j1 = 0; j1 <= twojmax; j1++) + for(int j2 = 0; j2 <= j1; j2++) + for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) { + for (int m1 = 0; m1 <= j1; m1++) { aa2 = 2 * m1 - j1; - for (int m2 = 0; m2 <= j2; m2 += 1) { + for (int m2 = 0; m2 <= j2; m2++) { // -c <= cc <= c bb2 = 2 * m2 - j2; m = (aa2 + bb2 + j) / 2; - if(m < 0 || m > j) continue; + if(m < 0 || m > j) { + h_cglist[idxcg_count] = 0.0; + idxcg_count++; + continue; + } sum = 0.0; for (int z = MAX(0, MAX(-(j - j2 + aa2) - / 2, -(j - j1 - bb2) / 2)); - z <= MIN((j1 + j2 - j) / 2, - MIN((j1 - aa2) / 2, (j2 + bb2) / 2)); - z++) { + / 2, -(j - j1 - bb2) / 2)); + z <= MIN((j1 + j2 - j) / 2, + MIN((j1 - aa2) / 2, (j2 + bb2) / 2)); + z++) { ifac = z % 2 ? -1 : 1; sum += ifac / (factorial(z) * @@ -1175,18 +1491,19 @@ void SNAKokkos::init_clebsch_gordan() cc2 = 2 * m - j; dcg = deltacg(j1, j2, j); sfaccg = sqrt(factorial((j1 + aa2) / 2) * - factorial((j1 - aa2) / 2) * - factorial((j2 + bb2) / 2) * - factorial((j2 - bb2) / 2) * - factorial((j + cc2) / 2) * - factorial((j - cc2) / 2) * - (j + 1)); - - h_cgarray(j1,j2,j,m1,m2) = sum * dcg * sfaccg; - //printf("SNAP-COMPARE: CG: %i %i %i %i %i %e\n",j1,j2,j,m1,m2,cgarray(j1,j2,j,m1,m2)); + factorial((j1 - aa2) / 2) * + factorial((j2 + bb2) / 2) * + factorial((j2 - bb2) / 2) * + factorial((j + cc2) / 2) * + factorial((j - cc2) / 2) * + (j + 1)); + + h_cglist[idxcg_count] = sum * dcg * sfaccg; + idxcg_count++; } } - Kokkos::deep_copy(cgarray,h_cgarray); + } + Kokkos::deep_copy(cglist,h_cglist); } /* ---------------------------------------------------------------------- @@ -1207,6 +1524,7 @@ void SNAKokkos::init_rootpqarray() /* ---------------------------------------------------------------------- */ + template inline int SNAKokkos::compute_ncoeff() @@ -1217,9 +1535,10 @@ int SNAKokkos::compute_ncoeff() for (int j1 = 0; j1 <= twojmax; j1++) for (int j2 = 0; j2 <= j1; j2++) - for (int j = abs(j1 - j2); - j <= MIN(twojmax, j1 + j2); j += 2) - if (j >= j1) ncount++; + for (int j = j1 - j2; + j <= MIN(twojmax, j1 + j2); j += 2) + if (j >= j1) ncount++; + return ncount; } @@ -1266,15 +1585,39 @@ double SNAKokkos::compute_dsfac(double r, double rcut) template double SNAKokkos::memory_usage() { + int jdimpq = twojmax + 2; int jdim = twojmax + 1; double bytes; - bytes = jdim * jdim * jdim * jdim * jdim * sizeof(double); - bytes += 2 * jdim * jdim * jdim * sizeof(std::complex); - bytes += 2 * jdim * jdim * jdim * sizeof(double); - bytes += jdim * jdim * jdim * 3 * sizeof(std::complex); - bytes += jdim * jdim * jdim * 3 * sizeof(double); - bytes += ncoeff * sizeof(double); - bytes += jdim * jdim * jdim * jdim * jdim * sizeof(std::complex); + + bytes = 0; + + bytes += jdimpq*jdimpq * sizeof(double); // pqarray + bytes += idxcg_max * sizeof(double); // cglist + + bytes += idxu_max * sizeof(double) * 2; // ulist + bytes += idxu_max * sizeof(double) * 2; // ulisttot + bytes += idxu_max * 3 * sizeof(double) * 2; // dulist + + bytes += idxz_max * sizeof(double) * 2; // zlist + bytes += idxb_max * sizeof(double); // blist + bytes += idxb_max * 3 * sizeof(double); // dblist + bytes += idxu_max * sizeof(double) * 2; // ylist + + bytes += jdim * jdim * jdim * sizeof(int); // idxcg_block + bytes += jdim * sizeof(int); // idxu_block + bytes += jdim * jdim * jdim * sizeof(int); // idxz_block + bytes += jdim * jdim * jdim * sizeof(int); // idxb_block + + bytes += idxz_max * sizeof(SNAKK_ZINDICES); // idxz + bytes += idxb_max * sizeof(SNAKK_BINDICES); // idxb + + bytes += jdim * sizeof(double); // bzero + + bytes += nmax * 3 * sizeof(double); // rij + bytes += nmax * sizeof(int); // inside + bytes += nmax * sizeof(double); // wj + bytes += nmax * sizeof(double); // rcutij + return bytes; } -- GitLab From 2be0fd61802b824363308985f415b40e8fb0e38a Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Wed, 26 Jun 2019 16:22:37 -0600 Subject: [PATCH 107/469] Fix GPU issues --- src/KOKKOS/pair_snap_kokkos_impl.h | 9 ++-- src/KOKKOS/sna_kokkos.h | 4 +- src/KOKKOS/sna_kokkos_impl.h | 78 ++++++++++-------------------- 3 files changed, 31 insertions(+), 60 deletions(-) diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index 687c9dc7cb..d56db05d19 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -309,7 +309,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokk const int ii = team.league_rank(); const int i = d_ilist[ii]; const int itype = type[i]; - const int ielem = map[itype]; + const int ielem = d_map[itype]; Kokkos::View> d_coeffi(d_coeffelem,ielem,Kokkos::ALL); @@ -603,11 +603,10 @@ void PairSNAPKokkos::operator() (TagPairSNAPCompute::member_type& team, double, double, double, double, double); // compute_ui - KOKKOS_INLINE_FUNCTION + inline double deltacg(int, int, int); // init_clebsch_gordan inline diff --git a/src/KOKKOS/sna_kokkos_impl.h b/src/KOKKOS/sna_kokkos_impl.h index 4ca8ae4471..e3ce1626d9 100644 --- a/src/KOKKOS/sna_kokkos_impl.h +++ b/src/KOKKOS/sna_kokkos_impl.h @@ -223,7 +223,7 @@ void SNAKokkos::build_indexlist() // apply to z(j1,j2,j,ma,mb) to unique element of y(j) - const int jju = idxu_block[j] + (j+1)*mb + ma; + const int jju = h_idxu_block[j] + (j+1)*mb + ma; h_idxz[idxz_count].jju = jju; idxz_count++; @@ -258,7 +258,6 @@ template KOKKOS_INLINE_FUNCTION void SNAKokkos::compute_ui(const typename Kokkos::TeamPolicy::member_type& team, int jnum) { - //printf("jnum %i\n",jnum); double rsq, r, x, y, z, z0, theta0; // utot(j,ma,mb) = 0 for all j,ma,ma @@ -348,7 +347,7 @@ void SNAKokkos::compute_zi(const typename Kokkos::TeamPolicy::compute_yi(const typename Kokkos::TeamPolicy::member_type& team, const Kokkos::View &beta, const int ii) { - int j; - int jjz; - int jju; double betaj; { @@ -400,8 +396,8 @@ void SNAKokkos::compute_yi(const typename Kokkos::TeamPolicy::compute_yi(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION void SNAKokkos::compute_deidrj(const typename Kokkos::TeamPolicy::member_type& team, double* dedr) { - - for(int k = 0; k < 3; k++) - dedr[k] = 0.0; + t_scalar3 sum; // TODO: which loop is faster to parallelize? - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,twojmax+1), - [&] (const int& j) { + Kokkos::parallel_reduce(Kokkos::ThreadVectorRange(team,twojmax+1), + [&] (const int& j, t_scalar3& sum_tmp) { //for(int j = 0; j <= twojmax; j++) { int jju = idxu_block[j]; for(int mb = 0; 2*mb < j; mb++) for(int ma = 0; ma <= j; ma++) { - - double jjjmambyarray_r = ylist_r[jju]; - double jjjmambyarray_i = ylist_i[jju]; - - for(int k = 0; k < 3; k++) - dedr[k] += - dulist_r(jju,k) * jjjmambyarray_r + - dulist_i(jju,k) * jjjmambyarray_i; + sum_tmp.x += dulist_r(jju,0) * ylist_r[jju] + dulist_i(jju,0) * ylist_i[jju]; + sum_tmp.y += dulist_r(jju,1) * ylist_r[jju] + dulist_i(jju,1) * ylist_i[jju]; + sum_tmp.z += dulist_r(jju,2) * ylist_r[jju] + dulist_i(jju,2) * ylist_i[jju]; jju++; } //end loop over ma mb @@ -505,32 +495,26 @@ void SNAKokkos::compute_deidrj(const typename Kokkos::TeamPolicy::compute_bi(const typename Kokkos::TeamPolicy::compute_bi(const typename Kokkos::TeamPolicy::compute_uarray(const typename Kokkos::TeamPolicy::compute_uarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy::create_team_scratch_arrays(const typename Kokkos::Te zlist_r = t_sna_1d(team.team_scratch(1),idxz_max); zlist_i = t_sna_1d(team.team_scratch(1),idxz_max); blist = t_sna_1d(team.team_scratch(1),idxb_max); - dblist = t_sna_2d(team.team_scratch(1),idxb_max,3); rij = t_sna_2d(team.team_scratch(1),nmax,3); rcutij = t_sna_1d(team.team_scratch(1),nmax); @@ -1193,7 +1168,6 @@ T_INT SNAKokkos::size_team_scratch_arrays() { size += t_sna_1d::shmem_size(idxu_max)*2; // ylist size += t_sna_1d::shmem_size(idxz_max)*2; // zlist size += t_sna_1d::shmem_size(idxb_max); // blist - size += t_sna_2d::shmem_size(idxb_max,3); // dblist size += t_sna_2d::shmem_size(nmax,3); // rij size += t_sna_1d::shmem_size(nmax); // rcutij @@ -1210,7 +1184,6 @@ KOKKOS_INLINE_FUNCTION void SNAKokkos::create_thread_scratch_arrays(const typename Kokkos::TeamPolicy::member_type& team) { dblist = t_sna_2d(team.thread_scratch(1),idxb_max,3); - ulist_r = t_sna_1d(team.thread_scratch(1),idxu_max); ulist_i = t_sna_1d(team.thread_scratch(1),idxu_max); dulist_r = t_sna_2d(team.thread_scratch(1),idxu_max,3); @@ -1223,7 +1196,6 @@ T_INT SNAKokkos::size_thread_scratch_arrays() { T_INT size = 0; size += t_sna_2d::shmem_size(idxb_max,3); // dblist - size += t_sna_1d::shmem_size(idxu_max)*2; // ulist size += t_sna_2d::shmem_size(idxu_max,3)*2; // dulist return size; -- GitLab From ff36bad09964fecad2b6569fef6992b164e9b56d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 00:33:48 -0400 Subject: [PATCH 108/469] cleanup includes in variable.h --- src/variable.h | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/variable.h b/src/variable.h index 512195bd14..c5f501f266 100644 --- a/src/variable.h +++ b/src/variable.h @@ -14,9 +14,8 @@ #ifndef LMP_VARIABLE_H #define LMP_VARIABLE_H -#include +#include #include "pointers.h" -#include "input.h" namespace LAMMPS_NS { -- GitLab From f7507512b131e2c515db82751b1a793de66aa657 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 00:39:47 -0400 Subject: [PATCH 109/469] apply memory alignment settings from my_page.h to my_pool_chunk.h --- src/my_pool_chunk.h | 12 ++++++++++++ 1 file changed, 12 insertions(+) diff --git a/src/my_pool_chunk.h b/src/my_pool_chunk.h index 8bf88d35bb..a313e45f05 100644 --- a/src/my_pool_chunk.h +++ b/src/my_pool_chunk.h @@ -43,6 +43,10 @@ public variables: #ifndef LAMMPS_MY_POOL_CHUNK_H #define LAMMPS_MY_POOL_CHUNK_H +#if defined(LMP_USER_INTEL) && !defined(LAMMPS_MEMALIGN) && !defined(_WIN32) +#define LAMMPS_MEMALIGN 64 +#endif + #include namespace LAMMPS_NS { @@ -190,9 +194,17 @@ class MyPoolChunk { for (int i = oldpage; i < npage; i++) { whichbin[i] = ibin; +#if defined(LAMMPS_MEMALIGN) + void *ptr; + if (posix_memalign(&ptr, LAMMPS_MEMALIGN, + chunkperpage*chunksize[ibin]*sizeof(T))) + errorflag = 2; + pages[i] = (T *) ptr; +#else pages[i] = (T *) malloc(chunkperpage*chunksize[ibin]*sizeof(T)); size += chunkperpage*chunksize[ibin]; if (!pages[i]) errorflag = 2; +#endif } // reset free list for unused chunks on new pages -- GitLab From 17602b4c26fa94e02e204b3e8e85a48cecc65569 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 01:02:17 -0400 Subject: [PATCH 110/469] some more include file cleanup. include cstdlib where functions like atoi() are used remove unneeded include statements from headers --- src/PYTHON/python_impl.cpp | 1 + src/USER-MEAMC/meam.h | 1 - src/compute_reduce_chunk.cpp | 3 ++- src/fix_vector.cpp | 1 + src/lammps.cpp | 1 + src/variable.cpp | 1 + 6 files changed, 6 insertions(+), 2 deletions(-) diff --git a/src/PYTHON/python_impl.cpp b/src/PYTHON/python_impl.cpp index aaa4f74c69..9c650330af 100644 --- a/src/PYTHON/python_impl.cpp +++ b/src/PYTHON/python_impl.cpp @@ -15,6 +15,7 @@ Contributing author: Richard Berger and Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include #include #include "lmppython.h" #include "force.h" diff --git a/src/USER-MEAMC/meam.h b/src/USER-MEAMC/meam.h index 42fd722e01..bb40202243 100644 --- a/src/USER-MEAMC/meam.h +++ b/src/USER-MEAMC/meam.h @@ -3,7 +3,6 @@ #include "memory.h" #include -#include #define maxelt 5 diff --git a/src/compute_reduce_chunk.cpp b/src/compute_reduce_chunk.cpp index f31672ef74..5eda71b21b 100644 --- a/src/compute_reduce_chunk.cpp +++ b/src/compute_reduce_chunk.cpp @@ -12,7 +12,8 @@ ------------------------------------------------------------------------- */ #include -#include +#include +#include #include "compute_reduce_chunk.h" #include "atom.h" #include "update.h" diff --git a/src/fix_vector.cpp b/src/fix_vector.cpp index 6387af7676..5657e59ab0 100644 --- a/src/fix_vector.cpp +++ b/src/fix_vector.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "fix_vector.h" #include "update.h" diff --git a/src/lammps.cpp b/src/lammps.cpp index f8d04c9323..320d89ed52 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -13,6 +13,7 @@ #include #include +#include #include #include #include diff --git a/src/variable.cpp b/src/variable.cpp index ea7f3044d7..1416754073 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -26,6 +26,7 @@ #include "region.h" #include "modify.h" #include "compute.h" +#include "input.h" #include "fix.h" #include "fix_store.h" #include "force.h" -- GitLab From 08ac695a062079390a47d7115e10428493c5cf75 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 01:03:08 -0400 Subject: [PATCH 111/469] move include statements from headers to implementation files where possible in USER-REAXC --- src/USER-OMP/reaxc_multi_body_omp.cpp | 1 + src/USER-REAXC/pair_reaxc.cpp | 1 + src/USER-REAXC/reaxc_control.cpp | 2 ++ src/USER-REAXC/reaxc_ffield.cpp | 2 ++ src/USER-REAXC/reaxc_forces.cpp | 1 + src/USER-REAXC/reaxc_init_md.cpp | 1 + src/USER-REAXC/reaxc_io_tools.cpp | 3 ++- src/USER-REAXC/reaxc_multi_body.cpp | 1 + src/USER-REAXC/reaxc_reset_tools.cpp | 1 + src/USER-REAXC/reaxc_tool_box.cpp | 5 +++++ src/USER-REAXC/reaxc_traj.cpp | 1 + src/USER-REAXC/reaxc_types.h | 10 +--------- 12 files changed, 19 insertions(+), 10 deletions(-) diff --git a/src/USER-OMP/reaxc_multi_body_omp.cpp b/src/USER-OMP/reaxc_multi_body_omp.cpp index 7552e7a733..d791f945a8 100644 --- a/src/USER-OMP/reaxc_multi_body_omp.cpp +++ b/src/USER-OMP/reaxc_multi_body_omp.cpp @@ -26,6 +26,7 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc_omp.h" #include "thr_data.h" diff --git a/src/USER-REAXC/pair_reaxc.cpp b/src/USER-REAXC/pair_reaxc.cpp index 8f8dcfb8fc..224f3e2568 100644 --- a/src/USER-REAXC/pair_reaxc.cpp +++ b/src/USER-REAXC/pair_reaxc.cpp @@ -20,6 +20,7 @@ Hybrid and hybrid/overlay compatibility added by Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include #include "pair_reaxc.h" #include "atom.h" #include "update.h" diff --git a/src/USER-REAXC/reaxc_control.cpp b/src/USER-REAXC/reaxc_control.cpp index 535226fff8..060c1a0342 100644 --- a/src/USER-REAXC/reaxc_control.cpp +++ b/src/USER-REAXC/reaxc_control.cpp @@ -24,6 +24,8 @@ . ----------------------------------------------------------------------*/ +#include +#include #include "pair_reaxc.h" #include "reaxc_control.h" #include "reaxc_tool_box.h" diff --git a/src/USER-REAXC/reaxc_ffield.cpp b/src/USER-REAXC/reaxc_ffield.cpp index 9534637645..2160d180cf 100644 --- a/src/USER-REAXC/reaxc_ffield.cpp +++ b/src/USER-REAXC/reaxc_ffield.cpp @@ -24,6 +24,8 @@ . ----------------------------------------------------------------------*/ +#include +#include #include "pair_reaxc.h" #include "error.h" #include "reaxc_ffield.h" diff --git a/src/USER-REAXC/reaxc_forces.cpp b/src/USER-REAXC/reaxc_forces.cpp index 186cde681a..79094ece43 100644 --- a/src/USER-REAXC/reaxc_forces.cpp +++ b/src/USER-REAXC/reaxc_forces.cpp @@ -24,6 +24,7 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc.h" #include "reaxc_forces.h" #include "reaxc_bond_orders.h" diff --git a/src/USER-REAXC/reaxc_init_md.cpp b/src/USER-REAXC/reaxc_init_md.cpp index df5de49034..a0e15e98f5 100644 --- a/src/USER-REAXC/reaxc_init_md.cpp +++ b/src/USER-REAXC/reaxc_init_md.cpp @@ -24,6 +24,7 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc.h" #include "reaxc_init_md.h" #include "reaxc_allocate.h" diff --git a/src/USER-REAXC/reaxc_io_tools.cpp b/src/USER-REAXC/reaxc_io_tools.cpp index 51aa8bca0f..f4a1486c48 100644 --- a/src/USER-REAXC/reaxc_io_tools.cpp +++ b/src/USER-REAXC/reaxc_io_tools.cpp @@ -24,6 +24,7 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc.h" #include "update.h" #include "reaxc_io_tools.h" @@ -85,7 +86,7 @@ int Init_Output_Files( reax_system *system, control_params *control, /************************ close output files ************************/ -int Close_Output_Files( reax_system *system, control_params *control, +int Close_Output_Files( reax_system *system, control_params * /* control */, output_controls *out_control, mpi_datatypes * /*mpi_data*/ ) { if (out_control->write_steps > 0) diff --git a/src/USER-REAXC/reaxc_multi_body.cpp b/src/USER-REAXC/reaxc_multi_body.cpp index f7d72a2678..371b8ed65e 100644 --- a/src/USER-REAXC/reaxc_multi_body.cpp +++ b/src/USER-REAXC/reaxc_multi_body.cpp @@ -24,6 +24,7 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc.h" #include "reaxc_multi_body.h" #include "reaxc_bond_orders.h" diff --git a/src/USER-REAXC/reaxc_reset_tools.cpp b/src/USER-REAXC/reaxc_reset_tools.cpp index e00656694c..c72ccbadcd 100644 --- a/src/USER-REAXC/reaxc_reset_tools.cpp +++ b/src/USER-REAXC/reaxc_reset_tools.cpp @@ -24,6 +24,7 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc.h" #include "reaxc_reset_tools.h" #include "reaxc_list.h" diff --git a/src/USER-REAXC/reaxc_tool_box.cpp b/src/USER-REAXC/reaxc_tool_box.cpp index ffe42e37bb..2cf66d8655 100644 --- a/src/USER-REAXC/reaxc_tool_box.cpp +++ b/src/USER-REAXC/reaxc_tool_box.cpp @@ -24,9 +24,14 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc.h" #include "reaxc_tool_box.h" +#if !defined(_MSC_VER) +#include +#endif + #include "error.h" struct timeval tim; diff --git a/src/USER-REAXC/reaxc_traj.cpp b/src/USER-REAXC/reaxc_traj.cpp index 356d7b6eeb..a536445113 100644 --- a/src/USER-REAXC/reaxc_traj.cpp +++ b/src/USER-REAXC/reaxc_traj.cpp @@ -24,6 +24,7 @@ . ----------------------------------------------------------------------*/ +#include #include "pair_reaxc.h" #include "reaxc_traj.h" #include "reaxc_list.h" diff --git a/src/USER-REAXC/reaxc_types.h b/src/USER-REAXC/reaxc_types.h index 0821c065cc..319c373927 100644 --- a/src/USER-REAXC/reaxc_types.h +++ b/src/USER-REAXC/reaxc_types.h @@ -27,19 +27,11 @@ #ifndef __REAX_TYPES_H_ #define __REAX_TYPES_H_ -#include #include "lmptype.h" - -#include -#include +#include #include -#include -#include -#include -#include #include "accelerator_kokkos.h" - namespace LAMMPS_NS { class Error;} #if defined LMP_USER_OMP -- GitLab From 312a1fa004bbec6f6e11e800f17c6e3038f0ecdc Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Thu, 27 Jun 2019 07:58:32 -0500 Subject: [PATCH 112/469] Added species to kim_queries in docs and some other edits --- doc/src/kim_commands.txt | 16 ++++++++-------- 1 file changed, 8 insertions(+), 8 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 9be4a79db5..48637ae722 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -32,7 +32,7 @@ kim_interactions Si kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 metal unit_conversion_mode kim_interactions C H O -kim_query a0 get_lattice_constant_fcc units=\["angstrom"\] :pre +kim_query a0 get_lattice_constant_fcc species=\["Al"] units=\["angstrom"\] :pre [Description:] @@ -53,7 +53,7 @@ Employing OpenKIM IMs provides LAMMPS users with multiple benefits: Reliability :h5 -All content archived in OpenKIM is subject to quality control by the "KIM Editor"_https://openkim.org/governance/. +All content archived in OpenKIM is reviewed by the "KIM Editor"_https://openkim.org/governance/ for quality. IMs in OpenKIM are archived with full provenance control. Each is associated with a maintainer responsible for the integrity of the content. All changes are tracked and recorded. IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/getting-started/kim-tests/ that compute a host of material properties, and "KIM Verification Checks"_https://openkim.org/about-verification-checks/ that provide the user with information on various aspects of the IM behavior and coding correctness. This information is displayed on the IM's page on "OpenKIM"_https://openkim.org. :ul @@ -73,8 +73,8 @@ Types of IMs in OpenKIM :h4 There are two types of IMs archived in OpenKIM: -The first type is called a {KIM Portable Model} (PM). A KIM PM is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran), which conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/) Portable Model Interface (PMI) standard. A KIM PM will work seamlessly with any simulation code that supports the KIM API/PMI standard (including LAMMPS; see "complete list of supported codes"_https://openkim.org/projects-using-kim/). -The second type is called a {KIM Simulator Model} (SM). A KIM SM is an IM that is implemented natively within a simulation code ({simulator}) that supports the KIM API/SMI (Simulator Model Interface); in this case LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol +The first type is called a {KIM Portable Model} (PM). A KIM PM is an independent computer implementation of an IM written in one of the languages supported by KIM (C, C++, Fortran) that conforms to the KIM Application Programming Interface ("KIM API"_https://openkim.org/kim-api/) Portable Model Interface (PMI) standard. A KIM PM will work seamlessly with any simulation code that supports the KIM API/PMI standard (including LAMMPS; see "complete list of supported codes"_https://openkim.org/projects-using-kim/). +The second type is called a {KIM Simulator Model} (SM). A KIM SM is an IM that is implemented natively within a simulation code ({simulator}) that supports the KIM API Simulator Model Interface (SMI); in this case LAMMPS. A separate SM package is archived in OpenKIM for each parameterization of the IM, which includes all of the necessary parameter files, LAMMPS commands, and metadata (supported species, units, etc.) needed to run the IM in LAMMPS. :ol With these two IM types, OpenKIM can archive and test almost all IMs that can be used by LAMMPS. (It is easy to contribute new IMs to OpenKIM, see @@ -356,7 +356,7 @@ or analysis phases of LAMMPS simulations. Some examples are given below. kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal boundary p p p -kim_query a0 get_lattice_constant_fcc units=\["angstrom"\] +kim_query a0 get_lattice_constant_fcc species=\["Al"\] units=\["angstrom"\] lattice fcc $\{a0\} ... :pre @@ -377,8 +377,8 @@ changed to: "lattice fcc $\{a0\}*$\{_u_distance\}". kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal boundary p p p -kim_query a0 get_lattice_constant_fcc units=\["angstrom"\] -kim_query alpha get_linear_thermal_expansion_fcc units=\{"1/K"\} +kim_query a0 get_lattice_constant_fcc species=\["Al"\] units=\["angstrom"\] +kim_query alpha get_linear_thermal_expansion_fcc species=\["Al"\] units=\{"1/K"\} variable DeltaT equal 300 lattice fcc $\{a0\}*$\{alpha\}*$\{DeltaT\} ... :pre @@ -395,7 +395,7 @@ kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal ... Build fcc crystal containing some defect and compute the total energy ... which is stored in the variable {Etot} ... -kim_query Ec get_cohesive_energy_fcc units=\["eV"\] +kim_query Ec get_cohesive_energy_fcc species=\["Al"\] units=\["eV"\] variable Eform equal $\{Etot\} - count(all)*$\{Ec\} ... :pre -- GitLab From 84e156d380519a7091f657fb89387d4b866280be Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 09:14:36 -0400 Subject: [PATCH 113/469] first batch of changes suggested by using include-what-you-use tool --- src/angle.cpp | 1 - src/angle.h | 2 +- src/angle_deprecated.cpp | 1 + src/angle_hybrid.cpp | 3 +-- src/angle_zero.cpp | 3 +-- src/bond.h | 2 +- src/compute.h | 2 +- src/dihedral.h | 2 +- src/dump.h | 2 +- src/fix.h | 2 +- src/improper.h | 2 +- src/lmptype.h | 4 ---- src/main.cpp | 3 --- src/pair.h | 2 +- src/pointers.h | 9 +++++++-- 15 files changed, 18 insertions(+), 22 deletions(-) diff --git a/src/angle.cpp b/src/angle.cpp index 2a297990ac..1b9532ea32 100644 --- a/src/angle.cpp +++ b/src/angle.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "angle.h" #include "atom.h" #include "comm.h" diff --git a/src/angle.h b/src/angle.h index 3d8371242e..6fc8a664c6 100644 --- a/src/angle.h +++ b/src/angle.h @@ -15,7 +15,7 @@ #define LMP_ANGLE_H #include -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/angle_deprecated.cpp b/src/angle_deprecated.cpp index b5af217b7b..73fcccc53a 100644 --- a/src/angle_deprecated.cpp +++ b/src/angle_deprecated.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include +#include #include "angle_deprecated.h" #include "angle_hybrid.h" #include "comm.h" diff --git a/src/angle_hybrid.cpp b/src/angle_hybrid.cpp index 6afa7413b2..47baf770a5 100644 --- a/src/angle_hybrid.cpp +++ b/src/angle_hybrid.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include #include #include "angle_hybrid.h" #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/angle_zero.cpp b/src/angle_zero.cpp index 6eb127fa58..62eab85aee 100644 --- a/src/angle_zero.cpp +++ b/src/angle_zero.cpp @@ -15,8 +15,7 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ -#include -#include +#include #include #include "angle_zero.h" #include "atom.h" diff --git a/src/bond.h b/src/bond.h index 8fb7040832..f9fb9384ed 100644 --- a/src/bond.h +++ b/src/bond.h @@ -15,7 +15,7 @@ #define LMP_BOND_H #include -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/compute.h b/src/compute.h index a023834368..38d001db6f 100644 --- a/src/compute.h +++ b/src/compute.h @@ -14,7 +14,7 @@ #ifndef LMP_COMPUTE_H #define LMP_COMPUTE_H -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/dihedral.h b/src/dihedral.h index f1b42008bf..8654132ed5 100644 --- a/src/dihedral.h +++ b/src/dihedral.h @@ -15,7 +15,7 @@ #define LMP_DIHEDRAL_H #include -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/dump.h b/src/dump.h index 1c6a131f76..d42e7f1f39 100644 --- a/src/dump.h +++ b/src/dump.h @@ -16,7 +16,7 @@ #include #include -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/fix.h b/src/fix.h index 7eaff38bd3..7e55e96269 100644 --- a/src/fix.h +++ b/src/fix.h @@ -14,7 +14,7 @@ #ifndef LMP_FIX_H #define LMP_FIX_H -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/improper.h b/src/improper.h index d940b43a13..4af5ad4a35 100644 --- a/src/improper.h +++ b/src/improper.h @@ -15,7 +15,7 @@ #define LMP_IMPROPER_H #include -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/lmptype.h b/src/lmptype.h index 12fa6cc4fb..8a596e9f83 100644 --- a/src/lmptype.h +++ b/src/lmptype.h @@ -48,10 +48,6 @@ namespace LAMMPS_NS { -// enum used for KOKKOS host/device flags - -enum ExecutionSpace{Host,Device}; - // reserve 2 hi bits in molecular system neigh list for special bonds flag // max local + ghost atoms per processor = 2^30 - 1 diff --git a/src/main.cpp b/src/main.cpp index 8eb5e4e543..1be9c253eb 100644 --- a/src/main.cpp +++ b/src/main.cpp @@ -14,9 +14,6 @@ #include #include "lammps.h" #include "input.h" -#include "error.h" -#include -#include #if defined(LAMMPS_TRAP_FPE) && defined(_GNU_SOURCE) #include diff --git a/src/pair.h b/src/pair.h index 7481514dae..501f3af8f8 100644 --- a/src/pair.h +++ b/src/pair.h @@ -14,7 +14,7 @@ #ifndef LMP_PAIR_H #define LMP_PAIR_H -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/pointers.h b/src/pointers.h index 44967f5135..fc359a5667 100644 --- a/src/pointers.h +++ b/src/pointers.h @@ -21,9 +21,10 @@ #ifndef LMP_POINTERS_H #define LMP_POINTERS_H -#include "lmptype.h" +#include "lmptype.h" // IWYU pragma: export #include -#include "lammps.h" +#include +#include "lammps.h" // IWYU pragma: export namespace LAMMPS_NS { @@ -34,6 +35,10 @@ namespace LAMMPS_NS { #define MIN(A,B) ((A) < (B) ? (A) : (B)) #define MAX(A,B) ((A) > (B) ? (A) : (B)) +// enum used for KOKKOS host/device flags + +enum ExecutionSpace{Host,Device}; + class Pointers { public: Pointers(LAMMPS *ptr) : -- GitLab From 333bec0222ed2f68fa84dc208c0b2f738e5e9da2 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 10:12:53 -0400 Subject: [PATCH 114/469] headers that directly or indirectly include pointers.h may assume is loaded, too. --- src/angle.h | 1 - src/angle_hybrid.h | 1 - src/angle_zero.h | 1 - src/atom.cpp | 4 ---- src/bond.h | 1 - src/dihedral.h | 1 - src/dump.h | 1 - src/improper.h | 1 - src/pointers.h | 2 +- 9 files changed, 1 insertion(+), 12 deletions(-) diff --git a/src/angle.h b/src/angle.h index 6fc8a664c6..7a008f7ca7 100644 --- a/src/angle.h +++ b/src/angle.h @@ -14,7 +14,6 @@ #ifndef LMP_ANGLE_H #define LMP_ANGLE_H -#include #include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/angle_hybrid.h b/src/angle_hybrid.h index 4fde71e43f..730d55b0e2 100644 --- a/src/angle_hybrid.h +++ b/src/angle_hybrid.h @@ -20,7 +20,6 @@ AngleStyle(hybrid,AngleHybrid) #ifndef LMP_ANGLE_HYBRID_H #define LMP_ANGLE_HYBRID_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/angle_zero.h b/src/angle_zero.h index b91be5c8d7..bc1ce0725f 100644 --- a/src/angle_zero.h +++ b/src/angle_zero.h @@ -20,7 +20,6 @@ AngleStyle(zero,AngleZero) #ifndef LMP_ANGLE_ZERO_H #define LMP_ANGLE_ZERO_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/atom.cpp b/src/atom.cpp index 1f5d5a80c4..8176039165 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include -#include #include #include #include -#include #include "atom.h" #include "style_atom.h" #include "atom_vec.h" @@ -28,14 +26,12 @@ #include "fix.h" #include "compute.h" #include "output.h" -#include "thermo.h" #include "update.h" #include "domain.h" #include "group.h" #include "input.h" #include "variable.h" #include "molecule.h" -#include "atom_masks.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/bond.h b/src/bond.h index f9fb9384ed..5c3b933083 100644 --- a/src/bond.h +++ b/src/bond.h @@ -14,7 +14,6 @@ #ifndef LMP_BOND_H #define LMP_BOND_H -#include #include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/dihedral.h b/src/dihedral.h index 8654132ed5..ed6c02c5b9 100644 --- a/src/dihedral.h +++ b/src/dihedral.h @@ -14,7 +14,6 @@ #ifndef LMP_DIHEDRAL_H #define LMP_DIHEDRAL_H -#include #include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/dump.h b/src/dump.h index d42e7f1f39..0173aa3112 100644 --- a/src/dump.h +++ b/src/dump.h @@ -15,7 +15,6 @@ #define LMP_DUMP_H #include -#include #include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/improper.h b/src/improper.h index 4af5ad4a35..234dc9cb20 100644 --- a/src/improper.h +++ b/src/improper.h @@ -14,7 +14,6 @@ #ifndef LMP_IMPROPER_H #define LMP_IMPROPER_H -#include #include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/pointers.h b/src/pointers.h index fc359a5667..f9ef229c90 100644 --- a/src/pointers.h +++ b/src/pointers.h @@ -23,7 +23,7 @@ #include "lmptype.h" // IWYU pragma: export #include -#include +#include // IWYU pragma: export #include "lammps.h" // IWYU pragma: export namespace LAMMPS_NS { -- GitLab From 60adaa24cb8f19d9effc6da6f1ea6967c736a947 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 27 Jun 2019 08:52:34 -0600 Subject: [PATCH 115/469] Remove redundant computation --- src/KOKKOS/sna_kokkos_impl.h | 22 ---------------------- src/SNAP/sna.cpp | 22 ---------------------- 2 files changed, 44 deletions(-) diff --git a/src/KOKKOS/sna_kokkos_impl.h b/src/KOKKOS/sna_kokkos_impl.h index e3ce1626d9..9b96cb8a16 100644 --- a/src/KOKKOS/sna_kokkos_impl.h +++ b/src/KOKKOS/sna_kokkos_impl.h @@ -1006,11 +1006,9 @@ void SNAKokkos::compute_duarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy Date: Thu, 27 Jun 2019 08:53:58 -0600 Subject: [PATCH 116/469] Remove no-op --- src/SNAP/sna.cpp | 2 -- 1 file changed, 2 deletions(-) diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp index 949e0ee071..ada3f528d2 100644 --- a/src/SNAP/sna.cpp +++ b/src/SNAP/sna.cpp @@ -610,8 +610,6 @@ void SNA::compute_bi() sumzu += 0.5*(ulisttot_r[jju]*zlist_r[jjz] + ulisttot_i[jju]*zlist_i[jjz]); - jjz++; - jju++; } // end if jeven blist[jjb] = 2.0*sumzu; -- GitLab From 48220b39b5813b8144a9ca8aa6dd37aa688b238f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 10:13:43 -0400 Subject: [PATCH 117/469] include explicitly in .cpp files, though --- src/angle_hybrid.cpp | 1 + src/atom.cpp | 2 +- src/atom_map.cpp | 2 ++ src/atom_vec.cpp | 1 + src/atom_vec.h | 3 +-- src/atom_vec_body.h | 1 - 6 files changed, 6 insertions(+), 4 deletions(-) diff --git a/src/angle_hybrid.cpp b/src/angle_hybrid.cpp index 47baf770a5..48bb241100 100644 --- a/src/angle_hybrid.cpp +++ b/src/angle_hybrid.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include +#include #include #include #include "angle_hybrid.h" diff --git a/src/atom.cpp b/src/atom.cpp index 8176039165..b79febfc20 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include +#include #include #include #include @@ -25,7 +26,6 @@ #include "modify.h" #include "fix.h" #include "compute.h" -#include "output.h" #include "update.h" #include "domain.h" #include "group.h" diff --git a/src/atom_map.cpp b/src/atom_map.cpp index e9cd590624..35d7435ae2 100644 --- a/src/atom_map.cpp +++ b/src/atom_map.cpp @@ -11,6 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "lmptype.h" +#include #include #include "atom.h" #include "comm.h" diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index a7ca6fcb19..91e1980dd0 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include #include "atom_vec.h" diff --git a/src/atom_vec.h b/src/atom_vec.h index 87fb35d9c7..26c181be1e 100644 --- a/src/atom_vec.h +++ b/src/atom_vec.h @@ -14,8 +14,7 @@ #ifndef LMP_ATOM_VEC_H #define LMP_ATOM_VEC_H -#include -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/atom_vec_body.h b/src/atom_vec_body.h index 4d02c4b3e0..09f03caca1 100644 --- a/src/atom_vec_body.h +++ b/src/atom_vec_body.h @@ -112,7 +112,6 @@ class AtomVecBody : public AtomVec { void grow_bonus(); void copy_bonus(int, int); - //void check(int); }; } -- GitLab From 121947e79d33d2d997bf705ec9b656da2c1edae3 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Thu, 27 Jun 2019 12:52:20 -0500 Subject: [PATCH 118/469] Added hcp query example to kim_commands --- doc/src/kim_commands.txt | 22 +++++++++++++++++++++- 1 file changed, 21 insertions(+), 1 deletion(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 48637ae722..66319d7a08 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -352,7 +352,7 @@ webpage at "https://query.openkim.org"_https://query.openkim.org/ The data obtained by {kim_query} commands can be used as part of the setup or analysis phases of LAMMPS simulations. Some examples are given below. -[Define a crystal at its equilibrium lattice constant] +[Define an equilibrium fcc crystal] kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal boundary p p p @@ -373,6 +373,26 @@ Note that in {unit_conversion_mode} the results obtained from a For example, in the above script, the lattice command would need to be changed to: "lattice fcc $\{a0\}*$\{_u_distance\}". +[Define an equilibrium hcp crystal] + +kim_init EAM_Dynamo_Mendelev_2007_Zr__MO_848899341753_000 metal +boundary p p p +kim_query latconst get_lattice_constant_hcp species=\["Zr"\] units=\["angstrom"\] +variable a0 equal latconst_1 +variable c0 equal latconst_2 +variable c_to_a equal $\{c0\}/$\{a0\} +lattice custom $\{a0\} a1 0.5 -0.866025 0 a2 0.5 0.866025 0 a3 0 0 $\{c_to_a\} & + basis 0.333333 0.666666 0.25 basis 0.666666 0.333333 0.75 +... :pre + +In this case the {kim_query} returns two arguments (since the hexagonal +close packed (hcp) structure has two independent lattice constants). +In the case where a query returns multiple results, the default behavior +for {kim_query} is to split these into individual variables of the form +{prefix_I}, where {prefix} is set to the the {kim_query} {variable} argument +and {I} ranges from 1 to the number of returned values. The number and order of +the returned values is determined by the type of query performed. + [Define a crystal at finite temperature accounting for thermal expansion] kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal -- GitLab From 03099d6e54e8b5832e945b32b81afcfeb3a3440b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 17:11:53 -0400 Subject: [PATCH 119/469] some more include file consistency changes --- src/atom_vec_body.cpp | 3 +-- src/atom_vec_body.h | 1 - src/atom_vec_ellipsoid.cpp | 2 +- src/atom_vec_line.cpp | 1 - src/atom_vec_sphere.cpp | 2 -- src/atom_vec_tri.cpp | 1 - src/balance.cpp | 3 --- src/balance.h | 1 - src/body.cpp | 3 --- src/body.h | 1 - src/bond.cpp | 2 +- src/bond_hybrid.cpp | 4 ++-- src/pointers.h | 5 +++++ 13 files changed, 10 insertions(+), 19 deletions(-) diff --git a/src/atom_vec_body.cpp b/src/atom_vec_body.cpp index d5f286c077..3e9528d6b9 100644 --- a/src/atom_vec_body.cpp +++ b/src/atom_vec_body.cpp @@ -11,17 +11,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include #include "atom_vec_body.h" +#include "my_pool_chunk.h" #include "style_body.h" #include "body.h" #include "atom.h" #include "comm.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "memory.h" #include "error.h" diff --git a/src/atom_vec_body.h b/src/atom_vec_body.h index 09f03caca1..38309648fb 100644 --- a/src/atom_vec_body.h +++ b/src/atom_vec_body.h @@ -21,7 +21,6 @@ AtomStyle(body,AtomVecBody) #define LMP_ATOM_VEC_BODY_H #include "atom_vec.h" -#include "my_pool_chunk.h" namespace LAMMPS_NS { diff --git a/src/atom_vec_ellipsoid.cpp b/src/atom_vec_ellipsoid.cpp index 2bf3f683d0..ad167bef79 100644 --- a/src/atom_vec_ellipsoid.cpp +++ b/src/atom_vec_ellipsoid.cpp @@ -16,11 +16,11 @@ ------------------------------------------------------------------------- */ #include +#include #include "atom_vec_ellipsoid.h" #include "math_extra.h" #include "atom.h" #include "comm.h" -#include "force.h" #include "domain.h" #include "modify.h" #include "fix.h" diff --git a/src/atom_vec_line.cpp b/src/atom_vec_line.cpp index 020b622c93..6b197d2663 100644 --- a/src/atom_vec_line.cpp +++ b/src/atom_vec_line.cpp @@ -19,7 +19,6 @@ #include "comm.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "math_const.h" #include "memory.h" diff --git a/src/atom_vec_sphere.cpp b/src/atom_vec_sphere.cpp index dec98e5200..b3f4bfe391 100644 --- a/src/atom_vec_sphere.cpp +++ b/src/atom_vec_sphere.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include #include "atom_vec_sphere.h" @@ -19,7 +18,6 @@ #include "comm.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "fix_adapt.h" #include "math_const.h" diff --git a/src/atom_vec_tri.cpp b/src/atom_vec_tri.cpp index 8fbe0a92dc..b0b6eca19b 100644 --- a/src/atom_vec_tri.cpp +++ b/src/atom_vec_tri.cpp @@ -20,7 +20,6 @@ #include "comm.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "math_const.h" #include "memory.h" diff --git a/src/balance.cpp b/src/balance.cpp index 61ac895467..04f342b69b 100644 --- a/src/balance.cpp +++ b/src/balance.cpp @@ -20,7 +20,6 @@ #include #include -#include #include #include "balance.h" #include "atom.h" @@ -30,7 +29,6 @@ #include "domain.h" #include "force.h" #include "update.h" -#include "group.h" #include "modify.h" #include "fix_store.h" #include "imbalance.h" @@ -39,7 +37,6 @@ #include "imbalance_neigh.h" #include "imbalance_store.h" #include "imbalance_var.h" -#include "timer.h" #include "memory.h" #include "error.h" diff --git a/src/balance.h b/src/balance.h index 420031502a..424da33757 100644 --- a/src/balance.h +++ b/src/balance.h @@ -20,7 +20,6 @@ CommandStyle(balance,Balance) #ifndef LMP_BALANCE_H #define LMP_BALANCE_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/body.cpp b/src/body.cpp index 78e2f5d71b..10f88bd43b 100644 --- a/src/body.cpp +++ b/src/body.cpp @@ -11,11 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include #include "body.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/body.h b/src/body.h index 59001620f8..44581b75f6 100644 --- a/src/body.h +++ b/src/body.h @@ -16,7 +16,6 @@ #include "pointers.h" #include "atom_vec_body.h" -#include "my_pool_chunk.h" namespace LAMMPS_NS { diff --git a/src/bond.cpp b/src/bond.cpp index edcd869425..0d50b7e3e5 100644 --- a/src/bond.cpp +++ b/src/bond.cpp @@ -11,7 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include "bond.h" #include "atom.h" #include "comm.h" diff --git a/src/bond_hybrid.cpp b/src/bond_hybrid.cpp index 65609b4b6e..0fb23a3214 100644 --- a/src/bond_hybrid.cpp +++ b/src/bond_hybrid.cpp @@ -11,13 +11,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include +#include #include #include #include "bond_hybrid.h" #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/pointers.h b/src/pointers.h index f9ef229c90..5df5b72d47 100644 --- a/src/pointers.h +++ b/src/pointers.h @@ -39,6 +39,11 @@ namespace LAMMPS_NS { enum ExecutionSpace{Host,Device}; +// global forward declarations + +template class MyPoolChunk; +template class MyPage; + class Pointers { public: Pointers(LAMMPS *ptr) : -- GitLab From 2c0a66b7f8c21ea580dc7bb893461d3585969559 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 20:50:25 -0400 Subject: [PATCH 120/469] increase buffer size of fix tune/kspace. header cleanup. remove use of iostreams --- src/KSPACE/fix_tune_kspace.cpp | 41 +++++++++++++++++----------------- src/KSPACE/fix_tune_kspace.h | 9 ++++---- 2 files changed, 24 insertions(+), 26 deletions(-) diff --git a/src/KSPACE/fix_tune_kspace.cpp b/src/KSPACE/fix_tune_kspace.cpp index 0c726985dc..2b22b44340 100644 --- a/src/KSPACE/fix_tune_kspace.cpp +++ b/src/KSPACE/fix_tune_kspace.cpp @@ -15,13 +15,11 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include #include -#include +#include #include "fix_tune_kspace.h" #include "update.h" -#include "domain.h" -#include "atom.h" -#include "comm.h" #include "force.h" #include "kspace.h" #include "pair.h" @@ -31,9 +29,6 @@ #include "neighbor.h" #include "modify.h" #include "compute.h" -#include -#include -#include #define SWAP(a,b) {temp=(a);(a)=(b);(b)=temp;} #define SIGN(a,b) ((b) >= 0.0 ? fabs(a) : -fabs(a)) #define GOLD 1.618034 @@ -101,7 +96,7 @@ void FixTuneKspace::init() double old_acc = force->kspace->accuracy/force->kspace->two_charge_force; char old_acc_str[16]; snprintf(old_acc_str,16,"%g",old_acc); - strcpy(new_acc_str,old_acc_str); + strncpy(new_acc_str,old_acc_str,16); int itmp; double *p_cutoff = (double *) force->pair->extract("cut_coul",itmp); @@ -131,36 +126,37 @@ void FixTuneKspace::pre_exchange() // test Ewald store_old_kspace_settings(); strcpy(new_kspace_style,"ewald"); - sprintf(new_pair_style,"%s/long",base_pair_style); + snprintf(new_pair_style,64,"%s/long",base_pair_style); update_pair_style(new_pair_style,pair_cut_coul); update_kspace_style(new_kspace_style,new_acc_str); } else if (niter == 2) { // test PPPM store_old_kspace_settings(); strcpy(new_kspace_style,"pppm"); - sprintf(new_pair_style,"%s/long",base_pair_style); + snprintf(new_pair_style,64,"%s/long",base_pair_style); update_pair_style(new_pair_style,pair_cut_coul); update_kspace_style(new_kspace_style,new_acc_str); } else if (niter == 3) { // test MSM store_old_kspace_settings(); strcpy(new_kspace_style,"msm"); - sprintf(new_pair_style,"%s/msm",base_pair_style); + snprintf(new_pair_style,64,"%s/msm",base_pair_style); update_pair_style(new_pair_style,pair_cut_coul); update_kspace_style(new_kspace_style,new_acc_str); } else if (niter == 4) { store_old_kspace_settings(); - cout << "ewald_time = " << ewald_time << endl; - cout << "pppm_time = " << pppm_time << endl; - cout << "msm_time = " << msm_time << endl; + if (screen) fprintf(screen,"ewald_time = %g\npppm_time = %g\nmsm_time = %g", + ewald_time, pppm_time, msm_time); + if (logfile) fprintf(logfile,"ewald_time = %g\npppm_time = %g\nmsm_time = %g", + ewald_time, pppm_time, msm_time); // switch to fastest one strcpy(new_kspace_style,"ewald"); - sprintf(new_pair_style,"%s/long",base_pair_style); + snprintf(new_pair_style,64,"%s/long",base_pair_style); if (pppm_time < ewald_time && pppm_time < msm_time) strcpy(new_kspace_style,"pppm"); else if (msm_time < pppm_time && msm_time < ewald_time) { strcpy(new_kspace_style,"msm"); - sprintf(new_pair_style,"%s/msm",base_pair_style); + snprintf(new_pair_style,64,"%s/msm",base_pair_style); } update_pair_style(new_pair_style,pair_cut_coul); update_kspace_style(new_kspace_style,new_acc_str); @@ -243,8 +239,8 @@ void FixTuneKspace::update_pair_style(char *new_pair_style, p_pair_settings_file = tmpfile(); force->pair->write_restart(p_pair_settings_file); rewind(p_pair_settings_file); - - cout << "Creating new pair style: " << new_pair_style << endl; + if (screen) fprintf(screen,"Creating new pair style: %s\n",new_pair_style); + if (logfile) fprintf(logfile,"Creating new pair style: %s\n",new_pair_style); // delete old pair style and create new one force->create_pair(new_pair_style,1); @@ -253,7 +249,8 @@ void FixTuneKspace::update_pair_style(char *new_pair_style, double *pcutoff = (double *) force->pair->extract("cut_coul",itmp); double current_cutoff = *pcutoff; - cout << "Coulomb cutoff for real space: " << current_cutoff << endl; + if (screen) fprintf(screen,"Coulomb cutoff for real space: %g\n", current_cutoff); + if (logfile) fprintf(logfile,"Coulomb cutoff for real space: %g\n", current_cutoff); // close temporary file fclose(p_pair_settings_file); @@ -321,7 +318,8 @@ void FixTuneKspace::adjust_rcut(double time) int itmp; double *p_cutoff = (double *) force->pair->extract("cut_coul",itmp); double current_cutoff = *p_cutoff; - cout << "Old Coulomb cutoff for real space: " << current_cutoff << endl; + if (screen) fprintf(screen,"Old Coulomb cutoff for real space: %g\n",current_cutoff); + if (logfile) fprintf(logfile,"Old Coulomb cutoff for real space: %g\n",current_cutoff); // use Brent's method from Numerical Recipes to find optimal real space cutoff @@ -391,7 +389,8 @@ void FixTuneKspace::adjust_rcut(double time) // report the new cutoff double *new_cutoff = (double *) force->pair->extract("cut_coul",itmp); current_cutoff = *new_cutoff; - cout << "Adjusted Coulomb cutoff for real space: " << current_cutoff << endl; + if (screen) fprintf(screen,"Adjusted Coulomb cutoff for real space: %g\n", current_cutoff); + if (logfile) fprintf(logfile,"Adjusted Coulomb cutoff for real space: %g\n", current_cutoff); store_old_kspace_settings(); update_pair_style(new_pair_style,pair_cut_coul); diff --git a/src/KSPACE/fix_tune_kspace.h b/src/KSPACE/fix_tune_kspace.h index 6f40fc8711..1ccd735317 100644 --- a/src/KSPACE/fix_tune_kspace.h +++ b/src/KSPACE/fix_tune_kspace.h @@ -20,7 +20,6 @@ FixStyle(tune/kspace,FixTuneKspace) #ifndef LMP_FIX_TUNE_KSPACE_H #define LMP_FIX_TUNE_KSPACE_H -#include #include "fix.h" namespace LAMMPS_NS { @@ -52,10 +51,10 @@ class FixTuneKspace : public Fix { double ewald_time,pppm_time,msm_time; double pair_cut_coul; - char new_acc_str[12]; - char new_kspace_style[20]; - char new_pair_style[20]; - char base_pair_style[20]; + char new_acc_str[16]; + char new_kspace_style[64]; + char new_pair_style[64]; + char base_pair_style[64]; int old_differentiation_flag; int old_slabflag; -- GitLab From 932f052cbf0cf4e94a4df52bbe3414dfeca90959 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 20:52:23 -0400 Subject: [PATCH 121/469] more header cleanup --- src/GPU/pair_vashishta_gpu.cpp | 1 - src/angle_deprecated.cpp | 1 - src/angle_hybrid.cpp | 1 - src/atom.cpp | 1 - src/atom_map.cpp | 2 +- src/atom_vec.cpp | 1 - src/atom_vec_hybrid.h | 1 - src/bond_zero.cpp | 4 ++-- src/change_box.cpp | 1 - src/citeme.cpp | 3 +-- src/citeme.h | 3 +-- src/comm.cpp | 1 + src/comm_brick.cpp | 8 -------- src/hashlittle.cpp | 2 +- src/lammps.cpp | 1 + 15 files changed, 8 insertions(+), 23 deletions(-) diff --git a/src/GPU/pair_vashishta_gpu.cpp b/src/GPU/pair_vashishta_gpu.cpp index b496359b8a..5539653756 100644 --- a/src/GPU/pair_vashishta_gpu.cpp +++ b/src/GPU/pair_vashishta_gpu.cpp @@ -14,7 +14,6 @@ /* ---------------------------------------------------------------------- Contributing author: Anders Hafreager (UiO) ------------------------------------------------------------------------- */ -#include #include #include #include diff --git a/src/angle_deprecated.cpp b/src/angle_deprecated.cpp index 73fcccc53a..b5af217b7b 100644 --- a/src/angle_deprecated.cpp +++ b/src/angle_deprecated.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include -#include #include "angle_deprecated.h" #include "angle_hybrid.h" #include "comm.h" diff --git a/src/angle_hybrid.cpp b/src/angle_hybrid.cpp index 48bb241100..47baf770a5 100644 --- a/src/angle_hybrid.cpp +++ b/src/angle_hybrid.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include #include "angle_hybrid.h" diff --git a/src/atom.cpp b/src/atom.cpp index b79febfc20..eab8a3063d 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -13,7 +13,6 @@ #include #include -#include #include #include #include "atom.h" diff --git a/src/atom_map.cpp b/src/atom_map.cpp index 35d7435ae2..b14ebdba68 100644 --- a/src/atom_map.cpp +++ b/src/atom_map.cpp @@ -11,7 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "lmptype.h" +#include "pointers.h" #include #include #include "atom.h" diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index 91e1980dd0..a7ca6fcb19 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include #include "atom_vec.h" diff --git a/src/atom_vec_hybrid.h b/src/atom_vec_hybrid.h index a027923a17..8129baccba 100644 --- a/src/atom_vec_hybrid.h +++ b/src/atom_vec_hybrid.h @@ -20,7 +20,6 @@ AtomStyle(hybrid,AtomVecHybrid) #ifndef LMP_ATOM_VEC_HYBRID_H #define LMP_ATOM_VEC_HYBRID_H -#include #include "atom_vec.h" namespace LAMMPS_NS { diff --git a/src/bond_zero.cpp b/src/bond_zero.cpp index 0847cf9e6b..3932846cb4 100644 --- a/src/bond_zero.cpp +++ b/src/bond_zero.cpp @@ -15,8 +15,8 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ -#include -#include +#include +#include #include #include "bond_zero.h" #include "atom.h" diff --git a/src/change_box.cpp b/src/change_box.cpp index b7d3cb245f..1fed65b430 100644 --- a/src/change_box.cpp +++ b/src/change_box.cpp @@ -13,7 +13,6 @@ #include #include -#include #include #include "change_box.h" #include "atom.h" diff --git a/src/citeme.cpp b/src/citeme.cpp index d021722671..24896b448c 100644 --- a/src/citeme.cpp +++ b/src/citeme.cpp @@ -11,10 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include "citeme.h" -#include "version.h" #include "universe.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/citeme.h b/src/citeme.h index 262b284337..c383ec2227 100644 --- a/src/citeme.h +++ b/src/citeme.h @@ -15,7 +15,6 @@ #define LMP_CITEME_H #include "pointers.h" -#include #include namespace LAMMPS_NS { @@ -29,7 +28,7 @@ class CiteMe : protected Pointers { private: FILE *fp; // opaque pointer to log.cite file object typedef std::set citeset; - citeset *cs; // registered set of publications + citeset *cs; // registered set of publications }; } diff --git a/src/comm.cpp b/src/comm.cpp index 052de93793..5f846cf292 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -21,6 +21,7 @@ #include "force.h" #include "pair.h" #include "modify.h" +#include "neighbor.h" #include "fix.h" #include "compute.h" #include "domain.h" diff --git a/src/comm_brick.cpp b/src/comm_brick.cpp index 330551aaed..47f60a3da6 100644 --- a/src/comm_brick.cpp +++ b/src/comm_brick.cpp @@ -19,23 +19,15 @@ #include #include #include -#include #include "comm_brick.h" -#include "comm_tiled.h" -#include "universe.h" #include "atom.h" #include "atom_vec.h" -#include "force.h" #include "pair.h" #include "domain.h" #include "neighbor.h" -#include "group.h" -#include "modify.h" #include "fix.h" #include "compute.h" -#include "output.h" #include "dump.h" -#include "math_extra.h" #include "error.h" #include "memory.h" diff --git a/src/hashlittle.cpp b/src/hashlittle.cpp index f612be9eeb..42109abd24 100644 --- a/src/hashlittle.cpp +++ b/src/hashlittle.cpp @@ -3,7 +3,7 @@ // bob_jenkins@burtleburtle.net #include -#include +#include #include // if the system defines the __BYTE_ORDER__ define, diff --git a/src/lammps.cpp b/src/lammps.cpp index 320d89ed52..83a2f057ee 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include +#include #include #include #include -- GitLab From 9c53a5ca3f1c756601b091a97ea5020a7187d2e5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 21:40:28 -0400 Subject: [PATCH 122/469] add first draft of a summary of the rules for include files --- doc/include-file-conventions.md | 125 ++++++++++++++++++++++++++++++++ 1 file changed, 125 insertions(+) create mode 100644 doc/include-file-conventions.md diff --git a/doc/include-file-conventions.md b/doc/include-file-conventions.md new file mode 100644 index 0000000000..5152051ba5 --- /dev/null +++ b/doc/include-file-conventions.md @@ -0,0 +1,125 @@ +# Outline of include file conventions in LAMMPS + +This purpose of this document is to provide a point of reference +for LAMMPS developers and contributors as to what include files +and definitions to put where into LAMMPS source. +Last change 2019-06-27 + +## Table of Contents + + * [Motivation](#motivation) + * [Rules](#rules) + * [Tools](#tools) + * [Legacy Code](#legacy-code) + +## Motivation + +The conventions outlined in this document are supposed to help making +maintenance of the LAMMPS software easier. By trying to achieve +consistency across files contributed by different developers, it will +become easier to modify and adjust files by the code maintainers, and +overall the chance for errors or portability issues will be reduced. +Also the rules employed are supposed to minimize naming conflicts and +simplify dependencies between files (and thus speed up compilation), as +well as make otherwise hidden dependencies visible. + +## Rules + +Below are the various rules that are applied. Not all a enforced +strictly and automatically. If there are no significant side effects, +exceptions may be possible for cases, where a full compliance to the +rules may require a large effort compared to the benefit. + +### Core Files Versus Package Files + +All rules listed below are most strictly observed for core LAMMPS files. +Which are the files that are not part of a package and files of the +packages MOLECULE, MANYBODY, KSPACE, and RIGID. On the other end of +the spectrum are USER packages and legacy packages that predate these +rules and thus may not be fully compliant. Also new contributions +will be checked more closely, while existing code is incrementally +adapted to the rules as time and required effort permits. + +### System Versus Local Header Files + +All system or library provided include files are included with angular +brackets (examples: `#include ` or `#include `) while +include files provided with LAMMPS are included with double quotes +(examples: `#include "pointers.h"` or `#include "compute_temp.h"`). + +For headers declaring functions of the C-library, the corresponding +C++ versions should be included (examples: `#include ` or +`#include `). However, those are limited to those defined +in the C++98 standard. Some files thus must use the older style unless +the minimum C++ standard requirement of LAMMPS is lifted to C++11 or +even beyond (examples: `#include ` versus `#include ` +or `#include ` versus `#include `). + +### C++ Standard Compliance + +LAMMPS core files currently correspond to the C++98 standard. Files +requiring C++11 or later are only permitted in (optional) packages +and particularly packages that are not part of the list of commonly +used packages like MOLECULE, KSPACE, MANYBODY, or RIGID. + +Also, LAMMPS uses the C-style stdio library for I/O instead of iostreams. +Since using both at the same time can cause problems, iostreams should +be avoided where possible. + +### Lean Header Files + +Header files will typically contain the definition of a (single) class. +These header files should have as few include statements as possible. +This is particularly important for classes that implement a "style" and +thus use a macro of the kind `SomeStyle(some/name,SomeName)`. These will +be all included in the auto-generated `"some_style.h"` files which will +result in a high potential for direct or indirect symbol name clashes. + +In the ideal case, the header would only include one file defining the +parent class. That would typically be either `#include "pointers.h"` for +the `Pointers` class, or a header of a class derived from it like +`#include "pair.h"` for the `Pair` class and so on. Referenced to other +classes inside the class should be make through pointers, for which forward +declarations (inside the `LAMMPS_NS` or the new class'es namespace) can +be employed. The full definition will then be included into the corresponding +implementation file. In the given example from above, the header file +would be called `some_name.h` and the implementation `some_name.cpp` (all +lower case with underscores, while the class itself would be in camel case +and no underscores, and the style name with lower case names separated by +a forward slash). + +### Implementation Files + +In the implementation files (typically, those would have the same base name +as the corresponding header with a .cpp extension instead of .h) include +statments should follow the "include what you use" principle. + +### Special Cases and Exceptions + +#### pointers.h + +The `pointer.h` header file also includes `cstdio` and `lmptype.h` +(and throught it `stdint.h`, `intttypes.h`, and `climits`). +This means any header including `pointers.h` can assume that `FILE`, +`NULL`, `INT_MAX` are defined. + +## Tools + +The [Include What You Use tool](https://include-what-you-use.org/) +can be used to provide supporting information about compliance with +the rules listed here. There are some limitations and the IWWU tool +may give incorrect advice. The tools is activated by setting the +CMake variable `CMAKE_CXX_INCLUDE_WHAT_YOU_USE` variable to the +path of the `include-what-you-use` command. When activated, the +tool will be run after each compilation and provide suggestions for +which include files should be added or removed. + +## Legacy Code + +A lot of code predates the application of the rules in this document, +and those rules are a moving target as well. So there is going to be +significant chunks of code, that does not fully comply. This applies +for example to the USER-REAXC, or the USER-ATC package. The LAMMPS +developers are dedicated to make an effort to improve the compliance +and welcome volunteers wanting to help with the process. + -- GitLab From 86a9e4fca24a7cefc832333a3ff75a057763e370 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 21:40:50 -0400 Subject: [PATCH 123/469] make body package compile again --- src/BODY/body_nparticle.cpp | 1 + src/BODY/body_rounded_polygon.cpp | 1 + src/BODY/body_rounded_polyhedron.cpp | 1 + 3 files changed, 3 insertions(+) diff --git a/src/BODY/body_nparticle.cpp b/src/BODY/body_nparticle.cpp index 10529ad3af..21070107f5 100644 --- a/src/BODY/body_nparticle.cpp +++ b/src/BODY/body_nparticle.cpp @@ -13,6 +13,7 @@ #include #include "body_nparticle.h" +#include "my_pool_chunk.h" #include "math_extra.h" #include "atom_vec_body.h" #include "atom.h" diff --git a/src/BODY/body_rounded_polygon.cpp b/src/BODY/body_rounded_polygon.cpp index d352c789d7..f7741ada88 100644 --- a/src/BODY/body_rounded_polygon.cpp +++ b/src/BODY/body_rounded_polygon.cpp @@ -17,6 +17,7 @@ #include #include "body_rounded_polygon.h" +#include "my_pool_chunk.h" #include "atom_vec_body.h" #include "atom.h" #include "force.h" diff --git a/src/BODY/body_rounded_polyhedron.cpp b/src/BODY/body_rounded_polyhedron.cpp index 99a380a932..34d918f1f6 100644 --- a/src/BODY/body_rounded_polyhedron.cpp +++ b/src/BODY/body_rounded_polyhedron.cpp @@ -17,6 +17,7 @@ #include #include "body_rounded_polyhedron.h" +#include "my_pool_chunk.h" #include "atom_vec_body.h" #include "atom.h" #include "force.h" -- GitLab From 4ec3a508fc1731e5d6d3708005515ff0addace9f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 21:54:07 -0400 Subject: [PATCH 124/469] bulk removal of #include from header files --- src/CLASS2/angle_class2.h | 1 - src/CLASS2/bond_class2.h | 1 - src/CLASS2/dihedral_class2.h | 1 - src/CLASS2/improper_class2.h | 1 - src/GPU/pair_eam_gpu.h | 1 - src/KOKKOS/atom_vec_hybrid_kokkos.h | 1 - src/KOKKOS/pair_eam_alloy_kokkos.h | 1 - src/KOKKOS/pair_eam_fs_kokkos.h | 1 - src/KOKKOS/pair_eam_kokkos.h | 1 - src/KOKKOS/pair_hybrid_kokkos.h | 1 - src/KOKKOS/pair_reaxc_kokkos.h | 1 - src/KOKKOS/pair_tersoff_kokkos.h | 1 - src/KOKKOS/pair_tersoff_mod_kokkos.h | 1 - src/KOKKOS/pair_tersoff_zbl_kokkos.h | 1 - src/MANYBODY/fix_qeq_comb.h | 1 - src/MANYBODY/pair_eam.h | 1 - src/MANYBODY/pair_eim.h | 1 - src/MC/fix_atom_swap.h | 1 - src/MC/fix_gcmc.h | 1 - src/MISC/fix_deposit.h | 1 - src/MOLECULE/angle_charmm.h | 1 - src/MOLECULE/angle_cosine.h | 1 - src/MOLECULE/angle_cosine_delta.h | 1 - src/MOLECULE/angle_cosine_periodic.h | 1 - src/MOLECULE/angle_cosine_squared.h | 1 - src/MOLECULE/angle_harmonic.h | 1 - src/MOLECULE/angle_table.h | 1 - src/MOLECULE/bond_fene.h | 1 - src/MOLECULE/bond_fene_expand.h | 1 - src/MOLECULE/bond_gromos.h | 1 - src/MOLECULE/bond_harmonic.h | 1 - src/MOLECULE/bond_morse.h | 1 - src/MOLECULE/bond_nonlinear.h | 1 - src/MOLECULE/bond_quartic.h | 1 - src/MOLECULE/bond_table.h | 1 - src/MOLECULE/dihedral_charmm.h | 1 - src/MOLECULE/dihedral_charmmfsw.h | 1 - src/MOLECULE/dihedral_harmonic.h | 1 - src/MOLECULE/dihedral_helix.h | 1 - src/MOLECULE/dihedral_multi_harmonic.h | 1 - src/MOLECULE/dihedral_opls.h | 1 - src/MOLECULE/improper_cvff.h | 1 - src/MOLECULE/improper_harmonic.h | 1 - src/MOLECULE/improper_umbrella.h | 1 - src/REPLICA/neb.h | 1 - src/SPIN/neb_spin.h | 1 - src/USER-CGDNA/mf_oxdna.h | 1 - src/USER-CGSDK/angle_sdk.h | 1 - src/USER-DIFFRACTION/fix_saed_vtk.h | 1 - src/USER-INTEL/angle_charmm_intel.h | 1 - src/USER-INTEL/angle_harmonic_intel.h | 1 - src/USER-INTEL/bond_fene_intel.h | 1 - src/USER-INTEL/bond_harmonic_intel.h | 1 - src/USER-INTEL/improper_cvff_intel.h | 1 - src/USER-INTEL/improper_harmonic_intel.h | 1 - src/USER-INTEL/intel_simd.h | 1 - src/USER-INTEL/pair_eam_intel.h | 1 - src/USER-MANIFOLD/manifold_thylakoid.h | 1 - src/USER-MGPT/mgpt_readpot.h | 1 - src/USER-MGPT/pair_mgpt.h | 1 - src/USER-MISC/angle_cosine_shift.h | 1 - src/USER-MISC/angle_cosine_shift_exp.h | 1 - src/USER-MISC/angle_dipole.h | 1 - src/USER-MISC/angle_fourier.h | 1 - src/USER-MISC/angle_fourier_simple.h | 1 - src/USER-MISC/angle_quartic.h | 1 - src/USER-MISC/bond_harmonic_shift.h | 1 - src/USER-MISC/bond_harmonic_shift_cut.h | 1 - src/USER-MISC/dihedral_cosine_shift_exp.h | 1 - src/USER-MISC/dihedral_fourier.h | 1 - src/USER-MISC/dihedral_nharmonic.h | 1 - src/USER-MISC/dihedral_quadratic.h | 1 - src/USER-MISC/dihedral_spherical.h | 1 - src/USER-MISC/fix_ave_correlate_long.h | 1 - src/USER-MISC/fix_srp.h | 1 - src/USER-MISC/improper_cossq.h | 1 - src/USER-MISC/improper_distance.h | 1 - src/USER-MISC/improper_fourier.h | 1 - src/USER-MISC/improper_ring.h | 1 - src/USER-MOFFF/angle_class2_p6.h | 1 - src/USER-MOFFF/angle_cosine_buck6d.h | 1 - src/USER-MOFFF/improper_inversion_harmonic.h | 1 - src/USER-REAXC/fix_reaxc_bonds.h | 1 - src/bond_hybrid.h | 1 - src/bond_zero.h | 1 - src/citeme.cpp | 1 - src/comm_brick.cpp | 1 - src/comm_tiled.cpp | 5 +---- src/comm_tiled.h | 1 + src/compute.cpp | 4 ---- src/compute_adf.h | 1 - src/compute_rdf.h | 1 - src/dihedral_hybrid.h | 1 - src/dihedral_zero.h | 1 - src/fix_ave_atom.h | 1 - src/fix_ave_chunk.h | 1 - src/fix_ave_correlate.h | 1 - src/fix_ave_histo.h | 1 - src/fix_ave_histo_weight.h | 1 - src/fix_ave_time.h | 1 - src/fix_balance.h | 1 - src/fix_halt.h | 1 - src/fix_move.h | 1 - src/fix_print.h | 1 - src/fix_store.h | 1 - src/fix_tmd.h | 1 - src/force.h | 1 - src/group.h | 1 - src/image.h | 1 - src/imbalance.h | 1 - src/improper_hybrid.h | 1 - src/improper_zero.h | 1 - src/input.h | 1 - src/lammps.h | 1 - src/modify.h | 1 - src/pair_hybrid.h | 1 - src/read_data.h | 1 - src/read_dump.h | 1 - src/read_restart.h | 1 - src/universe.h | 1 - src/variable.h | 1 - src/write_coeff.h | 1 - src/write_data.h | 1 - src/write_restart.h | 1 - 124 files changed, 2 insertions(+), 129 deletions(-) diff --git a/src/CLASS2/angle_class2.h b/src/CLASS2/angle_class2.h index 8444ada057..cc155747ac 100644 --- a/src/CLASS2/angle_class2.h +++ b/src/CLASS2/angle_class2.h @@ -20,7 +20,6 @@ AngleStyle(class2,AngleClass2) #ifndef LMP_ANGLE_CLASS2_H #define LMP_ANGLE_CLASS2_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/CLASS2/bond_class2.h b/src/CLASS2/bond_class2.h index 89d930b548..f0fcc6825e 100644 --- a/src/CLASS2/bond_class2.h +++ b/src/CLASS2/bond_class2.h @@ -20,7 +20,6 @@ BondStyle(class2,BondClass2) #ifndef LMP_BOND_CLASS2_H #define LMP_BOND_CLASS2_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/CLASS2/dihedral_class2.h b/src/CLASS2/dihedral_class2.h index a4ea9e4bd9..32cd289137 100644 --- a/src/CLASS2/dihedral_class2.h +++ b/src/CLASS2/dihedral_class2.h @@ -20,7 +20,6 @@ DihedralStyle(class2,DihedralClass2) #ifndef LMP_DIHEDRAL_CLASS2_H #define LMP_DIHEDRAL_CLASS2_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/CLASS2/improper_class2.h b/src/CLASS2/improper_class2.h index 1cc3417731..cac805046a 100644 --- a/src/CLASS2/improper_class2.h +++ b/src/CLASS2/improper_class2.h @@ -20,7 +20,6 @@ ImproperStyle(class2,ImproperClass2) #ifndef LMP_IMPROPER_CLASS2_H #define LMP_IMPROPER_CLASS2_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/GPU/pair_eam_gpu.h b/src/GPU/pair_eam_gpu.h index 099529f3df..e4742a3bef 100644 --- a/src/GPU/pair_eam_gpu.h +++ b/src/GPU/pair_eam_gpu.h @@ -20,7 +20,6 @@ PairStyle(eam/gpu,PairEAMGPU) #ifndef LMP_PAIR_EAM_GPU_H #define LMP_PAIR_EAM_GPU_H -#include #include "pair_eam.h" namespace LAMMPS_NS { diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.h b/src/KOKKOS/atom_vec_hybrid_kokkos.h index 1bbbd26319..4cfb186b17 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.h +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.h @@ -20,7 +20,6 @@ AtomStyle(hybrid/kk,AtomVecHybridKokkos) #ifndef LMP_ATOM_VEC_HYBRID_KOKKOS_H #define LMP_ATOM_VEC_HYBRID_KOKKOS_H -#include #include "atom_vec_kokkos.h" #include "kokkos_type.h" diff --git a/src/KOKKOS/pair_eam_alloy_kokkos.h b/src/KOKKOS/pair_eam_alloy_kokkos.h index 6593ccae73..e1dd9ab47d 100644 --- a/src/KOKKOS/pair_eam_alloy_kokkos.h +++ b/src/KOKKOS/pair_eam_alloy_kokkos.h @@ -23,7 +23,6 @@ PairStyle(eam/alloy/kk/host,PairEAMAlloyKokkos) #ifndef LMP_PAIR_EAM_ALLOY_KOKKOS_H #define LMP_PAIR_EAM_ALLOY_KOKKOS_H -#include #include "kokkos_base.h" #include "pair_kokkos.h" #include "pair_eam.h" diff --git a/src/KOKKOS/pair_eam_fs_kokkos.h b/src/KOKKOS/pair_eam_fs_kokkos.h index f75605ff6d..e93977869e 100644 --- a/src/KOKKOS/pair_eam_fs_kokkos.h +++ b/src/KOKKOS/pair_eam_fs_kokkos.h @@ -23,7 +23,6 @@ PairStyle(eam/fs/kk/host,PairEAMFSKokkos) #ifndef LMP_PAIR_EAM_FS_KOKKOS_H #define LMP_PAIR_EAM_FS_KOKKOS_H -#include #include "kokkos_base.h" #include "pair_kokkos.h" #include "pair_eam.h" diff --git a/src/KOKKOS/pair_eam_kokkos.h b/src/KOKKOS/pair_eam_kokkos.h index 4040eba858..3bf89c549a 100644 --- a/src/KOKKOS/pair_eam_kokkos.h +++ b/src/KOKKOS/pair_eam_kokkos.h @@ -23,7 +23,6 @@ PairStyle(eam/kk/host,PairEAMKokkos) #ifndef LMP_PAIR_EAM_KOKKOS_H #define LMP_PAIR_EAM_KOKKOS_H -#include #include "kokkos_base.h" #include "pair_kokkos.h" #include "pair_eam.h" diff --git a/src/KOKKOS/pair_hybrid_kokkos.h b/src/KOKKOS/pair_hybrid_kokkos.h index 94e034f875..799354cf01 100644 --- a/src/KOKKOS/pair_hybrid_kokkos.h +++ b/src/KOKKOS/pair_hybrid_kokkos.h @@ -20,7 +20,6 @@ PairStyle(hybrid/kk,PairHybridKokkos) #ifndef LMP_PAIR_HYBRID_KOKKOS_H #define LMP_PAIR_HYBRID_KOKKOS_H -#include #include "pair_hybrid.h" #include "pair_kokkos.h" #include "kokkos_type.h" diff --git a/src/KOKKOS/pair_reaxc_kokkos.h b/src/KOKKOS/pair_reaxc_kokkos.h index 89dfc4d884..783ea33c4e 100644 --- a/src/KOKKOS/pair_reaxc_kokkos.h +++ b/src/KOKKOS/pair_reaxc_kokkos.h @@ -23,7 +23,6 @@ PairStyle(reax/c/kk/host,PairReaxCKokkos) #ifndef LMP_PAIR_REAXC_KOKKOS_H #define LMP_PAIR_REAXC_KOKKOS_H -#include #include "pair_kokkos.h" #include "pair_reaxc.h" #include "neigh_list_kokkos.h" diff --git a/src/KOKKOS/pair_tersoff_kokkos.h b/src/KOKKOS/pair_tersoff_kokkos.h index f73d4fe2d8..7d41fe2346 100644 --- a/src/KOKKOS/pair_tersoff_kokkos.h +++ b/src/KOKKOS/pair_tersoff_kokkos.h @@ -23,7 +23,6 @@ PairStyle(tersoff/kk/host,PairTersoffKokkos) #ifndef LMP_PAIR_TERSOFF_KOKKOS_H #define LMP_PAIR_TERSOFF_KOKKOS_H -#include #include "pair_kokkos.h" #include "pair_tersoff.h" #include "neigh_list_kokkos.h" diff --git a/src/KOKKOS/pair_tersoff_mod_kokkos.h b/src/KOKKOS/pair_tersoff_mod_kokkos.h index d7c94ffc93..889e1eadfa 100644 --- a/src/KOKKOS/pair_tersoff_mod_kokkos.h +++ b/src/KOKKOS/pair_tersoff_mod_kokkos.h @@ -23,7 +23,6 @@ PairStyle(tersoff/mod/kk/host,PairTersoffMODKokkos) #ifndef LMP_PAIR_TERSOFF_MOD_KOKKOS_H #define LMP_PAIR_TERSOFF_MOD_KOKKOS_H -#include #include "pair_kokkos.h" #include "pair_tersoff_mod.h" #include "neigh_list_kokkos.h" diff --git a/src/KOKKOS/pair_tersoff_zbl_kokkos.h b/src/KOKKOS/pair_tersoff_zbl_kokkos.h index 3af4e0d8eb..0c7fa2e963 100644 --- a/src/KOKKOS/pair_tersoff_zbl_kokkos.h +++ b/src/KOKKOS/pair_tersoff_zbl_kokkos.h @@ -23,7 +23,6 @@ PairStyle(tersoff/zbl/kk/host,PairTersoffZBLKokkos) #ifndef LMP_PAIR_TERSOFF_ZBL_KOKKOS_H #define LMP_PAIR_TERSOFF_ZBL_KOKKOS_H -#include #include "pair_kokkos.h" #include "pair_tersoff_zbl.h" #include "neigh_list_kokkos.h" diff --git a/src/MANYBODY/fix_qeq_comb.h b/src/MANYBODY/fix_qeq_comb.h index dd4c9f7290..c3a0ac08f3 100644 --- a/src/MANYBODY/fix_qeq_comb.h +++ b/src/MANYBODY/fix_qeq_comb.h @@ -20,7 +20,6 @@ FixStyle(qeq/comb,FixQEQComb) #ifndef LMP_FIX_QEQ_COMB_H #define LMP_FIX_QEQ_COMB_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/MANYBODY/pair_eam.h b/src/MANYBODY/pair_eam.h index 234552157b..8bcb44c347 100644 --- a/src/MANYBODY/pair_eam.h +++ b/src/MANYBODY/pair_eam.h @@ -20,7 +20,6 @@ PairStyle(eam,PairEAM) #ifndef LMP_PAIR_EAM_H #define LMP_PAIR_EAM_H -#include #include "pair.h" namespace LAMMPS_NS { diff --git a/src/MANYBODY/pair_eim.h b/src/MANYBODY/pair_eim.h index 50f9934c44..f9fb2d5a77 100644 --- a/src/MANYBODY/pair_eim.h +++ b/src/MANYBODY/pair_eim.h @@ -20,7 +20,6 @@ PairStyle(eim,PairEIM) #ifndef LMP_PAIR_EIM_H #define LMP_PAIR_EIM_H -#include #include "pair.h" namespace LAMMPS_NS { diff --git a/src/MC/fix_atom_swap.h b/src/MC/fix_atom_swap.h index 19895704f1..a5ce89b16b 100644 --- a/src/MC/fix_atom_swap.h +++ b/src/MC/fix_atom_swap.h @@ -20,7 +20,6 @@ FixStyle(atom/swap,FixAtomSwap) #ifndef LMP_FIX_MCSWAP_H #define LMP_FIX_MCSWAP_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/MC/fix_gcmc.h b/src/MC/fix_gcmc.h index 5d0b7aab8f..da4232d19b 100644 --- a/src/MC/fix_gcmc.h +++ b/src/MC/fix_gcmc.h @@ -20,7 +20,6 @@ FixStyle(gcmc,FixGCMC) #ifndef LMP_FIX_GCMC_H #define LMP_FIX_GCMC_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/MISC/fix_deposit.h b/src/MISC/fix_deposit.h index 38958b80e7..e3104c890d 100644 --- a/src/MISC/fix_deposit.h +++ b/src/MISC/fix_deposit.h @@ -20,7 +20,6 @@ FixStyle(deposit,FixDeposit) #ifndef LMP_FIX_DEPOSIT_H #define LMP_FIX_DEPOSIT_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/angle_charmm.h b/src/MOLECULE/angle_charmm.h index 2228ad8732..444c833d37 100644 --- a/src/MOLECULE/angle_charmm.h +++ b/src/MOLECULE/angle_charmm.h @@ -20,7 +20,6 @@ AngleStyle(charmm,AngleCharmm) #ifndef LMP_ANGLE_CHARMM_H #define LMP_ANGLE_CHARMM_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/angle_cosine.h b/src/MOLECULE/angle_cosine.h index f2406bc5dd..ca1f4178f8 100644 --- a/src/MOLECULE/angle_cosine.h +++ b/src/MOLECULE/angle_cosine.h @@ -20,7 +20,6 @@ AngleStyle(cosine,AngleCosine) #ifndef LMP_ANGLE_COSINE_H #define LMP_ANGLE_COSINE_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/angle_cosine_delta.h b/src/MOLECULE/angle_cosine_delta.h index 1e19ecaf79..70b574b234 100644 --- a/src/MOLECULE/angle_cosine_delta.h +++ b/src/MOLECULE/angle_cosine_delta.h @@ -20,7 +20,6 @@ AngleStyle(cosine/delta,AngleCosineDelta) #ifndef LMP_ANGLE_COSINE_DELTA_H #define LMP_ANGLE_COSINE_DELTA_H -#include #include "angle_cosine_squared.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/angle_cosine_periodic.h b/src/MOLECULE/angle_cosine_periodic.h index e131e85101..f0188b6c17 100644 --- a/src/MOLECULE/angle_cosine_periodic.h +++ b/src/MOLECULE/angle_cosine_periodic.h @@ -20,7 +20,6 @@ AngleStyle(cosine/periodic, AngleCosinePeriodic) #ifndef LMP_ANGLE_PERIODIC_H #define LMP_ANGLE_PERIODIC_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/angle_cosine_squared.h b/src/MOLECULE/angle_cosine_squared.h index 8e8c84c0f9..a19a923850 100644 --- a/src/MOLECULE/angle_cosine_squared.h +++ b/src/MOLECULE/angle_cosine_squared.h @@ -20,7 +20,6 @@ AngleStyle(cosine/squared,AngleCosineSquared) #ifndef LMP_ANGLE_COSINE_SQUARED_H #define LMP_ANGLE_COSINE_SQUARED_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/angle_harmonic.h b/src/MOLECULE/angle_harmonic.h index e0c067653b..f371178d58 100644 --- a/src/MOLECULE/angle_harmonic.h +++ b/src/MOLECULE/angle_harmonic.h @@ -20,7 +20,6 @@ AngleStyle(harmonic,AngleHarmonic) #ifndef LMP_ANGLE_HARMONIC_H #define LMP_ANGLE_HARMONIC_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/angle_table.h b/src/MOLECULE/angle_table.h index 0088ace39b..46633d28cc 100644 --- a/src/MOLECULE/angle_table.h +++ b/src/MOLECULE/angle_table.h @@ -20,7 +20,6 @@ AngleStyle(table,AngleTable) #ifndef LMP_ANGLE_TABLE_H #define LMP_ANGLE_TABLE_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_fene.h b/src/MOLECULE/bond_fene.h index 58cd6ce289..1963e3ca22 100644 --- a/src/MOLECULE/bond_fene.h +++ b/src/MOLECULE/bond_fene.h @@ -20,7 +20,6 @@ BondStyle(fene,BondFENE) #ifndef LMP_BOND_FENE_H #define LMP_BOND_FENE_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_fene_expand.h b/src/MOLECULE/bond_fene_expand.h index cb316ac5f2..8cfc17dc68 100644 --- a/src/MOLECULE/bond_fene_expand.h +++ b/src/MOLECULE/bond_fene_expand.h @@ -20,7 +20,6 @@ BondStyle(fene/expand,BondFENEExpand) #ifndef LMP_BOND_FENE_EXPAND_H #define LMP_BOND_FENE_EXPAND_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_gromos.h b/src/MOLECULE/bond_gromos.h index c26ad64b3d..966b914437 100644 --- a/src/MOLECULE/bond_gromos.h +++ b/src/MOLECULE/bond_gromos.h @@ -20,7 +20,6 @@ BondStyle(gromos,BondGromos) #ifndef LMP_BOND_GROMOS_H #define LMP_BOND_GROMOS_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_harmonic.h b/src/MOLECULE/bond_harmonic.h index 5c692b2a8e..576e63629b 100644 --- a/src/MOLECULE/bond_harmonic.h +++ b/src/MOLECULE/bond_harmonic.h @@ -20,7 +20,6 @@ BondStyle(harmonic,BondHarmonic) #ifndef LMP_BOND_HARMONIC_H #define LMP_BOND_HARMONIC_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_morse.h b/src/MOLECULE/bond_morse.h index c4d60bc217..030a94a8da 100644 --- a/src/MOLECULE/bond_morse.h +++ b/src/MOLECULE/bond_morse.h @@ -20,7 +20,6 @@ BondStyle(morse,BondMorse) #ifndef LMP_BOND_MORSE_H #define LMP_BOND_MORSE_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_nonlinear.h b/src/MOLECULE/bond_nonlinear.h index 175421264b..7782b93778 100644 --- a/src/MOLECULE/bond_nonlinear.h +++ b/src/MOLECULE/bond_nonlinear.h @@ -20,7 +20,6 @@ BondStyle(nonlinear,BondNonlinear) #ifndef LMP_BOND_NONLINEAR_H #define LMP_BOND_NONLINEAR_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_quartic.h b/src/MOLECULE/bond_quartic.h index 2aaa76e2c3..60ccf307b9 100644 --- a/src/MOLECULE/bond_quartic.h +++ b/src/MOLECULE/bond_quartic.h @@ -20,7 +20,6 @@ BondStyle(quartic,BondQuartic) #ifndef LMP_BOND_QUARTIC_H #define LMP_BOND_QUARTIC_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/bond_table.h b/src/MOLECULE/bond_table.h index 5766239167..3db3ade3ab 100644 --- a/src/MOLECULE/bond_table.h +++ b/src/MOLECULE/bond_table.h @@ -20,7 +20,6 @@ BondStyle(table,BondTable) #ifndef LMP_BOND_TABLE_H #define LMP_BOND_TABLE_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/dihedral_charmm.h b/src/MOLECULE/dihedral_charmm.h index 8f51b398db..4be3925dad 100644 --- a/src/MOLECULE/dihedral_charmm.h +++ b/src/MOLECULE/dihedral_charmm.h @@ -20,7 +20,6 @@ DihedralStyle(charmm,DihedralCharmm) #ifndef LMP_DIHEDRAL_CHARMM_H #define LMP_DIHEDRAL_CHARMM_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/dihedral_charmmfsw.h b/src/MOLECULE/dihedral_charmmfsw.h index dd31067a8d..b33250004b 100644 --- a/src/MOLECULE/dihedral_charmmfsw.h +++ b/src/MOLECULE/dihedral_charmmfsw.h @@ -20,7 +20,6 @@ DihedralStyle(charmmfsw,DihedralCharmmfsw) #ifndef LMP_DIHEDRAL_CHARMMFSW_H #define LMP_DIHEDRAL_CHARMMFSW_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/dihedral_harmonic.h b/src/MOLECULE/dihedral_harmonic.h index 2031261256..938e59918b 100644 --- a/src/MOLECULE/dihedral_harmonic.h +++ b/src/MOLECULE/dihedral_harmonic.h @@ -20,7 +20,6 @@ DihedralStyle(harmonic,DihedralHarmonic) #ifndef LMP_DIHEDRAL_HARMONIC_H #define LMP_DIHEDRAL_HARMONIC_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/dihedral_helix.h b/src/MOLECULE/dihedral_helix.h index 745ab84115..0213c59e8a 100644 --- a/src/MOLECULE/dihedral_helix.h +++ b/src/MOLECULE/dihedral_helix.h @@ -20,7 +20,6 @@ DihedralStyle(helix,DihedralHelix) #ifndef LMP_DIHEDRAL_HELIX_H #define LMP_DIHEDRAL_HELIX_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/dihedral_multi_harmonic.h b/src/MOLECULE/dihedral_multi_harmonic.h index 32f17e75ae..bb3d7183f7 100644 --- a/src/MOLECULE/dihedral_multi_harmonic.h +++ b/src/MOLECULE/dihedral_multi_harmonic.h @@ -20,7 +20,6 @@ DihedralStyle(multi/harmonic,DihedralMultiHarmonic) #ifndef LMP_DIHEDRAL_MULTI_HARMONIC_H #define LMP_DIHEDRAL_MULTI_HARMONIC_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/dihedral_opls.h b/src/MOLECULE/dihedral_opls.h index c1e64ada1e..01878173cd 100644 --- a/src/MOLECULE/dihedral_opls.h +++ b/src/MOLECULE/dihedral_opls.h @@ -20,7 +20,6 @@ DihedralStyle(opls,DihedralOPLS) #ifndef LMP_DIHEDRAL_OPLS_H #define LMP_DIHEDRAL_OPLS_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/improper_cvff.h b/src/MOLECULE/improper_cvff.h index d4c30cc2ee..055d2ca9b8 100644 --- a/src/MOLECULE/improper_cvff.h +++ b/src/MOLECULE/improper_cvff.h @@ -20,7 +20,6 @@ ImproperStyle(cvff,ImproperCvff) #ifndef LMP_IMPROPER_CVFF_H #define LMP_IMPROPER_CVFF_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/improper_harmonic.h b/src/MOLECULE/improper_harmonic.h index fbbb8d33d6..5949c6911e 100644 --- a/src/MOLECULE/improper_harmonic.h +++ b/src/MOLECULE/improper_harmonic.h @@ -20,7 +20,6 @@ ImproperStyle(harmonic,ImproperHarmonic) #ifndef LMP_IMPROPER_HARMONIC_H #define LMP_IMPROPER_HARMONIC_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/MOLECULE/improper_umbrella.h b/src/MOLECULE/improper_umbrella.h index dc2262d01c..da9d6c8f4b 100644 --- a/src/MOLECULE/improper_umbrella.h +++ b/src/MOLECULE/improper_umbrella.h @@ -20,7 +20,6 @@ ImproperStyle(umbrella,ImproperUmbrella) #ifndef LMP_IMPROPER_UMBRELLA_H #define LMP_IMPROPER_UMBRELLA_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/REPLICA/neb.h b/src/REPLICA/neb.h index f585a0c8a7..b53992711c 100644 --- a/src/REPLICA/neb.h +++ b/src/REPLICA/neb.h @@ -20,7 +20,6 @@ CommandStyle(neb,NEB) #ifndef LMP_NEB_H #define LMP_NEB_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/SPIN/neb_spin.h b/src/SPIN/neb_spin.h index c128eaffa4..568eca0957 100644 --- a/src/SPIN/neb_spin.h +++ b/src/SPIN/neb_spin.h @@ -20,7 +20,6 @@ CommandStyle(neb/spin,NEBSpin) #ifndef LMP_NEB_SPIN_H #define LMP_NEB_SPIN_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/USER-CGDNA/mf_oxdna.h b/src/USER-CGDNA/mf_oxdna.h index c63a37cde2..e4ed1bbd03 100644 --- a/src/USER-CGDNA/mf_oxdna.h +++ b/src/USER-CGDNA/mf_oxdna.h @@ -14,7 +14,6 @@ #ifndef MF_OXDNA_H #define MF_OXDNA_H -#include #include "math_extra.h" namespace MFOxdna { diff --git a/src/USER-CGSDK/angle_sdk.h b/src/USER-CGSDK/angle_sdk.h index 293004ad4d..2e94b44470 100644 --- a/src/USER-CGSDK/angle_sdk.h +++ b/src/USER-CGSDK/angle_sdk.h @@ -20,7 +20,6 @@ AngleStyle(sdk,AngleSDK) #ifndef LMP_ANGLE_SDK_H #define LMP_ANGLE_SDK_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-DIFFRACTION/fix_saed_vtk.h b/src/USER-DIFFRACTION/fix_saed_vtk.h index 2fc09c781c..94abbf0194 100644 --- a/src/USER-DIFFRACTION/fix_saed_vtk.h +++ b/src/USER-DIFFRACTION/fix_saed_vtk.h @@ -20,7 +20,6 @@ FixStyle(saed/vtk,FixSAEDVTK) #ifndef LMP_FIX_SAED_VTK_H #define LMP_FIX_SAED_VTK_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/USER-INTEL/angle_charmm_intel.h b/src/USER-INTEL/angle_charmm_intel.h index 5d173ee6a9..155ecfaff9 100644 --- a/src/USER-INTEL/angle_charmm_intel.h +++ b/src/USER-INTEL/angle_charmm_intel.h @@ -24,7 +24,6 @@ AngleStyle(charmm/intel,AngleCharmmIntel) #ifndef LMP_ANGLE_CHARMM_INTEL_H #define LMP_ANGLE_CHARMM_INTEL_H -#include #include "angle_charmm.h" #include "fix_intel.h" diff --git a/src/USER-INTEL/angle_harmonic_intel.h b/src/USER-INTEL/angle_harmonic_intel.h index e7768542a1..c00292f7ce 100644 --- a/src/USER-INTEL/angle_harmonic_intel.h +++ b/src/USER-INTEL/angle_harmonic_intel.h @@ -24,7 +24,6 @@ AngleStyle(harmonic/intel,AngleHarmonicIntel) #ifndef LMP_ANGLE_HARMONIC_INTEL_H #define LMP_ANGLE_HARMONIC_INTEL_H -#include #include "angle_harmonic.h" #include "fix_intel.h" diff --git a/src/USER-INTEL/bond_fene_intel.h b/src/USER-INTEL/bond_fene_intel.h index afe3b85470..58fcdb8669 100644 --- a/src/USER-INTEL/bond_fene_intel.h +++ b/src/USER-INTEL/bond_fene_intel.h @@ -24,7 +24,6 @@ BondStyle(fene/intel,BondFENEIntel) #ifndef LMP_BOND_FENE_INTEL_H #define LMP_BOND_FENE_INTEL_H -#include #include "bond_fene.h" #include "fix_intel.h" diff --git a/src/USER-INTEL/bond_harmonic_intel.h b/src/USER-INTEL/bond_harmonic_intel.h index b86a560d6e..3c1d050a3b 100644 --- a/src/USER-INTEL/bond_harmonic_intel.h +++ b/src/USER-INTEL/bond_harmonic_intel.h @@ -24,7 +24,6 @@ BondStyle(harmonic/intel,BondHarmonicIntel) #ifndef LMP_BOND_HARMONIC_INTEL_H #define LMP_BOND_HARMONIC_INTEL_H -#include #include "bond_harmonic.h" #include "fix_intel.h" diff --git a/src/USER-INTEL/improper_cvff_intel.h b/src/USER-INTEL/improper_cvff_intel.h index e815fa75c9..812b49d50c 100644 --- a/src/USER-INTEL/improper_cvff_intel.h +++ b/src/USER-INTEL/improper_cvff_intel.h @@ -24,7 +24,6 @@ ImproperStyle(cvff/intel,ImproperCvffIntel) #ifndef LMP_IMPROPER_CVFF_INTEL_H #define LMP_IMPROPER_CVFF_INTEL_H -#include #include "improper_cvff.h" #include "fix_intel.h" diff --git a/src/USER-INTEL/improper_harmonic_intel.h b/src/USER-INTEL/improper_harmonic_intel.h index ce38e8fc31..6d7c829961 100644 --- a/src/USER-INTEL/improper_harmonic_intel.h +++ b/src/USER-INTEL/improper_harmonic_intel.h @@ -24,7 +24,6 @@ ImproperStyle(harmonic/intel,ImproperHarmonicIntel) #ifndef LMP_IMPROPER_HARMONIC_INTEL_H #define LMP_IMPROPER_HARMONIC_INTEL_H -#include #include "improper_harmonic.h" #include "fix_intel.h" diff --git a/src/USER-INTEL/intel_simd.h b/src/USER-INTEL/intel_simd.h index 75fc9828b9..9022f439c4 100644 --- a/src/USER-INTEL/intel_simd.h +++ b/src/USER-INTEL/intel_simd.h @@ -29,7 +29,6 @@ authors for more details. #ifndef INTEL_SIMD_H #define INTEL_SIMD_H -#include #include "intel_preprocess.h" #include "immintrin.h" diff --git a/src/USER-INTEL/pair_eam_intel.h b/src/USER-INTEL/pair_eam_intel.h index 83b1fbf6a1..a9590f6b3d 100644 --- a/src/USER-INTEL/pair_eam_intel.h +++ b/src/USER-INTEL/pair_eam_intel.h @@ -20,7 +20,6 @@ PairStyle(eam/intel,PairEAMIntel) #ifndef LMP_PAIR_EAM_INTEL_H #define LMP_PAIR_EAM_INTEL_H -#include #include "pair_eam.h" #include "fix_intel.h" diff --git a/src/USER-MANIFOLD/manifold_thylakoid.h b/src/USER-MANIFOLD/manifold_thylakoid.h index 5e5d3b9c41..d8ebe2e94f 100644 --- a/src/USER-MANIFOLD/manifold_thylakoid.h +++ b/src/USER-MANIFOLD/manifold_thylakoid.h @@ -3,7 +3,6 @@ #include "manifold.h" #include -#include #include "manifold_thylakoid_shared.h" diff --git a/src/USER-MGPT/mgpt_readpot.h b/src/USER-MGPT/mgpt_readpot.h index c19ea40774..62f66883b6 100644 --- a/src/USER-MGPT/mgpt_readpot.h +++ b/src/USER-MGPT/mgpt_readpot.h @@ -19,7 +19,6 @@ #ifndef READPOT__ #define READPOT__ -#include #include "mgpt_splinetab.h" diff --git a/src/USER-MGPT/pair_mgpt.h b/src/USER-MGPT/pair_mgpt.h index 94c66fb603..70b36364b1 100644 --- a/src/USER-MGPT/pair_mgpt.h +++ b/src/USER-MGPT/pair_mgpt.h @@ -32,7 +32,6 @@ PairStyle(mgpt,PairMGPT) #include #include -#include #include #include "pair.h" diff --git a/src/USER-MISC/angle_cosine_shift.h b/src/USER-MISC/angle_cosine_shift.h index 030709a0e2..febabcc090 100644 --- a/src/USER-MISC/angle_cosine_shift.h +++ b/src/USER-MISC/angle_cosine_shift.h @@ -20,7 +20,6 @@ AngleStyle(cosine/shift,AngleCosineShift) #ifndef LMP_ANGLE_COSINE_SHIFT_H #define LMP_ANGLE_COSINE_SHIFT_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/angle_cosine_shift_exp.h b/src/USER-MISC/angle_cosine_shift_exp.h index 8b8e389380..9614ddcc19 100644 --- a/src/USER-MISC/angle_cosine_shift_exp.h +++ b/src/USER-MISC/angle_cosine_shift_exp.h @@ -18,7 +18,6 @@ AngleStyle(cosine/shift/exp,AngleCosineShiftExp) #ifndef LMP_ANGLE_COSINE_SHIFT_EXP_H #define LMP_ANGLE_COSINE_SHIFT_EXP_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/angle_dipole.h b/src/USER-MISC/angle_dipole.h index 6c5dccb803..187822d0d4 100644 --- a/src/USER-MISC/angle_dipole.h +++ b/src/USER-MISC/angle_dipole.h @@ -20,7 +20,6 @@ AngleStyle(dipole,AngleDipole) #ifndef LMP_ANGLE_DIPOLE_H #define LMP_ANGLE_DIPOLE_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/angle_fourier.h b/src/USER-MISC/angle_fourier.h index 14b4eedf57..53eeea98da 100644 --- a/src/USER-MISC/angle_fourier.h +++ b/src/USER-MISC/angle_fourier.h @@ -20,7 +20,6 @@ AngleStyle(fourier,AngleFourier) #ifndef ANGLE_FOURIER_H #define ANGLE_FOURIER_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/angle_fourier_simple.h b/src/USER-MISC/angle_fourier_simple.h index 3a7bd37750..df2253317f 100644 --- a/src/USER-MISC/angle_fourier_simple.h +++ b/src/USER-MISC/angle_fourier_simple.h @@ -20,7 +20,6 @@ AngleStyle(fourier/simple,AngleFourierSimple) #ifndef ANGLE_FOURIER_SIMPLE_H #define ANGLE_FOURIER_SIMPLE_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/angle_quartic.h b/src/USER-MISC/angle_quartic.h index 7043cab064..b916a5f89f 100644 --- a/src/USER-MISC/angle_quartic.h +++ b/src/USER-MISC/angle_quartic.h @@ -20,7 +20,6 @@ AngleStyle(quartic,AngleQuartic) #ifndef LMP_ANGLE_QUARTIC_H #define LMP_ANGLE_QUARTIC_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/bond_harmonic_shift.h b/src/USER-MISC/bond_harmonic_shift.h index ff0d358243..b77cefb4af 100644 --- a/src/USER-MISC/bond_harmonic_shift.h +++ b/src/USER-MISC/bond_harmonic_shift.h @@ -20,7 +20,6 @@ BondStyle(harmonic/shift,BondHarmonicShift) #ifndef LMP_BOND_HARMONIC_SHIFT_H #define LMP_BOND_HARMONIC_SHIFT_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/bond_harmonic_shift_cut.h b/src/USER-MISC/bond_harmonic_shift_cut.h index 5db76d51aa..ad2bcd61ad 100644 --- a/src/USER-MISC/bond_harmonic_shift_cut.h +++ b/src/USER-MISC/bond_harmonic_shift_cut.h @@ -20,7 +20,6 @@ BondStyle(harmonic/shift/cut,BondHarmonicShiftCut) #ifndef LMP_BOND_HARMONIC_SHIFT_CUT_H #define LMP_BOND_HARMONIC_SHIFT_CUT_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/dihedral_cosine_shift_exp.h b/src/USER-MISC/dihedral_cosine_shift_exp.h index fc4be5049b..4d180f42de 100644 --- a/src/USER-MISC/dihedral_cosine_shift_exp.h +++ b/src/USER-MISC/dihedral_cosine_shift_exp.h @@ -20,7 +20,6 @@ DihedralStyle(cosine/shift/exp,DihedralCosineShiftExp) #ifndef LMP_DIHEDRAL_COSINE_SHIFT_EXP_H #define LMP_DIHEDRAL_COSINE_SHIFT_EXP_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/dihedral_fourier.h b/src/USER-MISC/dihedral_fourier.h index c1ed843c34..8b6291fc4c 100644 --- a/src/USER-MISC/dihedral_fourier.h +++ b/src/USER-MISC/dihedral_fourier.h @@ -20,7 +20,6 @@ DihedralStyle(fourier,DihedralFourier) #ifndef LMP_DIHEDRAL_FOURIER_H #define LMP_DIHEDRAL_FOURIER_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/dihedral_nharmonic.h b/src/USER-MISC/dihedral_nharmonic.h index 7c6a35b200..6fd1da3b8b 100644 --- a/src/USER-MISC/dihedral_nharmonic.h +++ b/src/USER-MISC/dihedral_nharmonic.h @@ -20,7 +20,6 @@ DihedralStyle(nharmonic,DihedralNHarmonic) #ifndef DIHEDRAL_NHARMONIC_H #define DIHEDRAL_NHARMONIC_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/dihedral_quadratic.h b/src/USER-MISC/dihedral_quadratic.h index edc29c3cf8..0b99cbc4f7 100644 --- a/src/USER-MISC/dihedral_quadratic.h +++ b/src/USER-MISC/dihedral_quadratic.h @@ -20,7 +20,6 @@ DihedralStyle(quadratic,DihedralQuadratic) #ifndef LMP_DIHEDRAL_QUADRATIC_H #define LMP_DIHEDRAL_QUADRATIC_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/dihedral_spherical.h b/src/USER-MISC/dihedral_spherical.h index ae0ece189a..472db36f33 100644 --- a/src/USER-MISC/dihedral_spherical.h +++ b/src/USER-MISC/dihedral_spherical.h @@ -20,7 +20,6 @@ DihedralStyle(spherical,DihedralSpherical) #ifndef LMP_DIHEDRAL_SPHERICAL_H #define LMP_DIHEDRAL_SPHERICAL_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/fix_ave_correlate_long.h b/src/USER-MISC/fix_ave_correlate_long.h index 548a0e7183..a0c5863e99 100644 --- a/src/USER-MISC/fix_ave_correlate_long.h +++ b/src/USER-MISC/fix_ave_correlate_long.h @@ -20,7 +20,6 @@ FixStyle(ave/correlate/long,FixAveCorrelateLong) #ifndef LMP_FIX_AVE_CORRELATE_LONG_H #define LMP_FIX_AVE_CORRELATE_LONG_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/fix_srp.h b/src/USER-MISC/fix_srp.h index 7dbf044bda..f8343df8a6 100644 --- a/src/USER-MISC/fix_srp.h +++ b/src/USER-MISC/fix_srp.h @@ -20,7 +20,6 @@ FixStyle(SRP,FixSRP) #ifndef LMP_FIX_SRP_H #define LMP_FIX_SRP_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/improper_cossq.h b/src/USER-MISC/improper_cossq.h index ea880adfaf..9e430bfa1a 100644 --- a/src/USER-MISC/improper_cossq.h +++ b/src/USER-MISC/improper_cossq.h @@ -20,7 +20,6 @@ ImproperStyle(cossq,ImproperCossq) #ifndef LMP_IMPROPER_COSSQ_H #define LMP_IMPROPER_COSSQ_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/improper_distance.h b/src/USER-MISC/improper_distance.h index 57e4d671e9..d7575c3585 100644 --- a/src/USER-MISC/improper_distance.h +++ b/src/USER-MISC/improper_distance.h @@ -20,7 +20,6 @@ ImproperStyle(distance,ImproperDistance) #ifndef LMP_IMPROPER_DISTANCE_H #define LMP_IMPROPER_DISTANCE_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/improper_fourier.h b/src/USER-MISC/improper_fourier.h index 0525c45494..91dfacfd8e 100644 --- a/src/USER-MISC/improper_fourier.h +++ b/src/USER-MISC/improper_fourier.h @@ -20,7 +20,6 @@ ImproperStyle(fourier,ImproperFourier) #ifndef LMP_IMPROPER_FOURIER_H #define LMP_IMPROPER_FOURIER_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/USER-MISC/improper_ring.h b/src/USER-MISC/improper_ring.h index c31329816f..7c53c6f59f 100644 --- a/src/USER-MISC/improper_ring.h +++ b/src/USER-MISC/improper_ring.h @@ -20,7 +20,6 @@ ImproperStyle(ring,ImproperRing) #ifndef LMP_IMPROPER_RING_H #define LMP_IMPROPER_RING_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/USER-MOFFF/angle_class2_p6.h b/src/USER-MOFFF/angle_class2_p6.h index b583a45b19..f2f324c0c6 100644 --- a/src/USER-MOFFF/angle_class2_p6.h +++ b/src/USER-MOFFF/angle_class2_p6.h @@ -20,7 +20,6 @@ AngleStyle(class2/p6,AngleClass2P6) #ifndef LMP_ANGLE_CLASS2_P6_H #define LMP_ANGLE_CLASS2_P6_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MOFFF/angle_cosine_buck6d.h b/src/USER-MOFFF/angle_cosine_buck6d.h index 689b1634e0..1d0df10228 100644 --- a/src/USER-MOFFF/angle_cosine_buck6d.h +++ b/src/USER-MOFFF/angle_cosine_buck6d.h @@ -20,7 +20,6 @@ AngleStyle(cosine/buck6d, AngleCosineBuck6d) #ifndef LMP_ANGLE_COSINE_BUCK6D_H #define LMP_ANGLE_COSINE_BUCK6D_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-MOFFF/improper_inversion_harmonic.h b/src/USER-MOFFF/improper_inversion_harmonic.h index 201c9e358d..206b40aebf 100644 --- a/src/USER-MOFFF/improper_inversion_harmonic.h +++ b/src/USER-MOFFF/improper_inversion_harmonic.h @@ -20,7 +20,6 @@ ImproperStyle(inversion/harmonic,ImproperInversionHarmonic) #ifndef LMP_IMPROPER_INVERSION_HARMONIC_H #define LMP_IMPROPER_INVERSION_HARMONIC_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/USER-REAXC/fix_reaxc_bonds.h b/src/USER-REAXC/fix_reaxc_bonds.h index d72f5446b5..60f41beb02 100644 --- a/src/USER-REAXC/fix_reaxc_bonds.h +++ b/src/USER-REAXC/fix_reaxc_bonds.h @@ -20,7 +20,6 @@ FixStyle(reax/c/bonds,FixReaxCBonds) #ifndef LMP_FIX_REAXC_BONDS_H #define LMP_FIX_REAXC_BONDS_H -#include #include "fix.h" #include "pointers.h" diff --git a/src/bond_hybrid.h b/src/bond_hybrid.h index e51d467ac1..19e4debfed 100644 --- a/src/bond_hybrid.h +++ b/src/bond_hybrid.h @@ -20,7 +20,6 @@ BondStyle(hybrid,BondHybrid) #ifndef LMP_BOND_HYBRID_H #define LMP_BOND_HYBRID_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/bond_zero.h b/src/bond_zero.h index 9443ff0784..7cbd2b9a96 100644 --- a/src/bond_zero.h +++ b/src/bond_zero.h @@ -20,7 +20,6 @@ BondStyle(zero,BondZero) #ifndef LMP_BOND_ZERO_H #define LMP_BOND_ZERO_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/citeme.cpp b/src/citeme.cpp index 24896b448c..c8745891cf 100644 --- a/src/citeme.cpp +++ b/src/citeme.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "citeme.h" #include "universe.h" diff --git a/src/comm_brick.cpp b/src/comm_brick.cpp index 47f60a3da6..dcf30807f5 100644 --- a/src/comm_brick.cpp +++ b/src/comm_brick.cpp @@ -18,7 +18,6 @@ #include #include #include -#include #include "comm_brick.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index d1d625445a..a85520ed45 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -11,19 +11,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "comm_tiled.h" -#include "comm_brick.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" -#include "force.h" #include "pair.h" #include "neighbor.h" -#include "modify.h" #include "fix.h" #include "compute.h" -#include "output.h" #include "dump.h" #include "memory.h" #include "error.h" diff --git a/src/comm_tiled.h b/src/comm_tiled.h index 13ecbc4b01..5a9beb28f7 100644 --- a/src/comm_tiled.h +++ b/src/comm_tiled.h @@ -14,6 +14,7 @@ #ifndef LMP_COMM_TILED_H #define LMP_COMM_TILED_H +#include #include "comm.h" namespace LAMMPS_NS { diff --git a/src/compute.cpp b/src/compute.cpp index 207f825ec8..8ff8487104 100644 --- a/src/compute.cpp +++ b/src/compute.cpp @@ -11,15 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include #include #include "compute.h" -#include "atom.h" #include "domain.h" #include "force.h" -#include "comm.h" #include "group.h" #include "modify.h" #include "fix.h" diff --git a/src/compute_adf.h b/src/compute_adf.h index a7983b7173..f768013207 100644 --- a/src/compute_adf.h +++ b/src/compute_adf.h @@ -20,7 +20,6 @@ ComputeStyle(adf,ComputeADF) #ifndef LMP_COMPUTE_ADF_H #define LMP_COMPUTE_ADF_H -#include #include "compute.h" namespace LAMMPS_NS { diff --git a/src/compute_rdf.h b/src/compute_rdf.h index 52a93a38dd..85f6ce6ad2 100644 --- a/src/compute_rdf.h +++ b/src/compute_rdf.h @@ -20,7 +20,6 @@ ComputeStyle(rdf,ComputeRDF) #ifndef LMP_COMPUTE_RDF_H #define LMP_COMPUTE_RDF_H -#include #include "compute.h" namespace LAMMPS_NS { diff --git a/src/dihedral_hybrid.h b/src/dihedral_hybrid.h index 0839fdfc61..2804060af4 100644 --- a/src/dihedral_hybrid.h +++ b/src/dihedral_hybrid.h @@ -20,7 +20,6 @@ DihedralStyle(hybrid,DihedralHybrid) #ifndef LMP_DIHEDRAL_HYBRID_H #define LMP_DIHEDRAL_HYBRID_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/dihedral_zero.h b/src/dihedral_zero.h index e7dbb0d3a5..e97f8f6641 100644 --- a/src/dihedral_zero.h +++ b/src/dihedral_zero.h @@ -24,7 +24,6 @@ DihedralStyle(zero,DihedralZero) #ifndef LMP_DIHEDRAL_ZERO_H #define LMP_DIHEDRAL_ZERO_H -#include #include "dihedral.h" namespace LAMMPS_NS { diff --git a/src/fix_ave_atom.h b/src/fix_ave_atom.h index e4baf6bda1..42aa282d53 100644 --- a/src/fix_ave_atom.h +++ b/src/fix_ave_atom.h @@ -20,7 +20,6 @@ FixStyle(ave/atom,FixAveAtom) #ifndef LMP_FIX_AVE_ATOM_H #define LMP_FIX_AVE_ATOM_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_ave_chunk.h b/src/fix_ave_chunk.h index 4dc1c1c246..dac5761ae8 100644 --- a/src/fix_ave_chunk.h +++ b/src/fix_ave_chunk.h @@ -20,7 +20,6 @@ FixStyle(ave/chunk,FixAveChunk) #ifndef LMP_FIX_AVE_CHUNK_H #define LMP_FIX_AVE_CHUNK_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_ave_correlate.h b/src/fix_ave_correlate.h index ff20e8ba94..05fd6b6576 100644 --- a/src/fix_ave_correlate.h +++ b/src/fix_ave_correlate.h @@ -20,7 +20,6 @@ FixStyle(ave/correlate,FixAveCorrelate) #ifndef LMP_FIX_AVE_CORRELATE_H #define LMP_FIX_AVE_CORRELATE_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_ave_histo.h b/src/fix_ave_histo.h index 3616959c61..35bdfcfa7f 100644 --- a/src/fix_ave_histo.h +++ b/src/fix_ave_histo.h @@ -20,7 +20,6 @@ FixStyle(ave/histo,FixAveHisto) #ifndef LMP_FIX_AVE_HISTO_H #define LMP_FIX_AVE_HISTO_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_ave_histo_weight.h b/src/fix_ave_histo_weight.h index e5638e1215..6ec3ba5721 100644 --- a/src/fix_ave_histo_weight.h +++ b/src/fix_ave_histo_weight.h @@ -20,7 +20,6 @@ FixStyle(ave/histo/weight,FixAveHistoWeight) #ifndef LMP_FIX_AVE_HISTO_WEIGHT_H #define LMP_FIX_AVE_HISTO_WEIGHT_H -#include #include "fix_ave_histo.h" namespace LAMMPS_NS { diff --git a/src/fix_ave_time.h b/src/fix_ave_time.h index 62dfbad296..01228f9e55 100644 --- a/src/fix_ave_time.h +++ b/src/fix_ave_time.h @@ -20,7 +20,6 @@ FixStyle(ave/time,FixAveTime) #ifndef LMP_FIX_AVE_TIME_H #define LMP_FIX_AVE_TIME_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_balance.h b/src/fix_balance.h index 64383b5950..76cbea258a 100644 --- a/src/fix_balance.h +++ b/src/fix_balance.h @@ -20,7 +20,6 @@ FixStyle(balance,FixBalance) #ifndef LMP_FIX_BALANCE_H #define LMP_FIX_BALANCE_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_halt.h b/src/fix_halt.h index 372c915a7f..93c5e95078 100644 --- a/src/fix_halt.h +++ b/src/fix_halt.h @@ -20,7 +20,6 @@ FixStyle(halt,FixHalt) #ifndef LMP_FIX_HALT_H #define LMP_FIX_HALT_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_move.h b/src/fix_move.h index 5993d7d6e8..740b051be0 100644 --- a/src/fix_move.h +++ b/src/fix_move.h @@ -20,7 +20,6 @@ FixStyle(move,FixMove) #ifndef LMP_FIX_MOVE_H #define LMP_FIX_MOVE_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_print.h b/src/fix_print.h index 37b6680aee..5644160220 100644 --- a/src/fix_print.h +++ b/src/fix_print.h @@ -20,7 +20,6 @@ FixStyle(print,FixPrint) #ifndef LMP_FIX_PRINT_H #define LMP_FIX_PRINT_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_store.h b/src/fix_store.h index 5524770a97..437c14f0f7 100644 --- a/src/fix_store.h +++ b/src/fix_store.h @@ -20,7 +20,6 @@ FixStyle(STORE,FixStore) #ifndef LMP_FIX_STORE_H #define LMP_FIX_STORE_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/fix_tmd.h b/src/fix_tmd.h index b6db41dd5a..f23a64a027 100644 --- a/src/fix_tmd.h +++ b/src/fix_tmd.h @@ -20,7 +20,6 @@ FixStyle(tmd,FixTMD) #ifndef LMP_FIX_TMD_H #define LMP_FIX_TMD_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/force.h b/src/force.h index 227b9427c0..26a3ecdfb8 100644 --- a/src/force.h +++ b/src/force.h @@ -15,7 +15,6 @@ #define LMP_FORCE_H #include "pointers.h" -#include #include #include diff --git a/src/group.h b/src/group.h index 962d37b32a..ec913f98bc 100644 --- a/src/group.h +++ b/src/group.h @@ -14,7 +14,6 @@ #ifndef LMP_GROUP_H #define LMP_GROUP_H -#include #include "pointers.h" #include diff --git a/src/image.h b/src/image.h index 5672bf85c5..7df81425d9 100644 --- a/src/image.h +++ b/src/image.h @@ -15,7 +15,6 @@ #define LMP_IMAGE_H #include -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/imbalance.h b/src/imbalance.h index d3c3b9a642..5f43c2e51d 100644 --- a/src/imbalance.h +++ b/src/imbalance.h @@ -14,7 +14,6 @@ #ifndef LMP_IMBALANCE_H #define LMP_IMBALANCE_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/improper_hybrid.h b/src/improper_hybrid.h index 89595ccfc4..3e5423b173 100644 --- a/src/improper_hybrid.h +++ b/src/improper_hybrid.h @@ -20,7 +20,6 @@ ImproperStyle(hybrid,ImproperHybrid) #ifndef LMP_IMPROPER_HYBRID_H #define LMP_IMPROPER_HYBRID_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/improper_zero.h b/src/improper_zero.h index 0a2290b6f7..1a70059070 100644 --- a/src/improper_zero.h +++ b/src/improper_zero.h @@ -20,7 +20,6 @@ ImproperStyle(zero,ImproperZero) #ifndef LMP_IMPROPER_ZERO_H #define LMP_IMPROPER_ZERO_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/input.h b/src/input.h index 33e83bfb06..9573b569bc 100644 --- a/src/input.h +++ b/src/input.h @@ -14,7 +14,6 @@ #ifndef LMP_INPUT_H #define LMP_INPUT_H -#include #include "pointers.h" #include #include diff --git a/src/lammps.h b/src/lammps.h index e02d0c764a..5820f25591 100644 --- a/src/lammps.h +++ b/src/lammps.h @@ -14,7 +14,6 @@ #ifndef LMP_LAMMPS_H #define LMP_LAMMPS_H -#include namespace LAMMPS_NS { diff --git a/src/modify.h b/src/modify.h index 5ff81855fe..b736485196 100644 --- a/src/modify.h +++ b/src/modify.h @@ -14,7 +14,6 @@ #ifndef LMP_MODIFY_H #define LMP_MODIFY_H -#include #include "pointers.h" #include #include diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index e313e16f18..074517a859 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -20,7 +20,6 @@ PairStyle(hybrid,PairHybrid) #ifndef LMP_PAIR_HYBRID_H #define LMP_PAIR_HYBRID_H -#include #include "pair.h" namespace LAMMPS_NS { diff --git a/src/read_data.h b/src/read_data.h index 26ab6ff381..98de607f6b 100644 --- a/src/read_data.h +++ b/src/read_data.h @@ -20,7 +20,6 @@ CommandStyle(read_data,ReadData) #ifndef LMP_READ_DATA_H #define LMP_READ_DATA_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/read_dump.h b/src/read_dump.h index 3ee13f779c..6fb4f11ed1 100644 --- a/src/read_dump.h +++ b/src/read_dump.h @@ -23,7 +23,6 @@ CommandStyle(read_dump,ReadDump) #define LMP_READ_DUMP_H #include -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/read_restart.h b/src/read_restart.h index 23d6ec3fba..63adf37b22 100644 --- a/src/read_restart.h +++ b/src/read_restart.h @@ -20,7 +20,6 @@ CommandStyle(read_restart,ReadRestart) #ifndef LMP_READ_RESTART_H #define LMP_READ_RESTART_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/universe.h b/src/universe.h index 3073409b86..fd6655c749 100644 --- a/src/universe.h +++ b/src/universe.h @@ -14,7 +14,6 @@ #ifndef LMP_UNIVERSE_H #define LMP_UNIVERSE_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/variable.h b/src/variable.h index c5f501f266..a504da14ec 100644 --- a/src/variable.h +++ b/src/variable.h @@ -14,7 +14,6 @@ #ifndef LMP_VARIABLE_H #define LMP_VARIABLE_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/write_coeff.h b/src/write_coeff.h index 569a615e6e..b995e60d63 100644 --- a/src/write_coeff.h +++ b/src/write_coeff.h @@ -20,7 +20,6 @@ CommandStyle(write_coeff,WriteCoeff) #ifndef LMP_WRITE_COEFF_H #define LMP_WRITE_COEFF_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/write_data.h b/src/write_data.h index 6f1bb2ec47..1c0f6b2a7c 100644 --- a/src/write_data.h +++ b/src/write_data.h @@ -20,7 +20,6 @@ CommandStyle(write_data,WriteData) #ifndef LMP_WRITE_DATA_H #define LMP_WRITE_DATA_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/write_restart.h b/src/write_restart.h index c6202acbfd..e7cdc6a501 100644 --- a/src/write_restart.h +++ b/src/write_restart.h @@ -20,7 +20,6 @@ CommandStyle(write_restart,WriteRestart) #ifndef LMP_WRITE_RESTART_H #define LMP_WRITE_RESTART_H -#include #include "pointers.h" namespace LAMMPS_NS { -- GitLab From 123bd57376066ade0dc92c891bd97de152afd2ad Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 21:59:05 -0400 Subject: [PATCH 125/469] try to make KOKKOS compile again --- src/KOKKOS/kokkos_type.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/kokkos_type.h b/src/KOKKOS/kokkos_type.h index 942c2af241..e900bbd6d1 100644 --- a/src/KOKKOS/kokkos_type.h +++ b/src/KOKKOS/kokkos_type.h @@ -14,7 +14,7 @@ #ifndef LMP_LMPTYPE_KOKKOS_H #define LMP_LMPTYPE_KOKKOS_H -#include "lmptype.h" +#include "pointers.h" #include #include -- GitLab From 2c119551f7af4eb6dfe1d0424debdec0d6089f80 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 22:13:42 -0400 Subject: [PATCH 126/469] add statement about order of include files --- doc/include-file-conventions.md | 8 ++++++++ 1 file changed, 8 insertions(+) diff --git a/doc/include-file-conventions.md b/doc/include-file-conventions.md index 5152051ba5..8d70d6cdec 100644 --- a/doc/include-file-conventions.md +++ b/doc/include-file-conventions.md @@ -94,6 +94,14 @@ In the implementation files (typically, those would have the same base name as the corresponding header with a .cpp extension instead of .h) include statments should follow the "include what you use" principle. +### Order of Include Statements + +Include files should be included in this order: +* lmptype.h (should only be included if `MPI_LMP_XXX` data types are used) +* mpi.h +* system and library headers (anything that is using angular brackets; C-library headers first, then C++) +* LAMMPS local headers (first the header matching the implementation file, the rest in mostly alphabetical order) + ### Special Cases and Exceptions #### pointers.h -- GitLab From a5cb6ddd4a798e4618e2e506ad9d14021f0c4670 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 27 Jun 2019 22:14:06 -0400 Subject: [PATCH 127/469] lammps.h must include cstdio and mpi.h --- src/lammps.h | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/lammps.h b/src/lammps.h index 5820f25591..dc2916f214 100644 --- a/src/lammps.h +++ b/src/lammps.h @@ -14,6 +14,8 @@ #ifndef LMP_LAMMPS_H #define LMP_LAMMPS_H +#include +#include namespace LAMMPS_NS { -- GitLab From 378474c4e642f34614d471953bb3758c04c8754a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 28 Jun 2019 02:01:08 -0400 Subject: [PATCH 128/469] more include file cleanup suggested by IWYU --- src/atom_map.cpp | 1 - src/atom_vec_body.cpp | 1 + src/bond_hybrid.cpp | 1 - src/bond_zero.cpp | 1 - src/comm.h | 2 +- src/comm_tiled.cpp | 1 + src/compute_adf.cpp | 3 --- src/compute_aggregate_atom.cpp | 1 + src/compute_angle.cpp | 2 +- src/compute_angmom_chunk.cpp | 1 + src/compute_bond.cpp | 2 +- src/compute_centro_atom.cpp | 1 - src/compute_chunk_atom.cpp | 6 ++++-- src/compute_cluster_atom.cpp | 2 +- src/compute_cna_atom.cpp | 2 +- src/compute_com_chunk.cpp | 1 + src/compute_contact_atom.cpp | 3 --- src/compute_coord_atom.cpp | 1 - src/compute_dihedral.cpp | 2 +- src/compute_dihedral_local.cpp | 2 -- src/compute_dipole_chunk.cpp | 2 ++ src/compute_displace_atom.cpp | 1 - src/compute_erotate_sphere.cpp | 3 --- src/compute_fragment_atom.cpp | 1 + src/compute_global_atom.cpp | 4 ---- src/compute_group_group.cpp | 1 - src/compute_gyration.cpp | 2 +- src/compute_gyration_chunk.cpp | 1 + src/compute_heat_flux.cpp | 3 +-- src/compute_hexorder_atom.cpp | 4 ++-- src/compute_improper.cpp | 2 +- src/compute_improper_local.cpp | 1 - src/compute_inertia_chunk.cpp | 1 + src/compute_ke.cpp | 2 -- src/compute_msd.cpp | 1 + src/compute_msd_chunk.cpp | 1 + src/compute_omega_chunk.cpp | 1 + src/compute_pair_local.cpp | 1 - src/compute_pe_atom.cpp | 1 - src/compute_pressure.cpp | 1 - src/compute_property_chunk.cpp | 1 + src/compute_rdf.cpp | 1 - src/compute_reduce.cpp | 2 -- src/compute_reduce_region.cpp | 3 +-- 44 files changed, 30 insertions(+), 47 deletions(-) diff --git a/src/atom_map.cpp b/src/atom_map.cpp index b14ebdba68..6af3b9c288 100644 --- a/src/atom_map.cpp +++ b/src/atom_map.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "pointers.h" #include #include #include "atom.h" diff --git a/src/atom_vec_body.cpp b/src/atom_vec_body.cpp index 3e9528d6b9..fad5b3eae0 100644 --- a/src/atom_vec_body.cpp +++ b/src/atom_vec_body.cpp @@ -13,6 +13,7 @@ #include #include +#include #include "atom_vec_body.h" #include "my_pool_chunk.h" #include "style_body.h" diff --git a/src/bond_hybrid.cpp b/src/bond_hybrid.cpp index 0fb23a3214..9028886758 100644 --- a/src/bond_hybrid.cpp +++ b/src/bond_hybrid.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include #include "bond_hybrid.h" diff --git a/src/bond_zero.cpp b/src/bond_zero.cpp index 3932846cb4..c473abbe4b 100644 --- a/src/bond_zero.cpp +++ b/src/bond_zero.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "bond_zero.h" #include "atom.h" diff --git a/src/comm.h b/src/comm.h index 30360b1059..6d5592585f 100644 --- a/src/comm.h +++ b/src/comm.h @@ -14,7 +14,7 @@ #ifndef LMP_COMM_H #define LMP_COMM_H -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index a85520ed45..385b7fdf22 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include #include "comm_tiled.h" diff --git a/src/compute_adf.cpp b/src/compute_adf.cpp index e9f9ba2b6f..a17561ff54 100644 --- a/src/compute_adf.cpp +++ b/src/compute_adf.cpp @@ -17,18 +17,15 @@ #include #include -#include #include #include "compute_adf.h" #include "atom.h" #include "update.h" #include "force.h" #include "pair.h" -#include "domain.h" #include "neighbor.h" #include "neigh_request.h" #include "neigh_list.h" -#include "group.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/compute_aggregate_atom.cpp b/src/compute_aggregate_atom.cpp index 6c8c8e5d9a..9a797124bd 100644 --- a/src/compute_aggregate_atom.cpp +++ b/src/compute_aggregate_atom.cpp @@ -15,6 +15,7 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include #include #include #include "compute_aggregate_atom.h" diff --git a/src/compute_angle.cpp b/src/compute_angle.cpp index 59945f5832..c1c02a1cc4 100644 --- a/src/compute_angle.cpp +++ b/src/compute_angle.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include -#include #include "compute_angle.h" +#include "angle.h" #include "update.h" #include "force.h" #include "angle_hybrid.h" diff --git a/src/compute_angmom_chunk.cpp b/src/compute_angmom_chunk.cpp index a70eaaf49f..ec42015527 100644 --- a/src/compute_angmom_chunk.cpp +++ b/src/compute_angmom_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_angmom_chunk.h" #include "atom.h" diff --git a/src/compute_bond.cpp b/src/compute_bond.cpp index 896aaec9bd..4fd3bbef30 100644 --- a/src/compute_bond.cpp +++ b/src/compute_bond.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include -#include #include "compute_bond.h" +#include "bond.h" #include "update.h" #include "force.h" #include "bond_hybrid.h" diff --git a/src/compute_centro_atom.cpp b/src/compute_centro_atom.cpp index 5096879b32..7df94271fc 100644 --- a/src/compute_centro_atom.cpp +++ b/src/compute_centro_atom.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include -#include #include "compute_centro_atom.h" #include "atom.h" #include "update.h" diff --git a/src/compute_chunk_atom.cpp b/src/compute_chunk_atom.cpp index 61b653b375..fd9204f1cb 100644 --- a/src/compute_chunk_atom.cpp +++ b/src/compute_chunk_atom.cpp @@ -14,8 +14,11 @@ // NOTE: allow for bin center to be variables for sphere/cylinder #include +#include #include #include +#include +#include #include "compute_chunk_atom.h" #include "atom.h" #include "update.h" @@ -24,6 +27,7 @@ #include "region.h" #include "lattice.h" #include "modify.h" +#include "fix.h" #include "fix_store.h" #include "comm.h" #include "group.h" @@ -33,8 +37,6 @@ #include "memory.h" #include "error.h" -#include - using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/compute_cluster_atom.cpp b/src/compute_cluster_atom.cpp index 0c34b42671..febe0658a0 100644 --- a/src/compute_cluster_atom.cpp +++ b/src/compute_cluster_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include -#include #include "compute_cluster_atom.h" #include "atom.h" #include "update.h" diff --git a/src/compute_cna_atom.cpp b/src/compute_cna_atom.cpp index b8ad3f0f64..d764e739b3 100644 --- a/src/compute_cna_atom.cpp +++ b/src/compute_cna_atom.cpp @@ -15,8 +15,8 @@ Contributing author: Wan Liang (Chinese Academy of Sciences) ------------------------------------------------------------------------- */ +#include #include -#include #include #include "compute_cna_atom.h" #include "atom.h" diff --git a/src/compute_com_chunk.cpp b/src/compute_com_chunk.cpp index ec66767245..7b4c960cf4 100644 --- a/src/compute_com_chunk.cpp +++ b/src/compute_com_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_com_chunk.h" #include "atom.h" diff --git a/src/compute_contact_atom.cpp b/src/compute_contact_atom.cpp index e60a51832a..e4afc1d761 100644 --- a/src/compute_contact_atom.cpp +++ b/src/compute_contact_atom.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include -#include #include "compute_contact_atom.h" #include "atom.h" #include "update.h" @@ -22,7 +20,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "force.h" -#include "pair.h" #include "comm.h" #include "memory.h" #include "error.h" diff --git a/src/compute_coord_atom.cpp b/src/compute_coord_atom.cpp index 54f4c70c71..8cedcbc027 100644 --- a/src/compute_coord_atom.cpp +++ b/src/compute_coord_atom.cpp @@ -13,7 +13,6 @@ #include #include -#include #include "compute_coord_atom.h" #include "compute_orientorder_atom.h" #include "atom.h" diff --git a/src/compute_dihedral.cpp b/src/compute_dihedral.cpp index 3595b2eda3..16823050da 100644 --- a/src/compute_dihedral.cpp +++ b/src/compute_dihedral.cpp @@ -12,10 +12,10 @@ ------------------------------------------------------------------------- */ #include -#include #include "compute_dihedral.h" #include "update.h" #include "force.h" +#include "dihedral.h" #include "dihedral_hybrid.h" #include "error.h" diff --git a/src/compute_dihedral_local.cpp b/src/compute_dihedral_local.cpp index 9efdd61cb8..784ae9c607 100644 --- a/src/compute_dihedral_local.cpp +++ b/src/compute_dihedral_local.cpp @@ -20,10 +20,8 @@ #include "update.h" #include "domain.h" #include "force.h" -#include "dihedral.h" #include "input.h" #include "variable.h" - #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/compute_dipole_chunk.cpp b/src/compute_dipole_chunk.cpp index b0474b6359..090bc5df94 100644 --- a/src/compute_dipole_chunk.cpp +++ b/src/compute_dipole_chunk.cpp @@ -11,6 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include +#include #include #include "compute_dipole_chunk.h" #include "atom.h" diff --git a/src/compute_displace_atom.cpp b/src/compute_displace_atom.cpp index d8f279058e..3773159143 100644 --- a/src/compute_displace_atom.cpp +++ b/src/compute_displace_atom.cpp @@ -19,7 +19,6 @@ #include "group.h" #include "domain.h" #include "modify.h" -#include "fix.h" #include "fix_store.h" #include "input.h" #include "variable.h" diff --git a/src/compute_erotate_sphere.cpp b/src/compute_erotate_sphere.cpp index 31ed0aaba5..65bb8a9770 100644 --- a/src/compute_erotate_sphere.cpp +++ b/src/compute_erotate_sphere.cpp @@ -14,11 +14,8 @@ #include #include "compute_erotate_sphere.h" #include "atom.h" -#include "atom_vec.h" #include "update.h" #include "force.h" -#include "domain.h" -#include "group.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/compute_fragment_atom.cpp b/src/compute_fragment_atom.cpp index bb273f3bdb..d59b519d09 100644 --- a/src/compute_fragment_atom.cpp +++ b/src/compute_fragment_atom.cpp @@ -15,6 +15,7 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include #include #include "compute_fragment_atom.h" #include "atom.h" diff --git a/src/compute_global_atom.cpp b/src/compute_global_atom.cpp index dc9ab52f49..6685f746a1 100644 --- a/src/compute_global_atom.cpp +++ b/src/compute_global_atom.cpp @@ -16,12 +16,8 @@ #include "compute_global_atom.h" #include "atom.h" #include "update.h" -#include "domain.h" #include "modify.h" #include "fix.h" -#include "force.h" -#include "comm.h" -#include "group.h" #include "input.h" #include "variable.h" #include "memory.h" diff --git a/src/compute_group_group.cpp b/src/compute_group_group.cpp index e55f679b2e..11e1aac720 100644 --- a/src/compute_group_group.cpp +++ b/src/compute_group_group.cpp @@ -33,7 +33,6 @@ #include "comm.h" #include "domain.h" #include "math_const.h" -#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/compute_gyration.cpp b/src/compute_gyration.cpp index f8d19853e0..3c5656a5af 100644 --- a/src/compute_gyration.cpp +++ b/src/compute_gyration.cpp @@ -11,7 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include "compute_gyration.h" #include "update.h" #include "atom.h" diff --git a/src/compute_gyration_chunk.cpp b/src/compute_gyration_chunk.cpp index 6a23398aca..f3db37d62f 100644 --- a/src/compute_gyration_chunk.cpp +++ b/src/compute_gyration_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include #include "compute_gyration_chunk.h" diff --git a/src/compute_heat_flux.cpp b/src/compute_heat_flux.cpp index e402da7842..9bd827c713 100644 --- a/src/compute_heat_flux.cpp +++ b/src/compute_heat_flux.cpp @@ -16,14 +16,13 @@ Mario Pinto (Computational Research Lab, Pune, India) ------------------------------------------------------------------------- */ -#include +#include #include #include "compute_heat_flux.h" #include "atom.h" #include "update.h" #include "modify.h" #include "force.h" -#include "group.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/compute_hexorder_atom.cpp b/src/compute_hexorder_atom.cpp index 6d17ae15bd..c54f4b1aae 100644 --- a/src/compute_hexorder_atom.cpp +++ b/src/compute_hexorder_atom.cpp @@ -15,9 +15,9 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ -#include +#include #include -#include +#include #include "compute_hexorder_atom.h" #include "atom.h" #include "update.h" diff --git a/src/compute_improper.cpp b/src/compute_improper.cpp index ac2a23e727..2f068dfb74 100644 --- a/src/compute_improper.cpp +++ b/src/compute_improper.cpp @@ -12,10 +12,10 @@ ------------------------------------------------------------------------- */ #include -#include #include "compute_improper.h" #include "update.h" #include "force.h" +#include "improper.h" #include "improper_hybrid.h" #include "error.h" diff --git a/src/compute_improper_local.cpp b/src/compute_improper_local.cpp index 2861850c79..ec1734cd96 100644 --- a/src/compute_improper_local.cpp +++ b/src/compute_improper_local.cpp @@ -20,7 +20,6 @@ #include "update.h" #include "domain.h" #include "force.h" -#include "improper.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/compute_inertia_chunk.cpp b/src/compute_inertia_chunk.cpp index a33073c35a..d1a7cb9fc1 100644 --- a/src/compute_inertia_chunk.cpp +++ b/src/compute_inertia_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_inertia_chunk.h" #include "atom.h" diff --git a/src/compute_ke.cpp b/src/compute_ke.cpp index fb3c5a9695..3418cc678f 100644 --- a/src/compute_ke.cpp +++ b/src/compute_ke.cpp @@ -16,8 +16,6 @@ #include "atom.h" #include "update.h" #include "force.h" -#include "domain.h" -#include "group.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/compute_msd.cpp b/src/compute_msd.cpp index fc47b2609a..d2e17eff9e 100644 --- a/src/compute_msd.cpp +++ b/src/compute_msd.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_msd.h" #include "atom.h" diff --git a/src/compute_msd_chunk.cpp b/src/compute_msd_chunk.cpp index 1f974cc06c..8520b36993 100644 --- a/src/compute_msd_chunk.cpp +++ b/src/compute_msd_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_msd_chunk.h" #include "atom.h" diff --git a/src/compute_omega_chunk.cpp b/src/compute_omega_chunk.cpp index 23447da602..360255e908 100644 --- a/src/compute_omega_chunk.cpp +++ b/src/compute_omega_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_omega_chunk.h" #include "atom.h" diff --git a/src/compute_pair_local.cpp b/src/compute_pair_local.cpp index c356a08be9..1ab46a0297 100644 --- a/src/compute_pair_local.cpp +++ b/src/compute_pair_local.cpp @@ -22,7 +22,6 @@ #include "neighbor.h" #include "neigh_request.h" #include "neigh_list.h" -#include "group.h" #include "memory.h" #include "error.h" diff --git a/src/compute_pe_atom.cpp b/src/compute_pe_atom.cpp index 2f1dc5650e..b3ace2d419 100644 --- a/src/compute_pe_atom.cpp +++ b/src/compute_pe_atom.cpp @@ -24,7 +24,6 @@ #include "improper.h" #include "kspace.h" #include "modify.h" -#include "fix.h" #include "memory.h" #include "error.h" diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index dde02a5aed..431f039de3 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -13,7 +13,6 @@ #include #include -#include #include "compute_pressure.h" #include "atom.h" #include "update.h" diff --git a/src/compute_property_chunk.cpp b/src/compute_property_chunk.cpp index 489890e1cc..089e867598 100644 --- a/src/compute_property_chunk.cpp +++ b/src/compute_property_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_property_chunk.h" #include "atom.h" diff --git a/src/compute_rdf.cpp b/src/compute_rdf.cpp index d49485b4ea..b1fa8bb2a3 100644 --- a/src/compute_rdf.cpp +++ b/src/compute_rdf.cpp @@ -17,7 +17,6 @@ #include #include -#include #include #include "compute_rdf.h" #include "atom.h" diff --git a/src/compute_reduce.cpp b/src/compute_reduce.cpp index 16dc84628a..e7692b0797 100644 --- a/src/compute_reduce.cpp +++ b/src/compute_reduce.cpp @@ -20,8 +20,6 @@ #include "domain.h" #include "modify.h" #include "fix.h" -#include "force.h" -#include "comm.h" #include "group.h" #include "input.h" #include "variable.h" diff --git a/src/compute_reduce_region.cpp b/src/compute_reduce_region.cpp index 8e91a299e8..30a5c6393f 100644 --- a/src/compute_reduce_region.cpp +++ b/src/compute_reduce_region.cpp @@ -11,8 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include #include "compute_reduce_region.h" #include "atom.h" #include "update.h" -- GitLab From df7c56d88160add5ce3492c1f5b9e757b34ebace Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 28 Jun 2019 05:28:54 -0400 Subject: [PATCH 129/469] use suffix compatible pair style matching when looking for ReaxFF pair style --- src/QEQ/fix_qeq_shielded.cpp | 2 +- src/USER-REAXC/fix_qeq_reax.cpp | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/src/QEQ/fix_qeq_shielded.cpp b/src/QEQ/fix_qeq_shielded.cpp index a74eee7d29..6367feacc5 100644 --- a/src/QEQ/fix_qeq_shielded.cpp +++ b/src/QEQ/fix_qeq_shielded.cpp @@ -80,7 +80,7 @@ void FixQEqShielded::init() void FixQEqShielded::extract_reax() { - Pair *pair = force->pair_match("reax/c",1); + Pair *pair = force->pair_match("^reax/c",0); if (pair == NULL) error->all(FLERR,"No pair reax/c for fix qeq/shielded"); int tmp; chi = (double *) pair->extract("chi",tmp); diff --git a/src/USER-REAXC/fix_qeq_reax.cpp b/src/USER-REAXC/fix_qeq_reax.cpp index b37c8fff83..faa0632608 100644 --- a/src/USER-REAXC/fix_qeq_reax.cpp +++ b/src/USER-REAXC/fix_qeq_reax.cpp @@ -124,7 +124,7 @@ FixQEqReax::FixQEqReax(LAMMPS *lmp, int narg, char **arg) : // register with Atom class reaxc = NULL; - reaxc = (PairReaxC *) force->pair_match("reax/c",0); + reaxc = (PairReaxC *) force->pair_match("^reax/c",0); s_hist = t_hist = NULL; grow_arrays(atom->nmax); -- GitLab From 557a1274e48fdb950a998c28f2e5eba6a996065d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 28 Jun 2019 02:12:47 -0400 Subject: [PATCH 130/469] even more include file cleanup --- src/compute_slice.cpp | 2 +- src/compute_stress_atom.cpp | 1 - src/compute_temp.cpp | 2 -- src/compute_temp_chunk.cpp | 1 + src/compute_temp_com.cpp | 3 --- src/compute_temp_partial.cpp | 1 - src/compute_temp_profile.cpp | 2 -- src/compute_temp_ramp.cpp | 2 -- src/compute_temp_sphere.cpp | 2 -- src/compute_torque_chunk.cpp | 1 + src/compute_vacf.cpp | 1 + src/compute_vcm_chunk.cpp | 2 +- src/create_atoms.cpp | 5 +---- src/create_bonds.cpp | 2 +- src/create_box.cpp | 2 -- src/delete_atoms.cpp | 3 ++- src/delete_bonds.cpp | 1 - src/deprecated.cpp | 1 - src/dihedral.cpp | 3 --- 19 files changed, 9 insertions(+), 28 deletions(-) diff --git a/src/compute_slice.cpp b/src/compute_slice.cpp index ac70e7dd15..6e509c24d4 100644 --- a/src/compute_slice.cpp +++ b/src/compute_slice.cpp @@ -11,13 +11,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include #include "compute_slice.h" #include "update.h" #include "modify.h" #include "fix.h" -#include "group.h" #include "input.h" #include "variable.h" #include "memory.h" diff --git a/src/compute_stress_atom.cpp b/src/compute_stress_atom.cpp index 5211f015ab..f84c977bdb 100644 --- a/src/compute_stress_atom.cpp +++ b/src/compute_stress_atom.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "compute_stress_atom.h" #include "atom.h" diff --git a/src/compute_temp.cpp b/src/compute_temp.cpp index f7d3a890ec..c330249a7e 100644 --- a/src/compute_temp.cpp +++ b/src/compute_temp.cpp @@ -12,13 +12,11 @@ ------------------------------------------------------------------------- */ #include -#include #include "compute_temp.h" #include "atom.h" #include "update.h" #include "force.h" #include "domain.h" -#include "comm.h" #include "group.h" #include "error.h" diff --git a/src/compute_temp_chunk.cpp b/src/compute_temp_chunk.cpp index 920515e05c..229e98e258 100644 --- a/src/compute_temp_chunk.cpp +++ b/src/compute_temp_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_temp_chunk.h" #include "atom.h" diff --git a/src/compute_temp_com.cpp b/src/compute_temp_com.cpp index f2ad40ea43..21814e1940 100644 --- a/src/compute_temp_com.cpp +++ b/src/compute_temp_com.cpp @@ -12,15 +12,12 @@ ------------------------------------------------------------------------- */ #include -#include -#include #include "compute_temp_com.h" #include "atom.h" #include "update.h" #include "force.h" #include "group.h" #include "domain.h" -#include "lattice.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/compute_temp_partial.cpp b/src/compute_temp_partial.cpp index 4425aebdda..8d5ff66796 100644 --- a/src/compute_temp_partial.cpp +++ b/src/compute_temp_partial.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include "compute_temp_partial.h" #include "atom.h" #include "update.h" diff --git a/src/compute_temp_profile.cpp b/src/compute_temp_profile.cpp index c7f0b28a6c..21c87b31a2 100644 --- a/src/compute_temp_profile.cpp +++ b/src/compute_temp_profile.cpp @@ -12,14 +12,12 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "compute_temp_profile.h" #include "atom.h" #include "update.h" #include "force.h" #include "group.h" -#include "fix.h" #include "domain.h" #include "memory.h" #include "error.h" diff --git a/src/compute_temp_ramp.cpp b/src/compute_temp_ramp.cpp index ba572645f3..715d2aa9f4 100644 --- a/src/compute_temp_ramp.cpp +++ b/src/compute_temp_ramp.cpp @@ -12,14 +12,12 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "compute_temp_ramp.h" #include "atom.h" #include "update.h" #include "force.h" #include "group.h" -#include "fix.h" #include "domain.h" #include "lattice.h" #include "memory.h" diff --git a/src/compute_temp_sphere.cpp b/src/compute_temp_sphere.cpp index 651da6dee5..b490a5ec45 100644 --- a/src/compute_temp_sphere.cpp +++ b/src/compute_temp_sphere.cpp @@ -15,12 +15,10 @@ #include #include "compute_temp_sphere.h" #include "atom.h" -#include "atom_vec.h" #include "update.h" #include "force.h" #include "domain.h" #include "modify.h" -#include "comm.h" #include "group.h" #include "error.h" diff --git a/src/compute_torque_chunk.cpp b/src/compute_torque_chunk.cpp index d9de99bcb2..e43155493f 100644 --- a/src/compute_torque_chunk.cpp +++ b/src/compute_torque_chunk.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_torque_chunk.h" #include "atom.h" diff --git a/src/compute_vacf.cpp b/src/compute_vacf.cpp index 3ef3acf0bf..787c2503ca 100644 --- a/src/compute_vacf.cpp +++ b/src/compute_vacf.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_vacf.h" #include "atom.h" diff --git a/src/compute_vcm_chunk.cpp b/src/compute_vcm_chunk.cpp index a6dd796c63..cf30130763 100644 --- a/src/compute_vcm_chunk.cpp +++ b/src/compute_vcm_chunk.cpp @@ -11,13 +11,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "compute_vcm_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" #include "compute_chunk_atom.h" -#include "domain.h" #include "memory.h" #include "error.h" diff --git a/src/create_atoms.cpp b/src/create_atoms.cpp index 52e4256fca..8504023a70 100644 --- a/src/create_atoms.cpp +++ b/src/create_atoms.cpp @@ -11,8 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include #include #include "create_atoms.h" #include "atom.h" @@ -23,8 +22,6 @@ #include "modify.h" #include "force.h" #include "special.h" -#include "fix.h" -#include "compute.h" #include "domain.h" #include "lattice.h" #include "region.h" diff --git a/src/create_bonds.cpp b/src/create_bonds.cpp index e19b565554..e00fe109ca 100644 --- a/src/create_bonds.cpp +++ b/src/create_bonds.cpp @@ -15,7 +15,7 @@ Contributing authors: Mike Salerno (NRL) added single methods ------------------------------------------------------------------------- */ -#include +#include #include #include "create_bonds.h" #include "atom.h" diff --git a/src/create_box.cpp b/src/create_box.cpp index b5e37b759c..5ec960bec4 100644 --- a/src/create_box.cpp +++ b/src/create_box.cpp @@ -11,12 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "create_box.h" #include "atom.h" #include "atom_vec.h" -#include "force.h" #include "domain.h" #include "region.h" #include "region_prism.h" diff --git a/src/delete_atoms.cpp b/src/delete_atoms.cpp index 41df167f07..ff4b97a3a4 100644 --- a/src/delete_atoms.cpp +++ b/src/delete_atoms.cpp @@ -11,8 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include +#include #include "delete_atoms.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/delete_bonds.cpp b/src/delete_bonds.cpp index fe32bca879..c4d591543a 100644 --- a/src/delete_bonds.cpp +++ b/src/delete_bonds.cpp @@ -18,7 +18,6 @@ #include "atom.h" #include "atom_vec.h" #include "domain.h" -#include "neighbor.h" #include "comm.h" #include "force.h" #include "group.h" diff --git a/src/deprecated.cpp b/src/deprecated.cpp index b937482669..66ddcfeff4 100644 --- a/src/deprecated.cpp +++ b/src/deprecated.cpp @@ -18,7 +18,6 @@ #include #include "deprecated.h" #include "comm.h" -#include "force.h" #include "error.h" #include "input.h" diff --git a/src/dihedral.cpp b/src/dihedral.cpp index adccf2a490..d2de841dd0 100644 --- a/src/dihedral.cpp +++ b/src/dihedral.cpp @@ -11,13 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "dihedral.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "pair.h" -#include "suffix.h" #include "atom_masks.h" #include "memory.h" #include "error.h" -- GitLab From d918432047743f70a0650713ba7a21f0935d5245 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 28 Jun 2019 09:54:24 -0600 Subject: [PATCH 131/469] Fix issue with compute_duarray --- src/KOKKOS/pair_snap_kokkos_impl.h | 11 +++++----- src/KOKKOS/sna_kokkos.h | 11 +++++----- src/KOKKOS/sna_kokkos_impl.h | 33 +++++++++++++++++++++++------- src/SNAP/compute_snad_atom.cpp | 2 +- src/SNAP/compute_snav_atom.cpp | 2 +- src/SNAP/pair_snap.cpp | 2 +- src/SNAP/sna.cpp | 27 +++++++++++++++++++----- src/SNAP/sna.h | 7 ++++--- 8 files changed, 67 insertions(+), 28 deletions(-) diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index d56db05d19..d0c7e09e84 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -309,7 +309,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokk const int ii = team.league_rank(); const int i = d_ilist[ii]; const int itype = type[i]; - const int ielem = d_map[itype]; + const int ielem = map[itype]; Kokkos::View> d_coeffi(d_coeffelem,ielem,Kokkos::ALL); @@ -601,12 +601,13 @@ void PairSNAPKokkos::operator() (TagPairSNAPCompute::member_type& team, double*, double, double); //ForceSNAP + void compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, double*, double, double, int); //ForceSNAP KOKKOS_INLINE_FUNCTION void compute_dbidrj(const typename Kokkos::TeamPolicy::member_type& team); //ForceSNAP KOKKOS_INLINE_FUNCTION @@ -123,10 +123,11 @@ inline t_sna_1d ulisttot_r, ulisttot_i; t_sna_1d_atomic ulisttot_r_a, ulisttot_i_a; t_sna_1d zlist_r, zlist_i; + t_sna_2d ulist_r_ij, ulist_i_ij; // Per InFlight Interaction t_sna_1d ulist_r, ulist_i; - t_sna_1d_atomic ylist_r, ylist_i; + t_sna_1d ylist_r, ylist_i; // derivatives of data t_sna_2d dulist_r, dulist_i; @@ -171,13 +172,13 @@ inline KOKKOS_INLINE_FUNCTION void addself_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double); // compute_ui KOKKOS_INLINE_FUNCTION - void add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double, double, double); // compute_ui + void add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double, double, double, int); // compute_ui KOKKOS_INLINE_FUNCTION void compute_uarray(const typename Kokkos::TeamPolicy::member_type& team, double, double, double, double, double); // compute_ui - inline + KOKKOS_INLINE_FUNCTION double deltacg(int, int, int); // init_clebsch_gordan inline @@ -185,7 +186,7 @@ inline KOKKOS_INLINE_FUNCTION void compute_duarray(const typename Kokkos::TeamPolicy::member_type& team, double, double, double, // compute_duidrj - double, double, double, double, double); + double, double, double, double, double, int); // Sets the style for the switching function // 0 = none diff --git a/src/KOKKOS/sna_kokkos_impl.h b/src/KOKKOS/sna_kokkos_impl.h index 9b96cb8a16..8cbb3eb3f6 100644 --- a/src/KOKKOS/sna_kokkos_impl.h +++ b/src/KOKKOS/sna_kokkos_impl.h @@ -289,7 +289,7 @@ void SNAKokkos::compute_ui(const typename Kokkos::TeamPolicy::compute_dbidrj(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION void SNAKokkos::compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, - double* rij, double wj, double rcut) + double* rij, double wj, double rcut, int jj) { double rsq, r, x, y, z, z0, theta0, cs, sn; double dz0dr; @@ -797,7 +797,7 @@ void SNAKokkos::compute_duidrj(const typename Kokkos::TeamPolicy::addself_uarraytot(const typename Kokkos::TeamPolicy< template KOKKOS_INLINE_FUNCTION -void SNAKokkos::add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double r, double wj, double rcut) +void SNAKokkos::add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, + double r, double wj, double rcut, int j) { const double sfac = compute_sfac(r, rcut) * wj; @@ -854,10 +855,19 @@ void SNAKokkos::add_uarraytot(const typename Kokkos::TeamPolicy> + ulist_r_j(ulist_r_ij,j,Kokkos::ALL); + Kokkos::View> + ulist_i_j(ulist_i_ij,j,Kokkos::ALL); + Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot_r.span()), [&] (const int& i) { Kokkos::atomic_add(ptrtot_r+i, sfac * ptr_r[i]); Kokkos::atomic_add(ptrtot_i+i, sfac * ptr_i[i]); + + ulist_r_j(i) = ulist_r(i); + ulist_i_j(i) = ulist_i(i); }); } @@ -962,7 +972,7 @@ KOKKOS_INLINE_FUNCTION void SNAKokkos::compute_duarray(const typename Kokkos::TeamPolicy::member_type& team, double x, double y, double z, double z0, double r, double dz0dr, - double wj, double rcut) + double wj, double rcut, int jj) { double r0inv; double a_r, a_i, b_r, b_i; @@ -1006,6 +1016,11 @@ void SNAKokkos::compute_duarray(const typename Kokkos::TeamPolicy> + ulist_r(ulist_r_ij,jj,Kokkos::ALL); + Kokkos::View> + ulist_i(ulist_i_ij,jj,Kokkos::ALL); + dulist_r(0,0) = 0.0; dulist_r(0,1) = 0.0; dulist_r(0,2) = 0.0; @@ -1135,6 +1150,8 @@ void SNAKokkos::create_team_scratch_arrays(const typename Kokkos::Te rcutij = t_sna_1d(team.team_scratch(1),nmax); wj = t_sna_1d(team.team_scratch(1),nmax); inside = t_sna_1i(team.team_scratch(1),nmax); + ulist_r_ij = t_sna_2d(team.team_scratch(1),nmax,idxu_max); + ulist_i_ij = t_sna_2d(team.team_scratch(1),nmax,idxu_max); } template @@ -1151,6 +1168,7 @@ T_INT SNAKokkos::size_team_scratch_arrays() { size += t_sna_1d::shmem_size(nmax); // rcutij size += t_sna_1d::shmem_size(nmax); // wj size += t_sna_1i::shmem_size(nmax); // inside + size += t_sna_2d::shmem_size(nmax,idxu_max)*2; // ulist_ij return size; } @@ -1558,8 +1576,8 @@ double SNAKokkos::memory_usage() bytes += jdim * jdim * jdim * sizeof(int); // idxz_block bytes += jdim * jdim * jdim * sizeof(int); // idxb_block - bytes += idxz_max * sizeof(SNAKK_ZINDICES); // idxz - bytes += idxb_max * sizeof(SNAKK_BINDICES); // idxb + bytes += idxz_max * sizeof(SNAKK_ZINDICES); // idxz + bytes += idxb_max * sizeof(SNAKK_BINDICES); // idxb bytes += jdim * sizeof(double); // bzero @@ -1567,6 +1585,7 @@ double SNAKokkos::memory_usage() bytes += nmax * sizeof(int); // inside bytes += nmax * sizeof(double); // wj bytes += nmax * sizeof(double); // rcutij + bytes += nmax * idxu_max * sizeof(double) * 2; // ulist_ij return bytes; } diff --git a/src/SNAP/compute_snad_atom.cpp b/src/SNAP/compute_snad_atom.cpp index 37587a0aae..0a82cdeb00 100644 --- a/src/SNAP/compute_snad_atom.cpp +++ b/src/SNAP/compute_snad_atom.cpp @@ -263,7 +263,7 @@ void ComputeSNADAtom::compute_peratom() const int j = snaptr->inside[jj]; snaptr->compute_duidrj(snaptr->rij[jj], snaptr->wj[jj], - snaptr->rcutij[jj]); + snaptr->rcutij[jj],jj); snaptr->compute_dbidrj(); // Accumulate -dBi/dRi, -dBi/dRj diff --git a/src/SNAP/compute_snav_atom.cpp b/src/SNAP/compute_snav_atom.cpp index 1f702496ed..374bf32298 100644 --- a/src/SNAP/compute_snav_atom.cpp +++ b/src/SNAP/compute_snav_atom.cpp @@ -258,7 +258,7 @@ void ComputeSNAVAtom::compute_peratom() snaptr->compute_duidrj(snaptr->rij[jj], snaptr->wj[jj], - snaptr->rcutij[jj]); + snaptr->rcutij[jj],jj); snaptr->compute_dbidrj(); // Accumulate -dBi/dRi*Ri, -dBi/dRj*Rj diff --git a/src/SNAP/pair_snap.cpp b/src/SNAP/pair_snap.cpp index f9ba8922a0..4dce39361f 100644 --- a/src/SNAP/pair_snap.cpp +++ b/src/SNAP/pair_snap.cpp @@ -176,7 +176,7 @@ void PairSNAP::compute(int eflag, int vflag) for (int jj = 0; jj < ninside; jj++) { int j = snaptr->inside[jj]; snaptr->compute_duidrj(snaptr->rij[jj], - snaptr->wj[jj],snaptr->rcutij[jj]); + snaptr->wj[jj],snaptr->rcutij[jj],jj); snaptr->compute_deidrj(fij); diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp index ada3f528d2..f9696e1f12 100644 --- a/src/SNAP/sna.cpp +++ b/src/SNAP/sna.cpp @@ -134,6 +134,8 @@ SNA::SNA(LAMMPS* lmp, double rfac0_in, nmax = 0; idxz = NULL; idxb = NULL; + ulist_r_ij = NULL; + ulist_i_ij = NULL; build_indexlist(); create_twojmax_arrays(); @@ -154,6 +156,8 @@ SNA::~SNA() memory->destroy(inside); memory->destroy(wj); memory->destroy(rcutij); + memory->destroy(ulist_r_ij); + memory->destroy(ulist_i_ij); delete[] idxz; delete[] idxb; destroy_twojmax_arrays(); @@ -299,10 +303,14 @@ void SNA::grow_rij(int newnmax) memory->destroy(inside); memory->destroy(wj); memory->destroy(rcutij); + memory->destroy(ulist_r_ij); + memory->destroy(ulist_i_ij); memory->create(rij, nmax, 3, "pair:rij"); memory->create(inside, nmax, "pair:inside"); memory->create(wj, nmax, "pair:wj"); memory->create(rcutij, nmax, "pair:rcutij"); + memory->create(ulist_r_ij, nmax, idxu_max, "sna:ulist_ij"); + memory->create(ulist_i_ij, nmax, idxu_max, "sna:ulist_ij"); } /* ---------------------------------------------------------------------- @@ -334,7 +342,7 @@ void SNA::compute_ui(int jnum) z0 = r / tan(theta0); compute_uarray(x, y, z, z0, r); - add_uarraytot(r, wj[j], rcutij[j]); + add_uarraytot(r, wj[j], rcutij[j], j); } } @@ -826,7 +834,7 @@ void SNA::compute_dbidrj() calculate derivative of Ui w.r.t. atom j ------------------------------------------------------------------------- */ -void SNA::compute_duidrj(double* rij, double wj, double rcut) +void SNA::compute_duidrj(double* rij, double wj, double rcut, int jj) { double rsq, r, x, y, z, z0, theta0, cs, sn; double dz0dr; @@ -843,7 +851,7 @@ void SNA::compute_duidrj(double* rij, double wj, double rcut) z0 = r * cs / sn; dz0dr = z0 / r - (r*rscale0) * (rsq + z0 * z0) / rsq; - compute_duarray(x, y, z, z0, r, dz0dr, wj, rcut); + compute_duarray(x, y, z, z0, r, dz0dr, wj, rcut, jj); } /* ---------------------------------------------------------------------- */ @@ -879,7 +887,7 @@ void SNA::addself_uarraytot(double wself_in) add Wigner U-functions for one neighbor to the total ------------------------------------------------------------------------- */ -void SNA::add_uarraytot(double r, double wj, double rcut) +void SNA::add_uarraytot(double r, double wj, double rcut, int jj) { double sfac; @@ -887,6 +895,9 @@ void SNA::add_uarraytot(double r, double wj, double rcut) sfac *= wj; + double* ulist_r_j = ulist_r_ij[jj]; + double* ulist_i_j = ulist_i_ij[jj]; + for (int j = 0; j <= twojmax; j++) { int jju = idxu_block[j]; for (int mb = 0; mb <= j; mb++) @@ -895,6 +906,9 @@ void SNA::add_uarraytot(double r, double wj, double rcut) sfac * ulist_r[jju]; ulisttot_i[jju] += sfac * ulist_i[jju]; + + ulist_r_j[jju] = ulist_r[jju]; + ulist_i_j[jju] = ulist_i[jju]; jju++; } } @@ -992,7 +1006,7 @@ void SNA::compute_uarray(double x, double y, double z, void SNA::compute_duarray(double x, double y, double z, double z0, double r, double dz0dr, - double wj, double rcut) + double wj, double rcut, int jj) { double r0inv; double a_r, a_i, b_r, b_i; @@ -1036,6 +1050,9 @@ void SNA::compute_duarray(double x, double y, double z, db_i[0] += -r0inv; db_r[1] += r0inv; + double* ulist_r = ulist_r_ij[jj]; + double* ulist_i = ulist_i_ij[jj]; + dulist_r[0][0] = 0.0; dulist_r[0][1] = 0.0; dulist_r[0][2] = 0.0; diff --git a/src/SNAP/sna.h b/src/SNAP/sna.h index 1e08ef123c..81582cf9e5 100644 --- a/src/SNAP/sna.h +++ b/src/SNAP/sna.h @@ -53,7 +53,7 @@ public: // functions for derivatives - void compute_duidrj(double*, double, double); + void compute_duidrj(double*, double, double, int); void compute_dbidrj(); void compute_deidrj(double*); double compute_sfac(double, double); @@ -86,6 +86,7 @@ private: double* ulisttot_r, * ulisttot_i; double* ulist_r, * ulist_i; + double** ulist_r_ij, ** ulist_i_ij; int* idxu_block; double* zlist_r, * zlist_i; @@ -106,13 +107,13 @@ private: void init_rootpqarray(); void zero_uarraytot(); void addself_uarraytot(double); - void add_uarraytot(double, double, double); + void add_uarraytot(double, double, double, int); void compute_uarray(double, double, double, double, double); double deltacg(int, int, int); int compute_ncoeff(); void compute_duarray(double, double, double, - double, double, double, double, double); + double, double, double, double, double, int); // Sets the style for the switching function // 0 = none -- GitLab From 5eabc820240604ef4ea3859d054e6c03febc3827 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 28 Jun 2019 10:17:22 -0600 Subject: [PATCH 132/469] Restore lost changes --- src/KOKKOS/pair_snap_kokkos_impl.h | 9 ++++----- src/KOKKOS/sna_kokkos.h | 4 ++-- 2 files changed, 6 insertions(+), 7 deletions(-) diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index d0c7e09e84..20e04605ce 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -309,7 +309,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokk const int ii = team.league_rank(); const int i = d_ilist[ii]; const int itype = type[i]; - const int ielem = map[itype]; + const int ielem = d_map[itype]; Kokkos::View> d_coeffi(d_coeffelem,ielem,Kokkos::ALL); @@ -603,11 +603,10 @@ void PairSNAPKokkos::operator() (TagPairSNAPCompute::member_type& team, double, double, double, double, double); // compute_ui - KOKKOS_INLINE_FUNCTION + inline double deltacg(int, int, int); // init_clebsch_gordan inline -- GitLab From 5e3a705911e057e2188efca2512394e96a46cc04 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 28 Jun 2019 14:28:45 -0400 Subject: [PATCH 133/469] fix bug caused by a parameter shadowing a class variable --- src/thermo.cpp | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/src/thermo.cpp b/src/thermo.cpp index f4ab7b0779..bba867d195 100644 --- a/src/thermo.cpp +++ b/src/thermo.cpp @@ -406,8 +406,9 @@ void Thermo::compute(int flag) call function to compute property ------------------------------------------------------------------------- */ -void Thermo::call_vfunc(int ifield) +void Thermo::call_vfunc(int ifield_in) { + ifield = ifield_in; (this->*vfunc[ifield])(); } -- GitLab From 31cbccda85de0c04dff11eebe97eabc53b57a738 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 28 Jun 2019 21:38:19 -0400 Subject: [PATCH 134/469] continue cleaning up include file lists --- src/RIGID/fix_shake.cpp | 4 +--- src/dihedral_hybrid.cpp | 3 +-- src/dihedral_zero.cpp | 3 --- src/displace_atoms.cpp | 2 +- src/domain.cpp | 4 ---- src/domain.h | 2 +- src/dump.cpp | 2 -- src/dump_atom.cpp | 1 - src/dump_cfg.cpp | 8 -------- src/dump_custom.cpp | 1 - src/dump_dcd.cpp | 2 -- src/dump_image.cpp | 4 ++-- src/dump_local.cpp | 1 - src/dump_movie.cpp | 3 --- src/dump_xyz.cpp | 1 - src/error.cpp | 1 - src/finish.cpp | 4 ---- src/fix.cpp | 1 - src/fix_adapt.cpp | 2 -- src/fix_addforce.cpp | 1 + src/fix_ave_atom.cpp | 1 - src/fix_ave_chunk.cpp | 2 ++ src/fix_ave_correlate.cpp | 2 ++ src/fix_ave_histo.cpp | 3 ++- src/fix_ave_histo_weight.cpp | 8 +++----- src/fix_ave_time.cpp | 2 ++ src/fix_aveforce.cpp | 1 - src/fix_balance.cpp | 2 -- src/fix_box_relax.cpp | 1 - src/fix_deform.cpp | 1 - src/fix_drag.cpp | 2 +- src/fix_dt_reset.cpp | 2 +- src/fix_external.cpp | 2 -- src/fix_gravity.cpp | 3 +-- src/fix_halt.cpp | 3 +-- src/fix_heat.cpp | 2 +- src/fix_indent.cpp | 3 +-- src/fix_langevin.cpp | 3 --- src/fix_lineforce.cpp | 1 - src/fix_minimize.cpp | 2 -- src/fix_momentum.cpp | 3 ++- src/fix_move.cpp | 2 -- src/fix_neigh_history.cpp | 4 +--- src/fix_neigh_history.h | 1 - src/fix_nh.cpp | 2 -- src/fix_nh_sphere.cpp | 2 +- src/fix_nve.cpp | 1 - src/fix_nve_limit.cpp | 3 +-- src/fix_nve_noforce.cpp | 1 - src/fix_nve_sphere.cpp | 3 --- src/fix_nvt_sllod.cpp | 1 - src/fix_planeforce.cpp | 1 - src/fix_press_berendsen.cpp | 2 -- src/fix_print.cpp | 2 +- src/fix_property_atom.cpp | 2 -- src/fix_read_restart.cpp | 1 - src/fix_recenter.cpp | 2 +- src/fix_respa.cpp | 1 - src/fix_restrain.cpp | 3 +-- 59 files changed, 32 insertions(+), 101 deletions(-) diff --git a/src/RIGID/fix_shake.cpp b/src/RIGID/fix_shake.cpp index 23ced2d0e7..5c202706af 100644 --- a/src/RIGID/fix_shake.cpp +++ b/src/RIGID/fix_shake.cpp @@ -13,11 +13,9 @@ #include #include -#include +#include #include -#include #include "fix_shake.h" -#include "fix_rattle.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/dihedral_hybrid.cpp b/src/dihedral_hybrid.cpp index f3e4823d53..27fd7084bc 100644 --- a/src/dihedral_hybrid.cpp +++ b/src/dihedral_hybrid.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include #include #include "dihedral_hybrid.h" #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/dihedral_zero.cpp b/src/dihedral_zero.cpp index 8145d5f32d..0367477267 100644 --- a/src/dihedral_zero.cpp +++ b/src/dihedral_zero.cpp @@ -15,13 +15,10 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ -#include -#include #include #include "dihedral_zero.h" #include "atom.h" #include "force.h" -#include "comm.h" #include "memory.h" #include "error.h" diff --git a/src/displace_atoms.cpp b/src/displace_atoms.cpp index 7b29b1d3d5..8bae173a1d 100644 --- a/src/displace_atoms.cpp +++ b/src/displace_atoms.cpp @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ #include -#include +#include #include #include "displace_atoms.h" #include "atom.h" diff --git a/src/domain.cpp b/src/domain.cpp index 74d7560c31..197eff514a 100644 --- a/src/domain.cpp +++ b/src/domain.cpp @@ -16,9 +16,7 @@ ------------------------------------------------------------------------- */ #include -#include #include -#include #include #include "domain.h" #include "style_region.h" @@ -37,13 +35,11 @@ #include "output.h" #include "thermo.h" #include "universe.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "utils.h" using namespace LAMMPS_NS; -using namespace MathConst; #define BIG 1.0e20 #define SMALL 1.0e-4 diff --git a/src/domain.h b/src/domain.h index e131d07a1b..a0bda8ae72 100644 --- a/src/domain.h +++ b/src/domain.h @@ -15,9 +15,9 @@ #define LMP_DOMAIN_H #include -#include "pointers.h" #include #include +#include "pointers.h" namespace LAMMPS_NS { diff --git a/src/dump.cpp b/src/dump.cpp index 8fa07a9cb2..b08a4de2ad 100644 --- a/src/dump.cpp +++ b/src/dump.cpp @@ -12,9 +12,7 @@ ------------------------------------------------------------------------- */ #include -#include #include -#include #include "dump.h" #include "atom.h" #include "irregular.h" diff --git a/src/dump_atom.cpp b/src/dump_atom.cpp index 74583f4013..c95256ac21 100644 --- a/src/dump_atom.cpp +++ b/src/dump_atom.cpp @@ -16,7 +16,6 @@ #include "domain.h" #include "atom.h" #include "update.h" -#include "group.h" #include "memory.h" #include "error.h" diff --git a/src/dump_cfg.cpp b/src/dump_cfg.cpp index ddd662c8a6..eb5329e0d1 100644 --- a/src/dump_cfg.cpp +++ b/src/dump_cfg.cpp @@ -16,18 +16,10 @@ Memory efficiency improved by Ray Shan (Sandia) ------------------------------------------------------------------------- */ -#include -#include #include #include "dump_cfg.h" #include "atom.h" #include "domain.h" -#include "comm.h" -#include "modify.h" -#include "compute.h" -#include "input.h" -#include "fix.h" -#include "variable.h" #include "memory.h" #include "error.h" diff --git a/src/dump_custom.cpp b/src/dump_custom.cpp index 17ad4b89ef..75e4e42bcd 100644 --- a/src/dump_custom.cpp +++ b/src/dump_custom.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include #include "dump_custom.h" diff --git a/src/dump_dcd.cpp b/src/dump_dcd.cpp index 384e9089c0..ce669fecfd 100644 --- a/src/dump_dcd.cpp +++ b/src/dump_dcd.cpp @@ -17,8 +17,6 @@ ------------------------------------------------------------------------- */ #include -#include // requires C++-11 -#include #include #include #include "dump_dcd.h" diff --git a/src/dump_image.cpp b/src/dump_image.cpp index 0d63d2e4cb..0b4ca43879 100644 --- a/src/dump_image.cpp +++ b/src/dump_image.cpp @@ -11,20 +11,20 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include -#include #include #include "dump_image.h" #include "image.h" #include "atom.h" +#include "atom_vec.h" #include "atom_vec_line.h" #include "atom_vec_tri.h" #include "atom_vec_body.h" #include "body.h" #include "molecule.h" #include "domain.h" -#include "group.h" #include "force.h" #include "comm.h" #include "modify.h" diff --git a/src/dump_local.cpp b/src/dump_local.cpp index 8dc0554690..f99b7ac06c 100644 --- a/src/dump_local.cpp +++ b/src/dump_local.cpp @@ -15,7 +15,6 @@ #include #include #include "dump_local.h" -#include "atom.h" #include "modify.h" #include "fix.h" #include "compute.h" diff --git a/src/dump_movie.cpp b/src/dump_movie.cpp index 59dfdc3d6e..37d8a37f4d 100644 --- a/src/dump_movie.cpp +++ b/src/dump_movie.cpp @@ -15,13 +15,10 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include -#include #include #include "dump_movie.h" #include "comm.h" #include "force.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/dump_xyz.cpp b/src/dump_xyz.cpp index fd52671d81..4d50cfc2c8 100644 --- a/src/dump_xyz.cpp +++ b/src/dump_xyz.cpp @@ -14,7 +14,6 @@ #include #include "dump_xyz.h" #include "atom.h" -#include "group.h" #include "error.h" #include "memory.h" #include "update.h" diff --git a/src/error.cpp b/src/error.cpp index cc80dcb4d8..8970145b7c 100644 --- a/src/error.cpp +++ b/src/error.cpp @@ -16,7 +16,6 @@ #include #include "error.h" #include "universe.h" -#include "update.h" #include "output.h" #include "input.h" diff --git a/src/finish.cpp b/src/finish.cpp index 1baa6d6fda..77c959b945 100644 --- a/src/finish.cpp +++ b/src/finish.cpp @@ -15,12 +15,10 @@ #include #include #include -#include #include "finish.h" #include "timer.h" #include "universe.h" #include "accelerator_kokkos.h" -#include "accelerator_omp.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" @@ -32,10 +30,8 @@ #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "output.h" #include "memory.h" #include "error.h" -#include "utils.h" #ifdef LMP_USER_OMP #include "modify.h" diff --git a/src/fix.cpp b/src/fix.cpp index 634bc2393d..1913ed483e 100644 --- a/src/fix.cpp +++ b/src/fix.cpp @@ -17,7 +17,6 @@ #include "atom.h" #include "group.h" #include "force.h" -#include "comm.h" #include "atom_masks.h" #include "memory.h" #include "error.h" diff --git a/src/fix_adapt.cpp b/src/fix_adapt.cpp index 9a5b528747..7ac6128558 100644 --- a/src/fix_adapt.cpp +++ b/src/fix_adapt.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include -#include #include "fix_adapt.h" #include "atom.h" #include "bond.h" diff --git a/src/fix_addforce.cpp b/src/fix_addforce.cpp index d66457a1f1..e29c4ffe9f 100644 --- a/src/fix_addforce.cpp +++ b/src/fix_addforce.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include #include "fix_addforce.h" diff --git a/src/fix_ave_atom.cpp b/src/fix_ave_atom.cpp index c8cbad75c9..e6566632de 100644 --- a/src/fix_ave_atom.cpp +++ b/src/fix_ave_atom.cpp @@ -15,7 +15,6 @@ #include #include "fix_ave_atom.h" #include "atom.h" -#include "domain.h" #include "update.h" #include "modify.h" #include "compute.h" diff --git a/src/fix_ave_chunk.cpp b/src/fix_ave_chunk.cpp index 7aed4dcbe7..1533d1fa4f 100644 --- a/src/fix_ave_chunk.cpp +++ b/src/fix_ave_chunk.cpp @@ -11,6 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include +#include // IWYU pragma: keep #include #include #include diff --git a/src/fix_ave_correlate.cpp b/src/fix_ave_correlate.cpp index 5c95f20ec2..555c1ac026 100644 --- a/src/fix_ave_correlate.cpp +++ b/src/fix_ave_correlate.cpp @@ -17,6 +17,8 @@ Reese Jones (Sandia) ------------------------------------------------------------------------- */ +#include +#include // IWYU pragma: keep #include #include #include diff --git a/src/fix_ave_histo.cpp b/src/fix_ave_histo.cpp index 87da5222f0..29fdc21c74 100644 --- a/src/fix_ave_histo.cpp +++ b/src/fix_ave_histo.cpp @@ -11,6 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include +#include // IWYU pragma: keep #include #include #include @@ -19,7 +21,6 @@ #include "update.h" #include "modify.h" #include "compute.h" -#include "group.h" #include "input.h" #include "variable.h" #include "memory.h" diff --git a/src/fix_ave_histo_weight.cpp b/src/fix_ave_histo_weight.cpp index c78f4fa1e3..5eeb074472 100644 --- a/src/fix_ave_histo_weight.cpp +++ b/src/fix_ave_histo_weight.cpp @@ -14,21 +14,19 @@ /* ---------------------------------------------------------------------- Contributing author: Shawn Coleman (ARL) ------------------------------------------------------------------------- */ - -#include -#include +#include +#include // IWYU pragma: keep #include +#include "fix.h" #include "fix_ave_histo_weight.h" #include "atom.h" #include "update.h" #include "modify.h" #include "compute.h" -#include "group.h" #include "input.h" #include "variable.h" #include "memory.h" #include "error.h" -#include "force.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/fix_ave_time.cpp b/src/fix_ave_time.cpp index 50654b6561..4820215f46 100644 --- a/src/fix_ave_time.cpp +++ b/src/fix_ave_time.cpp @@ -15,6 +15,8 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include +#include // IWYU pragma: keep #include #include #include diff --git a/src/fix_aveforce.cpp b/src/fix_aveforce.cpp index 1c87ba5785..4791a8b022 100644 --- a/src/fix_aveforce.cpp +++ b/src/fix_aveforce.cpp @@ -13,7 +13,6 @@ #include #include -#include #include "fix_aveforce.h" #include "atom.h" #include "update.h" diff --git a/src/fix_balance.cpp b/src/fix_balance.cpp index ddaf42b49d..f9c32e8df0 100644 --- a/src/fix_balance.cpp +++ b/src/fix_balance.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include "fix_balance.h" #include "balance.h" #include "update.h" @@ -26,7 +25,6 @@ #include "modify.h" #include "fix_store.h" #include "rcb.h" -#include "timer.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/fix_box_relax.cpp b/src/fix_box_relax.cpp index a315330d14..c73c0ade88 100644 --- a/src/fix_box_relax.cpp +++ b/src/fix_box_relax.cpp @@ -17,7 +17,6 @@ #include #include -#include #include "fix_box_relax.h" #include "atom.h" #include "domain.h" diff --git a/src/fix_deform.cpp b/src/fix_deform.cpp index 909ead3e2a..96d7580c39 100644 --- a/src/fix_deform.cpp +++ b/src/fix_deform.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_deform.h" #include "atom.h" diff --git a/src/fix_drag.cpp b/src/fix_drag.cpp index e4cf12d1ff..006d1c46d0 100644 --- a/src/fix_drag.cpp +++ b/src/fix_drag.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_drag.h" #include "atom.h" diff --git a/src/fix_dt_reset.cpp b/src/fix_dt_reset.cpp index 7566094b48..4e6195c4fa 100644 --- a/src/fix_dt_reset.cpp +++ b/src/fix_dt_reset.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_dt_reset.h" #include "atom.h" diff --git a/src/fix_external.cpp b/src/fix_external.cpp index b1ffa65e49..2c926e26b5 100644 --- a/src/fix_external.cpp +++ b/src/fix_external.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include -#include #include "fix_external.h" #include "atom.h" #include "update.h" diff --git a/src/fix_gravity.cpp b/src/fix_gravity.cpp index bc10eb2807..8508a92cc4 100644 --- a/src/fix_gravity.cpp +++ b/src/fix_gravity.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "fix_gravity.h" #include "atom.h" diff --git a/src/fix_halt.cpp b/src/fix_halt.cpp index 5fda4c30d6..133494fb8e 100644 --- a/src/fix_halt.cpp +++ b/src/fix_halt.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_halt.h" #include "update.h" #include "force.h" -#include "update.h" #include "input.h" #include "variable.h" #include "atom.h" diff --git a/src/fix_heat.cpp b/src/fix_heat.cpp index f34845785c..f78a9c0860 100644 --- a/src/fix_heat.cpp +++ b/src/fix_heat.cpp @@ -15,8 +15,8 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_heat.h" #include "atom.h" diff --git a/src/fix_indent.cpp b/src/fix_indent.cpp index b8e07dfd53..6a42cadefd 100644 --- a/src/fix_indent.cpp +++ b/src/fix_indent.cpp @@ -15,9 +15,9 @@ Contributing author: Ravi Agrawal (Northwestern U) ------------------------------------------------------------------------- */ +#include #include #include -#include #include "fix_indent.h" #include "atom.h" #include "input.h" @@ -26,7 +26,6 @@ #include "lattice.h" #include "update.h" #include "modify.h" -#include "output.h" #include "respa.h" #include "error.h" #include "force.h" diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 36ea47daf6..0f48562048 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -19,7 +19,6 @@ #include #include #include -#include #include "fix_langevin.h" #include "math_extra.h" #include "atom.h" @@ -28,8 +27,6 @@ #include "update.h" #include "modify.h" #include "compute.h" -#include "domain.h" -#include "region.h" #include "respa.h" #include "comm.h" #include "input.h" diff --git a/src/fix_lineforce.cpp b/src/fix_lineforce.cpp index aea1a2a25b..61c6341aa6 100644 --- a/src/fix_lineforce.cpp +++ b/src/fix_lineforce.cpp @@ -13,7 +13,6 @@ #include #include -#include #include "fix_lineforce.h" #include "atom.h" #include "update.h" diff --git a/src/fix_minimize.cpp b/src/fix_minimize.cpp index fa39643a1b..df2dfb02a7 100644 --- a/src/fix_minimize.cpp +++ b/src/fix_minimize.cpp @@ -11,12 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_minimize.h" #include "atom.h" #include "domain.h" #include "memory.h" -#include "error.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/fix_momentum.cpp b/src/fix_momentum.cpp index 680251e670..bf94a94362 100644 --- a/src/fix_momentum.cpp +++ b/src/fix_momentum.cpp @@ -11,7 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include +#include #include #include "fix_momentum.h" #include "atom.h" diff --git a/src/fix_move.cpp b/src/fix_move.cpp index 0a5f506ab2..646f943ef9 100644 --- a/src/fix_move.cpp +++ b/src/fix_move.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_move.h" #include "atom.h" -#include "group.h" #include "update.h" #include "modify.h" #include "force.h" diff --git a/src/fix_neigh_history.cpp b/src/fix_neigh_history.cpp index 207c409596..ca593f29df 100644 --- a/src/fix_neigh_history.cpp +++ b/src/fix_neigh_history.cpp @@ -13,16 +13,14 @@ #include #include -#include #include "fix_neigh_history.h" +#include "my_page.h" #include "atom.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" #include "force.h" #include "pair.h" -#include "update.h" -#include "modify.h" #include "memory.h" #include "error.h" diff --git a/src/fix_neigh_history.h b/src/fix_neigh_history.h index 601e8a55a2..51d03f5b12 100644 --- a/src/fix_neigh_history.h +++ b/src/fix_neigh_history.h @@ -21,7 +21,6 @@ FixStyle(NEIGH_HISTORY,FixNeighHistory) #define LMP_FIX_NEIGH_HISTORY_H #include "fix.h" -#include "my_page.h" namespace LAMMPS_NS { diff --git a/src/fix_nh.cpp b/src/fix_nh.cpp index deca0ad83d..3ffdff54cf 100644 --- a/src/fix_nh.cpp +++ b/src/fix_nh.cpp @@ -16,10 +16,8 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_nh.h" -#include "math_extra.h" #include "atom.h" #include "force.h" #include "group.h" diff --git a/src/fix_nh_sphere.cpp b/src/fix_nh_sphere.cpp index f176493242..0f1024700a 100644 --- a/src/fix_nh_sphere.cpp +++ b/src/fix_nh_sphere.cpp @@ -16,10 +16,10 @@ ------------------------------------------------------------------------- */ #include +#include #include "fix_nh_sphere.h" #include "atom.h" #include "atom_vec.h" -#include "group.h" #include "error.h" #include "force.h" #include "domain.h" diff --git a/src/fix_nve.cpp b/src/fix_nve.cpp index 959483230e..3396f3ca47 100644 --- a/src/fix_nve.cpp +++ b/src/fix_nve.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "fix_nve.h" #include "atom.h" diff --git a/src/fix_nve_limit.cpp b/src/fix_nve_limit.cpp index 68ff0665a1..49bed2e3dd 100644 --- a/src/fix_nve_limit.cpp +++ b/src/fix_nve_limit.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "fix_nve_limit.h" #include "atom.h" diff --git a/src/fix_nve_noforce.cpp b/src/fix_nve_noforce.cpp index d4fca9e676..7b61aac18e 100644 --- a/src/fix_nve_noforce.cpp +++ b/src/fix_nve_noforce.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "fix_nve_noforce.h" #include "atom.h" diff --git a/src/fix_nve_sphere.cpp b/src/fix_nve_sphere.cpp index 0bee8b8685..94e8aa88ac 100644 --- a/src/fix_nve_sphere.cpp +++ b/src/fix_nve_sphere.cpp @@ -12,14 +12,11 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_nve_sphere.h" #include "atom.h" #include "domain.h" #include "atom_vec.h" -#include "update.h" -#include "respa.h" #include "force.h" #include "error.h" #include "math_vector.h" diff --git a/src/fix_nvt_sllod.cpp b/src/fix_nvt_sllod.cpp index c7d23364a7..16e2fb1d3d 100644 --- a/src/fix_nvt_sllod.cpp +++ b/src/fix_nvt_sllod.cpp @@ -15,7 +15,6 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ -#include #include #include "fix_nvt_sllod.h" #include "math_extra.h" diff --git a/src/fix_planeforce.cpp b/src/fix_planeforce.cpp index 45dc782fcf..a83d00a506 100644 --- a/src/fix_planeforce.cpp +++ b/src/fix_planeforce.cpp @@ -13,7 +13,6 @@ #include #include -#include #include "fix_planeforce.h" #include "atom.h" #include "update.h" diff --git a/src/fix_press_berendsen.cpp b/src/fix_press_berendsen.cpp index 95db004436..ad3e3d1e1c 100644 --- a/src/fix_press_berendsen.cpp +++ b/src/fix_press_berendsen.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_press_berendsen.h" #include "atom.h" @@ -23,7 +22,6 @@ #include "compute.h" #include "kspace.h" #include "update.h" -#include "respa.h" #include "domain.h" #include "error.h" diff --git a/src/fix_print.cpp b/src/fix_print.cpp index f6db88114a..da2e2b54f3 100644 --- a/src/fix_print.cpp +++ b/src/fix_print.cpp @@ -11,7 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include #include "fix_print.h" #include "update.h" diff --git a/src/fix_property_atom.cpp b/src/fix_property_atom.cpp index c89419f850..62c3ec985b 100644 --- a/src/fix_property_atom.cpp +++ b/src/fix_property_atom.cpp @@ -19,8 +19,6 @@ #include "memory.h" #include "error.h" -#include "update.h" - using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/fix_read_restart.cpp b/src/fix_read_restart.cpp index 3c3178f4af..afedf9c12c 100644 --- a/src/fix_read_restart.cpp +++ b/src/fix_read_restart.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_read_restart.h" #include "atom.h" #include "memory.h" diff --git a/src/fix_recenter.cpp b/src/fix_recenter.cpp index 75b383d67a..cd50d7dc34 100644 --- a/src/fix_recenter.cpp +++ b/src/fix_recenter.cpp @@ -15,7 +15,7 @@ Contributing author: Naveen Michaud-Agrawal (Johns Hopkins U) ------------------------------------------------------------------------- */ -#include +#include #include #include "fix_recenter.h" #include "atom.h" diff --git a/src/fix_respa.cpp b/src/fix_respa.cpp index 64461ba7ca..ea2eb5050a 100644 --- a/src/fix_respa.cpp +++ b/src/fix_respa.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "fix_respa.h" #include "atom.h" diff --git a/src/fix_restrain.cpp b/src/fix_restrain.cpp index 08485d65b3..3b9980d567 100644 --- a/src/fix_restrain.cpp +++ b/src/fix_restrain.cpp @@ -16,9 +16,9 @@ support for bond and angle restraints by Andres Jaramillo-Botero (Caltech) ------------------------------------------------------------------------- */ +#include #include #include -#include #include "fix_restrain.h" #include "atom.h" #include "force.h" @@ -26,7 +26,6 @@ #include "domain.h" #include "comm.h" #include "respa.h" -#include "input.h" #include "math_const.h" #include "memory.h" #include "error.h" -- GitLab From 96744c49338448068b16c1fe24ad2557460b13b1 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 29 Jun 2019 21:30:23 -0400 Subject: [PATCH 135/469] more include file cleanup --- src/BODY/body_nparticle.cpp | 1 + src/BODY/body_rounded_polygon.cpp | 1 + src/BODY/body_rounded_polyhedron.cpp | 1 + src/fix_setforce.cpp | 2 +- src/fix_spring.cpp | 2 -- src/fix_spring_chunk.cpp | 2 -- src/fix_spring_rg.cpp | 2 -- src/fix_spring_self.cpp | 2 +- src/fix_store.cpp | 1 - src/fix_store_force.cpp | 1 - src/fix_temp_berendsen.cpp | 1 - src/fix_temp_csld.cpp | 1 - src/fix_temp_csvr.cpp | 3 +-- src/fix_temp_rescale.cpp | 3 --- src/fix_tmd.cpp | 1 - src/fix_vector.cpp | 1 - src/fix_viscous.cpp | 2 -- src/fix_wall.cpp | 4 +--- src/fix_wall_harmonic.cpp | 1 - src/fix_wall_reflect.cpp | 1 - src/fix_wall_region.cpp | 5 +---- src/force.cpp | 3 --- src/group.cpp | 3 +-- src/hashlittle.cpp | 1 - src/image.cpp | 3 +-- src/imbalance.h | 2 +- src/imbalance_var.cpp | 4 +--- src/improper.cpp | 1 - src/improper_hybrid.cpp | 3 +-- src/improper_zero.cpp | 3 --- src/info.cpp | 12 ++++++------ src/input.cpp | 5 ----- src/integrate.cpp | 1 - src/irregular.cpp | 1 - src/irregular.h | 1 + src/kspace.cpp | 2 ++ src/kspace.h | 1 + src/lammps.cpp | 1 - src/library.cpp | 4 +--- src/library.h | 2 ++ src/math_extra.h | 3 --- src/memory.cpp | 2 -- src/memory.h | 1 - src/min.cpp | 2 +- src/min_cg.cpp | 2 -- src/min_fire.cpp | 2 +- src/min_hftn.cpp | 1 + src/min_linesearch.cpp | 7 ++----- src/min_quickmin.cpp | 1 - src/min_sd.cpp | 2 -- src/minimize.cpp | 1 - src/modify.cpp | 1 - src/molecule.cpp | 6 +++--- src/nbin.cpp | 2 +- src/neigh_list.cpp | 4 +--- src/neigh_list.h | 1 - src/neighbor.cpp | 3 --- src/neighbor.h | 1 - src/npair_copy.cpp | 7 ------- src/npair_full_bin.cpp | 1 - src/npair_full_bin_atomonly.cpp | 2 -- src/procmap.cpp | 1 + 62 files changed, 37 insertions(+), 107 deletions(-) diff --git a/src/BODY/body_nparticle.cpp b/src/BODY/body_nparticle.cpp index 21070107f5..b2d9dbaca3 100644 --- a/src/BODY/body_nparticle.cpp +++ b/src/BODY/body_nparticle.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "body_nparticle.h" #include "my_pool_chunk.h" diff --git a/src/BODY/body_rounded_polygon.cpp b/src/BODY/body_rounded_polygon.cpp index f7741ada88..6e1e49319e 100644 --- a/src/BODY/body_rounded_polygon.cpp +++ b/src/BODY/body_rounded_polygon.cpp @@ -15,6 +15,7 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include #include #include "body_rounded_polygon.h" #include "my_pool_chunk.h" diff --git a/src/BODY/body_rounded_polyhedron.cpp b/src/BODY/body_rounded_polyhedron.cpp index 34d918f1f6..4b5208c397 100644 --- a/src/BODY/body_rounded_polyhedron.cpp +++ b/src/BODY/body_rounded_polyhedron.cpp @@ -15,6 +15,7 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include #include #include "body_rounded_polyhedron.h" #include "my_pool_chunk.h" diff --git a/src/fix_setforce.cpp b/src/fix_setforce.cpp index fc8b7aeb59..f01008dc10 100644 --- a/src/fix_setforce.cpp +++ b/src/fix_setforce.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include "fix_setforce.h" #include "atom.h" #include "update.h" diff --git a/src/fix_spring.cpp b/src/fix_spring.cpp index 328a0eeafd..c87cec2766 100644 --- a/src/fix_spring.cpp +++ b/src/fix_spring.cpp @@ -16,13 +16,11 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_spring.h" #include "atom.h" #include "update.h" #include "respa.h" -#include "domain.h" #include "force.h" #include "group.h" #include "error.h" diff --git a/src/fix_spring_chunk.cpp b/src/fix_spring_chunk.cpp index 5b5d95b111..f6ebadde94 100644 --- a/src/fix_spring_chunk.cpp +++ b/src/fix_spring_chunk.cpp @@ -12,14 +12,12 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_spring_chunk.h" #include "atom.h" #include "update.h" #include "force.h" #include "respa.h" -#include "domain.h" #include "modify.h" #include "compute_chunk_atom.h" #include "compute_com_chunk.h" diff --git a/src/fix_spring_rg.cpp b/src/fix_spring_rg.cpp index 28c8969006..1d5b87c599 100644 --- a/src/fix_spring_rg.cpp +++ b/src/fix_spring_rg.cpp @@ -16,8 +16,6 @@ Paul Crozier (SNL) ------------------------------------------------------------------------- */ -#include -#include #include #include "fix_spring_rg.h" #include "atom.h" diff --git a/src/fix_spring_self.cpp b/src/fix_spring_self.cpp index 670883af41..a5aa600229 100644 --- a/src/fix_spring_self.cpp +++ b/src/fix_spring_self.cpp @@ -15,7 +15,7 @@ Contributing author: Naveen Michaud-Agrawal (Johns Hopkins University) ------------------------------------------------------------------------- */ -#include +#include #include #include "fix_spring_self.h" #include "atom.h" diff --git a/src/fix_store.cpp b/src/fix_store.cpp index 9db65d0987..a370632489 100644 --- a/src/fix_store.cpp +++ b/src/fix_store.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "fix_store.h" #include "atom.h" diff --git a/src/fix_store_force.cpp b/src/fix_store_force.cpp index a841714098..8afd985615 100644 --- a/src/fix_store_force.cpp +++ b/src/fix_store_force.cpp @@ -15,7 +15,6 @@ #include "fix_store_force.h" #include "atom.h" #include "update.h" -#include "group.h" #include "respa.h" #include "memory.h" #include "error.h" diff --git a/src/fix_temp_berendsen.cpp b/src/fix_temp_berendsen.cpp index 55518015c4..b4dd65b0c5 100644 --- a/src/fix_temp_berendsen.cpp +++ b/src/fix_temp_berendsen.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_temp_berendsen.h" #include "atom.h" diff --git a/src/fix_temp_csld.cpp b/src/fix_temp_csld.cpp index 7bdf776355..57f7104c61 100644 --- a/src/fix_temp_csld.cpp +++ b/src/fix_temp_csld.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_temp_csld.h" #include "atom.h" diff --git a/src/fix_temp_csvr.cpp b/src/fix_temp_csvr.cpp index 495a155113..9f8135ffc8 100644 --- a/src/fix_temp_csvr.cpp +++ b/src/fix_temp_csvr.cpp @@ -16,13 +16,12 @@ Based on code by Paolo Raiteri (Curtin U) and Giovanni Bussi (SISSA) ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_temp_csvr.h" #include "atom.h" #include "force.h" -#include "memory.h" #include "comm.h" #include "input.h" #include "variable.h" diff --git a/src/fix_temp_rescale.cpp b/src/fix_temp_rescale.cpp index 11dfa6a5fc..378997c0c4 100644 --- a/src/fix_temp_rescale.cpp +++ b/src/fix_temp_rescale.cpp @@ -12,15 +12,12 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_temp_rescale.h" #include "atom.h" #include "force.h" #include "group.h" #include "update.h" -#include "domain.h" -#include "region.h" #include "comm.h" #include "input.h" #include "variable.h" diff --git a/src/fix_tmd.cpp b/src/fix_tmd.cpp index 4cbb244bc0..a0425db36c 100644 --- a/src/fix_tmd.cpp +++ b/src/fix_tmd.cpp @@ -18,7 +18,6 @@ #include #include -#include #include #include "fix_tmd.h" #include "atom.h" diff --git a/src/fix_vector.cpp b/src/fix_vector.cpp index 5657e59ab0..b7be472be6 100644 --- a/src/fix_vector.cpp +++ b/src/fix_vector.cpp @@ -18,7 +18,6 @@ #include "force.h" #include "modify.h" #include "compute.h" -#include "group.h" #include "input.h" #include "variable.h" #include "memory.h" diff --git a/src/fix_viscous.cpp b/src/fix_viscous.cpp index e845142322..cc60b1bda4 100644 --- a/src/fix_viscous.cpp +++ b/src/fix_viscous.cpp @@ -11,8 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include #include "fix_viscous.h" #include "atom.h" diff --git a/src/fix_wall.cpp b/src/fix_wall.cpp index e84d01191d..1046efc2df 100644 --- a/src/fix_wall.cpp +++ b/src/fix_wall.cpp @@ -11,11 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include #include #include "fix_wall.h" -#include "atom.h" #include "input.h" #include "variable.h" #include "domain.h" diff --git a/src/fix_wall_harmonic.cpp b/src/fix_wall_harmonic.cpp index 4dc067178a..6c6d5ec402 100644 --- a/src/fix_wall_harmonic.cpp +++ b/src/fix_wall_harmonic.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_wall_harmonic.h" #include "atom.h" #include "error.h" diff --git a/src/fix_wall_reflect.cpp b/src/fix_wall_reflect.cpp index 8acba72035..edf5c40a5f 100644 --- a/src/fix_wall_reflect.cpp +++ b/src/fix_wall_reflect.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "fix_wall_reflect.h" #include "atom.h" diff --git a/src/fix_wall_region.cpp b/src/fix_wall_region.cpp index ff147d7446..cb1c3c2ab2 100644 --- a/src/fix_wall_region.cpp +++ b/src/fix_wall_region.cpp @@ -11,18 +11,15 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_wall_region.h" #include "atom.h" -#include "atom_vec.h" #include "domain.h" #include "region.h" #include "force.h" -#include "lattice.h" #include "update.h" -#include "output.h" #include "respa.h" #include "error.h" #include "math_const.h" diff --git a/src/force.cpp b/src/force.cpp index 2648358932..e4939a10e8 100644 --- a/src/force.cpp +++ b/src/force.cpp @@ -21,7 +21,6 @@ #include "style_improper.h" #include "style_pair.h" #include "style_kspace.h" -#include "atom.h" #include "comm.h" #include "pair.h" #include "pair_hybrid.h" @@ -32,8 +31,6 @@ #include "dihedral.h" #include "improper.h" #include "kspace.h" -#include "group.h" -#include "memory.h" #include "error.h" #include "utils.h" diff --git a/src/group.cpp b/src/group.cpp index 256bab7778..a37d209947 100644 --- a/src/group.cpp +++ b/src/group.cpp @@ -13,9 +13,8 @@ #include #include -#include #include -#include +#include #include "group.h" #include "domain.h" #include "atom.h" diff --git a/src/hashlittle.cpp b/src/hashlittle.cpp index 42109abd24..e9340a7e55 100644 --- a/src/hashlittle.cpp +++ b/src/hashlittle.cpp @@ -2,7 +2,6 @@ // from lookup3.c, by Bob Jenkins, May 2006, Public Domain // bob_jenkins@burtleburtle.net -#include #include #include diff --git a/src/image.cpp b/src/image.cpp index 3df167bbf6..ccd6d98d87 100644 --- a/src/image.cpp +++ b/src/image.cpp @@ -18,7 +18,6 @@ #include #include #include -#include #include #include "image.h" #include "math_extra.h" @@ -29,7 +28,7 @@ #include "memory.h" #ifdef LAMMPS_JPEG -#include "jpeglib.h" +#include #endif #ifdef LAMMPS_PNG diff --git a/src/imbalance.h b/src/imbalance.h index 5f43c2e51d..0cc4ac844e 100644 --- a/src/imbalance.h +++ b/src/imbalance.h @@ -14,7 +14,7 @@ #ifndef LMP_IMBALANCE_H #define LMP_IMBALANCE_H -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/imbalance_var.cpp b/src/imbalance_var.cpp index e089b1df0c..ba17c06866 100644 --- a/src/imbalance_var.cpp +++ b/src/imbalance_var.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "imbalance_var.h" #include "atom.h" @@ -20,9 +21,6 @@ #include "memory.h" #include "error.h" -// DEBUG -#include "update.h" - using namespace LAMMPS_NS; /* -------------------------------------------------------------------- */ diff --git a/src/improper.cpp b/src/improper.cpp index 17e2df4e59..eefe3222ee 100644 --- a/src/improper.cpp +++ b/src/improper.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "improper.h" #include "atom.h" #include "comm.h" diff --git a/src/improper_hybrid.cpp b/src/improper_hybrid.cpp index 5fdcb42a96..af1382d3eb 100644 --- a/src/improper_hybrid.cpp +++ b/src/improper_hybrid.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include #include #include "improper_hybrid.h" #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/improper_zero.cpp b/src/improper_zero.cpp index 747dd57919..3f36954a0a 100644 --- a/src/improper_zero.cpp +++ b/src/improper_zero.cpp @@ -15,13 +15,10 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ -#include -#include #include #include "improper_zero.h" #include "atom.h" #include "force.h" -#include "comm.h" #include "memory.h" #include "error.h" diff --git a/src/info.cpp b/src/info.cpp index 25b9879408..bb2d3c4b45 100644 --- a/src/info.cpp +++ b/src/info.cpp @@ -16,7 +16,13 @@ Richard Berger (Temple U) ------------------------------------------------------------------------- */ +#include +#include #include +#include +#include +#include +#include #include "info.h" #include "accelerator_kokkos.h" #include "atom.h" @@ -44,18 +50,12 @@ #include "error.h" #include "utils.h" -#include -#include -#include -#include - #ifdef _WIN32 #define PSAPI_VERSION 1 #include #include // requires C++-11 #include #else -#include #include #include #endif diff --git a/src/input.cpp b/src/input.cpp index 9e0ad78d9e..cbad1d78bf 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include #include @@ -52,10 +51,6 @@ #include "memory.h" #include "utils.h" -#ifdef _OPENMP -#include -#endif - #ifdef _WIN32 #include #endif diff --git a/src/integrate.cpp b/src/integrate.cpp index d6b27e042d..545de849d5 100644 --- a/src/integrate.cpp +++ b/src/integrate.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "integrate.h" #include "update.h" #include "force.h" diff --git a/src/irregular.cpp b/src/irregular.cpp index 1865f9cbf6..2040d12d0b 100644 --- a/src/irregular.cpp +++ b/src/irregular.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "irregular.h" #include "atom.h" diff --git a/src/irregular.h b/src/irregular.h index d56bcb253d..3fdfe20b36 100644 --- a/src/irregular.h +++ b/src/irregular.h @@ -14,6 +14,7 @@ #ifndef LMP_IRREGULAR_H #define LMP_IRREGULAR_H +#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/kspace.cpp b/src/kspace.cpp index 643cf22113..b51191857d 100644 --- a/src/kspace.cpp +++ b/src/kspace.cpp @@ -11,6 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include +#include #include #include #include "kspace.h" diff --git a/src/kspace.h b/src/kspace.h index 69f4ccb433..83ce19cd87 100644 --- a/src/kspace.h +++ b/src/kspace.h @@ -14,6 +14,7 @@ #ifndef LMP_KSPACE_H #define LMP_KSPACE_H +#include #include "pointers.h" #ifdef FFT_SINGLE diff --git a/src/lammps.cpp b/src/lammps.cpp index 83a2f057ee..b73d9f1968 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -48,7 +48,6 @@ #include "output.h" #include "citeme.h" #include "accelerator_kokkos.h" -#include "accelerator_omp.h" #include "timer.h" #include "lmppython.h" #include "version.h" diff --git a/src/library.cpp b/src/library.cpp index a653b83adb..033b814865 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -15,13 +15,11 @@ // customize by adding new LAMMPS-specific functions #include +#include #include #include #include "library.h" -#include "lmptype.h" -#include "lammps.h" #include "universe.h" -#include "input.h" #include "atom_vec.h" #include "atom.h" #include "domain.h" diff --git a/src/library.h b/src/library.h index f6f8d9d75c..8b03bb3621 100644 --- a/src/library.h +++ b/src/library.h @@ -17,7 +17,9 @@ */ #include +#ifdef LAMMPS_BIGBIG #include /* for int64_t */ +#endif /* ifdefs allow this file to be included in a C program */ diff --git a/src/math_extra.h b/src/math_extra.h index 85f57224cf..09b135c641 100644 --- a/src/math_extra.h +++ b/src/math_extra.h @@ -19,9 +19,6 @@ #define LMP_MATH_EXTRA_H #include -#include -#include -#include "error.h" namespace MathExtra { diff --git a/src/memory.cpp b/src/memory.cpp index b2f8a95b17..ca7fd3ea7f 100644 --- a/src/memory.cpp +++ b/src/memory.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include -#include #include "memory.h" #include "error.h" diff --git a/src/memory.h b/src/memory.h index c5eddc7fe7..42c9bf6aba 100644 --- a/src/memory.h +++ b/src/memory.h @@ -14,7 +14,6 @@ #ifndef LMP_MEMORY_H #define LMP_MEMORY_H -#include "lmptype.h" #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/min.cpp b/src/min.cpp index 2a42a444a0..f2e1c982be 100644 --- a/src/min.cpp +++ b/src/min.cpp @@ -19,8 +19,8 @@ JR Shewchuk, http://www-2.cs.cmu.edu/~jrs/jrspapers.html#cg ------------------------------------------------------------------------- */ +#include #include -#include #include #include "min.h" #include "atom.h" diff --git a/src/min_cg.cpp b/src/min_cg.cpp index 20e8cc30dd..eb8831c8f5 100644 --- a/src/min_cg.cpp +++ b/src/min_cg.cpp @@ -13,9 +13,7 @@ #include #include -#include #include "min_cg.h" -#include "atom.h" #include "update.h" #include "output.h" #include "timer.h" diff --git a/src/min_fire.cpp b/src/min_fire.cpp index a50071d562..79346341bb 100644 --- a/src/min_fire.cpp +++ b/src/min_fire.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "min_fire.h" #include "universe.h" @@ -19,7 +20,6 @@ #include "update.h" #include "output.h" #include "timer.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/min_hftn.cpp b/src/min_hftn.cpp index 0c834fbeb4..c2c251c386 100644 --- a/src/min_hftn.cpp +++ b/src/min_hftn.cpp @@ -17,6 +17,7 @@ "Parallel Unconstrained Min", Plantenga, SAND98-8201 ------------------------------------------------------------------------- */ +#include #include #include #include "atom.h" diff --git a/src/min_linesearch.cpp b/src/min_linesearch.cpp index f93a56b09d..33a781ecfe 100644 --- a/src/min_linesearch.cpp +++ b/src/min_linesearch.cpp @@ -21,19 +21,16 @@ JR Shewchuk, http://www-2.cs.cmu.edu/~jrs/jrspapers.html#cg ------------------------------------------------------------------------- */ +#include #include #include "min_linesearch.h" #include "atom.h" -#include "update.h" -#include "neighbor.h" -#include "domain.h" #include "modify.h" +#include "neighbor.h" #include "fix_minimize.h" #include "pair.h" #include "output.h" #include "thermo.h" -#include "timer.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/min_quickmin.cpp b/src/min_quickmin.cpp index 8b48816355..784da82686 100644 --- a/src/min_quickmin.cpp +++ b/src/min_quickmin.cpp @@ -20,7 +20,6 @@ #include "update.h" #include "output.h" #include "timer.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/min_sd.cpp b/src/min_sd.cpp index 5d44437ca0..d66601119b 100644 --- a/src/min_sd.cpp +++ b/src/min_sd.cpp @@ -12,9 +12,7 @@ ------------------------------------------------------------------------- */ #include -#include #include "min_sd.h" -#include "atom.h" #include "update.h" #include "output.h" #include "timer.h" diff --git a/src/minimize.cpp b/src/minimize.cpp index e27fffd74b..e1af924019 100644 --- a/src/minimize.cpp +++ b/src/minimize.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "minimize.h" #include "domain.h" #include "update.h" diff --git a/src/modify.cpp b/src/modify.cpp index 3f034bf034..61497d86db 100644 --- a/src/modify.cpp +++ b/src/modify.cpp @@ -11,7 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include "modify.h" #include "style_compute.h" diff --git a/src/molecule.cpp b/src/molecule.cpp index 454459084a..4a3790296f 100644 --- a/src/molecule.cpp +++ b/src/molecule.cpp @@ -11,7 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include +#include +#include #include #include "molecule.h" #include "atom.h" @@ -21,12 +23,10 @@ #include "comm.h" #include "domain.h" #include "math_extra.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; #define MAXLINE 256 #define EPSILON 1.0e-7 diff --git a/src/nbin.cpp b/src/nbin.cpp index a30b76cca0..0480c9730d 100644 --- a/src/nbin.cpp +++ b/src/nbin.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include "nbin.h" #include "neighbor.h" #include "neigh_request.h" #include "domain.h" -#include "update.h" #include "memory.h" #include "error.h" diff --git a/src/neigh_list.cpp b/src/neigh_list.cpp index 6bdb9beae6..651b2ed70a 100644 --- a/src/neigh_list.cpp +++ b/src/neigh_list.cpp @@ -12,15 +12,13 @@ ------------------------------------------------------------------------- */ #include "neigh_list.h" +#include "my_page.h" #include "atom.h" #include "comm.h" -#include "update.h" -#include "pair.h" #include "neighbor.h" #include "neigh_request.h" #include "my_page.h" #include "memory.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/neigh_list.h b/src/neigh_list.h index 755a1bf134..aca11cd921 100644 --- a/src/neigh_list.h +++ b/src/neigh_list.h @@ -15,7 +15,6 @@ #define LMP_NEIGH_LIST_H #include "pointers.h" -#include "my_page.h" namespace LAMMPS_NS { diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 0382624198..a2efc5919b 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -17,7 +17,6 @@ #include #include -#include #include #include "neighbor.h" #include "neigh_list.h" @@ -48,8 +47,6 @@ #include "error.h" #include "utils.h" -#include - using namespace LAMMPS_NS; using namespace NeighConst; diff --git a/src/neighbor.h b/src/neighbor.h index 3466dd426a..50de4b4c98 100644 --- a/src/neighbor.h +++ b/src/neighbor.h @@ -15,7 +15,6 @@ #define LMP_NEIGHBOR_H #include "pointers.h" -#include namespace LAMMPS_NS { diff --git a/src/npair_copy.cpp b/src/npair_copy.cpp index 9426d22ed3..0a522c628d 100644 --- a/src/npair_copy.cpp +++ b/src/npair_copy.cpp @@ -12,14 +12,7 @@ ------------------------------------------------------------------------- */ #include "npair_copy.h" -#include "neighbor.h" #include "neigh_list.h" -#include "atom.h" -#include "atom_vec.h" -#include "molecule.h" -#include "domain.h" -#include "my_page.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/npair_full_bin.cpp b/src/npair_full_bin.cpp index 94a6af129c..464dca9251 100644 --- a/src/npair_full_bin.cpp +++ b/src/npair_full_bin.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_full_bin.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_full_bin_atomonly.cpp b/src/npair_full_bin_atomonly.cpp index db84733f1c..758fc7e42b 100644 --- a/src/npair_full_bin_atomonly.cpp +++ b/src/npair_full_bin_atomonly.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "npair_full_bin_atomonly.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/procmap.cpp b/src/procmap.cpp index 9d1ed83e73..08b60a26af 100644 --- a/src/procmap.cpp +++ b/src/procmap.cpp @@ -15,6 +15,7 @@ Contributing author (NUMA option) : Mike Brown (ORNL) ------------------------------------------------------------------------- */ +#include #include "procmap.h" #include "universe.h" #include "comm.h" -- GitLab From 3e88dacd3f351ad4a373a27b76d6799d7e1558c9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 30 Jun 2019 17:27:29 -0400 Subject: [PATCH 136/469] recover broken compilation of the USER-EFF package --- src/USER-EFF/fix_nvt_sllod_eff.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/USER-EFF/fix_nvt_sllod_eff.cpp b/src/USER-EFF/fix_nvt_sllod_eff.cpp index ed2274dcf9..0ebbf04d64 100644 --- a/src/USER-EFF/fix_nvt_sllod_eff.cpp +++ b/src/USER-EFF/fix_nvt_sllod_eff.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include +#include #include #include "fix_nvt_sllod_eff.h" #include "math_extra.h" -- GitLab From e29361523f472a67ca2c7309b7b6da3c9b29aef4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 30 Jun 2019 18:30:59 -0400 Subject: [PATCH 137/469] recover compilation of the USER-PHONON package --- src/USER-PHONON/dynamical_matrix.cpp | 7 +++---- 1 file changed, 3 insertions(+), 4 deletions(-) diff --git a/src/USER-PHONON/dynamical_matrix.cpp b/src/USER-PHONON/dynamical_matrix.cpp index d94bd11a80..559ef4c36f 100644 --- a/src/USER-PHONON/dynamical_matrix.cpp +++ b/src/USER-PHONON/dynamical_matrix.cpp @@ -3,15 +3,15 @@ // #include -#include +#include +#include #include "dynamical_matrix.h" #include "atom.h" -#include "modify.h" #include "domain.h" #include "comm.h" +#include "error.h" #include "group.h" #include "force.h" -#include "math_extra.h" #include "memory.h" #include "bond.h" #include "angle.h" @@ -25,7 +25,6 @@ #include "finish.h" #include - using namespace LAMMPS_NS; enum{REGULAR,ESKM}; -- GitLab From 78af59438101a989c6c1a5708601f7ba4a474f95 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 30 Jun 2019 22:45:41 -0400 Subject: [PATCH 138/469] fix typos. restore compilation of LAMMPS class implementation with OpenMP --- doc/include-file-conventions.md | 12 ++++++------ src/lammps.cpp | 1 + 2 files changed, 7 insertions(+), 6 deletions(-) diff --git a/doc/include-file-conventions.md b/doc/include-file-conventions.md index 8d70d6cdec..3f591361f5 100644 --- a/doc/include-file-conventions.md +++ b/doc/include-file-conventions.md @@ -25,7 +25,7 @@ well as make otherwise hidden dependencies visible. ## Rules -Below are the various rules that are applied. Not all a enforced +Below are the various rules that are applied. Not all are enforced strictly and automatically. If there are no significant side effects, exceptions may be possible for cases, where a full compliance to the rules may require a large effort compared to the benefit. @@ -78,9 +78,9 @@ result in a high potential for direct or indirect symbol name clashes. In the ideal case, the header would only include one file defining the parent class. That would typically be either `#include "pointers.h"` for the `Pointers` class, or a header of a class derived from it like -`#include "pair.h"` for the `Pair` class and so on. Referenced to other +`#include "pair.h"` for the `Pair` class and so on. References to other classes inside the class should be make through pointers, for which forward -declarations (inside the `LAMMPS_NS` or the new class'es namespace) can +declarations (inside the `LAMMPS_NS` or the new class' namespace) can be employed. The full definition will then be included into the corresponding implementation file. In the given example from above, the header file would be called `some_name.h` and the implementation `some_name.cpp` (all @@ -92,7 +92,7 @@ a forward slash). In the implementation files (typically, those would have the same base name as the corresponding header with a .cpp extension instead of .h) include -statments should follow the "include what you use" principle. +statements should follow the "include what you use" principle. ### Order of Include Statements @@ -107,7 +107,7 @@ Include files should be included in this order: #### pointers.h The `pointer.h` header file also includes `cstdio` and `lmptype.h` -(and throught it `stdint.h`, `intttypes.h`, and `climits`). +(and through it `stdint.h`, `intttypes.h`, and `climits`). This means any header including `pointers.h` can assume that `FILE`, `NULL`, `INT_MAX` are defined. @@ -115,7 +115,7 @@ This means any header including `pointers.h` can assume that `FILE`, The [Include What You Use tool](https://include-what-you-use.org/) can be used to provide supporting information about compliance with -the rules listed here. There are some limitations and the IWWU tool +the rules listed here. There are some limitations and the IWYU tool may give incorrect advice. The tools is activated by setting the CMake variable `CMAKE_CXX_INCLUDE_WHAT_YOU_USE` variable to the path of the `include-what-you-use` command. When activated, the diff --git a/src/lammps.cpp b/src/lammps.cpp index b73d9f1968..83a2f057ee 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -48,6 +48,7 @@ #include "output.h" #include "citeme.h" #include "accelerator_kokkos.h" +#include "accelerator_omp.h" #include "timer.h" #include "lmppython.h" #include "version.h" -- GitLab From e0c04355bb1019ee3ce37242a2cd426dedaef128 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 30 Jun 2019 22:59:44 -0400 Subject: [PATCH 139/469] try to recover compiling of USER-OMP with OpenMP enabled --- src/USER-OMP/fix_neigh_history_omp.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/USER-OMP/fix_neigh_history_omp.cpp b/src/USER-OMP/fix_neigh_history_omp.cpp index efa7f5a3f1..be03e1d8f2 100644 --- a/src/USER-OMP/fix_neigh_history_omp.cpp +++ b/src/USER-OMP/fix_neigh_history_omp.cpp @@ -14,6 +14,7 @@ #include #include #include "fix_neigh_history_omp.h" +#include "my_page.h" #include "atom.h" #include "comm.h" #include "neighbor.h" -- GitLab From 44372f52369cb101a3ca6757035d9e1ec2443fb6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 30 Jun 2019 23:12:08 -0400 Subject: [PATCH 140/469] more fixes for USER-OMP --- src/USER-OMP/fix_rigid_nh_omp.cpp | 6 ++++-- src/USER-OMP/fix_rigid_omp.cpp | 6 ++++-- src/USER-OMP/fix_rigid_small_omp.cpp | 4 ++-- src/lammps.cpp | 2 +- 4 files changed, 11 insertions(+), 7 deletions(-) diff --git a/src/USER-OMP/fix_rigid_nh_omp.cpp b/src/USER-OMP/fix_rigid_nh_omp.cpp index 53d0134741..e6a6e065bf 100644 --- a/src/USER-OMP/fix_rigid_nh_omp.cpp +++ b/src/USER-OMP/fix_rigid_nh_omp.cpp @@ -15,6 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include +#include + #include "fix_rigid_nh_omp.h" #include "atom.h" @@ -24,13 +27,12 @@ #include "comm.h" #include "compute.h" #include "domain.h" +#include "error.h" #include "force.h" #include "kspace.h" #include "modify.h" #include "update.h" -#include - #if defined(_OPENMP) #include #endif diff --git a/src/USER-OMP/fix_rigid_omp.cpp b/src/USER-OMP/fix_rigid_omp.cpp index 12c6362ed8..20478b3ca1 100644 --- a/src/USER-OMP/fix_rigid_omp.cpp +++ b/src/USER-OMP/fix_rigid_omp.cpp @@ -15,6 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include +#include + #include "fix_rigid_omp.h" #include "atom.h" @@ -23,8 +26,7 @@ #include "atom_vec_tri.h" #include "comm.h" #include "domain.h" - -#include +#include "error.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/fix_rigid_small_omp.cpp b/src/USER-OMP/fix_rigid_small_omp.cpp index a0495b3b93..1f6173497d 100644 --- a/src/USER-OMP/fix_rigid_small_omp.cpp +++ b/src/USER-OMP/fix_rigid_small_omp.cpp @@ -15,6 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include + #include "fix_rigid_small_omp.h" #include "atom.h" @@ -24,8 +26,6 @@ #include "comm.h" #include "domain.h" -#include - #if defined(_OPENMP) #include #endif diff --git a/src/lammps.cpp b/src/lammps.cpp index 83a2f057ee..052d14dfed 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -48,7 +48,7 @@ #include "output.h" #include "citeme.h" #include "accelerator_kokkos.h" -#include "accelerator_omp.h" +#include "accelerator_omp.h" // IWYU pragma: keep #include "timer.h" #include "lmppython.h" #include "version.h" -- GitLab From 483b1dbef5ee2d0c7f92885c7de2d8d94600dcbc Mon Sep 17 00:00:00 2001 From: jrgissing Date: Sun, 30 Jun 2019 21:19:04 -0600 Subject: [PATCH 141/469] Update fix_bond_react.txt --- doc/src/fix_bond_react.txt | 48 ++++++++++++++++++++++++-------------- 1 file changed, 31 insertions(+), 17 deletions(-) diff --git a/doc/src/fix_bond_react.txt b/doc/src/fix_bond_react.txt index 34f0e6daf7..7310545e1c 100644 --- a/doc/src/fix_bond_react.txt +++ b/doc/src/fix_bond_react.txt @@ -24,7 +24,7 @@ common_keyword = {stabilization} :l {stabilization} values = {no} or {yes} {group-ID} {xmax} {no} = no reaction site stabilization {yes} = perform reaction site stabilization - {group-ID} = user-assigned prefix for the dynamic group of non-reacting atoms + {group-ID} = user-assigned prefix for the dynamic group of atoms not currently involved in a reaction {xmax} = xmax value that is used by an internally-created "nve/limit"_fix_nve_limit.html integrator :pre react = mandatory argument indicating new reaction specification :l react-ID = user-assigned name for the reaction :l @@ -52,6 +52,8 @@ react = mandatory argument indicating new reaction specification :l [Examples:] +For unabridged example scripts and files, see \examples\USER\misc\bond_react. + molecule mol1 pre_reacted_topology.txt molecule mol2 post_reacted_topology.txt fix 5 all bond/react react myrxn1 all 1 0 3.25 mol1 mol2 map_file.txt :pre @@ -106,6 +108,20 @@ involved in any new reactions. The {xmax} value keyword should typically be set to the maximum distance that non-reacting atoms move during the simulation. +Fix bond/react creates and maintains two important dynamic groups of +atoms when using the {stabilization} keyword. The first group contains +all atoms currently involved in a reaction; this group is +automatically thermostatted by an internally-created +"nve/limit"_fix_nve_limit.html integrator. The second group contains +all atoms currently not involved in a reaction. This group should be +used by a thermostat in order to time integrate the system. The name +of this group of non-reacting atoms is created by appending '_REACT' +to the group-ID argument of the {stabilization} keyword, as shown in +the second example above. + +NOTE: When using reaction stabilization, you should generally not have +a separate thermostat which acts on the 'all' group. + The group-ID set using the {stabilization} keyword can be an existing static group or a previously-unused group-ID. It cannot be specified as 'all'. If the group-ID is previously unused, the fix bond/react @@ -116,20 +132,17 @@ internally-created dynamic group. In both cases, this new dynamic group is named by appending '_REACT' to the group-ID, e.g. nvt_grp_REACT. By specifying an existing group, you may thermostat constant-topology parts of your system separately. The dynamic group -contains only non-reacting atoms at a given timestep, and therefore -should be used by a subsequent system-wide time integrator such as -nvt, npt, or nve, as shown in the second example above. The time -integration command should be placed after the fix bond/react command -due to the internal dynamic grouping performed by fix bond/react. +contains only atoms not involved in a reaction at a given timestep, +and therefore should be used by a subsequent system-wide time +integrator such as nvt, npt, or nve, as shown in the second example +above (full examples can be found at \examples\USER\misc\bond_react). +The time integration command should be placed after the fix bond/react +command due to the internal dynamic grouping performed by fix +bond/react. NOTE: If the group-ID is an existing static group, react-group-IDs should also be specified as this static group, or a subset. -NOTE: If the group-ID is previously unused, the internally-created -group applies to all atoms in the system, i.e. you should generally -not have a separate thermostat which acts on the 'all' group, or any -other group. - The following comments pertain to each {react} argument (in other words, can be customized for each reaction, or reaction step): @@ -352,12 +365,13 @@ an atom that is not deleted. In addition to deleting unwanted reaction by-products, this feature can be used to remove specific topologies, such as small rings, that may be otherwise indistinguishable. -Also, it may be beneficial to ensure reacting atoms are at a certain -temperature before being released to the overall thermostat. For this, -you can use the internally-created dynamic group named -"bond_react_MASTER_group." For example, adding the following command -would thermostat the group of all atoms currently involved in a -reaction: +Optionally, you can enforce additional behaviors on reacting atoms. +For example, it may be beneficial to force reacting atoms to remain at +a certain temperature. For this, you can use the internally-created +dynamic group named "bond_react_MASTER_group", which consists of all +atoms currently involved in a reaction. For example, adding the +following command would add an additional thermostat to the group of +all currently-reacting atoms: fix 1 bond_react_MASTER_group temp/rescale 1 300 300 10 1 :pre -- GitLab From 62bddd47ee99ecbc2f7bee7a5d091e26ba667242 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 1 Jul 2019 00:01:00 -0400 Subject: [PATCH 142/469] limit number of nested include file levels to 16 --- src/input.cpp | 22 +++++++++------------- 1 file changed, 9 insertions(+), 13 deletions(-) diff --git a/src/input.cpp b/src/input.cpp index 644446710f..ca9defc66b 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -85,8 +85,9 @@ Input::Input(LAMMPS *lmp, int argc, char **argv) : Pointers(lmp) ifthenelse_flag = 0; if (me == 0) { - nfile = maxfile = 1; - infiles = (FILE **) memory->smalloc(sizeof(FILE *),"input:infiles"); + nfile = 1; + maxfile = 16; + infiles = new FILE *[maxfile]; infiles[0] = infile; } else infiles = NULL; @@ -138,7 +139,7 @@ Input::~Input() memory->sfree(work); if (labelstr) delete [] labelstr; memory->sfree(arg); - memory->sfree(infiles); + delete [] infiles; delete variable; delete command_map; @@ -251,11 +252,8 @@ void Input::file(const char *filename) // call to file() will close filename and decrement nfile if (me == 0) { - if (nfile == maxfile) { - maxfile++; - infiles = (FILE **) - memory->srealloc(infiles,maxfile*sizeof(FILE *),"input:infiles"); - } + if (nfile == maxfile) + error->one(FLERR,"Too many nested levels of input scripts"); infile = fopen(filename,"r"); if (infile == NULL) { @@ -1044,11 +1042,9 @@ void Input::include() error->all(FLERR,"Cannot use include command within an if command"); if (me == 0) { - if (nfile == maxfile) { - maxfile++; - infiles = (FILE **) - memory->srealloc(infiles,maxfile*sizeof(FILE *),"input:infiles"); - } + if (nfile == maxfile) + error->one(FLERR,"Too many nested levels of input scripts"); + infile = fopen(arg[0],"r"); if (infile == NULL) { char str[128]; -- GitLab From af8103433c63ee4ef6ea9b8ae4ad764d109820f9 Mon Sep 17 00:00:00 2001 From: jrgissing Date: Sun, 30 Jun 2019 22:13:12 -0600 Subject: [PATCH 143/469] add stabilized vs unstabilized examples --- ...in.tiny_nylon => in.tiny_nylon.stabilized} | 2 + .../tiny_nylon/in.tiny_nylon.unstabilized | 48 +++ .../tiny_nylon/log.20Apr18.tiny_nylon.g++.1 | 370 ------------------ .../tiny_nylon/log.20Apr18.tiny_nylon.g++.4 | 370 ------------------ .../log.5Jun19.tiny_nylon.stabilized.g++.1 | 148 +++++++ .../log.5Jun19.tiny_nylon.stabilized.g++.4 | 148 +++++++ .../log.5Jun19.tiny_nylon.unstabilized.g++.1 | 147 +++++++ .../log.5Jun19.tiny_nylon.unstabilized.g++.4 | 147 +++++++ 8 files changed, 640 insertions(+), 740 deletions(-) rename examples/USER/misc/bond_react/tiny_nylon/{in.tiny_nylon => in.tiny_nylon.stabilized} (88%) create mode 100644 examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon.unstabilized delete mode 100644 examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.1 delete mode 100644 examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.4 create mode 100644 examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.1 create mode 100644 examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.4 create mode 100644 examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.1 create mode 100644 examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.4 diff --git a/examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon b/examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon.stabilized similarity index 88% rename from examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon rename to examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon.stabilized index 73cb2eb270..b152dec00a 100644 --- a/examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon +++ b/examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon.stabilized @@ -38,6 +38,8 @@ fix myrxns all bond/react stabilization yes statted_grp .03 & fix 1 statted_grp_REACT nvt temp 300 300 100 +# optionally, you can customize behavior of reacting atoms, +# by using the internally-created 'bond_react_MASTER_group', like so: fix 4 bond_react_MASTER_group temp/rescale 1 300 300 10 1 thermo_style custom step temp press density f_myrxns[1] f_myrxns[2] diff --git a/examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon.unstabilized b/examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon.unstabilized new file mode 100644 index 0000000000..1e5a493821 --- /dev/null +++ b/examples/USER/misc/bond_react/tiny_nylon/in.tiny_nylon.unstabilized @@ -0,0 +1,48 @@ +# two monomer nylon example +# reaction produces a condensed water molecule + +units real + +boundary p p p + +atom_style full + +kspace_style pppm 1.0e-4 + +pair_style lj/class2/coul/long 8.5 + +angle_style class2 + +bond_style class2 + +dihedral_style class2 + +improper_style class2 + +read_data tiny_nylon.data + +velocity all create 300.0 4928459 dist gaussian + +molecule mol1 rxn1_stp1_unreacted.data_template +molecule mol2 rxn1_stp1_reacted.data_template +molecule mol3 rxn1_stp2_unreacted.data_template +molecule mol4 rxn1_stp2_reacted.data_template + +thermo 50 + +# dump 1 all xyz 1 test_vis.xyz + +fix myrxns all bond/react stabilization no & + react rxn1 all 1 0.0 2.9 mol1 mol2 rxn1_stp1_map & + react rxn2 all 1 0.0 5.0 mol3 mol4 rxn1_stp2_map + +fix 1 all nve/limit .03 + +thermo_style custom step temp press density f_myrxns[1] f_myrxns[2] + +# restart 100 restart1 restart2 + +run 1000 + +# write_restart restart_longrun +# write_data restart_longrun.data diff --git a/examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.1 b/examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.1 deleted file mode 100644 index 344439f94c..0000000000 --- a/examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.1 +++ /dev/null @@ -1,370 +0,0 @@ -LAMMPS (20 Apr 2018) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:90) - using 1 OpenMP thread(s) per MPI task -# two monomer nylon example -# reaction produces a condensed water molecule - -units real - -boundary p p p - -atom_style full - -kspace_style pppm 1.0e-4 - -pair_style lj/class2/coul/long 8.5 - -angle_style class2 - -bond_style class2 - -dihedral_style class2 - -improper_style class2 - -read_data tiny_nylon.data - orthogonal box = (-25 -25 -25) to (25 25 25) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 44 atoms - reading velocities ... - 44 velocities - scanning bonds ... - 9 = max bonds/atom - scanning angles ... - 21 = max angles/atom - scanning dihedrals ... - 29 = max dihedrals/atom - scanning impropers ... - 29 = max impropers/atom - reading bonds ... - 42 bonds - reading angles ... - 74 angles - reading dihedrals ... - 100 dihedrals - reading impropers ... - 44 impropers - 4 = max # of 1-2 neighbors - 6 = max # of 1-3 neighbors - 12 = max # of 1-4 neighbors - 41 = max # of special neighbors - -velocity all create 300.0 4928459 dist gaussian - -molecule mol1 rxn1_stp1_unreacted.data_template -Read molecule mol1: - 18 atoms with max type 8 - 16 bonds with max type 14 - 25 angles with max type 28 - 23 dihedrals with max type 36 - 14 impropers with max type 11 -molecule mol2 rxn1_stp1_reacted.data_template -Read molecule mol2: - 18 atoms with max type 9 - 17 bonds with max type 13 - 31 angles with max type 27 - 39 dihedrals with max type 33 - 20 impropers with max type 1 -molecule mol3 rxn1_stp2_unreacted.data_template -Read molecule mol3: - 15 atoms with max type 9 - 14 bonds with max type 13 - 25 angles with max type 27 - 30 dihedrals with max type 33 - 16 impropers with max type 1 -molecule mol4 rxn1_stp2_reacted.data_template -Read molecule mol4: - 15 atoms with max type 11 - 13 bonds with max type 15 - 19 angles with max type 29 - 16 dihedrals with max type 32 - 10 impropers with max type 13 - -thermo 50 - -# dump 1 all xyz 1 test_vis.xyz - -fix myrxns all bond/react stabilization yes statted_grp .03 react rxn1 all 1 0.0 2.9 mol1 mol2 rxn1_stp1_map react rxn2 all 1 0.0 5.0 mol3 mol4 rxn1_stp2_map -WARNING: An atom in 'react #1' changes bond connectivity but not atom type (../fix_bond_react.cpp:1489) -WARNING: An atom in 'react #2' changes bond connectivity but not atom type (../fix_bond_react.cpp:1489) -dynamic group bond_react_MASTER_group defined -dynamic group statted_grp defined -dynamic group bond_react_MASTER_group defined -dynamic group statted_grp defined - -fix 1 statted_grp nvt temp 300 300 100 - -fix 4 bond_react_MASTER_group temp/rescale 1 300 300 10 1 - -thermo_style custom step temp press density f_myrxns[1] f_myrxns[2] - -# restart 100 restart1 restart2 - -run 10000 -PPPM initialization ... - using 12-bit tables for long-range coulomb (../kspace.cpp:321) - G vector (1/distance) = 0.0534597 - grid = 2 2 2 - stencil order = 5 - estimated absolute RMS force accuracy = 0.0402256 - estimated relative force accuracy = 0.000121138 - using double precision FFTs - 3d grid and FFT values/proc = 343 8 -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 10.5 - ghost atom cutoff = 10.5 - binsize = 5.25, bins = 10 10 10 - 2 neighbor lists, perpetual/occasional/extra = 1 1 0 - (1) pair lj/class2/coul/long, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d/newton - bin: standard - (2) fix bond/react, occasional, copy from (1) - attributes: half, newton on - pair build: copy - stencil: none - bin: none -WARNING: Inconsistent image flags (../domain.cpp:786) -Per MPI rank memory allocation (min/avg/max) = 33.34 | 33.34 | 33.34 Mbytes -Step Temp Press Density f_myrxns[1] f_myrxns[2] - 0 300 346.78165 0.0034851739 0 0 - 50 296.70408 -51.30066 0.0034851739 1 0 - 100 274.25324 46.715512 0.0034851739 1 1 - 150 471.61579 31.321598 0.0034851739 1 1 - 200 362.87766 42.061118 0.0034851739 1 1 - 250 367.58058 65.303109 0.0034851739 1 1 - 300 372.38236 -52.421725 0.0034851739 1 1 - 350 297.69957 17.869945 0.0034851739 1 1 - 400 258.30433 49.19156 0.0034851739 1 1 - 450 253.34384 -5.8162637 0.0034851739 1 1 - 500 269.96465 -43.337517 0.0034851739 1 1 - 550 303.23718 10.180246 0.0034851739 1 1 - 600 329.59579 -48.97461 0.0034851739 1 1 - 650 350.42568 50.983183 0.0034851739 1 1 - 700 342.03272 35.43465 0.0034851739 1 1 - 750 269.23405 -41.873166 0.0034851739 1 1 - 800 245.15025 13.953092 0.0034851739 1 1 - 850 257.85421 -3.1492141 0.0034851739 1 1 - 900 316.15644 7.7798301 0.0034851739 1 1 - 950 299.9124 -15.77014 0.0034851739 1 1 - 1000 302.89968 -17.049693 0.0034851739 1 1 - 1050 308.91651 71.84632 0.0034851739 1 1 - 1100 348.43932 -18.742012 0.0034851739 1 1 - 1150 309.03036 50.536311 0.0034851739 1 1 - 1200 318.9761 -16.905746 0.0034851739 1 1 - 1250 320.42806 -0.057975092 0.0034851739 1 1 - 1300 289.7824 18.200772 0.0034851739 1 1 - 1350 284.79836 -9.1978427 0.0034851739 1 1 - 1400 325.43292 42.082833 0.0034851739 1 1 - 1450 261.5041 -37.823325 0.0034851739 1 1 - 1500 298.88723 -5.1647385 0.0034851739 1 1 - 1550 291.37403 -7.7764201 0.0034851739 1 1 - 1600 293.83475 22.2458 0.0034851739 1 1 - 1650 293.80611 24.202512 0.0034851739 1 1 - 1700 291.70205 -23.397884 0.0034851739 1 1 - 1750 292.32437 -10.671214 0.0034851739 1 1 - 1800 302.01367 -11.671025 0.0034851739 1 1 - 1850 322.1651 24.438331 0.0034851739 1 1 - 1900 310.45076 45.343592 0.0034851739 1 1 - 1950 325.91745 -19.847809 0.0034851739 1 1 - 2000 276.89662 63.387098 0.0034851739 1 1 - 2050 311.33783 -24.683247 0.0034851739 1 1 - 2100 346.2336 -27.526891 0.0034851739 1 1 - 2150 345.30604 -15.722411 0.0034851739 1 1 - 2200 346.7718 -17.857633 0.0034851739 1 1 - 2250 304.28676 -1.9965581 0.0034851739 1 1 - 2300 322.56372 -31.786868 0.0034851739 1 1 - 2350 282.64326 6.1982735 0.0034851739 1 1 - 2400 286.65759 -63.207781 0.0034851739 1 1 - 2450 257.05528 32.931491 0.0034851739 1 1 - 2500 283.64386 26.912373 0.0034851739 1 1 - 2550 299.54005 27.277039 0.0034851739 1 1 - 2600 283.92503 14.660972 0.0034851739 1 1 - 2650 321.93453 -18.977358 0.0034851739 1 1 - 2700 376.7189 31.826935 0.0034851739 1 1 - 2750 372.20075 -32.821697 0.0034851739 1 1 - 2800 361.40604 83.035183 0.0034851739 1 1 - 2850 332.27269 -23.927452 0.0034851739 1 1 - 2900 331.14638 -0.12328446 0.0034851739 1 1 - 2950 303.67489 -24.078857 0.0034851739 1 1 - 3000 311.40462 21.563537 0.0034851739 1 1 - 3050 284.72849 -23.849667 0.0034851739 1 1 - 3100 303.48477 39.347763 0.0034851739 1 1 - 3150 264.2739 -0.22299879 0.0034851739 1 1 - 3200 300.03351 31.545323 0.0034851739 1 1 - 3250 288.56663 5.7225228 0.0034851739 1 1 - 3300 200.13238 -31.239655 0.0034851739 1 1 - 3350 231.32512 16.631728 0.0034851739 1 1 - 3400 260.57402 2.1717992 0.0034851739 1 1 - 3450 301.47128 -42.210623 0.0034851739 1 1 - 3500 321.77414 40.074365 0.0034851739 1 1 - 3550 353.21858 28.387783 0.0034851739 1 1 - 3600 331.45989 -57.800858 0.0034851739 1 1 - 3650 303.88123 44.86596 0.0034851739 1 1 - 3700 329.73833 -0.80615652 0.0034851739 1 1 - 3750 297.55588 -0.49626039 0.0034851739 1 1 - 3800 286.38794 -10.010003 0.0034851739 1 1 - 3850 290.17417 -43.51187 0.0034851739 1 1 - 3900 247.88933 51.23735 0.0034851739 1 1 - 3950 332.31324 -18.194985 0.0034851739 1 1 - 4000 325.56802 18.402825 0.0034851739 1 1 - 4050 338.37593 36.430977 0.0034851739 1 1 - 4100 370.95478 39.290285 0.0034851739 1 1 - 4150 348.47859 -7.0779678 0.0034851739 1 1 - 4200 241.30632 -33.371788 0.0034851739 1 1 - 4250 242.17258 -9.986197 0.0034851739 1 1 - 4300 300.85311 -7.9244294 0.0034851739 1 1 - 4350 273.15684 -21.257283 0.0034851739 1 1 - 4400 305.77463 -5.8720722 0.0034851739 1 1 - 4450 314.97697 45.0373 0.0034851739 1 1 - 4500 310.77723 16.958773 0.0034851739 1 1 - 4550 302.1742 12.156862 0.0034851739 1 1 - 4600 319.74799 6.84889 0.0034851739 1 1 - 4650 270.86805 -13.767905 0.0034851739 1 1 - 4700 249.81731 -31.197487 0.0034851739 1 1 - 4750 285.86481 -9.8916364 0.0034851739 1 1 - 4800 233.98321 7.1338571 0.0034851739 1 1 - 4850 302.60551 49.262889 0.0034851739 1 1 - 4900 316.55056 34.663247 0.0034851739 1 1 - 4950 357.32741 11.583006 0.0034851739 1 1 - 5000 400.21045 -8.1781061 0.0034851739 1 1 - 5050 390.01845 -20.490275 0.0034851739 1 1 - 5100 378.84247 -41.328757 0.0034851739 1 1 - 5150 324.02038 -15.023862 0.0034851739 1 1 - 5200 262.08429 10.937354 0.0034851739 1 1 - 5250 255.75508 16.381455 0.0034851739 1 1 - 5300 277.84989 40.68232 0.0034851739 1 1 - 5350 302.92832 9.1989494 0.0034851739 1 1 - 5400 283.7196 -1.6584671 0.0034851739 1 1 - 5450 300.71266 -4.7030295 0.0034851739 1 1 - 5500 343.5499 -0.30550044 0.0034851739 1 1 - 5550 369.51271 21.691649 0.0034851739 1 1 - 5600 372.69789 -38.67994 0.0034851739 1 1 - 5650 327.41266 11.352137 0.0034851739 1 1 - 5700 278.98614 -23.827304 0.0034851739 1 1 - 5750 308.30054 -20.756187 0.0034851739 1 1 - 5800 341.45594 28.058441 0.0034851739 1 1 - 5850 322.97844 -10.731921 0.0034851739 1 1 - 5900 304.53591 32.825279 0.0034851739 1 1 - 5950 287.1752 -36.780091 0.0034851739 1 1 - 6000 296.52681 18.781896 0.0034851739 1 1 - 6050 314.25442 15.992829 0.0034851739 1 1 - 6100 313.86576 3.4342714 0.0034851739 1 1 - 6150 325.64196 32.392039 0.0034851739 1 1 - 6200 367.42931 -27.160706 0.0034851739 1 1 - 6250 369.30798 39.020934 0.0034851739 1 1 - 6300 328.92285 -23.175157 0.0034851739 1 1 - 6350 305.63077 4.9024453 0.0034851739 1 1 - 6400 241.70341 -13.676629 0.0034851739 1 1 - 6450 265.66717 2.40612 0.0034851739 1 1 - 6500 249.36037 13.420255 0.0034851739 1 1 - 6550 294.53814 10.853462 0.0034851739 1 1 - 6600 308.2025 18.995308 0.0034851739 1 1 - 6650 305.43797 -49.56785 0.0034851739 1 1 - 6700 320.27344 11.336281 0.0034851739 1 1 - 6750 321.78666 -23.463899 0.0034851739 1 1 - 6800 303.40388 7.6224553 0.0034851739 1 1 - 6850 297.18966 51.52256 0.0034851739 1 1 - 6900 284.18909 -8.4947203 0.0034851739 1 1 - 6950 331.03663 13.233655 0.0034851739 1 1 - 7000 311.37928 -43.265479 0.0034851739 1 1 - 7050 286.81661 -14.174683 0.0034851739 1 1 - 7100 302.84119 12.048954 0.0034851739 1 1 - 7150 297.19357 -43.111968 0.0034851739 1 1 - 7200 332.47359 26.048249 0.0034851739 1 1 - 7250 262.70677 41.176242 0.0034851739 1 1 - 7300 250.61405 -23.413982 0.0034851739 1 1 - 7350 296.91117 35.88133 0.0034851739 1 1 - 7400 245.09229 -13.447194 0.0034851739 1 1 - 7450 272.28131 -23.322585 0.0034851739 1 1 - 7500 209.04985 13.871239 0.0034851739 1 1 - 7550 255.00955 4.9325621 0.0034851739 1 1 - 7600 312.30937 -37.368274 0.0034851739 1 1 - 7650 305.65903 55.245496 0.0034851739 1 1 - 7700 325.09504 -18.347711 0.0034851739 1 1 - 7750 363.28282 -22.479686 0.0034851739 1 1 - 7800 350.17429 26.849547 0.0034851739 1 1 - 7850 271.70853 -17.764575 0.0034851739 1 1 - 7900 272.66484 -11.701967 0.0034851739 1 1 - 7950 298.60202 -12.765675 0.0034851739 1 1 - 8000 274.58852 49.641532 0.0034851739 1 1 - 8050 304.72347 -0.55414183 0.0034851739 1 1 - 8100 328.30757 -39.861301 0.0034851739 1 1 - 8150 406.67601 2.8999409 0.0034851739 1 1 - 8200 332.20083 -51.217399 0.0034851739 1 1 - 8250 354.50609 53.128769 0.0034851739 1 1 - 8300 337.2758 20.68562 0.0034851739 1 1 - 8350 361.89708 -54.185869 0.0034851739 1 1 - 8400 305.63496 24.058529 0.0034851739 1 1 - 8450 303.27461 4.304683 0.0034851739 1 1 - 8500 253.53694 -10.909021 0.0034851739 1 1 - 8550 277.03017 23.241479 0.0034851739 1 1 - 8600 291.41844 -22.240665 0.0034851739 1 1 - 8650 307.85368 31.919587 0.0034851739 1 1 - 8700 309.19724 0.53529642 0.0034851739 1 1 - 8750 354.6583 11.565515 0.0034851739 1 1 - 8800 329.78598 19.5996 0.0034851739 1 1 - 8850 240.79198 21.803515 0.0034851739 1 1 - 8900 318.40749 -59.816923 0.0034851739 1 1 - 8950 308.47211 -57.808635 0.0034851739 1 1 - 9000 271.51207 50.943482 0.0034851739 1 1 - 9050 249.4005 6.7529187 0.0034851739 1 1 - 9100 221.8772 47.196092 0.0034851739 1 1 - 9150 297.9351 4.0058184 0.0034851739 1 1 - 9200 274.85051 -24.774393 0.0034851739 1 1 - 9250 336.04757 5.3799028 0.0034851739 1 1 - 9300 380.44956 -22.389381 0.0034851739 1 1 - 9350 336.9824 23.050616 0.0034851739 1 1 - 9400 304.46425 32.530218 0.0034851739 1 1 - 9450 317.55591 -22.265425 0.0034851739 1 1 - 9500 323.70901 -7.0159787 0.0034851739 1 1 - 9550 316.07308 28.062131 0.0034851739 1 1 - 9600 262.74608 -0.78519192 0.0034851739 1 1 - 9650 271.55045 -21.430123 0.0034851739 1 1 - 9700 239.6022 14.483637 0.0034851739 1 1 - 9750 338.1437 -0.72765302 0.0034851739 1 1 - 9800 334.50189 19.495144 0.0034851739 1 1 - 9850 354.87554 19.272719 0.0034851739 1 1 - 9900 334.02141 -22.393457 0.0034851739 1 1 - 9950 293.63651 19.178873 0.0034851739 1 1 - 10000 319.81736 21.904414 0.0034851739 1 1 -Loop time of 1.84987 on 1 procs for 10000 steps with 44 atoms - -Performance: 467.059 ns/day, 0.051 hours/ns, 5405.774 timesteps/s -99.5% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.26152 | 0.26152 | 0.26152 | 0.0 | 14.14 -Bond | 0.74069 | 0.74069 | 0.74069 | 0.0 | 40.04 -Kspace | 0.30505 | 0.30505 | 0.30505 | 0.0 | 16.49 -Neigh | 0.39991 | 0.39991 | 0.39991 | 0.0 | 21.62 -Comm | 0.02261 | 0.02261 | 0.02261 | 0.0 | 1.22 -Output | 0.0034585 | 0.0034585 | 0.0034585 | 0.0 | 0.19 -Modify | 0.099979 | 0.099979 | 0.099979 | 0.0 | 5.40 -Other | | 0.01666 | | | 0.90 - -Nlocal: 44 ave 44 max 44 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 44 ave 44 max 44 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 823 ave 823 max 823 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 823 -Ave neighs/atom = 18.7045 -Ave special neighs/atom = 9.77273 -Neighbor list builds = 10000 -Dangerous builds = 0 - -# write_restart restart_longrun -# write_data restart_longrun.data - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:01 diff --git a/examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.4 b/examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.4 deleted file mode 100644 index 377781f48f..0000000000 --- a/examples/USER/misc/bond_react/tiny_nylon/log.20Apr18.tiny_nylon.g++.4 +++ /dev/null @@ -1,370 +0,0 @@ -LAMMPS (20 Apr 2018) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:90) - using 1 OpenMP thread(s) per MPI task -# two monomer nylon example -# reaction produces a condensed water molecule - -units real - -boundary p p p - -atom_style full - -kspace_style pppm 1.0e-4 - -pair_style lj/class2/coul/long 8.5 - -angle_style class2 - -bond_style class2 - -dihedral_style class2 - -improper_style class2 - -read_data tiny_nylon.data - orthogonal box = (-25 -25 -25) to (25 25 25) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 44 atoms - reading velocities ... - 44 velocities - scanning bonds ... - 9 = max bonds/atom - scanning angles ... - 21 = max angles/atom - scanning dihedrals ... - 29 = max dihedrals/atom - scanning impropers ... - 29 = max impropers/atom - reading bonds ... - 42 bonds - reading angles ... - 74 angles - reading dihedrals ... - 100 dihedrals - reading impropers ... - 44 impropers - 4 = max # of 1-2 neighbors - 6 = max # of 1-3 neighbors - 12 = max # of 1-4 neighbors - 41 = max # of special neighbors - -velocity all create 300.0 4928459 dist gaussian - -molecule mol1 rxn1_stp1_unreacted.data_template -Read molecule mol1: - 18 atoms with max type 8 - 16 bonds with max type 14 - 25 angles with max type 28 - 23 dihedrals with max type 36 - 14 impropers with max type 11 -molecule mol2 rxn1_stp1_reacted.data_template -Read molecule mol2: - 18 atoms with max type 9 - 17 bonds with max type 13 - 31 angles with max type 27 - 39 dihedrals with max type 33 - 20 impropers with max type 1 -molecule mol3 rxn1_stp2_unreacted.data_template -Read molecule mol3: - 15 atoms with max type 9 - 14 bonds with max type 13 - 25 angles with max type 27 - 30 dihedrals with max type 33 - 16 impropers with max type 1 -molecule mol4 rxn1_stp2_reacted.data_template -Read molecule mol4: - 15 atoms with max type 11 - 13 bonds with max type 15 - 19 angles with max type 29 - 16 dihedrals with max type 32 - 10 impropers with max type 13 - -thermo 50 - -# dump 1 all xyz 1 test_vis.xyz - -fix myrxns all bond/react stabilization yes statted_grp .03 react rxn1 all 1 0.0 2.9 mol1 mol2 rxn1_stp1_map react rxn2 all 1 0.0 5.0 mol3 mol4 rxn1_stp2_map -WARNING: An atom in 'react #1' changes bond connectivity but not atom type (../fix_bond_react.cpp:1489) -WARNING: An atom in 'react #2' changes bond connectivity but not atom type (../fix_bond_react.cpp:1489) -dynamic group bond_react_MASTER_group defined -dynamic group statted_grp defined -dynamic group bond_react_MASTER_group defined -dynamic group statted_grp defined - -fix 1 statted_grp nvt temp 300 300 100 - -fix 4 bond_react_MASTER_group temp/rescale 1 300 300 10 1 - -thermo_style custom step temp press density f_myrxns[1] f_myrxns[2] - -# restart 100 restart1 restart2 - -run 10000 -PPPM initialization ... - using 12-bit tables for long-range coulomb (../kspace.cpp:321) - G vector (1/distance) = 0.0534597 - grid = 2 2 2 - stencil order = 5 - estimated absolute RMS force accuracy = 0.0402256 - estimated relative force accuracy = 0.000121138 - using double precision FFTs - 3d grid and FFT values/proc = 252 2 -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 10.5 - ghost atom cutoff = 10.5 - binsize = 5.25, bins = 10 10 10 - 2 neighbor lists, perpetual/occasional/extra = 1 1 0 - (1) pair lj/class2/coul/long, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d/newton - bin: standard - (2) fix bond/react, occasional, copy from (1) - attributes: half, newton on - pair build: copy - stencil: none - bin: none -WARNING: Inconsistent image flags (../domain.cpp:786) -Per MPI rank memory allocation (min/avg/max) = 33.34 | 33.69 | 34.37 Mbytes -Step Temp Press Density f_myrxns[1] f_myrxns[2] - 0 300 346.78165 0.0034851739 0 0 - 50 296.70408 -51.30066 0.0034851739 1 0 - 100 274.25324 46.715512 0.0034851739 1 1 - 150 471.61579 31.321598 0.0034851739 1 1 - 200 362.87766 42.061118 0.0034851739 1 1 - 250 367.58058 65.303109 0.0034851739 1 1 - 300 372.38236 -52.421725 0.0034851739 1 1 - 350 297.69957 17.869945 0.0034851739 1 1 - 400 258.30433 49.19156 0.0034851739 1 1 - 450 253.34384 -5.8162637 0.0034851739 1 1 - 500 269.96465 -43.337517 0.0034851739 1 1 - 550 303.23718 10.180246 0.0034851739 1 1 - 600 329.59579 -48.97461 0.0034851739 1 1 - 650 350.42568 50.983183 0.0034851739 1 1 - 700 342.03272 35.43465 0.0034851739 1 1 - 750 269.23405 -41.873166 0.0034851739 1 1 - 800 245.15025 13.953092 0.0034851739 1 1 - 850 257.85421 -3.1492141 0.0034851739 1 1 - 900 316.15644 7.7798301 0.0034851739 1 1 - 950 299.9124 -15.77014 0.0034851739 1 1 - 1000 302.89968 -17.049693 0.0034851739 1 1 - 1050 308.91651 71.84632 0.0034851739 1 1 - 1100 348.43932 -18.742012 0.0034851739 1 1 - 1150 309.03036 50.536311 0.0034851739 1 1 - 1200 318.9761 -16.905746 0.0034851739 1 1 - 1250 320.42806 -0.057975092 0.0034851739 1 1 - 1300 289.7824 18.200772 0.0034851739 1 1 - 1350 284.79836 -9.1978427 0.0034851739 1 1 - 1400 325.43292 42.082833 0.0034851739 1 1 - 1450 261.5041 -37.823325 0.0034851739 1 1 - 1500 298.88723 -5.1647385 0.0034851739 1 1 - 1550 291.37403 -7.7764201 0.0034851739 1 1 - 1600 293.83475 22.2458 0.0034851739 1 1 - 1650 293.80611 24.202512 0.0034851739 1 1 - 1700 291.70205 -23.397884 0.0034851739 1 1 - 1750 292.32437 -10.671214 0.0034851739 1 1 - 1800 302.01367 -11.671025 0.0034851739 1 1 - 1850 322.1651 24.438331 0.0034851739 1 1 - 1900 310.45076 45.343592 0.0034851739 1 1 - 1950 325.91745 -19.847809 0.0034851739 1 1 - 2000 276.89662 63.387098 0.0034851739 1 1 - 2050 311.33783 -24.683247 0.0034851739 1 1 - 2100 346.2336 -27.526891 0.0034851739 1 1 - 2150 345.30604 -15.722411 0.0034851739 1 1 - 2200 346.7718 -17.857633 0.0034851739 1 1 - 2250 304.28676 -1.9965581 0.0034851739 1 1 - 2300 322.56372 -31.786868 0.0034851739 1 1 - 2350 282.64326 6.1982735 0.0034851739 1 1 - 2400 286.65759 -63.207781 0.0034851739 1 1 - 2450 257.05528 32.931491 0.0034851739 1 1 - 2500 283.64386 26.912373 0.0034851739 1 1 - 2550 299.54005 27.277039 0.0034851739 1 1 - 2600 283.92503 14.660972 0.0034851739 1 1 - 2650 321.93453 -18.977358 0.0034851739 1 1 - 2700 376.7189 31.826935 0.0034851739 1 1 - 2750 372.20075 -32.821697 0.0034851739 1 1 - 2800 361.40604 83.035183 0.0034851739 1 1 - 2850 332.27269 -23.927452 0.0034851739 1 1 - 2900 331.14638 -0.12328446 0.0034851739 1 1 - 2950 303.67489 -24.078857 0.0034851739 1 1 - 3000 311.40462 21.563537 0.0034851739 1 1 - 3050 284.72849 -23.849667 0.0034851739 1 1 - 3100 303.48477 39.347763 0.0034851739 1 1 - 3150 264.2739 -0.22299878 0.0034851739 1 1 - 3200 300.03351 31.545323 0.0034851739 1 1 - 3250 288.56663 5.7225229 0.0034851739 1 1 - 3300 200.13238 -31.239655 0.0034851739 1 1 - 3350 231.32512 16.631728 0.0034851739 1 1 - 3400 260.57402 2.1717992 0.0034851739 1 1 - 3450 301.47128 -42.210623 0.0034851739 1 1 - 3500 321.77414 40.074365 0.0034851739 1 1 - 3550 353.21858 28.387783 0.0034851739 1 1 - 3600 331.45989 -57.800858 0.0034851739 1 1 - 3650 303.88123 44.86596 0.0034851739 1 1 - 3700 329.73833 -0.8061567 0.0034851739 1 1 - 3750 297.55588 -0.49626022 0.0034851739 1 1 - 3800 286.38794 -10.010003 0.0034851739 1 1 - 3850 290.17417 -43.51187 0.0034851739 1 1 - 3900 247.88933 51.23735 0.0034851739 1 1 - 3950 332.31324 -18.194985 0.0034851739 1 1 - 4000 325.56802 18.402825 0.0034851739 1 1 - 4050 338.37594 36.430977 0.0034851739 1 1 - 4100 370.95478 39.290285 0.0034851739 1 1 - 4150 348.47859 -7.0779683 0.0034851739 1 1 - 4200 241.30632 -33.371789 0.0034851739 1 1 - 4250 242.17258 -9.9861962 0.0034851739 1 1 - 4300 300.85311 -7.924429 0.0034851739 1 1 - 4350 273.15684 -21.257282 0.0034851739 1 1 - 4400 305.77464 -5.8720712 0.0034851739 1 1 - 4450 314.97697 45.037299 0.0034851739 1 1 - 4500 310.77723 16.958771 0.0034851739 1 1 - 4550 302.17421 12.156862 0.0034851739 1 1 - 4600 319.74799 6.8488914 0.0034851739 1 1 - 4650 270.86805 -13.767907 0.0034851739 1 1 - 4700 249.81731 -31.197484 0.0034851739 1 1 - 4750 285.86481 -9.8916332 0.0034851739 1 1 - 4800 233.98321 7.1338518 0.0034851739 1 1 - 4850 302.60551 49.262886 0.0034851739 1 1 - 4900 316.55055 34.663238 0.0034851739 1 1 - 4950 357.32741 11.583013 0.0034851739 1 1 - 5000 400.21044 -8.1780861 0.0034851739 1 1 - 5050 390.01845 -20.490268 0.0034851739 1 1 - 5100 378.84249 -41.328772 0.0034851739 1 1 - 5150 324.02039 -15.023852 0.0034851739 1 1 - 5200 262.08427 10.937367 0.0034851739 1 1 - 5250 255.75506 16.381495 0.0034851739 1 1 - 5300 277.84991 40.682283 0.0034851739 1 1 - 5350 302.92834 9.1989644 0.0034851739 1 1 - 5400 283.71964 -1.6583895 0.0034851739 1 1 - 5450 300.71261 -4.703054 0.0034851739 1 1 - 5500 343.54987 -0.30546396 0.0034851739 1 1 - 5550 369.51272 21.691639 0.0034851739 1 1 - 5600 372.69786 -38.679919 0.0034851739 1 1 - 5650 327.41256 11.352201 0.0034851739 1 1 - 5700 278.9861 -23.82728 0.0034851739 1 1 - 5750 308.30037 -20.756238 0.0034851739 1 1 - 5800 341.4559 28.058314 0.0034851739 1 1 - 5850 322.9786 -10.731862 0.0034851739 1 1 - 5900 304.53598 32.825105 0.0034851739 1 1 - 5950 287.17515 -36.780057 0.0034851739 1 1 - 6000 296.52688 18.782156 0.0034851739 1 1 - 6050 314.25411 15.99272 0.0034851739 1 1 - 6100 313.86572 3.4344108 0.0034851739 1 1 - 6150 325.64197 32.39212 0.0034851739 1 1 - 6200 367.4298 -27.161154 0.0034851739 1 1 - 6250 369.30937 39.020881 0.0034851739 1 1 - 6300 328.92245 -23.175612 0.0034851739 1 1 - 6350 305.6293 4.9011587 0.0034851739 1 1 - 6400 241.70456 -13.675247 0.0034851739 1 1 - 6450 265.66574 2.4049735 0.0034851739 1 1 - 6500 249.3592 13.420453 0.0034851739 1 1 - 6550 294.5367 10.856753 0.0034851739 1 1 - 6600 308.20246 18.992923 0.0034851739 1 1 - 6650 305.43756 -49.57151 0.0034851739 1 1 - 6700 320.27395 11.339101 0.0034851739 1 1 - 6750 321.7875 -23.463361 0.0034851739 1 1 - 6800 303.40316 7.6256997 0.0034851739 1 1 - 6850 297.18652 51.52186 0.0034851739 1 1 - 6900 284.19084 -8.496294 0.0034851739 1 1 - 6950 331.04173 13.227745 0.0034851739 1 1 - 7000 311.38027 -43.26105 0.0034851739 1 1 - 7050 286.82046 -14.171194 0.0034851739 1 1 - 7100 302.81691 12.058085 0.0034851739 1 1 - 7150 297.18018 -43.110658 0.0034851739 1 1 - 7200 332.46131 26.051496 0.0034851739 1 1 - 7250 262.72288 41.161451 0.0034851739 1 1 - 7300 250.62739 -23.440907 0.0034851739 1 1 - 7350 296.92141 35.869216 0.0034851739 1 1 - 7400 245.06807 -13.467896 0.0034851739 1 1 - 7450 272.2659 -23.292836 0.0034851739 1 1 - 7500 209.05776 13.888665 0.0034851739 1 1 - 7550 255.03716 4.9662624 0.0034851739 1 1 - 7600 312.26011 -37.350427 0.0034851739 1 1 - 7650 305.5823 55.208039 0.0034851739 1 1 - 7700 325.13382 -18.370791 0.0034851739 1 1 - 7750 363.24898 -22.473126 0.0034851739 1 1 - 7800 350.19254 26.792307 0.0034851739 1 1 - 7850 271.76418 -17.843445 0.0034851739 1 1 - 7900 272.70301 -11.709349 0.0034851739 1 1 - 7950 298.5993 -12.736235 0.0034851739 1 1 - 8000 274.52611 49.657345 0.0034851739 1 1 - 8050 304.73711 -0.52485689 0.0034851739 1 1 - 8100 328.29239 -39.901891 0.0034851739 1 1 - 8150 406.52096 2.8669076 0.0034851739 1 1 - 8200 332.17309 -51.168754 0.0034851739 1 1 - 8250 354.68419 53.003157 0.0034851739 1 1 - 8300 337.28934 20.766408 0.0034851739 1 1 - 8350 361.81133 -54.159227 0.0034851739 1 1 - 8400 305.59597 24.011667 0.0034851739 1 1 - 8450 303.25823 4.423341 0.0034851739 1 1 - 8500 253.50747 -11.026949 0.0034851739 1 1 - 8550 277.13504 23.204625 0.0034851739 1 1 - 8600 291.40211 -22.253861 0.0034851739 1 1 - 8650 307.93765 32.14162 0.0034851739 1 1 - 8700 309.1529 0.36279434 0.0034851739 1 1 - 8750 355.10326 11.677219 0.0034851739 1 1 - 8800 330.21328 19.235269 0.0034851739 1 1 - 8850 241.29109 21.707386 0.0034851739 1 1 - 8900 319.15363 -60.010115 0.0034851739 1 1 - 8950 308.88552 -57.637014 0.0034851739 1 1 - 9000 272.22373 51.15837 0.0034851739 1 1 - 9050 248.84947 7.3390565 0.0034851739 1 1 - 9100 221.91564 48.387079 0.0034851739 1 1 - 9150 298.03506 2.9058639 0.0034851739 1 1 - 9200 274.25114 -24.597819 0.0034851739 1 1 - 9250 334.08373 5.1079577 0.0034851739 1 1 - 9300 383.07285 -23.274763 0.0034851739 1 1 - 9350 335.00581 20.94212 0.0034851739 1 1 - 9400 309.23862 34.074744 0.0034851739 1 1 - 9450 312.62262 -28.468057 0.0034851739 1 1 - 9500 324.54274 2.851136 0.0034851739 1 1 - 9550 313.32781 22.468182 0.0034851739 1 1 - 9600 269.04372 4.064934 0.0034851739 1 1 - 9650 270.98476 -21.520127 0.0034851739 1 1 - 9700 236.8736 16.250728 0.0034851739 1 1 - 9750 333.94686 1.6864148 0.0034851739 1 1 - 9800 330.91875 12.150018 0.0034851739 1 1 - 9850 343.8603 25.338853 0.0034851739 1 1 - 9900 330.93364 -28.292992 0.0034851739 1 1 - 9950 291.25518 25.795948 0.0034851739 1 1 - 10000 319.25565 25.323846 0.0034851739 1 1 -Loop time of 3.55353 on 4 procs for 10000 steps with 44 atoms - -Performance: 243.139 ns/day, 0.099 hours/ns, 2814.105 timesteps/s -93.4% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.0030422 | 0.10454 | 0.35211 | 44.8 | 2.94 -Bond | 0.0063896 | 0.29222 | 0.94356 | 71.3 | 8.22 -Kspace | 0.88508 | 1.6486 | 1.979 | 35.1 | 46.39 -Neigh | 0.61154 | 0.62212 | 0.63307 | 1.0 | 17.51 -Comm | 0.18944 | 0.24549 | 0.29196 | 7.9 | 6.91 -Output | 0.0050066 | 0.011804 | 0.032134 | 10.8 | 0.33 -Modify | 0.52282 | 0.60522 | 0.69588 | 7.9 | 17.03 -Other | | 0.02359 | | | 0.66 - -Nlocal: 11 ave 44 max 0 min -Histogram: 3 0 0 0 0 0 0 0 0 1 -Nghost: 33 ave 44 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 3 -Neighs: 205.75 ave 823 max 0 min -Histogram: 3 0 0 0 0 0 0 0 0 1 - -Total # of neighbors = 823 -Ave neighs/atom = 18.7045 -Ave special neighs/atom = 9.77273 -Neighbor list builds = 10000 -Dangerous builds = 0 - -# write_restart restart_longrun -# write_data restart_longrun.data - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:03 diff --git a/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.1 b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.1 new file mode 100644 index 0000000000..de1167c652 --- /dev/null +++ b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.1 @@ -0,0 +1,148 @@ +LAMMPS (5 Jun 2019) +Reading data file ... + orthogonal box = (-25 -25 -25) to (25 25 25) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 44 atoms + reading velocities ... + 44 velocities + scanning bonds ... + 9 = max bonds/atom + scanning angles ... + 21 = max angles/atom + scanning dihedrals ... + 29 = max dihedrals/atom + scanning impropers ... + 29 = max impropers/atom + reading bonds ... + 42 bonds + reading angles ... + 74 angles + reading dihedrals ... + 100 dihedrals + reading impropers ... + 44 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 6 = max # of 1-3 neighbors + 12 = max # of 1-4 neighbors + 41 = max # of special neighbors + special bonds CPU = 0.000181113 secs + read_data CPU = 0.0251833 secs +Read molecule mol1: + 18 atoms with max type 8 + 16 bonds with max type 14 + 25 angles with max type 28 + 23 dihedrals with max type 36 + 14 impropers with max type 11 +Read molecule mol2: + 18 atoms with max type 9 + 17 bonds with max type 13 + 31 angles with max type 27 + 39 dihedrals with max type 33 + 20 impropers with max type 1 +Read molecule mol3: + 15 atoms with max type 9 + 14 bonds with max type 13 + 25 angles with max type 27 + 30 dihedrals with max type 33 + 16 impropers with max type 1 +Read molecule mol4: + 15 atoms with max type 11 + 13 bonds with max type 15 + 19 angles with max type 29 + 16 dihedrals with max type 32 + 10 impropers with max type 13 +WARNING: Bond/react: Atom affected by reaction rxn1 too close to template edge (../fix_bond_react.cpp:1785) +WARNING: Bond/react: Atom affected by reaction rxn2 too close to template edge (../fix_bond_react.cpp:1785) +dynamic group bond_react_MASTER_group defined +dynamic group statted_grp_REACT defined +PPPM initialization ... + using 12-bit tables for long-range coulomb (../kspace.cpp:319) + G vector (1/distance) = 0.0534597 + grid = 2 2 2 + stencil order = 5 + estimated absolute RMS force accuracy = 0.0402256 + estimated relative force accuracy = 0.000121138 + using double precision FFTs + 3d grid and FFT values/proc = 343 8 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 10.5 + ghost atom cutoff = 10.5 + binsize = 5.25, bins = 10 10 10 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair lj/class2/coul/long, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard + (2) fix bond/react, occasional, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +WARNING: Inconsistent image flags (../domain.cpp:784) +Per MPI rank memory allocation (min/avg/max) = 34.41 | 34.41 | 34.41 Mbytes +Step Temp Press Density f_myrxns[1] f_myrxns[2] + 0 300 346.78165 0.0034851739 0 0 + 50 293.70542 -52.547388 0.0034851739 1 0 + 100 276.36755 54.81826 0.0034851739 1 1 + 150 448.65869 16.874435 0.0034851739 1 1 + 200 379.84257 11.578545 0.0034851739 1 1 + 250 298.21983 90.656585 0.0034851739 1 1 + 300 333.3111 -30.139607 0.0034851739 1 1 + 350 266.57108 6.4505134 0.0034851739 1 1 + 400 264.05476 10.513204 0.0034851739 1 1 + 450 250.70418 -18.635379 0.0034851739 1 1 + 500 261.21632 10.231013 0.0034851739 1 1 + 550 309.89024 -8.8299506 0.0034851739 1 1 + 600 373.45851 30.368993 0.0034851739 1 1 + 650 338.26242 9.0362267 0.0034851739 1 1 + 700 295.67794 -5.6007538 0.0034851739 1 1 + 750 310.86563 -59.228181 0.0034851739 1 1 + 800 286.22678 -9.9022407 0.0034851739 1 1 + 850 218.42135 27.845352 0.0034851739 1 1 + 900 259.62551 24.216336 0.0034851739 1 1 + 950 250.21307 -14.560985 0.0034851739 1 1 + 1000 274.29245 -0.38768626 0.0034851739 1 1 +Loop time of 0.341061 on 1 procs for 1000 steps with 44 atoms + +Performance: 253.327 ns/day, 0.095 hours/ns, 2932.025 timesteps/s +87.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.031135 | 0.031135 | 0.031135 | 0.0 | 9.13 +Bond | 0.12623 | 0.12623 | 0.12623 | 0.0 | 37.01 +Kspace | 0.036491 | 0.036491 | 0.036491 | 0.0 | 10.70 +Neigh | 0.046395 | 0.046395 | 0.046395 | 0.0 | 13.60 +Comm | 0.0025396 | 0.0025396 | 0.0025396 | 0.0 | 0.74 +Output | 0.07775 | 0.07775 | 0.07775 | 0.0 | 22.80 +Modify | 0.019219 | 0.019219 | 0.019219 | 0.0 | 5.64 +Other | | 0.001306 | | | 0.38 + +Nlocal: 44 ave 44 max 44 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 2 ave 2 max 2 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 740 ave 740 max 740 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 740 +Ave neighs/atom = 16.8182 +Ave special neighs/atom = 9.77273 +Neighbor list builds = 1000 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:00 diff --git a/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.4 b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.4 new file mode 100644 index 0000000000..b9c7a3ba15 --- /dev/null +++ b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.stabilized.g++.4 @@ -0,0 +1,148 @@ +LAMMPS (5 Jun 2019) +Reading data file ... + orthogonal box = (-25 -25 -25) to (25 25 25) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 44 atoms + reading velocities ... + 44 velocities + scanning bonds ... + 9 = max bonds/atom + scanning angles ... + 21 = max angles/atom + scanning dihedrals ... + 29 = max dihedrals/atom + scanning impropers ... + 29 = max impropers/atom + reading bonds ... + 42 bonds + reading angles ... + 74 angles + reading dihedrals ... + 100 dihedrals + reading impropers ... + 44 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 6 = max # of 1-3 neighbors + 12 = max # of 1-4 neighbors + 41 = max # of special neighbors + special bonds CPU = 0.000178751 secs + read_data CPU = 0.0385782 secs +Read molecule mol1: + 18 atoms with max type 8 + 16 bonds with max type 14 + 25 angles with max type 28 + 23 dihedrals with max type 36 + 14 impropers with max type 11 +Read molecule mol2: + 18 atoms with max type 9 + 17 bonds with max type 13 + 31 angles with max type 27 + 39 dihedrals with max type 33 + 20 impropers with max type 1 +Read molecule mol3: + 15 atoms with max type 9 + 14 bonds with max type 13 + 25 angles with max type 27 + 30 dihedrals with max type 33 + 16 impropers with max type 1 +Read molecule mol4: + 15 atoms with max type 11 + 13 bonds with max type 15 + 19 angles with max type 29 + 16 dihedrals with max type 32 + 10 impropers with max type 13 +WARNING: Bond/react: Atom affected by reaction rxn1 too close to template edge (../fix_bond_react.cpp:1785) +WARNING: Bond/react: Atom affected by reaction rxn2 too close to template edge (../fix_bond_react.cpp:1785) +dynamic group bond_react_MASTER_group defined +dynamic group statted_grp_REACT defined +PPPM initialization ... + using 12-bit tables for long-range coulomb (../kspace.cpp:319) + G vector (1/distance) = 0.0534597 + grid = 2 2 2 + stencil order = 5 + estimated absolute RMS force accuracy = 0.0402256 + estimated relative force accuracy = 0.000121138 + using double precision FFTs + 3d grid and FFT values/proc = 252 2 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 10.5 + ghost atom cutoff = 10.5 + binsize = 5.25, bins = 10 10 10 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair lj/class2/coul/long, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard + (2) fix bond/react, occasional, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +WARNING: Inconsistent image flags (../domain.cpp:784) +Per MPI rank memory allocation (min/avg/max) = 34.42 | 34.77 | 35.45 Mbytes +Step Temp Press Density f_myrxns[1] f_myrxns[2] + 0 300 346.78165 0.0034851739 0 0 + 50 293.70542 -52.547388 0.0034851739 1 0 + 100 276.36755 54.81826 0.0034851739 1 1 + 150 448.65869 16.874435 0.0034851739 1 1 + 200 379.84257 11.578545 0.0034851739 1 1 + 250 298.21983 90.656585 0.0034851739 1 1 + 300 333.3111 -30.139607 0.0034851739 1 1 + 350 266.57108 6.4505134 0.0034851739 1 1 + 400 264.05476 10.513204 0.0034851739 1 1 + 450 250.70418 -18.635379 0.0034851739 1 1 + 500 261.21632 10.231013 0.0034851739 1 1 + 550 309.89024 -8.8299506 0.0034851739 1 1 + 600 373.45851 30.368993 0.0034851739 1 1 + 650 338.26242 9.0362267 0.0034851739 1 1 + 700 295.67794 -5.6007538 0.0034851739 1 1 + 750 310.86563 -59.228181 0.0034851739 1 1 + 800 286.22678 -9.9022407 0.0034851739 1 1 + 850 218.42135 27.845352 0.0034851739 1 1 + 900 259.62551 24.216336 0.0034851739 1 1 + 950 250.21307 -14.560985 0.0034851739 1 1 + 1000 274.29245 -0.38768626 0.0034851739 1 1 +Loop time of 0.271242 on 4 procs for 1000 steps with 44 atoms + +Performance: 318.535 ns/day, 0.075 hours/ns, 3686.747 timesteps/s +98.6% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.00023773 | 0.0077322 | 0.016042 | 8.4 | 2.85 +Bond | 0.00073385 | 0.032108 | 0.08446 | 19.4 | 11.84 +Kspace | 0.041659 | 0.098095 | 0.13373 | 12.3 | 36.16 +Neigh | 0.028894 | 0.029247 | 0.029558 | 0.1 | 10.78 +Comm | 0.012367 | 0.013642 | 0.01503 | 0.9 | 5.03 +Output | 0.032475 | 0.040504 | 0.061019 | 5.9 | 14.93 +Modify | 0.032934 | 0.049086 | 0.0577 | 4.3 | 18.10 +Other | | 0.0008281 | | | 0.31 + +Nlocal: 11 ave 21 max 0 min +Histogram: 1 1 0 0 0 0 0 0 0 2 +Nghost: 32.5 ave 43 max 23 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 185 ave 376 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 + +Total # of neighbors = 740 +Ave neighs/atom = 16.8182 +Ave special neighs/atom = 9.77273 +Neighbor list builds = 1000 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:00 diff --git a/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.1 b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.1 new file mode 100644 index 0000000000..14cac1dfad --- /dev/null +++ b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.1 @@ -0,0 +1,147 @@ +LAMMPS (5 Jun 2019) +Reading data file ... + orthogonal box = (-25 -25 -25) to (25 25 25) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 44 atoms + reading velocities ... + 44 velocities + scanning bonds ... + 9 = max bonds/atom + scanning angles ... + 21 = max angles/atom + scanning dihedrals ... + 29 = max dihedrals/atom + scanning impropers ... + 29 = max impropers/atom + reading bonds ... + 42 bonds + reading angles ... + 74 angles + reading dihedrals ... + 100 dihedrals + reading impropers ... + 44 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 6 = max # of 1-3 neighbors + 12 = max # of 1-4 neighbors + 41 = max # of special neighbors + special bonds CPU = 0.000217102 secs + read_data CPU = 0.00630778 secs +Read molecule mol1: + 18 atoms with max type 8 + 16 bonds with max type 14 + 25 angles with max type 28 + 23 dihedrals with max type 36 + 14 impropers with max type 11 +Read molecule mol2: + 18 atoms with max type 9 + 17 bonds with max type 13 + 31 angles with max type 27 + 39 dihedrals with max type 33 + 20 impropers with max type 1 +Read molecule mol3: + 15 atoms with max type 9 + 14 bonds with max type 13 + 25 angles with max type 27 + 30 dihedrals with max type 33 + 16 impropers with max type 1 +Read molecule mol4: + 15 atoms with max type 11 + 13 bonds with max type 15 + 19 angles with max type 29 + 16 dihedrals with max type 32 + 10 impropers with max type 13 +WARNING: Bond/react: Atom affected by reaction rxn1 too close to template edge (../fix_bond_react.cpp:1785) +WARNING: Bond/react: Atom affected by reaction rxn2 too close to template edge (../fix_bond_react.cpp:1785) +dynamic group bond_react_MASTER_group defined +PPPM initialization ... + using 12-bit tables for long-range coulomb (../kspace.cpp:319) + G vector (1/distance) = 0.0534597 + grid = 2 2 2 + stencil order = 5 + estimated absolute RMS force accuracy = 0.0402256 + estimated relative force accuracy = 0.000121138 + using double precision FFTs + 3d grid and FFT values/proc = 343 8 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 10.5 + ghost atom cutoff = 10.5 + binsize = 5.25, bins = 10 10 10 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair lj/class2/coul/long, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard + (2) fix bond/react, occasional, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +WARNING: Inconsistent image flags (../domain.cpp:784) +Per MPI rank memory allocation (min/avg/max) = 34.35 | 34.35 | 34.35 Mbytes +Step Temp Press Density f_myrxns[1] f_myrxns[2] + 0 300 346.78165 0.0034851739 0 0 + 50 416.49412 -20.293038 0.0034851739 1 0 + 100 746.49323 91.912227 0.0034851739 1 1 + 150 515.15907 -1.4024709 0.0034851739 1 1 + 200 441.14572 -19.333087 0.0034851739 1 1 + 250 376.40996 30.717679 0.0034851739 1 1 + 300 326.15127 -3.0433799 0.0034851739 1 1 + 350 326.21116 6.235391 0.0034851739 1 1 + 400 366.48556 3.9807338 0.0034851739 1 1 + 450 313.79097 7.6674629 0.0034851739 1 1 + 500 278.89836 14.102052 0.0034851739 1 1 + 550 267.50214 18.241417 0.0034851739 1 1 + 600 276.28064 7.4649611 0.0034851739 1 1 + 650 255.26713 -8.5258573 0.0034851739 1 1 + 700 258.59752 -5.3341215 0.0034851739 1 1 + 750 263.71264 33.369869 0.0034851739 1 1 + 800 246.22976 -15.349137 0.0034851739 1 1 + 850 255.93887 16.331669 0.0034851739 1 1 + 900 239.72525 -0.20075789 0.0034851739 1 1 + 950 213.73064 12.17619 0.0034851739 1 1 + 1000 218.25094 -9.0955642 0.0034851739 1 1 +Loop time of 0.348252 on 1 procs for 1000 steps with 44 atoms + +Performance: 248.096 ns/day, 0.097 hours/ns, 2871.483 timesteps/s +91.8% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.031941 | 0.031941 | 0.031941 | 0.0 | 9.17 +Bond | 0.13031 | 0.13031 | 0.13031 | 0.0 | 37.42 +Kspace | 0.037554 | 0.037554 | 0.037554 | 0.0 | 10.78 +Neigh | 0.047397 | 0.047397 | 0.047397 | 0.0 | 13.61 +Comm | 0.0025814 | 0.0025814 | 0.0025814 | 0.0 | 0.74 +Output | 0.083526 | 0.083526 | 0.083526 | 0.0 | 23.98 +Modify | 0.013602 | 0.013602 | 0.013602 | 0.0 | 3.91 +Other | | 0.001336 | | | 0.38 + +Nlocal: 44 ave 44 max 44 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 3 ave 3 max 3 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 818 ave 818 max 818 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 818 +Ave neighs/atom = 18.5909 +Ave special neighs/atom = 9.77273 +Neighbor list builds = 1000 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:00 diff --git a/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.4 b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.4 new file mode 100644 index 0000000000..6b13dd60d3 --- /dev/null +++ b/examples/USER/misc/bond_react/tiny_nylon/log.5Jun19.tiny_nylon.unstabilized.g++.4 @@ -0,0 +1,147 @@ +LAMMPS (5 Jun 2019) +Reading data file ... + orthogonal box = (-25 -25 -25) to (25 25 25) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 44 atoms + reading velocities ... + 44 velocities + scanning bonds ... + 9 = max bonds/atom + scanning angles ... + 21 = max angles/atom + scanning dihedrals ... + 29 = max dihedrals/atom + scanning impropers ... + 29 = max impropers/atom + reading bonds ... + 42 bonds + reading angles ... + 74 angles + reading dihedrals ... + 100 dihedrals + reading impropers ... + 44 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 6 = max # of 1-3 neighbors + 12 = max # of 1-4 neighbors + 41 = max # of special neighbors + special bonds CPU = 0.000163256 secs + read_data CPU = 0.0244579 secs +Read molecule mol1: + 18 atoms with max type 8 + 16 bonds with max type 14 + 25 angles with max type 28 + 23 dihedrals with max type 36 + 14 impropers with max type 11 +Read molecule mol2: + 18 atoms with max type 9 + 17 bonds with max type 13 + 31 angles with max type 27 + 39 dihedrals with max type 33 + 20 impropers with max type 1 +Read molecule mol3: + 15 atoms with max type 9 + 14 bonds with max type 13 + 25 angles with max type 27 + 30 dihedrals with max type 33 + 16 impropers with max type 1 +Read molecule mol4: + 15 atoms with max type 11 + 13 bonds with max type 15 + 19 angles with max type 29 + 16 dihedrals with max type 32 + 10 impropers with max type 13 +WARNING: Bond/react: Atom affected by reaction rxn1 too close to template edge (../fix_bond_react.cpp:1785) +WARNING: Bond/react: Atom affected by reaction rxn2 too close to template edge (../fix_bond_react.cpp:1785) +dynamic group bond_react_MASTER_group defined +PPPM initialization ... + using 12-bit tables for long-range coulomb (../kspace.cpp:319) + G vector (1/distance) = 0.0534597 + grid = 2 2 2 + stencil order = 5 + estimated absolute RMS force accuracy = 0.0402256 + estimated relative force accuracy = 0.000121138 + using double precision FFTs + 3d grid and FFT values/proc = 252 2 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 10.5 + ghost atom cutoff = 10.5 + binsize = 5.25, bins = 10 10 10 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair lj/class2/coul/long, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard + (2) fix bond/react, occasional, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +WARNING: Inconsistent image flags (../domain.cpp:784) +Per MPI rank memory allocation (min/avg/max) = 33.34 | 33.69 | 34.37 Mbytes +Step Temp Press Density f_myrxns[1] f_myrxns[2] + 0 300 346.78165 0.0034851739 0 0 + 50 416.49412 -20.293038 0.0034851739 1 0 + 100 746.49323 91.912227 0.0034851739 1 1 + 150 515.15907 -1.4024709 0.0034851739 1 1 + 200 441.14572 -19.333087 0.0034851739 1 1 + 250 376.40996 30.717679 0.0034851739 1 1 + 300 326.15127 -3.0433799 0.0034851739 1 1 + 350 326.21116 6.235391 0.0034851739 1 1 + 400 366.48556 3.9807338 0.0034851739 1 1 + 450 313.79097 7.6674629 0.0034851739 1 1 + 500 278.89836 14.102052 0.0034851739 1 1 + 550 267.50214 18.241417 0.0034851739 1 1 + 600 276.28064 7.4649611 0.0034851739 1 1 + 650 255.26713 -8.5258573 0.0034851739 1 1 + 700 258.59752 -5.3341215 0.0034851739 1 1 + 750 263.71264 33.369869 0.0034851739 1 1 + 800 246.22976 -15.349137 0.0034851739 1 1 + 850 255.93887 16.331669 0.0034851739 1 1 + 900 239.72525 -0.20075789 0.0034851739 1 1 + 950 213.73064 12.17619 0.0034851739 1 1 + 1000 218.25094 -9.0955642 0.0034851739 1 1 +Loop time of 0.254903 on 4 procs for 1000 steps with 44 atoms + +Performance: 338.952 ns/day, 0.071 hours/ns, 3923.053 timesteps/s +99.8% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.00014252 | 0.0090715 | 0.021332 | 9.6 | 3.56 +Bond | 0.00047028 | 0.037261 | 0.10789 | 22.7 | 14.62 +Kspace | 0.051006 | 0.12756 | 0.1693 | 13.6 | 50.04 +Neigh | 0.035644 | 0.036088 | 0.036523 | 0.2 | 14.16 +Comm | 0.013984 | 0.016074 | 0.018676 | 1.6 | 6.31 +Output | 0.0002816 | 0.00033726 | 0.00044251 | 0.0 | 0.13 +Modify | 0.023697 | 0.027803 | 0.033552 | 2.5 | 10.91 +Other | | 0.0007123 | | | 0.28 + +Nlocal: 11 ave 29 max 0 min +Histogram: 1 1 0 0 1 0 0 0 0 1 +Nghost: 25 ave 31 max 12 min +Histogram: 1 0 0 0 0 0 0 0 2 1 +Neighs: 204.5 ave 443 max 0 min +Histogram: 2 0 0 0 0 0 0 0 1 1 + +Total # of neighbors = 818 +Ave neighs/atom = 18.5909 +Ave special neighs/atom = 9.77273 +Neighbor list builds = 1000 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:00 -- GitLab From 39f5b8c734af3e2408656f473638dcf39400babc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 1 Jul 2019 04:16:00 -0400 Subject: [PATCH 144/469] transform POEMS library to conform to IWYU conventions --- lib/poems/body.cpp | 14 ++++++++++++-- lib/poems/body.h | 20 +++++++++----------- lib/poems/body23joint.cpp | 16 ++++++++-------- lib/poems/body23joint.h | 6 ++---- lib/poems/colmatmap.h | 3 +++ lib/poems/colmatrix.cpp | 3 +-- lib/poems/colmatrix.h | 3 ++- lib/poems/eulerparameters.cpp | 4 ++++ lib/poems/eulerparameters.h | 6 +++--- lib/poems/fastmatrixops.cpp | 13 +++++++++++-- lib/poems/fastmatrixops.h | 11 ++++++++++- lib/poems/fixedpoint.cpp | 3 +++ lib/poems/fixedpoint.h | 2 ++ lib/poems/freebodyjoint.cpp | 12 ++++++++---- lib/poems/freebodyjoint.h | 3 +++ lib/poems/inertialframe.cpp | 4 +++- lib/poems/inertialframe.h | 3 +++ lib/poems/joint.cpp | 19 +++++++++++++++---- lib/poems/joint.h | 9 +++++++-- lib/poems/mat3x3.cpp | 3 ++- lib/poems/mat3x3.h | 3 +-- lib/poems/mat4x4.cpp | 2 ++ lib/poems/mat4x4.h | 4 +++- lib/poems/mat6x6.cpp | 2 ++ lib/poems/mat6x6.h | 3 ++- lib/poems/matrix.h | 2 ++ lib/poems/matrixfun.cpp | 10 ++++++++-- lib/poems/matrixfun.h | 18 +++++++++++++----- lib/poems/mixedjoint.cpp | 11 ++++++++--- lib/poems/mixedjoint.h | 4 ++++ lib/poems/norm.cpp | 6 ++++++ lib/poems/norm.h | 7 +++++-- lib/poems/onbody.cpp | 7 +++++-- lib/poems/onbody.h | 12 +++++++----- lib/poems/onfunctions.cpp | 9 +++++++-- lib/poems/onfunctions.h | 5 ++++- lib/poems/onsolver.cpp | 14 +++++++++++--- lib/poems/onsolver.h | 4 +++- lib/poems/particle.cpp | 1 - lib/poems/particle.h | 2 ++ lib/poems/poemstreenode.h | 6 ------ lib/poems/point.cpp | 4 +++- lib/poems/prismaticjoint.cpp | 4 ++++ lib/poems/prismaticjoint.h | 4 +++- lib/poems/revolutejoint.cpp | 4 ++++ lib/poems/revolutejoint.h | 5 +++-- lib/poems/rigidbody.cpp | 3 ++- lib/poems/rigidbody.h | 2 ++ lib/poems/rowmatrix.cpp | 2 +- lib/poems/rowmatrix.h | 3 +++ lib/poems/solver.cpp | 3 ++- lib/poems/solver.h | 4 ++-- lib/poems/sphericaljoint.cpp | 10 +++++++--- lib/poems/sphericaljoint.h | 6 ++---- lib/poems/system.cpp | 19 ++++++++++++++++++- lib/poems/system.h | 25 +------------------------ lib/poems/vect3.cpp | 9 +++++++++ lib/poems/vect3.h | 4 ++++ lib/poems/vect4.cpp | 2 ++ lib/poems/vect4.h | 4 +++- lib/poems/vect6.cpp | 2 ++ lib/poems/vect6.h | 3 +++ lib/poems/workspace.cpp | 19 +++++++++++++++---- lib/poems/workspace.h | 9 --------- 64 files changed, 301 insertions(+), 138 deletions(-) diff --git a/lib/poems/body.cpp b/lib/poems/body.cpp index 4ef05dd1e6..487d5e1ab7 100644 --- a/lib/poems/body.cpp +++ b/lib/poems/body.cpp @@ -14,9 +14,19 @@ * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - -#include "bodies.h" + +#include + +#include "body.h" +#include "inertialframe.h" +#include "mat3x3.h" +#include "particle.h" +#include "poemslist.h" #include "point.h" +#include "rigidbody.h" +#include "vect3.h" + +class Joint; using namespace std; diff --git a/lib/poems/body.h b/lib/poems/body.h index f8e0f6a5a3..06a9c72417 100644 --- a/lib/poems/body.h +++ b/lib/poems/body.h @@ -19,13 +19,11 @@ #ifndef BODY_H #define BODY_H -#include "poemslist.h" #include +#include "poemslist.h" #include "poemsobject.h" - -#include "matrices.h" - - +#include "mat3x3.h" +#include "vect3.h" // emumerated type enum BodyType { @@ -33,16 +31,16 @@ enum BodyType { PARTICLE = 1, RIGIDBODY = 2 }; - + class Point; class Joint; -class CompBody; + class Body : public POEMSObject { public: double mass; Mat3x3 inertia; - + Vect3 r; Vect3 v; Vect3 v_k; @@ -54,13 +52,13 @@ public: Vect3 alpha; Vect3 alpha_t; double KE; - + List joints; List points; Body(); - + bool ReadIn(std::istream& in); void WriteOut(std::ostream& out); bool ReadInPoints(std::istream& in); @@ -68,7 +66,7 @@ public: Point* GetPoint(int p); void AddJoint(Joint* joint); void AddPoint(Point* point); - + virtual bool ReadInBodyData(std::istream& in) = 0; virtual void WriteOutBodyData(std::ostream& out) = 0; virtual ~Body(); diff --git a/lib/poems/body23joint.cpp b/lib/poems/body23joint.cpp index 8cd0a95bca..7aa761fe2a 100644 --- a/lib/poems/body23joint.cpp +++ b/lib/poems/body23joint.cpp @@ -14,18 +14,18 @@ * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - +#include #include "body23joint.h" -#include "point.h" -#include "matrixfun.h" #include "body.h" -#include "fastmatrixops.h" -#include "norm.h" +#include "colmatrix.h" #include "eulerparameters.h" -#include "matrices.h" -#include - +#include "fastmatrixops.h" +#include "mat3x3.h" +#include "matrixfun.h" +#include "point.h" +#include "vect3.h" +#include "virtualmatrix.h" Body23Joint::Body23Joint(){ DimQandU(4,2); diff --git a/lib/poems/body23joint.h b/lib/poems/body23joint.h index 60253ac8a4..c47cdfb9de 100644 --- a/lib/poems/body23joint.h +++ b/lib/poems/body23joint.h @@ -18,11 +18,9 @@ #ifndef BODY23JOINT_H #define BODY23JOINT_H +#include #include "joint.h" -#include "vect3.h" -#include "mat3x3.h" - - +#include "matrix.h" class Body23Joint : public Joint { Matrix const_sP; diff --git a/lib/poems/colmatmap.h b/lib/poems/colmatmap.h index 3a6267a247..6d84870046 100644 --- a/lib/poems/colmatmap.h +++ b/lib/poems/colmatmap.h @@ -19,7 +19,10 @@ #ifndef COLMATMAP_H #define COLMATMAP_H +#include + #include "virtualcolmatrix.h" +#include "virtualmatrix.h" class ColMatrix; diff --git a/lib/poems/colmatrix.cpp b/lib/poems/colmatrix.cpp index dc6f49be2b..e7ae98a368 100644 --- a/lib/poems/colmatrix.cpp +++ b/lib/poems/colmatrix.cpp @@ -16,9 +16,8 @@ *_________________________________________________________________________*/ #include "colmatrix.h" -#include "rowmatrix.h" + #include -#include #include using namespace std; diff --git a/lib/poems/colmatrix.h b/lib/poems/colmatrix.h index 11fd85a928..70f13356e2 100644 --- a/lib/poems/colmatrix.h +++ b/lib/poems/colmatrix.h @@ -19,8 +19,9 @@ #ifndef COLMATRIX_H #define COLMATRIX_H +#include #include "virtualcolmatrix.h" -#include "colmatmap.h" +#include "virtualmatrix.h" class Matrix; class Vect6; diff --git a/lib/poems/eulerparameters.cpp b/lib/poems/eulerparameters.cpp index 032bc7da82..f698c40b3a 100644 --- a/lib/poems/eulerparameters.cpp +++ b/lib/poems/eulerparameters.cpp @@ -16,8 +16,12 @@ *_________________________________________________________________________*/ #include "eulerparameters.h" + #include +#include "colmatrix.h" +#include "mat3x3.h" + using namespace std; void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot){ diff --git a/lib/poems/eulerparameters.h b/lib/poems/eulerparameters.h index 029ade4b78..2e69a85fb9 100644 --- a/lib/poems/eulerparameters.h +++ b/lib/poems/eulerparameters.h @@ -14,12 +14,12 @@ * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #ifndef EULERPARAMETERS_H #define EULERPARAMETERS_H -#include "colmatrix.h" -#include "mat3x3.h" +class ColMatrix; +class Mat3x3; void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); diff --git a/lib/poems/fastmatrixops.cpp b/lib/poems/fastmatrixops.cpp index 782381a706..e6c81f0659 100644 --- a/lib/poems/fastmatrixops.cpp +++ b/lib/poems/fastmatrixops.cpp @@ -15,10 +15,19 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ -#include -#include "fastmatrixops.h" #include +#include "fastmatrixops.h" +#include "colmatmap.h" +#include "colmatrix.h" +#include "mat3x3.h" +#include "mat4x4.h" +#include "mat6x6.h" +#include "matrix.h" +#include "vect3.h" +#include "vect4.h" +#include "vect6.h" + using namespace std; // diff --git a/lib/poems/fastmatrixops.h b/lib/poems/fastmatrixops.h index e7ccdbd0ca..b2784a6e53 100644 --- a/lib/poems/fastmatrixops.h +++ b/lib/poems/fastmatrixops.h @@ -17,7 +17,16 @@ #ifndef FASTMATRIXOPS_H #define FASTMATRIXOPS_H -#include "matrices.h" + +class ColMatMap; +class ColMatrix; +class Mat3x3; +class Mat4x4; +class Mat6x6; +class Matrix; +class Vect3; +class Vect4; +class Vect6; void FastCross(Vect3& a, Vect3& b, Vect3& c); void FastSimpleRotation(Vect3& v, double q, Mat3x3& C); diff --git a/lib/poems/fixedpoint.cpp b/lib/poems/fixedpoint.cpp index 8600882393..238ddfed70 100644 --- a/lib/poems/fixedpoint.cpp +++ b/lib/poems/fixedpoint.cpp @@ -17,9 +17,12 @@ #include "fixedpoint.h" + #include #include +#include "virtualmatrix.h" + using namespace std; FixedPoint::FixedPoint(){ diff --git a/lib/poems/fixedpoint.h b/lib/poems/fixedpoint.h index b5ecb23906..fb8f23b0ae 100644 --- a/lib/poems/fixedpoint.h +++ b/lib/poems/fixedpoint.h @@ -19,6 +19,8 @@ #ifndef FIXEDPOINT_H #define FIXEDPOINT_H +#include + #include "point.h" #include "vect3.h" diff --git a/lib/poems/freebodyjoint.cpp b/lib/poems/freebodyjoint.cpp index d00f0bdb98..e6c59340f3 100644 --- a/lib/poems/freebodyjoint.cpp +++ b/lib/poems/freebodyjoint.cpp @@ -16,14 +16,18 @@ *_________________________________________________________________________*/ #include "freebodyjoint.h" -#include "point.h" + +#include + #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" -#include "norm.h" #include "eulerparameters.h" -#include "matrices.h" -#include +#include "colmatrix.h" +#include "mat3x3.h" +#include "mat6x6.h" +#include "vect3.h" +#include "virtualmatrix.h" FreeBodyJoint::FreeBodyJoint(){ diff --git a/lib/poems/freebodyjoint.h b/lib/poems/freebodyjoint.h index 27cacf7dc6..10574847e1 100644 --- a/lib/poems/freebodyjoint.h +++ b/lib/poems/freebodyjoint.h @@ -18,7 +18,10 @@ #ifndef FREEBODYJOINT_H #define FREEBODYJOINT_H +#include + #include "joint.h" +#include "matrix.h" class FreeBodyJoint : public Joint{ diff --git a/lib/poems/inertialframe.cpp b/lib/poems/inertialframe.cpp index 6c97b2f584..98ec820e7f 100644 --- a/lib/poems/inertialframe.cpp +++ b/lib/poems/inertialframe.cpp @@ -16,7 +16,9 @@ *_________________________________________________________________________*/ #include "inertialframe.h" -#include "fixedpoint.h" + +#include "mat3x3.h" +#include "virtualmatrix.h" using namespace std; diff --git a/lib/poems/inertialframe.h b/lib/poems/inertialframe.h index 08d0279a1e..3620641537 100644 --- a/lib/poems/inertialframe.h +++ b/lib/poems/inertialframe.h @@ -19,7 +19,10 @@ #ifndef INERTIALFRAME_H #define INERTIALFRAME_H +#include + #include "body.h" +#include "vect3.h" class InertialFrame : public Body { diff --git a/lib/poems/joint.cpp b/lib/poems/joint.cpp index 3bdd7b5fcd..ff24d5ebf5 100644 --- a/lib/poems/joint.cpp +++ b/lib/poems/joint.cpp @@ -16,13 +16,24 @@ *_________________________________________________________________________*/ -#include "joints.h" +#include +#include +#include + #include "body.h" #include "point.h" -#include -#include "matrixfun.h" #include "fastmatrixops.h" -#include +#include "body23joint.h" +#include "colmatrix.h" +#include "freebodyjoint.h" +#include "joint.h" +#include "mat3x3.h" +#include "matrix.h" +#include "mixedjoint.h" +#include "prismaticjoint.h" +#include "revolutejoint.h" +#include "sphericaljoint.h" +#include "virtualmatrix.h" using namespace std; diff --git a/lib/poems/joint.h b/lib/poems/joint.h index 17122af775..958805c4b5 100644 --- a/lib/poems/joint.h +++ b/lib/poems/joint.h @@ -18,9 +18,14 @@ #ifndef JOINT_H #define JOINT_H -#include "poemsobject.h" #include -#include "matrices.h" +#include "poemsobject.h" +#include "colmatrix.h" +#include "mat3x3.h" +#include "matrix.h" +#include "vect3.h" + +class VirtualMatrix; enum JointType { XYZJOINT = 0, diff --git a/lib/poems/mat3x3.cpp b/lib/poems/mat3x3.cpp index df24d4b108..3d9f1adcca 100644 --- a/lib/poems/mat3x3.cpp +++ b/lib/poems/mat3x3.cpp @@ -16,8 +16,9 @@ *_________________________________________________________________________*/ -#include "mat3x3.h" #include +#include +#include "mat3x3.h" using namespace std; diff --git a/lib/poems/mat3x3.h b/lib/poems/mat3x3.h index 4362b3ad9c..18abeadddc 100644 --- a/lib/poems/mat3x3.h +++ b/lib/poems/mat3x3.h @@ -18,12 +18,11 @@ #ifndef MAT3X3_H #define MAT3X3_H +#include #include "virtualmatrix.h" - class Vect3; class Mat6x6; -class Matrix; class ColMatrix; class Mat3x3 : public VirtualMatrix { diff --git a/lib/poems/mat4x4.cpp b/lib/poems/mat4x4.cpp index 4a611a6796..a6a587bc03 100644 --- a/lib/poems/mat4x4.cpp +++ b/lib/poems/mat4x4.cpp @@ -16,7 +16,9 @@ *_________________________________________________________________________*/ #include "mat4x4.h" + #include +#include using namespace std; diff --git a/lib/poems/mat4x4.h b/lib/poems/mat4x4.h index d7942b248e..c847f6e0d2 100644 --- a/lib/poems/mat4x4.h +++ b/lib/poems/mat4x4.h @@ -18,11 +18,13 @@ #ifndef MAT4X4_H #define MAT4X4_H +#include + #include "virtualmatrix.h" #include "matrix.h" - class Vect4; +class Matrix; class Mat4x4 : public VirtualMatrix { double elements[4][4]; diff --git a/lib/poems/mat6x6.cpp b/lib/poems/mat6x6.cpp index 16bffc5026..fdc917e03d 100644 --- a/lib/poems/mat6x6.cpp +++ b/lib/poems/mat6x6.cpp @@ -16,7 +16,9 @@ *_________________________________________________________________________*/ #include "mat6x6.h" + #include +#include using namespace std; diff --git a/lib/poems/mat6x6.h b/lib/poems/mat6x6.h index 11951b0442..5eaa4f803b 100644 --- a/lib/poems/mat6x6.h +++ b/lib/poems/mat6x6.h @@ -17,8 +17,9 @@ #ifndef MAT6X6_H #define MAT6X6_H -#include "virtualmatrix.h" +#include +#include "virtualmatrix.h" class Matrix; class Mat3x3; diff --git a/lib/poems/matrix.h b/lib/poems/matrix.h index 63699b9835..8bd8110760 100644 --- a/lib/poems/matrix.h +++ b/lib/poems/matrix.h @@ -18,6 +18,8 @@ #ifndef MATRIX_H #define MATRIX_H +#include + #include "virtualmatrix.h" class Mat3x3; diff --git a/lib/poems/matrixfun.cpp b/lib/poems/matrixfun.cpp index d193114679..99fbae4ca1 100644 --- a/lib/poems/matrixfun.cpp +++ b/lib/poems/matrixfun.cpp @@ -16,9 +16,15 @@ *_________________________________________________________________________*/ #include "matrixfun.h" -#include -#include "fastmatrixops.h" + #include +#include + +#include "fastmatrixops.h" +#include "vect4.h" +#include "virtualcolmatrix.h" +#include "virtualmatrix.h" +#include "virtualrowmatrix.h" using namespace std; diff --git a/lib/poems/matrixfun.h b/lib/poems/matrixfun.h index 600b608ad3..e9721eca7b 100644 --- a/lib/poems/matrixfun.h +++ b/lib/poems/matrixfun.h @@ -14,11 +14,22 @@ * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #ifndef MATRIXFUN_H #define MATRIXFUN_H -#include "matrices.h" +#include "colmatrix.h" +#include "mat3x3.h" +#include "mat4x4.h" +#include "mat6x6.h" +#include "matrix.h" +#include "rowmatrix.h" +#include "vect3.h" +#include "vect6.h" + +class VirtualColMatrix; +class VirtualMatrix; +class VirtualRowMatrix; // Create a Matrix VirtualMatrix* NewMatrix(int type); @@ -70,7 +81,4 @@ Matrix HStack(VirtualMatrix& A, VirtualMatrix& B); void Set6DAngularVector(Vect6& v6, Vect3& v3); void Set6DLinearVector(Vect6& v6, Vect3& v3); - - - #endif diff --git a/lib/poems/mixedjoint.cpp b/lib/poems/mixedjoint.cpp index c834ef621e..ef4ccd25df 100644 --- a/lib/poems/mixedjoint.cpp +++ b/lib/poems/mixedjoint.cpp @@ -16,13 +16,18 @@ *_________________________________________________________________________*/ #include "mixedjoint.h" -#include "point.h" + +#include + #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" -#include "norm.h" #include "eulerparameters.h" -#include "matrices.h" +#include "colmatrix.h" +#include "mat3x3.h" +#include "mat6x6.h" +#include "vect3.h" +#include "virtualmatrix.h" diff --git a/lib/poems/mixedjoint.h b/lib/poems/mixedjoint.h index 5f59b95f09..417f689523 100644 --- a/lib/poems/mixedjoint.h +++ b/lib/poems/mixedjoint.h @@ -18,7 +18,11 @@ #ifndef MIXEDJOINT_H #define MIXEDJOINT_H +#include + #include "joint.h" +#include "matrix.h" +#include "vect6.h" class MixedJoint : public Joint{ diff --git a/lib/poems/norm.cpp b/lib/poems/norm.cpp index 0f918cf968..6b8a56fa29 100644 --- a/lib/poems/norm.cpp +++ b/lib/poems/norm.cpp @@ -16,7 +16,13 @@ *_________________________________________________________________________*/ #include + #include "norm.h" +#include "colmatrix.h" +#include "rowmatrix.h" +#include "vect3.h" +#include "vect4.h" +#include "vect6.h" double Magnitude(ColMatrix& A){ double G; diff --git a/lib/poems/norm.h b/lib/poems/norm.h index 963a2ec5b2..b3ff285dea 100644 --- a/lib/poems/norm.h +++ b/lib/poems/norm.h @@ -18,8 +18,11 @@ #ifndef NORM_H #define NORM_H -#include "matrices.h" - +class ColMatrix; +class RowMatrix; +class Vect3; +class Vect4; +class Vect6; double Magnitude(ColMatrix& A); double Magnitude(RowMatrix& A); diff --git a/lib/poems/onbody.cpp b/lib/poems/onbody.cpp index 102900df8d..bf843be161 100644 --- a/lib/poems/onbody.cpp +++ b/lib/poems/onbody.cpp @@ -16,15 +16,18 @@ *_________________________________________________________________________*/ #include "onbody.h" + +#include +#include + #include "body.h" #include "inertialframe.h" #include "joint.h" #include "onfunctions.h" #include "virtualmatrix.h" #include "matrixfun.h" -#include -#include "norm.h" #include "eulerparameters.h" +#include "colmatrix.h" using namespace std; diff --git a/lib/poems/onbody.h b/lib/poems/onbody.h index d9923773c7..20190dfee8 100644 --- a/lib/poems/onbody.h +++ b/lib/poems/onbody.h @@ -22,6 +22,13 @@ #include "matrix.h" #include "vect6.h" #include "mat6x6.h" +#include "joint.h" +#include "mat3x3.h" +#include "vect3.h" + +class Body; +class ColMatrix; +class InertialFrame; // emumerated type enum Direction { @@ -29,11 +36,6 @@ enum Direction { FORWARD= 1 }; -class Body; -class InertialFrame; -class Joint; -class OnSolver; - class OnBody { Body* system_body; Joint* system_joint; diff --git a/lib/poems/onfunctions.cpp b/lib/poems/onfunctions.cpp index 582ab8cf8b..1d91dbf378 100644 --- a/lib/poems/onfunctions.cpp +++ b/lib/poems/onfunctions.cpp @@ -17,8 +17,13 @@ #include "onfunctions.h" -#include "matrixfun.h" -#include + +#include "mat3x3.h" +#include "mat6x6.h" +#include "vect3.h" +#include "vect6.h" +#include "virtualmatrix.h" + using namespace std; // friend of Vect3 & Vect6 diff --git a/lib/poems/onfunctions.h b/lib/poems/onfunctions.h index 8a69694095..42d0f4ac1c 100644 --- a/lib/poems/onfunctions.h +++ b/lib/poems/onfunctions.h @@ -18,7 +18,10 @@ #ifndef ONFUNCTIONS_H #define ONFUNCTIONS_H -#include "matrices.h" +class Mat3x3; +class Mat6x6; +class Vect3; +class Vect6; void OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV); void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC); diff --git a/lib/poems/onsolver.cpp b/lib/poems/onsolver.cpp index ad04d7e9e3..dd94c9c7ad 100644 --- a/lib/poems/onsolver.cpp +++ b/lib/poems/onsolver.cpp @@ -16,13 +16,21 @@ *_________________________________________________________________________*/ +#include +#include + #include "onsolver.h" #include "system.h" #include "onbody.h" #include "body.h" -#include "matrixfun.h" -#include - +#include "colmatmap.h" +#include "colmatrix.h" +#include "defines.h" +#include "inertialframe.h" +#include "matrix.h" +#include "poemslist.h" +#include "vect3.h" +#include "virtualmatrix.h" using namespace std; diff --git a/lib/poems/onsolver.h b/lib/poems/onsolver.h index f32b5880a9..b4bbd5e25d 100644 --- a/lib/poems/onsolver.h +++ b/lib/poems/onsolver.h @@ -21,7 +21,9 @@ #include "solver.h" #include "onbody.h" -#include + +class ColMatrix; +class Matrix; diff --git a/lib/poems/particle.cpp b/lib/poems/particle.cpp index 3496bc1906..0d953e00f6 100644 --- a/lib/poems/particle.cpp +++ b/lib/poems/particle.cpp @@ -17,7 +17,6 @@ #include "particle.h" -#include "fixedpoint.h" Particle::Particle(){ } diff --git a/lib/poems/particle.h b/lib/poems/particle.h index 20aa4831ea..0f13252f99 100644 --- a/lib/poems/particle.h +++ b/lib/poems/particle.h @@ -19,6 +19,8 @@ #ifndef PARTICLE_H #define PARTICLE_H +#include + #include "body.h" diff --git a/lib/poems/poemstreenode.h b/lib/poems/poemstreenode.h index b8f46031a5..e22bd9b97d 100644 --- a/lib/poems/poemstreenode.h +++ b/lib/poems/poemstreenode.h @@ -18,12 +18,6 @@ #ifndef TREENODE_H #define TREENODE_H -//#define NULL 0 - - -//Tree depends on TreeNode -class Tree; - // declares a tree node object for a binary tree class TreeNode{ diff --git a/lib/poems/point.cpp b/lib/poems/point.cpp index 4383844736..d7eed94efd 100644 --- a/lib/poems/point.cpp +++ b/lib/poems/point.cpp @@ -16,7 +16,9 @@ *_________________________________________________________________________*/ -#include "points.h" +#include "fixedpoint.h" +#include "point.h" +#include "vect3.h" Point::Point(){ position.Zeros(); diff --git a/lib/poems/prismaticjoint.cpp b/lib/poems/prismaticjoint.cpp index 7c01667a86..c7d4bed568 100644 --- a/lib/poems/prismaticjoint.cpp +++ b/lib/poems/prismaticjoint.cpp @@ -16,10 +16,14 @@ *_________________________________________________________________________*/ #include "prismaticjoint.h" + #include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" +#include "colmatrix.h" +#include "mat3x3.h" +#include "virtualmatrix.h" PrismaticJoint::PrismaticJoint(){ q.Dim(1); diff --git a/lib/poems/prismaticjoint.h b/lib/poems/prismaticjoint.h index 17cf050a78..c17be350cb 100644 --- a/lib/poems/prismaticjoint.h +++ b/lib/poems/prismaticjoint.h @@ -18,9 +18,11 @@ #ifndef PRISMATICJOINT_H #define PRISMATICJOINT_H +#include + #include "joint.h" #include "vect3.h" -#include "mat3x3.h" +#include "matrix.h" diff --git a/lib/poems/revolutejoint.cpp b/lib/poems/revolutejoint.cpp index ec5b1bec02..955a2f0dea 100644 --- a/lib/poems/revolutejoint.cpp +++ b/lib/poems/revolutejoint.cpp @@ -16,10 +16,14 @@ *_________________________________________________________________________*/ #include "revolutejoint.h" + #include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" +#include "colmatrix.h" +#include "mat3x3.h" +#include "virtualmatrix.h" RevoluteJoint::RevoluteJoint(){ DimQandU(1); diff --git a/lib/poems/revolutejoint.h b/lib/poems/revolutejoint.h index 478d48dbb9..ac1c06d5c5 100644 --- a/lib/poems/revolutejoint.h +++ b/lib/poems/revolutejoint.h @@ -18,11 +18,12 @@ #ifndef REVOLUTEJOINT_H #define REVOLUTEJOINT_H +#include #include "joint.h" #include "vect3.h" -#include "mat3x3.h" - +#include "matrix.h" +class VirtualMatrix; class RevoluteJoint : public Joint { Vect3 axis_pk; // unit vector in body1 basis diff --git a/lib/poems/rigidbody.cpp b/lib/poems/rigidbody.cpp index 3ac424f9e9..53acfa8bd4 100644 --- a/lib/poems/rigidbody.cpp +++ b/lib/poems/rigidbody.cpp @@ -16,7 +16,8 @@ *_________________________________________________________________________*/ #include "rigidbody.h" -#include "fixedpoint.h" +#include "mat3x3.h" +#include "virtualmatrix.h" using namespace std; diff --git a/lib/poems/rigidbody.h b/lib/poems/rigidbody.h index 0bb2a3ece2..2f4430e264 100644 --- a/lib/poems/rigidbody.h +++ b/lib/poems/rigidbody.h @@ -18,6 +18,8 @@ #ifndef RIGIDBODY_H #define RIGIDBODY_H +#include + #include "body.h" class RigidBody : public Body { diff --git a/lib/poems/rowmatrix.cpp b/lib/poems/rowmatrix.cpp index feb185070e..9fa57e773f 100644 --- a/lib/poems/rowmatrix.cpp +++ b/lib/poems/rowmatrix.cpp @@ -16,7 +16,7 @@ *_________________________________________________________________________*/ #include "rowmatrix.h" -#include "colmatrix.h" + #include #include diff --git a/lib/poems/rowmatrix.h b/lib/poems/rowmatrix.h index b04113e8ed..1dbb3d11e0 100644 --- a/lib/poems/rowmatrix.h +++ b/lib/poems/rowmatrix.h @@ -19,7 +19,10 @@ #ifndef ROWMATRIX_H #define ROWMATRIX_H +#include + #include "virtualrowmatrix.h" +#include "virtualmatrix.h" class RowMatrix : public VirtualRowMatrix { double* elements; diff --git a/lib/poems/solver.cpp b/lib/poems/solver.cpp index 67f5b607e3..9d2245149f 100644 --- a/lib/poems/solver.cpp +++ b/lib/poems/solver.cpp @@ -15,9 +15,10 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ +#include #include "solver.h" #include "system.h" -#include "matrices.h" +#include "onsolver.h" Solver::Solver(){ diff --git a/lib/poems/solver.h b/lib/poems/solver.h index 45564dd1ef..6a2debf497 100644 --- a/lib/poems/solver.h +++ b/lib/poems/solver.h @@ -17,12 +17,12 @@ #ifndef SOLVER_H #define SOLVER_H -#include + #include "colmatmap.h" -#include "matrices.h" #include "defines.h" class System; +class Matrix; class Solver{ protected: diff --git a/lib/poems/sphericaljoint.cpp b/lib/poems/sphericaljoint.cpp index fb5330db17..cba6d00a6e 100644 --- a/lib/poems/sphericaljoint.cpp +++ b/lib/poems/sphericaljoint.cpp @@ -17,14 +17,18 @@ #include "sphericaljoint.h" + +#include + #include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" -#include "norm.h" #include "eulerparameters.h" -#include "matrices.h" -#include +#include "colmatrix.h" +#include "mat3x3.h" +#include "vect3.h" +#include "virtualmatrix.h" SphericalJoint::SphericalJoint(){ diff --git a/lib/poems/sphericaljoint.h b/lib/poems/sphericaljoint.h index ef29f8e38e..90f1547873 100644 --- a/lib/poems/sphericaljoint.h +++ b/lib/poems/sphericaljoint.h @@ -18,11 +18,9 @@ #ifndef SPHERICALJOINT_H #define SPHERICALJOINT_H +#include #include "joint.h" -#include "vect3.h" -#include "mat3x3.h" - - +#include "matrix.h" class SphericalJoint : public Joint { Matrix const_sP; diff --git a/lib/poems/system.cpp b/lib/poems/system.cpp index 369213f7d0..1ac9ce1236 100644 --- a/lib/poems/system.cpp +++ b/lib/poems/system.cpp @@ -17,9 +17,26 @@ #include "system.h" + +#include +#include + #include "body.h" #include "joint.h" -#include +#include "colmatrix.h" +#include "eulerparameters.h" +#include "fixedpoint.h" +#include "freebodyjoint.h" +#include "inertialframe.h" +#include "mat3x3.h" +#include "matrix.h" +#include "matrixfun.h" +#include "rigidbody.h" +#include "sphericaljoint.h" +#include "vect3.h" +#include "virtualmatrix.h" + +class Point; System::System(){ diff --git a/lib/poems/system.h b/lib/poems/system.h index 1b59395de7..e5ce27194b 100644 --- a/lib/poems/system.h +++ b/lib/poems/system.h @@ -15,35 +15,12 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #ifndef SYSTEM_H #define SYSTEM_H - #include -#include -#include -#include -#include - #include "poemslist.h" -#include "matrices.h" -#include "workspace.h" -#include "matrixfun.h" -#include "onsolver.h" -#include "system.h" -#include "inertialframe.h" -#include "rigidbody.h" -#include "revolutejoint.h" -#include "fixedpoint.h" -#include "freebodyjoint.h" -#include "sphericaljoint.h" -#include "body23joint.h" -#include "mixedjoint.h" -#include "eulerparameters.h" -#include "matrices.h" -#include "norm.h" - class Body; class Joint; diff --git a/lib/poems/vect3.cpp b/lib/poems/vect3.cpp index 03c5d7bc00..7ce3230238 100644 --- a/lib/poems/vect3.cpp +++ b/lib/poems/vect3.cpp @@ -16,7 +16,9 @@ *_________________________________________________________________________*/ #include "vect3.h" + #include +#include using namespace std; @@ -141,6 +143,13 @@ Vect3& Vect3::operator+=(const Vect3& A){ return *this; } +Vect3& Vect3::operator-(){ + elements[0] = -elements[0]; + elements[1] = -elements[1]; + elements[2] = -elements[2]; + return *this; +} + Vect3& Vect3::operator-=(const Vect3& A){ elements[0] -= A.elements[0]; elements[1] -= A.elements[1]; diff --git a/lib/poems/vect3.h b/lib/poems/vect3.h index ababe18e51..a28832db6c 100644 --- a/lib/poems/vect3.h +++ b/lib/poems/vect3.h @@ -18,7 +18,10 @@ #ifndef VECT3_H #define VECT3_H +#include + #include "virtualcolmatrix.h" +#include "virtualmatrix.h" class Matrix; class Mat3x3; @@ -52,6 +55,7 @@ public: Vect3& operator*=(double b); Vect3& operator+=(const Vect3& A); Vect3& operator-=(const Vect3& A); + Vect3& operator-(); friend Matrix T(const Vect3& A); // a wasteful transpose friend Mat3x3 CrossMat(Vect3& a); // a wasteful cross matrix implementation diff --git a/lib/poems/vect4.cpp b/lib/poems/vect4.cpp index 3b5afddc50..b045998017 100644 --- a/lib/poems/vect4.cpp +++ b/lib/poems/vect4.cpp @@ -16,7 +16,9 @@ *_________________________________________________________________________*/ #include "vect4.h" + #include +#include using namespace std; diff --git a/lib/poems/vect4.h b/lib/poems/vect4.h index 695f5e158a..0b28994043 100644 --- a/lib/poems/vect4.h +++ b/lib/poems/vect4.h @@ -18,8 +18,10 @@ #ifndef VECT4_H #define VECT4_H -#include "virtualcolmatrix.h" +#include +#include "virtualcolmatrix.h" +#include "virtualmatrix.h" class Matrix; class Mat4x4; diff --git a/lib/poems/vect6.cpp b/lib/poems/vect6.cpp index eb65d24f16..5baadafc34 100644 --- a/lib/poems/vect6.cpp +++ b/lib/poems/vect6.cpp @@ -16,7 +16,9 @@ *_________________________________________________________________________*/ #include "vect6.h" + #include +#include using namespace std; diff --git a/lib/poems/vect6.h b/lib/poems/vect6.h index c346c852ef..8047c1bbf8 100644 --- a/lib/poems/vect6.h +++ b/lib/poems/vect6.h @@ -18,7 +18,10 @@ #ifndef VECT6_H #define VECT6_H +#include + #include "virtualcolmatrix.h" +#include "virtualmatrix.h" class Matrix; class Mat6x6; diff --git a/lib/poems/workspace.cpp b/lib/poems/workspace.cpp index 2b3257b0dd..29a1c95832 100644 --- a/lib/poems/workspace.cpp +++ b/lib/poems/workspace.cpp @@ -15,15 +15,26 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ +#include +#include // IWYU pragma: keep +#include #include "workspace.h" #include "system.h" #include "solver.h" #include "SystemProcessor.h" -#include -#include -#include -#include +#include "POEMSChain.h" +#include "body.h" +#include "colmatmap.h" +#include "colmatrix.h" +#include "defines.h" +#include "joint.h" +#include "mat3x3.h" +#include "matrix.h" +#include "matrixfun.h" +#include "poemslist.h" +#include "vect3.h" +#include "virtualmatrix.h" using namespace std; diff --git a/lib/poems/workspace.h b/lib/poems/workspace.h index 5faaf904dc..6213815d81 100644 --- a/lib/poems/workspace.h +++ b/lib/poems/workspace.h @@ -19,15 +19,6 @@ #ifndef WORKSPACE_H #define WORKSPACE_H -#include "matrices.h" -#include -#include -#include -#include -#include -#include - - class System; class Solver; -- GitLab From e9e7d995b270fd4abf7041474fd0c667453f4e99 Mon Sep 17 00:00:00 2001 From: Rupert Nash Date: Mon, 1 Jul 2019 11:37:13 +0100 Subject: [PATCH 145/469] move to user-misc --- src/USER-MISC/README | 1 + src/{ => USER-MISC}/compute_momentum.cpp | 0 src/{ => USER-MISC}/compute_momentum.h | 0 3 files changed, 1 insertion(+) rename src/{ => USER-MISC}/compute_momentum.cpp (100%) rename src/{ => USER-MISC}/compute_momentum.h (100%) diff --git a/src/USER-MISC/README b/src/USER-MISC/README index 219e19673d..7c48640e2a 100644 --- a/src/USER-MISC/README +++ b/src/USER-MISC/README @@ -31,6 +31,7 @@ compute basal/atom, Christopher Barrett, cdb333 at cavs.msstate.edu, 3 Mar 2013 compute cnp/atom, Paulo Branicio (USC), branicio at usc.edu, 31 May 2017 compute entropy/atom, Pablo Piaggi (EPFL), pablo.piaggi at epfl.ch, 15 June 2018 compute pressure/cylinder, Cody K. Addington (NCSU), , 2 Oct 2018 +compute momentum, Rupert Nash (University of Edinburgh), r.nash at epcc.ed.ac.uk, 28 June 2019 compute stress/mop, Romain Vermorel (U Pau) & Laurent Joly (U Lyon), romain.vermorel at univ-pau.fr & ljoly.ulyon at gmail.com, 5 Sep 18 compute stress/mop/profile, Romain Vermorel (U Pau) & Laurent Joly (U Lyon), romain.vermorel at univ-pau.fr & ljoly.ulyon at gmail.com, 5 Sep 18 compute temp/rotate, Laurent Joly (U Lyon), ljoly.ulyon at gmail.com, 8 Aug 11 diff --git a/src/compute_momentum.cpp b/src/USER-MISC/compute_momentum.cpp similarity index 100% rename from src/compute_momentum.cpp rename to src/USER-MISC/compute_momentum.cpp diff --git a/src/compute_momentum.h b/src/USER-MISC/compute_momentum.h similarity index 100% rename from src/compute_momentum.h rename to src/USER-MISC/compute_momentum.h -- GitLab From fb5e7e6f3badd73feb79768d6f4dbd0ed0c1c2de Mon Sep 17 00:00:00 2001 From: Rupert Nash Date: Mon, 1 Jul 2019 12:06:40 +0100 Subject: [PATCH 146/469] add note about USER-MISC package --- doc/src/compute_momentum.txt | 8 ++++++-- 1 file changed, 6 insertions(+), 2 deletions(-) diff --git a/doc/src/compute_momentum.txt b/doc/src/compute_momentum.txt index 4db171d42d..fc5243583e 100644 --- a/doc/src/compute_momentum.txt +++ b/doc/src/compute_momentum.txt @@ -36,9 +36,13 @@ output"_Howto_output.html doc page for an overview of LAMMPS output options. The vector value calculated by this compute is "extensive". The vector -value will be in momentum "units"_units.html. +value will be in mass*velocity "units"_units.html. -[Restrictions:] none +[Restrictions:] + +This compute is part of the USER-MISC package. It is only enabled if +LAMMPS was built with that package. See the "Build +package"_Build_package.html doc page for more info. [Related commands:] -- GitLab From 32728375b97714dbbe42e68fc2c14b5a0c770aa8 Mon Sep 17 00:00:00 2001 From: Rupert Nash Date: Mon, 1 Jul 2019 13:39:32 +0100 Subject: [PATCH 147/469] add test script for compute momentum --- examples/USER/misc/momentum/in.momentum | 65 +++++++++++++++++++++++++ 1 file changed, 65 insertions(+) create mode 100644 examples/USER/misc/momentum/in.momentum diff --git a/examples/USER/misc/momentum/in.momentum b/examples/USER/misc/momentum/in.momentum new file mode 100644 index 0000000000..5adcbfeff6 --- /dev/null +++ b/examples/USER/misc/momentum/in.momentum @@ -0,0 +1,65 @@ +# Test compute momentum with by comparing it's output with compute reduce + +# Script will output the two computations of the total momentum as +# thermo vars - they should be identical + +# 3D LJ Poiseuille flow simulation +dimension 3 +boundary p p p + +atom_style atomic +neighbor 0.3 bin +neigh_modify delay 5 + +# create geometry +lattice hcp 0.5 +region box block 0 20 0 10 0 10 +create_box 3 box +create_atoms 1 box + +mass 1 1.0 +mass 2 1.0 +mass 3 1.0 + +# LJ potentials +pair_style lj/cut 1.0 +pair_coeff * * 1.0 1.0 1.0 + +# define groups +region 1 block INF INF INF 1.0 INF INF +group lower region 1 +region 2 block INF INF 9.0 INF INF INF +group upper region 2 +group boundary union lower upper +group liquid subtract all boundary + +set group lower type 2 +set group upper type 3 + +# temperature settings +compute mobile liquid temp +velocity liquid create 1.0 100 temp mobile +fix 1 all nve +fix 2 liquid temp/rescale 200 1.0 2.0 0.02 1.0 +fix_modify 2 temp mobile + +velocity boundary set 0.0 0.0 0.0 +fix 4 lower setforce 0.0 0.0 0.0 +fix 5 upper setforce 0.0 0.0 0.0 +fix 6 liquid addforce 0.1 0.0 0.0 + +# Compute total momentum +compute mom liquid momentum + +# Comparison (momentum variables + compute reduce) +variable mx atom mass*vx +variable my atom mass*vy +variable mz atom mass*vz +compute mom_red liquid reduce sum v_mx v_my v_mz + +# Run +timestep 0.003 +thermo 1000 +thermo_style custom step c_mom_red[*] c_mom[*] + +run 100000 -- GitLab From 2443c8ad13ac452bcea30a3895f55394d89186ca Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 1 Jul 2019 09:14:22 -0400 Subject: [PATCH 148/469] reduce IWYU warnings for lammps.cpp --- src/lammps.cpp | 28 ++++++++++++++-------------- 1 file changed, 14 insertions(+), 14 deletions(-) diff --git a/src/lammps.cpp b/src/lammps.cpp index 052d14dfed..f8e7dceb89 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -19,20 +19,20 @@ #include #include #include "lammps.h" -#include "style_angle.h" -#include "style_atom.h" -#include "style_bond.h" -#include "style_command.h" -#include "style_compute.h" -#include "style_dihedral.h" -#include "style_dump.h" -#include "style_fix.h" -#include "style_improper.h" -#include "style_integrate.h" -#include "style_kspace.h" -#include "style_minimize.h" -#include "style_pair.h" -#include "style_region.h" +#include "style_angle.h" // IWYU pragma: keep +#include "style_atom.h" // IWYU pragma: keep +#include "style_bond.h" // IWYU pragma: keep +#include "style_command.h" // IWYU pragma: keep +#include "style_compute.h" // IWYU pragma: keep +#include "style_dihedral.h" // IWYU pragma: keep +#include "style_dump.h" // IWYU pragma: keep +#include "style_fix.h" // IWYU pragma: keep +#include "style_improper.h" // IWYU pragma: keep +#include "style_integrate.h" // IWYU pragma: keep +#include "style_kspace.h" // IWYU pragma: keep +#include "style_minimize.h" // IWYU pragma: keep +#include "style_pair.h" // IWYU pragma: keep +#include "style_region.h" // IWYU pragma: keep #include "universe.h" #include "input.h" #include "info.h" -- GitLab From e91539d4b52706bd16c5f22e5e3a8b719aa23bae Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 28 Jun 2019 12:25:48 -0600 Subject: [PATCH 149/469] Cleanup --- src/KOKKOS/pair_snap_kokkos_impl.h | 2 +- src/KOKKOS/sna_kokkos_impl.h | 6 +----- 2 files changed, 2 insertions(+), 6 deletions(-) diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index 20e04605ce..8d72d1fac4 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -200,7 +200,7 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) team_size = 1; #endif - if (beta_max < list->inum) { // TODO: no init + if (beta_max < list->inum) { d_beta = Kokkos::View("PairSNAPKokkos:beta", list->inum,ncoeff); d_bispectrum = Kokkos::View("PairSNAPKokkos:bispectrum", diff --git a/src/KOKKOS/sna_kokkos_impl.h b/src/KOKKOS/sna_kokkos_impl.h index 8cbb3eb3f6..f0d45cb5c2 100644 --- a/src/KOKKOS/sna_kokkos_impl.h +++ b/src/KOKKOS/sna_kokkos_impl.h @@ -475,7 +475,6 @@ void SNAKokkos::compute_deidrj(const typename Kokkos::TeamPolicy sum; - // TODO: which loop is faster to parallelize? Kokkos::parallel_reduce(Kokkos::ThreadVectorRange(team,twojmax+1), [&] (const int& j, t_scalar3& sum_tmp) { //for(int j = 0; j <= twojmax; j++) { @@ -632,9 +631,6 @@ void SNAKokkos::compute_dbidrj(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy Date: Mon, 1 Jul 2019 08:07:26 -0600 Subject: [PATCH 150/469] Remove temporary ulist variable --- src/SNAP/sna.cpp | 19 ++++++++----------- src/SNAP/sna.h | 3 +-- 2 files changed, 9 insertions(+), 13 deletions(-) diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp index f9696e1f12..6871bb5573 100644 --- a/src/SNAP/sna.cpp +++ b/src/SNAP/sna.cpp @@ -341,7 +341,7 @@ void SNA::compute_ui(int jnum) // theta0 = (r - rmin0) * rscale0; z0 = r / tan(theta0); - compute_uarray(x, y, z, z0, r); + compute_uarray(x, y, z, z0, r, j); add_uarraytot(r, wj[j], rcutij[j], j); } @@ -895,8 +895,8 @@ void SNA::add_uarraytot(double r, double wj, double rcut, int jj) sfac *= wj; - double* ulist_r_j = ulist_r_ij[jj]; - double* ulist_i_j = ulist_i_ij[jj]; + double* ulist_r = ulist_r_ij[jj]; + double* ulist_i = ulist_i_ij[jj]; for (int j = 0; j <= twojmax; j++) { int jju = idxu_block[j]; @@ -906,9 +906,6 @@ void SNA::add_uarraytot(double r, double wj, double rcut, int jj) sfac * ulist_r[jju]; ulisttot_i[jju] += sfac * ulist_i[jju]; - - ulist_r_j[jju] = ulist_r[jju]; - ulist_i_j[jju] = ulist_i[jju]; jju++; } } @@ -919,7 +916,7 @@ void SNA::add_uarraytot(double r, double wj, double rcut, int jj) ------------------------------------------------------------------------- */ void SNA::compute_uarray(double x, double y, double z, - double z0, double r) + double z0, double r, int jj) { double r0inv; double a_r, b_r, a_i, b_i; @@ -935,6 +932,10 @@ void SNA::compute_uarray(double x, double y, double z, // VMK Section 4.8.2 + + double* ulist_r = ulist_r_ij[jj]; + double* ulist_i = ulist_i_ij[jj]; + ulist_r[0] = 1.0; ulist_i[0] = 0.0; @@ -1208,8 +1209,6 @@ void SNA::create_twojmax_arrays() memory->create(rootpqarray, jdimpq, jdimpq, "sna:rootpqarray"); memory->create(cglist, idxcg_max, "sna:cglist"); - memory->create(ulist_r, idxu_max, "sna:ulist"); - memory->create(ulist_i, idxu_max, "sna:ulist"); memory->create(ulisttot_r, idxu_max, "sna:ulisttot"); memory->create(ulisttot_i, idxu_max, "sna:ulisttot"); memory->create(dulist_r, idxu_max, 3, "sna:dulist"); @@ -1234,8 +1233,6 @@ void SNA::destroy_twojmax_arrays() { memory->destroy(rootpqarray); memory->destroy(cglist); - memory->destroy(ulist_r); - memory->destroy(ulist_i); memory->destroy(ulisttot_r); memory->destroy(ulisttot_i); memory->destroy(dulist_r); diff --git a/src/SNAP/sna.h b/src/SNAP/sna.h index 81582cf9e5..e6bf4e3f9e 100644 --- a/src/SNAP/sna.h +++ b/src/SNAP/sna.h @@ -85,7 +85,6 @@ private: int*** idxcg_block; double* ulisttot_r, * ulisttot_i; - double* ulist_r, * ulist_i; double** ulist_r_ij, ** ulist_i_ij; int* idxu_block; @@ -109,7 +108,7 @@ private: void addself_uarraytot(double); void add_uarraytot(double, double, double, int); void compute_uarray(double, double, double, - double, double); + double, double, int); double deltacg(int, int, int); int compute_ncoeff(); void compute_duarray(double, double, double, -- GitLab From 559c187964622098a5eaa2e79d970e414eb6fa72 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Mon, 1 Jul 2019 08:20:48 -0600 Subject: [PATCH 151/469] Update SNA::memory_usage() --- src/SNAP/sna.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp index 6871bb5573..985110bdee 100644 --- a/src/SNAP/sna.cpp +++ b/src/SNAP/sna.cpp @@ -1175,7 +1175,7 @@ double SNA::memory_usage() bytes += jdimpq*jdimpq * sizeof(double); // pqarray bytes += idxcg_max * sizeof(double); // cglist - bytes += idxu_max * sizeof(double) * 2; // ulist + bytes += nmax * idxu_max * sizeof(double) * 2; // ulist_ij bytes += idxu_max * sizeof(double) * 2; // ulisttot bytes += idxu_max * 3 * sizeof(double) * 2; // dulist -- GitLab From 42c31227d9635de1da42550c8458aca622195a7a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 1 Jul 2019 14:31:41 -0400 Subject: [PATCH 152/469] continuing to clean up include file lists --- lib/poems/mat4x4.h | 2 -- src/KSPACE/pair_buck_coul_long.cpp | 3 +-- src/KSPACE/pair_buck_long_coul_long.cpp | 4 +--- src/MC/fix_bond_swap.cpp | 3 +-- src/MC/fix_bond_swap.h | 1 - src/MC/fix_gcmc.cpp | 7 ++----- src/PYTHON/fix_python_invoke.cpp | 3 --- src/PYTHON/fix_python_move.cpp | 7 ------- src/PYTHON/pair_python.cpp | 2 -- src/PYTHON/python_impl.cpp | 3 ++- src/PYTHON/python_impl.h | 1 + src/RIGID/fix_rigid_nh.cpp | 3 +-- src/RIGID/fix_rigid_nph_small.cpp | 1 - src/RIGID/fix_rigid_npt.cpp | 1 - src/RIGID/fix_rigid_npt_small.cpp | 1 - src/RIGID/fix_rigid_small.cpp | 4 ++-- src/imbalance_store.cpp | 1 - src/imbalance_time.cpp | 1 - src/lmppython.cpp | 4 ++++ src/lmppython.h | 5 ----- src/math_special.cpp | 2 +- src/min_linesearch.cpp | 1 - src/neigh_list.cpp | 2 +- src/npair_full_bin_ghost.cpp | 1 - src/npair_full_multi.cpp | 1 - src/npair_full_nsq.cpp | 1 - src/npair_full_nsq_ghost.cpp | 1 - src/npair_half_bin_atomonly_newton.cpp | 3 --- src/npair_half_bin_newtoff.cpp | 1 - src/npair_half_bin_newtoff_ghost.cpp | 1 - src/npair_half_bin_newton.cpp | 1 - src/npair_half_bin_newton_tri.cpp | 1 - src/npair_half_multi_newtoff.cpp | 1 - src/npair_half_multi_newton.cpp | 1 - src/npair_half_multi_newton_tri.cpp | 1 - src/npair_half_nsq_newtoff.cpp | 1 - src/npair_half_nsq_newtoff_ghost.cpp | 1 - src/npair_half_nsq_newton.cpp | 1 - src/npair_half_respa_bin_newtoff.cpp | 1 - src/npair_half_respa_bin_newton.cpp | 1 - src/npair_half_respa_bin_newton_tri.cpp | 1 - src/npair_half_respa_nsq_newtoff.cpp | 1 - src/npair_half_respa_nsq_newton.cpp | 1 - src/npair_half_size_bin_newtoff.cpp | 2 -- src/npair_half_size_bin_newton.cpp | 2 -- src/npair_half_size_bin_newton_tri.cpp | 2 -- src/npair_half_size_nsq_newtoff.cpp | 2 -- src/npair_half_size_nsq_newton.cpp | 2 -- src/npair_halffull_newtoff.cpp | 4 ---- src/npair_halffull_newton.cpp | 3 --- src/npair_skip.cpp | 3 --- src/pair_buck_coul_cut.cpp | 3 +-- src/pair_coul_cut.cpp | 3 +-- src/pointers.h | 1 + src/variable.cpp | 2 +- 55 files changed, 21 insertions(+), 92 deletions(-) diff --git a/lib/poems/mat4x4.h b/lib/poems/mat4x4.h index c847f6e0d2..a6ae232473 100644 --- a/lib/poems/mat4x4.h +++ b/lib/poems/mat4x4.h @@ -19,9 +19,7 @@ #define MAT4X4_H #include - #include "virtualmatrix.h" -#include "matrix.h" class Vect4; class Matrix; diff --git a/src/KSPACE/pair_buck_coul_long.cpp b/src/KSPACE/pair_buck_coul_long.cpp index 0a1ec88da5..a5427965dc 100644 --- a/src/KSPACE/pair_buck_coul_long.cpp +++ b/src/KSPACE/pair_buck_coul_long.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_buck_coul_long.h" #include "atom.h" diff --git a/src/KSPACE/pair_buck_long_coul_long.cpp b/src/KSPACE/pair_buck_long_coul_long.cpp index c7a4a4b2f6..bcd290891e 100644 --- a/src/KSPACE/pair_buck_long_coul_long.cpp +++ b/src/KSPACE/pair_buck_long_coul_long.cpp @@ -15,9 +15,8 @@ Contributing author: Pieter J. in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "math_vector.h" #include "pair_buck_long_coul_long.h" @@ -29,7 +28,6 @@ #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "memory.h" #include "error.h" diff --git a/src/MC/fix_bond_swap.cpp b/src/MC/fix_bond_swap.cpp index 9a72667907..5da2b845d6 100644 --- a/src/MC/fix_bond_swap.cpp +++ b/src/MC/fix_bond_swap.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_bond_swap.h" #include "atom.h" @@ -23,7 +23,6 @@ #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "group.h" #include "comm.h" #include "domain.h" #include "modify.h" diff --git a/src/MC/fix_bond_swap.h b/src/MC/fix_bond_swap.h index 0443144c23..d24159d807 100644 --- a/src/MC/fix_bond_swap.h +++ b/src/MC/fix_bond_swap.h @@ -21,7 +21,6 @@ FixStyle(bond/swap,FixBondSwap) #define LMP_FIX_BONDSWAP_H #include "fix.h" -#include "pair.h" namespace LAMMPS_NS { diff --git a/src/MC/fix_gcmc.cpp b/src/MC/fix_gcmc.cpp index 7ab0879335..4e48b71611 100644 --- a/src/MC/fix_gcmc.cpp +++ b/src/MC/fix_gcmc.cpp @@ -15,8 +15,8 @@ Contributing author: Paul Crozier, Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_gcmc.h" #include "atom.h" @@ -43,10 +43,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" -#include "thermo.h" -#include "output.h" #include "neighbor.h" -#include "utils.h" using namespace LAMMPS_NS; using namespace FixConst; @@ -371,7 +368,7 @@ void FixGCMC::options(int narg, char **arg) ngrouptypesmax*sizeof(char *), "fix_gcmc:grouptypestrings"); } - grouptypes[ngrouptypes] = atoi(arg[iarg+1]); + grouptypes[ngrouptypes] = force->inumeric(FLERR,arg[iarg+1]); int n = strlen(arg[iarg+2]) + 1; grouptypestrings[ngrouptypes] = new char[n]; strcpy(grouptypestrings[ngrouptypes],arg[iarg+2]); diff --git a/src/PYTHON/fix_python_invoke.cpp b/src/PYTHON/fix_python_invoke.cpp index 280c2d91e2..f704bd9741 100644 --- a/src/PYTHON/fix_python_invoke.cpp +++ b/src/PYTHON/fix_python_invoke.cpp @@ -16,13 +16,10 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_python_invoke.h" -#include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" #include "lmppython.h" #include "python_compat.h" diff --git a/src/PYTHON/fix_python_move.cpp b/src/PYTHON/fix_python_move.cpp index ec21dbeadd..56b7768669 100644 --- a/src/PYTHON/fix_python_move.cpp +++ b/src/PYTHON/fix_python_move.cpp @@ -16,15 +16,8 @@ ------------------------------------------------------------------------- */ #include -#include -#include #include #include "fix_python_move.h" -#include "atom.h" -#include "comm.h" -#include "force.h" -#include "memory.h" -#include "neigh_list.h" #include "lmppython.h" #include "error.h" #include "python_compat.h" diff --git a/src/PYTHON/pair_python.cpp b/src/PYTHON/pair_python.cpp index 2148fc67b8..638077da48 100644 --- a/src/PYTHON/pair_python.cpp +++ b/src/PYTHON/pair_python.cpp @@ -16,12 +16,10 @@ ------------------------------------------------------------------------- */ #include -#include #include #include #include "pair_python.h" #include "atom.h" -#include "comm.h" #include "force.h" #include "memory.h" #include "update.h" diff --git a/src/PYTHON/python_impl.cpp b/src/PYTHON/python_impl.cpp index 9c650330af..249d4f7bb1 100644 --- a/src/PYTHON/python_impl.cpp +++ b/src/PYTHON/python_impl.cpp @@ -16,8 +16,9 @@ ------------------------------------------------------------------------- */ #include +#include #include -#include "lmppython.h" +#include "python_impl.h" #include "force.h" #include "input.h" #include "variable.h" diff --git a/src/PYTHON/python_impl.h b/src/PYTHON/python_impl.h index 2ccdda95c9..f890f54f3b 100644 --- a/src/PYTHON/python_impl.h +++ b/src/PYTHON/python_impl.h @@ -15,6 +15,7 @@ #define LMP_PYTHON_IMPL_H #include "pointers.h" +#include "lmppython.h" namespace LAMMPS_NS { diff --git a/src/RIGID/fix_rigid_nh.cpp b/src/RIGID/fix_rigid_nh.cpp index 4dceb1b8b4..4acc8d3411 100644 --- a/src/RIGID/fix_rigid_nh.cpp +++ b/src/RIGID/fix_rigid_nh.cpp @@ -17,8 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_rigid_nh.h" #include "math_extra.h" @@ -32,7 +32,6 @@ #include "comm.h" #include "force.h" #include "kspace.h" -#include "output.h" #include "memory.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_nph_small.cpp b/src/RIGID/fix_rigid_nph_small.cpp index d32e3043f4..9b045eaf13 100644 --- a/src/RIGID/fix_rigid_nph_small.cpp +++ b/src/RIGID/fix_rigid_nph_small.cpp @@ -19,7 +19,6 @@ #include #include "fix_rigid_nph_small.h" -#include "domain.h" #include "modify.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_npt.cpp b/src/RIGID/fix_rigid_npt.cpp index da5d5ffaa5..526fc8f614 100644 --- a/src/RIGID/fix_rigid_npt.cpp +++ b/src/RIGID/fix_rigid_npt.cpp @@ -19,7 +19,6 @@ #include #include "fix_rigid_npt.h" -#include "domain.h" #include "modify.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_npt_small.cpp b/src/RIGID/fix_rigid_npt_small.cpp index f1fd5470da..fff338d687 100644 --- a/src/RIGID/fix_rigid_npt_small.cpp +++ b/src/RIGID/fix_rigid_npt_small.cpp @@ -19,7 +19,6 @@ #include #include "fix_rigid_npt_small.h" -#include "domain.h" #include "modify.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_small.cpp b/src/RIGID/fix_rigid_small.cpp index dedd71c98d..8c2feb6436 100644 --- a/src/RIGID/fix_rigid_small.cpp +++ b/src/RIGID/fix_rigid_small.cpp @@ -11,10 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include #include +#include #include "fix_rigid_small.h" #include "math_extra.h" #include "atom.h" @@ -31,7 +32,6 @@ #include "neighbor.h" #include "force.h" #include "input.h" -#include "output.h" #include "variable.h" #include "random_mars.h" #include "math_const.h" diff --git a/src/imbalance_store.cpp b/src/imbalance_store.cpp index 6b69caf785..c117b60860 100644 --- a/src/imbalance_store.cpp +++ b/src/imbalance_store.cpp @@ -14,7 +14,6 @@ #include #include "imbalance_store.h" #include "atom.h" -#include "input.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/imbalance_time.cpp b/src/imbalance_time.cpp index a5fe538b8f..ceb3c08220 100644 --- a/src/imbalance_time.cpp +++ b/src/imbalance_time.cpp @@ -14,7 +14,6 @@ #include #include "imbalance_time.h" #include "atom.h" -#include "comm.h" #include "force.h" #include "timer.h" #include "error.h" diff --git a/src/lmppython.cpp b/src/lmppython.cpp index 7c6a490c24..52abd93f10 100644 --- a/src/lmppython.cpp +++ b/src/lmppython.cpp @@ -12,7 +12,11 @@ ------------------------------------------------------------------------- */ #include "lmppython.h" +#if LMP_PYTHON +#include "python_impl.h" +#else #include "error.h" +#endif using namespace LAMMPS_NS; diff --git a/src/lmppython.h b/src/lmppython.h index afc21037fb..3d55c4827b 100644 --- a/src/lmppython.h +++ b/src/lmppython.h @@ -51,11 +51,6 @@ private: }; } - -#endif - -#if LMP_PYTHON -#include "python_impl.h" #endif /* ERROR/WARNING messages: diff --git a/src/math_special.cpp b/src/math_special.cpp index 31567bdc77..b2f545ddc6 100644 --- a/src/math_special.cpp +++ b/src/math_special.cpp @@ -1,5 +1,5 @@ #include -#include // requires C++-11 +#include // IWYU pragma: keep #include "math_special.h" using namespace LAMMPS_NS; diff --git a/src/min_linesearch.cpp b/src/min_linesearch.cpp index 33a781ecfe..3c0621c602 100644 --- a/src/min_linesearch.cpp +++ b/src/min_linesearch.cpp @@ -26,7 +26,6 @@ #include "min_linesearch.h" #include "atom.h" #include "modify.h" -#include "neighbor.h" #include "fix_minimize.h" #include "pair.h" #include "output.h" diff --git a/src/neigh_list.cpp b/src/neigh_list.cpp index 651b2ed70a..31720cc78c 100644 --- a/src/neigh_list.cpp +++ b/src/neigh_list.cpp @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ #include "neigh_list.h" -#include "my_page.h" +#include "my_page.h" // IWYU pragma: keep #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/npair_full_bin_ghost.cpp b/src/npair_full_bin_ghost.cpp index 2edd03cc9e..61b27dd99d 100644 --- a/src/npair_full_bin_ghost.cpp +++ b/src/npair_full_bin_ghost.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_full_bin_ghost.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_full_multi.cpp b/src/npair_full_multi.cpp index 9a2490ac5d..40ed2275be 100644 --- a/src/npair_full_multi.cpp +++ b/src/npair_full_multi.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_full_multi.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_full_nsq.cpp b/src/npair_full_nsq.cpp index 1b404ffc94..76b66fd004 100644 --- a/src/npair_full_nsq.cpp +++ b/src/npair_full_nsq.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_full_nsq.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_full_nsq_ghost.cpp b/src/npair_full_nsq_ghost.cpp index 1727b2905e..b20fa9b8ce 100644 --- a/src/npair_full_nsq_ghost.cpp +++ b/src/npair_full_nsq_ghost.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_full_nsq_ghost.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_bin_atomonly_newton.cpp b/src/npair_half_bin_atomonly_newton.cpp index 6da44b4a5c..a7fa3985ef 100644 --- a/src/npair_half_bin_atomonly_newton.cpp +++ b/src/npair_half_bin_atomonly_newton.cpp @@ -12,12 +12,9 @@ ------------------------------------------------------------------------- */ #include "npair_half_bin_atomonly_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/npair_half_bin_newtoff.cpp b/src/npair_half_bin_newtoff.cpp index 4c44741ffe..65768918c9 100644 --- a/src/npair_half_bin_newtoff.cpp +++ b/src/npair_half_bin_newtoff.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_bin_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_bin_newtoff_ghost.cpp b/src/npair_half_bin_newtoff_ghost.cpp index 72ec15e66a..91fbf049cb 100644 --- a/src/npair_half_bin_newtoff_ghost.cpp +++ b/src/npair_half_bin_newtoff_ghost.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_bin_newtoff_ghost.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_bin_newton.cpp b/src/npair_half_bin_newton.cpp index 3a387870e3..fe388e1144 100644 --- a/src/npair_half_bin_newton.cpp +++ b/src/npair_half_bin_newton.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_bin_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_bin_newton_tri.cpp b/src/npair_half_bin_newton_tri.cpp index 169e710e0e..1f0e3c1187 100644 --- a/src/npair_half_bin_newton_tri.cpp +++ b/src/npair_half_bin_newton_tri.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_bin_newton_tri.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_multi_newtoff.cpp b/src/npair_half_multi_newtoff.cpp index 07b5c87a6c..57dcf29cc7 100644 --- a/src/npair_half_multi_newtoff.cpp +++ b/src/npair_half_multi_newtoff.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_multi_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_multi_newton.cpp b/src/npair_half_multi_newton.cpp index 3d90979329..a9293d3d64 100644 --- a/src/npair_half_multi_newton.cpp +++ b/src/npair_half_multi_newton.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_multi_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_multi_newton_tri.cpp b/src/npair_half_multi_newton_tri.cpp index 909c69246b..c1d845cb38 100644 --- a/src/npair_half_multi_newton_tri.cpp +++ b/src/npair_half_multi_newton_tri.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_multi_newton_tri.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_nsq_newtoff.cpp b/src/npair_half_nsq_newtoff.cpp index 06e8344332..db369687d0 100644 --- a/src/npair_half_nsq_newtoff.cpp +++ b/src/npair_half_nsq_newtoff.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_nsq_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_nsq_newtoff_ghost.cpp b/src/npair_half_nsq_newtoff_ghost.cpp index 1865061a8b..0a9b6d0f45 100644 --- a/src/npair_half_nsq_newtoff_ghost.cpp +++ b/src/npair_half_nsq_newtoff_ghost.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_nsq_newtoff_ghost.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_nsq_newton.cpp b/src/npair_half_nsq_newton.cpp index 11c71d5609..69489915b2 100644 --- a/src/npair_half_nsq_newton.cpp +++ b/src/npair_half_nsq_newton.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_nsq_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_respa_bin_newtoff.cpp b/src/npair_half_respa_bin_newtoff.cpp index 0145771f4a..8c1d8d684f 100644 --- a/src/npair_half_respa_bin_newtoff.cpp +++ b/src/npair_half_respa_bin_newtoff.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_respa_bin_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_respa_bin_newton.cpp b/src/npair_half_respa_bin_newton.cpp index 72a613204d..d2598fa1a4 100644 --- a/src/npair_half_respa_bin_newton.cpp +++ b/src/npair_half_respa_bin_newton.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_respa_bin_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_respa_bin_newton_tri.cpp b/src/npair_half_respa_bin_newton_tri.cpp index add1cf6e5c..efe48d48e1 100644 --- a/src/npair_half_respa_bin_newton_tri.cpp +++ b/src/npair_half_respa_bin_newton_tri.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_respa_bin_newton_tri.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_respa_nsq_newtoff.cpp b/src/npair_half_respa_nsq_newtoff.cpp index c0e932f0ae..334ebb5ca8 100644 --- a/src/npair_half_respa_nsq_newtoff.cpp +++ b/src/npair_half_respa_nsq_newtoff.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_respa_nsq_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_respa_nsq_newton.cpp b/src/npair_half_respa_nsq_newton.cpp index f7d161896d..7ecd02b0c5 100644 --- a/src/npair_half_respa_nsq_newton.cpp +++ b/src/npair_half_respa_nsq_newton.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_respa_nsq_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_size_bin_newtoff.cpp b/src/npair_half_size_bin_newtoff.cpp index 021452028b..b9e44675ac 100644 --- a/src/npair_half_size_bin_newtoff.cpp +++ b/src/npair_half_size_bin_newtoff.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_bin_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_size_bin_newton.cpp b/src/npair_half_size_bin_newton.cpp index 760c09570a..93bcc25373 100644 --- a/src/npair_half_size_bin_newton.cpp +++ b/src/npair_half_size_bin_newton.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_bin_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_size_bin_newton_tri.cpp b/src/npair_half_size_bin_newton_tri.cpp index d831982ed6..39068c02bc 100644 --- a/src/npair_half_size_bin_newton_tri.cpp +++ b/src/npair_half_size_bin_newton_tri.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_bin_newton_tri.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_size_nsq_newtoff.cpp b/src/npair_half_size_nsq_newtoff.cpp index 1c2fe5f3d5..6f169d0b6c 100644 --- a/src/npair_half_size_nsq_newtoff.cpp +++ b/src/npair_half_size_nsq_newtoff.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_nsq_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_half_size_nsq_newton.cpp b/src/npair_half_size_nsq_newton.cpp index ce9f8ec186..d427c14809 100644 --- a/src/npair_half_size_nsq_newton.cpp +++ b/src/npair_half_size_nsq_newton.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_nsq_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_halffull_newtoff.cpp b/src/npair_halffull_newtoff.cpp index 84816f07b2..6ff5433e88 100644 --- a/src/npair_halffull_newtoff.cpp +++ b/src/npair_halffull_newtoff.cpp @@ -12,12 +12,8 @@ ------------------------------------------------------------------------- */ #include "npair_halffull_newtoff.h" -#include "neighbor.h" #include "neigh_list.h" -#include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/npair_halffull_newton.cpp b/src/npair_halffull_newton.cpp index 371bbd33a8..0912cfe12f 100644 --- a/src/npair_halffull_newton.cpp +++ b/src/npair_halffull_newton.cpp @@ -12,12 +12,9 @@ ------------------------------------------------------------------------- */ #include "npair_halffull_newton.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/npair_skip.cpp b/src/npair_skip.cpp index 1fe202537a..028041a947 100644 --- a/src/npair_skip.cpp +++ b/src/npair_skip.cpp @@ -12,12 +12,9 @@ ------------------------------------------------------------------------- */ #include "npair_skip.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/pair_buck_coul_cut.cpp b/src/pair_buck_coul_cut.cpp index 094797694c..64475166e3 100644 --- a/src/pair_buck_coul_cut.cpp +++ b/src/pair_buck_coul_cut.cpp @@ -15,9 +15,8 @@ Contributing author: Eduardo Bringa (LLNL) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include "pair_buck_coul_cut.h" #include "atom.h" #include "comm.h" diff --git a/src/pair_coul_cut.cpp b/src/pair_coul_cut.cpp index 196e064219..28973026cd 100644 --- a/src/pair_coul_cut.cpp +++ b/src/pair_coul_cut.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_coul_cut.h" #include "atom.h" diff --git a/src/pointers.h b/src/pointers.h index 5df5b72d47..1af07d5158 100644 --- a/src/pointers.h +++ b/src/pointers.h @@ -23,6 +23,7 @@ #include "lmptype.h" // IWYU pragma: export #include +#include // IWYU pragme: export #include // IWYU pragma: export #include "lammps.h" // IWYU pragma: export diff --git a/src/variable.cpp b/src/variable.cpp index 1416754073..111fc75a9a 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include #include @@ -34,7 +35,6 @@ #include "thermo.h" #include "random_mars.h" #include "math_const.h" -#include "atom_masks.h" #include "lmppython.h" #include "memory.h" #include "info.h" -- GitLab From 3cd1095dd83aa2b619000f04194e6f211ae2457a Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 1 Jul 2019 16:12:51 -0400 Subject: [PATCH 153/469] Add line for compute hma --- src/USER-MISC/README | 1 + 1 file changed, 1 insertion(+) diff --git a/src/USER-MISC/README b/src/USER-MISC/README index 219e19673d..18a3bfa629 100644 --- a/src/USER-MISC/README +++ b/src/USER-MISC/README @@ -30,6 +30,7 @@ compute ackland/atom, Gerolf Ziegenhain, gerolf at ziegenhain.com, 4 Oct 2007 compute basal/atom, Christopher Barrett, cdb333 at cavs.msstate.edu, 3 Mar 2013 compute cnp/atom, Paulo Branicio (USC), branicio at usc.edu, 31 May 2017 compute entropy/atom, Pablo Piaggi (EPFL), pablo.piaggi at epfl.ch, 15 June 2018 +compute hma, Andrew Schultz & David Kofke (UB), ajs42 at buffalo.edu & kofke at buffalo.edu, 1 Jul 2019 compute pressure/cylinder, Cody K. Addington (NCSU), , 2 Oct 2018 compute stress/mop, Romain Vermorel (U Pau) & Laurent Joly (U Lyon), romain.vermorel at univ-pau.fr & ljoly.ulyon at gmail.com, 5 Sep 18 compute stress/mop/profile, Romain Vermorel (U Pau) & Laurent Joly (U Lyon), romain.vermorel at univ-pau.fr & ljoly.ulyon at gmail.com, 5 Sep 18 -- GitLab From 7547e1dae621f02e14e8e77bffc6ad3c6300e59e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 1 Jul 2019 17:10:21 -0400 Subject: [PATCH 154/469] make certain that the vector storage and the size_vector variable are consistent in computes --- src/ASPHERE/compute_temp_asphere.cpp | 2 +- src/BODY/compute_temp_body.cpp | 2 +- src/CORESHELL/compute_temp_cs.cpp | 2 +- src/SPIN/compute_spin.cpp | 2 +- src/USER-BOCS/compute_pressure_bocs.cpp | 6 +++--- src/USER-DRUDE/compute_temp_drude.cpp | 2 +- src/USER-EFF/compute_temp_deform_eff.cpp | 2 +- src/USER-EFF/compute_temp_region_eff.cpp | 2 +- src/USER-FEP/compute_fep.cpp | 2 +- src/USER-MISC/compute_temp_rotate.cpp | 2 +- src/compute_com.cpp | 2 +- src/compute_group_group.cpp | 2 +- src/compute_gyration.cpp | 2 +- src/compute_heat_flux.cpp | 2 +- src/compute_msd.cpp | 2 +- src/compute_pressure.cpp | 2 +- src/compute_temp.cpp | 2 +- src/compute_temp_chunk.cpp | 2 +- src/compute_temp_com.cpp | 2 +- src/compute_temp_deform.cpp | 2 +- src/compute_temp_partial.cpp | 2 +- src/compute_temp_ramp.cpp | 2 +- src/compute_temp_region.cpp | 2 +- src/compute_temp_sphere.cpp | 2 +- src/compute_vacf.cpp | 2 +- 25 files changed, 27 insertions(+), 27 deletions(-) diff --git a/src/ASPHERE/compute_temp_asphere.cpp b/src/ASPHERE/compute_temp_asphere.cpp index 011d8cae80..651c228e41 100644 --- a/src/ASPHERE/compute_temp_asphere.cpp +++ b/src/ASPHERE/compute_temp_asphere.cpp @@ -78,7 +78,7 @@ ComputeTempAsphere::ComputeTempAsphere(LAMMPS *lmp, int narg, char **arg) : if (mode == ROTATE) extra_dof = 0; - vector = new double[6]; + vector = new double[size_vector]; } diff --git a/src/BODY/compute_temp_body.cpp b/src/BODY/compute_temp_body.cpp index 5446fb6d64..b560bdd11d 100644 --- a/src/BODY/compute_temp_body.cpp +++ b/src/BODY/compute_temp_body.cpp @@ -71,7 +71,7 @@ ComputeTempBody::ComputeTempBody(LAMMPS *lmp, int narg, char **arg) : } else error->all(FLERR,"Illegal compute temp/body command"); } - vector = new double[6]; + vector = new double[size_vector]; } diff --git a/src/CORESHELL/compute_temp_cs.cpp b/src/CORESHELL/compute_temp_cs.cpp index 03ebfa154d..dac0d60fce 100644 --- a/src/CORESHELL/compute_temp_cs.cpp +++ b/src/CORESHELL/compute_temp_cs.cpp @@ -101,7 +101,7 @@ ComputeTempCS::ComputeTempCS(LAMMPS *lmp, int narg, char **arg) : // allocate memory - vector = new double[6]; + vector = new double[size_vector]; maxatom = 0; vint = NULL; diff --git a/src/SPIN/compute_spin.cpp b/src/SPIN/compute_spin.cpp index 0a881e1de6..501b708c88 100644 --- a/src/SPIN/compute_spin.cpp +++ b/src/SPIN/compute_spin.cpp @@ -149,6 +149,6 @@ void ComputeSpin::compute_vector() void ComputeSpin::allocate() { - memory->create(vector,6,"compute/spin:vector"); + memory->create(vector,size_vector,"compute/spin:vector"); } diff --git a/src/USER-BOCS/compute_pressure_bocs.cpp b/src/USER-BOCS/compute_pressure_bocs.cpp index fc24efab4c..c43910ec6d 100644 --- a/src/USER-BOCS/compute_pressure_bocs.cpp +++ b/src/USER-BOCS/compute_pressure_bocs.cpp @@ -106,9 +106,9 @@ ComputePressureBocs::ComputePressureBocs(LAMMPS *lmp, int narg, char **arg) : if (keflag && id_temp == NULL) error->all(FLERR,"Compute pressure/bocs requires temperature ID " - "to include kinetic energy"); + "to include kinetic energy"); - vector = new double[6]; + vector = new double[size_vector]; nvirial = 0; vptr = NULL; } @@ -365,7 +365,7 @@ void ComputePressureBocs::compute_vector() if (force->kspace && kspace_virial && force->kspace->scalar_pressure_flag) error->all(FLERR,"Must use 'kspace_modify pressure/scalar no' for " - "tensor components with kspace_style msm"); + "tensor components with kspace_style msm"); // invoke temperature if it hasn't been already diff --git a/src/USER-DRUDE/compute_temp_drude.cpp b/src/USER-DRUDE/compute_temp_drude.cpp index 27b525c07d..4830e950d0 100644 --- a/src/USER-DRUDE/compute_temp_drude.cpp +++ b/src/USER-DRUDE/compute_temp_drude.cpp @@ -46,7 +46,7 @@ ComputeTempDrude::ComputeTempDrude(LAMMPS *lmp, int narg, char **arg) : extlist[2] = extlist[3] = extlist[4] = extlist[5] = 1; tempflag = 0; // because does not compute a single temperature (scalar and vector) - vector = new double[6]; + vector = new double[size_vector]; fix_drude = NULL; id_temp = NULL; temperature = NULL; diff --git a/src/USER-EFF/compute_temp_deform_eff.cpp b/src/USER-EFF/compute_temp_deform_eff.cpp index 23abb4f99d..621eff210f 100644 --- a/src/USER-EFF/compute_temp_deform_eff.cpp +++ b/src/USER-EFF/compute_temp_deform_eff.cpp @@ -54,7 +54,7 @@ ComputeTempDeformEff::ComputeTempDeformEff(LAMMPS *lmp, int narg, char **arg) : maxbias = 0; vbiasall = NULL; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/USER-EFF/compute_temp_region_eff.cpp b/src/USER-EFF/compute_temp_region_eff.cpp index 659bdfca5e..8cab690367 100644 --- a/src/USER-EFF/compute_temp_region_eff.cpp +++ b/src/USER-EFF/compute_temp_region_eff.cpp @@ -58,7 +58,7 @@ ComputeTempRegionEff::ComputeTempRegionEff(LAMMPS *lmp, int narg, char **arg) : maxbias = 0; vbiasall = NULL; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/USER-FEP/compute_fep.cpp b/src/USER-FEP/compute_fep.cpp index 0e5f164f88..dc0b71e71b 100644 --- a/src/USER-FEP/compute_fep.cpp +++ b/src/USER-FEP/compute_fep.cpp @@ -53,7 +53,7 @@ ComputeFEP::ComputeFEP(LAMMPS *lmp, int narg, char **arg) : size_vector = 3; extvector = 0; - vector = new double[3]; + vector = new double[size_vector]; fepinitflag = 0; // avoid init to run entirely when called by write_data diff --git a/src/USER-MISC/compute_temp_rotate.cpp b/src/USER-MISC/compute_temp_rotate.cpp index 66f1b8f5f7..36093bd1e1 100644 --- a/src/USER-MISC/compute_temp_rotate.cpp +++ b/src/USER-MISC/compute_temp_rotate.cpp @@ -46,7 +46,7 @@ ComputeTempRotate::ComputeTempRotate(LAMMPS *lmp, int narg, char **arg) : maxbias = 0; vbiasall = NULL; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_com.cpp b/src/compute_com.cpp index 27606cbc6f..2496aa9446 100644 --- a/src/compute_com.cpp +++ b/src/compute_com.cpp @@ -29,7 +29,7 @@ ComputeCOM::ComputeCOM(LAMMPS *lmp, int narg, char **arg) : size_vector = 3; extvector = 0; - vector = new double[3]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_group_group.cpp b/src/compute_group_group.cpp index e55f679b2e..17e8737350 100644 --- a/src/compute_group_group.cpp +++ b/src/compute_group_group.cpp @@ -105,7 +105,7 @@ ComputeGroupGroup::ComputeGroupGroup(LAMMPS *lmp, int narg, char **arg) : } else error->all(FLERR,"Illegal compute group/group command"); } - vector = new double[3]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_gyration.cpp b/src/compute_gyration.cpp index f8d19853e0..0e29c0d667 100644 --- a/src/compute_gyration.cpp +++ b/src/compute_gyration.cpp @@ -33,7 +33,7 @@ ComputeGyration::ComputeGyration(LAMMPS *lmp, int narg, char **arg) : extscalar = 0; extvector = 0; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_heat_flux.cpp b/src/compute_heat_flux.cpp index e402da7842..0b37865034 100644 --- a/src/compute_heat_flux.cpp +++ b/src/compute_heat_flux.cpp @@ -70,7 +70,7 @@ ComputeHeatFlux::ComputeHeatFlux(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR, "Compute heat/flux compute ID does not compute stress/atom"); - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_msd.cpp b/src/compute_msd.cpp index fc47b2609a..608d3e6b33 100644 --- a/src/compute_msd.cpp +++ b/src/compute_msd.cpp @@ -115,7 +115,7 @@ ComputeMSD::ComputeMSD(LAMMPS *lmp, int narg, char **arg) : // displacement vector - vector = new double[4]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index dde02a5aed..978cad0cad 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -101,7 +101,7 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Compute pressure requires temperature ID " "to include kinetic energy"); - vector = new double[6]; + vector = new double[size_vector]; nvirial = 0; vptr = NULL; } diff --git a/src/compute_temp.cpp b/src/compute_temp.cpp index f7d3a890ec..70a7734593 100644 --- a/src/compute_temp.cpp +++ b/src/compute_temp.cpp @@ -37,7 +37,7 @@ ComputeTemp::ComputeTemp(LAMMPS *lmp, int narg, char **arg) : extvector = 1; tempflag = 1; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_temp_chunk.cpp b/src/compute_temp_chunk.cpp index 920515e05c..396492e18d 100644 --- a/src/compute_temp_chunk.cpp +++ b/src/compute_temp_chunk.cpp @@ -125,7 +125,7 @@ ComputeTempChunk::ComputeTempChunk(LAMMPS *lmp, int narg, char **arg) : // vector data - vector = new double[6]; + vector = new double[size_vector]; // chunk-based data diff --git a/src/compute_temp_com.cpp b/src/compute_temp_com.cpp index f2ad40ea43..c46a17497f 100644 --- a/src/compute_temp_com.cpp +++ b/src/compute_temp_com.cpp @@ -39,7 +39,7 @@ ComputeTempCOM::ComputeTempCOM(LAMMPS *lmp, int narg, char **arg) : tempflag = 1; tempbias = 1; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_temp_deform.cpp b/src/compute_temp_deform.cpp index 39780b5cf6..280c17dd08 100644 --- a/src/compute_temp_deform.cpp +++ b/src/compute_temp_deform.cpp @@ -48,7 +48,7 @@ ComputeTempDeform::ComputeTempDeform(LAMMPS *lmp, int narg, char **arg) : maxbias = 0; vbiasall = NULL; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_temp_partial.cpp b/src/compute_temp_partial.cpp index 4425aebdda..ee72ba3e74 100644 --- a/src/compute_temp_partial.cpp +++ b/src/compute_temp_partial.cpp @@ -49,7 +49,7 @@ ComputeTempPartial::ComputeTempPartial(LAMMPS *lmp, int narg, char **arg) : maxbias = 0; vbiasall = NULL; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_temp_ramp.cpp b/src/compute_temp_ramp.cpp index ba572645f3..36e7f51ce4 100644 --- a/src/compute_temp_ramp.cpp +++ b/src/compute_temp_ramp.cpp @@ -101,7 +101,7 @@ ComputeTempRamp::ComputeTempRamp(LAMMPS *lmp, int narg, char **arg) : maxbias = 0; vbiasall = NULL; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_temp_region.cpp b/src/compute_temp_region.cpp index 4aa4dac0a1..0c54aeb63c 100644 --- a/src/compute_temp_region.cpp +++ b/src/compute_temp_region.cpp @@ -49,7 +49,7 @@ ComputeTempRegion::ComputeTempRegion(LAMMPS *lmp, int narg, char **arg) : maxbias = 0; vbiasall = NULL; - vector = new double[6]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ diff --git a/src/compute_temp_sphere.cpp b/src/compute_temp_sphere.cpp index 651da6dee5..23e74634b5 100644 --- a/src/compute_temp_sphere.cpp +++ b/src/compute_temp_sphere.cpp @@ -72,7 +72,7 @@ ComputeTempSphere::ComputeTempSphere(LAMMPS *lmp, int narg, char **arg) : if (mode == ROTATE) extra_dof = 0; - vector = new double[6]; + vector = new double[size_vector]; // error checks diff --git a/src/compute_vacf.cpp b/src/compute_vacf.cpp index 3ef3acf0bf..d46b8b5fa0 100644 --- a/src/compute_vacf.cpp +++ b/src/compute_vacf.cpp @@ -75,7 +75,7 @@ ComputeVACF::ComputeVACF(LAMMPS *lmp, int narg, char **arg) : // displacement vector - vector = new double[4]; + vector = new double[size_vector]; } /* ---------------------------------------------------------------------- */ -- GitLab From ef1b62a42219652cce3750dea3cab3697e8bae26 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 1 Jul 2019 20:44:03 -0400 Subject: [PATCH 155/469] rename single2nd => single_hessian --- src/USER-MISC/compute_hma.cpp | 2 +- src/pair.cpp | 2 +- src/pair.h | 4 ++-- src/pair_lj_smooth_linear.cpp | 4 ++-- src/pair_lj_smooth_linear.h | 2 +- 5 files changed, 7 insertions(+), 7 deletions(-) diff --git a/src/USER-MISC/compute_hma.cpp b/src/USER-MISC/compute_hma.cpp index 15cadbdd45..a14084b9ca 100644 --- a/src/USER-MISC/compute_hma.cpp +++ b/src/USER-MISC/compute_hma.cpp @@ -360,7 +360,7 @@ void ComputeHMA::compute_vector() if (rsq < cutsq[itype][jtype]) { double* jdr = deltaR[j]; double fforce, d2u[6]; - force->pair->single2nd(i, j, itype, jtype, rsq, delr, factor_coul, factor_lj, fforce, d2u); + force->pair->single_hessian(i, j, itype, jtype, rsq, delr, factor_coul, factor_lj, fforce, d2u); int m = 0; for (int k=0; k<3; k++) { double a = fac; diff --git a/src/pair.cpp b/src/pair.cpp index 61a75dd150..43fc9bc907 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -60,7 +60,7 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) comm_forward = comm_reverse = comm_reverse_off = 0; single_enable = 1; - single2nd_enable = 0; + single_hessian_enable = 0; restartinfo = 1; respa_enable = 0; one_coeff = 0; diff --git a/src/pair.h b/src/pair.h index 8d7362adba..d85b9af0c3 100644 --- a/src/pair.h +++ b/src/pair.h @@ -46,7 +46,7 @@ class Pair : protected Pointers { int comm_reverse_off; // size of reverse comm even if newton off int single_enable; // 1 if single() routine exists - int single2nd_enable; // 1 if single2nd() routine exists + int single_hessian_enable; // 1 if single_hessian() routine exists int restartinfo; // 1 if pair style writes restart info int respa_enable; // 1 if inner/middle/outer rRESPA routines int one_coeff; // 1 if allows only one coeff * * call @@ -151,7 +151,7 @@ class Pair : protected Pointers { void pairTensor(double fforce, double dfac, double delr[3], double phiTensor[6]); - virtual double single2nd(int, int, int, int, + virtual double single_hessian(int, int, int, int, double, double[3], double, double, double& fforce, double d2u[6]) { fforce = 0.0; diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 0aa19570f2..3ebdda4143 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -31,7 +31,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ PairLJSmoothLinear::PairLJSmoothLinear(LAMMPS *lmp) : Pair(lmp) { - single2nd_enable = 1; + single_hessian_enable = 1; } /* ---------------------------------------------------------------------- */ @@ -349,7 +349,7 @@ double PairLJSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, return factor_lj*philj; } -double PairLJSmoothLinear::single2nd(int /*i*/, int /*j*/, int itype, int jtype, double rsq, +double PairLJSmoothLinear::single_hessian(int /*i*/, int /*j*/, int itype, int jtype, double rsq, double delr[3], double factor_coul, double factor_lj, double &fforce, double d2u[6]) { diff --git a/src/pair_lj_smooth_linear.h b/src/pair_lj_smooth_linear.h index a43cbc23e2..7e26a7011e 100644 --- a/src/pair_lj_smooth_linear.h +++ b/src/pair_lj_smooth_linear.h @@ -38,7 +38,7 @@ class PairLJSmoothLinear : public Pair { void write_restart_settings(FILE *); void read_restart_settings(FILE *); double single(int, int, int, int, double, double, double, double &); - double single2nd(int, int, int, int, double, double[3], double, double, double&, double[6]); + double single_hessian(int, int, int, int, double, double[3], double, double, double&, double[6]); protected: double cut_global; -- GitLab From 6fc5810bb4d4b0d0042204926bf04d29259db063 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 2 Jul 2019 01:30:11 -0400 Subject: [PATCH 156/469] with the refactored include handling we can allow include in if/then/else --- doc/src/if.txt | 3 +-- src/input.cpp | 28 ++++++++-------------------- src/input.h | 1 - 3 files changed, 9 insertions(+), 23 deletions(-) diff --git a/doc/src/if.txt b/doc/src/if.txt index 20caf1a1ef..ceec8f55db 100644 --- a/doc/src/if.txt +++ b/doc/src/if.txt @@ -57,8 +57,7 @@ Boolean expression is FALSE, then no commands are executed. The syntax for Boolean expressions is described below. Each command (t1, f1, e1, etc) can be any valid LAMMPS input script -command, except an "include"_include.html command, which is not -allowed. If the command is more than one word, it must enclosed in +command. If the command is more than one word, it must enclosed in quotes, so it will be treated as a single argument, as in the examples above. diff --git a/src/input.cpp b/src/input.cpp index 9e0ad78d9e..390ca37bf3 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -82,7 +82,6 @@ Input::Input(LAMMPS *lmp, int argc, char **argv) : Pointers(lmp) label_active = 0; labelstr = NULL; jump_skip = 0; - ifthenelse_flag = 0; if (me == 0) { nfile = maxfile = 1; @@ -962,11 +961,10 @@ void Input::ifthenelse() ncommands++; } - ifthenelse_flag = 1; - for (int i = 0; i < ncommands; i++) one(commands[i]); - ifthenelse_flag = 0; - - for (int i = 0; i < ncommands; i++) delete [] commands[i]; + for (int i = 0; i < ncommands; i++) { + one(commands[i]); + delete [] commands[i]; + } delete [] commands; return; @@ -1018,13 +1016,10 @@ void Input::ifthenelse() // execute the list of commands - ifthenelse_flag = 1; - for (int i = 0; i < ncommands; i++) one(commands[i]); - ifthenelse_flag = 0; - - // clean up - - for (int i = 0; i < ncommands; i++) delete [] commands[i]; + for (int i = 0; i < ncommands; i++) { + one(commands[i]); + delete [] commands[i]; + } delete [] commands; return; @@ -1037,13 +1032,6 @@ void Input::include() { if (narg != 1) error->all(FLERR,"Illegal include command"); - // do not allow include inside an if command - // NOTE: this check will fail if a 2nd if command was inside the if command - // and came before the include - - if (ifthenelse_flag) - error->all(FLERR,"Cannot use include command within an if command"); - if (me == 0) { if (nfile == maxfile) { maxfile++; diff --git a/src/input.h b/src/input.h index 33e83bfb06..7b6e55c2ba 100644 --- a/src/input.h +++ b/src/input.h @@ -54,7 +54,6 @@ class Input : protected Pointers { int label_active; // 0 = no label, 1 = looking for label char *labelstr; // label string being looked for int jump_skip; // 1 if skipping next jump, 0 otherwise - int ifthenelse_flag; // 1 if executing commands inside an if-then-else FILE **infiles; // list of open input files -- GitLab From 968335d4fdc15ec3db520cb780895e5eca151d41 Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Tue, 2 Jul 2019 10:34:10 +0200 Subject: [PATCH 157/469] Remove useless things --- src/compute_pressure.cpp | 2 +- src/compute_pressure.h | 1 - src/pair_hybrid.h | 1 - 3 files changed, 1 insertion(+), 3 deletions(-) diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index 96f577219d..16e56cb9df 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -87,7 +87,7 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : pstyle = new char[n]; strcpy(pstyle,arg[iarg++]); - nsub = 0; + int nsub = 0; if (narg > iarg) { if (isdigit(arg[iarg][0])) { diff --git a/src/compute_pressure.h b/src/compute_pressure.h index 31983e8e2c..2982271390 100644 --- a/src/compute_pressure.h +++ b/src/compute_pressure.h @@ -49,7 +49,6 @@ class ComputePressure : public Compute { void virial_compute(int, int); private: - int nsub; char *pstyle; }; diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index 1e0130ba3d..e313e16f18 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -33,7 +33,6 @@ class PairHybrid : public Pair { friend class Respa; friend class Info; friend class PairDeprecated; - friend class ComputePressure; public: PairHybrid(class LAMMPS *); virtual ~PairHybrid(); -- GitLab From 0761c4dbb97fbbbe3b61f37fc62b7ca61f74b558 Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Tue, 2 Jul 2019 10:47:36 +0200 Subject: [PATCH 158/469] Name change hybridpair->pair/hybrid --- doc/src/compute_pressure.txt | 2 +- src/compute_pressure.cpp | 20 ++++++++++---------- src/compute_pressure.h | 4 ++-- 3 files changed, 13 insertions(+), 13 deletions(-) diff --git a/doc/src/compute_pressure.txt b/doc/src/compute_pressure.txt index 070376075e..b8d52b83de 100644 --- a/doc/src/compute_pressure.txt +++ b/doc/src/compute_pressure.txt @@ -22,7 +22,7 @@ keyword = {ke} or {pair} or {bond} or {angle} or {dihedral} or {improper} or {ks compute 1 all pressure thermo_temp compute 1 all pressure NULL pair bond -compute 1 all pressure NULL hybridpair lj/cut :pre +compute 1 all pressure NULL pair/hybrid lj/cut :pre [Description:] diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index 16e56cb9df..d586b7d953 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -67,7 +67,7 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : // process optional args - hybridpairflag = 0; + pairhybridflag = 0; if (narg == 4) { keflag = 1; pairflag = 1; @@ -81,7 +81,7 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : int iarg = 4; while (iarg < narg) { if (strcmp(arg[iarg],"ke") == 0) keflag = 1; - else if (strcmp(arg[iarg],"hybridpair") == 0) { + else if (strcmp(arg[iarg],"pair/hybrid") == 0) { int n = strlen(arg[++iarg]) + 1; if (lmp->suffix) n += strlen(lmp->suffix) + 1; pstyle = new char[n]; @@ -100,17 +100,17 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : // check if pair style with and without suffix exists - hybridpair = (Pair *) force->pair_match(pstyle,1,nsub); - if (!hybridpair && lmp->suffix) { + pairhybrid = (Pair *) force->pair_match(pstyle,1,nsub); + if (!pairhybrid && lmp->suffix) { strcat(pstyle,"/"); strcat(pstyle,lmp->suffix); - hybridpair = (Pair *) force->pair_match(pstyle,1,nsub); + pairhybrid = (Pair *) force->pair_match(pstyle,1,nsub); } - if (!hybridpair) + if (!pairhybrid) error->all(FLERR,"Unrecognized pair style in compute pressure command"); - hybridpairflag = 1; + pairhybridflag = 1; } else if (strcmp(arg[iarg],"pair") == 0) pairflag = 1; else if (strcmp(arg[iarg],"bond") == 0) bondflag = 1; @@ -173,7 +173,7 @@ void ComputePressure::init() nvirial = 0; vptr = NULL; - if (hybridpairflag && force->pair) nvirial++; + if (pairhybridflag && force->pair) nvirial++; if (pairflag && force->pair) nvirial++; if (bondflag && atom->molecular && force->bond) nvirial++; if (angleflag && atom->molecular && force->angle) nvirial++; @@ -186,10 +186,10 @@ void ComputePressure::init() if (nvirial) { vptr = new double*[nvirial]; nvirial = 0; - if (hybridpairflag && force->pair) { + if (pairhybridflag && force->pair) { PairHybrid *ph = (PairHybrid *) force->pair; ph->no_virial_fdotr_compute = 1; - vptr[nvirial++] = hybridpair->virial; + vptr[nvirial++] = pairhybrid->virial; } if (pairflag && force->pair) vptr[nvirial++] = force->pair->virial; if (bondflag && force->bond) vptr[nvirial++] = force->bond->virial; diff --git a/src/compute_pressure.h b/src/compute_pressure.h index 2982271390..76a4066179 100644 --- a/src/compute_pressure.h +++ b/src/compute_pressure.h @@ -41,8 +41,8 @@ class ComputePressure : public Compute { Compute *temperature; char *id_temp; double virial[6]; - int hybridpairflag; - class Pair *hybridpair; + int pairhybridflag; + class Pair *pairhybrid; int keflag,pairflag,bondflag,angleflag,dihedralflag,improperflag; int fixflag,kspaceflag; -- GitLab From fc1d8f2cbf03245a376dcb9fd4b1dcaf95e36fe5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 2 Jul 2019 01:12:16 -0400 Subject: [PATCH 159/469] more cleanup of include file handling. starting to work on files in packages --- src/OPT/pair_lj_long_coul_long_opt.cpp | 1 + src/PYTHON/fix_python_invoke.cpp | 2 +- src/PYTHON/fix_python_move.cpp | 2 +- src/PYTHON/pair_python.cpp | 2 +- src/PYTHON/python_impl.cpp | 2 +- src/RIGID/fix_ehex.cpp | 7 +-- src/RIGID/fix_ehex.h | 20 ++++----- src/RIGID/fix_rattle.cpp | 11 ----- src/RIGID/fix_rattle.h | 1 - src/RIGID/fix_rigid.cpp | 3 +- src/RIGID/fix_rigid_nh.cpp | 1 - src/RIGID/fix_rigid_nh_small.cpp | 3 +- src/RIGID/fix_rigid_nph.cpp | 1 - src/SHOCK/fix_append_atoms.cpp | 2 +- src/SHOCK/fix_msst.cpp | 5 +-- src/SHOCK/fix_nphug.cpp | 3 -- src/SHOCK/fix_wall_piston.cpp | 2 - src/SNAP/compute_snav_atom.cpp | 3 +- src/SNAP/pair_snap.cpp | 5 +-- src/SNAP/sna.cpp | 8 +--- src/SPIN/compute_spin.cpp | 8 +--- src/SPIN/fix_langevin_spin.cpp | 22 ++-------- src/SPIN/fix_neb_spin.cpp | 4 -- src/SPIN/fix_nve_spin.cpp | 16 +------ src/SPIN/fix_nve_spin.h | 2 - src/SPIN/fix_precession_spin.cpp | 9 +--- src/SPIN/fix_setforce_spin.cpp | 4 -- src/SPIN/min_spin.cpp | 3 -- src/SPIN/neb_spin.cpp | 8 ---- src/SPIN/pair_spin.cpp | 13 +----- src/SPIN/pair_spin.h | 2 +- src/SPIN/pair_spin_dipole_cut.cpp | 4 +- src/SPIN/pair_spin_dipole_long.cpp | 55 ++++++++++++------------ src/SPIN/pair_spin_dmi.cpp | 8 +--- src/SPIN/pair_spin_exchange.cpp | 8 +--- src/SPIN/pair_spin_magelec.cpp | 8 +--- src/SPIN/pair_spin_neel.cpp | 9 +--- src/SRD/fix_srd.cpp | 3 +- src/SRD/fix_wall_srd.cpp | 4 +- src/USER-EFF/atom_vec_electron.cpp | 2 - src/USER-EFF/compute_ke_atom_eff.cpp | 1 - src/USER-EFF/compute_ke_eff.cpp | 2 - src/USER-EFF/compute_temp_deform_eff.cpp | 1 - src/USER-EFF/compute_temp_eff.cpp | 2 - src/USER-EFF/compute_temp_region_eff.cpp | 2 - src/USER-EFF/fix_langevin_eff.cpp | 6 --- src/USER-EFF/fix_nh_eff.cpp | 2 - src/USER-EFF/fix_nve_eff.cpp | 2 - src/USER-EFF/fix_nvt_eff.cpp | 1 - src/USER-EFF/fix_temp_rescale_eff.cpp | 2 - src/USER-EFF/pair_eff_cut.cpp | 3 +- src/USER-PHONON/fix_phonon.cpp | 5 +-- 52 files changed, 75 insertions(+), 230 deletions(-) diff --git a/src/OPT/pair_lj_long_coul_long_opt.cpp b/src/OPT/pair_lj_long_coul_long_opt.cpp index 243b64391f..03853057f4 100644 --- a/src/OPT/pair_lj_long_coul_long_opt.cpp +++ b/src/OPT/pair_lj_long_coul_long_opt.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include +#include #include "pair_lj_long_coul_long_opt.h" #include "atom.h" #include "force.h" diff --git a/src/PYTHON/fix_python_invoke.cpp b/src/PYTHON/fix_python_invoke.cpp index f704bd9741..7fa9861c3f 100644 --- a/src/PYTHON/fix_python_invoke.cpp +++ b/src/PYTHON/fix_python_invoke.cpp @@ -15,7 +15,7 @@ Contributing author: Richard Berger (Temple U) ------------------------------------------------------------------------- */ -#include +#include // IWYU pragma: keep #include #include "fix_python_invoke.h" #include "force.h" diff --git a/src/PYTHON/fix_python_move.cpp b/src/PYTHON/fix_python_move.cpp index 56b7768669..b253df6828 100644 --- a/src/PYTHON/fix_python_move.cpp +++ b/src/PYTHON/fix_python_move.cpp @@ -15,7 +15,7 @@ Contributing author: Richard Berger (Temple U) ------------------------------------------------------------------------- */ -#include +#include // IWYU pragma: keep #include #include "fix_python_move.h" #include "lmppython.h" diff --git a/src/PYTHON/pair_python.cpp b/src/PYTHON/pair_python.cpp index 638077da48..5b8f23400b 100644 --- a/src/PYTHON/pair_python.cpp +++ b/src/PYTHON/pair_python.cpp @@ -15,7 +15,7 @@ Contributing authors: Axel Kohlmeyer and Richard Berger (Temple U) ------------------------------------------------------------------------- */ -#include +#include // IWYU pragma: keep #include #include #include "pair_python.h" diff --git a/src/PYTHON/python_impl.cpp b/src/PYTHON/python_impl.cpp index 249d4f7bb1..7456021675 100644 --- a/src/PYTHON/python_impl.cpp +++ b/src/PYTHON/python_impl.cpp @@ -17,7 +17,7 @@ #include #include -#include +#include // IWYU pragma: keep #include "python_impl.h" #include "force.h" #include "input.h" diff --git a/src/RIGID/fix_ehex.cpp b/src/RIGID/fix_ehex.cpp index 1476c71d3f..0bbdea51c6 100644 --- a/src/RIGID/fix_ehex.cpp +++ b/src/RIGID/fix_ehex.cpp @@ -22,8 +22,8 @@ which implements the heat exchange (HEX) algorithm. ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_ehex.h" #include "atom.h" @@ -33,14 +33,9 @@ #include "force.h" #include "update.h" #include "modify.h" -#include "input.h" -#include "variable.h" #include "memory.h" #include "error.h" #include "fix_shake.h" -#include "neighbor.h" -#include "comm.h" -#include "timer.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/RIGID/fix_ehex.h b/src/RIGID/fix_ehex.h index e29ddac135..860ed3d1f3 100644 --- a/src/RIGID/fix_ehex.h +++ b/src/RIGID/fix_ehex.h @@ -22,8 +22,6 @@ FixStyle(ehex,FixEHEX) #define LMP_FIX_EHEX_H #include "fix.h" -#include "fix_shake.h" -#include "region.h" #define EHEX_DEBUG 0 namespace LAMMPS_NS { @@ -41,9 +39,9 @@ class FixEHEX : public Fix { double memory_usage(); void update_scalingmask(); void com_properties(double *, double *, double *, double*, double *, double*); - bool rescale_atom(int i, Region*region); + bool rescale_atom(int i, class Region *region); virtual void grow_arrays(int nmax); - bool check_cluster(tagint *shake_atom, int n, Region * region); + bool check_cluster(tagint *shake_atom, int n, class Region *region); private: int iregion; @@ -53,14 +51,14 @@ class FixEHEX : public Fix { char *idregion; int me; - double **x; // coordinates - double **f; // forces - double **v; // velocities - double *mass; // masses - double *rmass; // reduced masses - int *type; // atom types + double **x; // coordinates + double **f; // forces + double **v; // velocities + double *mass; // masses + double *rmass; // reduced masses + int *type; // atom types int nlocal; // number of local atoms - FixShake * fshake; // pointer to fix_shake/fix_rattle + class FixShake * fshake; // pointer to fix_shake/fix_rattle int constraints; // constraints (0/1) int cluster; // rescaling entire clusters (0/1) int hex; // HEX mode (0/1) diff --git a/src/RIGID/fix_rattle.cpp b/src/RIGID/fix_rattle.cpp index 403f3091c6..db43b9e82d 100644 --- a/src/RIGID/fix_rattle.cpp +++ b/src/RIGID/fix_rattle.cpp @@ -17,31 +17,20 @@ #include #include -#include #include -#include #include "fix_rattle.h" #include "atom.h" -#include "atom_vec.h" -#include "molecule.h" #include "update.h" -#include "respa.h" #include "modify.h" #include "domain.h" #include "force.h" -#include "bond.h" -#include "angle.h" #include "comm.h" -#include "group.h" -#include "fix_respa.h" -#include "math_const.h" #include "math_extra.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; using namespace FixConst; -using namespace MathConst; using namespace MathExtra; // set RATTLE_DEBUG 1 to check constraints at end of timestep diff --git a/src/RIGID/fix_rattle.h b/src/RIGID/fix_rattle.h index 48edaef379..cab148f10c 100644 --- a/src/RIGID/fix_rattle.h +++ b/src/RIGID/fix_rattle.h @@ -20,7 +20,6 @@ FixStyle(rattle,FixRattle) #ifndef LMP_FIX_RATTLE_H #define LMP_FIX_RATTLE_H -#include "fix.h" #include "fix_shake.h" namespace LAMMPS_NS { diff --git a/src/RIGID/fix_rigid.cpp b/src/RIGID/fix_rigid.cpp index abb669bc02..19eb22a7fa 100644 --- a/src/RIGID/fix_rigid.cpp +++ b/src/RIGID/fix_rigid.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include #include #include "fix_rigid.h" @@ -31,7 +31,6 @@ #include "force.h" #include "input.h" #include "variable.h" -#include "output.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_nh.cpp b/src/RIGID/fix_rigid_nh.cpp index 4acc8d3411..2e1090ec88 100644 --- a/src/RIGID/fix_rigid_nh.cpp +++ b/src/RIGID/fix_rigid_nh.cpp @@ -17,7 +17,6 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ -#include #include #include #include "fix_rigid_nh.h" diff --git a/src/RIGID/fix_rigid_nh_small.cpp b/src/RIGID/fix_rigid_nh_small.cpp index 5016d3f168..8de588bd9b 100644 --- a/src/RIGID/fix_rigid_nh_small.cpp +++ b/src/RIGID/fix_rigid_nh_small.cpp @@ -17,8 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_rigid_nh_small.h" #include "math_extra.h" @@ -32,7 +32,6 @@ #include "comm.h" #include "force.h" #include "kspace.h" -#include "output.h" #include "memory.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_nph.cpp b/src/RIGID/fix_rigid_nph.cpp index 45a4a8d09c..6080fb05af 100644 --- a/src/RIGID/fix_rigid_nph.cpp +++ b/src/RIGID/fix_rigid_nph.cpp @@ -19,7 +19,6 @@ #include #include "fix_rigid_nph.h" -#include "domain.h" #include "modify.h" #include "error.h" diff --git a/src/SHOCK/fix_append_atoms.cpp b/src/SHOCK/fix_append_atoms.cpp index 2e515839c5..5e81b75c0d 100644 --- a/src/SHOCK/fix_append_atoms.cpp +++ b/src/SHOCK/fix_append_atoms.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include -#include #include "fix_append_atoms.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/SHOCK/fix_msst.cpp b/src/SHOCK/fix_msst.cpp index c800e8a85d..15ee4d370f 100644 --- a/src/SHOCK/fix_msst.cpp +++ b/src/SHOCK/fix_msst.cpp @@ -17,22 +17,19 @@ see Reed, Fried, Joannopoulos, Phys Rev Lett, 90, 235503 (2003) ------------------------------------------------------------------------- */ +#include #include -#include #include #include "fix_msst.h" #include "atom.h" #include "force.h" #include "comm.h" -#include "output.h" #include "modify.h" #include "fix_external.h" #include "compute.h" #include "kspace.h" #include "update.h" -#include "respa.h" #include "domain.h" -#include "thermo.h" #include "memory.h" #include "error.h" diff --git a/src/SHOCK/fix_nphug.cpp b/src/SHOCK/fix_nphug.cpp index c6df6646cf..5d5a1642c0 100644 --- a/src/SHOCK/fix_nphug.cpp +++ b/src/SHOCK/fix_nphug.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "fix_nphug.h" #include "modify.h" @@ -22,8 +21,6 @@ #include "force.h" #include "domain.h" #include "group.h" -#include "memory.h" -#include "comm.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/SHOCK/fix_wall_piston.cpp b/src/SHOCK/fix_wall_piston.cpp index eb89e19517..31f70b4174 100644 --- a/src/SHOCK/fix_wall_piston.cpp +++ b/src/SHOCK/fix_wall_piston.cpp @@ -13,10 +13,8 @@ #include #include -#include #include "fix_wall_piston.h" #include "atom.h" -#include "modify.h" #include "domain.h" #include "lattice.h" #include "update.h" diff --git a/src/SNAP/compute_snav_atom.cpp b/src/SNAP/compute_snav_atom.cpp index 1f702496ed..5faf7a1872 100644 --- a/src/SNAP/compute_snav_atom.cpp +++ b/src/SNAP/compute_snav_atom.cpp @@ -10,10 +10,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "sna.h" #include #include #include "compute_snav_atom.h" +#include "sna.h" #include "atom.h" #include "update.h" #include "modify.h" @@ -21,7 +21,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "force.h" -#include "pair.h" #include "comm.h" #include "memory.h" #include "error.h" diff --git a/src/SNAP/pair_snap.cpp b/src/SNAP/pair_snap.cpp index f9ba8922a0..f0f3ef72c6 100644 --- a/src/SNAP/pair_snap.cpp +++ b/src/SNAP/pair_snap.cpp @@ -11,24 +11,21 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include #include #include "pair_snap.h" #include "atom.h" -#include "atom_vec.h" #include "force.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "sna.h" -#include "domain.h" #include "memory.h" #include "error.h" -#include - using namespace LAMMPS_NS; #define MAXLINE 1024 diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp index ec545c51b2..d7d9b5163d 100644 --- a/src/SNAP/sna.cpp +++ b/src/SNAP/sna.cpp @@ -15,17 +15,11 @@ Contributing authors: Aidan Thompson, Christian Trott, SNL ------------------------------------------------------------------------- */ -#include "sna.h" #include +#include "sna.h" #include "math_const.h" -#include "math_extra.h" -#include -#include - #include "memory.h" #include "error.h" -#include "comm.h" -#include "atom.h" using namespace std; using namespace LAMMPS_NS; diff --git a/src/SPIN/compute_spin.cpp b/src/SPIN/compute_spin.cpp index 0a881e1de6..ec11bc68f2 100644 --- a/src/SPIN/compute_spin.cpp +++ b/src/SPIN/compute_spin.cpp @@ -22,20 +22,16 @@ ------------------------------------------------------------------------- */ #include -#include -#include "atom.h" +#include #include "compute_spin.h" -#include "domain.h" +#include "atom.h" #include "error.h" #include "force.h" -#include "math_special.h" #include "math_const.h" #include "memory.h" -#include "modify.h" #include "update.h" using namespace LAMMPS_NS; -using namespace MathSpecial; using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/SPIN/fix_langevin_spin.cpp b/src/SPIN/fix_langevin_spin.cpp index ec6f719a77..6936c701c6 100644 --- a/src/SPIN/fix_langevin_spin.cpp +++ b/src/SPIN/fix_langevin_spin.cpp @@ -21,31 +21,19 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ -#include #include #include -#include - -#include "atom.h" -#include "atom_vec_ellipsoid.h" +#include "fix_langevin_spin.h" #include "comm.h" -#include "compute.h" -#include "domain.h" #include "error.h" -#include "fix_langevin_spin.h" #include "force.h" -#include "group.h" -#include "input.h" #include "math_const.h" -#include "math_extra.h" #include "memory.h" #include "modify.h" -#include "random_mars.h" #include "random_park.h" -#include "region.h" #include "respa.h" #include "update.h" -#include "variable.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace FixConst; @@ -142,13 +130,11 @@ void FixLangevinSpin::init() void FixLangevinSpin::setup(int vflag) { - if (strstr(update->integrate_style,"verlet")) - post_force(vflag); - else { + if (utils::strmatch(update->integrate_style,"^respa")) { ((Respa *) update->integrate)->copy_flevel_f(nlevels_respa-1); post_force_respa(vflag,nlevels_respa-1,0); ((Respa *) update->integrate)->copy_f_flevel(nlevels_respa-1); - } + } else post_force(vflag); } /* ---------------------------------------------------------------------- */ diff --git a/src/SPIN/fix_neb_spin.cpp b/src/SPIN/fix_neb_spin.cpp index a8cb0cd2ca..7ed8967a24 100644 --- a/src/SPIN/fix_neb_spin.cpp +++ b/src/SPIN/fix_neb_spin.cpp @@ -23,13 +23,11 @@ #include #include -#include #include #include "fix_neb_spin.h" #include "universe.h" #include "update.h" #include "atom.h" -#include "domain.h" #include "comm.h" #include "modify.h" #include "compute.h" @@ -37,11 +35,9 @@ #include "memory.h" #include "error.h" #include "force.h" -#include "math_const.h" using namespace LAMMPS_NS; using namespace FixConst; -using namespace MathConst; enum{SINGLE_PROC_DIRECT,SINGLE_PROC_MAP,MULTI_PROC}; diff --git a/src/SPIN/fix_nve_spin.cpp b/src/SPIN/fix_nve_spin.cpp index 595ddb0cc2..d35585c7a6 100644 --- a/src/SPIN/fix_nve_spin.cpp +++ b/src/SPIN/fix_nve_spin.cpp @@ -21,38 +21,24 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ -#include -#include #include - +#include "fix_nve_spin.h" #include "atom.h" -#include "atom_vec.h" #include "citeme.h" #include "comm.h" #include "domain.h" #include "error.h" -#include "fix_nve_spin.h" #include "fix_precession_spin.h" #include "fix_langevin_spin.h" #include "fix_setforce_spin.h" #include "force.h" -#include "math_vector.h" -#include "math_extra.h" -#include "math_const.h" #include "memory.h" #include "modify.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "pair.h" -#include "pair_hybrid.h" #include "pair_spin.h" -#include "respa.h" #include "update.h" using namespace LAMMPS_NS; using namespace FixConst; -using namespace MathConst; -using namespace MathExtra; static const char cite_fix_nve_spin[] = "fix nve/spin command:\n\n" diff --git a/src/SPIN/fix_nve_spin.h b/src/SPIN/fix_nve_spin.h index 4800575c06..1e3b87c1fb 100644 --- a/src/SPIN/fix_nve_spin.h +++ b/src/SPIN/fix_nve_spin.h @@ -21,8 +21,6 @@ FixStyle(nve/spin,FixNVESpin) #define LMP_FIX_NVE_SPIN_H #include "fix.h" -#include "pair.h" -#include "pair_spin.h" namespace LAMMPS_NS { diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 1ea134d367..7764bb0438 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -21,21 +21,16 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include +#include "fix_precession_spin.h" #include "atom.h" #include "error.h" -#include "domain.h" -#include "error.h" -#include "fix_precession_spin.h" #include "force.h" #include "input.h" #include "math_const.h" -#include "memory.h" #include "modify.h" -#include "neigh_list.h" #include "respa.h" #include "update.h" #include "variable.h" diff --git a/src/SPIN/fix_setforce_spin.cpp b/src/SPIN/fix_setforce_spin.cpp index c2807418ec..1ab35c9663 100644 --- a/src/SPIN/fix_setforce_spin.cpp +++ b/src/SPIN/fix_setforce_spin.cpp @@ -21,7 +21,6 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ -#include #include #include "fix_setforce_spin.h" #include "atom.h" @@ -29,12 +28,9 @@ #include "modify.h" #include "domain.h" #include "region.h" -#include "respa.h" #include "input.h" #include "variable.h" #include "memory.h" -#include "error.h" -#include "force.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 2bddc110e7..3a330f448a 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -19,7 +19,6 @@ #include #include -#include #include #include "min_spin.h" #include "universe.h" @@ -29,8 +28,6 @@ #include "output.h" #include "timer.h" #include "error.h" -#include "modify.h" -#include "math_special.h" #include "math_const.h" using namespace LAMMPS_NS; diff --git a/src/SPIN/neb_spin.cpp b/src/SPIN/neb_spin.cpp index 46a0541488..400ce3d363 100644 --- a/src/SPIN/neb_spin.cpp +++ b/src/SPIN/neb_spin.cpp @@ -21,18 +21,12 @@ Computer Physics Communications, 196, 335-347. ------------------------------------------------------------------------- */ -// lmptype.h must be first b/c this file uses MAXBIGINT and includes mpi.h -// due to OpenMPI bug which sets INT64_MAX via its mpi.h -// before lmptype.h can set flags to insure it is done correctly - -#include "lmptype.h" #include #include #include #include #include "neb_spin.h" #include "citeme.h" -#include "compute.h" #include "force.h" #include "universe.h" #include "atom.h" @@ -49,10 +43,8 @@ #include "timer.h" #include "memory.h" #include "error.h" -#include "math_const.h" using namespace LAMMPS_NS; -using namespace MathConst; static const char cite_neb_spin[] = "neb/spin command:\n\n" diff --git a/src/SPIN/pair_spin.cpp b/src/SPIN/pair_spin.cpp index 929b79bef3..93d9a1e127 100644 --- a/src/SPIN/pair_spin.cpp +++ b/src/SPIN/pair_spin.cpp @@ -21,26 +21,15 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ -#include -#include #include - +#include "pair_spin.h" #include "atom.h" -#include "comm.h" #include "error.h" #include "fix.h" -#include "fix_nve_spin.h" #include "force.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "math_const.h" -#include "memory.h" #include "modify.h" #include "pair.h" -#include "pair_hybrid.h" -#include "pair_hybrid_overlay.h" -#include "pair_spin.h" #include "update.h" using namespace LAMMPS_NS; diff --git a/src/SPIN/pair_spin.h b/src/SPIN/pair_spin.h index 1be8550c65..3a909e1d13 100644 --- a/src/SPIN/pair_spin.h +++ b/src/SPIN/pair_spin.h @@ -14,7 +14,7 @@ #ifndef LMP_PAIR_SPIN_H #define LMP_PAIR_SPIN_H -#include "pair.h" +#include "pair.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/SPIN/pair_spin_dipole_cut.cpp b/src/SPIN/pair_spin_dipole_cut.cpp index 4ff198488a..8d9b5b8f2b 100644 --- a/src/SPIN/pair_spin_dipole_cut.cpp +++ b/src/SPIN/pair_spin_dipole_cut.cpp @@ -21,9 +21,8 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_spin_dipole_cut.h" #include "atom.h" @@ -31,6 +30,7 @@ #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" +#include "fix.h" #include "fix_nve_spin.h" #include "force.h" #include "math_const.h" diff --git a/src/SPIN/pair_spin_dipole_long.cpp b/src/SPIN/pair_spin_dipole_long.cpp index e3575a6a07..84c55a8c3c 100644 --- a/src/SPIN/pair_spin_dipole_long.cpp +++ b/src/SPIN/pair_spin_dipole_long.cpp @@ -13,20 +13,19 @@ /* ------------------------------------------------------------------------ Contributing authors: Julien Tranchida (SNL) - Stan Moore (SNL) + Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include - #include "pair_spin_dipole_long.h" #include "atom.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" +#include "fix.h" #include "fix_nve_spin.h" #include "force.h" #include "kspace.h" @@ -59,12 +58,12 @@ lockfixnvespin(NULL) no_virial_fdotr_compute = 1; lattice_flag = 0; - hbar = force->hplanck/MY_2PI; // eV/(rad.THz) + hbar = force->hplanck/MY_2PI; // eV/(rad.THz) mub = 9.274e-4; // in A.Ang^2 mu_0 = 785.15; // in eV/Ang/A^2 mub2mu0 = mub * mub * mu_0 / (4.0*MY_PI); // in eV.Ang^3 - //mub2mu0 = mub * mub * mu_0 / (4.0*MY_PI); // in eV - mub2mu0hbinv = mub2mu0 / hbar; // in rad.THz + //mub2mu0 = mub * mub * mu_0 / (4.0*MY_PI); // in eV + mub2mu0hbinv = mub2mu0 / hbar; // in rad.THz } @@ -243,7 +242,7 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) double **x = atom->x; double **f = atom->f; double **fm = atom->fm; - double **sp = atom->sp; + double **sp = atom->sp; int *type = atom->type; int nlocal = atom->nlocal; int newton_pair = force->newton_pair; @@ -314,36 +313,36 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) bij[2] = (3.0*bij[1] + pre2*expm2) * r2inv; bij[3] = (5.0*bij[2] + pre3*expm2) * r2inv; - compute_long(i,j,eij,bij,fmi,spi,spj); - compute_long_mech(i,j,eij,bij,fmi,spi,spj); + compute_long(i,j,eij,bij,fmi,spi,spj); + compute_long_mech(i,j,eij,bij,fmi,spi,spj); } // force accumulation - f[i][0] += fi[0]; - f[i][1] += fi[1]; + f[i][0] += fi[0]; + f[i][1] += fi[1]; f[i][2] += fi[2]; - fm[i][0] += fmi[0]; - fm[i][1] += fmi[1]; + fm[i][0] += fmi[0]; + fm[i][1] += fmi[1]; fm[i][2] += fmi[2]; if (newton_pair || j < nlocal) { - f[j][0] -= fi[0]; - f[j][1] -= fi[1]; + f[j][0] -= fi[0]; + f[j][1] -= fi[1]; f[j][2] -= fi[2]; } if (eflag) { - if (rsq <= local_cut2) { - evdwl -= spi[0]*fmi[0] + spi[1]*fmi[1] + - spi[2]*fmi[2]; - evdwl *= hbar; - } + if (rsq <= local_cut2) { + evdwl -= spi[0]*fmi[0] + spi[1]*fmi[1] + + spi[2]*fmi[2]; + evdwl *= hbar; + } } else evdwl = 0.0; if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair, - evdwl,ecoul,fi[0],fi[1],fi[2],rij[0],rij[1],rij[2]); + evdwl,ecoul,fi[0],fi[1],fi[2],rij[0],rij[1],rij[2]); } } @@ -365,7 +364,7 @@ void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) int *type = atom->type; double **x = atom->x; - double **sp = atom->sp; + double **sp = atom->sp; double **fm_long = atom->fm_long; ilist = list->ilist; @@ -550,7 +549,7 @@ void PairSpinDipoleLong::write_restart(FILE *fp) for (j = i; j <= atom->ntypes; j++) { fwrite(&setflag[i][j],sizeof(int),1,fp); if (setflag[i][j]) { - fwrite(&cut_spin_long[i][j],sizeof(int),1,fp); + fwrite(&cut_spin_long[i][j],sizeof(int),1,fp); } } } @@ -573,10 +572,10 @@ void PairSpinDipoleLong::read_restart(FILE *fp) if (me == 0) fread(&setflag[i][j],sizeof(int),1,fp); MPI_Bcast(&setflag[i][j],1,MPI_INT,0,world); if (setflag[i][j]) { - if (me == 0) { - fread(&cut_spin_long[i][j],sizeof(int),1,fp); - } - MPI_Bcast(&cut_spin_long[i][j],1,MPI_INT,0,world); + if (me == 0) { + fread(&cut_spin_long[i][j],sizeof(int),1,fp); + } + MPI_Bcast(&cut_spin_long[i][j],1,MPI_INT,0,world); } } } diff --git a/src/SPIN/pair_spin_dmi.cpp b/src/SPIN/pair_spin_dmi.cpp index 41430d230f..651f4397bd 100644 --- a/src/SPIN/pair_spin_dmi.cpp +++ b/src/SPIN/pair_spin_dmi.cpp @@ -21,28 +21,24 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include #include -#include #include - +#include "pair_spin_dmi.h" #include "atom.h" #include "comm.h" #include "error.h" #include "force.h" #include "fix.h" #include "fix_nve_spin.h" -#include "pair_hybrid.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "math_const.h" #include "memory.h" #include "modify.h" -#include "pair_spin_dmi.h" #include "update.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/SPIN/pair_spin_exchange.cpp b/src/SPIN/pair_spin_exchange.cpp index 93b6d9501e..059a8f5f34 100644 --- a/src/SPIN/pair_spin_exchange.cpp +++ b/src/SPIN/pair_spin_exchange.cpp @@ -21,28 +21,24 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include #include -#include #include - +#include "pair_spin_exchange.h" #include "atom.h" #include "comm.h" #include "error.h" #include "fix.h" #include "fix_nve_spin.h" #include "force.h" -#include "pair_hybrid.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "math_const.h" #include "memory.h" #include "modify.h" -#include "pair_spin_exchange.h" #include "update.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/SPIN/pair_spin_magelec.cpp b/src/SPIN/pair_spin_magelec.cpp index 1f1488b93c..55b96582c8 100644 --- a/src/SPIN/pair_spin_magelec.cpp +++ b/src/SPIN/pair_spin_magelec.cpp @@ -21,28 +21,24 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include #include -#include #include - +#include "pair_spin_magelec.h" #include "atom.h" #include "comm.h" #include "error.h" #include "fix.h" #include "fix_nve_spin.h" #include "force.h" -#include "pair_hybrid.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "math_const.h" #include "memory.h" #include "modify.h" -#include "pair_spin_magelec.h" #include "update.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/SPIN/pair_spin_neel.cpp b/src/SPIN/pair_spin_neel.cpp index 03041da17f..4d68dbdc22 100644 --- a/src/SPIN/pair_spin_neel.cpp +++ b/src/SPIN/pair_spin_neel.cpp @@ -21,29 +21,24 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include #include -#include #include - +#include "pair_spin_neel.h" #include "atom.h" #include "comm.h" #include "error.h" -#include "force.h" #include "fix.h" #include "fix_nve_spin.h" #include "force.h" -#include "pair_hybrid.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "math_const.h" #include "memory.h" #include "modify.h" -#include "pair_spin_neel.h" #include "update.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/SRD/fix_srd.cpp b/src/SRD/fix_srd.cpp index d87d2b5e56..a20ec212fd 100644 --- a/src/SRD/fix_srd.cpp +++ b/src/SRD/fix_srd.cpp @@ -15,9 +15,9 @@ Contributing authors: Jeremy Lechman (SNL), Pieter in 't Veld (BASF) ------------------------------------------------------------------------- */ +#include #include #include -#include #include "fix_srd.h" #include "math_extra.h" #include "atom.h" @@ -27,7 +27,6 @@ #include "group.h" #include "update.h" #include "force.h" -#include "pair.h" #include "domain.h" #include "neighbor.h" #include "comm.h" diff --git a/src/SRD/fix_wall_srd.cpp b/src/SRD/fix_wall_srd.cpp index 24b0c3cec5..cb0f023640 100644 --- a/src/SRD/fix_wall_srd.cpp +++ b/src/SRD/fix_wall_srd.cpp @@ -11,11 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include #include "fix_wall_srd.h" -#include "atom.h" -#include "modify.h" #include "fix.h" #include "domain.h" #include "lattice.h" diff --git a/src/USER-EFF/atom_vec_electron.cpp b/src/USER-EFF/atom_vec_electron.cpp index 1bc5387c9e..5de78f7510 100644 --- a/src/USER-EFF/atom_vec_electron.cpp +++ b/src/USER-EFF/atom_vec_electron.cpp @@ -15,7 +15,6 @@ Contributing author: Andres Jaramillo-Botero (Caltech) ------------------------------------------------------------------------- */ -#include #include #include #include "atom_vec_electron.h" @@ -23,7 +22,6 @@ #include "comm.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "citeme.h" #include "memory.h" diff --git a/src/USER-EFF/compute_ke_atom_eff.cpp b/src/USER-EFF/compute_ke_atom_eff.cpp index b1b87cd3df..c943366f1b 100644 --- a/src/USER-EFF/compute_ke_atom_eff.cpp +++ b/src/USER-EFF/compute_ke_atom_eff.cpp @@ -15,7 +15,6 @@ Contributing author: Andres Jaramillo-Botero ------------------------------------------------------------------------- */ -#include #include #include #include "compute_ke_atom_eff.h" diff --git a/src/USER-EFF/compute_ke_eff.cpp b/src/USER-EFF/compute_ke_eff.cpp index b4f571cb63..3e277fc66c 100644 --- a/src/USER-EFF/compute_ke_eff.cpp +++ b/src/USER-EFF/compute_ke_eff.cpp @@ -16,14 +16,12 @@ ------------------------------------------------------------------------- */ #include -#include #include #include "compute_ke_eff.h" #include "atom.h" #include "update.h" #include "force.h" #include "domain.h" -#include "group.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-EFF/compute_temp_deform_eff.cpp b/src/USER-EFF/compute_temp_deform_eff.cpp index 23abb4f99d..7a12a69982 100644 --- a/src/USER-EFF/compute_temp_deform_eff.cpp +++ b/src/USER-EFF/compute_temp_deform_eff.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include -#include #include #include #include "compute_temp_deform_eff.h" diff --git a/src/USER-EFF/compute_temp_eff.cpp b/src/USER-EFF/compute_temp_eff.cpp index 956461adf1..d745269ff5 100644 --- a/src/USER-EFF/compute_temp_eff.cpp +++ b/src/USER-EFF/compute_temp_eff.cpp @@ -17,8 +17,6 @@ #include #include -#include -#include #include "compute_temp_eff.h" #include "atom.h" #include "update.h" diff --git a/src/USER-EFF/compute_temp_region_eff.cpp b/src/USER-EFF/compute_temp_region_eff.cpp index 659bdfca5e..cec87b29ab 100644 --- a/src/USER-EFF/compute_temp_region_eff.cpp +++ b/src/USER-EFF/compute_temp_region_eff.cpp @@ -16,14 +16,12 @@ ------------------------------------------------------------------------- */ #include -#include #include #include #include "compute_temp_region_eff.h" #include "atom.h" #include "update.h" #include "force.h" -#include "modify.h" #include "domain.h" #include "region.h" #include "group.h" diff --git a/src/USER-EFF/fix_langevin_eff.cpp b/src/USER-EFF/fix_langevin_eff.cpp index d362113997..5158d7c681 100644 --- a/src/USER-EFF/fix_langevin_eff.cpp +++ b/src/USER-EFF/fix_langevin_eff.cpp @@ -17,19 +17,13 @@ #include #include -#include #include #include "fix_langevin_eff.h" -#include "math_extra.h" #include "atom.h" -#include "force.h" #include "update.h" #include "modify.h" #include "compute.h" #include "domain.h" -#include "region.h" -#include "respa.h" -#include "comm.h" #include "input.h" #include "variable.h" #include "random_mars.h" diff --git a/src/USER-EFF/fix_nh_eff.cpp b/src/USER-EFF/fix_nh_eff.cpp index 3e0a59612c..034233732e 100644 --- a/src/USER-EFF/fix_nh_eff.cpp +++ b/src/USER-EFF/fix_nh_eff.cpp @@ -15,12 +15,10 @@ Contributing author: Andres Jaramillo-Botero (Caltech) ------------------------------------------------------------------------- */ -#include #include #include "fix_nh_eff.h" #include "atom.h" #include "atom_vec.h" -#include "group.h" #include "error.h" #include "domain.h" diff --git a/src/USER-EFF/fix_nve_eff.cpp b/src/USER-EFF/fix_nve_eff.cpp index 699dd9f949..ea719c91c0 100644 --- a/src/USER-EFF/fix_nve_eff.cpp +++ b/src/USER-EFF/fix_nve_eff.cpp @@ -15,8 +15,6 @@ Contributing author: Andres Jaramillo-Botero (Caltech) ------------------------------------------------------------------------- */ -#include -#include #include #include #include "fix_nve_eff.h" diff --git a/src/USER-EFF/fix_nvt_eff.cpp b/src/USER-EFF/fix_nvt_eff.cpp index 9e23ee023b..8516accd31 100644 --- a/src/USER-EFF/fix_nvt_eff.cpp +++ b/src/USER-EFF/fix_nvt_eff.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include -#include #include "fix_nvt_eff.h" #include "group.h" #include "modify.h" diff --git a/src/USER-EFF/fix_temp_rescale_eff.cpp b/src/USER-EFF/fix_temp_rescale_eff.cpp index 37f45b3c28..4a8f4b0372 100644 --- a/src/USER-EFF/fix_temp_rescale_eff.cpp +++ b/src/USER-EFF/fix_temp_rescale_eff.cpp @@ -23,8 +23,6 @@ #include "force.h" #include "group.h" #include "update.h" -#include "domain.h" -#include "region.h" #include "comm.h" #include "modify.h" #include "compute.h" diff --git a/src/USER-EFF/pair_eff_cut.cpp b/src/USER-EFF/pair_eff_cut.cpp index f566922ef7..a4c0557620 100644 --- a/src/USER-EFF/pair_eff_cut.cpp +++ b/src/USER-EFF/pair_eff_cut.cpp @@ -15,8 +15,8 @@ Contributing author: Andres Jaramillo-Botero ------------------------------------------------------------------------- */ +#include #include -#include #include #include #include "pair_eff_cut.h" @@ -31,7 +31,6 @@ #include "neigh_list.h" #include "memory.h" #include "error.h" -#include "atom_vec_electron.h" using namespace LAMMPS_NS; diff --git a/src/USER-PHONON/fix_phonon.cpp b/src/USER-PHONON/fix_phonon.cpp index cdbe4068bc..9b663ce383 100644 --- a/src/USER-PHONON/fix_phonon.cpp +++ b/src/USER-PHONON/fix_phonon.cpp @@ -23,8 +23,8 @@ konglt@sjtu.edu.cn; konglt@gmail.com ------------------------------------------------------------------------- */ -#include -#include +#include +#include #include #include "fix_phonon.h" #include "fft3d_wrap.h" @@ -33,7 +33,6 @@ #include "domain.h" #include "force.h" #include "group.h" -#include "lattice.h" #include "modify.h" #include "update.h" #include "citeme.h" -- GitLab From 350d8f581275b43aceb8c2c14d59701ec2c4b3dd Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Tue, 2 Jul 2019 15:51:52 +0200 Subject: [PATCH 160/469] Missing some hybridpair replacement --- doc/src/compute_pressure.txt | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/compute_pressure.txt b/doc/src/compute_pressure.txt index b8d52b83de..9b27413cfc 100644 --- a/doc/src/compute_pressure.txt +++ b/doc/src/compute_pressure.txt @@ -16,7 +16,7 @@ ID, group-ID are documented in "compute"_compute.html command pressure = style name of this compute command temp-ID = ID of compute that calculates temperature, can be NULL if not needed zero or more keywords may be appended -keyword = {ke} or {pair} or {bond} or {angle} or {dihedral} or {improper} or {kspace} or {fix} or {virial} or {hybridpair} :ul +keyword = {ke} or {pair} or {bond} or {angle} or {dihedral} or {improper} or {kspace} or {fix} or {virial} or {pair/hybrid} :ul [Examples:] @@ -68,7 +68,7 @@ extra keywords are listed, then only those components are summed to compute temperature or ke and/or the virial. The {virial} keyword means include all terms except the kinetic energy {ke}. -The {hybridpair} keyword means to only include contribution +The {pair/hybrid} keyword means to only include contribution from a sub-style in a {hybrid} or {hybrid/overlay} pair style. Details of how LAMMPS computes the virial efficiently for the entire -- GitLab From 9984cbc99a371665d933e974bb0c84e66c720846 Mon Sep 17 00:00:00 2001 From: Julien Devemy Date: Tue, 2 Jul 2019 16:13:20 +0200 Subject: [PATCH 161/469] Recheck existence of pair style in init --- src/compute_pressure.cpp | 16 +++++++++++++++- src/compute_pressure.h | 1 + 2 files changed, 16 insertions(+), 1 deletion(-) diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index d586b7d953..2f412c23a0 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -87,7 +87,7 @@ ComputePressure::ComputePressure(LAMMPS *lmp, int narg, char **arg) : pstyle = new char[n]; strcpy(pstyle,arg[iarg++]); - int nsub = 0; + nsub = 0; if (narg > iarg) { if (isdigit(arg[iarg][0])) { @@ -166,6 +166,20 @@ void ComputePressure::init() temperature = modify->compute[icompute]; } + // recheck if pair style with and without suffix exists + + if (pairhybridflag) { + pairhybrid = (Pair *) force->pair_match(pstyle,1,nsub); + if (!pairhybrid && lmp->suffix) { + strcat(pstyle,"/"); + strcat(pstyle,lmp->suffix); + pairhybrid = (Pair *) force->pair_match(pstyle,1,nsub); + } + + if (!pairhybrid) + error->all(FLERR,"Unrecognized pair style in compute pressure command"); + } + // detect contributions to virial // vptr points to all virial[6] contributions diff --git a/src/compute_pressure.h b/src/compute_pressure.h index 76a4066179..8d0ec4aa04 100644 --- a/src/compute_pressure.h +++ b/src/compute_pressure.h @@ -50,6 +50,7 @@ class ComputePressure : public Compute { private: char *pstyle; + int nsub; }; } -- GitLab From 11708c8f96aa0f020d8c562a577940578ec4882a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 2 Jul 2019 12:07:26 -0400 Subject: [PATCH 162/469] continue cleaning up include files based on IWYU --- src/npair_skip_respa.cpp | 3 --- src/npair_skip_size.cpp | 2 -- src/npair_skip_size_off2on.cpp | 2 -- src/npair_skip_size_off2on_oneside.cpp | 2 -- src/nstencil_full_bin_2d.cpp | 2 -- src/nstencil_full_bin_3d.cpp | 2 -- src/nstencil_full_ghost_bin_2d.cpp | 2 -- src/nstencil_full_ghost_bin_3d.cpp | 2 -- src/nstencil_full_multi_2d.cpp | 2 -- src/nstencil_full_multi_3d.cpp | 2 -- src/nstencil_half_bin_2d_newtoff.cpp | 2 -- src/nstencil_half_bin_2d_newton.cpp | 2 -- src/nstencil_half_bin_2d_newton_tri.cpp | 2 -- src/nstencil_half_bin_3d_newtoff.cpp | 2 -- src/nstencil_half_bin_3d_newton.cpp | 2 -- src/nstencil_half_bin_3d_newton_tri.cpp | 2 -- src/nstencil_half_ghost_bin_2d_newtoff.cpp | 2 -- src/nstencil_half_ghost_bin_3d_newtoff.cpp | 2 -- src/nstencil_half_multi_2d_newtoff.cpp | 2 -- src/nstencil_half_multi_2d_newton.cpp | 2 -- src/nstencil_half_multi_2d_newton_tri.cpp | 2 -- src/nstencil_half_multi_3d_newtoff.cpp | 2 -- src/nstencil_half_multi_3d_newton.cpp | 2 -- src/nstencil_half_multi_3d_newton_tri.cpp | 2 -- src/ntopo.cpp | 2 +- src/output.cpp | 3 --- src/pair.cpp | 10 ++-------- src/pair_beck.cpp | 3 +-- src/pair_born.cpp | 3 +-- src/pair_born_coul_dsf.cpp | 4 +--- src/pair_born_coul_wolf.cpp | 4 +--- src/pair_buck.cpp | 3 +-- src/pair_coul_debye.cpp | 6 +----- src/pair_coul_dsf.cpp | 3 +-- src/pair_coul_streitz.cpp | 4 +--- src/pair_coul_wolf.cpp | 4 +--- src/pair_dpd.cpp | 4 +--- src/pair_dpd_tstat.cpp | 1 + src/pair_gauss.cpp | 4 +--- src/pair_hybrid.cpp | 3 +-- src/pair_hybrid_overlay.cpp | 3 --- src/pair_lj96_cut.cpp | 4 +--- src/pair_lj_cubic.cpp | 5 +---- src/pair_lj_cut.cpp | 4 +--- 44 files changed, 19 insertions(+), 107 deletions(-) diff --git a/src/npair_skip_respa.cpp b/src/npair_skip_respa.cpp index 1d4eda5354..68436654b2 100644 --- a/src/npair_skip_respa.cpp +++ b/src/npair_skip_respa.cpp @@ -12,12 +12,9 @@ ------------------------------------------------------------------------- */ #include "npair_skip_respa.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/npair_skip_size.cpp b/src/npair_skip_size.cpp index 67717ae576..436d21f76f 100644 --- a/src/npair_skip_size.cpp +++ b/src/npair_skip_size.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_skip_size.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_skip_size_off2on.cpp b/src/npair_skip_size_off2on.cpp index 74a80e6d3d..cd674ff777 100644 --- a/src/npair_skip_size_off2on.cpp +++ b/src/npair_skip_size_off2on.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_skip_size_off2on.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/npair_skip_size_off2on_oneside.cpp b/src/npair_skip_size_off2on_oneside.cpp index a042acd1c6..0540592cba 100644 --- a/src/npair_skip_size_off2on_oneside.cpp +++ b/src/npair_skip_size_off2on_oneside.cpp @@ -11,9 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_skip_size_off2on_oneside.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/nstencil_full_bin_2d.cpp b/src/nstencil_full_bin_2d.cpp index 0986c40dd4..b18d990bba 100644 --- a/src/nstencil_full_bin_2d.cpp +++ b/src/nstencil_full_bin_2d.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_full_bin_2d.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_full_bin_3d.cpp b/src/nstencil_full_bin_3d.cpp index b6a2198132..46ec073ddd 100644 --- a/src/nstencil_full_bin_3d.cpp +++ b/src/nstencil_full_bin_3d.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_full_bin_3d.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_full_ghost_bin_2d.cpp b/src/nstencil_full_ghost_bin_2d.cpp index bbbf1a4466..5ac19569c5 100644 --- a/src/nstencil_full_ghost_bin_2d.cpp +++ b/src/nstencil_full_ghost_bin_2d.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_full_ghost_bin_2d.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_full_ghost_bin_3d.cpp b/src/nstencil_full_ghost_bin_3d.cpp index e9abca2174..6ee56516dc 100644 --- a/src/nstencil_full_ghost_bin_3d.cpp +++ b/src/nstencil_full_ghost_bin_3d.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_full_ghost_bin_3d.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_full_multi_2d.cpp b/src/nstencil_full_multi_2d.cpp index ed2ffe11dc..c69c53a761 100644 --- a/src/nstencil_full_multi_2d.cpp +++ b/src/nstencil_full_multi_2d.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_full_multi_2d.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_full_multi_3d.cpp b/src/nstencil_full_multi_3d.cpp index c171bfadc5..df47c1e7e9 100644 --- a/src/nstencil_full_multi_3d.cpp +++ b/src/nstencil_full_multi_3d.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_full_multi_3d.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_bin_2d_newtoff.cpp b/src/nstencil_half_bin_2d_newtoff.cpp index e51db6fe7a..f3a6c5d08b 100644 --- a/src/nstencil_half_bin_2d_newtoff.cpp +++ b/src/nstencil_half_bin_2d_newtoff.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_2d_newtoff.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_bin_2d_newton.cpp b/src/nstencil_half_bin_2d_newton.cpp index 9479bbf0c8..8fdc8f1aa9 100644 --- a/src/nstencil_half_bin_2d_newton.cpp +++ b/src/nstencil_half_bin_2d_newton.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_2d_newton.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_bin_2d_newton_tri.cpp b/src/nstencil_half_bin_2d_newton_tri.cpp index 4f89b1c326..30d064fb29 100644 --- a/src/nstencil_half_bin_2d_newton_tri.cpp +++ b/src/nstencil_half_bin_2d_newton_tri.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_2d_newton_tri.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_bin_3d_newtoff.cpp b/src/nstencil_half_bin_3d_newtoff.cpp index 433de400c2..e44a93d47d 100644 --- a/src/nstencil_half_bin_3d_newtoff.cpp +++ b/src/nstencil_half_bin_3d_newtoff.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_3d_newtoff.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_bin_3d_newton.cpp b/src/nstencil_half_bin_3d_newton.cpp index 24c234c004..998ed28afe 100644 --- a/src/nstencil_half_bin_3d_newton.cpp +++ b/src/nstencil_half_bin_3d_newton.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_3d_newton.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_bin_3d_newton_tri.cpp b/src/nstencil_half_bin_3d_newton_tri.cpp index 691ce0bb80..2aae44ceaf 100644 --- a/src/nstencil_half_bin_3d_newton_tri.cpp +++ b/src/nstencil_half_bin_3d_newton_tri.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_3d_newton_tri.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_ghost_bin_2d_newtoff.cpp b/src/nstencil_half_ghost_bin_2d_newtoff.cpp index 4bb0ecafe2..6f9a7585fe 100644 --- a/src/nstencil_half_ghost_bin_2d_newtoff.cpp +++ b/src/nstencil_half_ghost_bin_2d_newtoff.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_ghost_bin_2d_newtoff.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_ghost_bin_3d_newtoff.cpp b/src/nstencil_half_ghost_bin_3d_newtoff.cpp index 1026b11542..6492fe4a4e 100644 --- a/src/nstencil_half_ghost_bin_3d_newtoff.cpp +++ b/src/nstencil_half_ghost_bin_3d_newtoff.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_ghost_bin_3d_newtoff.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_multi_2d_newtoff.cpp b/src/nstencil_half_multi_2d_newtoff.cpp index 567abe2878..63cd3fd524 100644 --- a/src/nstencil_half_multi_2d_newtoff.cpp +++ b/src/nstencil_half_multi_2d_newtoff.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_multi_2d_newtoff.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_multi_2d_newton.cpp b/src/nstencil_half_multi_2d_newton.cpp index 5dc2c37148..f6f6c488a5 100644 --- a/src/nstencil_half_multi_2d_newton.cpp +++ b/src/nstencil_half_multi_2d_newton.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_multi_2d_newton.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_multi_2d_newton_tri.cpp b/src/nstencil_half_multi_2d_newton_tri.cpp index 59a5a1d19e..b44ab36ea0 100644 --- a/src/nstencil_half_multi_2d_newton_tri.cpp +++ b/src/nstencil_half_multi_2d_newton_tri.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_multi_2d_newton_tri.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_multi_3d_newtoff.cpp b/src/nstencil_half_multi_3d_newtoff.cpp index 72b882dddc..5a83c4e002 100644 --- a/src/nstencil_half_multi_3d_newtoff.cpp +++ b/src/nstencil_half_multi_3d_newtoff.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_multi_3d_newtoff.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_multi_3d_newton.cpp b/src/nstencil_half_multi_3d_newton.cpp index 9a5d5cab65..5b0c7f9f63 100644 --- a/src/nstencil_half_multi_3d_newton.cpp +++ b/src/nstencil_half_multi_3d_newton.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_multi_3d_newton.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/nstencil_half_multi_3d_newton_tri.cpp b/src/nstencil_half_multi_3d_newton_tri.cpp index 953beb3211..b25a0d0bdb 100644 --- a/src/nstencil_half_multi_3d_newton_tri.cpp +++ b/src/nstencil_half_multi_3d_newton_tri.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_multi_3d_newton_tri.h" -#include "neighbor.h" -#include "neigh_list.h" #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/ntopo.cpp b/src/ntopo.cpp index 8a87a5d6e5..05e287e192 100644 --- a/src/ntopo.cpp +++ b/src/ntopo.cpp @@ -11,7 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include #include "ntopo.h" #include "atom.h" #include "neighbor.h" diff --git a/src/output.cpp b/src/output.cpp index 6253d7de37..fb2f9a700d 100644 --- a/src/output.cpp +++ b/src/output.cpp @@ -11,8 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include #include "output.h" #include "style_dump.h" @@ -26,7 +24,6 @@ #include "domain.h" #include "thermo.h" #include "modify.h" -#include "compute.h" #include "force.h" #include "dump.h" #include "write_restart.h" diff --git a/src/pair.cpp b/src/pair.cpp index 2b4863a54c..3d7bdaa62c 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -16,23 +16,17 @@ ------------------------------------------------------------------------- */ #include -#include -#include -#include +#include // IWYU pragma: keep +#include // IWYU pragma: keep #include -#include -#include #include #include "pair.h" #include "atom.h" #include "neighbor.h" -#include "neigh_list.h" #include "domain.h" #include "comm.h" #include "force.h" #include "kspace.h" -#include "update.h" -#include "modify.h" #include "compute.h" #include "suffix.h" #include "atom_masks.h" diff --git a/src/pair_beck.cpp b/src/pair_beck.cpp index 17731ebf0b..8ba3ef80f2 100644 --- a/src/pair_beck.cpp +++ b/src/pair_beck.cpp @@ -15,9 +15,8 @@ Contributing author: Jonathan Zimmerman (Sandia) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include "pair_beck.h" #include "atom.h" #include "comm.h" diff --git a/src/pair_born.cpp b/src/pair_born.cpp index 78434c91f8..ae7456ddbb 100644 --- a/src/pair_born.cpp +++ b/src/pair_born.cpp @@ -15,9 +15,8 @@ Contributing Author: Sai Jayaraman (Sandia) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_born.h" #include "atom.h" diff --git a/src/pair_born_coul_dsf.cpp b/src/pair_born_coul_dsf.cpp index 2e565897b5..51b9a2677d 100644 --- a/src/pair_born_coul_dsf.cpp +++ b/src/pair_born_coul_dsf.cpp @@ -16,10 +16,8 @@ References: Fennell and Gezelter, JCP 124, 234104 (2006) ------------------------------------------------------------------------- */ +#include #include -#include -#include -#include #include "pair_born_coul_dsf.h" #include "atom.h" #include "comm.h" diff --git a/src/pair_born_coul_wolf.cpp b/src/pair_born_coul_wolf.cpp index 3bb0e39e57..f4ccac80a1 100644 --- a/src/pair_born_coul_wolf.cpp +++ b/src/pair_born_coul_wolf.cpp @@ -15,10 +15,8 @@ Contributing author: Yongfeng Zhang (INL), yongfeng.zhang@inl.gov ------------------------------------------------------------------------- */ +#include #include -#include -#include -#include #include "pair_born_coul_wolf.h" #include "atom.h" #include "comm.h" diff --git a/src/pair_buck.cpp b/src/pair_buck.cpp index a3cf1a38d6..b9795fb0ed 100644 --- a/src/pair_buck.cpp +++ b/src/pair_buck.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_buck.h" #include "atom.h" diff --git a/src/pair_coul_debye.cpp b/src/pair_coul_debye.cpp index c8afdabb93..cd23ef1919 100644 --- a/src/pair_coul_debye.cpp +++ b/src/pair_coul_debye.cpp @@ -11,17 +11,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include -#include -#include #include "pair_coul_debye.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/pair_coul_dsf.cpp b/src/pair_coul_dsf.cpp index e487ff171c..4c15b5d330 100644 --- a/src/pair_coul_dsf.cpp +++ b/src/pair_coul_dsf.cpp @@ -16,9 +16,8 @@ References: Fennell and Gezelter, JCP 124, 234104 (2006) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_coul_dsf.h" #include "atom.h" diff --git a/src/pair_coul_streitz.cpp b/src/pair_coul_streitz.cpp index 282c855249..f577564ac1 100644 --- a/src/pair_coul_streitz.cpp +++ b/src/pair_coul_streitz.cpp @@ -15,8 +15,8 @@ Contributing author: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include #include -#include #include #include #include "pair_coul_streitz.h" @@ -27,8 +27,6 @@ #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "group.h" -#include "update.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/pair_coul_wolf.cpp b/src/pair_coul_wolf.cpp index dbf21b8bee..8c15378de8 100644 --- a/src/pair_coul_wolf.cpp +++ b/src/pair_coul_wolf.cpp @@ -15,10 +15,8 @@ Contributing author: Yongfeng Zhang (INL), yongfeng.zhang@inl.gov ------------------------------------------------------------------------- */ +#include #include -#include -#include -#include #include "pair_coul_wolf.h" #include "atom.h" #include "comm.h" diff --git a/src/pair_dpd.cpp b/src/pair_dpd.cpp index 914b4aee17..e5e6cf7dae 100644 --- a/src/pair_dpd.cpp +++ b/src/pair_dpd.cpp @@ -15,12 +15,10 @@ Contributing author: Kurt Smith (U Pittsburgh) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include "pair_dpd.h" #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "update.h" #include "force.h" diff --git a/src/pair_dpd_tstat.cpp b/src/pair_dpd_tstat.cpp index 1207c954eb..66c8d91ab1 100644 --- a/src/pair_dpd_tstat.cpp +++ b/src/pair_dpd_tstat.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "pair_dpd_tstat.h" #include "atom.h" diff --git a/src/pair_gauss.cpp b/src/pair_gauss.cpp index 2d157d6cac..7df9a417c3 100644 --- a/src/pair_gauss.cpp +++ b/src/pair_gauss.cpp @@ -15,15 +15,13 @@ Contributing author: Sai Jayaraman (Sandia) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_gauss.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index 9aff8a387a..daeee3d2b3 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -12,8 +12,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include #include #include #include "pair_hybrid.h" diff --git a/src/pair_hybrid_overlay.cpp b/src/pair_hybrid_overlay.cpp index 717c0de1d1..496e3d0406 100644 --- a/src/pair_hybrid_overlay.cpp +++ b/src/pair_hybrid_overlay.cpp @@ -11,14 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include #include #include "pair_hybrid_overlay.h" #include "atom.h" #include "force.h" -#include "neighbor.h" -#include "neigh_request.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/pair_lj96_cut.cpp b/src/pair_lj96_cut.cpp index cefe9b87e0..62e645ef2c 100644 --- a/src/pair_lj96_cut.cpp +++ b/src/pair_lj96_cut.cpp @@ -15,9 +15,8 @@ Contributing author: Chuanfu Luo (luochuanfu@gmail.com) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_lj96_cut.h" #include "atom.h" @@ -27,7 +26,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory.h" diff --git a/src/pair_lj_cubic.cpp b/src/pair_lj_cubic.cpp index fdbfca608f..8b1b4b7627 100644 --- a/src/pair_lj_cubic.cpp +++ b/src/pair_lj_cubic.cpp @@ -16,15 +16,12 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include #include -#include -#include -#include #include "pair_lj_cubic.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/pair_lj_cut.cpp b/src/pair_lj_cut.cpp index 2a0fcde3a5..9284923218 100644 --- a/src/pair_lj_cut.cpp +++ b/src/pair_lj_cut.cpp @@ -15,9 +15,8 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_lj_cut.h" #include "atom.h" @@ -27,7 +26,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory.h" -- GitLab From 0c4af8b820f4d6f559d07086db91a2c1dee67a47 Mon Sep 17 00:00:00 2001 From: jrgissing Date: Tue, 2 Jul 2019 22:13:06 -0600 Subject: [PATCH 163/469] spelling: attempt add file paths to false positives --- doc/utils/sphinx-config/conf.py | 3 +++ doc/utils/sphinx-config/custom_filters.py | 9 +++++++++ 2 files changed, 12 insertions(+) create mode 100644 doc/utils/sphinx-config/custom_filters.py diff --git a/doc/utils/sphinx-config/conf.py b/doc/utils/sphinx-config/conf.py index 29de3af156..646fbd2e94 100644 --- a/doc/utils/sphinx-config/conf.py +++ b/doc/utils/sphinx-config/conf.py @@ -312,3 +312,6 @@ if spelling_spec: spelling_lang='en_US' spelling_word_list_filename='false_positives.txt' + + from custom_filters import PathFilter + spelling_filters = [PathFilter] diff --git a/doc/utils/sphinx-config/custom_filters.py b/doc/utils/sphinx-config/custom_filters.py new file mode 100644 index 0000000000..3df26854e4 --- /dev/null +++ b/doc/utils/sphinx-config/custom_filters.py @@ -0,0 +1,9 @@ +class PathFilter(Filter): + r"""Filter skipping over simple file paths + """ + _DOC_ERRORS = ["zA"] + _pattern = re.compile(r"\/[^\s].*") + def _skip(self,word): + if self._pattern.match(word): + return True + return False -- GitLab From 7967cb11339b3ae52e9de9c671e5c611b1d9b1f2 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 2 Jul 2019 22:56:56 -0400 Subject: [PATCH 164/469] put implementation header first to avoid issues with mpi.h and lmptype.h with OpenMPI --- doc/include-file-conventions.md | 4 ++-- src/angle.h | 2 +- src/angle_deprecated.cpp | 5 +++-- src/angle_hybrid.cpp | 2 +- src/angle_zero.cpp | 2 +- src/atom.cpp | 2 +- src/atom_map.cpp | 2 +- src/atom_vec.cpp | 2 +- src/atom_vec_atomic.cpp | 2 +- src/atom_vec_body.cpp | 2 +- src/atom_vec_charge.cpp | 2 +- src/atom_vec_ellipsoid.cpp | 2 +- src/atom_vec_hybrid.cpp | 2 +- src/atom_vec_line.cpp | 2 +- src/atom_vec_sphere.cpp | 2 +- src/atom_vec_tri.cpp | 2 +- src/balance.cpp | 2 +- src/body.cpp | 2 +- src/bond.cpp | 2 +- src/bond_deprecated.cpp | 2 +- src/bond_hybrid.cpp | 2 +- src/bond_zero.cpp | 2 +- src/change_box.cpp | 2 +- src/comm.cpp | 2 +- src/comm_brick.cpp | 2 +- src/comm_tiled.cpp | 2 +- src/compute.cpp | 2 +- src/compute_adf.cpp | 2 +- src/compute_aggregate_atom.cpp | 2 +- src/compute_angle.cpp | 2 +- src/compute_angle_local.cpp | 2 +- src/compute_angmom_chunk.cpp | 2 +- src/compute_bond.cpp | 2 +- src/compute_bond_local.cpp | 2 +- src/compute_centro_atom.cpp | 2 +- src/compute_chunk_atom.cpp | 2 +- src/compute_chunk_spread_atom.cpp | 2 +- src/compute_cluster_atom.cpp | 2 +- src/compute_cna_atom.cpp | 2 +- src/compute_com_chunk.cpp | 2 +- src/compute_contact_atom.cpp | 2 +- src/compute_coord_atom.cpp | 2 +- src/compute_deprecated.cpp | 2 +- src/compute_dihedral.cpp | 2 +- src/compute_dihedral_local.cpp | 2 +- src/compute_dipole_chunk.cpp | 2 +- src/compute_displace_atom.cpp | 2 +- src/compute_erotate_sphere.cpp | 2 +- src/compute_erotate_sphere_atom.cpp | 2 +- src/compute_fragment_atom.cpp | 2 +- src/compute_global_atom.cpp | 2 +- src/compute_group_group.cpp | 2 +- src/compute_gyration.cpp | 2 +- src/compute_gyration_chunk.cpp | 2 +- src/compute_heat_flux.cpp | 2 +- src/compute_hexorder_atom.cpp | 2 +- src/compute_improper.cpp | 2 +- src/compute_improper_local.cpp | 2 +- src/compute_inertia_chunk.cpp | 2 +- src/compute_ke.cpp | 2 +- src/compute_ke_atom.cpp | 2 +- src/compute_msd.cpp | 2 +- src/compute_msd_chunk.cpp | 2 +- src/compute_omega_chunk.cpp | 2 +- src/compute_orientorder_atom.cpp | 2 +- src/compute_pair.cpp | 2 +- src/compute_pair_local.cpp | 2 +- src/compute_pe.cpp | 2 +- src/compute_pe_atom.cpp | 2 +- src/compute_pressure.cpp | 2 +- src/compute_property_atom.cpp | 2 +- src/compute_property_chunk.cpp | 2 +- src/compute_property_local.cpp | 2 +- src/compute_rdf.cpp | 2 +- src/compute_reduce.cpp | 2 +- src/compute_reduce_chunk.cpp | 2 +- src/compute_reduce_region.cpp | 2 +- src/compute_slice.cpp | 2 +- src/compute_stress_atom.cpp | 2 +- src/compute_temp.cpp | 2 +- src/compute_temp_chunk.cpp | 2 +- src/compute_temp_com.cpp | 2 +- src/compute_temp_deform.cpp | 2 +- src/compute_temp_partial.cpp | 2 +- src/compute_temp_profile.cpp | 2 +- src/compute_temp_ramp.cpp | 2 +- src/compute_temp_region.cpp | 2 +- src/compute_temp_sphere.cpp | 2 +- src/compute_torque_chunk.cpp | 2 +- src/compute_vacf.cpp | 2 +- src/compute_vcm_chunk.cpp | 2 +- src/create_atoms.cpp | 2 +- src/create_bonds.cpp | 2 +- src/create_box.cpp | 2 +- src/delete_atoms.cpp | 2 +- src/delete_bonds.cpp | 2 +- src/deprecated.cpp | 2 +- src/dihedral_deprecated.cpp | 2 +- src/dihedral_hybrid.cpp | 2 +- src/dihedral_zero.cpp | 2 +- src/displace_atoms.cpp | 2 +- src/domain.cpp | 2 +- src/dump.cpp | 2 +- src/dump_atom.cpp | 2 +- src/dump_cfg.cpp | 2 +- src/dump_custom.cpp | 2 +- src/dump_dcd.cpp | 2 +- src/dump_deprecated.cpp | 2 +- src/dump_image.cpp | 2 +- src/dump_local.cpp | 2 +- src/dump_movie.cpp | 2 +- src/dump_xyz.cpp | 2 +- src/error.cpp | 2 +- src/finish.cpp | 2 +- src/fix.cpp | 2 +- src/fix_adapt.cpp | 2 +- src/fix_addforce.cpp | 2 +- src/fix_ave_atom.cpp | 2 +- src/fix_ave_chunk.cpp | 3 +-- src/fix_ave_correlate.cpp | 3 +-- src/fix_ave_histo.cpp | 3 +-- src/fix_ave_histo_weight.cpp | 3 +-- src/fix_ave_time.cpp | 3 +-- src/fix_aveforce.cpp | 2 +- src/fix_balance.cpp | 2 +- src/fix_box_relax.cpp | 2 +- src/fix_controller.cpp | 2 +- src/fix_deform.cpp | 2 +- src/fix_deprecated.cpp | 2 +- src/fix_drag.cpp | 2 +- src/fix_dt_reset.cpp | 2 +- src/fix_enforce2d.cpp | 2 +- src/fix_external.cpp | 2 +- src/fix_gravity.cpp | 2 +- src/fix_group.cpp | 2 +- src/fix_halt.cpp | 2 +- src/fix_heat.cpp | 2 +- src/fix_indent.cpp | 2 +- src/fix_langevin.cpp | 2 +- src/fix_lineforce.cpp | 2 +- src/fix_momentum.cpp | 2 +- src/fix_move.cpp | 2 +- src/fix_neigh_history.cpp | 2 +- src/fix_nh.cpp | 2 +- src/fix_nh_sphere.cpp | 2 +- src/fix_nph.cpp | 2 +- src/fix_nph_sphere.cpp | 2 +- src/fix_npt.cpp | 2 +- src/fix_npt_sphere.cpp | 2 +- src/fix_nve.cpp | 2 +- src/fix_nve_limit.cpp | 2 +- src/fix_nve_noforce.cpp | 2 +- src/fix_nve_sphere.cpp | 2 +- src/fix_nvt.cpp | 2 +- src/fix_nvt_sllod.cpp | 2 +- src/fix_nvt_sphere.cpp | 2 +- src/fix_planeforce.cpp | 2 +- src/fix_press_berendsen.cpp | 2 +- src/fix_print.cpp | 2 +- src/fix_property_atom.cpp | 2 +- src/fix_recenter.cpp | 2 +- src/fix_respa.cpp | 2 +- src/fix_restrain.cpp | 2 +- src/fix_setforce.cpp | 2 +- src/fix_spring.cpp | 2 +- src/fix_spring_chunk.cpp | 2 +- src/fix_spring_rg.cpp | 2 +- src/fix_spring_self.cpp | 2 +- src/fix_store.cpp | 2 +- src/fix_store_force.cpp | 2 +- src/fix_store_state.cpp | 2 +- src/fix_temp_berendsen.cpp | 2 +- src/fix_temp_csld.cpp | 2 +- src/fix_temp_csvr.cpp | 2 +- src/fix_temp_rescale.cpp | 2 +- src/fix_tmd.cpp | 2 +- src/fix_vector.cpp | 2 +- src/fix_viscous.cpp | 2 +- src/fix_wall.cpp | 2 +- src/fix_wall_lj1043.cpp | 2 +- src/fix_wall_lj126.cpp | 2 +- src/fix_wall_lj93.cpp | 2 +- src/fix_wall_reflect.cpp | 2 +- src/fix_wall_region.cpp | 2 +- src/force.cpp | 2 +- src/group.cpp | 2 +- src/hashlittle.cpp | 5 ++--- src/hashlittle.h | 11 ++++++++++- src/image.cpp | 2 +- src/output.cpp | 1 + src/pair_lj_cut_coul_cut.cpp | 3 +-- src/pair_lj_cut_coul_debye.cpp | 2 +- src/pair_lj_cut_coul_dsf.cpp | 5 ++--- src/pointers.h | 2 +- 194 files changed, 208 insertions(+), 205 deletions(-) diff --git a/doc/include-file-conventions.md b/doc/include-file-conventions.md index 3f591361f5..1f206c8f88 100644 --- a/doc/include-file-conventions.md +++ b/doc/include-file-conventions.md @@ -97,10 +97,10 @@ statements should follow the "include what you use" principle. ### Order of Include Statements Include files should be included in this order: -* lmptype.h (should only be included if `MPI_LMP_XXX` data types are used) +* the header matching the implementation (`some_class.h` for file `some_class.cpp`) * mpi.h * system and library headers (anything that is using angular brackets; C-library headers first, then C++) -* LAMMPS local headers (first the header matching the implementation file, the rest in mostly alphabetical order) +* LAMMPS local headers (preferably in alphabetical order) ### Special Cases and Exceptions diff --git a/src/angle.h b/src/angle.h index 7a008f7ca7..3e6812c4fd 100644 --- a/src/angle.h +++ b/src/angle.h @@ -14,7 +14,7 @@ #ifndef LMP_ANGLE_H #define LMP_ANGLE_H -#include "pointers.h" // IWYU pragma: export +#include "pointers.h" namespace LAMMPS_NS { diff --git a/src/angle_deprecated.cpp b/src/angle_deprecated.cpp index b5af217b7b..cc29c9978e 100644 --- a/src/angle_deprecated.cpp +++ b/src/angle_deprecated.cpp @@ -15,12 +15,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "angle_deprecated.h" +#include #include "angle_hybrid.h" #include "comm.h" #include "force.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -43,7 +44,7 @@ void AngleDeprecated::settings(int, char **) // hybrid substyles are created in AngleHybrid::settings(), so when this is // called, our style was just added at the end of the list of substyles - if (strncmp(my_style,"hybrid",6) == 0) { + if (utils::strmatch(my_style,"^hybrid")) { AngleHybrid *hybrid = (AngleHybrid *)force->angle; my_style = hybrid->keywords[hybrid->nstyles]; } diff --git a/src/angle_hybrid.cpp b/src/angle_hybrid.cpp index 47baf770a5..a4729efb38 100644 --- a/src/angle_hybrid.cpp +++ b/src/angle_hybrid.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "angle_hybrid.h" #include #include #include -#include "angle_hybrid.h" #include "atom.h" #include "neighbor.h" #include "comm.h" diff --git a/src/angle_zero.cpp b/src/angle_zero.cpp index 62eab85aee..3c92b852b3 100644 --- a/src/angle_zero.cpp +++ b/src/angle_zero.cpp @@ -15,9 +15,9 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ +#include "angle_zero.h" #include #include -#include "angle_zero.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/atom.cpp b/src/atom.cpp index eab8a3063d..1073d9ebbb 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom.h" #include #include #include #include -#include "atom.h" #include "style_atom.h" #include "atom_vec.h" #include "atom_vec_ellipsoid.h" diff --git a/src/atom_map.cpp b/src/atom_map.cpp index 6af3b9c288..7949e327a9 100644 --- a/src/atom_map.cpp +++ b/src/atom_map.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom.h" #include #include -#include "atom.h" #include "comm.h" #include "memory.h" #include "error.h" diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index a7ca6fcb19..11fe2dba06 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec.h" #include #include -#include "atom_vec.h" #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/atom_vec_atomic.cpp b/src/atom_vec_atomic.cpp index e1c9a1e524..7b452e018f 100644 --- a/src/atom_vec_atomic.cpp +++ b/src/atom_vec_atomic.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_atomic.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/atom_vec_body.cpp b/src/atom_vec_body.cpp index fad5b3eae0..8cc220c8b9 100644 --- a/src/atom_vec_body.cpp +++ b/src/atom_vec_body.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_body.h" #include #include #include -#include "atom_vec_body.h" #include "my_pool_chunk.h" #include "style_body.h" #include "body.h" diff --git a/src/atom_vec_charge.cpp b/src/atom_vec_charge.cpp index 440393385d..950fe06488 100644 --- a/src/atom_vec_charge.cpp +++ b/src/atom_vec_charge.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_charge.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/atom_vec_ellipsoid.cpp b/src/atom_vec_ellipsoid.cpp index ad167bef79..a9c36a61f4 100644 --- a/src/atom_vec_ellipsoid.cpp +++ b/src/atom_vec_ellipsoid.cpp @@ -15,9 +15,9 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "atom_vec_ellipsoid.h" #include #include -#include "atom_vec_ellipsoid.h" #include "math_extra.h" #include "atom.h" #include "comm.h" diff --git a/src/atom_vec_hybrid.cpp b/src/atom_vec_hybrid.cpp index 7e1fb01e5d..a750b17ac3 100644 --- a/src/atom_vec_hybrid.cpp +++ b/src/atom_vec_hybrid.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_hybrid.h" #include #include -#include "atom_vec_hybrid.h" #include "atom.h" #include "domain.h" #include "modify.h" diff --git a/src/atom_vec_line.cpp b/src/atom_vec_line.cpp index 6b197d2663..d694c42043 100644 --- a/src/atom_vec_line.cpp +++ b/src/atom_vec_line.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_line.h" #include #include #include -#include "atom_vec_line.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/atom_vec_sphere.cpp b/src/atom_vec_sphere.cpp index b3f4bfe391..713fb0d721 100644 --- a/src/atom_vec_sphere.cpp +++ b/src/atom_vec_sphere.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_sphere.h" #include #include -#include "atom_vec_sphere.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/atom_vec_tri.cpp b/src/atom_vec_tri.cpp index b0b6eca19b..9a6afce02f 100644 --- a/src/atom_vec_tri.cpp +++ b/src/atom_vec_tri.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_tri.h" #include #include #include -#include "atom_vec_tri.h" #include "math_extra.h" #include "atom.h" #include "comm.h" diff --git a/src/balance.cpp b/src/balance.cpp index 04f342b69b..c3b6f7d3bf 100644 --- a/src/balance.cpp +++ b/src/balance.cpp @@ -18,10 +18,10 @@ //#define BALANCE_DEBUG 1 +#include "balance.h" #include #include #include -#include "balance.h" #include "atom.h" #include "comm.h" #include "rcb.h" diff --git a/src/body.cpp b/src/body.cpp index 10f88bd43b..c0e58d3f4c 100644 --- a/src/body.cpp +++ b/src/body.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "body.h" +#include using namespace LAMMPS_NS; diff --git a/src/bond.cpp b/src/bond.cpp index 0d50b7e3e5..bb54306280 100644 --- a/src/bond.cpp +++ b/src/bond.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "bond.h" +#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/bond_deprecated.cpp b/src/bond_deprecated.cpp index 567b1a4d00..3e20553cac 100644 --- a/src/bond_deprecated.cpp +++ b/src/bond_deprecated.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "bond_deprecated.h" +#include #include "bond_hybrid.h" #include "comm.h" #include "force.h" diff --git a/src/bond_hybrid.cpp b/src/bond_hybrid.cpp index 9028886758..0b1c944196 100644 --- a/src/bond_hybrid.cpp +++ b/src/bond_hybrid.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "bond_hybrid.h" #include #include #include -#include "bond_hybrid.h" #include "atom.h" #include "neighbor.h" #include "comm.h" diff --git a/src/bond_zero.cpp b/src/bond_zero.cpp index c473abbe4b..9be37c13be 100644 --- a/src/bond_zero.cpp +++ b/src/bond_zero.cpp @@ -15,9 +15,9 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ +#include "bond_zero.h" #include #include -#include "bond_zero.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/change_box.cpp b/src/change_box.cpp index 1fed65b430..98119fb3bf 100644 --- a/src/change_box.cpp +++ b/src/change_box.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "change_box.h" #include #include #include -#include "change_box.h" #include "atom.h" #include "modify.h" #include "fix.h" diff --git a/src/comm.cpp b/src/comm.cpp index 5f846cf292..53ec6b990c 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "comm.h" #include #include #include -#include "comm.h" #include "universe.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/comm_brick.cpp b/src/comm_brick.cpp index dcf30807f5..928357d5be 100644 --- a/src/comm_brick.cpp +++ b/src/comm_brick.cpp @@ -15,10 +15,10 @@ Contributing author (triclinic) : Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "comm_brick.h" #include #include #include -#include "comm_brick.h" #include "atom.h" #include "atom_vec.h" #include "pair.h" diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index 385b7fdf22..e145f50f75 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "comm_tiled.h" #include #include #include -#include "comm_tiled.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/compute.cpp b/src/compute.cpp index 8ff8487104..cc92d2b5d3 100644 --- a/src/compute.cpp +++ b/src/compute.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute.h" #include #include -#include "compute.h" #include "domain.h" #include "force.h" #include "group.h" diff --git a/src/compute_adf.cpp b/src/compute_adf.cpp index a17561ff54..dee5fb214f 100644 --- a/src/compute_adf.cpp +++ b/src/compute_adf.cpp @@ -15,10 +15,10 @@ Contributing authors: Aidan P. Thompson (SNL) ------------------------------------------------------------------------- */ +#include "compute_adf.h" #include #include #include -#include "compute_adf.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_aggregate_atom.cpp b/src/compute_aggregate_atom.cpp index 9a797124bd..e495ac6899 100644 --- a/src/compute_aggregate_atom.cpp +++ b/src/compute_aggregate_atom.cpp @@ -15,10 +15,10 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "compute_aggregate_atom.h" #include #include #include -#include "compute_aggregate_atom.h" #include "atom.h" #include "atom_vec.h" #include "update.h" diff --git a/src/compute_angle.cpp b/src/compute_angle.cpp index c1c02a1cc4..fc72a58453 100644 --- a/src/compute_angle.cpp +++ b/src/compute_angle.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_angle.h" +#include #include "angle.h" #include "update.h" #include "force.h" diff --git a/src/compute_angle_local.cpp b/src/compute_angle_local.cpp index 1196211665..b100824ea9 100644 --- a/src/compute_angle_local.cpp +++ b/src/compute_angle_local.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_angle_local.h" #include #include -#include "compute_angle_local.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/compute_angmom_chunk.cpp b/src/compute_angmom_chunk.cpp index ec42015527..05ea963b82 100644 --- a/src/compute_angmom_chunk.cpp +++ b/src/compute_angmom_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_angmom_chunk.h" #include #include -#include "compute_angmom_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_bond.cpp b/src/compute_bond.cpp index 4fd3bbef30..5cc947c764 100644 --- a/src/compute_bond.cpp +++ b/src/compute_bond.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_bond.h" +#include #include "bond.h" #include "update.h" #include "force.h" diff --git a/src/compute_bond_local.cpp b/src/compute_bond_local.cpp index ccdd3ee77c..d579772384 100644 --- a/src/compute_bond_local.cpp +++ b/src/compute_bond_local.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_bond_local.h" #include #include -#include "compute_bond_local.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/compute_centro_atom.cpp b/src/compute_centro_atom.cpp index 7df94271fc..18fc31390f 100644 --- a/src/compute_centro_atom.cpp +++ b/src/compute_centro_atom.cpp @@ -15,8 +15,8 @@ Contributing author: Michel Perez (U Lyon) for non-fcc lattices ------------------------------------------------------------------------- */ -#include #include "compute_centro_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_chunk_atom.cpp b/src/compute_chunk_atom.cpp index fd9204f1cb..92567101de 100644 --- a/src/compute_chunk_atom.cpp +++ b/src/compute_chunk_atom.cpp @@ -13,13 +13,13 @@ // NOTE: allow for bin center to be variables for sphere/cylinder +#include "compute_chunk_atom.h" #include #include #include #include #include #include -#include "compute_chunk_atom.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_chunk_spread_atom.cpp b/src/compute_chunk_spread_atom.cpp index 3d0cea1add..51dad00c25 100644 --- a/src/compute_chunk_spread_atom.cpp +++ b/src/compute_chunk_spread_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_chunk_spread_atom.h" #include #include -#include "compute_chunk_spread_atom.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_cluster_atom.cpp b/src/compute_cluster_atom.cpp index febe0658a0..ff227b3590 100644 --- a/src/compute_cluster_atom.cpp +++ b/src/compute_cluster_atom.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_cluster_atom.h" #include #include #include -#include "compute_cluster_atom.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_cna_atom.cpp b/src/compute_cna_atom.cpp index d764e739b3..054798f637 100644 --- a/src/compute_cna_atom.cpp +++ b/src/compute_cna_atom.cpp @@ -15,10 +15,10 @@ Contributing author: Wan Liang (Chinese Academy of Sciences) ------------------------------------------------------------------------- */ +#include "compute_cna_atom.h" #include #include #include -#include "compute_cna_atom.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_com_chunk.cpp b/src/compute_com_chunk.cpp index 7b4c960cf4..c39911214c 100644 --- a/src/compute_com_chunk.cpp +++ b/src/compute_com_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_com_chunk.h" #include #include -#include "compute_com_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_contact_atom.cpp b/src/compute_contact_atom.cpp index e4afc1d761..7a288afb43 100644 --- a/src/compute_contact_atom.cpp +++ b/src/compute_contact_atom.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_contact_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_coord_atom.cpp b/src/compute_coord_atom.cpp index 8cedcbc027..30747c1314 100644 --- a/src/compute_coord_atom.cpp +++ b/src/compute_coord_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_coord_atom.h" #include #include -#include "compute_coord_atom.h" #include "compute_orientorder_atom.h" #include "atom.h" #include "update.h" diff --git a/src/compute_deprecated.cpp b/src/compute_deprecated.cpp index 069fa73437..1db78b6bdf 100644 --- a/src/compute_deprecated.cpp +++ b/src/compute_deprecated.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_deprecated.h" +#include #include "comm.h" #include "error.h" diff --git a/src/compute_dihedral.cpp b/src/compute_dihedral.cpp index 16823050da..e50903104a 100644 --- a/src/compute_dihedral.cpp +++ b/src/compute_dihedral.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_dihedral.h" +#include #include "update.h" #include "force.h" #include "dihedral.h" diff --git a/src/compute_dihedral_local.cpp b/src/compute_dihedral_local.cpp index 784ae9c607..ac2c884c3f 100644 --- a/src/compute_dihedral_local.cpp +++ b/src/compute_dihedral_local.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_dihedral_local.h" #include #include -#include "compute_dihedral_local.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/compute_dipole_chunk.cpp b/src/compute_dipole_chunk.cpp index 090bc5df94..3790da2035 100644 --- a/src/compute_dipole_chunk.cpp +++ b/src/compute_dipole_chunk.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_dipole_chunk.h" #include #include #include -#include "compute_dipole_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_displace_atom.cpp b/src/compute_displace_atom.cpp index 3773159143..41db4db1d6 100644 --- a/src/compute_displace_atom.cpp +++ b/src/compute_displace_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_displace_atom.h" #include #include -#include "compute_displace_atom.h" #include "atom.h" #include "update.h" #include "group.h" diff --git a/src/compute_erotate_sphere.cpp b/src/compute_erotate_sphere.cpp index 65bb8a9770..2a8588f061 100644 --- a/src/compute_erotate_sphere.cpp +++ b/src/compute_erotate_sphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_erotate_sphere.h" +#include #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_erotate_sphere_atom.cpp b/src/compute_erotate_sphere_atom.cpp index 999bc062c5..78664a912f 100644 --- a/src/compute_erotate_sphere_atom.cpp +++ b/src/compute_erotate_sphere_atom.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_erotate_sphere_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_fragment_atom.cpp b/src/compute_fragment_atom.cpp index d59b519d09..f9b68dd217 100644 --- a/src/compute_fragment_atom.cpp +++ b/src/compute_fragment_atom.cpp @@ -15,9 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "compute_fragment_atom.h" #include #include -#include "compute_fragment_atom.h" #include "atom.h" #include "atom_vec.h" #include "update.h" diff --git a/src/compute_global_atom.cpp b/src/compute_global_atom.cpp index 6685f746a1..15f8a8f1aa 100644 --- a/src/compute_global_atom.cpp +++ b/src/compute_global_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_global_atom.h" #include #include -#include "compute_global_atom.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_group_group.cpp b/src/compute_group_group.cpp index 11e1aac720..f978b4a228 100644 --- a/src/compute_group_group.cpp +++ b/src/compute_group_group.cpp @@ -16,10 +16,10 @@ K-space terms added by Stan Moore (BYU) ------------------------------------------------------------------------- */ +#include "compute_group_group.h" #include #include #include -#include "compute_group_group.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_gyration.cpp b/src/compute_gyration.cpp index 3c5656a5af..2b1a26cc75 100644 --- a/src/compute_gyration.cpp +++ b/src/compute_gyration.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_gyration.h" +#include #include "update.h" #include "atom.h" #include "group.h" diff --git a/src/compute_gyration_chunk.cpp b/src/compute_gyration_chunk.cpp index f3db37d62f..5677ce4b6a 100644 --- a/src/compute_gyration_chunk.cpp +++ b/src/compute_gyration_chunk.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_gyration_chunk.h" #include #include #include -#include "compute_gyration_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_heat_flux.cpp b/src/compute_heat_flux.cpp index 9bd827c713..b717dce04a 100644 --- a/src/compute_heat_flux.cpp +++ b/src/compute_heat_flux.cpp @@ -16,9 +16,9 @@ Mario Pinto (Computational Research Lab, Pune, India) ------------------------------------------------------------------------- */ +#include "compute_heat_flux.h" #include #include -#include "compute_heat_flux.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_hexorder_atom.cpp b/src/compute_hexorder_atom.cpp index c54f4b1aae..96d4c47678 100644 --- a/src/compute_hexorder_atom.cpp +++ b/src/compute_hexorder_atom.cpp @@ -15,10 +15,10 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "compute_hexorder_atom.h" #include #include #include -#include "compute_hexorder_atom.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_improper.cpp b/src/compute_improper.cpp index 2f068dfb74..181771dcfb 100644 --- a/src/compute_improper.cpp +++ b/src/compute_improper.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_improper.h" +#include #include "update.h" #include "force.h" #include "improper.h" diff --git a/src/compute_improper_local.cpp b/src/compute_improper_local.cpp index ec1734cd96..e363749b67 100644 --- a/src/compute_improper_local.cpp +++ b/src/compute_improper_local.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_improper_local.h" #include #include -#include "compute_improper_local.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/compute_inertia_chunk.cpp b/src/compute_inertia_chunk.cpp index d1a7cb9fc1..be980a08ee 100644 --- a/src/compute_inertia_chunk.cpp +++ b/src/compute_inertia_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_inertia_chunk.h" #include #include -#include "compute_inertia_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_ke.cpp b/src/compute_ke.cpp index 3418cc678f..c6ba478dcb 100644 --- a/src/compute_ke.cpp +++ b/src/compute_ke.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_ke.h" +#include #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_ke_atom.cpp b/src/compute_ke_atom.cpp index c5506996da..102d6364ff 100644 --- a/src/compute_ke_atom.cpp +++ b/src/compute_ke_atom.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_ke_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_msd.cpp b/src/compute_msd.cpp index d2e17eff9e..b4115d859c 100644 --- a/src/compute_msd.cpp +++ b/src/compute_msd.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_msd.h" #include #include -#include "compute_msd.h" #include "atom.h" #include "update.h" #include "group.h" diff --git a/src/compute_msd_chunk.cpp b/src/compute_msd_chunk.cpp index 8520b36993..8039a4fcd5 100644 --- a/src/compute_msd_chunk.cpp +++ b/src/compute_msd_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_msd_chunk.h" #include #include -#include "compute_msd_chunk.h" #include "atom.h" #include "group.h" #include "update.h" diff --git a/src/compute_omega_chunk.cpp b/src/compute_omega_chunk.cpp index 360255e908..327c64493f 100644 --- a/src/compute_omega_chunk.cpp +++ b/src/compute_omega_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_omega_chunk.h" #include #include -#include "compute_omega_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_orientorder_atom.cpp b/src/compute_orientorder_atom.cpp index 8a0a525fdc..266df575f9 100644 --- a/src/compute_orientorder_atom.cpp +++ b/src/compute_orientorder_atom.cpp @@ -16,10 +16,10 @@ Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "compute_orientorder_atom.h" #include #include #include -#include "compute_orientorder_atom.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_pair.cpp b/src/compute_pair.cpp index df4f3a1ddb..e9a3faf723 100644 --- a/src/compute_pair.cpp +++ b/src/compute_pair.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_pair.h" #include #include #include -#include "compute_pair.h" #include "update.h" #include "force.h" #include "pair.h" diff --git a/src/compute_pair_local.cpp b/src/compute_pair_local.cpp index 1ab46a0297..2018d929f3 100644 --- a/src/compute_pair_local.cpp +++ b/src/compute_pair_local.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_pair_local.h" #include #include #include -#include "compute_pair_local.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_pe.cpp b/src/compute_pe.cpp index 5839ec2095..fd7b74b43a 100644 --- a/src/compute_pe.cpp +++ b/src/compute_pe.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_pe.h" #include #include -#include "compute_pe.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_pe_atom.cpp b/src/compute_pe_atom.cpp index b3ace2d419..274e1b05a6 100644 --- a/src/compute_pe_atom.cpp +++ b/src/compute_pe_atom.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_pe_atom.h" +#include #include "atom.h" #include "update.h" #include "comm.h" diff --git a/src/compute_pressure.cpp b/src/compute_pressure.cpp index 431f039de3..1782a040ae 100644 --- a/src/compute_pressure.cpp +++ b/src/compute_pressure.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_pressure.h" #include #include -#include "compute_pressure.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/compute_property_atom.cpp b/src/compute_property_atom.cpp index 0b57840696..065e3eeb82 100644 --- a/src/compute_property_atom.cpp +++ b/src/compute_property_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_property_atom.h" #include #include -#include "compute_property_atom.h" #include "math_extra.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/compute_property_chunk.cpp b/src/compute_property_chunk.cpp index 089e867598..579c7cae3f 100644 --- a/src/compute_property_chunk.cpp +++ b/src/compute_property_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_property_chunk.h" #include #include -#include "compute_property_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_property_local.cpp b/src/compute_property_local.cpp index ddcf5913ca..651e1190b1 100644 --- a/src/compute_property_local.cpp +++ b/src/compute_property_local.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_property_local.h" +#include #include "atom.h" #include "atom_vec.h" #include "update.h" diff --git a/src/compute_rdf.cpp b/src/compute_rdf.cpp index b1fa8bb2a3..501a506c98 100644 --- a/src/compute_rdf.cpp +++ b/src/compute_rdf.cpp @@ -15,10 +15,10 @@ Contributing authors: Paul Crozier (SNL), Jeff Greathouse (SNL) ------------------------------------------------------------------------- */ +#include "compute_rdf.h" #include #include #include -#include "compute_rdf.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_reduce.cpp b/src/compute_reduce.cpp index e7692b0797..8467554faa 100644 --- a/src/compute_reduce.cpp +++ b/src/compute_reduce.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_reduce.h" #include #include #include -#include "compute_reduce.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/compute_reduce_chunk.cpp b/src/compute_reduce_chunk.cpp index 5eda71b21b..3b68e20fcb 100644 --- a/src/compute_reduce_chunk.cpp +++ b/src/compute_reduce_chunk.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_reduce_chunk.h" #include #include #include -#include "compute_reduce_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_reduce_region.cpp b/src/compute_reduce_region.cpp index 30a5c6393f..9074124a61 100644 --- a/src/compute_reduce_region.cpp +++ b/src/compute_reduce_region.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_reduce_region.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_slice.cpp b/src/compute_slice.cpp index 6e509c24d4..67b60882f6 100644 --- a/src/compute_slice.cpp +++ b/src/compute_slice.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_slice.h" #include #include #include -#include "compute_slice.h" #include "update.h" #include "modify.h" #include "fix.h" diff --git a/src/compute_stress_atom.cpp b/src/compute_stress_atom.cpp index f84c977bdb..7c0ed9ef17 100644 --- a/src/compute_stress_atom.cpp +++ b/src/compute_stress_atom.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_stress_atom.h" +#include #include "atom.h" #include "update.h" #include "comm.h" diff --git a/src/compute_temp.cpp b/src/compute_temp.cpp index c330249a7e..e77531ee28 100644 --- a/src/compute_temp.cpp +++ b/src/compute_temp.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_temp.h" +#include #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_temp_chunk.cpp b/src/compute_temp_chunk.cpp index 229e98e258..e66aa64a27 100644 --- a/src/compute_temp_chunk.cpp +++ b/src/compute_temp_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_temp_chunk.h" #include #include -#include "compute_temp_chunk.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_temp_com.cpp b/src/compute_temp_com.cpp index 21814e1940..e5b9b3d828 100644 --- a/src/compute_temp_com.cpp +++ b/src/compute_temp_com.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_temp_com.h" +#include #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_temp_deform.cpp b/src/compute_temp_deform.cpp index 39780b5cf6..ff8909a5c7 100644 --- a/src/compute_temp_deform.cpp +++ b/src/compute_temp_deform.cpp @@ -15,9 +15,9 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "compute_temp_deform.h" #include #include -#include "compute_temp_deform.h" #include "domain.h" #include "atom.h" #include "update.h" diff --git a/src/compute_temp_partial.cpp b/src/compute_temp_partial.cpp index 8d5ff66796..6bffcef374 100644 --- a/src/compute_temp_partial.cpp +++ b/src/compute_temp_partial.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_temp_partial.h" +#include #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_temp_profile.cpp b/src/compute_temp_profile.cpp index 21c87b31a2..fce145848e 100644 --- a/src/compute_temp_profile.cpp +++ b/src/compute_temp_profile.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_temp_profile.h" #include #include -#include "compute_temp_profile.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_temp_ramp.cpp b/src/compute_temp_ramp.cpp index 715d2aa9f4..0899f89fd1 100644 --- a/src/compute_temp_ramp.cpp +++ b/src/compute_temp_ramp.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_temp_ramp.h" #include #include -#include "compute_temp_ramp.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_temp_region.cpp b/src/compute_temp_region.cpp index 4aa4dac0a1..a1b1b77648 100644 --- a/src/compute_temp_region.cpp +++ b/src/compute_temp_region.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_temp_region.h" #include #include -#include "compute_temp_region.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_temp_sphere.cpp b/src/compute_temp_sphere.cpp index b490a5ec45..d2bfe6db61 100644 --- a/src/compute_temp_sphere.cpp +++ b/src/compute_temp_sphere.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_temp_sphere.h" #include #include -#include "compute_temp_sphere.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/compute_torque_chunk.cpp b/src/compute_torque_chunk.cpp index e43155493f..35eef8fe10 100644 --- a/src/compute_torque_chunk.cpp +++ b/src/compute_torque_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_torque_chunk.h" #include #include -#include "compute_torque_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/compute_vacf.cpp b/src/compute_vacf.cpp index 787c2503ca..761f827347 100644 --- a/src/compute_vacf.cpp +++ b/src/compute_vacf.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_vacf.h" #include #include -#include "compute_vacf.h" #include "atom.h" #include "update.h" #include "group.h" diff --git a/src/compute_vcm_chunk.cpp b/src/compute_vcm_chunk.cpp index cf30130763..b0a8dbeee7 100644 --- a/src/compute_vcm_chunk.cpp +++ b/src/compute_vcm_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_vcm_chunk.h" #include #include -#include "compute_vcm_chunk.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/create_atoms.cpp b/src/create_atoms.cpp index 8504023a70..f6cff042fe 100644 --- a/src/create_atoms.cpp +++ b/src/create_atoms.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "create_atoms.h" #include #include -#include "create_atoms.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/create_bonds.cpp b/src/create_bonds.cpp index e00fe109ca..5b7c354595 100644 --- a/src/create_bonds.cpp +++ b/src/create_bonds.cpp @@ -15,9 +15,9 @@ Contributing authors: Mike Salerno (NRL) added single methods ------------------------------------------------------------------------- */ +#include "create_bonds.h" #include #include -#include "create_bonds.h" #include "atom.h" #include "domain.h" #include "force.h" diff --git a/src/create_box.cpp b/src/create_box.cpp index 5ec960bec4..4a826cb691 100644 --- a/src/create_box.cpp +++ b/src/create_box.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "create_box.h" +#include #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/delete_atoms.cpp b/src/delete_atoms.cpp index ff4b97a3a4..e8d9c5d53b 100644 --- a/src/delete_atoms.cpp +++ b/src/delete_atoms.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "delete_atoms.h" #include #include #include -#include "delete_atoms.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_ellipsoid.h" diff --git a/src/delete_bonds.cpp b/src/delete_bonds.cpp index c4d591543a..c450f77ee7 100644 --- a/src/delete_bonds.cpp +++ b/src/delete_bonds.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "delete_bonds.h" #include #include #include -#include "delete_bonds.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/deprecated.cpp b/src/deprecated.cpp index 66ddcfeff4..86af54fbfd 100644 --- a/src/deprecated.cpp +++ b/src/deprecated.cpp @@ -15,8 +15,8 @@ Contributing authors: Axel Kohlmeyer (Temple U), ------------------------------------------------------------------------- */ -#include #include "deprecated.h" +#include #include "comm.h" #include "error.h" #include "input.h" diff --git a/src/dihedral_deprecated.cpp b/src/dihedral_deprecated.cpp index 70888ca76d..0205b1b887 100644 --- a/src/dihedral_deprecated.cpp +++ b/src/dihedral_deprecated.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "dihedral_deprecated.h" +#include #include "dihedral_hybrid.h" #include "comm.h" #include "force.h" diff --git a/src/dihedral_hybrid.cpp b/src/dihedral_hybrid.cpp index 27fd7084bc..0863be955d 100644 --- a/src/dihedral_hybrid.cpp +++ b/src/dihedral_hybrid.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "dihedral_hybrid.h" #include #include #include -#include "dihedral_hybrid.h" #include "atom.h" #include "neighbor.h" #include "comm.h" diff --git a/src/dihedral_zero.cpp b/src/dihedral_zero.cpp index 0367477267..daf46fe79a 100644 --- a/src/dihedral_zero.cpp +++ b/src/dihedral_zero.cpp @@ -15,8 +15,8 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ -#include #include "dihedral_zero.h" +#include #include "atom.h" #include "force.h" #include "memory.h" diff --git a/src/displace_atoms.cpp b/src/displace_atoms.cpp index 8bae173a1d..dc94c3ed35 100644 --- a/src/displace_atoms.cpp +++ b/src/displace_atoms.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "displace_atoms.h" #include #include #include -#include "displace_atoms.h" #include "atom.h" #include "modify.h" #include "domain.h" diff --git a/src/domain.cpp b/src/domain.cpp index 197eff514a..372b264013 100644 --- a/src/domain.cpp +++ b/src/domain.cpp @@ -15,10 +15,10 @@ Contributing author (triclinic) : Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "domain.h" #include #include #include -#include "domain.h" #include "style_region.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/dump.cpp b/src/dump.cpp index b08a4de2ad..57a8decbb0 100644 --- a/src/dump.cpp +++ b/src/dump.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "dump.h" #include #include -#include "dump.h" #include "atom.h" #include "irregular.h" #include "update.h" diff --git a/src/dump_atom.cpp b/src/dump_atom.cpp index c95256ac21..e2e77cfb77 100644 --- a/src/dump_atom.cpp +++ b/src/dump_atom.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "dump_atom.h" +#include #include "domain.h" #include "atom.h" #include "update.h" diff --git a/src/dump_cfg.cpp b/src/dump_cfg.cpp index eb5329e0d1..3430720b8c 100644 --- a/src/dump_cfg.cpp +++ b/src/dump_cfg.cpp @@ -16,8 +16,8 @@ Memory efficiency improved by Ray Shan (Sandia) ------------------------------------------------------------------------- */ -#include #include "dump_cfg.h" +#include #include "atom.h" #include "domain.h" #include "memory.h" diff --git a/src/dump_custom.cpp b/src/dump_custom.cpp index 75e4e42bcd..ce83e442c9 100644 --- a/src/dump_custom.cpp +++ b/src/dump_custom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "dump_custom.h" #include #include -#include "dump_custom.h" #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/dump_dcd.cpp b/src/dump_dcd.cpp index ce669fecfd..254b371e22 100644 --- a/src/dump_dcd.cpp +++ b/src/dump_dcd.cpp @@ -16,10 +16,10 @@ Axel Kohlmeyer (Temple U), support for groups ------------------------------------------------------------------------- */ +#include "dump_dcd.h" #include #include #include -#include "dump_dcd.h" #include "domain.h" #include "atom.h" #include "update.h" diff --git a/src/dump_deprecated.cpp b/src/dump_deprecated.cpp index f0999f4276..4263b9801f 100644 --- a/src/dump_deprecated.cpp +++ b/src/dump_deprecated.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "dump_deprecated.h" +#include #include "comm.h" #include "error.h" diff --git a/src/dump_image.cpp b/src/dump_image.cpp index 0b4ca43879..7e6bc0c44c 100644 --- a/src/dump_image.cpp +++ b/src/dump_image.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "dump_image.h" #include #include #include #include -#include "dump_image.h" #include "image.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/dump_local.cpp b/src/dump_local.cpp index f99b7ac06c..9f021a7b6a 100644 --- a/src/dump_local.cpp +++ b/src/dump_local.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "dump_local.h" #include #include #include -#include "dump_local.h" #include "modify.h" #include "fix.h" #include "compute.h" diff --git a/src/dump_movie.cpp b/src/dump_movie.cpp index 37d8a37f4d..ea67320d4a 100644 --- a/src/dump_movie.cpp +++ b/src/dump_movie.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "dump_movie.h" +#include #include "comm.h" #include "force.h" #include "error.h" diff --git a/src/dump_xyz.cpp b/src/dump_xyz.cpp index 4d50cfc2c8..10ba10f995 100644 --- a/src/dump_xyz.cpp +++ b/src/dump_xyz.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "dump_xyz.h" +#include #include "atom.h" #include "error.h" #include "memory.h" diff --git a/src/error.cpp b/src/error.cpp index 8970145b7c..656c957ee2 100644 --- a/src/error.cpp +++ b/src/error.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "error.h" #include #include #include -#include "error.h" #include "universe.h" #include "output.h" #include "input.h" diff --git a/src/finish.cpp b/src/finish.cpp index 77c959b945..bef3ae89eb 100644 --- a/src/finish.cpp +++ b/src/finish.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "finish.h" #include #include #include #include -#include "finish.h" #include "timer.h" #include "universe.h" #include "accelerator_kokkos.h" diff --git a/src/fix.cpp b/src/fix.cpp index 1913ed483e..e0cfeca1a9 100644 --- a/src/fix.cpp +++ b/src/fix.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix.h" #include #include -#include "fix.h" #include "atom.h" #include "group.h" #include "force.h" diff --git a/src/fix_adapt.cpp b/src/fix_adapt.cpp index 7ac6128558..8668690e1d 100644 --- a/src/fix_adapt.cpp +++ b/src/fix_adapt.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_adapt.h" +#include #include "atom.h" #include "bond.h" #include "update.h" diff --git a/src/fix_addforce.cpp b/src/fix_addforce.cpp index e29c4ffe9f..275ec2c846 100644 --- a/src/fix_addforce.cpp +++ b/src/fix_addforce.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_addforce.h" #include #include #include -#include "fix_addforce.h" #include "atom.h" #include "atom_masks.h" #include "update.h" diff --git a/src/fix_ave_atom.cpp b/src/fix_ave_atom.cpp index e6566632de..694df2bcf7 100644 --- a/src/fix_ave_atom.cpp +++ b/src/fix_ave_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_ave_atom.h" #include #include -#include "fix_ave_atom.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/fix_ave_chunk.cpp b/src/fix_ave_chunk.cpp index 1533d1fa4f..45eb38f5c2 100644 --- a/src/fix_ave_chunk.cpp +++ b/src/fix_ave_chunk.cpp @@ -11,12 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_ave_chunk.h" #include -#include // IWYU pragma: keep #include #include #include -#include "fix_ave_chunk.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/fix_ave_correlate.cpp b/src/fix_ave_correlate.cpp index 555c1ac026..f65b53efc8 100644 --- a/src/fix_ave_correlate.cpp +++ b/src/fix_ave_correlate.cpp @@ -17,12 +17,11 @@ Reese Jones (Sandia) ------------------------------------------------------------------------- */ +#include "fix_ave_correlate.h" #include -#include // IWYU pragma: keep #include #include #include -#include "fix_ave_correlate.h" #include "update.h" #include "modify.h" #include "compute.h" diff --git a/src/fix_ave_histo.cpp b/src/fix_ave_histo.cpp index 29fdc21c74..5a5de6d0b6 100644 --- a/src/fix_ave_histo.cpp +++ b/src/fix_ave_histo.cpp @@ -11,12 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_ave_histo.h" #include -#include // IWYU pragma: keep #include #include #include -#include "fix_ave_histo.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/fix_ave_histo_weight.cpp b/src/fix_ave_histo_weight.cpp index 5eeb074472..1f0d282e5d 100644 --- a/src/fix_ave_histo_weight.cpp +++ b/src/fix_ave_histo_weight.cpp @@ -14,11 +14,10 @@ /* ---------------------------------------------------------------------- Contributing author: Shawn Coleman (ARL) ------------------------------------------------------------------------- */ +#include "fix_ave_histo_weight.h" #include -#include // IWYU pragma: keep #include #include "fix.h" -#include "fix_ave_histo_weight.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/fix_ave_time.cpp b/src/fix_ave_time.cpp index 4820215f46..05d556d0c8 100644 --- a/src/fix_ave_time.cpp +++ b/src/fix_ave_time.cpp @@ -15,12 +15,11 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "fix_ave_time.h" #include -#include // IWYU pragma: keep #include #include #include -#include "fix_ave_time.h" #include "update.h" #include "force.h" #include "modify.h" diff --git a/src/fix_aveforce.cpp b/src/fix_aveforce.cpp index 4791a8b022..8ad07780a9 100644 --- a/src/fix_aveforce.cpp +++ b/src/fix_aveforce.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_aveforce.h" #include #include -#include "fix_aveforce.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/fix_balance.cpp b/src/fix_balance.cpp index f9c32e8df0..5ca1ec124a 100644 --- a/src/fix_balance.cpp +++ b/src/fix_balance.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_balance.h" +#include #include "balance.h" #include "update.h" #include "atom.h" diff --git a/src/fix_box_relax.cpp b/src/fix_box_relax.cpp index c73c0ade88..c19ea918b4 100644 --- a/src/fix_box_relax.cpp +++ b/src/fix_box_relax.cpp @@ -15,9 +15,9 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "fix_box_relax.h" #include #include -#include "fix_box_relax.h" #include "atom.h" #include "domain.h" #include "update.h" diff --git a/src/fix_controller.cpp b/src/fix_controller.cpp index eb7a794962..855869a574 100644 --- a/src/fix_controller.cpp +++ b/src/fix_controller.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_controller.h" #include #include -#include "fix_controller.h" #include "force.h" #include "update.h" #include "modify.h" diff --git a/src/fix_deform.cpp b/src/fix_deform.cpp index 96d7580c39..9d84c4bb62 100644 --- a/src/fix_deform.cpp +++ b/src/fix_deform.cpp @@ -15,9 +15,9 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "fix_deform.h" #include #include -#include "fix_deform.h" #include "atom.h" #include "update.h" #include "comm.h" diff --git a/src/fix_deprecated.cpp b/src/fix_deprecated.cpp index 7db27152ba..0c212668b3 100644 --- a/src/fix_deprecated.cpp +++ b/src/fix_deprecated.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_deprecated.h" +#include #include "comm.h" #include "error.h" diff --git a/src/fix_drag.cpp b/src/fix_drag.cpp index 006d1c46d0..9af5a37675 100644 --- a/src/fix_drag.cpp +++ b/src/fix_drag.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_drag.h" #include #include #include -#include "fix_drag.h" #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/fix_dt_reset.cpp b/src/fix_dt_reset.cpp index 4e6195c4fa..da4bdad827 100644 --- a/src/fix_dt_reset.cpp +++ b/src/fix_dt_reset.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_dt_reset.h" #include #include #include -#include "fix_dt_reset.h" #include "atom.h" #include "update.h" #include "integrate.h" diff --git a/src/fix_enforce2d.cpp b/src/fix_enforce2d.cpp index 986ded5d16..3edd24e9af 100644 --- a/src/fix_enforce2d.cpp +++ b/src/fix_enforce2d.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_enforce2d.h" +#include #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/fix_external.cpp b/src/fix_external.cpp index 2c926e26b5..afb420df93 100644 --- a/src/fix_external.cpp +++ b/src/fix_external.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_external.h" +#include #include "atom.h" #include "update.h" #include "memory.h" diff --git a/src/fix_gravity.cpp b/src/fix_gravity.cpp index 8508a92cc4..14ba913c01 100644 --- a/src/fix_gravity.cpp +++ b/src/fix_gravity.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_gravity.h" #include #include #include -#include "fix_gravity.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/fix_group.cpp b/src/fix_group.cpp index 8a332bed95..d2eea9f781 100644 --- a/src/fix_group.cpp +++ b/src/fix_group.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_group.h" +#include #include "group.h" #include "update.h" #include "atom.h" diff --git a/src/fix_halt.cpp b/src/fix_halt.cpp index 133494fb8e..8ebb39f0e9 100644 --- a/src/fix_halt.cpp +++ b/src/fix_halt.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_halt.h" #include #include #include -#include "fix_halt.h" #include "update.h" #include "force.h" #include "input.h" diff --git a/src/fix_heat.cpp b/src/fix_heat.cpp index f78a9c0860..67d445df92 100644 --- a/src/fix_heat.cpp +++ b/src/fix_heat.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "fix_heat.h" #include #include #include -#include "fix_heat.h" #include "atom.h" #include "domain.h" #include "region.h" diff --git a/src/fix_indent.cpp b/src/fix_indent.cpp index 6a42cadefd..04837ff39b 100644 --- a/src/fix_indent.cpp +++ b/src/fix_indent.cpp @@ -15,10 +15,10 @@ Contributing author: Ravi Agrawal (Northwestern U) ------------------------------------------------------------------------- */ +#include "fix_indent.h" #include #include #include -#include "fix_indent.h" #include "atom.h" #include "input.h" #include "variable.h" diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 0f48562048..f8fea76c94 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -16,10 +16,10 @@ Aidan Thompson (SNL) GJF formulation ------------------------------------------------------------------------- */ +#include "fix_langevin.h" #include #include #include -#include "fix_langevin.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/fix_lineforce.cpp b/src/fix_lineforce.cpp index 61c6341aa6..c153ee65dd 100644 --- a/src/fix_lineforce.cpp +++ b/src/fix_lineforce.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_lineforce.h" #include #include -#include "fix_lineforce.h" #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/fix_momentum.cpp b/src/fix_momentum.cpp index bf94a94362..a363cb8eac 100644 --- a/src/fix_momentum.cpp +++ b/src/fix_momentum.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_momentum.h" #include #include #include -#include "fix_momentum.h" #include "atom.h" #include "domain.h" #include "group.h" diff --git a/src/fix_move.cpp b/src/fix_move.cpp index 646f943ef9..770c0fca6b 100644 --- a/src/fix_move.cpp +++ b/src/fix_move.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_move.h" #include #include -#include "fix_move.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/fix_neigh_history.cpp b/src/fix_neigh_history.cpp index ca593f29df..5c740ae649 100644 --- a/src/fix_neigh_history.cpp +++ b/src/fix_neigh_history.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_neigh_history.h" #include #include -#include "fix_neigh_history.h" #include "my_page.h" #include "atom.h" #include "comm.h" diff --git a/src/fix_nh.cpp b/src/fix_nh.cpp index 3ffdff54cf..bb3fe7559c 100644 --- a/src/fix_nh.cpp +++ b/src/fix_nh.cpp @@ -15,9 +15,9 @@ Contributing authors: Mark Stevens (SNL), Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "fix_nh.h" #include #include -#include "fix_nh.h" #include "atom.h" #include "force.h" #include "group.h" diff --git a/src/fix_nh_sphere.cpp b/src/fix_nh_sphere.cpp index 0f1024700a..1ff3fc2d4d 100644 --- a/src/fix_nh_sphere.cpp +++ b/src/fix_nh_sphere.cpp @@ -15,9 +15,9 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "fix_nh_sphere.h" #include #include -#include "fix_nh_sphere.h" #include "atom.h" #include "atom_vec.h" #include "error.h" diff --git a/src/fix_nph.cpp b/src/fix_nph.cpp index 40265ef57c..7148b024de 100644 --- a/src/fix_nph.cpp +++ b/src/fix_nph.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nph.h" +#include #include "modify.h" #include "error.h" diff --git a/src/fix_nph_sphere.cpp b/src/fix_nph_sphere.cpp index 3fcbe5e9c6..f64f144f34 100644 --- a/src/fix_nph_sphere.cpp +++ b/src/fix_nph_sphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nph_sphere.h" +#include #include "modify.h" #include "error.h" diff --git a/src/fix_npt.cpp b/src/fix_npt.cpp index d17577d68d..e856fafe2d 100644 --- a/src/fix_npt.cpp +++ b/src/fix_npt.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_npt.h" +#include #include "modify.h" #include "error.h" diff --git a/src/fix_npt_sphere.cpp b/src/fix_npt_sphere.cpp index 50ac990daf..9cbb17b0ca 100644 --- a/src/fix_npt_sphere.cpp +++ b/src/fix_npt_sphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_npt_sphere.h" +#include #include "modify.h" #include "error.h" diff --git a/src/fix_nve.cpp b/src/fix_nve.cpp index 3396f3ca47..863ce5404d 100644 --- a/src/fix_nve.cpp +++ b/src/fix_nve.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nve.h" +#include #include "atom.h" #include "force.h" #include "update.h" diff --git a/src/fix_nve_limit.cpp b/src/fix_nve_limit.cpp index 49bed2e3dd..d63c736e73 100644 --- a/src/fix_nve_limit.cpp +++ b/src/fix_nve_limit.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nve_limit.h" #include #include #include -#include "fix_nve_limit.h" #include "atom.h" #include "force.h" #include "update.h" diff --git a/src/fix_nve_noforce.cpp b/src/fix_nve_noforce.cpp index 7b61aac18e..022e8abe74 100644 --- a/src/fix_nve_noforce.cpp +++ b/src/fix_nve_noforce.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nve_noforce.h" +#include #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/fix_nve_sphere.cpp b/src/fix_nve_sphere.cpp index 94e8aa88ac..c0fea17c2b 100644 --- a/src/fix_nve_sphere.cpp +++ b/src/fix_nve_sphere.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nve_sphere.h" #include #include -#include "fix_nve_sphere.h" #include "atom.h" #include "domain.h" #include "atom_vec.h" diff --git a/src/fix_nvt.cpp b/src/fix_nvt.cpp index 7247612dd4..6f0d4c6c50 100644 --- a/src/fix_nvt.cpp +++ b/src/fix_nvt.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nvt.h" +#include #include "group.h" #include "modify.h" #include "error.h" diff --git a/src/fix_nvt_sllod.cpp b/src/fix_nvt_sllod.cpp index 16e2fb1d3d..138794862a 100644 --- a/src/fix_nvt_sllod.cpp +++ b/src/fix_nvt_sllod.cpp @@ -15,8 +15,8 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ -#include #include "fix_nvt_sllod.h" +#include #include "math_extra.h" #include "atom.h" #include "domain.h" diff --git a/src/fix_nvt_sphere.cpp b/src/fix_nvt_sphere.cpp index 44046699ba..fed3799011 100644 --- a/src/fix_nvt_sphere.cpp +++ b/src/fix_nvt_sphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nvt_sphere.h" +#include #include "group.h" #include "modify.h" #include "error.h" diff --git a/src/fix_planeforce.cpp b/src/fix_planeforce.cpp index a83d00a506..a3f27277bd 100644 --- a/src/fix_planeforce.cpp +++ b/src/fix_planeforce.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_planeforce.h" #include #include -#include "fix_planeforce.h" #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/fix_press_berendsen.cpp b/src/fix_press_berendsen.cpp index ad3e3d1e1c..c090c554e2 100644 --- a/src/fix_press_berendsen.cpp +++ b/src/fix_press_berendsen.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_press_berendsen.h" #include #include -#include "fix_press_berendsen.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/fix_print.cpp b/src/fix_print.cpp index da2e2b54f3..dc76fc39f9 100644 --- a/src/fix_print.cpp +++ b/src/fix_print.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_print.h" #include #include -#include "fix_print.h" #include "update.h" #include "input.h" #include "modify.h" diff --git a/src/fix_property_atom.cpp b/src/fix_property_atom.cpp index 62c3ec985b..555114e4f9 100644 --- a/src/fix_property_atom.cpp +++ b/src/fix_property_atom.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_property_atom.h" #include #include -#include "fix_property_atom.h" #include "atom.h" #include "comm.h" #include "memory.h" diff --git a/src/fix_recenter.cpp b/src/fix_recenter.cpp index cd50d7dc34..f461e0fa52 100644 --- a/src/fix_recenter.cpp +++ b/src/fix_recenter.cpp @@ -15,9 +15,9 @@ Contributing author: Naveen Michaud-Agrawal (Johns Hopkins U) ------------------------------------------------------------------------- */ +#include "fix_recenter.h" #include #include -#include "fix_recenter.h" #include "atom.h" #include "group.h" #include "update.h" diff --git a/src/fix_respa.cpp b/src/fix_respa.cpp index ea2eb5050a..742dd5c58b 100644 --- a/src/fix_respa.cpp +++ b/src/fix_respa.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_respa.h" +#include #include "atom.h" #include "force.h" #include "memory.h" diff --git a/src/fix_restrain.cpp b/src/fix_restrain.cpp index 3b9980d567..5a0d4fb662 100644 --- a/src/fix_restrain.cpp +++ b/src/fix_restrain.cpp @@ -16,10 +16,10 @@ support for bond and angle restraints by Andres Jaramillo-Botero (Caltech) ------------------------------------------------------------------------- */ +#include "fix_restrain.h" #include #include #include -#include "fix_restrain.h" #include "atom.h" #include "force.h" #include "update.h" diff --git a/src/fix_setforce.cpp b/src/fix_setforce.cpp index f01008dc10..77c4bfbddc 100644 --- a/src/fix_setforce.cpp +++ b/src/fix_setforce.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_setforce.h" #include #include -#include "fix_setforce.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/fix_spring.cpp b/src/fix_spring.cpp index c87cec2766..510b194ab7 100644 --- a/src/fix_spring.cpp +++ b/src/fix_spring.cpp @@ -15,9 +15,9 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "fix_spring.h" #include #include -#include "fix_spring.h" #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/fix_spring_chunk.cpp b/src/fix_spring_chunk.cpp index f6ebadde94..e14936a976 100644 --- a/src/fix_spring_chunk.cpp +++ b/src/fix_spring_chunk.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_spring_chunk.h" #include #include -#include "fix_spring_chunk.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/fix_spring_rg.cpp b/src/fix_spring_rg.cpp index 1d5b87c599..f1e68bffa4 100644 --- a/src/fix_spring_rg.cpp +++ b/src/fix_spring_rg.cpp @@ -16,8 +16,8 @@ Paul Crozier (SNL) ------------------------------------------------------------------------- */ -#include #include "fix_spring_rg.h" +#include #include "atom.h" #include "update.h" #include "group.h" diff --git a/src/fix_spring_self.cpp b/src/fix_spring_self.cpp index a5aa600229..c94f21b492 100644 --- a/src/fix_spring_self.cpp +++ b/src/fix_spring_self.cpp @@ -15,9 +15,9 @@ Contributing author: Naveen Michaud-Agrawal (Johns Hopkins University) ------------------------------------------------------------------------- */ +#include "fix_spring_self.h" #include #include -#include "fix_spring_self.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/fix_store.cpp b/src/fix_store.cpp index a370632489..94c62c1850 100644 --- a/src/fix_store.cpp +++ b/src/fix_store.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_store.h" +#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/fix_store_force.cpp b/src/fix_store_force.cpp index 8afd985615..5c25f0e162 100644 --- a/src/fix_store_force.cpp +++ b/src/fix_store_force.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_store_force.h" +#include #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/fix_store_state.cpp b/src/fix_store_state.cpp index da899a173c..18dfa026d9 100644 --- a/src/fix_store_state.cpp +++ b/src/fix_store_state.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_store_state.h" #include #include -#include "fix_store_state.h" #include "atom.h" #include "domain.h" #include "update.h" diff --git a/src/fix_temp_berendsen.cpp b/src/fix_temp_berendsen.cpp index b4dd65b0c5..be8922be4e 100644 --- a/src/fix_temp_berendsen.cpp +++ b/src/fix_temp_berendsen.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_temp_berendsen.h" #include #include -#include "fix_temp_berendsen.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/fix_temp_csld.cpp b/src/fix_temp_csld.cpp index 57f7104c61..f827c88f51 100644 --- a/src/fix_temp_csld.cpp +++ b/src/fix_temp_csld.cpp @@ -15,9 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_temp_csld.h" #include #include -#include "fix_temp_csld.h" #include "atom.h" #include "force.h" #include "memory.h" diff --git a/src/fix_temp_csvr.cpp b/src/fix_temp_csvr.cpp index 9f8135ffc8..55cbb60407 100644 --- a/src/fix_temp_csvr.cpp +++ b/src/fix_temp_csvr.cpp @@ -16,10 +16,10 @@ Based on code by Paolo Raiteri (Curtin U) and Giovanni Bussi (SISSA) ------------------------------------------------------------------------- */ +#include "fix_temp_csvr.h" #include #include #include -#include "fix_temp_csvr.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/fix_temp_rescale.cpp b/src/fix_temp_rescale.cpp index 378997c0c4..a9d605d5ba 100644 --- a/src/fix_temp_rescale.cpp +++ b/src/fix_temp_rescale.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_temp_rescale.h" #include #include -#include "fix_temp_rescale.h" #include "atom.h" #include "force.h" #include "group.h" diff --git a/src/fix_tmd.cpp b/src/fix_tmd.cpp index a0425db36c..ec8cdb859c 100644 --- a/src/fix_tmd.cpp +++ b/src/fix_tmd.cpp @@ -16,10 +16,10 @@ Christian Burisch (Bochum Univeristy, Germany) ------------------------------------------------------------------------- */ +#include "fix_tmd.h" #include #include #include -#include "fix_tmd.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/fix_vector.cpp b/src/fix_vector.cpp index b7be472be6..53093acbf6 100644 --- a/src/fix_vector.cpp +++ b/src/fix_vector.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_vector.h" #include #include -#include "fix_vector.h" #include "update.h" #include "force.h" #include "modify.h" diff --git a/src/fix_viscous.cpp b/src/fix_viscous.cpp index cc60b1bda4..bdd1e19976 100644 --- a/src/fix_viscous.cpp +++ b/src/fix_viscous.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_viscous.h" +#include #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/fix_wall.cpp b/src/fix_wall.cpp index 1046efc2df..8ceafb4bfc 100644 --- a/src/fix_wall.cpp +++ b/src/fix_wall.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_wall.h" #include #include -#include "fix_wall.h" #include "input.h" #include "variable.h" #include "domain.h" diff --git a/src/fix_wall_lj1043.cpp b/src/fix_wall_lj1043.cpp index a93f4dd699..5656cf113d 100644 --- a/src/fix_wall_lj1043.cpp +++ b/src/fix_wall_lj1043.cpp @@ -15,8 +15,8 @@ Contributing author: Jonathan Lee (Sandia) ------------------------------------------------------------------------- */ -#include #include "fix_wall_lj1043.h" +#include #include "atom.h" #include "math_const.h" diff --git a/src/fix_wall_lj126.cpp b/src/fix_wall_lj126.cpp index 369ef78c97..e748e2ef13 100644 --- a/src/fix_wall_lj126.cpp +++ b/src/fix_wall_lj126.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_wall_lj126.h" +#include #include "atom.h" #include "error.h" diff --git a/src/fix_wall_lj93.cpp b/src/fix_wall_lj93.cpp index ce5a06c81b..c0e81b60ee 100644 --- a/src/fix_wall_lj93.cpp +++ b/src/fix_wall_lj93.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_wall_lj93.h" +#include #include "atom.h" #include "error.h" diff --git a/src/fix_wall_reflect.cpp b/src/fix_wall_reflect.cpp index edf5c40a5f..bc3414d650 100644 --- a/src/fix_wall_reflect.cpp +++ b/src/fix_wall_reflect.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_wall_reflect.h" +#include #include "atom.h" #include "comm.h" #include "update.h" diff --git a/src/fix_wall_region.cpp b/src/fix_wall_region.cpp index cb1c3c2ab2..c1a689d90a 100644 --- a/src/fix_wall_region.cpp +++ b/src/fix_wall_region.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_wall_region.h" #include #include #include -#include "fix_wall_region.h" #include "atom.h" #include "domain.h" #include "region.h" diff --git a/src/force.cpp b/src/force.cpp index e4939a10e8..1a826b2843 100644 --- a/src/force.cpp +++ b/src/force.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "force.h" #include #include #include -#include "force.h" #include "style_bond.h" #include "style_angle.h" #include "style_dihedral.h" diff --git a/src/group.cpp b/src/group.cpp index a37d209947..d119964ea1 100644 --- a/src/group.cpp +++ b/src/group.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "group.h" #include #include #include #include -#include "group.h" #include "domain.h" #include "atom.h" #include "force.h" diff --git a/src/hashlittle.cpp b/src/hashlittle.cpp index e9340a7e55..c3824b71fe 100644 --- a/src/hashlittle.cpp +++ b/src/hashlittle.cpp @@ -2,8 +2,7 @@ // from lookup3.c, by Bob Jenkins, May 2006, Public Domain // bob_jenkins@burtleburtle.net -#include -#include +#include "hashlittle.h" // if the system defines the __BYTE_ORDER__ define, // we use it instead of guessing the platform @@ -141,7 +140,7 @@ acceptable. Do NOT use for cryptographic purposes. ------------------------------------------------------------------------------- */ -uint32_t hashlittle( const void *key, size_t length, uint32_t initval) +uint32_t LAMMPS_NS::hashlittle(const void *key, size_t length, uint32_t initval) { #ifndef PURIFY_HATES_HASHLITTLE diff --git a/src/hashlittle.h b/src/hashlittle.h index 7b57a35c80..75380d366b 100644 --- a/src/hashlittle.h +++ b/src/hashlittle.h @@ -2,4 +2,13 @@ // from lookup3.c, by Bob Jenkins, May 2006, Public Domain // bob_jenkins@burtleburtle.net -uint32_t hashlittle(const void *key, size_t length, uint32_t); +#ifndef LMP_HASHLITTLE_H +#define LMP_HASHLITTLE_H + +#include +#include + +namespace LAMMPS_NS { + uint32_t hashlittle(const void *key, size_t length, uint32_t); +} +#endif diff --git a/src/image.cpp b/src/image.cpp index ccd6d98d87..4a5009b8ed 100644 --- a/src/image.cpp +++ b/src/image.cpp @@ -15,11 +15,11 @@ Contributing author: Nathan Fabian (Sandia) ------------------------------------------------------------------------- */ +#include "image.h" #include #include #include #include -#include "image.h" #include "math_extra.h" #include "random_mars.h" #include "math_const.h" diff --git a/src/output.cpp b/src/output.cpp index fb2f9a700d..be6f66b7aa 100644 --- a/src/output.cpp +++ b/src/output.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include #include "output.h" #include "style_dump.h" diff --git a/src/pair_lj_cut_coul_cut.cpp b/src/pair_lj_cut_coul_cut.cpp index 38a6e2c431..9ffa02156e 100644 --- a/src/pair_lj_cut_coul_cut.cpp +++ b/src/pair_lj_cut_coul_cut.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include -#include #include #include "pair_lj_cut_coul_cut.h" #include "atom.h" diff --git a/src/pair_lj_cut_coul_debye.cpp b/src/pair_lj_cut_coul_debye.cpp index cc6e92b2e3..ab6220bd24 100644 --- a/src/pair_lj_cut_coul_debye.cpp +++ b/src/pair_lj_cut_coul_debye.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include #include -#include #include "pair_lj_cut_coul_debye.h" #include "atom.h" #include "neigh_list.h" diff --git a/src/pair_lj_cut_coul_dsf.cpp b/src/pair_lj_cut_coul_dsf.cpp index f114a5851f..778f9f2fb4 100644 --- a/src/pair_lj_cut_coul_dsf.cpp +++ b/src/pair_lj_cut_coul_dsf.cpp @@ -16,11 +16,10 @@ References: Fennell and Gezelter, JCP 124, 234104 (2006) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_dsf.h" +#include #include -#include -#include #include -#include "pair_lj_cut_coul_dsf.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pointers.h b/src/pointers.h index 1af07d5158..2d528db392 100644 --- a/src/pointers.h +++ b/src/pointers.h @@ -22,7 +22,7 @@ #define LMP_POINTERS_H #include "lmptype.h" // IWYU pragma: export -#include +#include // IWYU pragma: export #include // IWYU pragme: export #include // IWYU pragma: export #include "lammps.h" // IWYU pragma: export -- GitLab From 63dcd999d8c5cbfd07d109836d72355bc138281e Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 3 Jul 2019 11:49:38 -0500 Subject: [PATCH 165/469] Switch to kim-api c-bindings for SimulatorModel --- src/KIM/fix_store_kim.cpp | 12 +++++--- src/KIM/kim_init.cpp | 60 ++++++++++++++++++------------------ src/KIM/kim_interactions.cpp | 49 +++++++++++++++-------------- 3 files changed, 63 insertions(+), 58 deletions(-) diff --git a/src/KIM/fix_store_kim.cpp b/src/KIM/fix_store_kim.cpp index c9a99acca9..1bd924bcfb 100644 --- a/src/KIM/fix_store_kim.cpp +++ b/src/KIM/fix_store_kim.cpp @@ -56,7 +56,9 @@ #include #include "fix_store_kim.h" -#include "KIM_SimulatorModel.hpp" +extern "C" { +#include "KIM_SimulatorModel.h" +} #include "error.h" using namespace LAMMPS_NS; @@ -78,8 +80,8 @@ FixStoreKIM::~FixStoreKIM() // free associated storage if (simulator_model) { - KIM::SimulatorModel *sm = (KIM::SimulatorModel *)simulator_model; - KIM::SimulatorModel::Destroy(&sm); + KIM_SimulatorModel *sm = (KIM_SimulatorModel *)simulator_model; + KIM_SimulatorModel_Destroy(&sm); simulator_model = NULL; } @@ -116,8 +118,8 @@ void FixStoreKIM::setptr(const char *name, void *ptr) { if (strcmp(name,"simulator_model") == 0) { if (simulator_model) { - KIM::SimulatorModel *sm = (KIM::SimulatorModel *)simulator_model; - KIM::SimulatorModel::Destroy(&sm); + KIM_SimulatorModel *sm = (KIM_SimulatorModel *)simulator_model; + KIM_SimulatorModel_Destroy(&sm); } simulator_model = ptr; } else if (strcmp(name,"model_name") == 0) { diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 080e3dac3f..052e63263f 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -75,9 +75,6 @@ extern "C" { #include "KIM_SimulatorHeaders.h" } -//@@@@@ Need to switch to c-bindings when they are available. -#include "KIM_SimulatorModel.hpp" -//@@@@@ using namespace LAMMPS_NS; @@ -214,29 +211,30 @@ void KimInit::determine_model_type_and_units(char * model_name, } } - KIM::SimulatorModel * kim_SM; - kim_error = KIM::SimulatorModel::Create(model_name, &kim_SM); + KIM_SimulatorModel * kim_SM; + kim_error = KIM_SimulatorModel_Create(model_name, &kim_SM); if (kim_error) error->all(FLERR,"KIM model name not found"); model_type = SM; int sim_fields; int sim_lines; - std::string const * sim_field; - std::string const * sim_value; - kim_SM->GetNumberOfSimulatorFields(&sim_fields); - kim_SM->CloseTemplateMap(); + char const * sim_field; + char const * sim_value; + KIM_SimulatorModel_GetNumberOfSimulatorFields(kim_SM, &sim_fields); + KIM_SimulatorModel_CloseTemplateMap(kim_SM); for (int i=0; i < sim_fields; ++i) { - kim_SM->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + KIM_SimulatorModel_GetSimulatorFieldMetadata( + kim_SM,i,&sim_lines,&sim_field); - if (*sim_field == "units") { - kim_SM->GetSimulatorFieldLine(i,0,&sim_value); - int len=(*sim_value).length()+1; - *model_units = new char[len]; strcpy(*model_units,sim_value->c_str()); + if (0 == strcmp(sim_field,"units")) { + KIM_SimulatorModel_GetSimulatorFieldLine(kim_SM,i,0,&sim_value); + int len=strlen(sim_value)+1; + *model_units = new char[len]; strcpy(*model_units,sim_value); break; } } - KIM::SimulatorModel::Destroy(&kim_SM); + KIM_SimulatorModel_Destroy(&kim_SM); if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) { std::string mesg("Incompatible units for KIM Simulator Model, " @@ -271,16 +269,16 @@ void KimInit::do_init(char *model_name, char *user_units, char *model_units) kim_init_log_delimiter("begin"); int kimerror; - // @@@@@ switch to c-bindings when they are available - KIM::SimulatorModel * simulatorModel; + KIM_SimulatorModel * simulatorModel; if (model_type == SM) { - kimerror = KIM::SimulatorModel::Create(model_name,&simulatorModel); + kimerror = KIM_SimulatorModel_Create(model_name,&simulatorModel); - const std::string *sim_name, *sim_version; - simulatorModel->GetSimulatorNameAndVersion(&sim_name, &sim_version); + char const *sim_name, *sim_version; + KIM_SimulatorModel_GetSimulatorNameAndVersion( + simulatorModel,&sim_name, &sim_version); - if (*sim_name != "LAMMPS") + if (0 != strcmp(sim_name,"LAMMPS")) error->all(FLERR,"Incompatible KIM Simulator Model"); if (comm->me == 0) { @@ -288,7 +286,7 @@ void KimInit::do_init(char *model_name, char *user_units, char *model_units) mesg += model_name; mesg += "\n"; mesg += "# For Simulator : "; - mesg += *sim_name + " " + *sim_version + "\n"; + mesg += std::string(sim_name) + " " + sim_version + "\n"; mesg += "# Running on : LAMMPS "; mesg += universe->version; mesg += "\n"; @@ -302,7 +300,7 @@ void KimInit::do_init(char *model_name, char *user_units, char *model_units) // need to call this to have access to (some) simulator model init data. - simulatorModel->CloseTemplateMap(); + KIM_SimulatorModel_CloseTemplateMap(simulatorModel); } // Define unit conversion factor variables and print to log @@ -316,24 +314,26 @@ void KimInit::do_init(char *model_name, char *user_units, char *model_units) if (model_type == SM) { int sim_fields, sim_lines; - const std::string *sim_field, *sim_value; - simulatorModel->GetNumberOfSimulatorFields(&sim_fields); + char const *sim_field, *sim_value; + KIM_SimulatorModel_GetNumberOfSimulatorFields(simulatorModel, &sim_fields); // init model for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "model-init") { + KIM_SimulatorModel_GetSimulatorFieldMetadata( + simulatorModel,i,&sim_lines,&sim_field); + if (0 == strcmp(sim_field,"model-init")) { for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(i,j,&sim_value); - input->one(sim_value->c_str()); + KIM_SimulatorModel_GetSimulatorFieldLine( + simulatorModel,i,j,&sim_value); + input->one(sim_value); } break; } } // reset template map. - simulatorModel->OpenAndInitializeTemplateMap(); + KIM_SimulatorModel_OpenAndInitializeTemplateMap(simulatorModel); } // End output to log file diff --git a/src/KIM/kim_interactions.cpp b/src/KIM/kim_interactions.cpp index 4771272ff8..355df9c3be 100644 --- a/src/KIM/kim_interactions.cpp +++ b/src/KIM/kim_interactions.cpp @@ -73,9 +73,6 @@ extern "C" { #include "KIM_SimulatorHeaders.h" } -//@@@@@ Need to switch to c-bindings when they are available. -#include "KIM_SimulatorModel.hpp" -//@@@@@ #define SNUM(x) \ static_cast(std::ostringstream() \ @@ -122,7 +119,7 @@ void KimInteractions::do_setup(int narg, char **arg) error->all(FLERR,"Illegal kim_interactions command"); char *model_name = NULL; - KIM::SimulatorModel *simulatorModel(NULL); + KIM_SimulatorModel *simulatorModel(NULL); // check if we had a kim_init command by finding fix STORE/KIM // retrieve model name and pointer to simulator model class instance. @@ -132,7 +129,7 @@ void KimInteractions::do_setup(int narg, char **arg) if (ifix >= 0) { FixStoreKIM *fix_store = (FixStoreKIM *) modify->fix[ifix]; model_name = (char *)fix_store->getptr("model_name"); - simulatorModel = (KIM::SimulatorModel *)fix_store->getptr("simulator_model"); + simulatorModel = (KIM_SimulatorModel *)fix_store->getptr("simulator_model"); } else error->all(FLERR,"Must use 'kim_init' before 'kim_interactions'"); // Begin output to log file @@ -151,9 +148,11 @@ void KimInteractions::do_setup(int narg, char **arg) delimiter = " "; } - simulatorModel->AddTemplateMap("atom-type-sym-list",atom_type_sym_list); - simulatorModel->AddTemplateMap("atom-type-num-list",atom_type_num_list); - simulatorModel->CloseTemplateMap(); + KIM_SimulatorModel_AddTemplateMap( + simulatorModel,"atom-type-sym-list",atom_type_sym_list.c_str()); + KIM_SimulatorModel_AddTemplateMap( + simulatorModel,"atom-type-num-list",atom_type_num_list.c_str()); + KIM_SimulatorModel_CloseTemplateMap(simulatorModel); int len = strlen(atom_type_sym_list.c_str())+1; char *strbuf = new char[len]; @@ -163,16 +162,17 @@ void KimInteractions::do_setup(int narg, char **arg) int sim_num_species; bool species_is_supported; - const std::string *sim_species; - simulatorModel->GetNumberOfSupportedSpecies(&sim_num_species); + char const *sim_species; + KIM_SimulatorModel_GetNumberOfSupportedSpecies( + simulatorModel,&sim_num_species); strcpy(strbuf,atom_type_sym_list.c_str()); strword = strtok(strbuf," \t"); while (strword) { species_is_supported = false; if (strcmp(strword,"NULL") == 0) continue; for (int i=0; i < sim_num_species; ++i) { - simulatorModel->GetSupportedSpecies(i, &sim_species); - if (strcmp(sim_species->c_str(),strword) == 0) + KIM_SimulatorModel_GetSupportedSpecies(simulatorModel,i,&sim_species); + if (strcmp(sim_species,strword) == 0) species_is_supported = true; } if (!species_is_supported) { @@ -188,26 +188,29 @@ void KimInteractions::do_setup(int narg, char **arg) // check if units are unchanged int sim_fields, sim_lines; - const std::string *sim_field, *sim_value; - simulatorModel->GetNumberOfSimulatorFields(&sim_fields); + const char *sim_field, *sim_value; + KIM_SimulatorModel_GetNumberOfSimulatorFields(simulatorModel, &sim_fields); for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); + KIM_SimulatorModel_GetSimulatorFieldMetadata( + simulatorModel,i,&sim_lines,&sim_field); - if (*sim_field == "units") { - simulatorModel->GetSimulatorFieldLine(i,0,&sim_value); - if (*sim_value != update->unit_style) + if (0 == strcmp(sim_field,"units")) { + KIM_SimulatorModel_GetSimulatorFieldLine(simulatorModel,i,0,&sim_value); + if (0 != strcmp(sim_value,update->unit_style)) error->all(FLERR,"Incompatible units for KIM Simulator Model"); } } int sim_model_idx=-1; for (int i=0; i < sim_fields; ++i) { - simulatorModel->GetSimulatorFieldMetadata(i,&sim_lines,&sim_field); - if (*sim_field == "model-defn") { + KIM_SimulatorModel_GetSimulatorFieldMetadata( + simulatorModel,i,&sim_lines,&sim_field); + if (0 == strcmp(sim_field,"model-defn")) { sim_model_idx = i; for (int j=0; j < sim_lines; ++j) { - simulatorModel->GetSimulatorFieldLine(sim_model_idx,j,&sim_value); - input->one(sim_value->c_str()); + KIM_SimulatorModel_GetSimulatorFieldLine( + simulatorModel,sim_model_idx,j,&sim_value); + input->one(sim_value); } } } @@ -215,7 +218,7 @@ void KimInteractions::do_setup(int narg, char **arg) if (sim_model_idx < 0) error->all(FLERR,"KIM Simulator Model has no Model definition"); - simulatorModel->OpenAndInitializeTemplateMap(); + KIM_SimulatorModel_OpenAndInitializeTemplateMap(simulatorModel); } else { -- GitLab From 00d820dcf98864fdac0e30a0dbeaafbf57271192 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 3 Jul 2019 13:20:55 -0500 Subject: [PATCH 166/469] Added support for log.cite to kim_init --- src/KIM/kim_init.cpp | 52 ++++++++++++++++++++++++++++++++++++++++++++ src/KIM/kim_init.h | 1 + 2 files changed, 53 insertions(+) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 052e63263f..40e0cbaaed 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -69,6 +69,7 @@ #include "universe.h" #include "input.h" #include "variable.h" +#include "citeme.h" #include "fix_store_kim.h" #include "kim_units.h" @@ -99,6 +100,8 @@ void KimInit::command(int narg, char **arg) char *model_units; determine_model_type_and_units(model_name, user_units, &model_units); + write_log_cite(model_name); + do_init(model_name, user_units, model_units); } @@ -441,3 +444,52 @@ void KimInit::do_variables(char *user_units, char *model_units) if ((logfile) && (input->echo_log)) fputs("#\n",logfile); } } + +/* ---------------------------------------------------------------------- */ + +void KimInit::write_log_cite(char * model_name) +{ + KIM_Collections * coll; + int err = KIM_Collections_Create(&coll); + if (err) return; + + int extent; + if (model_type == MO) + { + err = KIM_Collections_CacheListOfItemMetadataFiles( + coll,KIM_COLLECTION_ITEM_TYPE_portableModel,model_name,&extent); + } + else if (model_type == SM) + { + err = KIM_Collections_CacheListOfItemMetadataFiles( + coll,KIM_COLLECTION_ITEM_TYPE_simulatorModel,model_name,&extent); + } + else + { + error->all(FLERR,"Unknown model type."); + } + + if (err) + { + KIM_Collections_Destroy(&coll); + return; + } + + for (int i = 0; i < extent;++i) + { + char const * fileName; + int availableAsString; + char const * fileString; + err = KIM_Collections_GetItemMetadataFile( + coll,i,&fileName,NULL,NULL,&availableAsString,&fileString); + if (err) continue; + + if (0 == strncmp("kimcite-",fileName,8)) + { + if (lmp->citeme) lmp->citeme->add(fileString); + break; + } + } + + KIM_Collections_Destroy(&coll); +} diff --git a/src/KIM/kim_init.h b/src/KIM/kim_init.h index c22e2be720..7c7a24615b 100644 --- a/src/KIM/kim_init.h +++ b/src/KIM/kim_init.h @@ -78,6 +78,7 @@ class KimInit : protected Pointers { bool unit_conversion_mode; void determine_model_type_and_units(char *, char *, char **); + void write_log_cite(char *); void do_init(char *, char *, char *); void do_variables(char*, char*); void kim_init_log_delimiter(std::string const begin_end) const; -- GitLab From bb5a1c5205c281d23633339c7d700ae0569b63ca Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 3 Jul 2019 13:38:08 -0500 Subject: [PATCH 167/469] Adjust log.cite behavior --- src/KIM/kim_init.cpp | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 40e0cbaaed..5fb6748427 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -484,10 +484,9 @@ void KimInit::write_log_cite(char * model_name) coll,i,&fileName,NULL,NULL,&availableAsString,&fileString); if (err) continue; - if (0 == strncmp("kimcite-",fileName,8)) + if (0 == strncmp("kimcite",fileName,7)) { if (lmp->citeme) lmp->citeme->add(fileString); - break; } } -- GitLab From 5ef389eaea33ce97355177f91a4478f08f987944 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 3 Jul 2019 14:45:45 -0400 Subject: [PATCH 168/469] Mention that a smoothly truncated potential works better Add a table of pair styles that implement single_hessian --- doc/src/compute_hma.txt | 19 ++++++++++++------- 1 file changed, 12 insertions(+), 7 deletions(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index 581e4afeb4..f62498754c 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -48,13 +48,18 @@ effects, smaller timestep inaccuracy, faster equilibration and shorter decorrelation time. HMA should not be used if atoms are expected to diffuse. It is also -restricted to simulations in the NVT ensemble. - -Computation of the heat capacity with this compute is presently restricted to -the "pair_lj_smooth_linear"_pair_lj_smooth_linear.html pair style. Use with other pair -styles requires an additional method (single2nd) to be implemented in the -corresponding Pair class. Computation of the energy and pressure does not -have this restriction. +restricted to simulations in the NVT ensemble. While this compute may be +used with any potential in LAMMPS, it may not provide efficiency improvements +for potentials that do not go to 0 smoothly at the truncation distance; +"pair_lj_smooth_linear"_pair_lj_smooth_linear.html and Ewald summation should +work fine, while "pair_lj"_pair_lj.html will perform poorly unless +the cutoff is very large. Furthermore, computation of the heat capacity with +this compute is restricted to those that implement the single_hessian method +in Pair. This is the list of pair styles that currently implement +pair_hessian: + +"lj_smooth_linear"_pair_lj_smooth_linear.html :l +:ule In this method, the analytically known harmonic behavior of a crystal is removed from the traditional ensemble averages, which leads to an accurate and precise measurement of the anharmonic contributions without contamination -- GitLab From 8e9037ac95780facae8a1bb176f1e768fbfd49db Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 3 Jul 2019 16:19:26 -0400 Subject: [PATCH 169/469] Add request to contact if interested in more pair styles --- doc/src/compute_hma.txt | 6 ++++-- 1 file changed, 4 insertions(+), 2 deletions(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index f62498754c..35a92664df 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -55,8 +55,10 @@ for potentials that do not go to 0 smoothly at the truncation distance; work fine, while "pair_lj"_pair_lj.html will perform poorly unless the cutoff is very large. Furthermore, computation of the heat capacity with this compute is restricted to those that implement the single_hessian method -in Pair. This is the list of pair styles that currently implement -pair_hessian: +in Pair. Implementing single_hessian in additional pair styles is simple. +Please contact Andrew Schultz (ajs42 at buffalo.edu) and David Kofke (kofke at +buffalo.edu) if your desired pair style does not have this method. This is +the list of pair styles that currently implement pair_hessian: "lj_smooth_linear"_pair_lj_smooth_linear.html :l :ule -- GitLab From b675edcf5cf658c22f5f5c6f97f906acb3229870 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Wed, 3 Jul 2019 16:28:37 -0400 Subject: [PATCH 170/469] More false positives --- doc/utils/sphinx-config/false_positives.txt | 2 ++ 1 file changed, 2 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 07a0e4eaf0..2d74c5b464 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -44,6 +44,7 @@ Aidan aij airebo Aj +ajs ajaramil akohlmey Aktulga @@ -1324,6 +1325,7 @@ Kmax Knizhnik knl Kofke +kofke Kohlmeyer Kohn kokkos -- GitLab From 256531a29a31d2f80f860504d0653c4013794338 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 3 Jul 2019 19:34:13 -0400 Subject: [PATCH 171/469] put implementation header first for all remaining main folder source files --- src/imbalance_neigh.cpp | 2 +- src/imbalance_store.cpp | 2 +- src/imbalance_time.cpp | 2 +- src/imbalance_var.cpp | 2 +- src/improper_deprecated.cpp | 2 +- src/improper_hybrid.cpp | 2 +- src/improper_zero.cpp | 2 +- src/info.cpp | 2 +- src/input.cpp | 2 +- src/irregular.cpp | 2 +- src/kspace.cpp | 2 +- src/kspace_deprecated.cpp | 2 +- src/lammps.cpp | 2 +- src/lattice.cpp | 2 +- src/library.cpp | 2 +- src/main.cpp | 2 +- src/math_extra.cpp | 2 +- src/math_special.cpp | 2 +- src/memory.cpp | 2 +- src/min.cpp | 2 +- src/min_cg.cpp | 2 +- src/min_fire.cpp | 2 +- src/min_hftn.cpp | 2 +- src/min_linesearch.cpp | 2 +- src/min_quickmin.cpp | 2 +- src/min_sd.cpp | 2 +- src/modify.cpp | 2 +- src/molecule.cpp | 2 +- src/nbin.cpp | 2 +- src/neighbor.cpp | 2 +- src/npair.cpp | 2 +- src/ntopo.cpp | 2 +- src/ntopo_angle_all.cpp | 2 +- src/ntopo_angle_partial.cpp | 2 +- src/ntopo_angle_template.cpp | 2 +- src/ntopo_bond_all.cpp | 2 +- src/ntopo_bond_partial.cpp | 2 +- src/ntopo_bond_template.cpp | 2 +- src/ntopo_dihedral_all.cpp | 2 +- src/ntopo_dihedral_partial.cpp | 2 +- src/ntopo_dihedral_template.cpp | 2 +- src/ntopo_improper_all.cpp | 2 +- src/ntopo_improper_partial.cpp | 2 +- src/ntopo_improper_template.cpp | 2 +- src/output.cpp | 2 +- src/pair.cpp | 2 +- src/pair_beck.cpp | 2 +- src/pair_born.cpp | 2 +- src/pair_born_coul_dsf.cpp | 2 +- src/pair_born_coul_wolf.cpp | 2 +- src/pair_buck.cpp | 2 +- src/pair_buck_coul_cut.cpp | 2 +- src/pair_coul_cut.cpp | 2 +- src/pair_coul_debye.cpp | 2 +- src/pair_coul_dsf.cpp | 2 +- src/pair_coul_streitz.cpp | 2 +- src/pair_coul_wolf.cpp | 2 +- src/pair_deprecated.cpp | 2 +- src/pair_dpd.cpp | 2 +- src/pair_dpd_tstat.cpp | 2 +- src/pair_gauss.cpp | 2 +- src/pair_hybrid.cpp | 2 +- src/pair_hybrid_overlay.cpp | 2 +- src/pair_lj96_cut.cpp | 2 +- src/pair_lj_cubic.cpp | 2 +- src/pair_lj_cut.cpp | 2 +- src/pair_lj_cut_coul_cut.cpp | 2 +- src/pair_lj_cut_coul_debye.cpp | 2 +- src/pair_lj_cut_coul_wolf.cpp | 2 +- src/pair_lj_expand.cpp | 2 +- src/pair_lj_gromacs.cpp | 2 +- src/pair_lj_gromacs_coul_gromacs.cpp | 2 +- src/pair_lj_smooth.cpp | 2 +- src/pair_lj_smooth_linear.cpp | 2 +- src/pair_mie_cut.cpp | 2 +- src/pair_morse.cpp | 2 +- src/pair_soft.cpp | 2 +- src/pair_table.cpp | 2 +- src/pair_ufm.cpp | 2 +- src/pair_yukawa.cpp | 2 +- src/pair_zbl.cpp | 2 +- src/pair_zero.cpp | 2 +- src/procmap.cpp | 2 +- src/random_mars.cpp | 2 +- src/random_park.cpp | 2 +- src/rcb.cpp | 2 +- src/read_data.cpp | 2 +- src/read_dump.cpp | 2 +- src/read_restart.cpp | 2 +- src/reader.cpp | 2 +- src/reader_native.cpp | 2 +- src/reader_xyz.cpp | 2 +- src/region.cpp | 2 +- src/region_block.cpp | 2 +- src/region_cone.cpp | 2 +- src/region_cylinder.cpp | 2 +- src/region_deprecated.cpp | 2 +- src/region_intersect.cpp | 2 +- src/region_plane.cpp | 2 +- src/region_prism.cpp | 2 +- src/region_sphere.cpp | 2 +- src/region_union.cpp | 2 +- src/replicate.cpp | 2 +- src/rerun.cpp | 2 +- src/reset_ids.cpp | 2 +- src/respa.cpp | 2 +- src/run.cpp | 2 +- src/set.cpp | 2 +- src/special.cpp | 2 +- src/thermo.cpp | 2 +- src/timer.cpp | 2 +- src/universe.cpp | 2 +- src/update.cpp | 2 +- src/utils.cpp | 2 +- src/variable.cpp | 2 +- src/velocity.cpp | 2 +- src/verlet.cpp | 2 +- src/write_coeff.cpp | 2 +- src/write_data.cpp | 2 +- src/write_dump.cpp | 2 +- src/write_restart.cpp | 2 +- 121 files changed, 121 insertions(+), 121 deletions(-) diff --git a/src/imbalance_neigh.cpp b/src/imbalance_neigh.cpp index 2a55754da8..19f3915a11 100644 --- a/src/imbalance_neigh.cpp +++ b/src/imbalance_neigh.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "imbalance_neigh.h" +#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/imbalance_store.cpp b/src/imbalance_store.cpp index c117b60860..343d47b189 100644 --- a/src/imbalance_store.cpp +++ b/src/imbalance_store.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "imbalance_store.h" +#include #include "atom.h" #include "error.h" diff --git a/src/imbalance_time.cpp b/src/imbalance_time.cpp index ceb3c08220..0831713204 100644 --- a/src/imbalance_time.cpp +++ b/src/imbalance_time.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "imbalance_time.h" +#include #include "atom.h" #include "force.h" #include "timer.h" diff --git a/src/imbalance_var.cpp b/src/imbalance_var.cpp index ba17c06866..ba84ef01ef 100644 --- a/src/imbalance_var.cpp +++ b/src/imbalance_var.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "imbalance_var.h" #include #include -#include "imbalance_var.h" #include "atom.h" #include "group.h" #include "input.h" diff --git a/src/improper_deprecated.cpp b/src/improper_deprecated.cpp index 6f4d08764f..62a688527a 100644 --- a/src/improper_deprecated.cpp +++ b/src/improper_deprecated.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "improper_deprecated.h" +#include #include "improper_hybrid.h" #include "comm.h" #include "force.h" diff --git a/src/improper_hybrid.cpp b/src/improper_hybrid.cpp index af1382d3eb..f078a73ec0 100644 --- a/src/improper_hybrid.cpp +++ b/src/improper_hybrid.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "improper_hybrid.h" #include #include #include -#include "improper_hybrid.h" #include "atom.h" #include "neighbor.h" #include "comm.h" diff --git a/src/improper_zero.cpp b/src/improper_zero.cpp index 3f36954a0a..efa70c8ff5 100644 --- a/src/improper_zero.cpp +++ b/src/improper_zero.cpp @@ -15,8 +15,8 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ -#include #include "improper_zero.h" +#include #include "atom.h" #include "force.h" #include "memory.h" diff --git a/src/info.cpp b/src/info.cpp index bb2d3c4b45..8f55fab367 100644 --- a/src/info.cpp +++ b/src/info.cpp @@ -16,6 +16,7 @@ Richard Berger (Temple U) ------------------------------------------------------------------------- */ +#include "info.h" #include #include #include @@ -23,7 +24,6 @@ #include #include #include -#include "info.h" #include "accelerator_kokkos.h" #include "atom.h" #include "comm.h" diff --git a/src/input.cpp b/src/input.cpp index cbad1d78bf..f887bc0245 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "input.h" #include #include #include @@ -18,7 +19,6 @@ #include #include #include -#include "input.h" #include "style_command.h" #include "universe.h" #include "atom.h" diff --git a/src/irregular.cpp b/src/irregular.cpp index 2040d12d0b..b67214df25 100644 --- a/src/irregular.cpp +++ b/src/irregular.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "irregular.h" #include #include -#include "irregular.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/kspace.cpp b/src/kspace.cpp index b51191857d..f9020416bf 100644 --- a/src/kspace.cpp +++ b/src/kspace.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "kspace.h" #include #include #include #include -#include "kspace.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/kspace_deprecated.cpp b/src/kspace_deprecated.cpp index 1d62de2692..0b6490b4cf 100644 --- a/src/kspace_deprecated.cpp +++ b/src/kspace_deprecated.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "kspace_deprecated.h" +#include #include "comm.h" #include "force.h" #include "error.h" diff --git a/src/lammps.cpp b/src/lammps.cpp index f8e7dceb89..5ddc1600a4 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "lammps.h" #include #include #include @@ -18,7 +19,6 @@ #include #include #include -#include "lammps.h" #include "style_angle.h" // IWYU pragma: keep #include "style_atom.h" // IWYU pragma: keep #include "style_bond.h" // IWYU pragma: keep diff --git a/src/lattice.cpp b/src/lattice.cpp index ee2fea2a75..98faf680e8 100644 --- a/src/lattice.cpp +++ b/src/lattice.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "lattice.h" #include #include #include -#include "lattice.h" #include "update.h" #include "domain.h" #include "comm.h" diff --git a/src/library.cpp b/src/library.cpp index 033b814865..eabe5fd179 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -14,11 +14,11 @@ // C or Fortran style library interface to LAMMPS // customize by adding new LAMMPS-specific functions +#include "library.h" #include #include #include #include -#include "library.h" #include "universe.h" #include "atom_vec.h" #include "atom.h" diff --git a/src/main.cpp b/src/main.cpp index 1be9c253eb..b7f6adbdda 100644 --- a/src/main.cpp +++ b/src/main.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "lammps.h" +#include #include "input.h" #if defined(LAMMPS_TRAP_FPE) && defined(_GNU_SOURCE) diff --git a/src/math_extra.cpp b/src/math_extra.cpp index f7e5bb646b..797d210d0e 100644 --- a/src/math_extra.cpp +++ b/src/math_extra.cpp @@ -15,9 +15,9 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "math_extra.h" #include #include -#include "math_extra.h" #define MAXJACOBI 50 diff --git a/src/math_special.cpp b/src/math_special.cpp index b2f545ddc6..bf11a1ad45 100644 --- a/src/math_special.cpp +++ b/src/math_special.cpp @@ -1,6 +1,6 @@ +#include "math_special.h" #include #include // IWYU pragma: keep -#include "math_special.h" using namespace LAMMPS_NS; diff --git a/src/memory.cpp b/src/memory.cpp index ca7fd3ea7f..a513dde6c2 100644 --- a/src/memory.cpp +++ b/src/memory.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "memory.h" +#include #include "error.h" #if defined(LMP_USER_INTEL) && defined(__INTEL_COMPILER) diff --git a/src/min.cpp b/src/min.cpp index f2e1c982be..408954edb8 100644 --- a/src/min.cpp +++ b/src/min.cpp @@ -19,10 +19,10 @@ JR Shewchuk, http://www-2.cs.cmu.edu/~jrs/jrspapers.html#cg ------------------------------------------------------------------------- */ +#include "min.h" #include #include #include -#include "min.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/min_cg.cpp b/src/min_cg.cpp index eb8831c8f5..ff318d23da 100644 --- a/src/min_cg.cpp +++ b/src/min_cg.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "min_cg.h" #include #include -#include "min_cg.h" #include "update.h" #include "output.h" #include "timer.h" diff --git a/src/min_fire.cpp b/src/min_fire.cpp index 79346341bb..b7f853afd2 100644 --- a/src/min_fire.cpp +++ b/src/min_fire.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "min_fire.h" #include #include -#include "min_fire.h" #include "universe.h" #include "atom.h" #include "force.h" diff --git a/src/min_hftn.cpp b/src/min_hftn.cpp index c2c251c386..dcfed10fef 100644 --- a/src/min_hftn.cpp +++ b/src/min_hftn.cpp @@ -17,12 +17,12 @@ "Parallel Unconstrained Min", Plantenga, SAND98-8201 ------------------------------------------------------------------------- */ +#include "min_hftn.h" #include #include #include #include "atom.h" #include "fix_minimize.h" -#include "min_hftn.h" #include "modify.h" #include "output.h" #include "pair.h" diff --git a/src/min_linesearch.cpp b/src/min_linesearch.cpp index 3c0621c602..a7a10dcd51 100644 --- a/src/min_linesearch.cpp +++ b/src/min_linesearch.cpp @@ -21,9 +21,9 @@ JR Shewchuk, http://www-2.cs.cmu.edu/~jrs/jrspapers.html#cg ------------------------------------------------------------------------- */ +#include "min_linesearch.h" #include #include -#include "min_linesearch.h" #include "atom.h" #include "modify.h" #include "fix_minimize.h" diff --git a/src/min_quickmin.cpp b/src/min_quickmin.cpp index 784da82686..04e72b046d 100644 --- a/src/min_quickmin.cpp +++ b/src/min_quickmin.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "min_quickmin.h" #include #include -#include "min_quickmin.h" #include "universe.h" #include "atom.h" #include "force.h" diff --git a/src/min_sd.cpp b/src/min_sd.cpp index d66601119b..e4e159003f 100644 --- a/src/min_sd.cpp +++ b/src/min_sd.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "min_sd.h" +#include #include "update.h" #include "output.h" #include "timer.h" diff --git a/src/modify.cpp b/src/modify.cpp index 61497d86db..a9b8817aed 100644 --- a/src/modify.cpp +++ b/src/modify.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "modify.h" +#include #include "style_compute.h" #include "style_fix.h" #include "atom.h" diff --git a/src/molecule.cpp b/src/molecule.cpp index 4a3790296f..38887ebb0c 100644 --- a/src/molecule.cpp +++ b/src/molecule.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "molecule.h" #include #include #include #include -#include "molecule.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_body.h" diff --git a/src/nbin.cpp b/src/nbin.cpp index 0480c9730d..99d41db140 100644 --- a/src/nbin.cpp +++ b/src/nbin.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "nbin.h" +#include #include "neighbor.h" #include "neigh_request.h" #include "domain.h" diff --git a/src/neighbor.cpp b/src/neighbor.cpp index a2efc5919b..d38aed08c0 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -15,10 +15,10 @@ Contributing author (triclinic and multi-neigh) : Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "neighbor.h" #include #include #include -#include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "nbin.h" diff --git a/src/npair.cpp b/src/npair.cpp index 24cdc7750a..b63135fad6 100644 --- a/src/npair.cpp +++ b/src/npair.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair.h" +#include #include "neighbor.h" #include "neigh_request.h" #include "nbin.h" diff --git a/src/ntopo.cpp b/src/ntopo.cpp index 05e287e192..ca63b85328 100644 --- a/src/ntopo.cpp +++ b/src/ntopo.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo.h" +#include #include "atom.h" #include "neighbor.h" #include "comm.h" diff --git a/src/ntopo_angle_all.cpp b/src/ntopo_angle_all.cpp index 2a358c8ce5..e0c20609a1 100644 --- a/src/ntopo_angle_all.cpp +++ b/src/ntopo_angle_all.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_angle_all.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_angle_partial.cpp b/src/ntopo_angle_partial.cpp index c82110cda5..a6fd900825 100644 --- a/src/ntopo_angle_partial.cpp +++ b/src/ntopo_angle_partial.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_angle_partial.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_angle_template.cpp b/src/ntopo_angle_template.cpp index 15a8b658f3..8cbcf8bcbd 100644 --- a/src/ntopo_angle_template.cpp +++ b/src/ntopo_angle_template.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_angle_template.h" +#include #include "atom.h" #include "atom_vec.h" #include "force.h" diff --git a/src/ntopo_bond_all.cpp b/src/ntopo_bond_all.cpp index 42e9e2303d..5309754554 100644 --- a/src/ntopo_bond_all.cpp +++ b/src/ntopo_bond_all.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_bond_all.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_bond_partial.cpp b/src/ntopo_bond_partial.cpp index 5a1acd9191..1cbf5eed11 100644 --- a/src/ntopo_bond_partial.cpp +++ b/src/ntopo_bond_partial.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_bond_partial.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_bond_template.cpp b/src/ntopo_bond_template.cpp index fa98658ad0..cd7b85aa19 100644 --- a/src/ntopo_bond_template.cpp +++ b/src/ntopo_bond_template.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_bond_template.h" +#include #include "atom.h" #include "atom_vec.h" #include "force.h" diff --git a/src/ntopo_dihedral_all.cpp b/src/ntopo_dihedral_all.cpp index 9c94fb10f9..5af2d526e0 100644 --- a/src/ntopo_dihedral_all.cpp +++ b/src/ntopo_dihedral_all.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_dihedral_all.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_dihedral_partial.cpp b/src/ntopo_dihedral_partial.cpp index 14749e6511..faac57aa51 100644 --- a/src/ntopo_dihedral_partial.cpp +++ b/src/ntopo_dihedral_partial.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_dihedral_partial.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_dihedral_template.cpp b/src/ntopo_dihedral_template.cpp index 8ea860c2e2..bce8ecf4bc 100644 --- a/src/ntopo_dihedral_template.cpp +++ b/src/ntopo_dihedral_template.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_dihedral_template.h" +#include #include "atom.h" #include "atom_vec.h" #include "force.h" diff --git a/src/ntopo_improper_all.cpp b/src/ntopo_improper_all.cpp index 6c478dec52..0cbecbf962 100644 --- a/src/ntopo_improper_all.cpp +++ b/src/ntopo_improper_all.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_improper_all.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_improper_partial.cpp b/src/ntopo_improper_partial.cpp index 2c37668ca8..17e5d4cf62 100644 --- a/src/ntopo_improper_partial.cpp +++ b/src/ntopo_improper_partial.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_improper_partial.h" +#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/ntopo_improper_template.cpp b/src/ntopo_improper_template.cpp index 953e010d89..a80fe60e1d 100644 --- a/src/ntopo_improper_template.cpp +++ b/src/ntopo_improper_template.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "ntopo_improper_template.h" +#include #include "atom.h" #include "atom_vec.h" #include "force.h" diff --git a/src/output.cpp b/src/output.cpp index be6f66b7aa..193db9ae2a 100644 --- a/src/output.cpp +++ b/src/output.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "output.h" #include #include -#include "output.h" #include "style_dump.h" #include "atom.h" #include "neighbor.h" diff --git a/src/pair.cpp b/src/pair.cpp index 3d7bdaa62c..36194aec9b 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -15,12 +15,12 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair.h" #include #include // IWYU pragma: keep #include // IWYU pragma: keep #include #include -#include "pair.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/pair_beck.cpp b/src/pair_beck.cpp index 8ba3ef80f2..b94436b696 100644 --- a/src/pair_beck.cpp +++ b/src/pair_beck.cpp @@ -15,9 +15,9 @@ Contributing author: Jonathan Zimmerman (Sandia) ------------------------------------------------------------------------- */ +#include "pair_beck.h" #include #include -#include "pair_beck.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_born.cpp b/src/pair_born.cpp index ae7456ddbb..bd993acb56 100644 --- a/src/pair_born.cpp +++ b/src/pair_born.cpp @@ -15,10 +15,10 @@ Contributing Author: Sai Jayaraman (Sandia) ------------------------------------------------------------------------- */ +#include "pair_born.h" #include #include #include -#include "pair_born.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_born_coul_dsf.cpp b/src/pair_born_coul_dsf.cpp index 51b9a2677d..f7e139c750 100644 --- a/src/pair_born_coul_dsf.cpp +++ b/src/pair_born_coul_dsf.cpp @@ -16,9 +16,9 @@ References: Fennell and Gezelter, JCP 124, 234104 (2006) ------------------------------------------------------------------------- */ +#include "pair_born_coul_dsf.h" #include #include -#include "pair_born_coul_dsf.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_born_coul_wolf.cpp b/src/pair_born_coul_wolf.cpp index f4ccac80a1..f4d533bdb0 100644 --- a/src/pair_born_coul_wolf.cpp +++ b/src/pair_born_coul_wolf.cpp @@ -15,9 +15,9 @@ Contributing author: Yongfeng Zhang (INL), yongfeng.zhang@inl.gov ------------------------------------------------------------------------- */ +#include "pair_born_coul_wolf.h" #include #include -#include "pair_born_coul_wolf.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_buck.cpp b/src/pair_buck.cpp index b9795fb0ed..a94ce87891 100644 --- a/src/pair_buck.cpp +++ b/src/pair_buck.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_buck.h" #include #include #include -#include "pair_buck.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_buck_coul_cut.cpp b/src/pair_buck_coul_cut.cpp index 64475166e3..d05c139f71 100644 --- a/src/pair_buck_coul_cut.cpp +++ b/src/pair_buck_coul_cut.cpp @@ -15,9 +15,9 @@ Contributing author: Eduardo Bringa (LLNL) ------------------------------------------------------------------------- */ +#include "pair_buck_coul_cut.h" #include #include -#include "pair_buck_coul_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_coul_cut.cpp b/src/pair_coul_cut.cpp index 28973026cd..9e6f238eba 100644 --- a/src/pair_coul_cut.cpp +++ b/src/pair_coul_cut.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_coul_cut.h" #include #include #include -#include "pair_coul_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_coul_debye.cpp b/src/pair_coul_debye.cpp index cd23ef1919..1b87a93701 100644 --- a/src/pair_coul_debye.cpp +++ b/src/pair_coul_debye.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_coul_debye.h" #include #include -#include "pair_coul_debye.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_coul_dsf.cpp b/src/pair_coul_dsf.cpp index 4c15b5d330..22230182b0 100644 --- a/src/pair_coul_dsf.cpp +++ b/src/pair_coul_dsf.cpp @@ -16,10 +16,10 @@ References: Fennell and Gezelter, JCP 124, 234104 (2006) ------------------------------------------------------------------------- */ +#include "pair_coul_dsf.h" #include #include #include -#include "pair_coul_dsf.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_coul_streitz.cpp b/src/pair_coul_streitz.cpp index f577564ac1..628f6a6b36 100644 --- a/src/pair_coul_streitz.cpp +++ b/src/pair_coul_streitz.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include "pair_coul_streitz.h" #include #include #include #include -#include "pair_coul_streitz.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_coul_wolf.cpp b/src/pair_coul_wolf.cpp index 8c15378de8..15c7839fc6 100644 --- a/src/pair_coul_wolf.cpp +++ b/src/pair_coul_wolf.cpp @@ -15,9 +15,9 @@ Contributing author: Yongfeng Zhang (INL), yongfeng.zhang@inl.gov ------------------------------------------------------------------------- */ +#include "pair_coul_wolf.h" #include #include -#include "pair_coul_wolf.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_deprecated.cpp b/src/pair_deprecated.cpp index 0b1342fb2d..058809eb80 100644 --- a/src/pair_deprecated.cpp +++ b/src/pair_deprecated.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_deprecated.h" +#include #include "pair_hybrid.h" #include "comm.h" #include "force.h" diff --git a/src/pair_dpd.cpp b/src/pair_dpd.cpp index e5e6cf7dae..ec65eaafd6 100644 --- a/src/pair_dpd.cpp +++ b/src/pair_dpd.cpp @@ -15,9 +15,9 @@ Contributing author: Kurt Smith (U Pittsburgh) ------------------------------------------------------------------------- */ +#include "pair_dpd.h" #include #include -#include "pair_dpd.h" #include "atom.h" #include "comm.h" #include "update.h" diff --git a/src/pair_dpd_tstat.cpp b/src/pair_dpd_tstat.cpp index 66c8d91ab1..15d7c90b27 100644 --- a/src/pair_dpd_tstat.cpp +++ b/src/pair_dpd_tstat.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_dpd_tstat.h" #include #include -#include "pair_dpd_tstat.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/pair_gauss.cpp b/src/pair_gauss.cpp index 7df9a417c3..7fd3233f4c 100644 --- a/src/pair_gauss.cpp +++ b/src/pair_gauss.cpp @@ -15,10 +15,10 @@ Contributing author: Sai Jayaraman (Sandia) ------------------------------------------------------------------------- */ +#include "pair_gauss.h" #include #include #include -#include "pair_gauss.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index daeee3d2b3..762b9fe8fc 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -12,10 +12,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_hybrid.h" #include #include #include -#include "pair_hybrid.h" #include "atom.h" #include "force.h" #include "pair.h" diff --git a/src/pair_hybrid_overlay.cpp b/src/pair_hybrid_overlay.cpp index 496e3d0406..e67cb677af 100644 --- a/src/pair_hybrid_overlay.cpp +++ b/src/pair_hybrid_overlay.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_hybrid_overlay.h" #include #include -#include "pair_hybrid_overlay.h" #include "atom.h" #include "force.h" #include "error.h" diff --git a/src/pair_lj96_cut.cpp b/src/pair_lj96_cut.cpp index 62e645ef2c..c27038900d 100644 --- a/src/pair_lj96_cut.cpp +++ b/src/pair_lj96_cut.cpp @@ -15,10 +15,10 @@ Contributing author: Chuanfu Luo (luochuanfu@gmail.com) ------------------------------------------------------------------------- */ +#include "pair_lj96_cut.h" #include #include #include -#include "pair_lj96_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_cubic.cpp b/src/pair_lj_cubic.cpp index 8b1b4b7627..7990952494 100644 --- a/src/pair_lj_cubic.cpp +++ b/src/pair_lj_cubic.cpp @@ -16,9 +16,9 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cubic.h" #include #include -#include "pair_lj_cubic.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_cut.cpp b/src/pair_lj_cut.cpp index 9284923218..0302858adb 100644 --- a/src/pair_lj_cut.cpp +++ b/src/pair_lj_cut.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut.h" #include #include #include -#include "pair_lj_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_cut_coul_cut.cpp b/src/pair_lj_cut_coul_cut.cpp index 9ffa02156e..d4640bee3a 100644 --- a/src/pair_lj_cut_coul_cut.cpp +++ b/src/pair_lj_cut_coul_cut.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_cut.h" #include #include #include -#include "pair_lj_cut_coul_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_cut_coul_debye.cpp b/src/pair_lj_cut_coul_debye.cpp index ab6220bd24..4ef533a743 100644 --- a/src/pair_lj_cut_coul_debye.cpp +++ b/src/pair_lj_cut_coul_debye.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_debye.h" #include #include -#include "pair_lj_cut_coul_debye.h" #include "atom.h" #include "neigh_list.h" #include "force.h" diff --git a/src/pair_lj_cut_coul_wolf.cpp b/src/pair_lj_cut_coul_wolf.cpp index 55aff0d7c5..fb641f7d24 100644 --- a/src/pair_lj_cut_coul_wolf.cpp +++ b/src/pair_lj_cut_coul_wolf.cpp @@ -15,11 +15,11 @@ Contributing author: Vishal Boddu (FAU) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_wolf.h" #include #include #include #include -#include "pair_lj_cut_coul_wolf.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_expand.cpp b/src/pair_lj_expand.cpp index d5c0a40f2d..60593fd01d 100644 --- a/src/pair_lj_expand.cpp +++ b/src/pair_lj_expand.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_expand.h" #include #include #include #include -#include "pair_lj_expand.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_gromacs.cpp b/src/pair_lj_gromacs.cpp index 1fdaefebe9..4796c288d7 100644 --- a/src/pair_lj_gromacs.cpp +++ b/src/pair_lj_gromacs.cpp @@ -15,11 +15,11 @@ Contributing author: Mark Stevens (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_gromacs.h" #include #include #include #include -#include "pair_lj_gromacs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_gromacs_coul_gromacs.cpp b/src/pair_lj_gromacs_coul_gromacs.cpp index 28dc8ec79b..45beeb1daf 100644 --- a/src/pair_lj_gromacs_coul_gromacs.cpp +++ b/src/pair_lj_gromacs_coul_gromacs.cpp @@ -15,11 +15,11 @@ Contributing author: Mark Stevens (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_gromacs_coul_gromacs.h" #include #include #include #include -#include "pair_lj_gromacs_coul_gromacs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_smooth.cpp b/src/pair_lj_smooth.cpp index ecacadbffa..d89fee1148 100644 --- a/src/pair_lj_smooth.cpp +++ b/src/pair_lj_smooth.cpp @@ -15,10 +15,10 @@ Contributing author: Craig Maloney (UCSB) ------------------------------------------------------------------------- */ +#include "pair_lj_smooth.h" #include #include #include -#include "pair_lj_smooth.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 265828c4cf..6ed19a452f 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -15,10 +15,10 @@ Contributing author: Jonathan Zimmerman (Sandia) ------------------------------------------------------------------------- */ +#include "pair_lj_smooth_linear.h" #include #include #include -#include "pair_lj_smooth_linear.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_mie_cut.cpp b/src/pair_mie_cut.cpp index 231832dc48..d2b0c20cd5 100644 --- a/src/pair_mie_cut.cpp +++ b/src/pair_mie_cut.cpp @@ -15,11 +15,11 @@ Contributing author: Cassiano Aimoli (aimoli@gmail.com) ------------------------------------------------------------------------- */ +#include "pair_mie_cut.h" #include #include #include #include -#include "pair_mie_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_morse.cpp b/src/pair_morse.cpp index dca1834c14..47102932db 100644 --- a/src/pair_morse.cpp +++ b/src/pair_morse.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_morse.h" #include #include #include #include -#include "pair_morse.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_soft.cpp b/src/pair_soft.cpp index 7602f7b925..f3d7423b04 100644 --- a/src/pair_soft.cpp +++ b/src/pair_soft.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_soft.h" #include #include #include #include -#include "pair_soft.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_table.cpp b/src/pair_table.cpp index b1b6f45eda..63cda78c67 100644 --- a/src/pair_table.cpp +++ b/src/pair_table.cpp @@ -15,11 +15,11 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_table.h" #include #include #include #include -#include "pair_table.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/pair_ufm.cpp b/src/pair_ufm.cpp index 226fb6e7d9..40b72136ff 100644 --- a/src/pair_ufm.cpp +++ b/src/pair_ufm.cpp @@ -17,11 +17,11 @@ Maurice de Koning (Unicamp/Brazil) - dekoning@ifi.unicamp.br ------------------------------------------------------------------------- */ +#include "pair_ufm.h" #include #include #include #include -#include "pair_ufm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_yukawa.cpp b/src/pair_yukawa.cpp index 913afbd5a1..4a2cf23952 100644 --- a/src/pair_yukawa.cpp +++ b/src/pair_yukawa.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_yukawa.h" #include #include -#include "pair_yukawa.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/pair_zbl.cpp b/src/pair_zbl.cpp index 254a82ea64..b01c301785 100644 --- a/src/pair_zbl.cpp +++ b/src/pair_zbl.cpp @@ -15,11 +15,11 @@ Contributing authors: Stephen Foiles, Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "pair_zbl.h" #include #include #include #include -#include "pair_zbl.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_zero.cpp b/src/pair_zero.cpp index 143808f598..2692710e20 100644 --- a/src/pair_zero.cpp +++ b/src/pair_zero.cpp @@ -15,11 +15,11 @@ Contributing author: Carsten Svaneborg (SDU) ------------------------------------------------------------------------- */ +#include "pair_zero.h" #include #include #include #include -#include "pair_zero.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/procmap.cpp b/src/procmap.cpp index 08b60a26af..47afb76da9 100644 --- a/src/procmap.cpp +++ b/src/procmap.cpp @@ -15,8 +15,8 @@ Contributing author (NUMA option) : Mike Brown (ORNL) ------------------------------------------------------------------------- */ -#include #include "procmap.h" +#include #include "universe.h" #include "comm.h" #include "domain.h" diff --git a/src/random_mars.cpp b/src/random_mars.cpp index 464e640eab..9de5290d29 100644 --- a/src/random_mars.cpp +++ b/src/random_mars.cpp @@ -14,8 +14,8 @@ // Marsaglia random number generator // see RANMAR in F James, Comp Phys Comm, 60, 329 (1990) -#include #include "random_mars.h" +#include #include "error.h" using namespace LAMMPS_NS; diff --git a/src/random_park.cpp b/src/random_park.cpp index fc00939bd4..e12e8a3a10 100644 --- a/src/random_park.cpp +++ b/src/random_park.cpp @@ -13,8 +13,8 @@ // Park/Miller RNG -#include #include "random_park.h" +#include #include "error.h" using namespace LAMMPS_NS; diff --git a/src/rcb.cpp b/src/rcb.cpp index 83cdccdf80..b19beae3c5 100644 --- a/src/rcb.cpp +++ b/src/rcb.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "rcb.h" #include #include -#include "rcb.h" #include "irregular.h" #include "memory.h" #include "error.h" diff --git a/src/read_data.cpp b/src/read_data.cpp index e70a526c38..a50d41b498 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -15,13 +15,13 @@ // due to OpenMPI bug which sets INT64_MAX via its mpi.h // before lmptype.h can set flags to insure it is done correctly +#include "read_data.h" #include "lmptype.h" #include #include #include #include #include -#include "read_data.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_ellipsoid.h" diff --git a/src/read_dump.cpp b/src/read_dump.cpp index 395f4c8edd..49f96db680 100644 --- a/src/read_dump.cpp +++ b/src/read_dump.cpp @@ -19,11 +19,11 @@ // due to OpenMPI bug which sets INT64_MAX via its mpi.h // before lmptype.h can set flags to insure it is done correctly +#include "read_dump.h" #include "lmptype.h" #include #include #include -#include "read_dump.h" #include "reader.h" #include "style_reader.h" #include "atom.h" diff --git a/src/read_restart.cpp b/src/read_restart.cpp index 6e156da837..17b313bfa2 100644 --- a/src/read_restart.cpp +++ b/src/read_restart.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "read_restart.h" #include #include #include #include -#include "read_restart.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/reader.cpp b/src/reader.cpp index cf344b37b3..a1fe51f662 100644 --- a/src/reader.cpp +++ b/src/reader.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "reader.h" #include #include -#include "reader.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/reader_native.cpp b/src/reader_native.cpp index 2c60ffdfd4..9e98a95759 100644 --- a/src/reader_native.cpp +++ b/src/reader_native.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "reader_native.h" #include #include -#include "reader_native.h" #include "atom.h" #include "memory.h" #include "error.h" diff --git a/src/reader_xyz.cpp b/src/reader_xyz.cpp index 37d30bd740..fa553dc30f 100644 --- a/src/reader_xyz.cpp +++ b/src/reader_xyz.cpp @@ -15,9 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "reader_xyz.h" #include #include -#include "reader_xyz.h" #include "atom.h" #include "memory.h" #include "error.h" diff --git a/src/region.cpp b/src/region.cpp index 6b49a2819b..0c4bec16e0 100644 --- a/src/region.cpp +++ b/src/region.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region.h" #include #include #include -#include "region.h" #include "update.h" #include "domain.h" #include "lattice.h" diff --git a/src/region_block.cpp b/src/region_block.cpp index e55c481189..bc52fcd7cf 100644 --- a/src/region_block.cpp +++ b/src/region_block.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region_block.h" #include #include -#include "region_block.h" #include "force.h" #include "domain.h" #include "math_extra.h" diff --git a/src/region_cone.cpp b/src/region_cone.cpp index 72f56a268f..345c9fa8e2 100644 --- a/src/region_cone.cpp +++ b/src/region_cone.cpp @@ -15,10 +15,10 @@ Contributing author: Pim Schravendijk ------------------------------------------------------------------------- */ +#include "region_cone.h" #include #include #include -#include "region_cone.h" #include "domain.h" #include "error.h" #include "force.h" diff --git a/src/region_cylinder.cpp b/src/region_cylinder.cpp index 7709c57aab..968453cf37 100644 --- a/src/region_cylinder.cpp +++ b/src/region_cylinder.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region_cylinder.h" #include #include #include -#include "region_cylinder.h" #include "update.h" #include "domain.h" #include "input.h" diff --git a/src/region_deprecated.cpp b/src/region_deprecated.cpp index 87225959fa..a2e4e88393 100644 --- a/src/region_deprecated.cpp +++ b/src/region_deprecated.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "region_deprecated.h" +#include #include "comm.h" #include "error.h" diff --git a/src/region_intersect.cpp b/src/region_intersect.cpp index 96d3bed16c..c6c11cf35c 100644 --- a/src/region_intersect.cpp +++ b/src/region_intersect.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region_intersect.h" #include #include -#include "region_intersect.h" #include "domain.h" #include "error.h" #include "force.h" diff --git a/src/region_plane.cpp b/src/region_plane.cpp index e67a2c85bd..950c0a4b53 100644 --- a/src/region_plane.cpp +++ b/src/region_plane.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region_plane.h" #include #include #include -#include "region_plane.h" #include "error.h" #include "force.h" diff --git a/src/region_prism.cpp b/src/region_prism.cpp index 22fc504c37..38fc23da21 100644 --- a/src/region_prism.cpp +++ b/src/region_prism.cpp @@ -15,10 +15,10 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "region_prism.h" #include #include #include -#include "region_prism.h" #include "domain.h" #include "force.h" #include "math_extra.h" diff --git a/src/region_sphere.cpp b/src/region_sphere.cpp index 8080ef5882..9c478960e3 100644 --- a/src/region_sphere.cpp +++ b/src/region_sphere.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region_sphere.h" #include #include #include -#include "region_sphere.h" #include "update.h" #include "input.h" #include "variable.h" diff --git a/src/region_union.cpp b/src/region_union.cpp index 33ac6fedd7..f4e30f5b94 100644 --- a/src/region_union.cpp +++ b/src/region_union.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region_union.h" #include #include -#include "region_union.h" #include "domain.h" #include "error.h" #include "force.h" diff --git a/src/replicate.cpp b/src/replicate.cpp index 3c8f4a8aee..6f8c94238a 100644 --- a/src/replicate.cpp +++ b/src/replicate.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "replicate.h" #include #include -#include "replicate.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_hybrid.h" diff --git a/src/rerun.cpp b/src/rerun.cpp index 063ea882c2..e75779ccc0 100644 --- a/src/rerun.cpp +++ b/src/rerun.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "rerun.h" #include #include -#include "rerun.h" #include "read_dump.h" #include "domain.h" #include "update.h" diff --git a/src/reset_ids.cpp b/src/reset_ids.cpp index b2cf7a9bbc..b68b7ca797 100644 --- a/src/reset_ids.cpp +++ b/src/reset_ids.cpp @@ -28,7 +28,7 @@ ResetIDs::ResetIDs(LAMMPS *lmp) : Pointers(lmp) {} /* ---------------------------------------------------------------------- */ -void ResetIDs::command(int narg, char **/*arg*/) +void ResetIDs::command(int narg, char ** /* arg */) { if (domain->box_exist == 0) error->all(FLERR,"Reset_ids command before simulation box is defined"); diff --git a/src/respa.cpp b/src/respa.cpp index 6fa9959d78..867662b3c2 100644 --- a/src/respa.cpp +++ b/src/respa.cpp @@ -15,9 +15,9 @@ Contributing authors: Mark Stevens (SNL), Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "respa.h" #include #include -#include "respa.h" #include "neighbor.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/run.cpp b/src/run.cpp index beb71be52c..60861ad3b9 100644 --- a/src/run.cpp +++ b/src/run.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "run.h" #include #include -#include "run.h" #include "domain.h" #include "update.h" #include "force.h" diff --git a/src/set.cpp b/src/set.cpp index 00b2d8a9b0..d34aa7753a 100644 --- a/src/set.cpp +++ b/src/set.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "set.h" #include #include #include #include -#include "set.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_ellipsoid.h" diff --git a/src/special.cpp b/src/special.cpp index 903794c0f6..f8661e238c 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "special.h" #include #include -#include "special.h" #include "atom.h" #include "atom_vec.h" #include "force.h" diff --git a/src/thermo.cpp b/src/thermo.cpp index f4ab7b0779..d267ea260c 100644 --- a/src/thermo.cpp +++ b/src/thermo.cpp @@ -15,12 +15,12 @@ // due to OpenMPI bug which sets INT64_MAX via its mpi.h // before lmptype.h can set flags to insure it is done correctly +#include "thermo.h" #include "lmptype.h" #include #include #include #include -#include "thermo.h" #include "atom.h" #include "update.h" #include "comm.h" diff --git a/src/timer.cpp b/src/timer.cpp index 65cb6ab5d8..0dad8fb756 100644 --- a/src/timer.cpp +++ b/src/timer.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "timer.h" #include #include #include -#include "timer.h" #include "comm.h" #include "error.h" #include "force.h" diff --git a/src/universe.cpp b/src/universe.cpp index f078590103..2a7117da51 100644 --- a/src/universe.cpp +++ b/src/universe.cpp @@ -11,12 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "universe.h" #include #include #include #include #include -#include "universe.h" #include "version.h" #include "error.h" #include "force.h" diff --git a/src/update.cpp b/src/update.cpp index f5e706e354..e83f4d9f72 100644 --- a/src/update.cpp +++ b/src/update.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "update.h" #include #include -#include "update.h" #include "integrate.h" #include "min.h" #include "style_integrate.h" diff --git a/src/utils.cpp b/src/utils.cpp index 8468b22d8c..ea2ab57f6f 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "utils.h" #include #include -#include "utils.h" #include "lammps.h" #include "error.h" diff --git a/src/variable.cpp b/src/variable.cpp index 111fc75a9a..440fb07f95 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -11,13 +11,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "variable.h" #include #include #include #include #include #include -#include "variable.h" #include "universe.h" #include "atom.h" #include "update.h" diff --git a/src/velocity.cpp b/src/velocity.cpp index 95d820cc22..1a03f71128 100644 --- a/src/velocity.cpp +++ b/src/velocity.cpp @@ -11,12 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "velocity.h" #include #include #include #include #include -#include "velocity.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/verlet.cpp b/src/verlet.cpp index fcba248d5f..5ccef36259 100644 --- a/src/verlet.cpp +++ b/src/verlet.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "verlet.h" +#include #include "neighbor.h" #include "domain.h" #include "comm.h" diff --git a/src/write_coeff.cpp b/src/write_coeff.cpp index 9bf54b3c08..08ff964e7c 100644 --- a/src/write_coeff.cpp +++ b/src/write_coeff.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "write_coeff.h" #include #include #include -#include "write_coeff.h" #include "pair.h" #include "bond.h" #include "angle.h" diff --git a/src/write_data.cpp b/src/write_data.cpp index decc92ea8c..b78e701d35 100644 --- a/src/write_data.cpp +++ b/src/write_data.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "write_data.h" #include #include -#include "write_data.h" #include "atom.h" #include "atom_vec.h" #include "group.h" diff --git a/src/write_dump.cpp b/src/write_dump.cpp index 072680a8a5..903f0e0cdd 100644 --- a/src/write_dump.cpp +++ b/src/write_dump.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "write_dump.h" +#include #include "style_dump.h" #include "dump.h" #include "dump_image.h" diff --git a/src/write_restart.cpp b/src/write_restart.cpp index e0e17cd292..5adb39067c 100644 --- a/src/write_restart.cpp +++ b/src/write_restart.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "write_restart.h" #include #include -#include "write_restart.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_hybrid.h" -- GitLab From 5b3a15bd944b0dc6a3b49c0f8d088e6797cfc6db Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 3 Jul 2019 19:44:58 -0400 Subject: [PATCH 172/469] putting implementation header first in package folder sources --- src/ASPHERE/compute_erotate_asphere.cpp | 2 +- src/ASPHERE/compute_temp_asphere.cpp | 2 +- src/ASPHERE/fix_nh_asphere.cpp | 2 +- src/ASPHERE/fix_nph_asphere.cpp | 2 +- src/ASPHERE/fix_npt_asphere.cpp | 2 +- src/ASPHERE/fix_nve_asphere.cpp | 2 +- src/ASPHERE/fix_nve_asphere_noforce.cpp | 2 +- src/ASPHERE/fix_nve_line.cpp | 2 +- src/ASPHERE/fix_nve_tri.cpp | 2 +- src/ASPHERE/fix_nvt_asphere.cpp | 2 +- src/ASPHERE/pair_gayberne.cpp | 2 +- src/ASPHERE/pair_line_lj.cpp | 2 +- src/ASPHERE/pair_resquared.cpp | 2 +- src/ASPHERE/pair_tri_lj.cpp | 2 +- src/BODY/body_nparticle.cpp | 2 +- src/BODY/body_rounded_polygon.cpp | 2 +- src/BODY/body_rounded_polyhedron.cpp | 2 +- src/BODY/compute_body_local.cpp | 2 +- src/BODY/compute_temp_body.cpp | 2 +- src/BODY/fix_nh_body.cpp | 2 +- src/BODY/fix_nph_body.cpp | 2 +- src/BODY/fix_npt_body.cpp | 2 +- src/BODY/fix_nve_body.cpp | 2 +- src/BODY/fix_nvt_body.cpp | 2 +- src/BODY/fix_wall_body_polygon.cpp | 2 +- src/BODY/fix_wall_body_polyhedron.cpp | 2 +- src/BODY/pair_body_nparticle.cpp | 2 +- src/BODY/pair_body_rounded_polygon.cpp | 2 +- src/BODY/pair_body_rounded_polyhedron.cpp | 2 +- src/CLASS2/angle_class2.cpp | 2 +- src/CLASS2/bond_class2.cpp | 2 +- src/CLASS2/dihedral_class2.cpp | 2 +- src/CLASS2/improper_class2.cpp | 2 +- src/CLASS2/pair_lj_class2.cpp | 2 +- src/CLASS2/pair_lj_class2_coul_cut.cpp | 2 +- src/CLASS2/pair_lj_class2_coul_long.cpp | 2 +- src/COLLOID/fix_wall_colloid.cpp | 2 +- src/COLLOID/pair_brownian.cpp | 2 +- src/COLLOID/pair_brownian_poly.cpp | 2 +- src/COLLOID/pair_colloid.cpp | 2 +- src/COLLOID/pair_lubricate.cpp | 2 +- src/COLLOID/pair_lubricateU.cpp | 2 +- src/COLLOID/pair_lubricateU_poly.cpp | 2 +- src/COLLOID/pair_lubricate_poly.cpp | 2 +- src/COLLOID/pair_yukawa_colloid.cpp | 2 +- src/CORESHELL/compute_temp_cs.cpp | 2 +- src/CORESHELL/pair_born_coul_dsf_cs.cpp | 2 +- src/CORESHELL/pair_born_coul_long_cs.cpp | 2 +- src/CORESHELL/pair_born_coul_wolf_cs.cpp | 2 +- src/CORESHELL/pair_buck_coul_long_cs.cpp | 2 +- src/CORESHELL/pair_coul_long_cs.cpp | 2 +- src/CORESHELL/pair_coul_wolf_cs.cpp | 3 +-- src/CORESHELL/pair_lj_cut_coul_long_cs.cpp | 2 +- src/DIPOLE/atom_vec_dipole.cpp | 2 +- src/DIPOLE/pair_lj_cut_dipole_cut.cpp | 2 +- src/DIPOLE/pair_lj_cut_dipole_long.cpp | 2 +- src/DIPOLE/pair_lj_long_dipole_long.cpp | 2 +- src/GPU/fix_gpu.cpp | 2 +- src/GPU/pair_beck_gpu.cpp | 2 +- src/GPU/pair_born_coul_long_cs_gpu.cpp | 2 +- src/GPU/pair_born_coul_long_gpu.cpp | 2 +- src/GPU/pair_born_coul_wolf_cs_gpu.cpp | 2 +- src/GPU/pair_born_coul_wolf_gpu.cpp | 2 +- src/GPU/pair_born_gpu.cpp | 2 +- src/GPU/pair_buck_coul_cut_gpu.cpp | 2 +- src/GPU/pair_buck_coul_long_gpu.cpp | 2 +- src/GPU/pair_buck_gpu.cpp | 2 +- src/GPU/pair_colloid_gpu.cpp | 2 +- src/GPU/pair_coul_cut_gpu.cpp | 2 +- src/GPU/pair_coul_debye_gpu.cpp | 2 +- src/GPU/pair_coul_dsf_gpu.cpp | 2 +- src/GPU/pair_coul_long_cs_gpu.cpp | 2 +- src/GPU/pair_coul_long_gpu.cpp | 2 +- src/GPU/pair_dpd_gpu.cpp | 2 +- src/GPU/pair_dpd_tstat_gpu.cpp | 2 +- src/GPU/pair_eam_alloy_gpu.cpp | 2 +- src/GPU/pair_eam_fs_gpu.cpp | 2 +- src/GPU/pair_eam_gpu.cpp | 2 +- src/GPU/pair_gauss_gpu.cpp | 2 +- src/GPU/pair_gayberne_gpu.cpp | 2 +- src/GPU/pair_lj96_cut_gpu.cpp | 2 +- src/GPU/pair_lj_charmm_coul_long_gpu.cpp | 2 +- src/GPU/pair_lj_class2_coul_long_gpu.cpp | 2 +- src/GPU/pair_lj_class2_gpu.cpp | 2 +- src/GPU/pair_lj_cubic_gpu.cpp | 2 +- src/GPU/pair_lj_cut_coul_cut_gpu.cpp | 2 +- src/GPU/pair_lj_cut_coul_debye_gpu.cpp | 2 +- src/GPU/pair_lj_cut_coul_dsf_gpu.cpp | 2 +- src/GPU/pair_lj_cut_coul_long_gpu.cpp | 2 +- src/GPU/pair_lj_cut_coul_msm_gpu.cpp | 2 +- src/GPU/pair_lj_cut_dipole_cut_gpu.cpp | 2 +- src/GPU/pair_lj_cut_dipole_long_gpu.cpp | 2 +- src/GPU/pair_lj_cut_gpu.cpp | 2 +- src/GPU/pair_lj_expand_coul_long_gpu.cpp | 2 +- src/GPU/pair_lj_expand_gpu.cpp | 2 +- src/GPU/pair_lj_gromacs_gpu.cpp | 2 +- src/GPU/pair_lj_sdk_coul_long_gpu.cpp | 2 +- src/GPU/pair_lj_sdk_gpu.cpp | 2 +- src/GPU/pair_lj_sf_dipole_sf_gpu.cpp | 2 +- src/GPU/pair_mie_cut_gpu.cpp | 2 +- src/GPU/pair_morse_gpu.cpp | 2 +- src/GPU/pair_resquared_gpu.cpp | 2 +- src/GPU/pair_soft_gpu.cpp | 2 +- src/GPU/pair_sw_gpu.cpp | 2 +- src/GPU/pair_table_gpu.cpp | 2 +- src/GPU/pair_tersoff_gpu.cpp | 2 +- src/GPU/pair_tersoff_mod_gpu.cpp | 2 +- src/GPU/pair_tersoff_zbl_gpu.cpp | 2 +- src/GPU/pair_ufm_gpu.cpp | 2 +- src/GPU/pair_vashishta_gpu.cpp | 3 ++- src/GPU/pair_yukawa_colloid_gpu.cpp | 2 +- src/GPU/pair_yukawa_gpu.cpp | 2 +- src/GPU/pair_zbl_gpu.cpp | 2 +- src/GPU/pppm_gpu.cpp | 2 +- src/GRANULAR/fix_freeze.cpp | 2 +- src/GRANULAR/fix_pour.cpp | 2 +- src/GRANULAR/fix_wall_gran.cpp | 2 +- src/GRANULAR/fix_wall_gran_region.cpp | 2 +- src/GRANULAR/pair_gran_hertz_history.cpp | 2 +- src/GRANULAR/pair_gran_hooke.cpp | 2 +- src/GRANULAR/pair_gran_hooke_history.cpp | 2 +- src/GRANULAR/pair_granular.cpp | 2 +- src/KIM/kim_query.cpp | 2 +- src/KIM/pair_kim.cpp | 4 +--- src/KOKKOS/angle_charmm_kokkos.cpp | 2 +- src/KOKKOS/angle_class2_kokkos.cpp | 2 +- src/KOKKOS/angle_cosine_kokkos.cpp | 2 +- src/KOKKOS/angle_harmonic_kokkos.cpp | 2 +- src/KOKKOS/atom_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_angle_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_atomic_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_bond_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_charge_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_dpd_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_full_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_hybrid_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_molecular_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_sphere_kokkos.cpp | 2 +- src/KOKKOS/bond_class2_kokkos.cpp | 2 +- src/KOKKOS/bond_fene_kokkos.cpp | 2 +- src/KOKKOS/bond_harmonic_kokkos.cpp | 2 +- src/KOKKOS/comm_tiled_kokkos.cpp | 2 +- src/KOKKOS/compute_temp_kokkos.cpp | 2 +- src/KOKKOS/dihedral_charmm_kokkos.cpp | 2 +- src/KOKKOS/dihedral_class2_kokkos.cpp | 2 +- src/KOKKOS/dihedral_opls_kokkos.cpp | 2 +- src/KOKKOS/fix_deform_kokkos.cpp | 2 +- src/KOKKOS/fix_dpd_energy_kokkos.cpp | 2 +- src/KOKKOS/fix_enforce2d_kokkos.cpp | 2 +- src/KOKKOS/fix_eos_table_rx_kokkos.cpp | 2 +- src/KOKKOS/fix_langevin_kokkos.cpp | 2 +- src/KOKKOS/fix_momentum_kokkos.cpp | 2 +- src/KOKKOS/fix_nh_kokkos.cpp | 2 +- src/KOKKOS/fix_nph_kokkos.cpp | 2 +- src/KOKKOS/fix_npt_kokkos.cpp | 2 +- src/KOKKOS/fix_nve_kokkos.cpp | 2 +- src/KOKKOS/fix_nvt_kokkos.cpp | 2 +- src/KOKKOS/fix_property_atom_kokkos.cpp | 2 +- src/KOKKOS/fix_qeq_reax_kokkos.cpp | 2 +- src/KOKKOS/fix_reaxc_bonds_kokkos.cpp | 2 +- src/KOKKOS/fix_reaxc_species_kokkos.cpp | 2 +- src/KOKKOS/fix_rx_kokkos.cpp | 2 +- src/KOKKOS/fix_setforce_kokkos.cpp | 2 +- src/KOKKOS/fix_shardlow_kokkos.cpp | 2 +- src/KOKKOS/fix_wall_lj93_kokkos.cpp | 2 +- src/KOKKOS/fix_wall_reflect_kokkos.cpp | 2 +- src/KOKKOS/gridcomm_kokkos.cpp | 2 +- src/KOKKOS/improper_class2_kokkos.cpp | 2 +- src/KOKKOS/improper_harmonic_kokkos.cpp | 2 +- src/KOKKOS/kokkos.cpp | 2 +- src/KOKKOS/math_special_kokkos.cpp | 2 +- src/KOKKOS/pair_buck_coul_cut_kokkos.cpp | 2 +- src/KOKKOS/pair_buck_coul_long_kokkos.cpp | 2 +- src/KOKKOS/pair_buck_kokkos.cpp | 2 +- src/KOKKOS/pair_coul_cut_kokkos.cpp | 2 +- src/KOKKOS/pair_coul_debye_kokkos.cpp | 2 +- src/KOKKOS/pair_coul_dsf_kokkos.cpp | 2 +- src/KOKKOS/pair_coul_long_kokkos.cpp | 2 +- src/KOKKOS/pair_coul_wolf_kokkos.cpp | 2 +- src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp | 3 +-- src/KOKKOS/pair_eam_alloy_kokkos.cpp | 2 +- src/KOKKOS/pair_eam_fs_kokkos.cpp | 2 +- src/KOKKOS/pair_eam_kokkos.cpp | 2 +- src/KOKKOS/pair_exp6_rx_kokkos.cpp | 2 +- src/KOKKOS/pair_hybrid_kokkos.cpp | 2 +- src/KOKKOS/pair_hybrid_overlay_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_class2_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_cut_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_expand_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_gromacs_kokkos.cpp | 2 +- src/KOKKOS/pair_lj_sdk_kokkos.cpp | 2 +- src/KOKKOS/pair_morse_kokkos.cpp | 2 +- src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp | 4 ++-- src/KOKKOS/pair_reaxc_kokkos.cpp | 2 +- src/KOKKOS/pair_sw_kokkos.cpp | 2 +- src/KOKKOS/pair_table_kokkos.cpp | 2 +- src/KOKKOS/pair_table_rx_kokkos.cpp | 2 +- src/KOKKOS/pair_tersoff_kokkos.cpp | 2 +- src/KOKKOS/pair_tersoff_mod_kokkos.cpp | 2 +- src/KOKKOS/pair_tersoff_zbl_kokkos.cpp | 2 +- src/KOKKOS/pair_vashishta_kokkos.cpp | 2 +- src/KOKKOS/pair_yukawa_kokkos.cpp | 3 ++- src/KOKKOS/pair_zbl_kokkos.cpp | 2 +- src/KOKKOS/pppm_kokkos.cpp | 2 +- src/KOKKOS/rand_pool_wrap_kokkos.cpp | 2 +- src/KOKKOS/region_block_kokkos.cpp | 2 +- src/KOKKOS/verlet_kokkos.cpp | 2 +- src/KSPACE/ewald.cpp | 2 +- src/KSPACE/ewald_dipole.cpp | 2 +- src/KSPACE/ewald_dipole_spin.cpp | 2 +- src/KSPACE/ewald_disp.cpp | 2 +- src/KSPACE/fft3d.cpp | 2 +- src/KSPACE/fft3d_wrap.cpp | 2 +- src/KSPACE/fix_tune_kspace.cpp | 2 +- src/KSPACE/gridcomm.cpp | 2 +- src/KSPACE/msm.cpp | 2 +- src/KSPACE/msm_cg.cpp | 2 +- src/KSPACE/pair_born_coul_long.cpp | 2 +- src/KSPACE/pair_born_coul_msm.cpp | 2 +- src/KSPACE/pair_buck_coul_long.cpp | 2 +- src/KSPACE/pair_buck_coul_msm.cpp | 2 +- src/KSPACE/pair_buck_long_coul_long.cpp | 2 +- src/KSPACE/pair_coul_long.cpp | 2 +- src/KSPACE/pair_coul_msm.cpp | 2 +- src/KSPACE/pair_lj_charmm_coul_long.cpp | 2 +- src/KSPACE/pair_lj_charmm_coul_msm.cpp | 2 +- src/KSPACE/pair_lj_charmmfsw_coul_long.cpp | 2 +- src/KSPACE/pair_lj_cut_coul_long.cpp | 2 +- src/KSPACE/pair_lj_cut_coul_msm.cpp | 2 +- src/KSPACE/pair_lj_cut_tip4p_long.cpp | 2 +- src/KSPACE/pair_lj_long_coul_long.cpp | 2 +- src/KSPACE/pair_lj_long_tip4p_long.cpp | 2 +- src/KSPACE/pair_tip4p_long.cpp | 2 +- src/KSPACE/pppm.cpp | 2 +- src/KSPACE/pppm_cg.cpp | 4 +--- src/KSPACE/pppm_dipole.cpp | 2 +- src/KSPACE/pppm_dipole_spin.cpp | 2 +- src/KSPACE/pppm_disp.cpp | 2 +- src/KSPACE/pppm_disp_tip4p.cpp | 2 +- src/KSPACE/pppm_stagger.cpp | 2 +- src/KSPACE/pppm_tip4p.cpp | 2 +- src/KSPACE/remap.cpp | 2 +- src/KSPACE/remap_wrap.cpp | 2 +- 253 files changed, 256 insertions(+), 260 deletions(-) diff --git a/src/ASPHERE/compute_erotate_asphere.cpp b/src/ASPHERE/compute_erotate_asphere.cpp index afec2a9b28..665506acdf 100644 --- a/src/ASPHERE/compute_erotate_asphere.cpp +++ b/src/ASPHERE/compute_erotate_asphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_erotate_asphere.h" +#include #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/ASPHERE/compute_temp_asphere.cpp b/src/ASPHERE/compute_temp_asphere.cpp index 011d8cae80..32773b2925 100644 --- a/src/ASPHERE/compute_temp_asphere.cpp +++ b/src/ASPHERE/compute_temp_asphere.cpp @@ -15,9 +15,9 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "compute_temp_asphere.h" #include #include -#include "compute_temp_asphere.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/ASPHERE/fix_nh_asphere.cpp b/src/ASPHERE/fix_nh_asphere.cpp index 828c064a52..9e8e9d73d9 100644 --- a/src/ASPHERE/fix_nh_asphere.cpp +++ b/src/ASPHERE/fix_nh_asphere.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "fix_nh_asphere.h" #include #include #include #include "math_extra.h" -#include "fix_nh_asphere.h" #include "atom.h" #include "atom_vec_ellipsoid.h" #include "group.h" diff --git a/src/ASPHERE/fix_nph_asphere.cpp b/src/ASPHERE/fix_nph_asphere.cpp index 5f201a8463..70880701ca 100644 --- a/src/ASPHERE/fix_nph_asphere.cpp +++ b/src/ASPHERE/fix_nph_asphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nph_asphere.h" +#include #include "modify.h" #include "error.h" diff --git a/src/ASPHERE/fix_npt_asphere.cpp b/src/ASPHERE/fix_npt_asphere.cpp index 5d52891169..26d4fff81d 100644 --- a/src/ASPHERE/fix_npt_asphere.cpp +++ b/src/ASPHERE/fix_npt_asphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_npt_asphere.h" +#include #include "modify.h" #include "error.h" diff --git a/src/ASPHERE/fix_nve_asphere.cpp b/src/ASPHERE/fix_nve_asphere.cpp index 61e3c35293..05219e442f 100644 --- a/src/ASPHERE/fix_nve_asphere.cpp +++ b/src/ASPHERE/fix_nve_asphere.cpp @@ -15,10 +15,10 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "fix_nve_asphere.h" #include #include #include -#include "fix_nve_asphere.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/ASPHERE/fix_nve_asphere_noforce.cpp b/src/ASPHERE/fix_nve_asphere_noforce.cpp index 9cc430592a..015cc8cfb6 100644 --- a/src/ASPHERE/fix_nve_asphere_noforce.cpp +++ b/src/ASPHERE/fix_nve_asphere_noforce.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nve_asphere_noforce.h" #include #include #include -#include "fix_nve_asphere_noforce.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/ASPHERE/fix_nve_line.cpp b/src/ASPHERE/fix_nve_line.cpp index 51a502df89..57335f22e0 100644 --- a/src/ASPHERE/fix_nve_line.cpp +++ b/src/ASPHERE/fix_nve_line.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nve_line.h" #include #include #include -#include "fix_nve_line.h" #include "atom.h" #include "atom_vec_line.h" #include "domain.h" diff --git a/src/ASPHERE/fix_nve_tri.cpp b/src/ASPHERE/fix_nve_tri.cpp index fb9bf64c58..b1f7667d06 100644 --- a/src/ASPHERE/fix_nve_tri.cpp +++ b/src/ASPHERE/fix_nve_tri.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nve_tri.h" #include #include #include -#include "fix_nve_tri.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_tri.h" diff --git a/src/ASPHERE/fix_nvt_asphere.cpp b/src/ASPHERE/fix_nvt_asphere.cpp index 5ef91923eb..597fb03514 100644 --- a/src/ASPHERE/fix_nvt_asphere.cpp +++ b/src/ASPHERE/fix_nvt_asphere.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nvt_asphere.h" +#include #include "group.h" #include "modify.h" #include "error.h" diff --git a/src/ASPHERE/pair_gayberne.cpp b/src/ASPHERE/pair_gayberne.cpp index 3d4ed3f183..7dbf11c5ea 100644 --- a/src/ASPHERE/pair_gayberne.cpp +++ b/src/ASPHERE/pair_gayberne.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_gayberne.h" #include #include #include #include -#include "pair_gayberne.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/ASPHERE/pair_line_lj.cpp b/src/ASPHERE/pair_line_lj.cpp index 4873b44dc4..0cb603c4fa 100644 --- a/src/ASPHERE/pair_line_lj.cpp +++ b/src/ASPHERE/pair_line_lj.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_line_lj.h" #include #include #include #include -#include "pair_line_lj.h" #include "atom.h" #include "atom_vec_line.h" #include "force.h" diff --git a/src/ASPHERE/pair_resquared.cpp b/src/ASPHERE/pair_resquared.cpp index b100a5f184..ba73c5ba0c 100644 --- a/src/ASPHERE/pair_resquared.cpp +++ b/src/ASPHERE/pair_resquared.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_resquared.h" #include #include #include #include -#include "pair_resquared.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/ASPHERE/pair_tri_lj.cpp b/src/ASPHERE/pair_tri_lj.cpp index cefd73f976..3dde2a4f44 100644 --- a/src/ASPHERE/pair_tri_lj.cpp +++ b/src/ASPHERE/pair_tri_lj.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_tri_lj.h" #include #include #include #include -#include "pair_tri_lj.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_tri.h" diff --git a/src/BODY/body_nparticle.cpp b/src/BODY/body_nparticle.cpp index b2d9dbaca3..353ce5550c 100644 --- a/src/BODY/body_nparticle.cpp +++ b/src/BODY/body_nparticle.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "body_nparticle.h" #include #include -#include "body_nparticle.h" #include "my_pool_chunk.h" #include "math_extra.h" #include "atom_vec_body.h" diff --git a/src/BODY/body_rounded_polygon.cpp b/src/BODY/body_rounded_polygon.cpp index 6e1e49319e..21f1d7e221 100644 --- a/src/BODY/body_rounded_polygon.cpp +++ b/src/BODY/body_rounded_polygon.cpp @@ -15,9 +15,9 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "body_rounded_polygon.h" #include #include -#include "body_rounded_polygon.h" #include "my_pool_chunk.h" #include "atom_vec_body.h" #include "atom.h" diff --git a/src/BODY/body_rounded_polyhedron.cpp b/src/BODY/body_rounded_polyhedron.cpp index 4b5208c397..15e1871e02 100644 --- a/src/BODY/body_rounded_polyhedron.cpp +++ b/src/BODY/body_rounded_polyhedron.cpp @@ -15,9 +15,9 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "body_rounded_polyhedron.h" #include #include -#include "body_rounded_polyhedron.h" #include "my_pool_chunk.h" #include "atom_vec_body.h" #include "atom.h" diff --git a/src/BODY/compute_body_local.cpp b/src/BODY/compute_body_local.cpp index 20f7d76708..f58b66c2ca 100644 --- a/src/BODY/compute_body_local.cpp +++ b/src/BODY/compute_body_local.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_body_local.h" #include #include -#include "compute_body_local.h" #include "atom.h" #include "atom_vec_body.h" #include "body.h" diff --git a/src/BODY/compute_temp_body.cpp b/src/BODY/compute_temp_body.cpp index 5446fb6d64..7beca36df8 100644 --- a/src/BODY/compute_temp_body.cpp +++ b/src/BODY/compute_temp_body.cpp @@ -16,9 +16,9 @@ based on ComputeTempAsphere ------------------------------------------------------------------------- */ +#include "compute_temp_body.h" #include #include -#include "compute_temp_body.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" diff --git a/src/BODY/fix_nh_body.cpp b/src/BODY/fix_nh_body.cpp index 9739842419..6064f1f9de 100644 --- a/src/BODY/fix_nh_body.cpp +++ b/src/BODY/fix_nh_body.cpp @@ -16,11 +16,11 @@ based on FixNHAsphere ------------------------------------------------------------------------- */ +#include "fix_nh_body.h" #include #include #include #include "math_extra.h" -#include "fix_nh_body.h" #include "atom.h" #include "atom_vec_body.h" #include "group.h" diff --git a/src/BODY/fix_nph_body.cpp b/src/BODY/fix_nph_body.cpp index e647488bce..a65c951c96 100644 --- a/src/BODY/fix_nph_body.cpp +++ b/src/BODY/fix_nph_body.cpp @@ -15,8 +15,8 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ -#include #include "fix_nph_body.h" +#include #include "modify.h" #include "error.h" diff --git a/src/BODY/fix_npt_body.cpp b/src/BODY/fix_npt_body.cpp index 3c30e9e4e9..7e8097486e 100644 --- a/src/BODY/fix_npt_body.cpp +++ b/src/BODY/fix_npt_body.cpp @@ -15,8 +15,8 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ -#include #include "fix_npt_body.h" +#include #include "modify.h" #include "error.h" diff --git a/src/BODY/fix_nve_body.cpp b/src/BODY/fix_nve_body.cpp index 0c74facf34..3f3bd41cbc 100644 --- a/src/BODY/fix_nve_body.cpp +++ b/src/BODY/fix_nve_body.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nve_body.h" #include #include #include -#include "fix_nve_body.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" diff --git a/src/BODY/fix_nvt_body.cpp b/src/BODY/fix_nvt_body.cpp index 273b5e7fff..efb05143a1 100644 --- a/src/BODY/fix_nvt_body.cpp +++ b/src/BODY/fix_nvt_body.cpp @@ -15,8 +15,8 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ -#include #include "fix_nvt_body.h" +#include #include "group.h" #include "modify.h" #include "error.h" diff --git a/src/BODY/fix_wall_body_polygon.cpp b/src/BODY/fix_wall_body_polygon.cpp index 221937461b..8f27a094cb 100644 --- a/src/BODY/fix_wall_body_polygon.cpp +++ b/src/BODY/fix_wall_body_polygon.cpp @@ -15,10 +15,10 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "fix_wall_body_polygon.h" #include #include #include -#include "fix_wall_body_polygon.h" #include "atom.h" #include "atom_vec_body.h" #include "body_rounded_polygon.h" diff --git a/src/BODY/fix_wall_body_polyhedron.cpp b/src/BODY/fix_wall_body_polyhedron.cpp index 24a9e51dad..37b542803f 100644 --- a/src/BODY/fix_wall_body_polyhedron.cpp +++ b/src/BODY/fix_wall_body_polyhedron.cpp @@ -15,10 +15,10 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "fix_wall_body_polyhedron.h" #include #include #include -#include "fix_wall_body_polyhedron.h" #include "atom.h" #include "atom_vec_body.h" #include "body_rounded_polyhedron.h" diff --git a/src/BODY/pair_body_nparticle.cpp b/src/BODY/pair_body_nparticle.cpp index f2eb2aa520..96a7af6255 100644 --- a/src/BODY/pair_body_nparticle.cpp +++ b/src/BODY/pair_body_nparticle.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_body_nparticle.h" #include #include #include #include -#include "pair_body_nparticle.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" diff --git a/src/BODY/pair_body_rounded_polygon.cpp b/src/BODY/pair_body_rounded_polygon.cpp index 69495ea57f..c818b5a2e6 100644 --- a/src/BODY/pair_body_rounded_polygon.cpp +++ b/src/BODY/pair_body_rounded_polygon.cpp @@ -18,11 +18,11 @@ the contact history for friction forces. ------------------------------------------------------------------------- */ +#include "pair_body_rounded_polygon.h" #include #include #include #include -#include "pair_body_rounded_polygon.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" diff --git a/src/BODY/pair_body_rounded_polyhedron.cpp b/src/BODY/pair_body_rounded_polyhedron.cpp index 60f6df3582..75caab88bd 100644 --- a/src/BODY/pair_body_rounded_polyhedron.cpp +++ b/src/BODY/pair_body_rounded_polyhedron.cpp @@ -20,11 +20,11 @@ the contact history for friction forces. ------------------------------------------------------------------------- */ +#include "pair_body_rounded_polyhedron.h" #include #include #include #include -#include "pair_body_rounded_polyhedron.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" diff --git a/src/CLASS2/angle_class2.cpp b/src/CLASS2/angle_class2.cpp index d550767e5e..340152abd4 100644 --- a/src/CLASS2/angle_class2.cpp +++ b/src/CLASS2/angle_class2.cpp @@ -15,10 +15,10 @@ Contributing author: Eric Simon (Cray) ------------------------------------------------------------------------- */ +#include "angle_class2.h" #include #include #include -#include "angle_class2.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/CLASS2/bond_class2.cpp b/src/CLASS2/bond_class2.cpp index 26c4e63a4d..945555f772 100644 --- a/src/CLASS2/bond_class2.cpp +++ b/src/CLASS2/bond_class2.cpp @@ -15,9 +15,9 @@ Contributing author: Eric Simon (Cray) ------------------------------------------------------------------------- */ +#include "bond_class2.h" #include #include -#include "bond_class2.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/CLASS2/dihedral_class2.cpp b/src/CLASS2/dihedral_class2.cpp index c471b1f353..c36d976525 100644 --- a/src/CLASS2/dihedral_class2.cpp +++ b/src/CLASS2/dihedral_class2.cpp @@ -15,10 +15,10 @@ Contributing author: Eric Simon (Cray) ------------------------------------------------------------------------- */ +#include "dihedral_class2.h" #include #include #include -#include "dihedral_class2.h" #include "atom.h" #include "neighbor.h" #include "update.h" diff --git a/src/CLASS2/improper_class2.cpp b/src/CLASS2/improper_class2.cpp index ccb81aebd9..aff37df318 100644 --- a/src/CLASS2/improper_class2.cpp +++ b/src/CLASS2/improper_class2.cpp @@ -15,10 +15,10 @@ Contributing author: Eric Simon (Cray) ------------------------------------------------------------------------- */ +#include "improper_class2.h" #include #include #include -#include "improper_class2.h" #include "atom.h" #include "neighbor.h" #include "update.h" diff --git a/src/CLASS2/pair_lj_class2.cpp b/src/CLASS2/pair_lj_class2.cpp index 60b988926a..9a67fafecb 100644 --- a/src/CLASS2/pair_lj_class2.cpp +++ b/src/CLASS2/pair_lj_class2.cpp @@ -9,11 +9,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2.h" #include #include #include #include -#include "pair_lj_class2.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CLASS2/pair_lj_class2_coul_cut.cpp b/src/CLASS2/pair_lj_class2_coul_cut.cpp index 8dc038b8fc..24620611c6 100644 --- a/src/CLASS2/pair_lj_class2_coul_cut.cpp +++ b/src/CLASS2/pair_lj_class2_coul_cut.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2_coul_cut.h" #include #include #include #include -#include "pair_lj_class2_coul_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CLASS2/pair_lj_class2_coul_long.cpp b/src/CLASS2/pair_lj_class2_coul_long.cpp index c92c7b78f1..cd11294327 100644 --- a/src/CLASS2/pair_lj_class2_coul_long.cpp +++ b/src/CLASS2/pair_lj_class2_coul_long.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2_coul_long.h" #include #include #include #include -#include "pair_lj_class2_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/COLLOID/fix_wall_colloid.cpp b/src/COLLOID/fix_wall_colloid.cpp index 095d01eef3..f2e895c4f3 100644 --- a/src/COLLOID/fix_wall_colloid.cpp +++ b/src/COLLOID/fix_wall_colloid.cpp @@ -15,9 +15,9 @@ Contributing authors: Jeremy Lechman (SNL) ------------------------------------------------------------------------- */ +#include "fix_wall_colloid.h" #include #include -#include "fix_wall_colloid.h" #include "atom.h" #include "atom_vec.h" #include "update.h" diff --git a/src/COLLOID/pair_brownian.cpp b/src/COLLOID/pair_brownian.cpp index aefa96b1fb..f9185264e0 100644 --- a/src/COLLOID/pair_brownian.cpp +++ b/src/COLLOID/pair_brownian.cpp @@ -15,11 +15,11 @@ Contributing authors: Amit Kumar and Michael Bybee (UIUC) ------------------------------------------------------------------------- */ +#include "pair_brownian.h" #include #include #include #include -#include "pair_brownian.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/COLLOID/pair_brownian_poly.cpp b/src/COLLOID/pair_brownian_poly.cpp index 389ae084b7..250dcef1fd 100644 --- a/src/COLLOID/pair_brownian_poly.cpp +++ b/src/COLLOID/pair_brownian_poly.cpp @@ -16,11 +16,11 @@ Dave Heine (Corning), polydispersity ------------------------------------------------------------------------- */ +#include "pair_brownian_poly.h" #include #include #include #include -#include "pair_brownian_poly.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/COLLOID/pair_colloid.cpp b/src/COLLOID/pair_colloid.cpp index 04c35a7c00..306cdfebdf 100644 --- a/src/COLLOID/pair_colloid.cpp +++ b/src/COLLOID/pair_colloid.cpp @@ -15,11 +15,11 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "pair_colloid.h" #include #include #include #include -#include "pair_colloid.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/COLLOID/pair_lubricate.cpp b/src/COLLOID/pair_lubricate.cpp index 4e629bd442..ee55c6cbf5 100644 --- a/src/COLLOID/pair_lubricate.cpp +++ b/src/COLLOID/pair_lubricate.cpp @@ -16,11 +16,11 @@ Amit Kumar and Michael Bybee (UIUC) ------------------------------------------------------------------------- */ +#include "pair_lubricate.h" #include #include #include #include -#include "pair_lubricate.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/COLLOID/pair_lubricateU.cpp b/src/COLLOID/pair_lubricateU.cpp index 3ea3d4fe4a..be589167c9 100644 --- a/src/COLLOID/pair_lubricateU.cpp +++ b/src/COLLOID/pair_lubricateU.cpp @@ -15,12 +15,12 @@ Contributing authors: Amit Kumar and Michael Bybee (UIUC) ------------------------------------------------------------------------- */ +#include "pair_lubricateU.h" #include #include #include #include #include -#include "pair_lubricateU.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/COLLOID/pair_lubricateU_poly.cpp b/src/COLLOID/pair_lubricateU_poly.cpp index 4fec95dcd8..ebcf939cff 100644 --- a/src/COLLOID/pair_lubricateU_poly.cpp +++ b/src/COLLOID/pair_lubricateU_poly.cpp @@ -17,12 +17,12 @@ Dave Heine (Corning), polydispersity ------------------------------------------------------------------------- */ +#include "pair_lubricateU_poly.h" #include #include #include #include #include -#include "pair_lubricateU_poly.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/COLLOID/pair_lubricate_poly.cpp b/src/COLLOID/pair_lubricate_poly.cpp index ffbe7fce3c..f1bfa0c695 100644 --- a/src/COLLOID/pair_lubricate_poly.cpp +++ b/src/COLLOID/pair_lubricate_poly.cpp @@ -17,11 +17,11 @@ Dave Heine (Corning), polydispersity ------------------------------------------------------------------------- */ +#include "pair_lubricate_poly.h" #include #include #include #include -#include "pair_lubricate_poly.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/COLLOID/pair_yukawa_colloid.cpp b/src/COLLOID/pair_yukawa_colloid.cpp index ab7d088508..98d0586925 100644 --- a/src/COLLOID/pair_yukawa_colloid.cpp +++ b/src/COLLOID/pair_yukawa_colloid.cpp @@ -15,9 +15,9 @@ Contributing authors: Randy Schunk (Sandia) ------------------------------------------------------------------------- */ +#include "pair_yukawa_colloid.h" #include #include -#include "pair_yukawa_colloid.h" #include "atom.h" #include "atom_vec.h" #include "force.h" diff --git a/src/CORESHELL/compute_temp_cs.cpp b/src/CORESHELL/compute_temp_cs.cpp index 03ebfa154d..4217fe3410 100644 --- a/src/CORESHELL/compute_temp_cs.cpp +++ b/src/CORESHELL/compute_temp_cs.cpp @@ -16,11 +16,11 @@ (hendrik.heenen at mytum.com) ------------------------------------------------------------------------- */ +#include "compute_temp_cs.h" #include #include #include #include -#include "compute_temp_cs.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/CORESHELL/pair_born_coul_dsf_cs.cpp b/src/CORESHELL/pair_born_coul_dsf_cs.cpp index f4d7447ade..cd932e560b 100644 --- a/src/CORESHELL/pair_born_coul_dsf_cs.cpp +++ b/src/CORESHELL/pair_born_coul_dsf_cs.cpp @@ -16,11 +16,11 @@ References: Fennell and Gezelter, JCP 124, 234104 (2006) ------------------------------------------------------------------------- */ +#include "pair_born_coul_dsf_cs.h" #include #include #include #include -#include "pair_born_coul_dsf_cs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CORESHELL/pair_born_coul_long_cs.cpp b/src/CORESHELL/pair_born_coul_long_cs.cpp index a19f8c34a8..2ef7fdb273 100644 --- a/src/CORESHELL/pair_born_coul_long_cs.cpp +++ b/src/CORESHELL/pair_born_coul_long_cs.cpp @@ -15,11 +15,11 @@ Contributing author: Hendrik Heenen (hendrik.heenen@mytum.de) ------------------------------------------------------------------------- */ +#include "pair_born_coul_long_cs.h" #include #include #include #include -#include "pair_born_coul_long_cs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CORESHELL/pair_born_coul_wolf_cs.cpp b/src/CORESHELL/pair_born_coul_wolf_cs.cpp index 7b52c28664..c0374e2ddb 100644 --- a/src/CORESHELL/pair_born_coul_wolf_cs.cpp +++ b/src/CORESHELL/pair_born_coul_wolf_cs.cpp @@ -12,11 +12,11 @@ ------------------------------------------------------------------------- */ +#include "pair_born_coul_wolf_cs.h" #include #include #include #include -#include "pair_born_coul_wolf_cs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CORESHELL/pair_buck_coul_long_cs.cpp b/src/CORESHELL/pair_buck_coul_long_cs.cpp index 8df91f39a3..6c897622fa 100644 --- a/src/CORESHELL/pair_buck_coul_long_cs.cpp +++ b/src/CORESHELL/pair_buck_coul_long_cs.cpp @@ -15,11 +15,11 @@ Contributing author: Hendrik Heenen (hendrik.heenen@mytum.de) ------------------------------------------------------------------------- */ +#include "pair_buck_coul_long_cs.h" #include #include #include #include -#include "pair_buck_coul_long_cs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CORESHELL/pair_coul_long_cs.cpp b/src/CORESHELL/pair_coul_long_cs.cpp index c8c8387d6d..6094ae072a 100644 --- a/src/CORESHELL/pair_coul_long_cs.cpp +++ b/src/CORESHELL/pair_coul_long_cs.cpp @@ -15,11 +15,11 @@ Contributing author: Hendrik Heenen (hendrik.heenen@mytum.de) ------------------------------------------------------------------------- */ +#include "pair_coul_long_cs.h" #include #include #include #include -#include "pair_coul_long_cs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CORESHELL/pair_coul_wolf_cs.cpp b/src/CORESHELL/pair_coul_wolf_cs.cpp index 36e037bfc8..40ade7bfe4 100644 --- a/src/CORESHELL/pair_coul_wolf_cs.cpp +++ b/src/CORESHELL/pair_coul_wolf_cs.cpp @@ -11,12 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ - +#include "pair_coul_wolf_cs.h" #include #include #include #include -#include "pair_coul_wolf_cs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp b/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp index 56c75f0f5d..3f20377cf1 100644 --- a/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp +++ b/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp @@ -15,11 +15,11 @@ Contributing author: Hendrik Heenen (hendrik.heenen@mytum.de) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_long_cs.h" #include #include #include #include -#include "pair_lj_cut_coul_long_cs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/DIPOLE/atom_vec_dipole.cpp b/src/DIPOLE/atom_vec_dipole.cpp index c304ae3bc6..67e5aa9e70 100644 --- a/src/DIPOLE/atom_vec_dipole.cpp +++ b/src/DIPOLE/atom_vec_dipole.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_dipole.h" #include #include -#include "atom_vec_dipole.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/DIPOLE/pair_lj_cut_dipole_cut.cpp b/src/DIPOLE/pair_lj_cut_dipole_cut.cpp index 18b78c55e0..44708edec9 100644 --- a/src/DIPOLE/pair_lj_cut_dipole_cut.cpp +++ b/src/DIPOLE/pair_lj_cut_dipole_cut.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_cut_dipole_cut.h" #include #include #include -#include "pair_lj_cut_dipole_cut.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/DIPOLE/pair_lj_cut_dipole_long.cpp b/src/DIPOLE/pair_lj_cut_dipole_long.cpp index 42446a3777..071dbaeb02 100644 --- a/src/DIPOLE/pair_lj_cut_dipole_long.cpp +++ b/src/DIPOLE/pair_lj_cut_dipole_long.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_cut_dipole_long.h" #include #include #include #include -#include "pair_lj_cut_dipole_long.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/DIPOLE/pair_lj_long_dipole_long.cpp b/src/DIPOLE/pair_lj_long_dipole_long.cpp index fbdc47a15b..1391cc1a1a 100644 --- a/src/DIPOLE/pair_lj_long_dipole_long.cpp +++ b/src/DIPOLE/pair_lj_long_dipole_long.cpp @@ -15,13 +15,13 @@ Contributing author: Pieter J. in 't Veld and Stan Moore (Sandia) ------------------------------------------------------------------------- */ +#include "pair_lj_long_dipole_long.h" #include #include #include #include #include "math_const.h" #include "math_vector.h" -#include "pair_lj_long_dipole_long.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/GPU/fix_gpu.cpp b/src/GPU/fix_gpu.cpp index f0558e6a02..d4397503dc 100644 --- a/src/GPU/fix_gpu.cpp +++ b/src/GPU/fix_gpu.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_gpu.h" #include #include -#include "fix_gpu.h" #include "atom.h" #include "force.h" #include "pair.h" diff --git a/src/GPU/pair_beck_gpu.cpp b/src/GPU/pair_beck_gpu.cpp index 9f76975ef1..d4d36a5837 100644 --- a/src/GPU/pair_beck_gpu.cpp +++ b/src/GPU/pair_beck_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_beck_gpu.h" #include #include #include #include -#include "pair_beck_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_born_coul_long_cs_gpu.cpp b/src/GPU/pair_born_coul_long_cs_gpu.cpp index 291ad8ad1f..7314024d71 100644 --- a/src/GPU/pair_born_coul_long_cs_gpu.cpp +++ b/src/GPU/pair_born_coul_long_cs_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (Northwestern) ------------------------------------------------------------------------- */ +#include "pair_born_coul_long_cs_gpu.h" #include #include #include #include -#include "pair_born_coul_long_cs_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_born_coul_long_gpu.cpp b/src/GPU/pair_born_coul_long_gpu.cpp index eb204691c7..79c0d5f147 100644 --- a/src/GPU/pair_born_coul_long_gpu.cpp +++ b/src/GPU/pair_born_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_born_coul_long_gpu.h" #include #include #include #include -#include "pair_born_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_born_coul_wolf_cs_gpu.cpp b/src/GPU/pair_born_coul_wolf_cs_gpu.cpp index 4877a442b5..5f74d3fc7c 100644 --- a/src/GPU/pair_born_coul_wolf_cs_gpu.cpp +++ b/src/GPU/pair_born_coul_wolf_cs_gpu.cpp @@ -15,11 +15,11 @@ Contributing authors: Trung Dac Nguyen (Northwestern) ------------------------------------------------------------------------- */ +#include "pair_born_coul_wolf_cs_gpu.h" #include #include #include #include -#include "pair_born_coul_wolf_cs_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_born_coul_wolf_gpu.cpp b/src/GPU/pair_born_coul_wolf_gpu.cpp index 851174988b..693c2abffb 100644 --- a/src/GPU/pair_born_coul_wolf_gpu.cpp +++ b/src/GPU/pair_born_coul_wolf_gpu.cpp @@ -15,11 +15,11 @@ Contributing authors: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_born_coul_wolf_gpu.h" #include #include #include #include -#include "pair_born_coul_wolf_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_born_gpu.cpp b/src/GPU/pair_born_gpu.cpp index 253d2d7282..e9edc4f1c2 100644 --- a/src/GPU/pair_born_gpu.cpp +++ b/src/GPU/pair_born_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_born_gpu.h" #include #include #include #include -#include "pair_born_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_buck_coul_cut_gpu.cpp b/src/GPU/pair_buck_coul_cut_gpu.cpp index ed602f9cab..182673fb0d 100644 --- a/src/GPU/pair_buck_coul_cut_gpu.cpp +++ b/src/GPU/pair_buck_coul_cut_gpu.cpp @@ -15,11 +15,11 @@ Contributing authors: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_buck_coul_cut_gpu.h" #include #include #include #include -#include "pair_buck_coul_cut_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_buck_coul_long_gpu.cpp b/src/GPU/pair_buck_coul_long_gpu.cpp index d6b9e53282..75e784fafa 100644 --- a/src/GPU/pair_buck_coul_long_gpu.cpp +++ b/src/GPU/pair_buck_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_buck_coul_long_gpu.h" #include #include #include #include -#include "pair_buck_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_buck_gpu.cpp b/src/GPU/pair_buck_gpu.cpp index 8c85407e6e..1559c45b88 100644 --- a/src/GPU/pair_buck_gpu.cpp +++ b/src/GPU/pair_buck_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_buck_gpu.h" #include #include #include #include -#include "pair_buck_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_colloid_gpu.cpp b/src/GPU/pair_colloid_gpu.cpp index 0ee8708b5b..4db18dbc52 100644 --- a/src/GPU/pair_colloid_gpu.cpp +++ b/src/GPU/pair_colloid_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_colloid_gpu.h" #include #include #include #include -#include "pair_colloid_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_coul_cut_gpu.cpp b/src/GPU/pair_coul_cut_gpu.cpp index fb50c446b1..8a3eb12f8d 100644 --- a/src/GPU/pair_coul_cut_gpu.cpp +++ b/src/GPU/pair_coul_cut_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen ------------------------------------------------------------------------- */ +#include "pair_coul_cut_gpu.h" #include #include #include #include -#include "pair_coul_cut_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_coul_debye_gpu.cpp b/src/GPU/pair_coul_debye_gpu.cpp index ec771a9935..1fc07f8dac 100644 --- a/src/GPU/pair_coul_debye_gpu.cpp +++ b/src/GPU/pair_coul_debye_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ndtrung@umich.edu) ------------------------------------------------------------------------- */ +#include "pair_coul_debye_gpu.h" #include #include #include #include -#include "pair_coul_debye_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_coul_dsf_gpu.cpp b/src/GPU/pair_coul_dsf_gpu.cpp index 1753b8a91c..408be036dd 100644 --- a/src/GPU/pair_coul_dsf_gpu.cpp +++ b/src/GPU/pair_coul_dsf_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_coul_dsf_gpu.h" #include #include #include #include -#include "pair_coul_dsf_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_coul_long_cs_gpu.cpp b/src/GPU/pair_coul_long_cs_gpu.cpp index 6ca00d6361..c70424e472 100644 --- a/src/GPU/pair_coul_long_cs_gpu.cpp +++ b/src/GPU/pair_coul_long_cs_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Nguyen (Northwestern) ------------------------------------------------------------------------- */ +#include "pair_coul_long_cs_gpu.h" #include #include #include #include -#include "pair_coul_long_cs_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_coul_long_gpu.cpp b/src/GPU/pair_coul_long_gpu.cpp index f75d10b6dd..9623c25f2f 100644 --- a/src/GPU/pair_coul_long_gpu.cpp +++ b/src/GPU/pair_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Axel Kohlmeyer (Temple) ------------------------------------------------------------------------- */ +#include "pair_coul_long_gpu.h" #include #include #include #include -#include "pair_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_dpd_gpu.cpp b/src/GPU/pair_dpd_gpu.cpp index b1e45fbecd..5fcad6a350 100644 --- a/src/GPU/pair_dpd_gpu.cpp +++ b/src/GPU/pair_dpd_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_dpd_gpu.h" #include #include #include #include -#include "pair_dpd_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_dpd_tstat_gpu.cpp b/src/GPU/pair_dpd_tstat_gpu.cpp index 0693a27344..2d6798a12d 100644 --- a/src/GPU/pair_dpd_tstat_gpu.cpp +++ b/src/GPU/pair_dpd_tstat_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_dpd_tstat_gpu.h" #include #include #include #include -#include "pair_dpd_tstat_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_eam_alloy_gpu.cpp b/src/GPU/pair_eam_alloy_gpu.cpp index 9b3412d3d1..bc55c66676 100644 --- a/src/GPU/pair_eam_alloy_gpu.cpp +++ b/src/GPU/pair_eam_alloy_gpu.cpp @@ -15,10 +15,10 @@ Contributing authors: Trung Dac Nguyen (ORNL), W. Michael Brown (ORNL) ------------------------------------------------------------------------- */ +#include "pair_eam_alloy_gpu.h" #include #include #include -#include "pair_eam_alloy_gpu.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/GPU/pair_eam_fs_gpu.cpp b/src/GPU/pair_eam_fs_gpu.cpp index 11ef28af3e..ac379a9ce6 100644 --- a/src/GPU/pair_eam_fs_gpu.cpp +++ b/src/GPU/pair_eam_fs_gpu.cpp @@ -15,10 +15,10 @@ Contributing authors: Trung Dac Nguyen (ORNL), W. Michael Brown (ORNL) ------------------------------------------------------------------------- */ +#include "pair_eam_fs_gpu.h" #include #include #include -#include "pair_eam_fs_gpu.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/GPU/pair_eam_gpu.cpp b/src/GPU/pair_eam_gpu.cpp index 4788a72417..57106f48a4 100644 --- a/src/GPU/pair_eam_gpu.cpp +++ b/src/GPU/pair_eam_gpu.cpp @@ -15,11 +15,11 @@ Contributing authors: Trung Dac Nguyen (ORNL), W. Michael Brown (ORNL) ------------------------------------------------------------------------- */ +#include "pair_eam_gpu.h" #include #include #include #include -#include "pair_eam_gpu.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/GPU/pair_gauss_gpu.cpp b/src/GPU/pair_gauss_gpu.cpp index c596a9d644..842b84acf2 100644 --- a/src/GPU/pair_gauss_gpu.cpp +++ b/src/GPU/pair_gauss_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_gauss_gpu.h" #include #include #include #include -#include "pair_gauss_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_gayberne_gpu.cpp b/src/GPU/pair_gayberne_gpu.cpp index 4ed2750e57..f00accda15 100644 --- a/src/GPU/pair_gayberne_gpu.cpp +++ b/src/GPU/pair_gayberne_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_gayberne_gpu.h" #include #include #include #include -#include "pair_gayberne_gpu.h" #include "math_extra.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/GPU/pair_lj96_cut_gpu.cpp b/src/GPU/pair_lj96_cut_gpu.cpp index 5bc30c809d..16b6b835c0 100644 --- a/src/GPU/pair_lj96_cut_gpu.cpp +++ b/src/GPU/pair_lj96_cut_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj96_cut_gpu.h" #include #include #include #include -#include "pair_lj96_cut_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_charmm_coul_long_gpu.cpp b/src/GPU/pair_lj_charmm_coul_long_gpu.cpp index 134295c69f..bacbb400b1 100644 --- a/src/GPU/pair_lj_charmm_coul_long_gpu.cpp +++ b/src/GPU/pair_lj_charmm_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_long_gpu.h" #include #include #include #include -#include "pair_lj_charmm_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_class2_coul_long_gpu.cpp b/src/GPU/pair_lj_class2_coul_long_gpu.cpp index fdffb06a8d..e34dbb0f99 100644 --- a/src/GPU/pair_lj_class2_coul_long_gpu.cpp +++ b/src/GPU/pair_lj_class2_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_class2_coul_long_gpu.h" #include #include #include #include -#include "pair_lj_class2_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_class2_gpu.cpp b/src/GPU/pair_lj_class2_gpu.cpp index bbb9168169..68f27598f3 100644 --- a/src/GPU/pair_lj_class2_gpu.cpp +++ b/src/GPU/pair_lj_class2_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_class2_gpu.h" #include #include #include #include -#include "pair_lj_class2_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cubic_gpu.cpp b/src/GPU/pair_lj_cubic_gpu.cpp index 95eee6ae8f..542de37840 100644 --- a/src/GPU/pair_lj_cubic_gpu.cpp +++ b/src/GPU/pair_lj_cubic_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "pair_lj_cubic_gpu.h" #include #include #include #include -#include "pair_lj_cubic_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_coul_cut_gpu.cpp b/src/GPU/pair_lj_cut_coul_cut_gpu.cpp index 69fefbcdea..cf3dd711dc 100644 --- a/src/GPU/pair_lj_cut_coul_cut_gpu.cpp +++ b/src/GPU/pair_lj_cut_coul_cut_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_cut_gpu.h" #include #include #include #include -#include "pair_lj_cut_coul_cut_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_coul_debye_gpu.cpp b/src/GPU/pair_lj_cut_coul_debye_gpu.cpp index de86c58647..20354e732c 100644 --- a/src/GPU/pair_lj_cut_coul_debye_gpu.cpp +++ b/src/GPU/pair_lj_cut_coul_debye_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_debye_gpu.h" #include #include #include #include -#include "pair_lj_cut_coul_debye_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_coul_dsf_gpu.cpp b/src/GPU/pair_lj_cut_coul_dsf_gpu.cpp index 87eac52749..ccaf86efa6 100644 --- a/src/GPU/pair_lj_cut_coul_dsf_gpu.cpp +++ b/src/GPU/pair_lj_cut_coul_dsf_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_dsf_gpu.h" #include #include #include #include -#include "pair_lj_cut_coul_dsf_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_coul_long_gpu.cpp b/src/GPU/pair_lj_cut_coul_long_gpu.cpp index c854dab83d..36c72f1143 100644 --- a/src/GPU/pair_lj_cut_coul_long_gpu.cpp +++ b/src/GPU/pair_lj_cut_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_long_gpu.h" #include #include #include #include -#include "pair_lj_cut_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_coul_msm_gpu.cpp b/src/GPU/pair_lj_cut_coul_msm_gpu.cpp index f87dc0ec91..79ca90698a 100644 --- a/src/GPU/pair_lj_cut_coul_msm_gpu.cpp +++ b/src/GPU/pair_lj_cut_coul_msm_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_msm_gpu.h" #include #include #include #include -#include "pair_lj_cut_coul_msm_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_dipole_cut_gpu.cpp b/src/GPU/pair_lj_cut_dipole_cut_gpu.cpp index d2c925d950..e2c8b8d686 100644 --- a/src/GPU/pair_lj_cut_dipole_cut_gpu.cpp +++ b/src/GPU/pair_lj_cut_dipole_cut_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_dipole_cut_gpu.h" #include #include #include #include -#include "pair_lj_cut_dipole_cut_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_dipole_long_gpu.cpp b/src/GPU/pair_lj_cut_dipole_long_gpu.cpp index 774ff2fae4..fb76376d34 100644 --- a/src/GPU/pair_lj_cut_dipole_long_gpu.cpp +++ b/src/GPU/pair_lj_cut_dipole_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (Northwestern) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_dipole_long_gpu.h" #include #include #include #include -#include "pair_lj_cut_dipole_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_cut_gpu.cpp b/src/GPU/pair_lj_cut_gpu.cpp index 6dde9689f7..809e5cf05e 100644 --- a/src/GPU/pair_lj_cut_gpu.cpp +++ b/src/GPU/pair_lj_cut_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_gpu.h" #include #include #include #include -#include "pair_lj_cut_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_expand_coul_long_gpu.cpp b/src/GPU/pair_lj_expand_coul_long_gpu.cpp index 31f4fd651c..a530f7ff9a 100644 --- a/src/GPU/pair_lj_expand_coul_long_gpu.cpp +++ b/src/GPU/pair_lj_expand_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Nguyen (Northwestern) ------------------------------------------------------------------------- */ +#include "pair_lj_expand_coul_long_gpu.h" #include #include #include #include -#include "pair_lj_expand_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_expand_gpu.cpp b/src/GPU/pair_lj_expand_gpu.cpp index a2e1cf54e3..86f8a76b52 100644 --- a/src/GPU/pair_lj_expand_gpu.cpp +++ b/src/GPU/pair_lj_expand_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Inderaj Bains (NVIDIA), ibains@nvidia.com ------------------------------------------------------------------------- */ +#include "pair_lj_expand_gpu.h" #include #include #include #include -#include "pair_lj_expand_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_gromacs_gpu.cpp b/src/GPU/pair_lj_gromacs_gpu.cpp index e03f4b2e50..78f8b8b461 100644 --- a/src/GPU/pair_lj_gromacs_gpu.cpp +++ b/src/GPU/pair_lj_gromacs_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_lj_gromacs_gpu.h" #include #include #include #include -#include "pair_lj_gromacs_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_sdk_coul_long_gpu.cpp b/src/GPU/pair_lj_sdk_coul_long_gpu.cpp index f5029df5dc..24ff8a4f28 100644 --- a/src/GPU/pair_lj_sdk_coul_long_gpu.cpp +++ b/src/GPU/pair_lj_sdk_coul_long_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_sdk_coul_long_gpu.h" #include #include #include #include -#include "pair_lj_sdk_coul_long_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_sdk_gpu.cpp b/src/GPU/pair_lj_sdk_gpu.cpp index 4797a34408..2621f49aeb 100644 --- a/src/GPU/pair_lj_sdk_gpu.cpp +++ b/src/GPU/pair_lj_sdk_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_sdk_gpu.h" #include #include #include #include -#include "pair_lj_sdk_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_lj_sf_dipole_sf_gpu.cpp b/src/GPU/pair_lj_sf_dipole_sf_gpu.cpp index dd25a70eee..cf26cdf3b4 100644 --- a/src/GPU/pair_lj_sf_dipole_sf_gpu.cpp +++ b/src/GPU/pair_lj_sf_dipole_sf_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_lj_sf_dipole_sf_gpu.h" #include #include #include #include -#include "pair_lj_sf_dipole_sf_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_mie_cut_gpu.cpp b/src/GPU/pair_mie_cut_gpu.cpp index 838d28033f..f3a384113f 100644 --- a/src/GPU/pair_mie_cut_gpu.cpp +++ b/src/GPU/pair_mie_cut_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_mie_cut_gpu.h" #include #include #include #include -#include "pair_mie_cut_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_morse_gpu.cpp b/src/GPU/pair_morse_gpu.cpp index 1f94643e3a..dcad227045 100644 --- a/src/GPU/pair_morse_gpu.cpp +++ b/src/GPU/pair_morse_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_morse_gpu.h" #include #include #include #include -#include "pair_morse_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_resquared_gpu.cpp b/src/GPU/pair_resquared_gpu.cpp index 5e90f788bf..b12a790c81 100644 --- a/src/GPU/pair_resquared_gpu.cpp +++ b/src/GPU/pair_resquared_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "pair_resquared_gpu.h" #include #include #include #include -#include "pair_resquared_gpu.h" #include "math_extra.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/GPU/pair_soft_gpu.cpp b/src/GPU/pair_soft_gpu.cpp index 42adb02553..0efcb20c8d 100644 --- a/src/GPU/pair_soft_gpu.cpp +++ b/src/GPU/pair_soft_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_soft_gpu.h" #include #include #include #include -#include "pair_soft_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_sw_gpu.cpp b/src/GPU/pair_sw_gpu.cpp index 0cc858e57d..8999cb6c47 100644 --- a/src/GPU/pair_sw_gpu.cpp +++ b/src/GPU/pair_sw_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (ORNL) ------------------------------------------------------------------------- */ +#include "pair_sw_gpu.h" #include #include #include #include -#include "pair_sw_gpu.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/GPU/pair_table_gpu.cpp b/src/GPU/pair_table_gpu.cpp index a0b6562e5e..4432265874 100644 --- a/src/GPU/pair_table_gpu.cpp +++ b/src/GPU/pair_table_gpu.cpp @@ -15,11 +15,11 @@ Contributing authors: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_table_gpu.h" #include #include #include #include -#include "pair_table_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_tersoff_gpu.cpp b/src/GPU/pair_tersoff_gpu.cpp index cd0c5e6693..e0dc021b57 100644 --- a/src/GPU/pair_tersoff_gpu.cpp +++ b/src/GPU/pair_tersoff_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "pair_tersoff_gpu.h" #include #include #include #include -#include "pair_tersoff_gpu.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/GPU/pair_tersoff_mod_gpu.cpp b/src/GPU/pair_tersoff_mod_gpu.cpp index fd55ddc6e6..a17efb55e8 100644 --- a/src/GPU/pair_tersoff_mod_gpu.cpp +++ b/src/GPU/pair_tersoff_mod_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "pair_tersoff_mod_gpu.h" #include #include #include #include -#include "pair_tersoff_mod_gpu.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/GPU/pair_tersoff_zbl_gpu.cpp b/src/GPU/pair_tersoff_zbl_gpu.cpp index d3828962e2..765d25f8e6 100644 --- a/src/GPU/pair_tersoff_zbl_gpu.cpp +++ b/src/GPU/pair_tersoff_zbl_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ndactrung@gmail.com) ------------------------------------------------------------------------- */ +#include "pair_tersoff_zbl_gpu.h" #include #include #include #include -#include "pair_tersoff_zbl_gpu.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/GPU/pair_ufm_gpu.cpp b/src/GPU/pair_ufm_gpu.cpp index 31422b0f4d..97c2eebf24 100644 --- a/src/GPU/pair_ufm_gpu.cpp +++ b/src/GPU/pair_ufm_gpu.cpp @@ -17,11 +17,11 @@ Maurice de Koning (Unicamp/Brazil) - dekoning@ifi.unicamp.br ------------------------------------------------------------------------- */ +#include "pair_ufm_gpu.h" #include #include #include #include -#include "pair_ufm_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_vashishta_gpu.cpp b/src/GPU/pair_vashishta_gpu.cpp index 5539653756..3b74e5685e 100644 --- a/src/GPU/pair_vashishta_gpu.cpp +++ b/src/GPU/pair_vashishta_gpu.cpp @@ -14,11 +14,12 @@ /* ---------------------------------------------------------------------- Contributing author: Anders Hafreager (UiO) ------------------------------------------------------------------------- */ + +#include "pair_vashishta_gpu.h" #include #include #include #include -#include "pair_vashishta_gpu.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/GPU/pair_yukawa_colloid_gpu.cpp b/src/GPU/pair_yukawa_colloid_gpu.cpp index 3645f392a2..51c7e683db 100644 --- a/src/GPU/pair_yukawa_colloid_gpu.cpp +++ b/src/GPU/pair_yukawa_colloid_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_yukawa_colloid_gpu.h" #include #include #include #include -#include "pair_yukawa_colloid_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_yukawa_gpu.cpp b/src/GPU/pair_yukawa_gpu.cpp index 90317fea34..5dc13c7750 100644 --- a/src/GPU/pair_yukawa_gpu.cpp +++ b/src/GPU/pair_yukawa_gpu.cpp @@ -15,11 +15,11 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_yukawa_gpu.h" #include #include #include #include -#include "pair_yukawa_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pair_zbl_gpu.cpp b/src/GPU/pair_zbl_gpu.cpp index 99471cbe90..5e24281145 100644 --- a/src/GPU/pair_zbl_gpu.cpp +++ b/src/GPU/pair_zbl_gpu.cpp @@ -15,12 +15,12 @@ Contributing author: Trung Dac Nguyen (ORNL) ------------------------------------------------------------------------- */ +#include "pair_zbl_gpu.h" #include "lmptype.h" #include #include #include #include -#include "pair_zbl_gpu.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/GPU/pppm_gpu.cpp b/src/GPU/pppm_gpu.cpp index 1bb1a39703..bbb270ff8e 100644 --- a/src/GPU/pppm_gpu.cpp +++ b/src/GPU/pppm_gpu.cpp @@ -15,12 +15,12 @@ Contributing authors: Mike Brown (ORNL), Axel Kohlmeyer (Temple) ------------------------------------------------------------------------- */ +#include "pppm_gpu.h" #include #include #include #include #include -#include "pppm_gpu.h" #include "atom.h" #include "comm.h" #include "gridcomm.h" diff --git a/src/GRANULAR/fix_freeze.cpp b/src/GRANULAR/fix_freeze.cpp index 73c1c9fc11..e2345bdf19 100644 --- a/src/GRANULAR/fix_freeze.cpp +++ b/src/GRANULAR/fix_freeze.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_freeze.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/GRANULAR/fix_pour.cpp b/src/GRANULAR/fix_pour.cpp index 3ffca8db9d..0fe7493127 100644 --- a/src/GRANULAR/fix_pour.cpp +++ b/src/GRANULAR/fix_pour.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_pour.h" #include #include #include -#include "fix_pour.h" #include "atom.h" #include "atom_vec.h" #include "force.h" diff --git a/src/GRANULAR/fix_wall_gran.cpp b/src/GRANULAR/fix_wall_gran.cpp index 8513fc702b..b0fbc0c2b8 100644 --- a/src/GRANULAR/fix_wall_gran.cpp +++ b/src/GRANULAR/fix_wall_gran.cpp @@ -16,10 +16,10 @@ Dan Bolintineanu (SNL) ------------------------------------------------------------------------- */ +#include "fix_wall_gran.h" #include #include #include -#include "fix_wall_gran.h" #include "atom.h" #include "domain.h" #include "update.h" diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index 72798bf7b7..97e889ddcc 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -15,10 +15,10 @@ Contributing authors: Dan Bolintineanu (SNL) ------------------------------------------------------------------------- */ +#include "fix_wall_gran_region.h" #include #include #include -#include "fix_wall_gran_region.h" #include "region.h" #include "atom.h" #include "domain.h" diff --git a/src/GRANULAR/pair_gran_hertz_history.cpp b/src/GRANULAR/pair_gran_hertz_history.cpp index 728491c17a..e303089e56 100644 --- a/src/GRANULAR/pair_gran_hertz_history.cpp +++ b/src/GRANULAR/pair_gran_hertz_history.cpp @@ -15,11 +15,11 @@ Contributing authors: Leo Silbert (SNL), Gary Grest (SNL) ------------------------------------------------------------------------- */ +#include "pair_gran_hertz_history.h" #include #include #include #include -#include "pair_gran_hertz_history.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/GRANULAR/pair_gran_hooke.cpp b/src/GRANULAR/pair_gran_hooke.cpp index cfcc2743ba..a30aa0bb6c 100644 --- a/src/GRANULAR/pair_gran_hooke.cpp +++ b/src/GRANULAR/pair_gran_hooke.cpp @@ -15,10 +15,10 @@ Contributing authors: Leo Silbert (SNL), Gary Grest (SNL) ------------------------------------------------------------------------- */ +#include "pair_gran_hooke.h" #include #include #include -#include "pair_gran_hooke.h" #include "atom.h" #include "force.h" #include "fix.h" diff --git a/src/GRANULAR/pair_gran_hooke_history.cpp b/src/GRANULAR/pair_gran_hooke_history.cpp index 5a78b9d79a..f832fdfac3 100644 --- a/src/GRANULAR/pair_gran_hooke_history.cpp +++ b/src/GRANULAR/pair_gran_hooke_history.cpp @@ -15,11 +15,11 @@ Contributing authors: Leo Silbert (SNL), Gary Grest (SNL) ------------------------------------------------------------------------- */ +#include "pair_gran_hooke_history.h" #include #include #include #include -#include "pair_gran_hooke_history.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 903ed303b0..942587a676 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -16,11 +16,11 @@ See the README file in the top-level LAMMPS directory. Leo Silbert (SNL), Gary Grest (SNL) ----------------------------------------------------------------------- */ +#include "pair_granular.h" #include #include #include #include -#include "pair_granular.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index fedc976110..dce9c8761a 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -55,10 +55,10 @@ Designed for use with the kim-api-2.0.2 (and newer) package ------------------------------------------------------------------------- */ +#include "kim_query.h" #include #include #include -#include "kim_query.h" #include "comm.h" #include "error.h" #include "input.h" diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index a1c13ae81f..e107e4276f 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -53,11 +53,9 @@ Designed for use with the kim-api-2.0.2 (and newer) package ------------------------------------------------------------------------- */ +#include "pair_kim.h" #include #include - -// includes from LAMMPS -#include "pair_kim.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KOKKOS/angle_charmm_kokkos.cpp b/src/KOKKOS/angle_charmm_kokkos.cpp index 0f46c958d6..fd9757aab3 100644 --- a/src/KOKKOS/angle_charmm_kokkos.cpp +++ b/src/KOKKOS/angle_charmm_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "angle_charmm_kokkos.h" #include #include -#include "angle_charmm_kokkos.h" #include "atom_kokkos.h" #include "neighbor_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/angle_class2_kokkos.cpp b/src/KOKKOS/angle_class2_kokkos.cpp index 836714764d..809ce7e7dd 100644 --- a/src/KOKKOS/angle_class2_kokkos.cpp +++ b/src/KOKKOS/angle_class2_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Ray Shan (Materials Design) ------------------------------------------------------------------------- */ +#include "angle_class2_kokkos.h" #include #include -#include "angle_class2_kokkos.h" #include "atom_kokkos.h" #include "neighbor_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/angle_cosine_kokkos.cpp b/src/KOKKOS/angle_cosine_kokkos.cpp index 4a4866948f..da0ff398f1 100644 --- a/src/KOKKOS/angle_cosine_kokkos.cpp +++ b/src/KOKKOS/angle_cosine_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "angle_cosine_kokkos.h" #include #include -#include "angle_cosine_kokkos.h" #include "atom_kokkos.h" #include "neighbor_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/angle_harmonic_kokkos.cpp b/src/KOKKOS/angle_harmonic_kokkos.cpp index dbe705800c..fc274bb894 100644 --- a/src/KOKKOS/angle_harmonic_kokkos.cpp +++ b/src/KOKKOS/angle_harmonic_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "angle_harmonic_kokkos.h" #include #include -#include "angle_harmonic_kokkos.h" #include "atom_kokkos.h" #include "neighbor_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_kokkos.cpp b/src/KOKKOS/atom_kokkos.cpp index 813c5ddbf2..4637a9a21c 100644 --- a/src/KOKKOS/atom_kokkos.cpp +++ b/src/KOKKOS/atom_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_kokkos.h" +#include #include "atom_vec.h" #include "atom_vec_kokkos.h" #include "comm_kokkos.h" diff --git a/src/KOKKOS/atom_vec_angle_kokkos.cpp b/src/KOKKOS/atom_vec_angle_kokkos.cpp index e4f27e733a..3e66d813cf 100644 --- a/src/KOKKOS/atom_vec_angle_kokkos.cpp +++ b/src/KOKKOS/atom_vec_angle_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_angle_kokkos.h" +#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_vec_atomic_kokkos.cpp b/src/KOKKOS/atom_vec_atomic_kokkos.cpp index 95e4ddd72b..27aaa96b6d 100644 --- a/src/KOKKOS/atom_vec_atomic_kokkos.cpp +++ b/src/KOKKOS/atom_vec_atomic_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_atomic_kokkos.h" +#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_vec_bond_kokkos.cpp b/src/KOKKOS/atom_vec_bond_kokkos.cpp index 92311d5d09..ad6d5bd486 100644 --- a/src/KOKKOS/atom_vec_bond_kokkos.cpp +++ b/src/KOKKOS/atom_vec_bond_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_bond_kokkos.h" +#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_vec_charge_kokkos.cpp b/src/KOKKOS/atom_vec_charge_kokkos.cpp index 31a690f521..507e8170c5 100644 --- a/src/KOKKOS/atom_vec_charge_kokkos.cpp +++ b/src/KOKKOS/atom_vec_charge_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_charge_kokkos.h" +#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index 4034efee9e..db857909bf 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_dpd_kokkos.h" +#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_vec_full_kokkos.cpp b/src/KOKKOS/atom_vec_full_kokkos.cpp index 034da88f73..486c4e4c4e 100644 --- a/src/KOKKOS/atom_vec_full_kokkos.cpp +++ b/src/KOKKOS/atom_vec_full_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_full_kokkos.h" +#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp index 03cbe1ee5e..39d88a0f38 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_hybrid_kokkos.h" #include #include -#include "atom_vec_hybrid_kokkos.h" #include "atom_kokkos.h" #include "domain.h" #include "modify.h" diff --git a/src/KOKKOS/atom_vec_molecular_kokkos.cpp b/src/KOKKOS/atom_vec_molecular_kokkos.cpp index 9ac8ecd264..49bc7bf3c0 100644 --- a/src/KOKKOS/atom_vec_molecular_kokkos.cpp +++ b/src/KOKKOS/atom_vec_molecular_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_molecular_kokkos.h" +#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/atom_vec_sphere_kokkos.cpp b/src/KOKKOS/atom_vec_sphere_kokkos.cpp index 9e8388488f..b2abbfe8c4 100644 --- a/src/KOKKOS/atom_vec_sphere_kokkos.cpp +++ b/src/KOKKOS/atom_vec_sphere_kokkos.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_sphere_kokkos.h" #include #include #include -#include "atom_vec_sphere_kokkos.h" #include "atom_kokkos.h" #include "atom_masks.h" #include "comm_kokkos.h" diff --git a/src/KOKKOS/bond_class2_kokkos.cpp b/src/KOKKOS/bond_class2_kokkos.cpp index 798fb41c92..04281bfdd2 100644 --- a/src/KOKKOS/bond_class2_kokkos.cpp +++ b/src/KOKKOS/bond_class2_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Ray Shan (Materials Design) ------------------------------------------------------------------------- */ +#include "bond_class2_kokkos.h" #include #include -#include "bond_class2_kokkos.h" #include "atom_kokkos.h" #include "neighbor_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/bond_fene_kokkos.cpp b/src/KOKKOS/bond_fene_kokkos.cpp index b5cdc1a05a..361bb61f7e 100644 --- a/src/KOKKOS/bond_fene_kokkos.cpp +++ b/src/KOKKOS/bond_fene_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "bond_fene_kokkos.h" #include #include -#include "bond_fene_kokkos.h" #include "atom_kokkos.h" #include "neighbor_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/bond_harmonic_kokkos.cpp b/src/KOKKOS/bond_harmonic_kokkos.cpp index 51a9fa4389..792d98fe88 100644 --- a/src/KOKKOS/bond_harmonic_kokkos.cpp +++ b/src/KOKKOS/bond_harmonic_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "bond_harmonic_kokkos.h" #include #include -#include "bond_harmonic_kokkos.h" #include "atom_kokkos.h" #include "neighbor_kokkos.h" #include "domain.h" diff --git a/src/KOKKOS/comm_tiled_kokkos.cpp b/src/KOKKOS/comm_tiled_kokkos.cpp index 81cf1f0563..fc6de0a0d7 100644 --- a/src/KOKKOS/comm_tiled_kokkos.cpp +++ b/src/KOKKOS/comm_tiled_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "comm_tiled_kokkos.h" +#include #include "comm_brick.h" #include "atom_kokkos.h" #include "atom_vec.h" diff --git a/src/KOKKOS/compute_temp_kokkos.cpp b/src/KOKKOS/compute_temp_kokkos.cpp index 7b76f54f57..a2fcf63125 100644 --- a/src/KOKKOS/compute_temp_kokkos.cpp +++ b/src/KOKKOS/compute_temp_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_temp_kokkos.h" #include #include -#include "compute_temp_kokkos.h" #include "atom_kokkos.h" #include "update.h" #include "force.h" diff --git a/src/KOKKOS/dihedral_charmm_kokkos.cpp b/src/KOKKOS/dihedral_charmm_kokkos.cpp index 61ddcc425a..94fd0b9bb7 100644 --- a/src/KOKKOS/dihedral_charmm_kokkos.cpp +++ b/src/KOKKOS/dihedral_charmm_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "dihedral_charmm_kokkos.h" #include #include -#include "dihedral_charmm_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "neighbor_kokkos.h" diff --git a/src/KOKKOS/dihedral_class2_kokkos.cpp b/src/KOKKOS/dihedral_class2_kokkos.cpp index 98436bc696..4b8d171f61 100644 --- a/src/KOKKOS/dihedral_class2_kokkos.cpp +++ b/src/KOKKOS/dihedral_class2_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Ray Shan (Materials Design) ------------------------------------------------------------------------- */ +#include "dihedral_class2_kokkos.h" #include #include -#include "dihedral_class2_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "neighbor_kokkos.h" diff --git a/src/KOKKOS/dihedral_opls_kokkos.cpp b/src/KOKKOS/dihedral_opls_kokkos.cpp index f50dea2c36..825d106e04 100644 --- a/src/KOKKOS/dihedral_opls_kokkos.cpp +++ b/src/KOKKOS/dihedral_opls_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "dihedral_opls_kokkos.h" #include #include -#include "dihedral_opls_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "neighbor_kokkos.h" diff --git a/src/KOKKOS/fix_deform_kokkos.cpp b/src/KOKKOS/fix_deform_kokkos.cpp index 7b9336ed3b..05eb1c22f6 100644 --- a/src/KOKKOS/fix_deform_kokkos.cpp +++ b/src/KOKKOS/fix_deform_kokkos.cpp @@ -15,10 +15,10 @@ Contributing author: Pieter in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "fix_deform_kokkos.h" #include #include #include -#include "fix_deform_kokkos.h" #include "atom_kokkos.h" #include "update.h" #include "comm.h" diff --git a/src/KOKKOS/fix_dpd_energy_kokkos.cpp b/src/KOKKOS/fix_dpd_energy_kokkos.cpp index d092cb4802..debad0407a 100644 --- a/src/KOKKOS/fix_dpd_energy_kokkos.cpp +++ b/src/KOKKOS/fix_dpd_energy_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_dpd_energy_kokkos.h" #include #include -#include "fix_dpd_energy_kokkos.h" #include "atom_masks.h" #include "atom_kokkos.h" #include "force.h" diff --git a/src/KOKKOS/fix_enforce2d_kokkos.cpp b/src/KOKKOS/fix_enforce2d_kokkos.cpp index 346e440f55..bf2a882539 100644 --- a/src/KOKKOS/fix_enforce2d_kokkos.cpp +++ b/src/KOKKOS/fix_enforce2d_kokkos.cpp @@ -15,11 +15,11 @@ Contributing authors: Stefan Paquay & Matthew Peterson (Brandeis University) ------------------------------------------------------------------------- */ +#include "fix_enforce2d_kokkos.h" #include "atom_masks.h" #include "atom_kokkos.h" #include "comm.h" #include "error.h" -#include "fix_enforce2d_kokkos.h" using namespace LAMMPS_NS; diff --git a/src/KOKKOS/fix_eos_table_rx_kokkos.cpp b/src/KOKKOS/fix_eos_table_rx_kokkos.cpp index 2f730d1193..d0280eeef0 100644 --- a/src/KOKKOS/fix_eos_table_rx_kokkos.cpp +++ b/src/KOKKOS/fix_eos_table_rx_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (Sandia) ------------------------------------------------------------------------- */ +#include "fix_eos_table_rx_kokkos.h" #include #include -#include "fix_eos_table_rx_kokkos.h" #include "atom_kokkos.h" #include "error.h" #include "force.h" diff --git a/src/KOKKOS/fix_langevin_kokkos.cpp b/src/KOKKOS/fix_langevin_kokkos.cpp index 0947fee693..23a43b38ef 100644 --- a/src/KOKKOS/fix_langevin_kokkos.cpp +++ b/src/KOKKOS/fix_langevin_kokkos.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_langevin_kokkos.h" #include #include #include -#include "fix_langevin_kokkos.h" #include "atom_masks.h" #include "atom_kokkos.h" #include "force.h" diff --git a/src/KOKKOS/fix_momentum_kokkos.cpp b/src/KOKKOS/fix_momentum_kokkos.cpp index 38500531ca..2d4911bfda 100644 --- a/src/KOKKOS/fix_momentum_kokkos.cpp +++ b/src/KOKKOS/fix_momentum_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_momentum_kokkos.h" #include #include -#include "fix_momentum_kokkos.h" #include "atom_kokkos.h" #include "atom_masks.h" #include "domain.h" diff --git a/src/KOKKOS/fix_nh_kokkos.cpp b/src/KOKKOS/fix_nh_kokkos.cpp index fae9ef8f30..578f2f5c70 100644 --- a/src/KOKKOS/fix_nh_kokkos.cpp +++ b/src/KOKKOS/fix_nh_kokkos.cpp @@ -15,10 +15,10 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "fix_nh_kokkos.h" #include #include #include -#include "fix_nh_kokkos.h" #include "math_extra.h" #include "atom.h" #include "force.h" diff --git a/src/KOKKOS/fix_nph_kokkos.cpp b/src/KOKKOS/fix_nph_kokkos.cpp index c5072e6ae9..3830860fd7 100644 --- a/src/KOKKOS/fix_nph_kokkos.cpp +++ b/src/KOKKOS/fix_nph_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nph_kokkos.h" +#include #include "modify.h" #include "error.h" diff --git a/src/KOKKOS/fix_npt_kokkos.cpp b/src/KOKKOS/fix_npt_kokkos.cpp index c488c8e4f3..5b751c9e4d 100644 --- a/src/KOKKOS/fix_npt_kokkos.cpp +++ b/src/KOKKOS/fix_npt_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_npt_kokkos.h" +#include #include "modify.h" #include "error.h" diff --git a/src/KOKKOS/fix_nve_kokkos.cpp b/src/KOKKOS/fix_nve_kokkos.cpp index 6db8ff8c0f..0ca01c589a 100644 --- a/src/KOKKOS/fix_nve_kokkos.cpp +++ b/src/KOKKOS/fix_nve_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nve_kokkos.h" #include #include -#include "fix_nve_kokkos.h" #include "atom_masks.h" #include "atom_kokkos.h" #include "force.h" diff --git a/src/KOKKOS/fix_nvt_kokkos.cpp b/src/KOKKOS/fix_nvt_kokkos.cpp index 4db42a62fb..66165dd7bc 100644 --- a/src/KOKKOS/fix_nvt_kokkos.cpp +++ b/src/KOKKOS/fix_nvt_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_nvt_kokkos.h" +#include #include "group.h" #include "modify.h" #include "error.h" diff --git a/src/KOKKOS/fix_property_atom_kokkos.cpp b/src/KOKKOS/fix_property_atom_kokkos.cpp index 6860676911..ff374b885f 100644 --- a/src/KOKKOS/fix_property_atom_kokkos.cpp +++ b/src/KOKKOS/fix_property_atom_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_property_atom_kokkos.h" #include #include -#include "fix_property_atom_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/fix_qeq_reax_kokkos.cpp b/src/KOKKOS/fix_qeq_reax_kokkos.cpp index 12369261b3..6f8392ab16 100644 --- a/src/KOKKOS/fix_qeq_reax_kokkos.cpp +++ b/src/KOKKOS/fix_qeq_reax_kokkos.cpp @@ -16,11 +16,11 @@ Kamesh Arumugam (NVIDIA) ------------------------------------------------------------------------- */ +#include "fix_qeq_reax_kokkos.h" #include #include #include #include -#include "fix_qeq_reax_kokkos.h" #include "kokkos.h" #include "atom.h" #include "atom_masks.h" diff --git a/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp b/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp index 9aed0b9ae4..347c477476 100644 --- a/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp +++ b/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp @@ -15,9 +15,9 @@ Contributing author: Stan Moore (Sandia) ------------------------------------------------------------------------- */ +#include "fix_ave_atom.h" #include #include -#include "fix_ave_atom.h" #include "fix_reaxc_bonds_kokkos.h" #include "atom.h" #include "update.h" diff --git a/src/KOKKOS/fix_reaxc_species_kokkos.cpp b/src/KOKKOS/fix_reaxc_species_kokkos.cpp index bd92251960..71aacba68d 100644 --- a/src/KOKKOS/fix_reaxc_species_kokkos.cpp +++ b/src/KOKKOS/fix_reaxc_species_kokkos.cpp @@ -15,12 +15,12 @@ Contributing authors: Stan Moore (Sandia) ------------------------------------------------------------------------- */ +#include "fix_reaxc_species_kokkos.h" #include #include #include "atom.h" #include #include "fix_ave_atom.h" -#include "fix_reaxc_species_kokkos.h" #include "domain.h" #include "update.h" #include "pair_reaxc_kokkos.h" diff --git a/src/KOKKOS/fix_rx_kokkos.cpp b/src/KOKKOS/fix_rx_kokkos.cpp index 80333e1e9b..050dda2400 100644 --- a/src/KOKKOS/fix_rx_kokkos.cpp +++ b/src/KOKKOS/fix_rx_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_rx_kokkos.h" #include #include -#include "fix_rx_kokkos.h" #include "atom_masks.h" #include "atom_kokkos.h" #include "force.h" diff --git a/src/KOKKOS/fix_setforce_kokkos.cpp b/src/KOKKOS/fix_setforce_kokkos.cpp index 5d15b88d76..03cfd3afb2 100644 --- a/src/KOKKOS/fix_setforce_kokkos.cpp +++ b/src/KOKKOS/fix_setforce_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_setforce_kokkos.h" #include #include -#include "fix_setforce_kokkos.h" #include "atom_kokkos.h" #include "update.h" #include "modify.h" diff --git a/src/KOKKOS/fix_shardlow_kokkos.cpp b/src/KOKKOS/fix_shardlow_kokkos.cpp index 968f877abd..96f67ccb5e 100644 --- a/src/KOKKOS/fix_shardlow_kokkos.cpp +++ b/src/KOKKOS/fix_shardlow_kokkos.cpp @@ -33,10 +33,10 @@ 135, 204105. ------------------------------------------------------------------------- */ +#include "fix_shardlow_kokkos.h" #include #include #include -#include "fix_shardlow_kokkos.h" #include "atom.h" #include "atom_masks.h" #include "atom_kokkos.h" diff --git a/src/KOKKOS/fix_wall_lj93_kokkos.cpp b/src/KOKKOS/fix_wall_lj93_kokkos.cpp index 5dbb054175..61346144c8 100644 --- a/src/KOKKOS/fix_wall_lj93_kokkos.cpp +++ b/src/KOKKOS/fix_wall_lj93_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_wall_lj93_kokkos.h" +#include #include "atom_kokkos.h" #include "error.h" #include "atom_masks.h" diff --git a/src/KOKKOS/fix_wall_reflect_kokkos.cpp b/src/KOKKOS/fix_wall_reflect_kokkos.cpp index 75a5c1a81e..ba104d19a9 100644 --- a/src/KOKKOS/fix_wall_reflect_kokkos.cpp +++ b/src/KOKKOS/fix_wall_reflect_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_wall_reflect_kokkos.h" #include #include -#include "fix_wall_reflect_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "update.h" diff --git a/src/KOKKOS/gridcomm_kokkos.cpp b/src/KOKKOS/gridcomm_kokkos.cpp index 14b84a5733..1d0371c147 100644 --- a/src/KOKKOS/gridcomm_kokkos.cpp +++ b/src/KOKKOS/gridcomm_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "gridcomm_kokkos.h" +#include #include "comm.h" #include "kspace.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/improper_class2_kokkos.cpp b/src/KOKKOS/improper_class2_kokkos.cpp index ad32e6da4e..84b721bd2a 100644 --- a/src/KOKKOS/improper_class2_kokkos.cpp +++ b/src/KOKKOS/improper_class2_kokkos.cpp @@ -15,10 +15,10 @@ Contributing author: Ray Shan (Materials Design) ------------------------------------------------------------------------- */ +#include "improper_class2_kokkos.h" #include #include #include -#include "improper_class2_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "neighbor_kokkos.h" diff --git a/src/KOKKOS/improper_harmonic_kokkos.cpp b/src/KOKKOS/improper_harmonic_kokkos.cpp index bb397a2c2f..262ffe7700 100644 --- a/src/KOKKOS/improper_harmonic_kokkos.cpp +++ b/src/KOKKOS/improper_harmonic_kokkos.cpp @@ -15,10 +15,10 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "improper_harmonic_kokkos.h" #include #include #include -#include "improper_harmonic_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "neighbor_kokkos.h" diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 3fa84d98b2..c269f69cdd 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "kokkos.h" #include #include #include @@ -18,7 +19,6 @@ #include #include #include -#include "kokkos.h" #include "lammps.h" #include "force.h" #include "neighbor_kokkos.h" diff --git a/src/KOKKOS/math_special_kokkos.cpp b/src/KOKKOS/math_special_kokkos.cpp index 127168ef8b..f5fc725347 100644 --- a/src/KOKKOS/math_special_kokkos.cpp +++ b/src/KOKKOS/math_special_kokkos.cpp @@ -1,7 +1,7 @@ +#include "math_special_kokkos.h" #include #include -#include "math_special_kokkos.h" using namespace LAMMPS_NS; diff --git a/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp b/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp index 57ac3a9c57..e3843262a5 100644 --- a/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_buck_coul_cut_kokkos.h" #include #include #include #include -#include "pair_buck_coul_cut_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_buck_coul_long_kokkos.cpp b/src/KOKKOS/pair_buck_coul_long_kokkos.cpp index 349c4c0601..7457a0988f 100644 --- a/src/KOKKOS/pair_buck_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_buck_coul_long_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_buck_coul_long_kokkos.h" #include #include #include #include -#include "pair_buck_coul_long_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_buck_kokkos.cpp b/src/KOKKOS/pair_buck_kokkos.cpp index 02c02c986e..131622cac5 100644 --- a/src/KOKKOS/pair_buck_kokkos.cpp +++ b/src/KOKKOS/pair_buck_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_buck_kokkos.h" #include #include #include #include -#include "pair_buck_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_coul_cut_kokkos.cpp b/src/KOKKOS/pair_coul_cut_kokkos.cpp index 54ba0b63ce..e79f103363 100644 --- a/src/KOKKOS/pair_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_coul_cut_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_coul_cut_kokkos.h" #include #include #include #include -#include "pair_coul_cut_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_coul_debye_kokkos.cpp b/src/KOKKOS/pair_coul_debye_kokkos.cpp index 8966e30394..0fe03af043 100644 --- a/src/KOKKOS/pair_coul_debye_kokkos.cpp +++ b/src/KOKKOS/pair_coul_debye_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_coul_debye_kokkos.h" #include #include #include #include -#include "pair_coul_debye_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_coul_dsf_kokkos.cpp b/src/KOKKOS/pair_coul_dsf_kokkos.cpp index 748fed71a7..e94aae4754 100644 --- a/src/KOKKOS/pair_coul_dsf_kokkos.cpp +++ b/src/KOKKOS/pair_coul_dsf_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_coul_dsf_kokkos.h" #include #include #include #include -#include "pair_coul_dsf_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_coul_long_kokkos.cpp b/src/KOKKOS/pair_coul_long_kokkos.cpp index a21cb050ff..67132e11f6 100644 --- a/src/KOKKOS/pair_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_coul_long_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_coul_long_kokkos.h" #include #include #include #include -#include "pair_coul_long_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_coul_wolf_kokkos.cpp b/src/KOKKOS/pair_coul_wolf_kokkos.cpp index 20391d9530..dbbb865961 100644 --- a/src/KOKKOS/pair_coul_wolf_kokkos.cpp +++ b/src/KOKKOS/pair_coul_wolf_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_coul_wolf_kokkos.h" #include #include #include #include -#include "pair_coul_wolf_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp b/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp index a44ef1790e..7a2fca47a0 100644 --- a/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp +++ b/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Stan Moore (Sandia) ------------------------------------------------------------------------- */ +#include "pair_dpd_fdt_energy_kokkos.h" #include #include #include #include -#include "atom_kokkos.h" #include "atom_vec.h" #include "comm.h" #include "update.h" @@ -30,7 +30,6 @@ #include "neigh_request.h" #include "memory_kokkos.h" #include "modify.h" -#include "pair_dpd_fdt_energy_kokkos.h" #include "error.h" #include "atom_masks.h" #include "kokkos.h" diff --git a/src/KOKKOS/pair_eam_alloy_kokkos.cpp b/src/KOKKOS/pair_eam_alloy_kokkos.cpp index b5442c0d29..aa33d44eee 100644 --- a/src/KOKKOS/pair_eam_alloy_kokkos.cpp +++ b/src/KOKKOS/pair_eam_alloy_kokkos.cpp @@ -15,13 +15,13 @@ Contributing authors: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_eam_alloy_kokkos.h" #include #include #include #include #include "kokkos.h" #include "pair_kokkos.h" -#include "pair_eam_alloy_kokkos.h" #include "atom_kokkos.h" #include "force.h" #include "comm.h" diff --git a/src/KOKKOS/pair_eam_fs_kokkos.cpp b/src/KOKKOS/pair_eam_fs_kokkos.cpp index 16701febd6..9832a16a73 100644 --- a/src/KOKKOS/pair_eam_fs_kokkos.cpp +++ b/src/KOKKOS/pair_eam_fs_kokkos.cpp @@ -15,13 +15,13 @@ Contributing authors: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_eam_fs_kokkos.h" #include #include #include #include #include "kokkos.h" #include "pair_kokkos.h" -#include "pair_eam_fs_kokkos.h" #include "atom_kokkos.h" #include "force.h" #include "comm.h" diff --git a/src/KOKKOS/pair_eam_kokkos.cpp b/src/KOKKOS/pair_eam_kokkos.cpp index d423f2c927..4c6fadfe92 100644 --- a/src/KOKKOS/pair_eam_kokkos.cpp +++ b/src/KOKKOS/pair_eam_kokkos.cpp @@ -15,13 +15,13 @@ Contributing authors: Stan Moore (SNL), Christian Trott (SNL) ------------------------------------------------------------------------- */ +#include "pair_eam_kokkos.h" #include #include #include #include #include "kokkos.h" #include "pair_kokkos.h" -#include "pair_eam_kokkos.h" #include "atom_kokkos.h" #include "force.h" #include "comm.h" diff --git a/src/KOKKOS/pair_exp6_rx_kokkos.cpp b/src/KOKKOS/pair_exp6_rx_kokkos.cpp index 3a857a6485..31a48fe154 100644 --- a/src/KOKKOS/pair_exp6_rx_kokkos.cpp +++ b/src/KOKKOS/pair_exp6_rx_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Stan Moore (Sandia) ------------------------------------------------------------------------- */ +#include "pair_exp6_rx_kokkos.h" #include #include #include #include -#include "pair_exp6_rx_kokkos.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KOKKOS/pair_hybrid_kokkos.cpp b/src/KOKKOS/pair_hybrid_kokkos.cpp index 00df4a8f3c..c767d9f470 100644 --- a/src/KOKKOS/pair_hybrid_kokkos.cpp +++ b/src/KOKKOS/pair_hybrid_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_hybrid_kokkos.h" #include #include #include #include -#include "pair_hybrid_kokkos.h" #include "atom_kokkos.h" #include "force.h" #include "pair.h" diff --git a/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp b/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp index a2c3edab65..cb1389d38e 100644 --- a/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp +++ b/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_hybrid_overlay_kokkos.h" #include #include #include -#include "pair_hybrid_overlay_kokkos.h" #include "atom.h" #include "force.h" #include "neighbor.h" diff --git a/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp b/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp index 510740112a..b7c3766d5f 100644 --- a/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp +++ b/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_charmm_implicit_kokkos.h" #include #include #include #include -#include "pair_lj_charmm_coul_charmm_implicit_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp b/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp index 51c96354f9..c6a1e3211d 100644 --- a/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp +++ b/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_charmm_kokkos.h" #include #include #include #include -#include "pair_lj_charmm_coul_charmm_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp b/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp index 22faa98935..4ba0651601 100644 --- a/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_long_kokkos.h" #include #include #include #include -#include "pair_lj_charmm_coul_long_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp b/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp index 60d480188b..ef8fe7a128 100644 --- a/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2_coul_cut_kokkos.h" #include #include #include #include -#include "pair_lj_class2_coul_cut_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp b/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp index 4c8aea8e92..5a25d0250b 100644 --- a/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2_coul_long_kokkos.h" #include #include #include #include -#include "pair_lj_class2_coul_long_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_class2_kokkos.cpp b/src/KOKKOS/pair_lj_class2_kokkos.cpp index dd42baa4e0..6d673b2d01 100644 --- a/src/KOKKOS/pair_lj_class2_kokkos.cpp +++ b/src/KOKKOS/pair_lj_class2_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_class2_kokkos.h" #include #include #include #include -#include "pair_lj_class2_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp index cb5ab96871..9201a116b5 100644 --- a/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_cut_kokkos.h" #include #include #include #include -#include "pair_lj_cut_coul_cut_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp index 800092a09b..8935333c74 100644 --- a/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_debye_kokkos.h" #include #include #include #include -#include "pair_lj_cut_coul_debye_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp index f793485b47..aea70faec4 100644 --- a/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_dsf_kokkos.h" #include #include #include #include -#include "pair_lj_cut_coul_dsf_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp index 02150586f4..53d27f2447 100644 --- a/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_long_kokkos.h" #include #include #include #include -#include "pair_lj_cut_coul_long_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_cut_kokkos.cpp b/src/KOKKOS/pair_lj_cut_kokkos.cpp index 4ba8c00f88..ee29e12322 100644 --- a/src/KOKKOS/pair_lj_cut_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_cut_kokkos.h" #include #include #include #include -#include "pair_lj_cut_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_expand_kokkos.cpp b/src/KOKKOS/pair_lj_expand_kokkos.cpp index 5ea6c9e438..061fc205fb 100644 --- a/src/KOKKOS/pair_lj_expand_kokkos.cpp +++ b/src/KOKKOS/pair_lj_expand_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_expand_kokkos.h" #include #include #include #include -#include "pair_lj_expand_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp b/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp index 2421d059da..4df9fdea9e 100644 --- a/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp +++ b/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_gromacs_coul_gromacs_kokkos.h" #include #include #include #include -#include "pair_lj_gromacs_coul_gromacs_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_gromacs_kokkos.cpp b/src/KOKKOS/pair_lj_gromacs_kokkos.cpp index 09a0261ae1..2d395c39d5 100644 --- a/src/KOKKOS/pair_lj_gromacs_kokkos.cpp +++ b/src/KOKKOS/pair_lj_gromacs_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_gromacs_kokkos.h" #include #include #include #include -#include "pair_lj_gromacs_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_lj_sdk_kokkos.cpp b/src/KOKKOS/pair_lj_sdk_kokkos.cpp index c2375fa7a8..14c53c38bf 100644 --- a/src/KOKKOS/pair_lj_sdk_kokkos.cpp +++ b/src/KOKKOS/pair_lj_sdk_kokkos.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_sdk_kokkos.h" #include #include #include #include -#include "pair_lj_sdk_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_morse_kokkos.cpp b/src/KOKKOS/pair_morse_kokkos.cpp index b308330ead..d679477321 100644 --- a/src/KOKKOS/pair_morse_kokkos.cpp +++ b/src/KOKKOS/pair_morse_kokkos.cpp @@ -15,11 +15,11 @@ Contributing authors: Stefan Paquay (Eindhoven University of Technology) ------------------------------------------------------------------------- */ +#include "pair_morse_kokkos.h" #include #include #include #include -#include "pair_morse_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp b/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp index 7d17ac3f43..81a4aa7a82 100644 --- a/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp +++ b/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp @@ -21,12 +21,12 @@ The Journal of Chemical Physics, 2016, 144, 104501. ------------------------------------------------------------------------------------------- */ +#include "pair_multi_lucy_rx_kokkos.h" #include #include -#include "math_const.h" #include #include -#include "pair_multi_lucy_rx_kokkos.h" +#include "math_const.h" #include "atom_kokkos.h" #include "force.h" #include "comm.h" diff --git a/src/KOKKOS/pair_reaxc_kokkos.cpp b/src/KOKKOS/pair_reaxc_kokkos.cpp index 64651be270..ca897a377c 100644 --- a/src/KOKKOS/pair_reaxc_kokkos.cpp +++ b/src/KOKKOS/pair_reaxc_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL), Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_reaxc_kokkos.h" #include #include #include #include -#include "pair_reaxc_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_sw_kokkos.cpp b/src/KOKKOS/pair_sw_kokkos.cpp index da4737a2c1..dbd45747f0 100644 --- a/src/KOKKOS/pair_sw_kokkos.cpp +++ b/src/KOKKOS/pair_sw_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_sw_kokkos.h" #include #include #include #include -#include "pair_sw_kokkos.h" #include "kokkos.h" #include "pair_kokkos.h" #include "atom_kokkos.h" diff --git a/src/KOKKOS/pair_table_kokkos.cpp b/src/KOKKOS/pair_table_kokkos.cpp index 737d600d1e..01966d708a 100644 --- a/src/KOKKOS/pair_table_kokkos.cpp +++ b/src/KOKKOS/pair_table_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Christian Trott (SNL) ------------------------------------------------------------------------- */ +#include "pair_table_kokkos.h" #include #include #include #include -#include "pair_table_kokkos.h" #include "kokkos.h" #include "atom.h" #include "force.h" diff --git a/src/KOKKOS/pair_table_rx_kokkos.cpp b/src/KOKKOS/pair_table_rx_kokkos.cpp index ec7a2ffb94..7c2d20c68d 100644 --- a/src/KOKKOS/pair_table_rx_kokkos.cpp +++ b/src/KOKKOS/pair_table_rx_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Dan Ibanez (SNL) ------------------------------------------------------------------------- */ +#include "pair_table_rx_kokkos.h" #include #include #include #include -#include "pair_table_rx_kokkos.h" #include "kokkos.h" #include "atom.h" #include "force.h" diff --git a/src/KOKKOS/pair_tersoff_kokkos.cpp b/src/KOKKOS/pair_tersoff_kokkos.cpp index 9252e3de52..b68af84425 100644 --- a/src/KOKKOS/pair_tersoff_kokkos.cpp +++ b/src/KOKKOS/pair_tersoff_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) and Christian Trott (SNL) ------------------------------------------------------------------------- */ +#include "pair_tersoff_kokkos.h" #include #include #include #include -#include "pair_tersoff_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_tersoff_mod_kokkos.cpp b/src/KOKKOS/pair_tersoff_mod_kokkos.cpp index 585074b128..b6921179c0 100644 --- a/src/KOKKOS/pair_tersoff_mod_kokkos.cpp +++ b/src/KOKKOS/pair_tersoff_mod_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_tersoff_mod_kokkos.h" #include #include #include #include -#include "pair_tersoff_mod_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp b/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp index e1e2211ab5..60ff0a7269 100644 --- a/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp +++ b/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (SNL) ------------------------------------------------------------------------- */ +#include "pair_tersoff_zbl_kokkos.h" #include #include #include #include -#include "pair_tersoff_zbl_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_vashishta_kokkos.cpp b/src/KOKKOS/pair_vashishta_kokkos.cpp index 4a1f291b17..febb171c83 100644 --- a/src/KOKKOS/pair_vashishta_kokkos.cpp +++ b/src/KOKKOS/pair_vashishta_kokkos.cpp @@ -15,11 +15,11 @@ Contributing author: Anders Hafreager (UiO), andershaf@gmail.com ------------------------------------------------------------------------- */ +#include "pair_vashishta_kokkos.h" #include #include #include #include -#include "pair_vashishta_kokkos.h" #include "kokkos.h" #include "pair_kokkos.h" #include "atom_kokkos.h" diff --git a/src/KOKKOS/pair_yukawa_kokkos.cpp b/src/KOKKOS/pair_yukawa_kokkos.cpp index 27e18533a2..acfeb2fbdc 100644 --- a/src/KOKKOS/pair_yukawa_kokkos.cpp +++ b/src/KOKKOS/pair_yukawa_kokkos.cpp @@ -14,9 +14,10 @@ /* ---------------------------------------------------------------------- Contributing authors: Stefan Paquay (Brandeis University) ------------------------------------------------------------------------- */ + +#include "pair_yukawa_kokkos.h" #include #include -#include "pair_yukawa_kokkos.h" #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" diff --git a/src/KOKKOS/pair_zbl_kokkos.cpp b/src/KOKKOS/pair_zbl_kokkos.cpp index 06c84e5189..0f21331266 100644 --- a/src/KOKKOS/pair_zbl_kokkos.cpp +++ b/src/KOKKOS/pair_zbl_kokkos.cpp @@ -15,11 +15,11 @@ Contributing authors: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_zbl_kokkos.h" #include #include #include #include -#include "pair_zbl_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "force.h" diff --git a/src/KOKKOS/pppm_kokkos.cpp b/src/KOKKOS/pppm_kokkos.cpp index 7c01adc510..1842524e23 100644 --- a/src/KOKKOS/pppm_kokkos.cpp +++ b/src/KOKKOS/pppm_kokkos.cpp @@ -15,12 +15,12 @@ Contributing author: Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pppm_kokkos.h" #include #include #include #include #include -#include "pppm_kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "gridcomm_kokkos.h" diff --git a/src/KOKKOS/rand_pool_wrap_kokkos.cpp b/src/KOKKOS/rand_pool_wrap_kokkos.cpp index 51ebcb154e..2d8865feb0 100644 --- a/src/KOKKOS/rand_pool_wrap_kokkos.cpp +++ b/src/KOKKOS/rand_pool_wrap_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "comm.h" #include "rand_pool_wrap_kokkos.h" +#include "comm.h" #include "lammps.h" #include "kokkos.h" #include "random_mars.h" diff --git a/src/KOKKOS/region_block_kokkos.cpp b/src/KOKKOS/region_block_kokkos.cpp index 730ef81466..a5734f6ba7 100644 --- a/src/KOKKOS/region_block_kokkos.cpp +++ b/src/KOKKOS/region_block_kokkos.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "region_block_kokkos.h" #include #include -#include "region_block_kokkos.h" #include "domain.h" #include "force.h" #include "atom_kokkos.h" diff --git a/src/KOKKOS/verlet_kokkos.cpp b/src/KOKKOS/verlet_kokkos.cpp index b80d5e0646..d555b74d23 100644 --- a/src/KOKKOS/verlet_kokkos.cpp +++ b/src/KOKKOS/verlet_kokkos.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "verlet_kokkos.h" +#include #include "neighbor.h" #include "domain.h" #include "comm.h" diff --git a/src/KSPACE/ewald.cpp b/src/KSPACE/ewald.cpp index ccbb3ed708..aad0e364d0 100644 --- a/src/KSPACE/ewald.cpp +++ b/src/KSPACE/ewald.cpp @@ -18,12 +18,12 @@ triclinic added by Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "ewald.h" #include #include #include #include #include -#include "ewald.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/ewald_dipole.cpp b/src/KSPACE/ewald_dipole.cpp index 89ef7e39a8..53bac0637f 100644 --- a/src/KSPACE/ewald_dipole.cpp +++ b/src/KSPACE/ewald_dipole.cpp @@ -15,12 +15,12 @@ Contributing authors: Julien Tranchida (SNL), Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "ewald_dipole.h" #include #include #include #include #include -#include "ewald_dipole.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/ewald_dipole_spin.cpp b/src/KSPACE/ewald_dipole_spin.cpp index 698203c85c..2b6c95f174 100644 --- a/src/KSPACE/ewald_dipole_spin.cpp +++ b/src/KSPACE/ewald_dipole_spin.cpp @@ -15,12 +15,12 @@ Contributing authors: Julien Tranchida (SNL) ------------------------------------------------------------------------- */ +#include "ewald_dipole_spin.h" #include #include #include #include #include -#include "ewald_dipole_spin.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/ewald_disp.cpp b/src/KSPACE/ewald_disp.cpp index 0603d68eb2..c775056dd8 100644 --- a/src/KSPACE/ewald_disp.cpp +++ b/src/KSPACE/ewald_disp.cpp @@ -15,12 +15,12 @@ Contributing authors: Pieter in 't Veld (SNL), Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "ewald_disp.h" #include #include #include #include #include -#include "ewald_disp.h" #include "math_vector.h" #include "math_const.h" #include "math_special.h" diff --git a/src/KSPACE/fft3d.cpp b/src/KSPACE/fft3d.cpp index 7d3c8c83f2..e4c38a57f5 100644 --- a/src/KSPACE/fft3d.cpp +++ b/src/KSPACE/fft3d.cpp @@ -19,11 +19,11 @@ Paul Coffman (IBM) added MPI collectives remap ------------------------------------------------------------------------- */ +#include "fft3d.h" #include #include #include #include -#include "fft3d.h" #include "remap.h" #ifdef FFT_KISS diff --git a/src/KSPACE/fft3d_wrap.cpp b/src/KSPACE/fft3d_wrap.cpp index b9a6f0ae46..507b23d27d 100644 --- a/src/KSPACE/fft3d_wrap.cpp +++ b/src/KSPACE/fft3d_wrap.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fft3d_wrap.h" +#include #include "error.h" using namespace LAMMPS_NS; diff --git a/src/KSPACE/fix_tune_kspace.cpp b/src/KSPACE/fix_tune_kspace.cpp index 2b22b44340..cfd88609b3 100644 --- a/src/KSPACE/fix_tune_kspace.cpp +++ b/src/KSPACE/fix_tune_kspace.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "fix_tune_kspace.h" #include #include #include -#include "fix_tune_kspace.h" #include "update.h" #include "force.h" #include "kspace.h" diff --git a/src/KSPACE/gridcomm.cpp b/src/KSPACE/gridcomm.cpp index ba08c9be26..552d80daab 100644 --- a/src/KSPACE/gridcomm.cpp +++ b/src/KSPACE/gridcomm.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "gridcomm.h" +#include #include "comm.h" #include "kspace.h" #include "memory.h" diff --git a/src/KSPACE/msm.cpp b/src/KSPACE/msm.cpp index d7cc3f6876..bc5360dcd2 100644 --- a/src/KSPACE/msm.cpp +++ b/src/KSPACE/msm.cpp @@ -15,12 +15,12 @@ Contributing authors: Paul Crozier, Stan Moore, Stephen Bond, (all SNL) ------------------------------------------------------------------------- */ +#include "msm.h" #include #include #include #include #include -#include "msm.h" #include "atom.h" #include "comm.h" #include "gridcomm.h" diff --git a/src/KSPACE/msm_cg.cpp b/src/KSPACE/msm_cg.cpp index c7896db50c..22976b8442 100644 --- a/src/KSPACE/msm_cg.cpp +++ b/src/KSPACE/msm_cg.cpp @@ -15,6 +15,7 @@ Contributing authors: Paul Crozier, Stan Moore, Stephen Bond, (all SNL) ------------------------------------------------------------------------- */ +#include "msm_cg.h" #include #include #include @@ -27,7 +28,6 @@ #include "force.h" #include "neighbor.h" #include "memory.h" -#include "msm_cg.h" #include "math_const.h" diff --git a/src/KSPACE/pair_born_coul_long.cpp b/src/KSPACE/pair_born_coul_long.cpp index f12f5779d9..cb8360e401 100644 --- a/src/KSPACE/pair_born_coul_long.cpp +++ b/src/KSPACE/pair_born_coul_long.cpp @@ -15,11 +15,11 @@ Contributing author: Ahmed Ismail (SNL) ------------------------------------------------------------------------- */ +#include "pair_born_coul_long.h" #include #include #include #include -#include "pair_born_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_born_coul_msm.cpp b/src/KSPACE/pair_born_coul_msm.cpp index eaa1c116c1..deaf224334 100644 --- a/src/KSPACE/pair_born_coul_msm.cpp +++ b/src/KSPACE/pair_born_coul_msm.cpp @@ -15,11 +15,11 @@ Contributing author: Stan Moore (SNL), Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_born_coul_msm.h" #include #include #include #include -#include "pair_born_coul_msm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_buck_coul_long.cpp b/src/KSPACE/pair_buck_coul_long.cpp index a5427965dc..c97856fa3c 100644 --- a/src/KSPACE/pair_buck_coul_long.cpp +++ b/src/KSPACE/pair_buck_coul_long.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_buck_coul_long.h" #include #include #include -#include "pair_buck_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_buck_coul_msm.cpp b/src/KSPACE/pair_buck_coul_msm.cpp index 257d1b661f..3d7687df90 100644 --- a/src/KSPACE/pair_buck_coul_msm.cpp +++ b/src/KSPACE/pair_buck_coul_msm.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_buck_coul_msm.h" #include #include #include #include -#include "pair_buck_coul_msm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_buck_long_coul_long.cpp b/src/KSPACE/pair_buck_long_coul_long.cpp index bcd290891e..8127cbc127 100644 --- a/src/KSPACE/pair_buck_long_coul_long.cpp +++ b/src/KSPACE/pair_buck_long_coul_long.cpp @@ -15,11 +15,11 @@ Contributing author: Pieter J. in 't Veld (SNL) ------------------------------------------------------------------------- */ +#include "pair_buck_long_coul_long.h" #include #include #include #include "math_vector.h" -#include "pair_buck_long_coul_long.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/KSPACE/pair_coul_long.cpp b/src/KSPACE/pair_coul_long.cpp index ae268b9857..cb45b7a906 100644 --- a/src/KSPACE/pair_coul_long.cpp +++ b/src/KSPACE/pair_coul_long.cpp @@ -15,11 +15,11 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_coul_long.h" #include #include #include #include -#include "pair_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_coul_msm.cpp b/src/KSPACE/pair_coul_msm.cpp index 960505142c..2173171e79 100644 --- a/src/KSPACE/pair_coul_msm.cpp +++ b/src/KSPACE/pair_coul_msm.cpp @@ -15,11 +15,11 @@ Contributing authors: Stan Moore (SNL), Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_coul_msm.h" #include #include #include #include -#include "pair_coul_msm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_lj_charmm_coul_long.cpp b/src/KSPACE/pair_lj_charmm_coul_long.cpp index b40eab244b..3ad14c8ea7 100644 --- a/src/KSPACE/pair_lj_charmm_coul_long.cpp +++ b/src/KSPACE/pair_lj_charmm_coul_long.cpp @@ -15,11 +15,11 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_long.h" #include #include #include #include -#include "pair_lj_charmm_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_lj_charmm_coul_msm.cpp b/src/KSPACE/pair_lj_charmm_coul_msm.cpp index 72a8e340bc..2d1775802f 100644 --- a/src/KSPACE/pair_lj_charmm_coul_msm.cpp +++ b/src/KSPACE/pair_lj_charmm_coul_msm.cpp @@ -15,11 +15,11 @@ Contributing authors: Paul Crozier (SNL), Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_msm.h" #include #include #include #include -#include "pair_lj_charmm_coul_msm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp b/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp index cdde211157..7f32613cba 100644 --- a/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp +++ b/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp @@ -19,11 +19,11 @@ additional assistance from Robert A. Latour, Clemson University ------------------------------------------------------------------------- */ +#include "pair_lj_charmmfsw_coul_long.h" #include #include #include #include -#include "pair_lj_charmmfsw_coul_long.h" #include "atom.h" #include "update.h" #include "comm.h" diff --git a/src/KSPACE/pair_lj_cut_coul_long.cpp b/src/KSPACE/pair_lj_cut_coul_long.cpp index fde7fa8e35..59f4766fa3 100644 --- a/src/KSPACE/pair_lj_cut_coul_long.cpp +++ b/src/KSPACE/pair_lj_cut_coul_long.cpp @@ -15,11 +15,11 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_long.h" #include #include #include #include -#include "pair_lj_cut_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_lj_cut_coul_msm.cpp b/src/KSPACE/pair_lj_cut_coul_msm.cpp index c2e566a117..1305d485da 100644 --- a/src/KSPACE/pair_lj_cut_coul_msm.cpp +++ b/src/KSPACE/pair_lj_cut_coul_msm.cpp @@ -15,11 +15,11 @@ Contributing authors: Stan Moore (SNL), Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_msm.h" #include #include #include #include -#include "pair_lj_cut_coul_msm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/KSPACE/pair_lj_cut_tip4p_long.cpp b/src/KSPACE/pair_lj_cut_tip4p_long.cpp index f5889fd520..cd9b3c032d 100644 --- a/src/KSPACE/pair_lj_cut_tip4p_long.cpp +++ b/src/KSPACE/pair_lj_cut_tip4p_long.cpp @@ -16,11 +16,11 @@ simpler force assignment added by Rolf Isele-Holder (Aachen University) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_tip4p_long.h" #include #include #include #include -#include "pair_lj_cut_tip4p_long.h" #include "angle.h" #include "atom.h" #include "bond.h" diff --git a/src/KSPACE/pair_lj_long_coul_long.cpp b/src/KSPACE/pair_lj_long_coul_long.cpp index 493866a895..46dbb60a96 100644 --- a/src/KSPACE/pair_lj_long_coul_long.cpp +++ b/src/KSPACE/pair_lj_long_coul_long.cpp @@ -17,12 +17,12 @@ University New Orleans) ------------------------------------------------------------------------- */ +#include "pair_lj_long_coul_long.h" #include #include #include #include #include "math_vector.h" -#include "pair_lj_long_coul_long.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/KSPACE/pair_lj_long_tip4p_long.cpp b/src/KSPACE/pair_lj_long_tip4p_long.cpp index 3137b9d79a..5a1e347c78 100644 --- a/src/KSPACE/pair_lj_long_tip4p_long.cpp +++ b/src/KSPACE/pair_lj_long_tip4p_long.cpp @@ -16,11 +16,11 @@ Rolf Isele-Holder (Aachen University) ------------------------------------------------------------------------- */ +#include "pair_lj_long_tip4p_long.h" #include #include #include #include -#include "pair_lj_long_tip4p_long.h" #include "angle.h" #include "atom.h" #include "bond.h" diff --git a/src/KSPACE/pair_tip4p_long.cpp b/src/KSPACE/pair_tip4p_long.cpp index 9419fdf196..deb8662a8b 100644 --- a/src/KSPACE/pair_tip4p_long.cpp +++ b/src/KSPACE/pair_tip4p_long.cpp @@ -16,11 +16,11 @@ simpler force assignment added by Rolf Isele-Holder (Aachen University) ------------------------------------------------------------------------- */ +#include "pair_tip4p_long.h" #include #include #include #include -#include "pair_tip4p_long.h" #include "angle.h" #include "atom.h" #include "bond.h" diff --git a/src/KSPACE/pppm.cpp b/src/KSPACE/pppm.cpp index 53c18804a5..ae545c5c27 100644 --- a/src/KSPACE/pppm.cpp +++ b/src/KSPACE/pppm.cpp @@ -18,12 +18,12 @@ triclinic added by Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pppm.h" #include #include #include #include #include -#include "pppm.h" #include "atom.h" #include "comm.h" #include "gridcomm.h" diff --git a/src/KSPACE/pppm_cg.cpp b/src/KSPACE/pppm_cg.cpp index 3285dba21c..f9bd7b0cb4 100644 --- a/src/KSPACE/pppm_cg.cpp +++ b/src/KSPACE/pppm_cg.cpp @@ -15,11 +15,11 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_cg.h" #include #include #include #include - #include "atom.h" #include "gridcomm.h" #include "domain.h" @@ -27,8 +27,6 @@ #include "force.h" #include "neighbor.h" #include "memory.h" -#include "pppm_cg.h" - #include "math_const.h" using namespace LAMMPS_NS; diff --git a/src/KSPACE/pppm_dipole.cpp b/src/KSPACE/pppm_dipole.cpp index 21a777dd75..ad03b8205a 100644 --- a/src/KSPACE/pppm_dipole.cpp +++ b/src/KSPACE/pppm_dipole.cpp @@ -15,12 +15,12 @@ Contributing authors: Stan Moore (SNL), Julien Tranchida (SNL) ------------------------------------------------------------------------- */ +#include "pppm_dipole.h" #include #include #include #include #include -#include "pppm_dipole.h" #include "atom.h" #include "comm.h" #include "gridcomm.h" diff --git a/src/KSPACE/pppm_dipole_spin.cpp b/src/KSPACE/pppm_dipole_spin.cpp index 878d40c82e..2c96eadde1 100644 --- a/src/KSPACE/pppm_dipole_spin.cpp +++ b/src/KSPACE/pppm_dipole_spin.cpp @@ -15,12 +15,12 @@ Contributing author: Julien Tranchida (SNL) ------------------------------------------------------------------------- */ +#include "pppm_dipole_spin.h" #include #include #include #include #include -#include "pppm_dipole_spin.h" #include "atom.h" #include "comm.h" #include "gridcomm.h" diff --git a/src/KSPACE/pppm_disp.cpp b/src/KSPACE/pppm_disp.cpp index 45dce0895b..22e570049c 100644 --- a/src/KSPACE/pppm_disp.cpp +++ b/src/KSPACE/pppm_disp.cpp @@ -16,12 +16,12 @@ Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pppm_disp.h" #include #include #include #include #include -#include "pppm_disp.h" #include "math_const.h" #include "atom.h" #include "comm.h" diff --git a/src/KSPACE/pppm_disp_tip4p.cpp b/src/KSPACE/pppm_disp_tip4p.cpp index 2bc63a84bb..36e6159131 100644 --- a/src/KSPACE/pppm_disp_tip4p.cpp +++ b/src/KSPACE/pppm_disp_tip4p.cpp @@ -16,8 +16,8 @@ Rolf Isele-Holder (Aachen University) ------------------------------------------------------------------------- */ -#include #include "pppm_disp_tip4p.h" +#include #include "pppm_disp.h" #include "atom.h" #include "domain.h" diff --git a/src/KSPACE/pppm_stagger.cpp b/src/KSPACE/pppm_stagger.cpp index a5ed6de626..5c2e2a6098 100644 --- a/src/KSPACE/pppm_stagger.cpp +++ b/src/KSPACE/pppm_stagger.cpp @@ -15,12 +15,12 @@ Contributing author: Stan Moore (Sandia) ------------------------------------------------------------------------- */ +#include "pppm_stagger.h" #include #include #include #include #include -#include "pppm_stagger.h" #include "atom.h" #include "gridcomm.h" #include "force.h" diff --git a/src/KSPACE/pppm_tip4p.cpp b/src/KSPACE/pppm_tip4p.cpp index b9fe3e6488..52a1fb3787 100644 --- a/src/KSPACE/pppm_tip4p.cpp +++ b/src/KSPACE/pppm_tip4p.cpp @@ -15,8 +15,8 @@ Contributing authors: Amalie Frischknecht and Ahmed Ismail (SNL) ------------------------------------------------------------------------- */ -#include #include "pppm_tip4p.h" +#include #include "atom.h" #include "domain.h" #include "force.h" diff --git a/src/KSPACE/remap.cpp b/src/KSPACE/remap.cpp index 26541f121e..85fe78c9d7 100644 --- a/src/KSPACE/remap.cpp +++ b/src/KSPACE/remap.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "remap.h" #include #include -#include "remap.h" #define PACK_DATA FFT_SCALAR diff --git a/src/KSPACE/remap_wrap.cpp b/src/KSPACE/remap_wrap.cpp index 8ea2918d7f..7929cd053c 100644 --- a/src/KSPACE/remap_wrap.cpp +++ b/src/KSPACE/remap_wrap.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "remap_wrap.h" +#include #include "error.h" using namespace LAMMPS_NS; -- GitLab From 6cf3bb3e4e5e5176b985fe820876e0d240e1159e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 3 Jul 2019 21:56:29 -0400 Subject: [PATCH 173/469] recover compilation of KSPACE package --- src/KSPACE/fft3d.h | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/KSPACE/fft3d.h b/src/KSPACE/fft3d.h index a51818d986..8c3d2f27ad 100644 --- a/src/KSPACE/fft3d.h +++ b/src/KSPACE/fft3d.h @@ -11,6 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include + // User-settable FFT precision // FFT_PRECISION = 1 is single-precision complex (4-byte real, 4-byte imag) -- GitLab From 416911aa7e05a94328bfb9f1d7a580f40a450603 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 3 Jul 2019 21:57:39 -0400 Subject: [PATCH 174/469] more rearranging of include file order to put implementation headers first --- src/LATTE/fix_latte.cpp | 2 +- src/MANYBODY/fix_qeq_comb.cpp | 2 +- src/MANYBODY/pair_adp.cpp | 2 +- src/MANYBODY/pair_airebo.cpp | 2 +- src/MANYBODY/pair_atm.cpp | 2 +- src/MANYBODY/pair_bop.cpp | 2 +- src/MANYBODY/pair_comb.cpp | 2 +- src/MANYBODY/pair_comb3.cpp | 2 +- src/MANYBODY/pair_eam.cpp | 2 +- src/MANYBODY/pair_eam_alloy.cpp | 2 +- src/MANYBODY/pair_eam_cd.cpp | 2 +- src/MANYBODY/pair_eam_fs.cpp | 2 +- src/MANYBODY/pair_eim.cpp | 2 +- src/MANYBODY/pair_gw.cpp | 2 +- src/MANYBODY/pair_gw_zbl.cpp | 2 +- src/MANYBODY/pair_lcbop.cpp | 2 +- src/MANYBODY/pair_nb3b_harmonic.cpp | 2 +- src/MANYBODY/pair_polymorphic.cpp | 2 +- src/MANYBODY/pair_sw.cpp | 2 +- src/MANYBODY/pair_tersoff.cpp | 2 +- src/MANYBODY/pair_tersoff_mod.cpp | 2 +- src/MANYBODY/pair_tersoff_mod_c.cpp | 2 +- src/MANYBODY/pair_tersoff_zbl.cpp | 2 +- src/MANYBODY/pair_vashishta.cpp | 2 +- src/MANYBODY/pair_vashishta_table.cpp | 2 +- src/MC/fix_atom_swap.cpp | 2 +- src/MC/fix_bond_break.cpp | 2 +- src/MC/fix_bond_create.cpp | 2 +- src/MC/fix_bond_swap.cpp | 2 +- src/MC/fix_gcmc.cpp | 2 +- src/MC/pair_dsmc.cpp | 2 +- src/MESSAGE/fix_client_md.cpp | 2 +- src/MESSAGE/message.cpp | 2 +- src/MESSAGE/server.cpp | 2 +- src/MESSAGE/server_md.cpp | 2 +- src/MISC/compute_msd_nongauss.cpp | 2 +- src/MISC/compute_ti.cpp | 4 +-- src/MISC/dump_xtc.cpp | 2 +- src/MISC/fix_deposit.cpp | 2 +- src/MISC/fix_efield.cpp | 2 +- src/MISC/fix_evaporate.cpp | 2 +- src/MISC/fix_gld.cpp | 2 +- src/MISC/fix_oneway.cpp | 2 +- src/MISC/fix_orient_bcc.cpp | 2 +- src/MISC/fix_orient_fcc.cpp | 2 +- src/MISC/fix_thermal_conductivity.cpp | 2 +- src/MISC/fix_ttm.cpp | 2 +- src/MISC/fix_viscosity.cpp | 2 +- src/MISC/pair_nm_cut.cpp | 2 +- src/MISC/pair_nm_cut_coul_cut.cpp | 2 +- src/MISC/pair_nm_cut_coul_long.cpp | 2 +- src/MISC/xdr_compat.cpp | 2 +- src/MOLECULE/angle_charmm.cpp | 2 +- src/MOLECULE/angle_cosine.cpp | 2 +- src/MOLECULE/angle_cosine_delta.cpp | 2 +- src/MOLECULE/angle_cosine_periodic.cpp | 2 +- src/MOLECULE/angle_cosine_squared.cpp | 2 +- src/MOLECULE/angle_harmonic.cpp | 2 +- src/MOLECULE/angle_table.cpp | 2 +- src/MOLECULE/atom_vec_angle.cpp | 2 +- src/MOLECULE/atom_vec_bond.cpp | 2 +- src/MOLECULE/atom_vec_full.cpp | 2 +- src/MOLECULE/atom_vec_molecular.cpp | 2 +- src/MOLECULE/atom_vec_template.cpp | 2 +- src/MOLECULE/bond_fene.cpp | 2 +- src/MOLECULE/bond_fene_expand.cpp | 2 +- src/MOLECULE/bond_gromos.cpp | 2 +- src/MOLECULE/bond_harmonic.cpp | 2 +- src/MOLECULE/bond_morse.cpp | 2 +- src/MOLECULE/bond_nonlinear.cpp | 2 +- src/MOLECULE/bond_quartic.cpp | 2 +- src/MOLECULE/bond_table.cpp | 2 +- src/MOLECULE/dihedral_charmm.cpp | 2 +- src/MOLECULE/dihedral_charmmfsw.cpp | 2 +- src/MOLECULE/dihedral_harmonic.cpp | 2 +- src/MOLECULE/dihedral_helix.cpp | 2 +- src/MOLECULE/dihedral_multi_harmonic.cpp | 2 +- src/MOLECULE/dihedral_opls.cpp | 2 +- src/MOLECULE/fix_cmap.cpp | 2 +- src/MOLECULE/improper_cvff.cpp | 2 +- src/MOLECULE/improper_harmonic.cpp | 2 +- src/MOLECULE/improper_umbrella.cpp | 2 +- src/MOLECULE/pair_hbond_dreiding_lj.cpp | 2 +- src/MOLECULE/pair_hbond_dreiding_morse.cpp | 2 +- src/MOLECULE/pair_lj_charmm_coul_charmm.cpp | 2 +- .../pair_lj_charmm_coul_charmm_implicit.cpp | 2 +- .../pair_lj_charmmfsw_coul_charmmfsh.cpp | 2 +- src/MOLECULE/pair_lj_cut_tip4p_cut.cpp | 2 +- src/MOLECULE/pair_tip4p_cut.cpp | 2 +- src/MPIIO/dump_atom_mpiio.cpp | 2 +- src/MPIIO/dump_cfg_mpiio.cpp | 2 +- src/MPIIO/dump_custom_mpiio.cpp | 2 +- src/MPIIO/dump_xyz_mpiio.cpp | 2 +- src/MPIIO/restart_mpiio.cpp | 2 +- src/MSCG/fix_mscg.cpp | 2 +- src/OPT/pair_eam_opt.cpp | 2 +- src/OPT/pair_lj_charmm_coul_long_opt.cpp | 2 +- src/OPT/pair_lj_cut_coul_long_opt.cpp | 2 +- src/OPT/pair_lj_cut_opt.cpp | 2 +- src/OPT/pair_lj_cut_tip4p_long_opt.cpp | 2 +- src/OPT/pair_lj_long_coul_long_opt.cpp | 2 +- src/OPT/pair_morse_opt.cpp | 2 +- src/OPT/pair_ufm_opt.cpp | 2 +- src/PERI/atom_vec_peri.cpp | 2 +- src/PERI/compute_damage_atom.cpp | 2 +- src/PERI/compute_dilatation_atom.cpp | 2 +- src/PERI/compute_plasticity_atom.cpp | 2 +- src/PERI/fix_peri_neigh.cpp | 2 +- src/PERI/pair_peri_eps.cpp | 2 +- src/PERI/pair_peri_lps.cpp | 2 +- src/PERI/pair_peri_pmb.cpp | 2 +- src/PERI/pair_peri_ves.cpp | 2 +- src/POEMS/fix_poems.cpp | 2 +- src/PYTHON/fix_python_invoke.cpp | 2 +- src/PYTHON/fix_python_move.cpp | 2 +- src/PYTHON/pair_python.cpp | 2 +- src/PYTHON/python_impl.cpp | 2 +- src/QEQ/fix_qeq.cpp | 2 +- src/QEQ/fix_qeq_dynamic.cpp | 2 +- src/QEQ/fix_qeq_fire.cpp | 2 +- src/QEQ/fix_qeq_point.cpp | 2 +- src/QEQ/fix_qeq_shielded.cpp | 2 +- src/QEQ/fix_qeq_slater.cpp | 2 +- src/REPLICA/compute_event_displace.cpp | 2 +- src/REPLICA/fix_event.cpp | 2 +- src/REPLICA/fix_event_hyper.cpp | 2 +- src/REPLICA/fix_event_prd.cpp | 2 +- src/REPLICA/fix_event_tad.cpp | 2 +- src/REPLICA/fix_hyper.cpp | 2 +- src/REPLICA/fix_hyper_global.cpp | 2 +- src/REPLICA/fix_hyper_local.cpp | 2 +- src/REPLICA/fix_neb.cpp | 2 +- src/REPLICA/hyper.cpp | 2 +- src/REPLICA/neb.cpp | 2 +- src/REPLICA/prd.cpp | 2 +- src/REPLICA/tad.cpp | 2 +- src/REPLICA/temper.cpp | 2 +- src/REPLICA/verlet_split.cpp | 2 +- src/RIGID/compute_erotate_rigid.cpp | 2 +- src/RIGID/compute_ke_rigid.cpp | 2 +- src/RIGID/compute_rigid_local.cpp | 2 +- src/RIGID/fix_ehex.cpp | 2 +- src/RIGID/fix_rattle.cpp | 2 +- src/RIGID/fix_rigid.cpp | 2 +- src/RIGID/fix_rigid_nh.cpp | 2 +- src/RIGID/fix_rigid_nh_small.cpp | 2 +- src/RIGID/fix_rigid_nph.cpp | 2 +- src/RIGID/fix_rigid_nph_small.cpp | 2 +- src/RIGID/fix_rigid_npt.cpp | 2 +- src/RIGID/fix_rigid_npt_small.cpp | 2 +- src/RIGID/fix_rigid_small.cpp | 2 +- src/RIGID/fix_shake.cpp | 2 +- src/SHOCK/fix_append_atoms.cpp | 2 +- src/SHOCK/fix_msst.cpp | 2 +- src/SHOCK/fix_nphug.cpp | 2 +- src/SHOCK/fix_wall_piston.cpp | 2 +- src/SNAP/compute_sna_atom.cpp | 5 ++-- src/SNAP/compute_snad_atom.cpp | 5 ++-- src/SNAP/compute_snav_atom.cpp | 3 ++- src/SNAP/pair_snap.cpp | 2 +- src/SNAP/sna.cpp | 2 +- src/SPIN/atom_vec_spin.cpp | 2 +- src/SPIN/compute_spin.cpp | 2 +- src/SPIN/fix_langevin_spin.cpp | 2 +- src/SPIN/fix_neb_spin.cpp | 2 +- src/SPIN/fix_nve_spin.cpp | 2 +- src/SPIN/fix_precession_spin.cpp | 2 +- src/SPIN/fix_setforce_spin.cpp | 2 +- src/SPIN/min_spin.cpp | 2 +- src/SPIN/neb_spin.cpp | 2 +- src/SPIN/pair_spin.cpp | 2 +- src/SPIN/pair_spin_dipole_cut.cpp | 2 +- src/SPIN/pair_spin_dipole_long.cpp | 2 +- src/SPIN/pair_spin_dmi.cpp | 2 +- src/SPIN/pair_spin_exchange.cpp | 2 +- src/SPIN/pair_spin_magelec.cpp | 2 +- src/SPIN/pair_spin_neel.cpp | 2 +- src/SRD/fix_srd.cpp | 2 +- src/SRD/fix_wall_srd.cpp | 2 +- src/USER-ADIOS/dump_atom_adios.cpp | 2 +- src/USER-ADIOS/dump_custom_adios.cpp | 4 +-- src/USER-ATC/fix_atc.cpp | 10 +++---- src/USER-AWPMD/atom_vec_wavepacket.cpp | 2 +- src/USER-AWPMD/fix_nve_awpmd.cpp | 2 +- src/USER-AWPMD/pair_awpmd_cut.cpp | 2 +- src/USER-BOCS/compute_pressure_bocs.cpp | 2 +- src/USER-BOCS/fix_bocs.cpp | 2 +- src/USER-CGDNA/bond_oxdna2_fene.cpp | 2 +- src/USER-CGDNA/bond_oxdna_fene.cpp | 2 +- src/USER-CGDNA/fix_nve_dot.cpp | 2 +- src/USER-CGDNA/fix_nve_dotc_langevin.cpp | 2 +- src/USER-CGDNA/pair_oxdna2_coaxstk.cpp | 2 +- src/USER-CGDNA/pair_oxdna2_dh.cpp | 2 +- src/USER-CGDNA/pair_oxdna2_excv.cpp | 2 +- src/USER-CGDNA/pair_oxdna2_stk.cpp | 2 +- src/USER-CGDNA/pair_oxdna_coaxstk.cpp | 2 +- src/USER-CGDNA/pair_oxdna_excv.cpp | 2 +- src/USER-CGDNA/pair_oxdna_hbond.cpp | 2 +- src/USER-CGDNA/pair_oxdna_stk.cpp | 2 +- src/USER-CGDNA/pair_oxdna_xstk.cpp | 2 +- src/USER-CGSDK/angle_sdk.cpp | 2 +- src/USER-CGSDK/pair_lj_sdk.cpp | 2 +- src/USER-CGSDK/pair_lj_sdk_coul_long.cpp | 2 +- src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp | 2 +- src/USER-COLVARS/colvarproxy_lammps.cpp | 26 +++++++++---------- src/USER-COLVARS/fix_colvars.cpp | 2 +- src/USER-COLVARS/group_ndx.cpp | 5 ++-- src/USER-COLVARS/ndx_group.cpp | 7 +++-- 208 files changed, 233 insertions(+), 234 deletions(-) diff --git a/src/LATTE/fix_latte.cpp b/src/LATTE/fix_latte.cpp index 645b298e09..7d4e89272d 100644 --- a/src/LATTE/fix_latte.cpp +++ b/src/LATTE/fix_latte.cpp @@ -15,9 +15,9 @@ Contributing author: Christian Negre (LANL) ------------------------------------------------------------------------- */ +#include "fix_latte.h" #include #include -#include "fix_latte.h" #include "atom.h" #include "comm.h" #include "update.h" diff --git a/src/MANYBODY/fix_qeq_comb.cpp b/src/MANYBODY/fix_qeq_comb.cpp index 5019e7711a..9e9bbcc9d6 100644 --- a/src/MANYBODY/fix_qeq_comb.cpp +++ b/src/MANYBODY/fix_qeq_comb.cpp @@ -15,13 +15,13 @@ Contributing authors: Ray Shan (Sandia, tnshan@sandia.gov) ------------------------------------------------------------------------- */ +#include "fix_qeq_comb.h" #include #include #include #include #include "pair_comb.h" #include "pair_comb3.h" -#include "fix_qeq_comb.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/MANYBODY/pair_adp.cpp b/src/MANYBODY/pair_adp.cpp index 68511b8709..8051f97634 100644 --- a/src/MANYBODY/pair_adp.cpp +++ b/src/MANYBODY/pair_adp.cpp @@ -16,11 +16,11 @@ Chandra Veer Singh (Cornell) ------------------------------------------------------------------------- */ +#include "pair_adp.h" #include #include #include #include -#include "pair_adp.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/MANYBODY/pair_airebo.cpp b/src/MANYBODY/pair_airebo.cpp index e3c5a1627b..fd2016b7a7 100644 --- a/src/MANYBODY/pair_airebo.cpp +++ b/src/MANYBODY/pair_airebo.cpp @@ -20,12 +20,12 @@ Thomas C. O'Connor (JHU) 2014 ------------------------------------------------------------------------- */ +#include "pair_airebo.h" #include #include #include #include #include -#include "pair_airebo.h" #include "atom.h" #include "neighbor.h" #include "force.h" diff --git a/src/MANYBODY/pair_atm.cpp b/src/MANYBODY/pair_atm.cpp index c157e0763c..ba68033721 100644 --- a/src/MANYBODY/pair_atm.cpp +++ b/src/MANYBODY/pair_atm.cpp @@ -15,8 +15,8 @@ Contributing author: Sergey Lishchuk ------------------------------------------------------------------------- */ -#include #include "pair_atm.h" +#include #include "atom.h" #include "citeme.h" #include "comm.h" diff --git a/src/MANYBODY/pair_bop.cpp b/src/MANYBODY/pair_bop.cpp index ac157e071c..27c24ce3d7 100644 --- a/src/MANYBODY/pair_bop.cpp +++ b/src/MANYBODY/pair_bop.cpp @@ -32,12 +32,12 @@ Rules"_http://lammps.sandia.gov/open_source.html ------------------------------------------------------------------------- */ +#include "pair_bop.h" #include #include #include #include #include -#include "pair_bop.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MANYBODY/pair_comb.cpp b/src/MANYBODY/pair_comb.cpp index 980aa84b2a..b9a17eeb35 100644 --- a/src/MANYBODY/pair_comb.cpp +++ b/src/MANYBODY/pair_comb.cpp @@ -18,11 +18,11 @@ and Aidan Thompson's Tersoff code in LAMMPS ------------------------------------------------------------------------- */ +#include "pair_comb.h" #include #include #include #include -#include "pair_comb.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MANYBODY/pair_comb3.cpp b/src/MANYBODY/pair_comb3.cpp index 097f235ff2..846ef7d4b9 100644 --- a/src/MANYBODY/pair_comb3.cpp +++ b/src/MANYBODY/pair_comb3.cpp @@ -17,11 +17,11 @@ Dundar Yilmaz (dundar.yilmaz@zirve.edu.tr) ------------------------------------------------------------------------- */ +#include "pair_comb3.h" #include #include #include #include -#include "pair_comb3.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MANYBODY/pair_eam.cpp b/src/MANYBODY/pair_eam.cpp index b7957349b6..e6476b78c5 100644 --- a/src/MANYBODY/pair_eam.cpp +++ b/src/MANYBODY/pair_eam.cpp @@ -15,11 +15,11 @@ Contributing authors: Stephen Foiles (SNL), Murray Daw (SNL) ------------------------------------------------------------------------- */ +#include "pair_eam.h" #include #include #include #include -#include "pair_eam.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/MANYBODY/pair_eam_alloy.cpp b/src/MANYBODY/pair_eam_alloy.cpp index c004030240..7aae786720 100644 --- a/src/MANYBODY/pair_eam_alloy.cpp +++ b/src/MANYBODY/pair_eam_alloy.cpp @@ -15,10 +15,10 @@ Contributing authors: Stephen Foiles (SNL), Murray Daw (SNL) ------------------------------------------------------------------------- */ +#include "pair_eam_alloy.h" #include #include #include -#include "pair_eam_alloy.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MANYBODY/pair_eam_cd.cpp b/src/MANYBODY/pair_eam_cd.cpp index c111c6d950..55ad597cce 100644 --- a/src/MANYBODY/pair_eam_cd.cpp +++ b/src/MANYBODY/pair_eam_cd.cpp @@ -17,11 +17,11 @@ Germany Department of Materials Science ------------------------------------------------------------------------- */ +#include "pair_eam_cd.h" #include #include #include #include -#include "pair_eam_cd.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/MANYBODY/pair_eam_fs.cpp b/src/MANYBODY/pair_eam_fs.cpp index bbda84fdf1..7b13988d0c 100644 --- a/src/MANYBODY/pair_eam_fs.cpp +++ b/src/MANYBODY/pair_eam_fs.cpp @@ -15,10 +15,10 @@ Contributing authors: Tim Lau (MIT) ------------------------------------------------------------------------- */ +#include "pair_eam_fs.h" #include #include #include -#include "pair_eam_fs.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MANYBODY/pair_eim.cpp b/src/MANYBODY/pair_eim.cpp index f1c028ef38..58cb1fd2e0 100644 --- a/src/MANYBODY/pair_eim.cpp +++ b/src/MANYBODY/pair_eim.cpp @@ -15,11 +15,11 @@ Contributing author: Xiaowang Zhou (SNL) ------------------------------------------------------------------------- */ +#include "pair_eim.h" #include #include #include #include -#include "pair_eim.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/MANYBODY/pair_gw.cpp b/src/MANYBODY/pair_gw.cpp index e4b74f7a29..07e9201f94 100644 --- a/src/MANYBODY/pair_gw.cpp +++ b/src/MANYBODY/pair_gw.cpp @@ -16,11 +16,11 @@ based on PairTersoff by Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "pair_gw.h" #include #include #include #include -#include "pair_gw.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/MANYBODY/pair_gw_zbl.cpp b/src/MANYBODY/pair_gw_zbl.cpp index f3dd1bc04b..cd83727ed3 100644 --- a/src/MANYBODY/pair_gw_zbl.cpp +++ b/src/MANYBODY/pair_gw_zbl.cpp @@ -16,11 +16,11 @@ Based on PairTersoffZBL by Aidan Thompson (SNL) and David Farrell (NWU) ------------------------------------------------------------------------- */ +#include "pair_gw_zbl.h" #include #include #include #include -#include "pair_gw_zbl.h" #include "atom.h" #include "update.h" #include "neighbor.h" diff --git a/src/MANYBODY/pair_lcbop.cpp b/src/MANYBODY/pair_lcbop.cpp index 05cdea8055..b0240978a9 100644 --- a/src/MANYBODY/pair_lcbop.cpp +++ b/src/MANYBODY/pair_lcbop.cpp @@ -16,12 +16,12 @@ based on pair_airebo by Ase Henry (MIT) ------------------------------------------------------------------------- */ +#include "pair_lcbop.h" #include #include #include #include #include -#include "pair_lcbop.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MANYBODY/pair_nb3b_harmonic.cpp b/src/MANYBODY/pair_nb3b_harmonic.cpp index a61b403459..ac20c3e61f 100644 --- a/src/MANYBODY/pair_nb3b_harmonic.cpp +++ b/src/MANYBODY/pair_nb3b_harmonic.cpp @@ -16,11 +16,11 @@ (based on Stillinger-Weber pair style) ------------------------------------------------------------------------- */ +#include "pair_nb3b_harmonic.h" #include #include #include #include -#include "pair_nb3b_harmonic.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MANYBODY/pair_polymorphic.cpp b/src/MANYBODY/pair_polymorphic.cpp index d3aca4e889..0cca50823d 100644 --- a/src/MANYBODY/pair_polymorphic.cpp +++ b/src/MANYBODY/pair_polymorphic.cpp @@ -16,11 +16,11 @@ This modifies from pair_tersoff.cpp by Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "pair_polymorphic.h" #include #include #include #include -#include "pair_polymorphic.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index 5a148fb152..ea47fc97c3 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -15,11 +15,11 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "pair_sw.h" #include #include #include #include -#include "pair_sw.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MANYBODY/pair_tersoff.cpp b/src/MANYBODY/pair_tersoff.cpp index 213b1037bb..9d7f804f9a 100644 --- a/src/MANYBODY/pair_tersoff.cpp +++ b/src/MANYBODY/pair_tersoff.cpp @@ -15,11 +15,11 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "pair_tersoff.h" #include #include #include #include -#include "pair_tersoff.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/MANYBODY/pair_tersoff_mod.cpp b/src/MANYBODY/pair_tersoff_mod.cpp index e8fdecfe01..df3c41fc33 100644 --- a/src/MANYBODY/pair_tersoff_mod.cpp +++ b/src/MANYBODY/pair_tersoff_mod.cpp @@ -16,11 +16,11 @@ Vitaly Dozhdikov (JIHT of RAS) - MOD addition ------------------------------------------------------------------------- */ +#include "pair_tersoff_mod.h" #include #include #include #include -#include "pair_tersoff_mod.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/MANYBODY/pair_tersoff_mod_c.cpp b/src/MANYBODY/pair_tersoff_mod_c.cpp index 4a5904c106..d34291f6cd 100644 --- a/src/MANYBODY/pair_tersoff_mod_c.cpp +++ b/src/MANYBODY/pair_tersoff_mod_c.cpp @@ -15,11 +15,11 @@ Contributing author: Ganga P Purja Pun (George Mason University, Fairfax) ------------------------------------------------------------------------- */ +#include "pair_tersoff_mod_c.h" #include #include #include #include -#include "pair_tersoff_mod_c.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/MANYBODY/pair_tersoff_zbl.cpp b/src/MANYBODY/pair_tersoff_zbl.cpp index 353e3d2264..6a8aa40782 100644 --- a/src/MANYBODY/pair_tersoff_zbl.cpp +++ b/src/MANYBODY/pair_tersoff_zbl.cpp @@ -16,11 +16,11 @@ David Farrell (NWU) - ZBL addition ------------------------------------------------------------------------- */ +#include "pair_tersoff_zbl.h" #include #include #include #include -#include "pair_tersoff_zbl.h" #include "atom.h" #include "update.h" #include "neighbor.h" diff --git a/src/MANYBODY/pair_vashishta.cpp b/src/MANYBODY/pair_vashishta.cpp index 3d4b1d900e..5055dadfaf 100644 --- a/src/MANYBODY/pair_vashishta.cpp +++ b/src/MANYBODY/pair_vashishta.cpp @@ -16,11 +16,11 @@ Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "pair_vashishta.h" #include #include #include #include -#include "pair_vashishta.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MANYBODY/pair_vashishta_table.cpp b/src/MANYBODY/pair_vashishta_table.cpp index d4eaa59f1a..726e0f83f1 100644 --- a/src/MANYBODY/pair_vashishta_table.cpp +++ b/src/MANYBODY/pair_vashishta_table.cpp @@ -15,11 +15,11 @@ Contributing author: Anders Hafreager (UiO), andershaf@gmail.com ------------------------------------------------------------------------- */ +#include "pair_vashishta_table.h" #include #include #include #include -#include "pair_vashishta_table.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MC/fix_atom_swap.cpp b/src/MC/fix_atom_swap.cpp index 7d817ffbb1..c14efcca46 100644 --- a/src/MC/fix_atom_swap.cpp +++ b/src/MC/fix_atom_swap.cpp @@ -16,11 +16,11 @@ Alexander Stukowski ------------------------------------------------------------------------- */ +#include "fix_atom_swap.h" #include #include #include #include -#include "fix_atom_swap.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_hybrid.h" diff --git a/src/MC/fix_bond_break.cpp b/src/MC/fix_bond_break.cpp index 05edc0509e..1b07395f1e 100644 --- a/src/MC/fix_bond_break.cpp +++ b/src/MC/fix_bond_break.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_bond_break.h" #include #include #include #include -#include "fix_bond_break.h" #include "update.h" #include "respa.h" #include "atom.h" diff --git a/src/MC/fix_bond_create.cpp b/src/MC/fix_bond_create.cpp index e1dd18cb5b..d2d93b67f6 100644 --- a/src/MC/fix_bond_create.cpp +++ b/src/MC/fix_bond_create.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_bond_create.h" #include #include #include #include -#include "fix_bond_create.h" #include "update.h" #include "respa.h" #include "atom.h" diff --git a/src/MC/fix_bond_swap.cpp b/src/MC/fix_bond_swap.cpp index 5da2b845d6..187c552416 100644 --- a/src/MC/fix_bond_swap.cpp +++ b/src/MC/fix_bond_swap.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_bond_swap.h" #include #include #include -#include "fix_bond_swap.h" #include "atom.h" #include "force.h" #include "pair.h" diff --git a/src/MC/fix_gcmc.cpp b/src/MC/fix_gcmc.cpp index 4e48b71611..8fe6042c2e 100644 --- a/src/MC/fix_gcmc.cpp +++ b/src/MC/fix_gcmc.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Crozier, Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "fix_gcmc.h" #include #include #include -#include "fix_gcmc.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_hybrid.h" diff --git a/src/MC/pair_dsmc.cpp b/src/MC/pair_dsmc.cpp index c71eaa2295..cf48706133 100644 --- a/src/MC/pair_dsmc.cpp +++ b/src/MC/pair_dsmc.cpp @@ -15,12 +15,12 @@ Contributing authors: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_dsmc.h" #include #include #include #include #include -#include "pair_dsmc.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MESSAGE/fix_client_md.cpp b/src/MESSAGE/fix_client_md.cpp index 727481dcc0..7d4ae13f0f 100644 --- a/src/MESSAGE/fix_client_md.cpp +++ b/src/MESSAGE/fix_client_md.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_client_md.h" #include #include -#include "fix_client_md.h" #include "update.h" #include "atom.h" #include "comm.h" diff --git a/src/MESSAGE/message.cpp b/src/MESSAGE/message.cpp index 61221ca26e..f8fc349746 100644 --- a/src/MESSAGE/message.cpp +++ b/src/MESSAGE/message.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "message.h" +#include #include "error.h" // CSlib interface diff --git a/src/MESSAGE/server.cpp b/src/MESSAGE/server.cpp index f587fb76df..dbcec08488 100644 --- a/src/MESSAGE/server.cpp +++ b/src/MESSAGE/server.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "server.h" +#include #include "error.h" // customize by adding a new server protocol include and enum diff --git a/src/MESSAGE/server_md.cpp b/src/MESSAGE/server_md.cpp index bef327616e..e16095ad4c 100644 --- a/src/MESSAGE/server_md.cpp +++ b/src/MESSAGE/server_md.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "server_md.h" #include #include -#include "server_md.h" #include "atom.h" #include "atom_vec.h" #include "update.h" diff --git a/src/MISC/compute_msd_nongauss.cpp b/src/MISC/compute_msd_nongauss.cpp index f6291f4204..e02dd633cb 100644 --- a/src/MISC/compute_msd_nongauss.cpp +++ b/src/MISC/compute_msd_nongauss.cpp @@ -15,8 +15,8 @@ Contributing authors: Rob Hoy ------------------------------------------------------------------------- */ -#include #include "compute_msd_nongauss.h" +#include #include "atom.h" #include "update.h" #include "group.h" diff --git a/src/MISC/compute_ti.cpp b/src/MISC/compute_ti.cpp index d2e43a9f69..266263785f 100644 --- a/src/MISC/compute_ti.cpp +++ b/src/MISC/compute_ti.cpp @@ -15,10 +15,10 @@ Contributing author: Sai Jayaraman (University of Notre Dame) ------------------------------------------------------------------------- */ +#include "compute_ti.h" #include -#include "atom.h" #include -#include "compute_ti.h" +#include "atom.h" #include "update.h" #include "modify.h" #include "domain.h" diff --git a/src/MISC/dump_xtc.cpp b/src/MISC/dump_xtc.cpp index a82cba20bd..7abe4c4093 100644 --- a/src/MISC/dump_xtc.cpp +++ b/src/MISC/dump_xtc.cpp @@ -22,12 +22,12 @@ support for groups ------------------------------------------------------------------------- */ +#include "dump_xtc.h" #include #include #include #include #include -#include "dump_xtc.h" #include "domain.h" #include "atom.h" #include "update.h" diff --git a/src/MISC/fix_deposit.cpp b/src/MISC/fix_deposit.cpp index 66aed34846..22a144da60 100644 --- a/src/MISC/fix_deposit.cpp +++ b/src/MISC/fix_deposit.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_deposit.h" #include #include #include -#include "fix_deposit.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/MISC/fix_efield.cpp b/src/MISC/fix_efield.cpp index 004c8ad7bc..87ece82f57 100644 --- a/src/MISC/fix_efield.cpp +++ b/src/MISC/fix_efield.cpp @@ -16,10 +16,10 @@ Stan Moore (Sandia) for dipole terms ------------------------------------------------------------------------- */ +#include "fix_efield.h" #include #include #include -#include "fix_efield.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/MISC/fix_evaporate.cpp b/src/MISC/fix_evaporate.cpp index 1bf7a15f1f..e2c7844853 100644 --- a/src/MISC/fix_evaporate.cpp +++ b/src/MISC/fix_evaporate.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_evaporate.h" #include #include #include -#include "fix_evaporate.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/MISC/fix_gld.cpp b/src/MISC/fix_gld.cpp index 2bf02889a5..265ee4fb09 100644 --- a/src/MISC/fix_gld.cpp +++ b/src/MISC/fix_gld.cpp @@ -16,10 +16,10 @@ Andrew Baczewski (Michigan State/SNL) ------------------------------------------------------------------------- */ +#include "fix_gld.h" #include #include #include -#include "fix_gld.h" #include "math_extra.h" #include "atom.h" #include "force.h" diff --git a/src/MISC/fix_oneway.cpp b/src/MISC/fix_oneway.cpp index 73853775a3..fcf5a7a0bd 100644 --- a/src/MISC/fix_oneway.cpp +++ b/src/MISC/fix_oneway.cpp @@ -15,8 +15,8 @@ Contributing author: Axel Kohlmeyer (ICTP, Italy) ------------------------------------------------------------------------- */ -#include #include "fix_oneway.h" +#include #include "atom.h" #include "domain.h" #include "error.h" diff --git a/src/MISC/fix_orient_bcc.cpp b/src/MISC/fix_orient_bcc.cpp index 02cce5a014..a300631658 100644 --- a/src/MISC/fix_orient_bcc.cpp +++ b/src/MISC/fix_orient_bcc.cpp @@ -18,11 +18,11 @@ (https://dx.doi.org/10.6084/m9.figshare.1488628.v1 ------------------------------------------------------------------------- */ +#include "fix_orient_bcc.h" #include #include #include #include -#include "fix_orient_bcc.h" #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/MISC/fix_orient_fcc.cpp b/src/MISC/fix_orient_fcc.cpp index fc827ceb8f..d898f95d2c 100644 --- a/src/MISC/fix_orient_fcc.cpp +++ b/src/MISC/fix_orient_fcc.cpp @@ -15,11 +15,11 @@ Contributing authors: Koenraad Janssens and David Olmsted (SNL) ------------------------------------------------------------------------- */ +#include "fix_orient_fcc.h" #include #include #include #include -#include "fix_orient_fcc.h" #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/MISC/fix_thermal_conductivity.cpp b/src/MISC/fix_thermal_conductivity.cpp index f1aec3ff69..8da303c8ab 100644 --- a/src/MISC/fix_thermal_conductivity.cpp +++ b/src/MISC/fix_thermal_conductivity.cpp @@ -16,11 +16,11 @@ for swapping atoms of different masses ------------------------------------------------------------------------- */ +#include "fix_thermal_conductivity.h" #include #include #include #include -#include "fix_thermal_conductivity.h" #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/MISC/fix_ttm.cpp b/src/MISC/fix_ttm.cpp index 170103b0d0..06de732de6 100644 --- a/src/MISC/fix_ttm.cpp +++ b/src/MISC/fix_ttm.cpp @@ -16,11 +16,11 @@ Carolyn Phillips (University of Michigan) ------------------------------------------------------------------------- */ +#include "fix_ttm.h" #include #include #include #include -#include "fix_ttm.h" #include "atom.h" #include "force.h" #include "update.h" diff --git a/src/MISC/fix_viscosity.cpp b/src/MISC/fix_viscosity.cpp index 8e33c1c614..52107954c2 100644 --- a/src/MISC/fix_viscosity.cpp +++ b/src/MISC/fix_viscosity.cpp @@ -16,11 +16,11 @@ for swapping atoms of different masses ------------------------------------------------------------------------- */ +#include "fix_viscosity.h" #include #include #include #include -#include "fix_viscosity.h" #include "atom.h" #include "domain.h" #include "modify.h" diff --git a/src/MISC/pair_nm_cut.cpp b/src/MISC/pair_nm_cut.cpp index 124832b63e..9b8c36da3a 100644 --- a/src/MISC/pair_nm_cut.cpp +++ b/src/MISC/pair_nm_cut.cpp @@ -15,11 +15,11 @@ Contributing Author: Julien Devemy (ICCF) ------------------------------------------------------------------------- */ +#include "pair_nm_cut.h" #include #include #include #include -#include "pair_nm_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MISC/pair_nm_cut_coul_cut.cpp b/src/MISC/pair_nm_cut_coul_cut.cpp index a8428ab980..069c363817 100644 --- a/src/MISC/pair_nm_cut_coul_cut.cpp +++ b/src/MISC/pair_nm_cut_coul_cut.cpp @@ -15,11 +15,11 @@ Contributing Author: Julien Devemy (ICCF) ------------------------------------------------------------------------- */ +#include "pair_nm_cut_coul_cut.h" #include #include #include #include -#include "pair_nm_cut_coul_cut.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MISC/pair_nm_cut_coul_long.cpp b/src/MISC/pair_nm_cut_coul_long.cpp index af21f02881..b3d42b05f8 100644 --- a/src/MISC/pair_nm_cut_coul_long.cpp +++ b/src/MISC/pair_nm_cut_coul_long.cpp @@ -15,11 +15,11 @@ Contributing Author: Julien Devemy (ICCF) ------------------------------------------------------------------------- */ +#include "pair_nm_cut_coul_long.h" #include #include #include #include -#include "pair_nm_cut_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MISC/xdr_compat.cpp b/src/MISC/xdr_compat.cpp index 2d8d0ce7e5..e124d52d7b 100644 --- a/src/MISC/xdr_compat.cpp +++ b/src/MISC/xdr_compat.cpp @@ -1,7 +1,7 @@ +#include "xdr_compat.h" #include #include #include -#include "xdr_compat.h" /* This file is needed for systems, that do not provide XDR support * in their system libraries. It was written for windows, but will diff --git a/src/MOLECULE/angle_charmm.cpp b/src/MOLECULE/angle_charmm.cpp index efd1c682f7..fb0afd78c3 100644 --- a/src/MOLECULE/angle_charmm.cpp +++ b/src/MOLECULE/angle_charmm.cpp @@ -15,9 +15,9 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "angle_charmm.h" #include #include -#include "angle_charmm.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_cosine.cpp b/src/MOLECULE/angle_cosine.cpp index 6e1b9fa2fb..aff5130323 100644 --- a/src/MOLECULE/angle_cosine.cpp +++ b/src/MOLECULE/angle_cosine.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "angle_cosine.h" #include #include -#include "angle_cosine.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_cosine_delta.cpp b/src/MOLECULE/angle_cosine_delta.cpp index eca10970f2..13ed00b327 100644 --- a/src/MOLECULE/angle_cosine_delta.cpp +++ b/src/MOLECULE/angle_cosine_delta.cpp @@ -15,9 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U), akohlmey at gmail.com ------------------------------------------------------------------------- */ +#include "angle_cosine_delta.h" #include #include -#include "angle_cosine_delta.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_cosine_periodic.cpp b/src/MOLECULE/angle_cosine_periodic.cpp index cb0a26871a..9f7c02cabc 100644 --- a/src/MOLECULE/angle_cosine_periodic.cpp +++ b/src/MOLECULE/angle_cosine_periodic.cpp @@ -15,9 +15,9 @@ Contributing author: Tod A Pascal (Caltech) ------------------------------------------------------------------------- */ +#include "angle_cosine_periodic.h" #include #include -#include "angle_cosine_periodic.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_cosine_squared.cpp b/src/MOLECULE/angle_cosine_squared.cpp index 28d63344a4..789a536c98 100644 --- a/src/MOLECULE/angle_cosine_squared.cpp +++ b/src/MOLECULE/angle_cosine_squared.cpp @@ -15,9 +15,9 @@ Contributing author: Naveen Michaud-Agrawal (Johns Hopkins U) ------------------------------------------------------------------------- */ +#include "angle_cosine_squared.h" #include #include -#include "angle_cosine_squared.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_harmonic.cpp b/src/MOLECULE/angle_harmonic.cpp index 48b493d9b2..b626bdfae5 100644 --- a/src/MOLECULE/angle_harmonic.cpp +++ b/src/MOLECULE/angle_harmonic.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "angle_harmonic.h" #include #include -#include "angle_harmonic.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_table.cpp b/src/MOLECULE/angle_table.cpp index c18b4c43b0..ce7fcdcaf2 100644 --- a/src/MOLECULE/angle_table.cpp +++ b/src/MOLECULE/angle_table.cpp @@ -15,10 +15,10 @@ Contributing author: Chuanfu Luo (luochuanfu@gmail.com) ------------------------------------------------------------------------- */ +#include "angle_table.h" #include #include #include -#include "angle_table.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/atom_vec_angle.cpp b/src/MOLECULE/atom_vec_angle.cpp index 6eb5b50fd2..f3c48aa87a 100644 --- a/src/MOLECULE/atom_vec_angle.cpp +++ b/src/MOLECULE/atom_vec_angle.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_angle.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/MOLECULE/atom_vec_bond.cpp b/src/MOLECULE/atom_vec_bond.cpp index 6a7b3585b4..b0f76adc45 100644 --- a/src/MOLECULE/atom_vec_bond.cpp +++ b/src/MOLECULE/atom_vec_bond.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_bond.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/MOLECULE/atom_vec_full.cpp b/src/MOLECULE/atom_vec_full.cpp index d682abf799..c9b2402062 100644 --- a/src/MOLECULE/atom_vec_full.cpp +++ b/src/MOLECULE/atom_vec_full.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_full.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/MOLECULE/atom_vec_molecular.cpp b/src/MOLECULE/atom_vec_molecular.cpp index cdd3f02505..524f7bcb0d 100644 --- a/src/MOLECULE/atom_vec_molecular.cpp +++ b/src/MOLECULE/atom_vec_molecular.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "atom_vec_molecular.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/MOLECULE/atom_vec_template.cpp b/src/MOLECULE/atom_vec_template.cpp index 3172804b95..6a12027b7b 100644 --- a/src/MOLECULE/atom_vec_template.cpp +++ b/src/MOLECULE/atom_vec_template.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_template.h" #include #include -#include "atom_vec_template.h" #include "atom.h" #include "molecule.h" #include "comm.h" diff --git a/src/MOLECULE/bond_fene.cpp b/src/MOLECULE/bond_fene.cpp index c023a7e81e..d4f2a4010e 100644 --- a/src/MOLECULE/bond_fene.cpp +++ b/src/MOLECULE/bond_fene.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "bond_fene.h" #include #include -#include "bond_fene.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/bond_fene_expand.cpp b/src/MOLECULE/bond_fene_expand.cpp index b1bfdc6a1b..3e4ceab42c 100644 --- a/src/MOLECULE/bond_fene_expand.cpp +++ b/src/MOLECULE/bond_fene_expand.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "bond_fene_expand.h" #include #include -#include "bond_fene_expand.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/bond_gromos.cpp b/src/MOLECULE/bond_gromos.cpp index f65adeb2cb..44e99d8fe0 100644 --- a/src/MOLECULE/bond_gromos.cpp +++ b/src/MOLECULE/bond_gromos.cpp @@ -15,10 +15,10 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "bond_gromos.h" #include #include #include -#include "bond_gromos.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/bond_harmonic.cpp b/src/MOLECULE/bond_harmonic.cpp index cb8434ce6e..bbbad4102d 100644 --- a/src/MOLECULE/bond_harmonic.cpp +++ b/src/MOLECULE/bond_harmonic.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "bond_harmonic.h" #include #include #include -#include "bond_harmonic.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/bond_morse.cpp b/src/MOLECULE/bond_morse.cpp index 91dd2dbc49..af476d6fe8 100644 --- a/src/MOLECULE/bond_morse.cpp +++ b/src/MOLECULE/bond_morse.cpp @@ -15,9 +15,9 @@ Contributing author: Jeff Greathouse (SNL) ------------------------------------------------------------------------- */ +#include "bond_morse.h" #include #include -#include "bond_morse.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/bond_nonlinear.cpp b/src/MOLECULE/bond_nonlinear.cpp index 9999ead47f..89ddb7b118 100644 --- a/src/MOLECULE/bond_nonlinear.cpp +++ b/src/MOLECULE/bond_nonlinear.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "bond_nonlinear.h" #include #include -#include "bond_nonlinear.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/bond_quartic.cpp b/src/MOLECULE/bond_quartic.cpp index 895202ff00..34b3ad8288 100644 --- a/src/MOLECULE/bond_quartic.cpp +++ b/src/MOLECULE/bond_quartic.cpp @@ -15,9 +15,9 @@ Contributing authors: Chris Lorenz and Mark Stevens (SNL) ------------------------------------------------------------------------- */ +#include "bond_quartic.h" #include #include -#include "bond_quartic.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/bond_table.cpp b/src/MOLECULE/bond_table.cpp index 10851774d7..e80baee6e8 100644 --- a/src/MOLECULE/bond_table.cpp +++ b/src/MOLECULE/bond_table.cpp @@ -15,10 +15,10 @@ Contributing author: Chuanfu Luo (luochuanfu@gmail.com) ------------------------------------------------------------------------- */ +#include "bond_table.h" #include #include #include -#include "bond_table.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/dihedral_charmm.cpp b/src/MOLECULE/dihedral_charmm.cpp index 68c62eb4fd..1905c14358 100644 --- a/src/MOLECULE/dihedral_charmm.cpp +++ b/src/MOLECULE/dihedral_charmm.cpp @@ -15,11 +15,11 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "dihedral_charmm.h" #include #include #include #include -#include "dihedral_charmm.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/MOLECULE/dihedral_charmmfsw.cpp b/src/MOLECULE/dihedral_charmmfsw.cpp index f65d01e9ed..9b02b908d6 100644 --- a/src/MOLECULE/dihedral_charmmfsw.cpp +++ b/src/MOLECULE/dihedral_charmmfsw.cpp @@ -18,11 +18,11 @@ with additional assistance from Robert A. Latour, Clemson University ------------------------------------------------------------------------- */ +#include "dihedral_charmmfsw.h" #include #include #include #include -#include "dihedral_charmmfsw.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/MOLECULE/dihedral_harmonic.cpp b/src/MOLECULE/dihedral_harmonic.cpp index ddb94dc571..159636ecd5 100644 --- a/src/MOLECULE/dihedral_harmonic.cpp +++ b/src/MOLECULE/dihedral_harmonic.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "dihedral_harmonic.h" #include #include #include -#include "dihedral_harmonic.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/MOLECULE/dihedral_helix.cpp b/src/MOLECULE/dihedral_helix.cpp index d19731c097..a7d2aba1d6 100644 --- a/src/MOLECULE/dihedral_helix.cpp +++ b/src/MOLECULE/dihedral_helix.cpp @@ -16,10 +16,10 @@ Mark Stevens (Sandia) ------------------------------------------------------------------------- */ +#include "dihedral_helix.h" #include #include #include -#include "dihedral_helix.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/dihedral_multi_harmonic.cpp b/src/MOLECULE/dihedral_multi_harmonic.cpp index 04e7bbb627..ba98cf6ddf 100644 --- a/src/MOLECULE/dihedral_multi_harmonic.cpp +++ b/src/MOLECULE/dihedral_multi_harmonic.cpp @@ -15,9 +15,9 @@ Contributing author: Mathias Puetz (SNL) and friends ------------------------------------------------------------------------- */ +#include "dihedral_multi_harmonic.h" #include #include -#include "dihedral_multi_harmonic.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/dihedral_opls.cpp b/src/MOLECULE/dihedral_opls.cpp index 293245e411..d68eba0bec 100644 --- a/src/MOLECULE/dihedral_opls.cpp +++ b/src/MOLECULE/dihedral_opls.cpp @@ -15,9 +15,9 @@ Contributing author: Mark Stevens (SNL) ------------------------------------------------------------------------- */ +#include "dihedral_opls.h" #include #include -#include "dihedral_opls.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/MOLECULE/fix_cmap.cpp b/src/MOLECULE/fix_cmap.cpp index 3395c7ef14..3d5bf90bdc 100644 --- a/src/MOLECULE/fix_cmap.cpp +++ b/src/MOLECULE/fix_cmap.cpp @@ -27,12 +27,12 @@ - MacKerell et al., J. Comput. Chem. 25(2004):1400-1415. ------------------------------------------------------------------------- */ +#include "fix_cmap.h" #include #include #include #include #include -#include "fix_cmap.h" #include "atom.h" #include "atom_vec.h" #include "update.h" diff --git a/src/MOLECULE/improper_cvff.cpp b/src/MOLECULE/improper_cvff.cpp index 01e9729e80..fd24ab69c3 100644 --- a/src/MOLECULE/improper_cvff.cpp +++ b/src/MOLECULE/improper_cvff.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "improper_cvff.h" #include #include #include -#include "improper_cvff.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/MOLECULE/improper_harmonic.cpp b/src/MOLECULE/improper_harmonic.cpp index c5421fffdb..936c22e94a 100644 --- a/src/MOLECULE/improper_harmonic.cpp +++ b/src/MOLECULE/improper_harmonic.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "improper_harmonic.h" #include #include #include -#include "improper_harmonic.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/MOLECULE/improper_umbrella.cpp b/src/MOLECULE/improper_umbrella.cpp index 3de46df0f3..2e41ac6493 100644 --- a/src/MOLECULE/improper_umbrella.cpp +++ b/src/MOLECULE/improper_umbrella.cpp @@ -15,10 +15,10 @@ Contributing author: Tod A Pascal (Caltech) ------------------------------------------------------------------------- */ +#include "improper_umbrella.h" #include #include #include -#include "improper_umbrella.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/MOLECULE/pair_hbond_dreiding_lj.cpp b/src/MOLECULE/pair_hbond_dreiding_lj.cpp index ddc1110081..58666f27d1 100644 --- a/src/MOLECULE/pair_hbond_dreiding_lj.cpp +++ b/src/MOLECULE/pair_hbond_dreiding_lj.cpp @@ -15,11 +15,11 @@ Contributing author: Tod A Pascal (Caltech) ------------------------------------------------------------------------- */ +#include "pair_hbond_dreiding_lj.h" #include #include #include #include -#include "pair_hbond_dreiding_lj.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/MOLECULE/pair_hbond_dreiding_morse.cpp b/src/MOLECULE/pair_hbond_dreiding_morse.cpp index 055f0ed46b..120a2d8d55 100644 --- a/src/MOLECULE/pair_hbond_dreiding_morse.cpp +++ b/src/MOLECULE/pair_hbond_dreiding_morse.cpp @@ -15,11 +15,11 @@ Contributing author: Tod A Pascal (Caltech) ------------------------------------------------------------------------- */ +#include "pair_hbond_dreiding_morse.h" #include #include #include #include -#include "pair_hbond_dreiding_morse.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp b/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp index af4611e014..c9becb75c3 100644 --- a/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp +++ b/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp @@ -15,11 +15,11 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_charmm.h" #include #include #include #include -#include "pair_lj_charmm_coul_charmm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp b/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp index d68d5e8f6d..a2be2936b2 100644 --- a/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp +++ b/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_charmm_implicit.h" #include #include -#include "pair_lj_charmm_coul_charmm_implicit.h" #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp b/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp index 0e1cbd85a5..f2f16c88ce 100644 --- a/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp +++ b/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp @@ -19,11 +19,11 @@ with additional assistance from Robert A. Latour, Clemson University ------------------------------------------------------------------------- */ +#include "pair_lj_charmmfsw_coul_charmmfsh.h" #include #include #include #include -#include "pair_lj_charmmfsw_coul_charmmfsh.h" #include "atom.h" #include "update.h" #include "comm.h" diff --git a/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp b/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp index 2b3d2c60f5..5bb82d7635 100644 --- a/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp +++ b/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp @@ -15,10 +15,10 @@ Contributing author: Pavel Elkind (Gothenburg University) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_tip4p_cut.h" #include #include #include -#include "pair_lj_cut_tip4p_cut.h" #include "atom.h" #include "force.h" #include "neighbor.h" diff --git a/src/MOLECULE/pair_tip4p_cut.cpp b/src/MOLECULE/pair_tip4p_cut.cpp index e6fb9aab99..1511c09384 100644 --- a/src/MOLECULE/pair_tip4p_cut.cpp +++ b/src/MOLECULE/pair_tip4p_cut.cpp @@ -15,9 +15,9 @@ Contributing author: Pavel Elkind (Gothenburg University) ------------------------------------------------------------------------- */ +#include "pair_tip4p_cut.h" #include #include -#include "pair_tip4p_cut.h" #include "atom.h" #include "force.h" #include "neighbor.h" diff --git a/src/MPIIO/dump_atom_mpiio.cpp b/src/MPIIO/dump_atom_mpiio.cpp index f2f2991442..cde5b6258b 100644 --- a/src/MPIIO/dump_atom_mpiio.cpp +++ b/src/MPIIO/dump_atom_mpiio.cpp @@ -15,8 +15,8 @@ Contributing author: Paul Coffman (IBM) ------------------------------------------------------------------------- */ -#include #include "dump_atom_mpiio.h" +#include #include "domain.h" #include "atom.h" #include "update.h" diff --git a/src/MPIIO/dump_cfg_mpiio.cpp b/src/MPIIO/dump_cfg_mpiio.cpp index c580d2e7af..90f92d094d 100644 --- a/src/MPIIO/dump_cfg_mpiio.cpp +++ b/src/MPIIO/dump_cfg_mpiio.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Coffman (IBM) ------------------------------------------------------------------------- */ +#include "dump_cfg_mpiio.h" #include #include #include -#include "dump_cfg_mpiio.h" #include "atom.h" #include "domain.h" #include "comm.h" diff --git a/src/MPIIO/dump_custom_mpiio.cpp b/src/MPIIO/dump_custom_mpiio.cpp index 3650ca994e..5838c61124 100644 --- a/src/MPIIO/dump_custom_mpiio.cpp +++ b/src/MPIIO/dump_custom_mpiio.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Coffman (IBM) ------------------------------------------------------------------------- */ +#include "dump_custom_mpiio.h" #include #include #include -#include "dump_custom_mpiio.h" #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/MPIIO/dump_xyz_mpiio.cpp b/src/MPIIO/dump_xyz_mpiio.cpp index f15d340cd1..7b647561bf 100644 --- a/src/MPIIO/dump_xyz_mpiio.cpp +++ b/src/MPIIO/dump_xyz_mpiio.cpp @@ -15,10 +15,10 @@ Contributing author: Paul Coffman (IBM) ------------------------------------------------------------------------- */ +#include "dump_xyz_mpiio.h" #include #include #include -#include "dump_xyz_mpiio.h" #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/MPIIO/restart_mpiio.cpp b/src/MPIIO/restart_mpiio.cpp index 804df211dc..e8ef5c6c4e 100644 --- a/src/MPIIO/restart_mpiio.cpp +++ b/src/MPIIO/restart_mpiio.cpp @@ -15,9 +15,9 @@ Contributing author: Paul Coffman (IBM) ------------------------------------------------------------------------- */ +#include "restart_mpiio.h" #include #include -#include "restart_mpiio.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/MSCG/fix_mscg.cpp b/src/MSCG/fix_mscg.cpp index b282595240..caa9a528a7 100644 --- a/src/MSCG/fix_mscg.cpp +++ b/src/MSCG/fix_mscg.cpp @@ -15,10 +15,10 @@ Contributing authors: Lauren Abbott (Sandia) ------------------------------------------------------------------------- */ +#include "fix_mscg.h" #include #include #include -#include "fix_mscg.h" #include "mscg.h" #include "atom.h" #include "comm.h" diff --git a/src/OPT/pair_eam_opt.cpp b/src/OPT/pair_eam_opt.cpp index fc2b6731ee..ad24aaee63 100644 --- a/src/OPT/pair_eam_opt.cpp +++ b/src/OPT/pair_eam_opt.cpp @@ -19,9 +19,9 @@ Vincent Natoli, Stone Ridge Technology ------------------------------------------------------------------------- */ +#include "pair_eam_opt.h" #include #include -#include "pair_eam_opt.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/OPT/pair_lj_charmm_coul_long_opt.cpp b/src/OPT/pair_lj_charmm_coul_long_opt.cpp index d80d3d1ec4..3dc6bdb6b4 100644 --- a/src/OPT/pair_lj_charmm_coul_long_opt.cpp +++ b/src/OPT/pair_lj_charmm_coul_long_opt.cpp @@ -18,9 +18,9 @@ Vincent Natoli, Stone Ridge Technology ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_long_opt.h" #include #include -#include "pair_lj_charmm_coul_long_opt.h" #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/OPT/pair_lj_cut_coul_long_opt.cpp b/src/OPT/pair_lj_cut_coul_long_opt.cpp index a25010cf1f..a1f97aaae9 100644 --- a/src/OPT/pair_lj_cut_coul_long_opt.cpp +++ b/src/OPT/pair_lj_cut_coul_long_opt.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "pair_lj_cut_coul_long_opt.h" +#include #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/OPT/pair_lj_cut_opt.cpp b/src/OPT/pair_lj_cut_opt.cpp index c6684461be..3b3a19a9e8 100644 --- a/src/OPT/pair_lj_cut_opt.cpp +++ b/src/OPT/pair_lj_cut_opt.cpp @@ -18,8 +18,8 @@ Vincent Natoli, Stone Ridge Technology ------------------------------------------------------------------------- */ -#include #include "pair_lj_cut_opt.h" +#include #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/OPT/pair_lj_cut_tip4p_long_opt.cpp b/src/OPT/pair_lj_cut_tip4p_long_opt.cpp index 92facca43e..f8181d69a6 100644 --- a/src/OPT/pair_lj_cut_tip4p_long_opt.cpp +++ b/src/OPT/pair_lj_cut_tip4p_long_opt.cpp @@ -15,8 +15,8 @@ OPT version: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_lj_cut_tip4p_long_opt.h" +#include #include "atom.h" #include "domain.h" #include "force.h" diff --git a/src/OPT/pair_lj_long_coul_long_opt.cpp b/src/OPT/pair_lj_long_coul_long_opt.cpp index 03853057f4..c323d078c4 100644 --- a/src/OPT/pair_lj_long_coul_long_opt.cpp +++ b/src/OPT/pair_lj_long_coul_long_opt.cpp @@ -15,9 +15,9 @@ OPT version: Wayne Mitchell (Loyola University New Orleans) ------------------------------------------------------------------------- */ +#include "pair_lj_long_coul_long_opt.h" #include #include -#include "pair_lj_long_coul_long_opt.h" #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/OPT/pair_morse_opt.cpp b/src/OPT/pair_morse_opt.cpp index c9c6bba355..1d2e226777 100644 --- a/src/OPT/pair_morse_opt.cpp +++ b/src/OPT/pair_morse_opt.cpp @@ -18,9 +18,9 @@ Vincent Natoli, Stone Ridge Technology ------------------------------------------------------------------------- */ +#include "pair_morse_opt.h" #include #include -#include "pair_morse_opt.h" #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/OPT/pair_ufm_opt.cpp b/src/OPT/pair_ufm_opt.cpp index f463dac3f1..eabb093b18 100644 --- a/src/OPT/pair_ufm_opt.cpp +++ b/src/OPT/pair_ufm_opt.cpp @@ -17,9 +17,9 @@ Maurice de Koning (Unicamp/Brazil) - dekoning@ifi.unicamp.br ------------------------------------------------------------------------- */ +#include "pair_ufm_opt.h" #include #include -#include "pair_ufm_opt.h" #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/PERI/atom_vec_peri.cpp b/src/PERI/atom_vec_peri.cpp index d78fe27c94..f677b24eb2 100644 --- a/src/PERI/atom_vec_peri.cpp +++ b/src/PERI/atom_vec_peri.cpp @@ -15,10 +15,10 @@ Contributing author: Mike Parks (SNL) ------------------------------------------------------------------------- */ +#include "atom_vec_peri.h" #include #include #include -#include "atom_vec_peri.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/PERI/compute_damage_atom.cpp b/src/PERI/compute_damage_atom.cpp index 4bf8fa17a5..f5a532cd0b 100644 --- a/src/PERI/compute_damage_atom.cpp +++ b/src/PERI/compute_damage_atom.cpp @@ -15,8 +15,8 @@ Contributing author: Mike Parks (SNL) ------------------------------------------------------------------------- */ -#include #include "compute_damage_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/PERI/compute_dilatation_atom.cpp b/src/PERI/compute_dilatation_atom.cpp index 990731a227..7a6607d65c 100644 --- a/src/PERI/compute_dilatation_atom.cpp +++ b/src/PERI/compute_dilatation_atom.cpp @@ -15,8 +15,8 @@ Contributing author: Rezwanur Rahman, John Foster (UTSA) ------------------------------------------------------------------------- */ -#include #include "compute_dilatation_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/PERI/compute_plasticity_atom.cpp b/src/PERI/compute_plasticity_atom.cpp index d08fb98e07..0b20bc5075 100644 --- a/src/PERI/compute_plasticity_atom.cpp +++ b/src/PERI/compute_plasticity_atom.cpp @@ -15,8 +15,8 @@ Contributing author: Rezwanur Rahman, John Foster (UTSA) ------------------------------------------------------------------------- */ -#include #include "compute_plasticity_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/PERI/fix_peri_neigh.cpp b/src/PERI/fix_peri_neigh.cpp index 66137e6a01..297936577f 100644 --- a/src/PERI/fix_peri_neigh.cpp +++ b/src/PERI/fix_peri_neigh.cpp @@ -15,8 +15,8 @@ Contributing authors: Mike Parks (SNL), Ezwanur Rahman, J.T. Foster (UTSA) ------------------------------------------------------------------------- */ -#include #include "fix_peri_neigh.h" +#include #include "pair_peri_pmb.h" #include "pair_peri_lps.h" #include "pair_peri_ves.h" diff --git a/src/PERI/pair_peri_eps.cpp b/src/PERI/pair_peri_eps.cpp index c00495ba4d..07314081da 100644 --- a/src/PERI/pair_peri_eps.cpp +++ b/src/PERI/pair_peri_eps.cpp @@ -15,10 +15,10 @@ Contributing author: Rezwanur Rahman, John Foster (UTSA) ------------------------------------------------------------------------- */ +#include "pair_peri_eps.h" #include #include #include -#include "pair_peri_eps.h" #include "atom.h" #include "domain.h" #include "lattice.h" diff --git a/src/PERI/pair_peri_lps.cpp b/src/PERI/pair_peri_lps.cpp index f0418c8c8d..660209f3f5 100644 --- a/src/PERI/pair_peri_lps.cpp +++ b/src/PERI/pair_peri_lps.cpp @@ -15,10 +15,10 @@ Contributing author: Mike Parks (SNL) ------------------------------------------------------------------------- */ +#include "pair_peri_lps.h" #include #include #include -#include "pair_peri_lps.h" #include "atom.h" #include "domain.h" #include "lattice.h" diff --git a/src/PERI/pair_peri_pmb.cpp b/src/PERI/pair_peri_pmb.cpp index ad2f3fb7c7..fa53efc344 100644 --- a/src/PERI/pair_peri_pmb.cpp +++ b/src/PERI/pair_peri_pmb.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Parks (SNL) ------------------------------------------------------------------------- */ +#include "pair_peri_pmb.h" #include #include #include #include -#include "pair_peri_pmb.h" #include "atom.h" #include "domain.h" #include "lattice.h" diff --git a/src/PERI/pair_peri_ves.cpp b/src/PERI/pair_peri_ves.cpp index 24a9f92a97..1687bed35d 100644 --- a/src/PERI/pair_peri_ves.cpp +++ b/src/PERI/pair_peri_ves.cpp @@ -15,10 +15,10 @@ Contributing authors: Rezwanur Rahman, J.T. Foster (UTSA) ------------------------------------------------------------------------- */ +#include "pair_peri_ves.h" #include #include #include -#include "pair_peri_ves.h" #include "atom.h" #include "domain.h" #include "lattice.h" diff --git a/src/POEMS/fix_poems.cpp b/src/POEMS/fix_poems.cpp index 41cfcede34..6d943a79db 100644 --- a/src/POEMS/fix_poems.cpp +++ b/src/POEMS/fix_poems.cpp @@ -17,13 +17,13 @@ Kurt Anderson (anderk5@rpi.edu) ------------------------------------------------------------------------- */ +#include "fix_poems.h" #include #include #include #include #include #include "workspace.h" -#include "fix_poems.h" #include "atom.h" #include "domain.h" #include "update.h" diff --git a/src/PYTHON/fix_python_invoke.cpp b/src/PYTHON/fix_python_invoke.cpp index 7fa9861c3f..57ea2e9148 100644 --- a/src/PYTHON/fix_python_invoke.cpp +++ b/src/PYTHON/fix_python_invoke.cpp @@ -15,9 +15,9 @@ Contributing author: Richard Berger (Temple U) ------------------------------------------------------------------------- */ +#include "fix_python_invoke.h" #include // IWYU pragma: keep #include -#include "fix_python_invoke.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/PYTHON/fix_python_move.cpp b/src/PYTHON/fix_python_move.cpp index b253df6828..be63b851a2 100644 --- a/src/PYTHON/fix_python_move.cpp +++ b/src/PYTHON/fix_python_move.cpp @@ -15,9 +15,9 @@ Contributing author: Richard Berger (Temple U) ------------------------------------------------------------------------- */ +#include "fix_python_move.h" #include // IWYU pragma: keep #include -#include "fix_python_move.h" #include "lmppython.h" #include "error.h" #include "python_compat.h" diff --git a/src/PYTHON/pair_python.cpp b/src/PYTHON/pair_python.cpp index 5b8f23400b..0d79a31946 100644 --- a/src/PYTHON/pair_python.cpp +++ b/src/PYTHON/pair_python.cpp @@ -15,10 +15,10 @@ Contributing authors: Axel Kohlmeyer and Richard Berger (Temple U) ------------------------------------------------------------------------- */ +#include "pair_python.h" #include // IWYU pragma: keep #include #include -#include "pair_python.h" #include "atom.h" #include "force.h" #include "memory.h" diff --git a/src/PYTHON/python_impl.cpp b/src/PYTHON/python_impl.cpp index 7456021675..1188942e75 100644 --- a/src/PYTHON/python_impl.cpp +++ b/src/PYTHON/python_impl.cpp @@ -15,10 +15,10 @@ Contributing author: Richard Berger and Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "python_impl.h" #include #include #include // IWYU pragma: keep -#include "python_impl.h" #include "force.h" #include "input.h" #include "variable.h" diff --git a/src/QEQ/fix_qeq.cpp b/src/QEQ/fix_qeq.cpp index 0ab010b7bb..2e0b7edbe5 100644 --- a/src/QEQ/fix_qeq.cpp +++ b/src/QEQ/fix_qeq.cpp @@ -16,11 +16,11 @@ Based on fix qeq/reax by H. Metin Aktulga ------------------------------------------------------------------------- */ +#include "fix_qeq.h" #include #include #include #include -#include "fix_qeq.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/QEQ/fix_qeq_dynamic.cpp b/src/QEQ/fix_qeq_dynamic.cpp index ba88f4f1c3..fb5fd2ddac 100644 --- a/src/QEQ/fix_qeq_dynamic.cpp +++ b/src/QEQ/fix_qeq_dynamic.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include "fix_qeq_dynamic.h" #include #include #include #include -#include "fix_qeq_dynamic.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/QEQ/fix_qeq_fire.cpp b/src/QEQ/fix_qeq_fire.cpp index 1e3686f99c..561a82b714 100644 --- a/src/QEQ/fix_qeq_fire.cpp +++ b/src/QEQ/fix_qeq_fire.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include "fix_qeq_fire.h" #include #include #include #include -#include "fix_qeq_fire.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/QEQ/fix_qeq_point.cpp b/src/QEQ/fix_qeq_point.cpp index 9517343974..bb3ce835fc 100644 --- a/src/QEQ/fix_qeq_point.cpp +++ b/src/QEQ/fix_qeq_point.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include "fix_qeq_point.h" #include #include #include #include -#include "fix_qeq_point.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/QEQ/fix_qeq_shielded.cpp b/src/QEQ/fix_qeq_shielded.cpp index a74eee7d29..60ff62ca07 100644 --- a/src/QEQ/fix_qeq_shielded.cpp +++ b/src/QEQ/fix_qeq_shielded.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include "fix_qeq_shielded.h" #include #include #include #include -#include "fix_qeq_shielded.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/QEQ/fix_qeq_slater.cpp b/src/QEQ/fix_qeq_slater.cpp index 3443a519a2..95105b5ef2 100644 --- a/src/QEQ/fix_qeq_slater.cpp +++ b/src/QEQ/fix_qeq_slater.cpp @@ -15,11 +15,11 @@ Contributing author: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include "fix_qeq_slater.h" #include #include #include #include -#include "fix_qeq_slater.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/REPLICA/compute_event_displace.cpp b/src/REPLICA/compute_event_displace.cpp index df14221586..4c8d022d70 100644 --- a/src/REPLICA/compute_event_displace.cpp +++ b/src/REPLICA/compute_event_displace.cpp @@ -15,11 +15,11 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "compute_event_displace.h" #include #include #include #include -#include "compute_event_displace.h" #include "atom.h" #include "domain.h" #include "modify.h" diff --git a/src/REPLICA/fix_event.cpp b/src/REPLICA/fix_event.cpp index 8fc5de6b16..8cf1acba94 100644 --- a/src/REPLICA/fix_event.cpp +++ b/src/REPLICA/fix_event.cpp @@ -15,9 +15,9 @@ Contributing author: Mike Brown (SNL), Aidan Thompson (SNL) ------------------------------------------------------------------------- */ +#include "fix_event.h" #include #include -#include "fix_event.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/REPLICA/fix_event_hyper.cpp b/src/REPLICA/fix_event_hyper.cpp index eae1ad021d..3dd1a03eb9 100644 --- a/src/REPLICA/fix_event_hyper.cpp +++ b/src/REPLICA/fix_event_hyper.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_event_hyper.h" #include #include -#include "fix_event_hyper.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/REPLICA/fix_event_prd.cpp b/src/REPLICA/fix_event_prd.cpp index a311a6444a..63c9c2718b 100644 --- a/src/REPLICA/fix_event_prd.cpp +++ b/src/REPLICA/fix_event_prd.cpp @@ -15,9 +15,9 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "fix_event_prd.h" #include #include -#include "fix_event_prd.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/REPLICA/fix_event_tad.cpp b/src/REPLICA/fix_event_tad.cpp index 0916fdf493..b92bc1fd73 100644 --- a/src/REPLICA/fix_event_tad.cpp +++ b/src/REPLICA/fix_event_tad.cpp @@ -15,9 +15,9 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ +#include "fix_event_tad.h" #include #include -#include "fix_event_tad.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/REPLICA/fix_hyper.cpp b/src/REPLICA/fix_hyper.cpp index c86c00ad45..21a4fde04d 100644 --- a/src/REPLICA/fix_hyper.cpp +++ b/src/REPLICA/fix_hyper.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "fix_hyper.h" +#include using namespace LAMMPS_NS; diff --git a/src/REPLICA/fix_hyper_global.cpp b/src/REPLICA/fix_hyper_global.cpp index 0c76b29911..a58798a63e 100644 --- a/src/REPLICA/fix_hyper_global.cpp +++ b/src/REPLICA/fix_hyper_global.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_hyper_global.h" #include #include #include #include -#include "fix_hyper_global.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/REPLICA/fix_hyper_local.cpp b/src/REPLICA/fix_hyper_local.cpp index a6db4419f0..555c5234f6 100644 --- a/src/REPLICA/fix_hyper_local.cpp +++ b/src/REPLICA/fix_hyper_local.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_hyper_local.h" #include #include #include #include -#include "fix_hyper_local.h" #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/REPLICA/fix_neb.cpp b/src/REPLICA/fix_neb.cpp index e1b1e46a53..2803c37b23 100644 --- a/src/REPLICA/fix_neb.cpp +++ b/src/REPLICA/fix_neb.cpp @@ -16,11 +16,11 @@ new options for inter-replica forces, first/last replica treatment ------------------------------------------------------------------------- */ +#include "fix_neb.h" #include #include #include #include -#include "fix_neb.h" #include "universe.h" #include "update.h" #include "atom.h" diff --git a/src/REPLICA/hyper.cpp b/src/REPLICA/hyper.cpp index 00b91684e9..c400ae097d 100644 --- a/src/REPLICA/hyper.cpp +++ b/src/REPLICA/hyper.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "hyper.h" #include #include #include -#include "hyper.h" #include "update.h" #include "atom.h" #include "domain.h" diff --git a/src/REPLICA/neb.cpp b/src/REPLICA/neb.cpp index 6b68c52dbb..b670f3d8f1 100644 --- a/src/REPLICA/neb.cpp +++ b/src/REPLICA/neb.cpp @@ -15,12 +15,12 @@ // due to OpenMPI bug which sets INT64_MAX via its mpi.h // before lmptype.h can set flags to insure it is done correctly +#include "neb.h" #include "lmptype.h" #include #include #include #include -#include "neb.h" #include "universe.h" #include "atom.h" #include "update.h" diff --git a/src/REPLICA/prd.cpp b/src/REPLICA/prd.cpp index 6d450f48e3..19a12ddbbb 100644 --- a/src/REPLICA/prd.cpp +++ b/src/REPLICA/prd.cpp @@ -19,12 +19,12 @@ // due to OpenMPI bug which sets INT64_MAX via its mpi.h // before lmptype.h can set flags to insure it is done correctly +#include "prd.h" #include "lmptype.h" #include #include #include #include -#include "prd.h" #include "universe.h" #include "update.h" #include "atom.h" diff --git a/src/REPLICA/tad.cpp b/src/REPLICA/tad.cpp index da42ba6fae..90667b8865 100644 --- a/src/REPLICA/tad.cpp +++ b/src/REPLICA/tad.cpp @@ -19,12 +19,12 @@ // due to OpenMPI bug which sets INT64_MAX via its mpi.h // before lmptype.h can set flags to insure it is done correctly +#include "tad.h" #include "lmptype.h" #include #include #include #include -#include "tad.h" #include "universe.h" #include "update.h" #include "atom.h" diff --git a/src/REPLICA/temper.cpp b/src/REPLICA/temper.cpp index fe3e3fb993..6eb50c8d9f 100644 --- a/src/REPLICA/temper.cpp +++ b/src/REPLICA/temper.cpp @@ -15,10 +15,10 @@ Contributing author: Mark Sears (SNL) ------------------------------------------------------------------------- */ +#include "temper.h" #include #include #include -#include "temper.h" #include "universe.h" #include "domain.h" #include "atom.h" diff --git a/src/REPLICA/verlet_split.cpp b/src/REPLICA/verlet_split.cpp index 7042fc6993..f268afe7f8 100644 --- a/src/REPLICA/verlet_split.cpp +++ b/src/REPLICA/verlet_split.cpp @@ -15,8 +15,8 @@ Contributing authors: Yuxing Peng and Chris Knight (U Chicago) ------------------------------------------------------------------------- */ -#include #include "verlet_split.h" +#include #include "universe.h" #include "neighbor.h" #include "domain.h" diff --git a/src/RIGID/compute_erotate_rigid.cpp b/src/RIGID/compute_erotate_rigid.cpp index a3ddffd9ab..1a7236e263 100644 --- a/src/RIGID/compute_erotate_rigid.cpp +++ b/src/RIGID/compute_erotate_rigid.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_erotate_rigid.h" #include #include -#include "compute_erotate_rigid.h" #include "update.h" #include "force.h" #include "modify.h" diff --git a/src/RIGID/compute_ke_rigid.cpp b/src/RIGID/compute_ke_rigid.cpp index 4de13532b2..66b7a92566 100644 --- a/src/RIGID/compute_ke_rigid.cpp +++ b/src/RIGID/compute_ke_rigid.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_ke_rigid.h" #include #include -#include "compute_ke_rigid.h" #include "update.h" #include "force.h" #include "modify.h" diff --git a/src/RIGID/compute_rigid_local.cpp b/src/RIGID/compute_rigid_local.cpp index ec2799b6bc..75334bb759 100644 --- a/src/RIGID/compute_rigid_local.cpp +++ b/src/RIGID/compute_rigid_local.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_rigid_local.h" #include #include -#include "compute_rigid_local.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/RIGID/fix_ehex.cpp b/src/RIGID/fix_ehex.cpp index 0bbdea51c6..a5efc22d11 100644 --- a/src/RIGID/fix_ehex.cpp +++ b/src/RIGID/fix_ehex.cpp @@ -22,10 +22,10 @@ which implements the heat exchange (HEX) algorithm. ------------------------------------------------------------------------- */ +#include "fix_ehex.h" #include #include #include -#include "fix_ehex.h" #include "atom.h" #include "domain.h" #include "region.h" diff --git a/src/RIGID/fix_rattle.cpp b/src/RIGID/fix_rattle.cpp index db43b9e82d..93bf610e94 100644 --- a/src/RIGID/fix_rattle.cpp +++ b/src/RIGID/fix_rattle.cpp @@ -15,10 +15,10 @@ Contributing author: Peter Wirnsberger (University of Cambridge) ------------------------------------------------------------------------- */ +#include "fix_rattle.h" #include #include #include -#include "fix_rattle.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/RIGID/fix_rigid.cpp b/src/RIGID/fix_rigid.cpp index 19eb22a7fa..912f529403 100644 --- a/src/RIGID/fix_rigid.cpp +++ b/src/RIGID/fix_rigid.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_rigid.h" #include #include #include #include -#include "fix_rigid.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/RIGID/fix_rigid_nh.cpp b/src/RIGID/fix_rigid_nh.cpp index 2e1090ec88..4738e253f6 100644 --- a/src/RIGID/fix_rigid_nh.cpp +++ b/src/RIGID/fix_rigid_nh.cpp @@ -17,9 +17,9 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ +#include "fix_rigid_nh.h" #include #include -#include "fix_rigid_nh.h" #include "math_extra.h" #include "atom.h" #include "compute.h" diff --git a/src/RIGID/fix_rigid_nh_small.cpp b/src/RIGID/fix_rigid_nh_small.cpp index 8de588bd9b..1545e913c0 100644 --- a/src/RIGID/fix_rigid_nh_small.cpp +++ b/src/RIGID/fix_rigid_nh_small.cpp @@ -17,10 +17,10 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ +#include "fix_rigid_nh_small.h" #include #include #include -#include "fix_rigid_nh_small.h" #include "math_extra.h" #include "atom.h" #include "compute.h" diff --git a/src/RIGID/fix_rigid_nph.cpp b/src/RIGID/fix_rigid_nph.cpp index 6080fb05af..706e08ec12 100644 --- a/src/RIGID/fix_rigid_nph.cpp +++ b/src/RIGID/fix_rigid_nph.cpp @@ -17,8 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ -#include #include "fix_rigid_nph.h" +#include #include "modify.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_nph_small.cpp b/src/RIGID/fix_rigid_nph_small.cpp index 9b045eaf13..32ac58220d 100644 --- a/src/RIGID/fix_rigid_nph_small.cpp +++ b/src/RIGID/fix_rigid_nph_small.cpp @@ -17,8 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ -#include #include "fix_rigid_nph_small.h" +#include #include "modify.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_npt.cpp b/src/RIGID/fix_rigid_npt.cpp index 526fc8f614..1f19fb4ec7 100644 --- a/src/RIGID/fix_rigid_npt.cpp +++ b/src/RIGID/fix_rigid_npt.cpp @@ -17,8 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ -#include #include "fix_rigid_npt.h" +#include #include "modify.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_npt_small.cpp b/src/RIGID/fix_rigid_npt_small.cpp index fff338d687..e8924be79f 100644 --- a/src/RIGID/fix_rigid_npt_small.cpp +++ b/src/RIGID/fix_rigid_npt_small.cpp @@ -17,8 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ -#include #include "fix_rigid_npt_small.h" +#include #include "modify.h" #include "error.h" diff --git a/src/RIGID/fix_rigid_small.cpp b/src/RIGID/fix_rigid_small.cpp index 8c2feb6436..14e230ab9c 100644 --- a/src/RIGID/fix_rigid_small.cpp +++ b/src/RIGID/fix_rigid_small.cpp @@ -11,12 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_rigid_small.h" #include #include #include #include #include -#include "fix_rigid_small.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/RIGID/fix_shake.cpp b/src/RIGID/fix_shake.cpp index 5c202706af..48a08118c5 100644 --- a/src/RIGID/fix_shake.cpp +++ b/src/RIGID/fix_shake.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_shake.h" #include #include #include #include -#include "fix_shake.h" #include "atom.h" #include "atom_vec.h" #include "molecule.h" diff --git a/src/SHOCK/fix_append_atoms.cpp b/src/SHOCK/fix_append_atoms.cpp index 5e81b75c0d..5e85b39076 100644 --- a/src/SHOCK/fix_append_atoms.cpp +++ b/src/SHOCK/fix_append_atoms.cpp @@ -11,10 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_append_atoms.h" #include #include #include -#include "fix_append_atoms.h" #include "atom.h" #include "atom_vec.h" #include "comm.h" diff --git a/src/SHOCK/fix_msst.cpp b/src/SHOCK/fix_msst.cpp index 15ee4d370f..2e9f751824 100644 --- a/src/SHOCK/fix_msst.cpp +++ b/src/SHOCK/fix_msst.cpp @@ -17,10 +17,10 @@ see Reed, Fried, Joannopoulos, Phys Rev Lett, 90, 235503 (2003) ------------------------------------------------------------------------- */ +#include "fix_msst.h" #include #include #include -#include "fix_msst.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/SHOCK/fix_nphug.cpp b/src/SHOCK/fix_nphug.cpp index 5d5a1642c0..8ad787d759 100644 --- a/src/SHOCK/fix_nphug.cpp +++ b/src/SHOCK/fix_nphug.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_nphug.h" #include #include -#include "fix_nphug.h" #include "modify.h" #include "error.h" #include "update.h" diff --git a/src/SHOCK/fix_wall_piston.cpp b/src/SHOCK/fix_wall_piston.cpp index 31f70b4174..5a359d9f6f 100644 --- a/src/SHOCK/fix_wall_piston.cpp +++ b/src/SHOCK/fix_wall_piston.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_wall_piston.h" #include #include -#include "fix_wall_piston.h" #include "atom.h" #include "domain.h" #include "lattice.h" diff --git a/src/SNAP/compute_sna_atom.cpp b/src/SNAP/compute_sna_atom.cpp index cc7a84281e..7ca9d52467 100644 --- a/src/SNAP/compute_sna_atom.cpp +++ b/src/SNAP/compute_sna_atom.cpp @@ -10,10 +10,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "sna.h" + +#include "compute_sna_atom.h" #include #include -#include "compute_sna_atom.h" +#include "sna.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/SNAP/compute_snad_atom.cpp b/src/SNAP/compute_snad_atom.cpp index 37587a0aae..7e71e4a556 100644 --- a/src/SNAP/compute_snad_atom.cpp +++ b/src/SNAP/compute_snad_atom.cpp @@ -10,10 +10,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "sna.h" + +#include "compute_snad_atom.h" #include #include -#include "compute_snad_atom.h" +#include "sna.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/SNAP/compute_snav_atom.cpp b/src/SNAP/compute_snav_atom.cpp index 5faf7a1872..28c018b1cc 100644 --- a/src/SNAP/compute_snav_atom.cpp +++ b/src/SNAP/compute_snav_atom.cpp @@ -10,9 +10,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ + +#include "compute_snav_atom.h" #include #include -#include "compute_snav_atom.h" #include "sna.h" #include "atom.h" #include "update.h" diff --git a/src/SNAP/pair_snap.cpp b/src/SNAP/pair_snap.cpp index f0f3ef72c6..56f59c7fcc 100644 --- a/src/SNAP/pair_snap.cpp +++ b/src/SNAP/pair_snap.cpp @@ -11,11 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_snap.h" #include #include #include #include -#include "pair_snap.h" #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp index d7d9b5163d..9194e44c21 100644 --- a/src/SNAP/sna.cpp +++ b/src/SNAP/sna.cpp @@ -15,8 +15,8 @@ Contributing authors: Aidan Thompson, Christian Trott, SNL ------------------------------------------------------------------------- */ -#include #include "sna.h" +#include #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index 37d6fb1e59..5810ecf85b 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -23,11 +23,11 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "atom_vec_spin.h" #include #include #include #include "atom.h" -#include "atom_vec_spin.h" #include "comm.h" #include "domain.h" #include "error.h" diff --git a/src/SPIN/compute_spin.cpp b/src/SPIN/compute_spin.cpp index ec11bc68f2..8dad128994 100644 --- a/src/SPIN/compute_spin.cpp +++ b/src/SPIN/compute_spin.cpp @@ -21,9 +21,9 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "compute_spin.h" #include #include -#include "compute_spin.h" #include "atom.h" #include "error.h" #include "force.h" diff --git a/src/SPIN/fix_langevin_spin.cpp b/src/SPIN/fix_langevin_spin.cpp index 6936c701c6..ec9c98c4f8 100644 --- a/src/SPIN/fix_langevin_spin.cpp +++ b/src/SPIN/fix_langevin_spin.cpp @@ -21,9 +21,9 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "fix_langevin_spin.h" #include #include -#include "fix_langevin_spin.h" #include "comm.h" #include "error.h" #include "force.h" diff --git a/src/SPIN/fix_neb_spin.cpp b/src/SPIN/fix_neb_spin.cpp index 7ed8967a24..5acbbf59e8 100644 --- a/src/SPIN/fix_neb_spin.cpp +++ b/src/SPIN/fix_neb_spin.cpp @@ -21,10 +21,10 @@ Computer Physics Communications, 196, 335-347. ------------------------------------------------------------------------- */ +#include "fix_neb_spin.h" #include #include #include -#include "fix_neb_spin.h" #include "universe.h" #include "update.h" #include "atom.h" diff --git a/src/SPIN/fix_nve_spin.cpp b/src/SPIN/fix_nve_spin.cpp index d35585c7a6..1165048723 100644 --- a/src/SPIN/fix_nve_spin.cpp +++ b/src/SPIN/fix_nve_spin.cpp @@ -21,8 +21,8 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ -#include #include "fix_nve_spin.h" +#include #include "atom.h" #include "citeme.h" #include "comm.h" diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 7764bb0438..3296b28228 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -21,10 +21,10 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "fix_precession_spin.h" #include #include #include -#include "fix_precession_spin.h" #include "atom.h" #include "error.h" #include "force.h" diff --git a/src/SPIN/fix_setforce_spin.cpp b/src/SPIN/fix_setforce_spin.cpp index 1ab35c9663..15e5aacfb6 100644 --- a/src/SPIN/fix_setforce_spin.cpp +++ b/src/SPIN/fix_setforce_spin.cpp @@ -21,8 +21,8 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ -#include #include "fix_setforce_spin.h" +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 3a330f448a..2514645325 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -17,10 +17,10 @@ Please cite the related publication: ------------------------------------------------------------------------- */ +#include "min_spin.h" #include #include #include -#include "min_spin.h" #include "universe.h" #include "atom.h" #include "force.h" diff --git a/src/SPIN/neb_spin.cpp b/src/SPIN/neb_spin.cpp index 400ce3d363..2bcfe6573a 100644 --- a/src/SPIN/neb_spin.cpp +++ b/src/SPIN/neb_spin.cpp @@ -21,11 +21,11 @@ Computer Physics Communications, 196, 335-347. ------------------------------------------------------------------------- */ +#include "neb_spin.h" #include #include #include #include -#include "neb_spin.h" #include "citeme.h" #include "force.h" #include "universe.h" diff --git a/src/SPIN/pair_spin.cpp b/src/SPIN/pair_spin.cpp index 93d9a1e127..fef247c09b 100644 --- a/src/SPIN/pair_spin.cpp +++ b/src/SPIN/pair_spin.cpp @@ -21,8 +21,8 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ -#include #include "pair_spin.h" +#include #include "atom.h" #include "error.h" #include "fix.h" diff --git a/src/SPIN/pair_spin_dipole_cut.cpp b/src/SPIN/pair_spin_dipole_cut.cpp index 8d9b5b8f2b..fb0ec8bb20 100644 --- a/src/SPIN/pair_spin_dipole_cut.cpp +++ b/src/SPIN/pair_spin_dipole_cut.cpp @@ -21,10 +21,10 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "pair_spin_dipole_cut.h" #include #include #include -#include "pair_spin_dipole_cut.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/SPIN/pair_spin_dipole_long.cpp b/src/SPIN/pair_spin_dipole_long.cpp index 84c55a8c3c..670fccfce2 100644 --- a/src/SPIN/pair_spin_dipole_long.cpp +++ b/src/SPIN/pair_spin_dipole_long.cpp @@ -16,10 +16,10 @@ Stan Moore (SNL) ------------------------------------------------------------------------- */ +#include "pair_spin_dipole_long.h" #include #include #include -#include "pair_spin_dipole_long.h" #include "atom.h" #include "comm.h" #include "neighbor.h" diff --git a/src/SPIN/pair_spin_dmi.cpp b/src/SPIN/pair_spin_dmi.cpp index 651f4397bd..afd2deaa6a 100644 --- a/src/SPIN/pair_spin_dmi.cpp +++ b/src/SPIN/pair_spin_dmi.cpp @@ -21,10 +21,10 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "pair_spin_dmi.h" #include #include #include -#include "pair_spin_dmi.h" #include "atom.h" #include "comm.h" #include "error.h" diff --git a/src/SPIN/pair_spin_exchange.cpp b/src/SPIN/pair_spin_exchange.cpp index 059a8f5f34..cc28018ad0 100644 --- a/src/SPIN/pair_spin_exchange.cpp +++ b/src/SPIN/pair_spin_exchange.cpp @@ -21,10 +21,10 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "pair_spin_exchange.h" #include #include #include -#include "pair_spin_exchange.h" #include "atom.h" #include "comm.h" #include "error.h" diff --git a/src/SPIN/pair_spin_magelec.cpp b/src/SPIN/pair_spin_magelec.cpp index 55b96582c8..6756ebc3cc 100644 --- a/src/SPIN/pair_spin_magelec.cpp +++ b/src/SPIN/pair_spin_magelec.cpp @@ -21,10 +21,10 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "pair_spin_magelec.h" #include #include #include -#include "pair_spin_magelec.h" #include "atom.h" #include "comm.h" #include "error.h" diff --git a/src/SPIN/pair_spin_neel.cpp b/src/SPIN/pair_spin_neel.cpp index 4d68dbdc22..355ba20f39 100644 --- a/src/SPIN/pair_spin_neel.cpp +++ b/src/SPIN/pair_spin_neel.cpp @@ -21,10 +21,10 @@ and molecular dynamics. Journal of Computational Physics. ------------------------------------------------------------------------- */ +#include "pair_spin_neel.h" #include #include #include -#include "pair_spin_neel.h" #include "atom.h" #include "comm.h" #include "error.h" diff --git a/src/SRD/fix_srd.cpp b/src/SRD/fix_srd.cpp index a20ec212fd..d5eec91f50 100644 --- a/src/SRD/fix_srd.cpp +++ b/src/SRD/fix_srd.cpp @@ -15,10 +15,10 @@ Contributing authors: Jeremy Lechman (SNL), Pieter in 't Veld (BASF) ------------------------------------------------------------------------- */ +#include "fix_srd.h" #include #include #include -#include "fix_srd.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/SRD/fix_wall_srd.cpp b/src/SRD/fix_wall_srd.cpp index cb0f023640..ab113df28a 100644 --- a/src/SRD/fix_wall_srd.cpp +++ b/src/SRD/fix_wall_srd.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_wall_srd.h" #include #include -#include "fix_wall_srd.h" #include "fix.h" #include "domain.h" #include "lattice.h" diff --git a/src/USER-ADIOS/dump_atom_adios.cpp b/src/USER-ADIOS/dump_atom_adios.cpp index 55d6c5fbf9..e711b8a583 100644 --- a/src/USER-ADIOS/dump_atom_adios.cpp +++ b/src/USER-ADIOS/dump_atom_adios.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "dump_atom_adios.h" +#include #include "atom.h" #include "domain.h" #include "error.h" @@ -23,7 +24,6 @@ #include "memory.h" #include "universe.h" #include "update.h" -#include #include "adios2.h" diff --git a/src/USER-ADIOS/dump_custom_adios.cpp b/src/USER-ADIOS/dump_custom_adios.cpp index 67f3deeb64..ee6d7d7e49 100644 --- a/src/USER-ADIOS/dump_custom_adios.cpp +++ b/src/USER-ADIOS/dump_custom_adios.cpp @@ -16,6 +16,8 @@ ------------------------------------------------------------------------- */ #include "dump_custom_adios.h" +#include +#include #include "atom.h" #include "compute.h" #include "domain.h" @@ -30,8 +32,6 @@ #include "universe.h" #include "update.h" #include "variable.h" -#include -#include #include "adios2.h" diff --git a/src/USER-ATC/fix_atc.cpp b/src/USER-ATC/fix_atc.cpp index f53343ced1..e2a1768f55 100644 --- a/src/USER-ATC/fix_atc.cpp +++ b/src/USER-ATC/fix_atc.cpp @@ -11,8 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -// LAMMPS #include "fix_atc.h" +#include +#include +#include #include "fix_nve.h" #include "atom.h" #include "force.h" @@ -24,7 +26,7 @@ #include "pointers.h" #include "comm.h" #include "group.h" -// ATC + #include "ATC_Method.h" #include "ATC_Transfer.h" #include "ATC_TransferKernel.h" @@ -34,10 +36,6 @@ #include "ATC_CouplingMass.h" #include "ATC_CouplingMomentumEnergy.h" #include "LammpsInterface.h" -// other -#include -#include -#include using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-AWPMD/atom_vec_wavepacket.cpp b/src/USER-AWPMD/atom_vec_wavepacket.cpp index 7556dd2c8e..bc70c0dbc2 100644 --- a/src/USER-AWPMD/atom_vec_wavepacket.cpp +++ b/src/USER-AWPMD/atom_vec_wavepacket.cpp @@ -15,10 +15,10 @@ Contributing author: Ilya Valuev (JIHT, Moscow, Russia) ------------------------------------------------------------------------- */ +#include "atom_vec_wavepacket.h" #include #include #include -#include "atom_vec_wavepacket.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/USER-AWPMD/fix_nve_awpmd.cpp b/src/USER-AWPMD/fix_nve_awpmd.cpp index 7722c93121..57ad17f3e6 100644 --- a/src/USER-AWPMD/fix_nve_awpmd.cpp +++ b/src/USER-AWPMD/fix_nve_awpmd.cpp @@ -15,10 +15,10 @@ Contributing author: Ilya Valuev (JIHT, Moscow, Russia) ------------------------------------------------------------------------- */ +#include "fix_nve_awpmd.h" #include #include #include -#include "fix_nve_awpmd.h" #include "atom.h" #include "force.h" #include "update.h" diff --git a/src/USER-AWPMD/pair_awpmd_cut.cpp b/src/USER-AWPMD/pair_awpmd_cut.cpp index 1b7bf35c28..ae2fbc59fa 100644 --- a/src/USER-AWPMD/pair_awpmd_cut.cpp +++ b/src/USER-AWPMD/pair_awpmd_cut.cpp @@ -15,11 +15,11 @@ Contributing author: Ilya Valuev (JIHT, Moscow, Russia) ------------------------------------------------------------------------- */ +#include "pair_awpmd_cut.h" #include #include #include #include -#include "pair_awpmd_cut.h" #include "atom.h" #include "update.h" #include "min.h" diff --git a/src/USER-BOCS/compute_pressure_bocs.cpp b/src/USER-BOCS/compute_pressure_bocs.cpp index fc24efab4c..33163f7aff 100644 --- a/src/USER-BOCS/compute_pressure_bocs.cpp +++ b/src/USER-BOCS/compute_pressure_bocs.cpp @@ -14,10 +14,10 @@ from The Pennsylvania State University ------------------------------------------------------------------------- */ +#include "compute_pressure_bocs.h" #include #include #include -#include "compute_pressure_bocs.h" #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/USER-BOCS/fix_bocs.cpp b/src/USER-BOCS/fix_bocs.cpp index 7bdb8933e3..e0952086dd 100644 --- a/src/USER-BOCS/fix_bocs.cpp +++ b/src/USER-BOCS/fix_bocs.cpp @@ -14,10 +14,10 @@ from The Pennsylvania State University ------------------------------------------------------------------------- */ +#include "fix_bocs.h" #include #include #include -#include "fix_bocs.h" #include "math_extra.h" #include "atom.h" #include "force.h" diff --git a/src/USER-CGDNA/bond_oxdna2_fene.cpp b/src/USER-CGDNA/bond_oxdna2_fene.cpp index 39cbb04f88..2cd7883600 100644 --- a/src/USER-CGDNA/bond_oxdna2_fene.cpp +++ b/src/USER-CGDNA/bond_oxdna2_fene.cpp @@ -14,9 +14,9 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "bond_oxdna2_fene.h" #include #include -#include "bond_oxdna2_fene.h" using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/bond_oxdna_fene.cpp b/src/USER-CGDNA/bond_oxdna_fene.cpp index 8271668e3f..8b94fd6a5a 100644 --- a/src/USER-CGDNA/bond_oxdna_fene.cpp +++ b/src/USER-CGDNA/bond_oxdna_fene.cpp @@ -14,9 +14,9 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "bond_oxdna_fene.h" #include #include -#include "bond_oxdna_fene.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-CGDNA/fix_nve_dot.cpp b/src/USER-CGDNA/fix_nve_dot.cpp index 72b3388793..3bf6757df7 100644 --- a/src/USER-CGDNA/fix_nve_dot.cpp +++ b/src/USER-CGDNA/fix_nve_dot.cpp @@ -14,10 +14,10 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "fix_nve_dot.h" #include #include #include -#include "fix_nve_dot.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/USER-CGDNA/fix_nve_dotc_langevin.cpp b/src/USER-CGDNA/fix_nve_dotc_langevin.cpp index c73801c97a..61e3552f11 100644 --- a/src/USER-CGDNA/fix_nve_dotc_langevin.cpp +++ b/src/USER-CGDNA/fix_nve_dotc_langevin.cpp @@ -15,10 +15,10 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "fix_nve_dotc_langevin.h" #include #include #include -#include "fix_nve_dotc_langevin.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" diff --git a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp index dfea97f0bf..1d0a2eb494 100644 --- a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp +++ b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna2_coaxstk.h" #include #include #include #include -#include "pair_oxdna2_coaxstk.h" #include "mf_oxdna.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-CGDNA/pair_oxdna2_dh.cpp b/src/USER-CGDNA/pair_oxdna2_dh.cpp index b4afad12db..22fc79dae4 100644 --- a/src/USER-CGDNA/pair_oxdna2_dh.cpp +++ b/src/USER-CGDNA/pair_oxdna2_dh.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna2_dh.h" #include #include #include #include -#include "pair_oxdna2_dh.h" #include "mf_oxdna.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-CGDNA/pair_oxdna2_excv.cpp b/src/USER-CGDNA/pair_oxdna2_excv.cpp index 4329fbe071..de4f8319b9 100644 --- a/src/USER-CGDNA/pair_oxdna2_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna2_excv.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna2_excv.h" #include #include #include #include -#include "pair_oxdna2_excv.h" using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/pair_oxdna2_stk.cpp b/src/USER-CGDNA/pair_oxdna2_stk.cpp index f479572aa6..3b9480bff6 100644 --- a/src/USER-CGDNA/pair_oxdna2_stk.cpp +++ b/src/USER-CGDNA/pair_oxdna2_stk.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna2_stk.h" #include #include #include #include -#include "pair_oxdna2_stk.h" using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp index 6f3fa4fa4e..7310f60ec3 100644 --- a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp +++ b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna_coaxstk.h" #include #include #include #include -#include "pair_oxdna_coaxstk.h" #include "mf_oxdna.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-CGDNA/pair_oxdna_excv.cpp b/src/USER-CGDNA/pair_oxdna_excv.cpp index 82af5ed1c7..68091f4190 100644 --- a/src/USER-CGDNA/pair_oxdna_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna_excv.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna_excv.h" #include #include #include #include -#include "pair_oxdna_excv.h" #include "mf_oxdna.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-CGDNA/pair_oxdna_hbond.cpp b/src/USER-CGDNA/pair_oxdna_hbond.cpp index 8cd28f10c8..2de05e66ae 100644 --- a/src/USER-CGDNA/pair_oxdna_hbond.cpp +++ b/src/USER-CGDNA/pair_oxdna_hbond.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna_hbond.h" #include #include #include #include -#include "pair_oxdna_hbond.h" #include "mf_oxdna.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-CGDNA/pair_oxdna_stk.cpp b/src/USER-CGDNA/pair_oxdna_stk.cpp index 93c65979ac..aaa25039ef 100644 --- a/src/USER-CGDNA/pair_oxdna_stk.cpp +++ b/src/USER-CGDNA/pair_oxdna_stk.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna_stk.h" #include #include #include #include -#include "pair_oxdna_stk.h" #include "mf_oxdna.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-CGDNA/pair_oxdna_xstk.cpp b/src/USER-CGDNA/pair_oxdna_xstk.cpp index 1365d0d2b2..806f8a42c6 100644 --- a/src/USER-CGDNA/pair_oxdna_xstk.cpp +++ b/src/USER-CGDNA/pair_oxdna_xstk.cpp @@ -14,11 +14,11 @@ Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) ------------------------------------------------------------------------- */ +#include "pair_oxdna_xstk.h" #include #include #include #include -#include "pair_oxdna_xstk.h" #include "mf_oxdna.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-CGSDK/angle_sdk.cpp b/src/USER-CGSDK/angle_sdk.cpp index 823c725e07..575b0fae69 100644 --- a/src/USER-CGSDK/angle_sdk.cpp +++ b/src/USER-CGSDK/angle_sdk.cpp @@ -18,9 +18,9 @@ lj/sdk potential for coarse grained MD simulations. ------------------------------------------------------------------------- */ +#include "angle_sdk.h" #include #include -#include "angle_sdk.h" #include "atom.h" #include "neighbor.h" #include "pair.h" diff --git a/src/USER-CGSDK/pair_lj_sdk.cpp b/src/USER-CGSDK/pair_lj_sdk.cpp index 7dd6c04436..b22469566e 100644 --- a/src/USER-CGSDK/pair_lj_sdk.cpp +++ b/src/USER-CGSDK/pair_lj_sdk.cpp @@ -16,11 +16,11 @@ This style is a simplified re-implementation of the CG/CMM pair style ------------------------------------------------------------------------- */ +#include "pair_lj_sdk.h" #include #include #include #include -#include "pair_lj_sdk.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp b/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp index 33a1659df9..5fba8cde66 100644 --- a/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp +++ b/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp @@ -16,11 +16,11 @@ This style is a simplified re-implementation of the CG/CMM pair style ------------------------------------------------------------------------- */ +#include "pair_lj_sdk_coul_long.h" #include #include #include #include -#include "pair_lj_sdk_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp b/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp index d26f8efcdc..b61ed5528f 100644 --- a/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp +++ b/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp @@ -16,11 +16,11 @@ This style is a simplified re-implementation of the CG/CMM pair style ------------------------------------------------------------------------- */ +#include "pair_lj_sdk_coul_msm.h" #include #include #include #include -#include "pair_lj_sdk_coul_msm.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-COLVARS/colvarproxy_lammps.cpp b/src/USER-COLVARS/colvarproxy_lammps.cpp index 651999f79c..685c698ab6 100644 --- a/src/USER-COLVARS/colvarproxy_lammps.cpp +++ b/src/USER-COLVARS/colvarproxy_lammps.cpp @@ -8,7 +8,20 @@ // Colvars repository at GitHub. +#include "colvarproxy_lammps.h" #include +#include +#include +#include + +#include +#include +#include + +#include +#include +#include + #include "lammps.h" #include "atom.h" #include "error.h" @@ -22,19 +35,6 @@ #include "colvarbias.h" #include "colvaratoms.h" #include "colvarproxy.h" -#include "colvarproxy_lammps.h" - -#include -#include -#include - -#include -#include -#include - -#include -#include -#include #define HASH_FAIL -1 diff --git a/src/USER-COLVARS/fix_colvars.cpp b/src/USER-COLVARS/fix_colvars.cpp index ff0e8fb334..9331fe7abb 100644 --- a/src/USER-COLVARS/fix_colvars.cpp +++ b/src/USER-COLVARS/fix_colvars.cpp @@ -24,13 +24,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_colvars.h" #include #include #include #include #include -#include "fix_colvars.h" #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/USER-COLVARS/group_ndx.cpp b/src/USER-COLVARS/group_ndx.cpp index 858336c9d5..7350712c40 100644 --- a/src/USER-COLVARS/group_ndx.cpp +++ b/src/USER-COLVARS/group_ndx.cpp @@ -17,15 +17,14 @@ ------------------------------------------------------------------------- */ #include "group_ndx.h" +#include +#include #include "atom.h" #include "comm.h" #include "group.h" #include "memory.h" #include "error.h" -#include -#include - using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- diff --git a/src/USER-COLVARS/ndx_group.cpp b/src/USER-COLVARS/ndx_group.cpp index 7b46364f18..5436ba7b6b 100644 --- a/src/USER-COLVARS/ndx_group.cpp +++ b/src/USER-COLVARS/ndx_group.cpp @@ -17,6 +17,9 @@ ------------------------------------------------------------------------- */ #include "ndx_group.h" +#include +#include +#include #include "atom.h" #include "comm.h" #include "group.h" @@ -24,10 +27,6 @@ #include "force.h" #include "error.h" -#include -#include -#include - using namespace LAMMPS_NS; #define BUFLEN 4096 #define DELTA 16384 -- GitLab From 95cb995336e4c20211bd354067bdb199baadee07 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 3 Jul 2019 22:18:41 -0400 Subject: [PATCH 175/469] recover compilation of MANYBODY package --- src/MANYBODY/pair_polymorphic.h | 1 + 1 file changed, 1 insertion(+) diff --git a/src/MANYBODY/pair_polymorphic.h b/src/MANYBODY/pair_polymorphic.h index 32f1c5414a..e7c3cd0d26 100644 --- a/src/MANYBODY/pair_polymorphic.h +++ b/src/MANYBODY/pair_polymorphic.h @@ -22,6 +22,7 @@ PairStyle(polymorphic,PairPolymorphic) #include "pair.h" #include +#include namespace LAMMPS_NS { -- GitLab From e63fe1fe84e51c734c2170b4f6eb324d01abb58e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 4 Jul 2019 00:09:01 -0400 Subject: [PATCH 176/469] please POEMS library in namespace POEMS and remove "using namespace" from headers --- lib/poems/POEMSChain.h | 99 +++--- lib/poems/SystemProcessor.h | 439 +++++++++++------------ lib/poems/body.cpp | 5 +- lib/poems/body.h | 3 +- lib/poems/body23joint.cpp | 3 + lib/poems/body23joint.h | 3 +- lib/poems/colmatmap.cpp | 2 + lib/poems/colmatmap.h | 3 +- lib/poems/colmatrix.cpp | 2 + lib/poems/colmatrix.h | 42 +-- lib/poems/defines.h | 7 +- lib/poems/eulerparameters.cpp | 42 +-- lib/poems/eulerparameters.h | 3 +- lib/poems/fastmatrixops.cpp | 130 +++---- lib/poems/fastmatrixops.h | 3 +- lib/poems/fixedpoint.cpp | 2 + lib/poems/fixedpoint.h | 3 +- lib/poems/freebodyjoint.cpp | 124 +++---- lib/poems/freebodyjoint.h | 8 +- lib/poems/inertialframe.cpp | 2 + lib/poems/inertialframe.h | 4 +- lib/poems/joint.cpp | 4 +- lib/poems/joint.h | 3 +- lib/poems/mat3x3.cpp | 2 + lib/poems/mat3x3.h | 14 +- lib/poems/mat4x4.cpp | 2 + lib/poems/mat4x4.h | 11 +- lib/poems/mat6x6.cpp | 2 + lib/poems/mat6x6.h | 3 +- lib/poems/matrices.h | 13 +- lib/poems/matrix.cpp | 2 + lib/poems/matrix.h | 8 +- lib/poems/matrixfun.cpp | 48 +-- lib/poems/matrixfun.h | 17 +- lib/poems/mixedjoint.cpp | 130 +++---- lib/poems/mixedjoint.h | 12 +- lib/poems/norm.cpp | 2 + lib/poems/norm.h | 7 +- lib/poems/onbody.cpp | 2 + lib/poems/onbody.h | 106 +++--- lib/poems/onfunctions.cpp | 40 ++- lib/poems/onfunctions.h | 3 +- lib/poems/onsolver.cpp | 2 + lib/poems/onsolver.h | 49 ++- lib/poems/particle.cpp | 2 + lib/poems/particle.h | 10 +- lib/poems/poemslist.h | 74 ++-- lib/poems/poemsnodelib.h | 11 +- lib/poems/poemsobject.cpp | 2 + lib/poems/poemsobject.h | 4 +- lib/poems/poemstree.h | 4 +- lib/poems/poemstreenode.cpp | 2 + lib/poems/poemstreenode.h | 39 ++- lib/poems/point.cpp | 4 +- lib/poems/point.h | 18 +- lib/poems/prismaticjoint.cpp | 2 + lib/poems/prismaticjoint.h | 5 +- lib/poems/revolutejoint.cpp | 2 + lib/poems/revolutejoint.h | 3 +- lib/poems/rigidbody.cpp | 2 + lib/poems/rigidbody.h | 3 +- lib/poems/rowmatrix.cpp | 2 + lib/poems/rowmatrix.h | 3 +- lib/poems/solver.cpp | 2 + lib/poems/solver.h | 19 +- lib/poems/sphericaljoint.cpp | 196 +++++------ lib/poems/sphericaljoint.h | 3 +- lib/poems/system.cpp | 615 +++++++++++++++++---------------- lib/poems/system.h | 33 +- lib/poems/vect3.cpp | 2 + lib/poems/vect3.h | 8 +- lib/poems/vect4.cpp | 2 + lib/poems/vect4.h | 9 +- lib/poems/vect6.cpp | 2 + lib/poems/vect6.h | 3 +- lib/poems/virtualcolmatrix.cpp | 2 + lib/poems/virtualcolmatrix.h | 40 +-- lib/poems/virtualmatrix.cpp | 6 +- lib/poems/virtualmatrix.h | 3 +- lib/poems/virtualrowmatrix.cpp | 2 + lib/poems/virtualrowmatrix.h | 11 +- lib/poems/workspace.cpp | 2 + lib/poems/workspace.h | 69 ++-- src/POEMS/fix_poems.cpp | 4 +- src/POEMS/fix_poems.h | 3 +- 85 files changed, 1365 insertions(+), 1274 deletions(-) diff --git a/lib/poems/POEMSChain.h b/lib/poems/POEMSChain.h index 9f0db59333..8baa293dbd 100644 --- a/lib/poems/POEMSChain.h +++ b/lib/poems/POEMSChain.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: PoemsChain.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -19,56 +19,59 @@ #define POEMSCHAIN_H_ #include "poemslist.h" +#include +namespace POEMS { struct ChildRingData { - List * childRing; - int entranceNodeId; + List * childRing; + int entranceNodeId; }; struct POEMSChain{ - ~POEMSChain(){ - for(int i = 0; i < childChains.GetNumElements(); i++) - { - delete childChains(i); - } - listOfNodes.DeleteValues(); - } - //void printTreeStructure(int tabs); - //void getTreeAsList(List * temp); - List listOfNodes; - List childChains; - POEMSChain * parentChain; - List childRings; - - - void printTreeStructure(int tabs){ - for(int i = 0; i < tabs; i++) - { - cout << "\t"; - } - cout << "Chain: "; - for(int i = 0; i < listOfNodes.GetNumElements(); i++) - { - cout << *(listOfNodes(i)) << " "; - } - cout << endl; - for(int i = 0; i < childChains.GetNumElements(); i++) - { - childChains(i)->printTreeStructure(tabs + 1); - } - } - void getTreeAsList(List * temp) - { - for(int i = 0; i < listOfNodes.GetNumElements(); i++) - { - int * integer = new int; - *integer = *(listOfNodes(i)); - temp->Append(integer); - } - for(int i = 0; i < childChains.GetNumElements(); i++) - { - childChains(i)->getTreeAsList(temp); - } - } + ~POEMSChain(){ + for(int i = 0; i < childChains.GetNumElements(); i++) + { + delete childChains(i); + } + listOfNodes.DeleteValues(); + } + //void printTreeStructure(int tabs); + //void getTreeAsList(List * temp); + List listOfNodes; + List childChains; + POEMSChain * parentChain; + List childRings; + + + void printTreeStructure(int tabs){ + for(int i = 0; i < tabs; i++) + { + std::cout << "\t"; + } + std::cout << "Chain: "; + for(int i = 0; i < listOfNodes.GetNumElements(); i++) + { + std::cout << *(listOfNodes(i)) << " "; + } + std::cout << std::endl; + for(int i = 0; i < childChains.GetNumElements(); i++) + { + childChains(i)->printTreeStructure(tabs + 1); + } + } + void getTreeAsList(List * temp) + { + for(int i = 0; i < listOfNodes.GetNumElements(); i++) + { + int * integer = new int; + *integer = *(listOfNodes(i)); + temp->Append(integer); + } + for(int i = 0; i < childChains.GetNumElements(); i++) + { + childChains(i)->getTreeAsList(temp); + } + } }; +} #endif diff --git a/lib/poems/SystemProcessor.h b/lib/poems/SystemProcessor.h index 3be168c34d..a6001d96d0 100644 --- a/lib/poems/SystemProcessor.h +++ b/lib/poems/SystemProcessor.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: SystemProcessor.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,59 +11,61 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef _SYS_PROCESSOR_H_ #define _SYS_PROCESSOR_H_ +#include #include "poemslist.h" #include "poemstree.h" #include "POEMSChain.h" +namespace POEMS { struct POEMSNode { - List links; - List taken; - int idNumber; - bool visited; - - ~POEMSNode(){ - for(int i = 0; i < taken.GetNumElements(); i++) - { - delete taken(i); - } - }; + List links; + List taken; + int idNumber; + bool visited; + + ~POEMSNode(){ + for(int i = 0; i < taken.GetNumElements(); i++) + { + delete taken(i); + } + }; }; class SystemProcessor{ private: - Tree nodes; - static void POEMSNodeDelete_cb(void *node) { - delete (POEMSNode *) node; - } - List headsOfSystems; - List > ringsInSystem; - POEMSNode * findSingleLink(TreeNode * aNode); - POEMSChain * AddNewChain(POEMSNode * currentNode); - bool setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNode); + Tree nodes; + static void POEMSNodeDelete_cb(void *node) { + delete (POEMSNode *) node; + } + List headsOfSystems; + List > ringsInSystem; + POEMSNode * findSingleLink(TreeNode * aNode); + POEMSChain * AddNewChain(POEMSNode * currentNode); + bool setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNode); public: - SystemProcessor(void); - - ~SystemProcessor(void) { - headsOfSystems.DeleteValues(); - for(int i = 0; i < ringsInSystem.GetNumElements(); i++) - { - for(int k = 0; k < ringsInSystem(i)->GetNumElements(); i++) - { - delete (*ringsInSystem(i))(k); - } - } - }; - void processArray(int** links, int numLinks); - List * getSystemData(); - int getNumberOfHeadChains(); + SystemProcessor(void); + + ~SystemProcessor(void) { + headsOfSystems.DeleteValues(); + for(int i = 0; i < ringsInSystem.GetNumElements(); i++) + { + for(int k = 0; k < ringsInSystem(i)->GetNumElements(); i++) + { + delete (*ringsInSystem(i))(k); + } + } + }; + void processArray(int** links, int numLinks); + List * getSystemData(); + int getNumberOfHeadChains(); }; SystemProcessor::SystemProcessor(void){ @@ -73,145 +75,145 @@ SystemProcessor::SystemProcessor(void){ void SystemProcessor::processArray(int** links, int numLinks) { - bool * false_var; //holds the value false; needed because a constant cannot be put into a list; the list requires a - //reference. - for(int i = 0; i < numLinks; i++) //go through all the links in the input array - { - if(!nodes.Find(links[i][0])) //if the first node in the pair is not found in the storage tree - { - POEMSNode * newNode = new POEMSNode; //make a new node -// forDeletion.Append(newNode); - newNode->idNumber = links[i][0]; //set its ID to the value - newNode->visited = false; //set it to be unvisited - nodes.Insert(links[i][0], links[i][0], (void *) newNode); //and add it to the tree storage structure - } - if(!nodes.Find(links[i][1])) //repeat process for the other half of each link - { - POEMSNode * newNode = new POEMSNode; -// forDeletion.Append(newNode); - newNode->idNumber = links[i][1]; - newNode->visited = false; - nodes.Insert(links[i][1], links[i][1], (void *) newNode); - } - POEMSNode * firstNode = (POEMSNode *)nodes.Find(links[i][0]); //now that we are sure both nodes exist, - POEMSNode * secondNode = (POEMSNode *)nodes.Find(links[i][1]); //we can get both of them out of the tree - firstNode->links.Append(secondNode); //and add the link from the first to the second... - false_var = new bool; - *false_var = false; //make a new false boolean to note that the link between these two - firstNode->taken.Append(false_var); //has not already been taken, and append it to the taken list - secondNode->links.Append(firstNode); //repeat process for link from second node to first - false_var = new bool; - *false_var = false; - secondNode->taken.Append(false_var); - } - - TreeNode * temp = nodes.GetRoot(); //get the root node of the node storage tree - POEMSNode * currentNode; - do - { - currentNode = findSingleLink(temp); //find the start of the next available chain - if(currentNode != NULL) - { - headsOfSystems.Append(AddNewChain(currentNode)); //and add it to the headsOfSystems list of chains - } - } - while(currentNode != NULL); //repeat this until all chains have been added + bool * false_var; //holds the value false; needed because a constant cannot be put into a list; the list requires a + //reference. + for(int i = 0; i < numLinks; i++) //go through all the links in the input array + { + if(!nodes.Find(links[i][0])) //if the first node in the pair is not found in the storage tree + { + POEMSNode * newNode = new POEMSNode; //make a new node +// forDeletion.Append(newNode); + newNode->idNumber = links[i][0]; //set its ID to the value + newNode->visited = false; //set it to be unvisited + nodes.Insert(links[i][0], links[i][0], (void *) newNode); //and add it to the tree storage structure + } + if(!nodes.Find(links[i][1])) //repeat process for the other half of each link + { + POEMSNode * newNode = new POEMSNode; +// forDeletion.Append(newNode); + newNode->idNumber = links[i][1]; + newNode->visited = false; + nodes.Insert(links[i][1], links[i][1], (void *) newNode); + } + POEMSNode * firstNode = (POEMSNode *)nodes.Find(links[i][0]); //now that we are sure both nodes exist, + POEMSNode * secondNode = (POEMSNode *)nodes.Find(links[i][1]); //we can get both of them out of the tree + firstNode->links.Append(secondNode); //and add the link from the first to the second... + false_var = new bool; + *false_var = false; //make a new false boolean to note that the link between these two + firstNode->taken.Append(false_var); //has not already been taken, and append it to the taken list + secondNode->links.Append(firstNode); //repeat process for link from second node to first + false_var = new bool; + *false_var = false; + secondNode->taken.Append(false_var); + } + + TreeNode * temp = nodes.GetRoot(); //get the root node of the node storage tree + POEMSNode * currentNode; + do + { + currentNode = findSingleLink(temp); //find the start of the next available chain + if(currentNode != NULL) + { + headsOfSystems.Append(AddNewChain(currentNode)); //and add it to the headsOfSystems list of chains + } + } + while(currentNode != NULL); //repeat this until all chains have been added } POEMSChain * SystemProcessor::AddNewChain(POEMSNode * currentNode){ - if(currentNode == NULL) //Termination condition; if the currentNode is null, then return null - { - return NULL; - } - int * tmp; - POEMSNode * nextNode = NULL; //nextNode stores the proposed next node to add to the chain. this will be checked to make sure no backtracking is occuring before being assigned as the current node. - POEMSChain * newChain = new POEMSChain; //make a new POEMSChain object. This will be the object returned + if(currentNode == NULL) //Termination condition; if the currentNode is null, then return null + { + return NULL; + } + int * tmp; + POEMSNode * nextNode = NULL; //nextNode stores the proposed next node to add to the chain. this will be checked to make sure no backtracking is occuring before being assigned as the current node. + POEMSChain * newChain = new POEMSChain; //make a new POEMSChain object. This will be the object returned - if(currentNode->links.GetNumElements() == 0) //if we have no links from this node, then the whole chain is only one node. Add this node to the chain and return it; mark node as visited for future reference - { - currentNode->visited = true; - tmp = new int; - *tmp = currentNode->idNumber; - newChain->listOfNodes.Append(tmp); - return newChain; - } - while(currentNode->links.GetNumElements() <= 2) //we go until we get to a node that branches, or both branches have already been taken both branches can already be taken if a loop with no spurs is found in the input data - { - currentNode->visited = true; - tmp = new int; - *tmp = currentNode->idNumber; - newChain->listOfNodes.Append(tmp); //append the current node to the chain & mark as visited - //cout << "Appending node " << currentNode->idNumber << " to chain" << endl; - nextNode = currentNode->links.GetHeadElement()->value; //the next node is the first or second value stored in the links array - //of the current node. We get the first value... - if(!setLinkVisited(currentNode, nextNode)) //...and see if it points back to where we came from. If it does... - { //either way, we set this link as visited - if(currentNode->links.GetNumElements() == 1) //if it does, then if that is the only link to this node, we're done with the chain, so append the chain to the list and return the newly created chain - { -// headsOfSystems.Append(newChain); - return newChain; - } - nextNode = currentNode->links.GetHeadElement()->next->value;//follow the other link if there is one, so we go down the chain - if(!setLinkVisited(currentNode, nextNode)) //mark link as followed, so we know not to backtrack - { - // headsOfSystems.Append(newChain); - return newChain; //This condition, where no branches have occurred but both links have already - //been taken can only occur in a loop with no spurs; add this loop to the - //system (currently added as a chain for consistency), and return. - } - } - currentNode = nextNode; //set the current node to be the next node in the chain - } - currentNode->visited = true; - tmp = new int; - *tmp = currentNode->idNumber; - newChain->listOfNodes.Append(tmp); //append the last node before branch (node shared jointly with branch chains) - //re-mark as visited, just to make sure - ListElement * tempNode = currentNode->links.GetHeadElement(); //go through all of the links, one at a time that branch - POEMSChain * tempChain = NULL; //temporary variable to hold data - while(tempNode != NULL) //when we have followed all links, stop - { - if(setLinkVisited(tempNode->value, currentNode)) //dont backtrack, or create closed loops - { - tempChain = AddNewChain(tempNode->value); //Add a new chain created out of the next node down that link - tempChain->parentChain = newChain; //set the parent to be this chain - newChain->childChains.Append(tempChain); //append the chain to this chain's list of child chains - } - tempNode = tempNode->next; //go to process the next chain - } - //headsOfSystems.Append(newChain); //append this chain to the system list - return newChain; + if(currentNode->links.GetNumElements() == 0) //if we have no links from this node, then the whole chain is only one node. Add this node to the chain and return it; mark node as visited for future reference + { + currentNode->visited = true; + tmp = new int; + *tmp = currentNode->idNumber; + newChain->listOfNodes.Append(tmp); + return newChain; + } + while(currentNode->links.GetNumElements() <= 2) //we go until we get to a node that branches, or both branches have already been taken both branches can already be taken if a loop with no spurs is found in the input data + { + currentNode->visited = true; + tmp = new int; + *tmp = currentNode->idNumber; + newChain->listOfNodes.Append(tmp); //append the current node to the chain & mark as visited + //std::cout << "Appending node " << currentNode->idNumber << " to chain" << std::endl; + nextNode = currentNode->links.GetHeadElement()->value; //the next node is the first or second value stored in the links array + //of the current node. We get the first value... + if(!setLinkVisited(currentNode, nextNode)) //...and see if it points back to where we came from. If it does... + { //either way, we set this link as visited + if(currentNode->links.GetNumElements() == 1) //if it does, then if that is the only link to this node, we're done with the chain, so append the chain to the list and return the newly created chain + { +// headsOfSystems.Append(newChain); + return newChain; + } + nextNode = currentNode->links.GetHeadElement()->next->value;//follow the other link if there is one, so we go down the chain + if(!setLinkVisited(currentNode, nextNode)) //mark link as followed, so we know not to backtrack + { + // headsOfSystems.Append(newChain); + return newChain; //This condition, where no branches have occurred but both links have already + //been taken can only occur in a loop with no spurs; add this loop to the + //system (currently added as a chain for consistency), and return. + } + } + currentNode = nextNode; //set the current node to be the next node in the chain + } + currentNode->visited = true; + tmp = new int; + *tmp = currentNode->idNumber; + newChain->listOfNodes.Append(tmp); //append the last node before branch (node shared jointly with branch chains) + //re-mark as visited, just to make sure + ListElement * tempNode = currentNode->links.GetHeadElement(); //go through all of the links, one at a time that branch + POEMSChain * tempChain = NULL; //temporary variable to hold data + while(tempNode != NULL) //when we have followed all links, stop + { + if(setLinkVisited(tempNode->value, currentNode)) //dont backtrack, or create closed loops + { + tempChain = AddNewChain(tempNode->value); //Add a new chain created out of the next node down that link + tempChain->parentChain = newChain; //set the parent to be this chain + newChain->childChains.Append(tempChain); //append the chain to this chain's list of child chains + } + tempNode = tempNode->next; //go to process the next chain + } + //headsOfSystems.Append(newChain); //append this chain to the system list + return newChain; } POEMSNode * SystemProcessor::findSingleLink(TreeNode * aNode) //This function takes the root of a search tree containing POEMSNodes and returns a POEMSNode corresponding to the start of a chain in the //system. It finds a node that has not been visited before, and only has one link; this node will be used as the head of the chain. { - if(aNode == NULL) - { - return NULL; - } - POEMSNode * returnVal = (POEMSNode *)aNode->GetAuxData(); //get the poemsnode data out of the treenode - POEMSNode * detectLoneLoops = NULL; //is used to handle a loop that has no protruding chains - if(returnVal->visited == false) - { - detectLoneLoops = returnVal; //if we find any node that has not been visited yet, save it - } - if(returnVal->links.GetNumElements() == 1 && returnVal->visited == false) //see if it has one element and hasnt been visited already - { - return returnVal; //return the node is it meets this criteria - } - returnVal = findSingleLink(aNode->Left()); //otherwise, check the left subtree - if(returnVal == NULL) //and if we find nothing... - { - returnVal = findSingleLink(aNode->Right()); //check the right subtree - } - if(returnVal == NULL) //if we could not find any chains - { - returnVal = detectLoneLoops; //see if we found any nodes at all that havent been processed - } - return returnVal; //return what we find (will be NULL if no new chains are - //found) + if(aNode == NULL) + { + return NULL; + } + POEMSNode * returnVal = (POEMSNode *)aNode->GetAuxData(); //get the poemsnode data out of the treenode + POEMSNode * detectLoneLoops = NULL; //is used to handle a loop that has no protruding chains + if(returnVal->visited == false) + { + detectLoneLoops = returnVal; //if we find any node that has not been visited yet, save it + } + if(returnVal->links.GetNumElements() == 1 && returnVal->visited == false) //see if it has one element and hasnt been visited already + { + return returnVal; //return the node is it meets this criteria + } + returnVal = findSingleLink(aNode->Left()); //otherwise, check the left subtree + if(returnVal == NULL) //and if we find nothing... + { + returnVal = findSingleLink(aNode->Right()); //check the right subtree + } + if(returnVal == NULL) //if we could not find any chains + { + returnVal = detectLoneLoops; //see if we found any nodes at all that havent been processed + } + return returnVal; //return what we find (will be NULL if no new chains are + //found) } bool SystemProcessor::setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNode) @@ -223,65 +225,66 @@ bool SystemProcessor::setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNo //value for that particular link. Because each link is represented twice, (once at each node in the link), both of the boolean values need //to be set in the event that the link has to be set as visited. { - //cout << "Checking link between nodes " << firstNode->idNumber << " and " << secondNode->idNumber << "... "; - ListElement * tmp = firstNode->links.GetHeadElement(); //get the head element of the list of pointers for node 1 - ListElement * tmp2 = firstNode->taken.GetHeadElement(); //get the head element of the list of bool isVisited flags for node 1 - while(tmp->value != NULL || tmp2->value != NULL) //go through untill we reach the end of the lists - { - if(tmp->value == secondNode) //if we find the link to the other node - { - if(*(tmp2->value) == true) //if the link has already been visited - { - //cout << "visited already" << endl; - return false; //return false to indicate that the link has been visited before this attempt - } - else //otherwise, visit it - { - *tmp2->value = true; - } - break; - } - tmp = tmp->next; //go check next link - tmp2 = tmp2->next; - } + //std::cout << "Checking link between nodes " << firstNode->idNumber << " and " << secondNode->idNumber << "... "; + ListElement * tmp = firstNode->links.GetHeadElement(); //get the head element of the list of pointers for node 1 + ListElement * tmp2 = firstNode->taken.GetHeadElement(); //get the head element of the list of bool isVisited flags for node 1 + while(tmp->value != NULL || tmp2->value != NULL) //go through untill we reach the end of the lists + { + if(tmp->value == secondNode) //if we find the link to the other node + { + if(*(tmp2->value) == true) //if the link has already been visited + { + //std::cout << "visited already" << std::endl; + return false; //return false to indicate that the link has been visited before this attempt + } + else //otherwise, visit it + { + *tmp2->value = true; + } + break; + } + tmp = tmp->next; //go check next link + tmp2 = tmp2->next; + } - tmp = secondNode->links.GetHeadElement(); //now, if the link was unvisited, we need to go set the other node's list such that - //it also knows this link is being visited - tmp2 = secondNode->taken.GetHeadElement(); - while(tmp->value != NULL || tmp2->value != NULL) //go through the list - { - if(tmp->value == firstNode) //if we find the link - { - if(*(tmp2->value) == true) //and it has already been visited, then signal an error; this shouldnt ever happen - { - cout << "Error in parsing structure! Should never reach this condition! \n" << - "Record of visited links out of synch between two adjacent nodes.\n"; - return false; - } - else - { - *tmp2->value = true; //set the appropriate value to true to indicate this link has been visited - } - break; - } - tmp = tmp->next; - tmp2 = tmp2->next; - } - //cout << "not visited" << endl; - return true; //return true to indicate that this is the first time the link has been visited + tmp = secondNode->links.GetHeadElement(); //now, if the link was unvisited, we need to go set the other node's list such that + //it also knows this link is being visited + tmp2 = secondNode->taken.GetHeadElement(); + while(tmp->value != NULL || tmp2->value != NULL) //go through the list + { + if(tmp->value == firstNode) //if we find the link + { + if(*(tmp2->value) == true) //and it has already been visited, then signal an error; this shouldnt ever happen + { + std::cout << "Error in parsing structure! Should never reach this condition! \n" << + "Record of visited links out of synch between two adjacent nodes.\n"; + return false; + } + else + { + *tmp2->value = true; //set the appropriate value to true to indicate this link has been visited + } + break; + } + tmp = tmp->next; + tmp2 = tmp2->next; + } + //std::cout << "not visited" << std::endl; + return true; //return true to indicate that this is the first time the link has been visited } -List * SystemProcessor::getSystemData(void) //Gets the list of POEMSChains that comprise the system. Might eventually only - //return chains linked to the reference plane, but currently returns every chain - //in the system. +List * SystemProcessor::getSystemData(void) //Gets the list of POEMSChains that comprise the system. Might eventually only + //return chains linked to the reference plane, but currently returns every chain + //in the system. { - return &headsOfSystems; + return &headsOfSystems; } int SystemProcessor::getNumberOfHeadChains(void) //This function isnt implemented yet, and might be taken out entirely; this was a holdover - //from when I intended to return an array of chain pointers, rather than a list of chains - //It will probably be deleted once I finish figuring out exactly what needs to be returned + //from when I intended to return an array of chain pointers, rather than a list of chains + //It will probably be deleted once I finish figuring out exactly what needs to be returned { - return 0; + return 0; +} } #endif diff --git a/lib/poems/body.cpp b/lib/poems/body.cpp index 487d5e1ab7..6825941b93 100644 --- a/lib/poems/body.cpp +++ b/lib/poems/body.cpp @@ -26,9 +26,8 @@ #include "rigidbody.h" #include "vect3.h" -class Joint; - using namespace std; +using namespace POEMS; Body::Body() { @@ -132,7 +131,7 @@ void Body::AddPoint(Point* point){ // global body functions // -Body* NewBody(int type){ +Body* POEMS::NewBody(int type){ switch( BodyType(type) ) { case INERTIALFRAME : // The inertial reference frame diff --git a/lib/poems/body.h b/lib/poems/body.h index 06a9c72417..e2394b40aa 100644 --- a/lib/poems/body.h +++ b/lib/poems/body.h @@ -25,6 +25,7 @@ #include "mat3x3.h" #include "vect3.h" +namespace POEMS { // emumerated type enum BodyType { INERTIALFRAME = 0, @@ -75,5 +76,5 @@ public: // global body functions Body* NewBody(int type); - +} #endif diff --git a/lib/poems/body23joint.cpp b/lib/poems/body23joint.cpp index 7aa761fe2a..e3ef32b2a9 100644 --- a/lib/poems/body23joint.cpp +++ b/lib/poems/body23joint.cpp @@ -27,6 +27,9 @@ #include "vect3.h" #include "virtualmatrix.h" +using namespace std; +using namespace POEMS; + Body23Joint::Body23Joint(){ DimQandU(4,2); } diff --git a/lib/poems/body23joint.h b/lib/poems/body23joint.h index c47cdfb9de..43a727c815 100644 --- a/lib/poems/body23joint.h +++ b/lib/poems/body23joint.h @@ -22,6 +22,7 @@ #include "joint.h" #include "matrix.h" +namespace POEMS { class Body23Joint : public Joint { Matrix const_sP; public: @@ -38,5 +39,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; - +} #endif diff --git a/lib/poems/colmatmap.cpp b/lib/poems/colmatmap.cpp index 1954e7ff15..34a95feb03 100644 --- a/lib/poems/colmatmap.cpp +++ b/lib/poems/colmatmap.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + ColMatMap::ColMatMap(){ numrows = 0; diff --git a/lib/poems/colmatmap.h b/lib/poems/colmatmap.h index 6d84870046..5a12cf487f 100644 --- a/lib/poems/colmatmap.h +++ b/lib/poems/colmatmap.h @@ -24,6 +24,7 @@ #include "virtualcolmatrix.h" #include "virtualmatrix.h" +namespace POEMS { class ColMatrix; class ColMatMap : public VirtualColMatrix { @@ -64,5 +65,5 @@ public: friend void FastCKRK5(ColMatMap& X, ColMatrix& Xi, ColMatrix* f, double* c, double dt); friend void FastFRK5(ColMatMap& X, ColMatrix& Xi, ColMatrix* f, double* c, double dt); }; - +} #endif diff --git a/lib/poems/colmatrix.cpp b/lib/poems/colmatrix.cpp index e7ae98a368..0cc666645a 100644 --- a/lib/poems/colmatrix.cpp +++ b/lib/poems/colmatrix.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + ColMatrix::ColMatrix(){ numrows = 0; diff --git a/lib/poems/colmatrix.h b/lib/poems/colmatrix.h index 70f13356e2..bcfa86843a 100644 --- a/lib/poems/colmatrix.h +++ b/lib/poems/colmatrix.h @@ -23,12 +23,14 @@ #include "virtualcolmatrix.h" #include "virtualmatrix.h" +namespace POEMS { class Matrix; class Vect6; class Mat3x3; class Vect3; class ColMatrix : public VirtualColMatrix { +protected: double* elements; public: ColMatrix(); @@ -58,28 +60,28 @@ public: ColMatrix& operator=(const VirtualMatrix& A); // overloaded = ColMatrix& operator*=(double b); - void Abs(); - void BasicMax(double& value, int& index); - void BasicMin(double& value, int& index); + void Abs(); + void BasicMax(double& value, int& index); + void BasicMin(double& value, int& index); // fast matrix operations - friend void FastQuaternions(ColMatrix& q, Mat3x3& C); - friend void FastInvQuaternions(Mat3x3& C, ColMatrix& q); - friend void FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot); - friend void FastTMult(Matrix& A, Vect6& B, ColMatrix& C); - friend void FastMult(Matrix& A, ColMatrix& B, Vect6& C); - friend void FastAssign(ColMatrix& A, ColMatrix& C); + friend void FastQuaternions(ColMatrix& q, Mat3x3& C); + friend void FastInvQuaternions(Mat3x3& C, ColMatrix& q); + friend void FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot); + friend void FastTMult(Matrix& A, Vect6& B, ColMatrix& C); + friend void FastMult(Matrix& A, ColMatrix& B, Vect6& C); + friend void FastAssign(ColMatrix& A, ColMatrix& C); - friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); - friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); - friend void FastAssign(ColMatrix&A, Vect3& C); - - friend void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); - friend void EP_Transformation(ColMatrix& q, Mat3x3& C); - friend void EP_FromTransformation(ColMatrix& q, Mat3x3& C); - friend void EP_Normalize(ColMatrix& q); - friend void EPdotdot_udot(ColMatrix& Audot, ColMatrix& Aqdot, ColMatrix& Aq,ColMatrix& Aqddot); - friend void qdot_to_u(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); -}; + friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); + friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); + friend void FastAssign(ColMatrix&A, Vect3& C); + friend void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); + friend void EP_Transformation(ColMatrix& q, Mat3x3& C); + friend void EP_FromTransformation(ColMatrix& q, Mat3x3& C); + friend void EP_Normalize(ColMatrix& q); + friend void EPdotdot_udot(ColMatrix& Audot, ColMatrix& Aqdot, ColMatrix& Aq,ColMatrix& Aqddot); + friend void qdot_to_u(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); +}; +} #endif diff --git a/lib/poems/defines.h b/lib/poems/defines.h index 455bc298d5..877bc0fa0b 100644 --- a/lib/poems/defines.h +++ b/lib/poems/defines.h @@ -15,13 +15,14 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ -#ifndef _DEFINES_H_ -#define _DEFINES_H_ +#ifndef POEMS_DEFINES_H +#define POEMS_DEFINES_H +namespace POEMS { enum SolverType { ONSOLVER = 0, PARTICLESOLVER = 1 }; - +} #endif diff --git a/lib/poems/eulerparameters.cpp b/lib/poems/eulerparameters.cpp index f698c40b3a..bb8d676796 100644 --- a/lib/poems/eulerparameters.cpp +++ b/lib/poems/eulerparameters.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: eulerparameters.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -23,8 +23,10 @@ #include "mat3x3.h" using namespace std; +using namespace POEMS; -void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot){ + +void POEMS::EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot){ EP_Normalize(q); int num=u.GetNumRows(); if (3 @@ -28,10 +28,12 @@ #include "mat6x6.h" #include "vect3.h" #include "virtualmatrix.h" - + +using namespace POEMS; + FreeBodyJoint::FreeBodyJoint(){ - DimQandU(7,6); + DimQandU(7,6); } FreeBodyJoint::~FreeBodyJoint(){ @@ -49,112 +51,112 @@ void FreeBodyJoint::WriteOutJointData(std::ostream& out){ } void FreeBodyJoint::ComputeLocalTransform(){ - Mat3x3 ko_C_k; - EP_Transformation(q, ko_C_k); - FastMult(pk_C_ko,ko_C_k,pk_C_k); + Mat3x3 ko_C_k; + EP_Transformation(q, ko_C_k); + FastMult(pk_C_ko,ko_C_k,pk_C_k); } Matrix FreeBodyJoint::GetForward_sP(){ Mat6x6 sP; - //sP.Identity(); - - sP.Zeros(); + //sP.Identity(); + + sP.Zeros(); Mat3x3 temp0=T(pk_C_k); for(int i=1;i<4;i++){ sP(i,i)=1.0; for(int j=1;j<4;j++){ sP(3+i,3+j)=temp0(i,j); } - } - return sP; + } + return sP; } Matrix FreeBodyJoint::GetBackward_sP(){ Mat6x6 sP; - sP.Identity(); + sP.Identity(); sP =-1.0*sP; - cout<<"Did I come here in "<r); - - //COMMENT STEP3: CALCULATE QDOT + + FastAssign(r12,body2->r); + + //COMMENT STEP3: CALCULATE QDOT qdot_to_u(q, u, qdot); - - + + Vect3 WN; WN.BasicSet(0,u.BasicGet(0)); WN.BasicSet(1,u.BasicGet(1)); WN.BasicSet(2,u.BasicGet(2)); - - Vect3 VN; + + Vect3 VN; VN.BasicSet(0,u.BasicGet(3)); VN.BasicSet(1,u.BasicGet(4)); - VN.BasicSet(2,u.BasicGet(5)); - - FastAssign(WN,body2->omega_k); - + VN.BasicSet(2,u.BasicGet(5)); + + FastAssign(WN,body2->omega_k); + Vect3 pk_w_k; - FastMult(body2->n_C_k,WN,pk_w_k); + FastMult(body2->n_C_k,WN,pk_w_k); FastAssign(pk_w_k,body2->omega); - - - - //COMMENT STEP5: CALCULATE VELOCITES - FastAssign(VN,body2->v); - FastTMult(body2->n_C_k,body2->v,body2->v_k); - - - //CALCULATE KE - + + + + //COMMENT STEP5: CALCULATE VELOCITES + FastAssign(VN,body2->v); + FastTMult(body2->n_C_k,body2->v,body2->v_k); + + + //CALCULATE KE + Matrix tempke; - tempke = T(body2->v)*(body2->v); + tempke = T(body2->v)*(body2->v); double ke = 0.0; - ke = body2->mass*tempke(1,1); + ke = body2->mass*tempke(1,1); FastMult(body2->inertia,body2->omega_k,result1); - tempke= T(body2->omega_k)*result1; + tempke= T(body2->omega_k)*result1; ke = 0.5*ke + 0.5*tempke(1,1); body2->KE=ke; - - + + //COMMENT STEP6: CALCULATE STATE EXPLICIT ANGULAR ACCELERATIONS body2->alpha_t.Zeros(); - - + + //COMMENT STEP7: CALCULATE STATE EXPLICIT ACCELERATIONS - body2->a_t.Zeros(); - + body2->a_t.Zeros(); + } void FreeBodyJoint::BackwardKinematics(){ -cout<<"Did I come here "< #include "virtualmatrix.h" +namespace POEMS { class Vect3; class Mat6x6; class ColMatrix; @@ -67,16 +68,15 @@ public: friend void FastMult(Mat3x3& A, Mat3x3& B, Mat3x3& C); friend void FastMultT(Mat3x3& A, Mat3x3& B, Mat3x3& C); friend void FastAssignT(Mat3x3& A, Mat3x3& C); - friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); - + friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); + friend void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC); friend void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI); friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); - + friend void EP_Transformation(ColMatrix& q, Mat3x3& C); friend void EP_FromTransformation(ColMatrix& q, Mat3x3& C); - }; - +} #endif diff --git a/lib/poems/mat4x4.cpp b/lib/poems/mat4x4.cpp index a6a587bc03..9a0e7b8d56 100644 --- a/lib/poems/mat4x4.cpp +++ b/lib/poems/mat4x4.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + Mat4x4::Mat4x4(){ numrows = numcols = 4; diff --git a/lib/poems/mat4x4.h b/lib/poems/mat4x4.h index a6ae232473..3f6d97ba15 100644 --- a/lib/poems/mat4x4.h +++ b/lib/poems/mat4x4.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: mat4x4.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,17 +21,18 @@ #include #include "virtualmatrix.h" +namespace POEMS { class Vect4; class Matrix; class Mat4x4 : public VirtualMatrix { double elements[4][4]; -public: +public: Mat4x4(); ~Mat4x4(); Mat4x4(const Mat4x4& A); // copy constructor Mat4x4(const VirtualMatrix& A); // copy constructor - + double& operator_2int (int i, int j); // array access double Get_2int(int i, int j) const; void Set_2int(int i, int j, double value); @@ -64,5 +65,5 @@ public: friend void FastMultT(Mat4x4& A, Mat4x4& B, Mat4x4& C); friend void FastAssignT(Mat4x4& A, Mat4x4& C); }; - +} #endif diff --git a/lib/poems/mat6x6.cpp b/lib/poems/mat6x6.cpp index fdc917e03d..e9dde2fe87 100644 --- a/lib/poems/mat6x6.cpp +++ b/lib/poems/mat6x6.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + Mat6x6::Mat6x6(){ numrows = numcols = 6; diff --git a/lib/poems/mat6x6.h b/lib/poems/mat6x6.h index 5eaa4f803b..a611bc8283 100644 --- a/lib/poems/mat6x6.h +++ b/lib/poems/mat6x6.h @@ -21,6 +21,7 @@ #include "virtualmatrix.h" +namespace POEMS { class Matrix; class Mat3x3; class Vect6; @@ -73,5 +74,5 @@ public: friend void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC); friend void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI); }; - +} #endif diff --git a/lib/poems/matrices.h b/lib/poems/matrices.h index 7a7e2c4b58..15f0d3ad23 100644 --- a/lib/poems/matrices.h +++ b/lib/poems/matrices.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: matrices.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -20,23 +20,14 @@ #define MATRICES_H #include "matrix.h" - #include "colmatrix.h" - #include "rowmatrix.h" - #include "mat3x3.h" - #include "vect3.h" - #include "mat4x4.h" - #include "vect4.h" - #include "mat6x6.h" - #include "vect6.h" - #include "colmatmap.h" #endif diff --git a/lib/poems/matrix.cpp b/lib/poems/matrix.cpp index f05d6f815c..f7b0c631f2 100644 --- a/lib/poems/matrix.cpp +++ b/lib/poems/matrix.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + Matrix::Matrix(){ numrows = numcols = 0; diff --git a/lib/poems/matrix.h b/lib/poems/matrix.h index 8bd8110760..c2ed92873c 100644 --- a/lib/poems/matrix.h +++ b/lib/poems/matrix.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: matrix.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -22,6 +22,7 @@ #include "virtualmatrix.h" +namespace POEMS { class Mat3x3; class Mat4x4; class Mat6x6; @@ -73,7 +74,6 @@ public: friend void FastMult(Mat6x6& A, Matrix& B, Matrix& C); friend void FastMult(Matrix& A, ColMatrix& B, Vect6& C); friend void FastMultT(Matrix& A, Matrix& B, Mat6x6& C); - }; - +} #endif diff --git a/lib/poems/matrixfun.cpp b/lib/poems/matrixfun.cpp index 99fbae4ca1..037e986a99 100644 --- a/lib/poems/matrixfun.cpp +++ b/lib/poems/matrixfun.cpp @@ -27,12 +27,14 @@ #include "virtualrowmatrix.h" using namespace std; +using namespace POEMS; + // // Create a new matrix // -VirtualMatrix* NewMatrix(int type){ +VirtualMatrix* POEMS::NewMatrix(int type){ switch( MatrixType(type) ) { case MATRIX : return new Matrix; @@ -50,7 +52,7 @@ VirtualMatrix* NewMatrix(int type){ // Transpose // -Matrix T(const VirtualMatrix& A){ +Matrix POEMS::T(const VirtualMatrix& A){ int numrows = A.GetNumRows(); int numcols = A.GetNumCols(); Matrix C(numcols,numrows); @@ -60,8 +62,8 @@ Matrix T(const VirtualMatrix& A){ return C; } -Mat3x3 T(const Mat3x3& A){ - Mat3x3 C; +Mat3x3 POEMS::T(const Mat3x3& A){ + Mat3x3 C; C.elements[0][0] = A.elements[0][0]; C.elements[1][1] = A.elements[1][1]; C.elements[2][2] = A.elements[2][2]; @@ -76,7 +78,7 @@ Mat3x3 T(const Mat3x3& A){ return C; } -Mat6x6 T(const Mat6x6& A){ +Mat6x6 POEMS::T(const Mat6x6& A){ Mat6x6 C; int i,j; for(i=0;i<6;i++) @@ -86,7 +88,7 @@ Mat6x6 T(const Mat6x6& A){ return C; } -Matrix T(const Vect3& A){ +Matrix POEMS::T(const Vect3& A){ Matrix C(1,3); C.BasicSet(0,0,A.elements[0]); C.BasicSet(0,1,A.elements[1]); @@ -95,7 +97,7 @@ Matrix T(const Vect3& A){ return C; } -Matrix T(const Vect6& A){ +Matrix POEMS::T(const Vect6& A){ Matrix C(1,6); C.BasicSet(0,0,A.elements[0]); C.BasicSet(0,1,A.elements[1]); @@ -107,7 +109,7 @@ Matrix T(const Vect6& A){ return C; } -RowMatrix T(const VirtualColMatrix &A){ +RowMatrix POEMS::T(const VirtualColMatrix &A){ int numele = A.GetNumRows(); RowMatrix C(numele); for(int i=0;i @@ -29,9 +29,11 @@ #include "vect3.h" #include "virtualmatrix.h" - +using namespace POEMS; +using namespace std; + -MixedJoint::MixedJoint(){ +MixedJoint::MixedJoint(){ } MixedJoint::~MixedJoint(){ @@ -54,23 +56,23 @@ void MixedJoint::SetsP(Matrix& sPr, Vect6& temp_dofs, int i, int j){ numrots = i; numtrans = j; if (numrots < 2) - DimQandU(numrots+numtrans,numrots+numtrans); - else - DimQandU((4+numtrans),(numrots+numtrans)); + DimQandU(numrots+numtrans,numrots+numtrans); + else + DimQandU((4+numtrans),(numrots+numtrans)); cout<<"Check "<<4+numtrans<<" "< 1) EP_Normalize(q); // COMMENT STEP1: CALCULATE ORIENTATIONS - ComputeForwardTransforms(); - - + ComputeForwardTransforms(); + + //COMMENT STEP2: CALCULATE POSITION VECTORS - Vect3 result1, result2, result3, result4; + Vect3 result1, result2, result3, result4; result1.Zeros(); for (int k=0; k<3; k++){ if( dofs(3+k) != 0.0 ){ @@ -116,32 +118,32 @@ void MixedJoint::ForwardKinematics(){ result1.BasicSet(k,q.BasicGet(4 + k)); else result1.BasicSet(k,q.BasicGet(numrots + k)); - } + } } - - - - FastAssign(result1,r12); // r12 in parents basis i.e. Newtonian - FastNegMult(k_C_pk,r12,r21); // r21 in body basis - - FastAssign(r12,body2->r); // This is right - - //COMMENT STEP3: CALCULATE QDOT + + + + FastAssign(result1,r12); // r12 in parents basis i.e. Newtonian + FastNegMult(k_C_pk,r12,r21); // r21 in body basis + + FastAssign(r12,body2->r); // This is right + + //COMMENT STEP3: CALCULATE QDOT int pp = 0; if (numrots > 1){ ColMatrix temp_u(3+numtrans); qdot_to_u(q,temp_u,qdot); for (int k=1;k<=6;k++){ if(dofs(k) != 0.0){ - u.BasicSet(pp,temp_u.BasicGet(k-1)); + u.BasicSet(pp,temp_u.BasicGet(k-1)); pp = pp+1; - } + } } } else u = qdot; - - + + Vect3 WN; WN.Zeros(); int p = 0; for (int k=0;k<3;k++){ @@ -151,51 +153,51 @@ void MixedJoint::ForwardKinematics(){ } }// WN is in body basis - - Vect3 VN; VN.Zeros(); + + Vect3 VN; VN.Zeros(); for (int k=0;k<3;k++){ if( dofs(3+k+1) != 0.0 ) { VN.BasicSet(k,u.BasicGet(p)); p=p+1; } }// VN is the vector of translational velocities in Newtonian basis - - FastAssign(WN,body2->omega_k); - // cout<<"Angular Velocity "<omega_k); + + // cout<<"Angular Velocity "<n_C_k,WN,pk_w_k); + FastMult(body2->n_C_k,WN,pk_w_k); FastAssign(pk_w_k,body2->omega); - - - - //COMMENT STEP5: CALCULATE VELOCITES - FastAssign(VN,body2->v); - FastTMult(body2->n_C_k,body2->v,body2->v_k); - - - //CALCULATE KE - + + + + //COMMENT STEP5: CALCULATE VELOCITES + FastAssign(VN,body2->v); + FastTMult(body2->n_C_k,body2->v,body2->v_k); + + + //CALCULATE KE + Matrix tempke; - tempke = T(body2->v)*(body2->v); + tempke = T(body2->v)*(body2->v); double ke = 0.0; - ke = body2->mass*tempke(1,1); + ke = body2->mass*tempke(1,1); FastMult(body2->inertia,body2->omega_k,result1); - tempke= T(body2->omega_k)*result1; + tempke= T(body2->omega_k)*result1; ke = 0.5*ke + 0.5*tempke(1,1); body2->KE=ke; - - + + //COMMENT STEP6: CALCULATE STATE EXPLICIT ANGULAR ACCELERATIONS body2->alpha_t.Zeros(); - - + + //COMMENT STEP7: CALCULATE STATE EXPLICIT ACCELERATIONS - body2->a_t.Zeros(); - + body2->a_t.Zeros(); + } void MixedJoint::BackwardKinematics(){ cout<<"Did I come here "< children; + Body* system_body; + Joint* system_joint; + OnBody* parent; + List children; - Direction joint_dir; - void (Joint::*kinfun)(); // kinematics function - void (Joint::*updatesP)(Matrix&); // sP update function - Vect3* gamma; // pointer to gamma vector - Mat3x3* pk_C_k; // pointer to transformation + Direction joint_dir; + void (Joint::*kinfun)(); // kinematics function + void (Joint::*updatesP)(Matrix&); // sP update function + Vect3* gamma; // pointer to gamma vector + Mat3x3* pk_C_k; // pointer to transformation - - Mat6x6 sI; // spatial inertias - Mat6x6 sIhat; // recursive spatial inertias - Mat6x6 sSC; // spatial shift - Mat6x6 sT; // spatial triangularization - Vect6 sF; // spatial forces - Vect6 sFhat; // recursive spatial forces - Vect6 sAhat; // recursive spatial acceleration + Mat6x6 sI; // spatial inertias + Mat6x6 sIhat; // recursive spatial inertias + Mat6x6 sSC; // spatial shift + Mat6x6 sT; // spatial triangularization - Matrix sP; // spatial partial velocities - Matrix sM; // triangularized mass matrix diagonal elements - Matrix sMinv; // inverse of sM - Matrix sPsMinv; - Matrix sIhatsP; + Vect6 sF; // spatial forces + Vect6 sFhat; // recursive spatial forces + Vect6 sAhat; // recursive spatial acceleration - // states and state derivatives - ColMatrix* q; - ColMatrix* u; - ColMatrix* qdot; - ColMatrix* udot; - ColMatrix* qdotdot; - - ColMatrix* r; - ColMatrix* acc; - ColMatrix* ang; + Matrix sP; // spatial partial velocities + Matrix sM; // triangularized mass matrix diagonal elements + Matrix sMinv; // inverse of sM + Matrix sPsMinv; + Matrix sIhatsP; + + // states and state derivatives + ColMatrix* q; + ColMatrix* u; + ColMatrix* qdot; + ColMatrix* udot; + ColMatrix* qdotdot; + + ColMatrix* r; + ColMatrix* acc; + ColMatrix* ang; // friend classes friend class OnSolver; - -public: - OnBody(); - ~OnBody(); - int RecursiveSetup(InertialFrame* basebody); - int RecursiveSetup(int ID, OnBody* parentbody, Joint* sys_joint); - void RecursiveKinematics(); - void RecursiveTriangularization(); - void RecursiveForwardSubstitution(); - Mat3x3 GetN_C_K(); - Vect3 LocalCart(); - int GetBodyID(); - void CalculateAcceleration(); - void Setup(); - void SetupInertialFrame(); - void LocalKinematics(); - void LocalTriangularization(Vect3& Torque, Vect3& Force); - void LocalForwardSubstitution(); +public: + OnBody(); + ~OnBody(); + int RecursiveSetup(InertialFrame* basebody); + int RecursiveSetup(int ID, OnBody* parentbody, Joint* sys_joint); + void RecursiveKinematics(); + void RecursiveTriangularization(); + void RecursiveForwardSubstitution(); + Mat3x3 GetN_C_K(); + Vect3 LocalCart(); + int GetBodyID(); + void CalculateAcceleration(); + void Setup(); + void SetupInertialFrame(); + void LocalKinematics(); + void LocalTriangularization(Vect3& Torque, Vect3& Force); + void LocalForwardSubstitution(); }; - +} #endif diff --git a/lib/poems/onfunctions.cpp b/lib/poems/onfunctions.cpp index 1d91dbf378..cfc0c60936 100644 --- a/lib/poems/onfunctions.cpp +++ b/lib/poems/onfunctions.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: onfunction.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,10 +11,10 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #include "onfunctions.h" @@ -25,9 +25,11 @@ #include "virtualmatrix.h" using namespace std; +using namespace POEMS; + // friend of Vect3 & Vect6 -void OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV){ +void POEMS::OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV){ sV.elements[0] = angular.elements[0]; sV.elements[1] = angular.elements[1]; sV.elements[2] = angular.elements[2]; @@ -37,38 +39,38 @@ void OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV){ } // friend of Vect3, Mat3x3, & Mat6x6 -void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC){ +void POEMS::OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC){ // the block diagonals - + // the gamma cross with transform Mat3x3 temp; Mat3x3 temp2; SC.Zeros(); - temp.Zeros(); + temp.Zeros(); temp2.Zeros(); - //FastTMult(C,gamma,temp); + //FastTMult(C,gamma,temp); temp(1,2)= -gamma(3); temp(1,3)= gamma(2); temp(2,1)= gamma(3); - temp(2,3)= -gamma(1); temp(3,1)= -gamma(2); temp(3,2)= gamma(1); + temp(2,3)= -gamma(1); temp(3,1)= -gamma(2); temp(3,2)= gamma(1); FastMult(temp,C,temp2); - + SC(1,4)=temp2(1,1); SC(2,4)=temp2(2,1); SC(3,4)=temp2(3,1); SC(1,5)=temp2(1,2); SC(2,5)=temp2(2,2); SC(3,5)=temp2(3,2); SC(1,6)=temp2(1,3); SC(2,6)=temp2(2,3); SC(3,6)=temp2(3,3); - + SC(1,1)=C(1,1); SC(2,1)=C(2,1); SC(3,1)=C(3,1); SC(1,2)=C(1,2); SC(2,2)=C(2,2); SC(3,2)=C(3,2); SC(1,3)=C(1,3); SC(2,3)=C(2,3); SC(3,3)=C(3,3); SC(4,4)=C(1,1); SC(5,4)=C(2,1); SC(6,4)=C(3,1); SC(4,5)=C(1,2); SC(5,5)=C(2,2); SC(6,5)=C(3,2); - SC(4,6)=C(1,3); SC(5,6)=C(2,3); SC(6,6)=C(3,3); - + SC(4,6)=C(1,3); SC(5,6)=C(2,3); SC(6,6)=C(3,3); + } // friend of Mat3x3 & Mat6x6 -void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI){ - - sI(4,4)=mass; sI(5,5)=mass; sI(6,6)=mass; - sI(1,1)=inertia(1,1); sI(1,2)=inertia(1,2); sI(1,3)=inertia(1,3); - sI(2,1)=inertia(2,1); sI(2,2)=inertia(2,2); sI(2,3)=inertia(2,3); - sI(3,1)=inertia(3,1); sI(3,2)=inertia(3,2); sI(3,3)=inertia(3,3); +void POEMS::OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI){ + + sI(4,4)=mass; sI(5,5)=mass; sI(6,6)=mass; + sI(1,1)=inertia(1,1); sI(1,2)=inertia(1,2); sI(1,3)=inertia(1,3); + sI(2,1)=inertia(2,1); sI(2,2)=inertia(2,2); sI(2,3)=inertia(2,3); + sI(3,1)=inertia(3,1); sI(3,2)=inertia(3,2); sI(3,3)=inertia(3,3); } diff --git a/lib/poems/onfunctions.h b/lib/poems/onfunctions.h index 42d0f4ac1c..bb07425b85 100644 --- a/lib/poems/onfunctions.h +++ b/lib/poems/onfunctions.h @@ -18,6 +18,7 @@ #ifndef ONFUNCTIONS_H #define ONFUNCTIONS_H +namespace POEMS { class Mat3x3; class Mat6x6; class Vect3; @@ -30,5 +31,5 @@ void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI); void Create_Map(int MM); int ICELL(int IX,int IY,int IZ, int MM); - +} #endif diff --git a/lib/poems/onsolver.cpp b/lib/poems/onsolver.cpp index dd94c9c7ad..609ef32613 100644 --- a/lib/poems/onsolver.cpp +++ b/lib/poems/onsolver.cpp @@ -33,6 +33,8 @@ #include "virtualmatrix.h" using namespace std; +using namespace POEMS; + OnSolver::OnSolver(){ numbodies = 0; diff --git a/lib/poems/onsolver.h b/lib/poems/onsolver.h index b4bbd5e25d..1e850b8fc1 100644 --- a/lib/poems/onsolver.h +++ b/lib/poems/onsolver.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: onsolver.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -22,32 +22,31 @@ #include "solver.h" #include "onbody.h" +namespace POEMS { class ColMatrix; class Matrix; - - class OnSolver : public Solver { - OnBody inertialframe; - int numbodies; - OnBody** bodyarray; - ColMatrix** q; - ColMatrix** qdot; - ColMatrix** qdotdot; - ColMatrix** u; - ColMatrix** udot; - - - - void DeleteModel(); - int CreateTopologyArray(int i, OnBody* body); - void CreateStateMatrixMaps(); - void GetType(); -public: - OnSolver(); - ~OnSolver(); - void CreateModel(); - void Solve(double time, Matrix& FF); -}; + OnBody inertialframe; + int numbodies; + OnBody** bodyarray; + ColMatrix** q; + ColMatrix** qdot; + ColMatrix** qdotdot; + ColMatrix** u; + ColMatrix** udot; + + + void DeleteModel(); + int CreateTopologyArray(int i, OnBody* body); + void CreateStateMatrixMaps(); + void GetType(); +public: + OnSolver(); + ~OnSolver(); + void CreateModel(); + void Solve(double time, Matrix& FF); +}; +} #endif diff --git a/lib/poems/particle.cpp b/lib/poems/particle.cpp index 0d953e00f6..37ec790666 100644 --- a/lib/poems/particle.cpp +++ b/lib/poems/particle.cpp @@ -18,6 +18,8 @@ #include "particle.h" +using namespace POEMS; + Particle::Particle(){ } diff --git a/lib/poems/particle.h b/lib/poems/particle.h index 0f13252f99..8a7a521451 100644 --- a/lib/poems/particle.h +++ b/lib/poems/particle.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: particle.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -23,14 +23,14 @@ #include "body.h" - +namespace POEMS { class Particle : public Body { -public: +public: Particle(); ~Particle(); BodyType GetType(); bool ReadInBodyData(std::istream& in); void WriteOutBodyData(std::ostream& out); }; - +} #endif diff --git a/lib/poems/poemslist.h b/lib/poems/poemslist.h index 9882af013a..bd0c1456b4 100644 --- a/lib/poems/poemslist.h +++ b/lib/poems/poemslist.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: poemslist.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,8 +21,7 @@ #include #include -using namespace std; - +namespace POEMS { template class ListElement{ public: ListElement* prev; @@ -51,7 +50,7 @@ public: S* operator()(int id); void Append(List * listToAppend); void DeleteValues(); - void RemoveElementAndDeleteValue(ListElement* ele); + void RemoveElementAndDeleteValue(ListElement* ele); void PrintList(); }; @@ -90,9 +89,9 @@ template List::~List(){ template void List::Append(List * listToAppend) { - tail->next = listToAppend->head; - listToAppend->head->prev = tail; - tail = listToAppend->tail; + tail->next = listToAppend->head; + listToAppend->head->prev = tail; + tail = listToAppend->tail; } template int List::GetNumElements(){ @@ -104,17 +103,17 @@ template ListElement* List::GetHeadElement(){ } template ListElement* List::GetTailElement(){ - return tail; + return tail; } template void List::Remove(ListElement* ele){ if(!ele){ - cerr << "ERROR: ListElement to be removed not defined" << endl; + std::cerr << "ERROR: ListElement to be removed not defined" << std::endl; exit(0); } if(!numelements){ - cerr << "ERROR: List is empty" << endl; + std::cerr << "ERROR: List is empty" << std::endl; exit(0); } @@ -135,7 +134,7 @@ template void List::Remove(ListElement* ele){ template ListElement* List::Append(S* v){ if(!v){ - cerr << "ERROR: cannot add null Body to list" << endl; + std::cerr << "ERROR: cannot add null Body to list" << std::endl; exit(0); } @@ -145,22 +144,22 @@ template ListElement* List::Append(S* v){ if(numelements==1) head = tail = ele; else{ - /* + /* tail->next = ele; ele->prev = tail; - tail = ele;*/ - - ele->prev = tail; - tail = ele; - ele->prev->next = ele; - - } + tail = ele;*/ + + ele->prev = tail; + tail = ele; + ele->prev->next = ele; + + } return ele; } template ListElement* List::Prepend(S* v){ if(!v){ - cerr << "ERROR: cannot add null Body to list" << endl; + std::cerr << "ERROR: cannot add null Body to list" << std::endl; exit(0); } @@ -170,9 +169,9 @@ template ListElement* List::Prepend(S* v){ if(numelements==1) head = tail = ele; else{ - ele->next = head; - head = ele; - ele->next->prev = ele; + ele->next = head; + head = ele; + ele->next->prev = ele; } return ele; } @@ -190,15 +189,15 @@ template S** List::CreateArray(){ template S* List::operator()(int id){ if(id >= numelements){ - cerr << "ERROR: subscript out of bounds" << endl; + std::cerr << "ERROR: subscript out of bounds" << std::endl; exit(0); } - + ListElement* ele = head; for(int i=0;inext; } - + return ele->value; } @@ -214,16 +213,15 @@ template void List::RemoveElementAndDeleteValue(ListElement* ele) } template void List::PrintList(){ - cout<<"Printing List "<* ele = head; - cout<<*(ele->value)<<" "; - ele = ele->next; - for(int k =2; kvalue)<<" "; - ele = ele->next; - } - cout<<*(ele->value)<* ele = head; + std::cout << *(ele->value) << " "; + ele = ele->next; + for(int k =2; kvalue) << " "; + ele = ele->next; + } + std::cout << *(ele->value) << std::endl; +} } - - #endif diff --git a/lib/poems/poemsnodelib.h b/lib/poems/poemsnodelib.h index 06cf4530d2..d323b701b0 100644 --- a/lib/poems/poemsnodelib.h +++ b/lib/poems/poemsnodelib.h @@ -20,9 +20,7 @@ #include -using namespace std; - - +namespace POEMS { TreeNode *GetTreeNode(int item,TreeNode *lptr = NULL,TreeNode *rptr =NULL); void FreeTreeNode(TreeNode *p); @@ -81,7 +79,7 @@ TreeNode *GetTreeNode(int item,TreeNode *lptr,TreeNode *rptr) // if insufficient memory, terminatewith an error message if (p == NULL) { - cerr << "Memory allocation failure!\n"; + std::cerr << "Memory allocation failure!\n"; exit(1); } @@ -140,7 +138,7 @@ void IndentBlanks(int num) // const int indentblock = 6; for(int i = 0; i < num; i++) - cout << " "; + std::cout << " "; } void PrintTree (TreeNode *t, int level) @@ -153,10 +151,11 @@ void PrintTree (TreeNode *t, int level) PrintTree(t->Right(),level + 1); // indent to current level; output node data IndentBlanks(indentUnit*level); - cout << t->GetData() << endl; + std::cout << t->GetData() << std::endl; // print left branch of tree t PrintTree(t->Left(),level + 1); } } +} #endif diff --git a/lib/poems/poemsobject.cpp b/lib/poems/poemsobject.cpp index 7c3f1ca872..dfdd95953e 100644 --- a/lib/poems/poemsobject.cpp +++ b/lib/poems/poemsobject.cpp @@ -19,6 +19,8 @@ #include "poemsobject.h" #include +using namespace POEMS; + POEMSObject::POEMSObject(){ name = 0; ChangeName((const char*)"unnamed"); diff --git a/lib/poems/poemsobject.h b/lib/poems/poemsobject.h index 63b2915638..173d9da7ab 100644 --- a/lib/poems/poemsobject.h +++ b/lib/poems/poemsobject.h @@ -19,7 +19,7 @@ #ifndef POEMSOBJECT_H #define POEMSOBJECT_H - +namespace POEMS { class POEMSObject { char* name; int ID; @@ -31,5 +31,5 @@ public: int GetID(); void SetID(int id); }; - +} #endif diff --git a/lib/poems/poemstree.h b/lib/poems/poemstree.h index 8f8e80ab66..d49a0d0a88 100644 --- a/lib/poems/poemstree.h +++ b/lib/poems/poemstree.h @@ -21,7 +21,7 @@ #include "poemstreenode.h" #include "poemsnodelib.h" - +namespace POEMS { // constants to indicate the balance factor of a node const int leftheavy = -1; const int balanced = 0; @@ -609,5 +609,5 @@ void Tree::ClearList(void) delete current; size = 0; } - +} #endif diff --git a/lib/poems/poemstreenode.cpp b/lib/poems/poemstreenode.cpp index 051e13d6e0..ca4307f69f 100644 --- a/lib/poems/poemstreenode.cpp +++ b/lib/poems/poemstreenode.cpp @@ -17,6 +17,8 @@ #include "poemstreenode.h" +using namespace POEMS; + // constructor; initialize the data and pointer fields // The pointer value NULL assigns a empty subtree TreeNode::TreeNode (const int & item, TreeNode *lptr,TreeNode *rptr, diff --git a/lib/poems/poemstreenode.h b/lib/poems/poemstreenode.h index e22bd9b97d..69f3caf958 100644 --- a/lib/poems/poemstreenode.h +++ b/lib/poems/poemstreenode.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: poemstreenode.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,36 +11,37 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef TREENODE_H #define TREENODE_H +namespace POEMS { // declares a tree node object for a binary tree class TreeNode{ private: // points to the left and right children of the node - TreeNode *left; - TreeNode *right; + TreeNode *left; + TreeNode *right; - int balanceFactor; - int data; - void * aux_data; -public: - // make Tree a friend because it needs access to left and right pointer fields of a node - friend class Tree; - TreeNode * Left(); - TreeNode * Right(); - int GetData(); - void * GetAuxData() {return aux_data;}; - void SetAuxData(void * AuxData) {aux_data = AuxData;}; - int GetBalanceFactor(); - TreeNode(const int &item, TreeNode *lptr, TreeNode *rptr, int balfac = 0); - //friend class DCASolver; + int balanceFactor; + int data; + void * aux_data; +public: + // make Tree a friend because it needs access to left and right pointer fields of a node + friend class Tree; + TreeNode * Left(); + TreeNode * Right(); + int GetData(); + void * GetAuxData() {return aux_data;}; + void SetAuxData(void * AuxData) {aux_data = AuxData;}; + int GetBalanceFactor(); + TreeNode(const int &item, TreeNode *lptr, TreeNode *rptr, int balfac = 0); + //friend class DCASolver; }; - +} #endif diff --git a/lib/poems/point.cpp b/lib/poems/point.cpp index d7eed94efd..f648b58d3d 100644 --- a/lib/poems/point.cpp +++ b/lib/poems/point.cpp @@ -20,6 +20,8 @@ #include "point.h" #include "vect3.h" +using namespace POEMS; + Point::Point(){ position.Zeros(); } @@ -35,7 +37,7 @@ void Point::WriteOut(std::ostream& out){ WriteOutPointData(out); } -Point* NewPoint(int type){ +Point* POEMS::NewPoint(int type){ switch( PointType(type) ) { case FIXEDPOINT : // A Fixed Point diff --git a/lib/poems/point.h b/lib/poems/point.h index 746a527cd7..c08e92db0d 100644 --- a/lib/poems/point.h +++ b/lib/poems/point.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: point.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -22,21 +22,21 @@ #include "poemsobject.h" #include "vect3.h" - +namespace POEMS { // emumerated type enum PointType { FIXEDPOINT = 0 }; class Point : public POEMSObject { -public: +public: Vect3 position; - Point(); - bool ReadIn(std::istream& in); + Point(); + bool ReadIn(std::istream& in); void WriteOut(std::ostream& out); - - virtual ~Point(); + + virtual ~Point(); virtual PointType GetType() = 0; virtual Vect3 GetPoint() = 0; virtual bool ReadInPointData(std::istream& in) = 0; @@ -45,5 +45,5 @@ public: // global point functions Point* NewPoint(int type); - +} #endif diff --git a/lib/poems/prismaticjoint.cpp b/lib/poems/prismaticjoint.cpp index c7d4bed568..3e649f0d22 100644 --- a/lib/poems/prismaticjoint.cpp +++ b/lib/poems/prismaticjoint.cpp @@ -25,6 +25,8 @@ #include "mat3x3.h" #include "virtualmatrix.h" +using namespace POEMS; + PrismaticJoint::PrismaticJoint(){ q.Dim(1); qdot.Dim(1); diff --git a/lib/poems/prismaticjoint.h b/lib/poems/prismaticjoint.h index c17be350cb..df3ab3195c 100644 --- a/lib/poems/prismaticjoint.h +++ b/lib/poems/prismaticjoint.h @@ -24,8 +24,7 @@ #include "vect3.h" #include "matrix.h" - - +namespace POEMS { class PrismaticJoint : public Joint { Vect3 axis_pk; // unit vector in body1 basis Vect3 axis_k; // unit vector in body2 basis @@ -45,5 +44,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; - +} #endif diff --git a/lib/poems/revolutejoint.cpp b/lib/poems/revolutejoint.cpp index 955a2f0dea..6b11acbf0f 100644 --- a/lib/poems/revolutejoint.cpp +++ b/lib/poems/revolutejoint.cpp @@ -25,6 +25,8 @@ #include "mat3x3.h" #include "virtualmatrix.h" +using namespace POEMS; + RevoluteJoint::RevoluteJoint(){ DimQandU(1); Vect3 axis; diff --git a/lib/poems/revolutejoint.h b/lib/poems/revolutejoint.h index ac1c06d5c5..10a38114df 100644 --- a/lib/poems/revolutejoint.h +++ b/lib/poems/revolutejoint.h @@ -23,6 +23,7 @@ #include "vect3.h" #include "matrix.h" +namespace POEMS { class VirtualMatrix; class RevoluteJoint : public Joint { @@ -44,5 +45,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; - +} #endif diff --git a/lib/poems/rigidbody.cpp b/lib/poems/rigidbody.cpp index 53acfa8bd4..a7d4f9f19f 100644 --- a/lib/poems/rigidbody.cpp +++ b/lib/poems/rigidbody.cpp @@ -20,6 +20,8 @@ #include "virtualmatrix.h" using namespace std; +using namespace POEMS; + RigidBody::RigidBody(){ } diff --git a/lib/poems/rigidbody.h b/lib/poems/rigidbody.h index 2f4430e264..d4be92ebcf 100644 --- a/lib/poems/rigidbody.h +++ b/lib/poems/rigidbody.h @@ -22,6 +22,7 @@ #include "body.h" +namespace POEMS { class RigidBody : public Body { public: RigidBody(); @@ -30,5 +31,5 @@ public: bool ReadInBodyData(std::istream& in); void WriteOutBodyData(std::ostream& out); }; - +} #endif diff --git a/lib/poems/rowmatrix.cpp b/lib/poems/rowmatrix.cpp index 9fa57e773f..eac8fbef5d 100644 --- a/lib/poems/rowmatrix.cpp +++ b/lib/poems/rowmatrix.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + RowMatrix::RowMatrix(){ numcols = 0; diff --git a/lib/poems/rowmatrix.h b/lib/poems/rowmatrix.h index 1dbb3d11e0..8e8d7b5f99 100644 --- a/lib/poems/rowmatrix.h +++ b/lib/poems/rowmatrix.h @@ -24,6 +24,7 @@ #include "virtualrowmatrix.h" #include "virtualmatrix.h" +namespace POEMS { class RowMatrix : public VirtualRowMatrix { double* elements; public: @@ -52,5 +53,5 @@ public: RowMatrix& operator=(const VirtualMatrix& A); // overloaded = RowMatrix& operator*=(double b); }; - +} #endif diff --git a/lib/poems/solver.cpp b/lib/poems/solver.cpp index 9d2245149f..04afb27945 100644 --- a/lib/poems/solver.cpp +++ b/lib/poems/solver.cpp @@ -20,6 +20,8 @@ #include "system.h" #include "onsolver.h" +using namespace POEMS; + Solver::Solver(){ } diff --git a/lib/poems/solver.h b/lib/poems/solver.h index 6a2debf497..489e6d41f1 100644 --- a/lib/poems/solver.h +++ b/lib/poems/solver.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: solver.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,6 +21,7 @@ #include "colmatmap.h" #include "defines.h" +namespace POEMS { class System; class Matrix; @@ -28,11 +29,11 @@ class Solver{ protected: System* system; - + double time; ColMatMap state; ColMatMap statedot; - ColMatMap statedoubledot; + ColMatMap statedoubledot; SolverType type; @@ -47,13 +48,13 @@ public: virtual void DeleteModel() = 0; virtual void CreateModel() = 0; - virtual void Solve(double time, Matrix& FF) = 0; - - - + virtual void Solve(double time, Matrix& FF) = 0; + + + ColMatMap* GetState(); ColMatMap* GetStateDerivative(); ColMatMap* GetStateDerivativeDerivative(); }; - +} #endif diff --git a/lib/poems/sphericaljoint.cpp b/lib/poems/sphericaljoint.cpp index cba6d00a6e..996bb5a887 100644 --- a/lib/poems/sphericaljoint.cpp +++ b/lib/poems/sphericaljoint.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: sphericaljoint.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,10 +11,10 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #include "sphericaljoint.h" @@ -30,6 +30,8 @@ #include "vect3.h" #include "virtualmatrix.h" +using namespace std; +using namespace POEMS; SphericalJoint::SphericalJoint(){ DimQandU(4,3); @@ -48,24 +50,24 @@ bool SphericalJoint::ReadInJointData(std::istream& in){ void SphericalJoint::WriteOutJointData(std::ostream& out){ } -Matrix SphericalJoint::GetForward_sP(){ +Matrix SphericalJoint::GetForward_sP(){ Mat3x3 sPa,sPl; Matrix sP(6,3); - sPa.Identity(); + sPa.Identity(); sPl.Zeros(); - Vect3 temp = -(point2->position); - + Vect3 temp = -(point2->position); + sPl(1,2) = temp(3); sPl(1,3) = -temp(2); - + sPl(2,1) = -temp(3); sPl(2,3) = temp(1); - - sPl(3,1) = temp(2); + + sPl(3,1) = temp(2); sPl(3,2) = -temp(1); - - sP=Stack(sPa,sPl); - return sP; + + sP=Stack(sPa,sPl); + return sP; } void SphericalJoint::UpdateForward_sP( Matrix& sP){ @@ -79,15 +81,15 @@ Matrix SphericalJoint::GetBackward_sP(){ cout<<" -----------"<position(1)); - sPl(2,3)=-(point2->position(1)); + sPa.Identity(); + sPl.Zeros(); + sPl(3,2)=(point2->position(1)); + sPl(2,3)=-(point2->position(1)); sP=Stack(sPa,sPl); - return sP; + return sP; } -void SphericalJoint::UpdateBackward_sP( Matrix& sP){ +void SphericalJoint::UpdateBackward_sP( Matrix& sP){ // sP is constant, do nothing. } @@ -96,106 +98,106 @@ void SphericalJoint::ComputeLocalTransform(){ // Obtain the transformation matrix from euler parameters EP_Transformation(q, ko_C_k); FastMult(pk_C_ko,ko_C_k,pk_C_k); - } + } void SphericalJoint::ForwardKinematics(){ Vect3 result1,result2,result3,result4,result5; Vect3 pk_w_k; - + //cout<<"Check in spherical "<position,result1); // parents basis - FastAdd(result1,point1->position,r12); - - // compute position vector r21 - FastNegMult(k_C_pk,r12,r21); - - - + // COMPUTE POSITION VECTOR R12 aka GAMMA + + FastNegMult(pk_C_k,point2->position,result1); // parents basis + FastAdd(result1,point1->position,r12); + + // compute position vector r21 + FastNegMult(k_C_pk,r12,r21); + + + //----------------------------------// - // COMPUTE GLOBAL LOCATION - FastMult(body1->n_C_k,(body1->GetPoint(2))->position,result1); - FastAdd(result1,body1->r,result1); - FastNegMult(body2->n_C_k,(body2->GetPoint(1))->position,result2); - FastAdd(result1,result2,body2->r); - - qdot_to_u(q, u, qdot); - - - //----------------------------------- - // angular velocities - + // COMPUTE GLOBAL LOCATION + FastMult(body1->n_C_k,(body1->GetPoint(2))->position,result1); + FastAdd(result1,body1->r,result1); + FastNegMult(body2->n_C_k,(body2->GetPoint(1))->position,result2); + FastAdd(result1,result2,body2->r); + + qdot_to_u(q, u, qdot); + + + //----------------------------------- + // angular velocities + FastAssign(u,pk_w_k); - FastTMult(pk_C_k,body1->omega_k,result1); + FastTMult(pk_C_k,body1->omega_k,result1); FastAdd(result1,pk_w_k,body2->omega_k); - FastMult(body2->n_C_k,body2->omega_k,body2->omega); - - - - //----------------------------------- - - // compute velocities - FastCross(body1->omega_k,(body1->GetPoint(2))->position,result1); + FastMult(body2->n_C_k,body2->omega_k,body2->omega); + + + + //----------------------------------- + + // compute velocities + FastCross(body1->omega_k,(body1->GetPoint(2))->position,result1); FastAdd(body1->v_k,result1,result2); - FastTMult(pk_C_k,result2,result1); // In body basis - - FastCross((body2->GetPoint(1))->position,body2->omega_k,result2); - FastAdd(result1,result2,body2->v_k); // In body basis - FastMult(body2->n_C_k,body2->v_k,body2->v); - - + FastTMult(pk_C_k,result2,result1); // In body basis + + FastCross((body2->GetPoint(1))->position,body2->omega_k,result2); + FastAdd(result1,result2,body2->v_k); // In body basis + FastMult(body2->n_C_k,body2->v_k,body2->v); + + //------------------------------------------ - //Compute the KE + //Compute the KE Matrix tempke; - tempke = T(body2->v)*(body2->v); + tempke = T(body2->v)*(body2->v); double ke = 0.0; - ke = body2->mass*tempke(1,1); + ke = body2->mass*tempke(1,1); FastMult(body2->inertia,body2->omega_k,result1); - tempke= T(body2->omega_k)*result1; + tempke= T(body2->omega_k)*result1; ke = 0.5*ke + 0.5*tempke(1,1); body2->KE=ke; - //----------------------------------- - // compute state explicit angular acceleration // Has to be in body basis - FastTMult(pk_C_k,body1->alpha_t,result2); + //----------------------------------- + // compute state explicit angular acceleration // Has to be in body basis + FastTMult(pk_C_k,body1->alpha_t,result2); FastCross(body2->omega_k,pk_w_k,result1); - FastAdd(result1,result2,body2->alpha_t); - - //----------------------------------- - // compute state explicit acceleration - // NEED TO DO THIS COMPLETELY IN BODY BASIS - + FastAdd(result1,result2,body2->alpha_t); + + //----------------------------------- + // compute state explicit acceleration + // NEED TO DO THIS COMPLETELY IN BODY BASIS + FastCross(body1->omega_k,(body1->GetPoint(2))->position,result1); - FastCross(body1->omega_k,result1,result2); - FastTMult(pk_C_k,result2,result1); - - //FastCross(body2->omega_k,-(body2->GetPoint(1))->position,result3); - FastCross((body2->GetPoint(1))->position,body2->omega_k,result3); - FastCross(body2->omega_k,result3,result2); - FastAdd(result1,result2,result3); //wxwxr in body basis - - FastCross(body1->alpha_t,(body1->GetPoint(2))->position,result4); - FastTMult(pk_C_k,result4,result5); + FastCross(body1->omega_k,result1,result2); + FastTMult(pk_C_k,result2,result1); + + //FastCross(body2->omega_k,-(body2->GetPoint(1))->position,result3); + FastCross((body2->GetPoint(1))->position,body2->omega_k,result3); + FastCross(body2->omega_k,result3,result2); + FastAdd(result1,result2,result3); //wxwxr in body basis + + FastCross(body1->alpha_t,(body1->GetPoint(2))->position,result4); + FastTMult(pk_C_k,result4,result5); FastAssign(result5,result4); - - FastCross((body2->GetPoint(1))->position,body2->alpha_t,result2); - FastAdd(result2,result4,result1); //alphaxr in body basis - + + FastCross((body2->GetPoint(1))->position,body2->alpha_t,result2); + FastAdd(result2,result4,result1); //alphaxr in body basis + FastTMult(pk_C_k,body1->a_t,result2); - FastTripleSum(result3,result1,result2,body2->a_t); // in body basis - - - //----------------------------------- + FastTripleSum(result3,result1,result2,body2->a_t); // in body basis + + + //----------------------------------- } // NOTE: NOT USING BACKWARDKINEMATICS AT PRESENT @@ -206,13 +208,13 @@ void SphericalJoint::BackwardKinematics(){ // orientations ComputeBackwardTransforms(); - + // compute position vector r21 //r21 = point2->position - k_C_pk * point1->position; FastMult(k_C_pk,point1->position,result1); FastSubt(point2->position,result1,r21); - + // compute position vector r21 FastNegMult(pk_C_k,r21,r12); @@ -231,7 +233,7 @@ void SphericalJoint::BackwardKinematics(){ EP_Derivatives(q,u,qdot); // angular velocities - + FastMult(body2->n_C_k,u,result2); FastAdd(body2->omega,result2,body1->omega); FastAssign(u,k_w_pk); @@ -251,7 +253,7 @@ void SphericalJoint::BackwardKinematics(){ FastCross(body1->omega_k,k_w_pk,result1); FastMult(pk_C_k,body2->alpha_t,result2); FastAdd(result1,result2,body1->alpha_t); - + // compute state explicit acceleration FastCross(body2->alpha_t,point2->position,result1); FastCross(body2->omega_k,point2->position,result2); @@ -264,5 +266,5 @@ void SphericalJoint::BackwardKinematics(){ FastCross(body1->omega_k,result2,result3); FastTripleSum(result5,result1,result3,body1->a_t); - + } diff --git a/lib/poems/sphericaljoint.h b/lib/poems/sphericaljoint.h index 90f1547873..db048e5544 100644 --- a/lib/poems/sphericaljoint.h +++ b/lib/poems/sphericaljoint.h @@ -22,6 +22,7 @@ #include "joint.h" #include "matrix.h" +namespace POEMS { class SphericalJoint : public Joint { Matrix const_sP; public: @@ -38,5 +39,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; - +} #endif diff --git a/lib/poems/system.cpp b/lib/poems/system.cpp index 1ac9ce1236..8515588424 100644 --- a/lib/poems/system.cpp +++ b/lib/poems/system.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: system.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -36,11 +36,12 @@ #include "vect3.h" #include "virtualmatrix.h" -class Point; - +namespace POEMS { class Point; } +using namespace std; +using namespace POEMS; System::System(){ - mappings = NULL; + mappings = NULL; } System::~System(){ @@ -59,7 +60,7 @@ int System::GetNumBodies(){ int * System::GetMappings() { - return mappings; + return mappings; } void System::AddBody(Body* body){ @@ -78,16 +79,16 @@ double System::GetTime(){ return time; } -void System::ComputeForces(){ - // NOT DOING ANYTHING AT THIS TIME - } - +void System::ComputeForces(){ + // NOT DOING ANYTHING AT THIS TIME + } + bool System::ReadIn(istream& in){ int numbodies; Body* body; int bodytype; char bodyname[256]; - int index; + int index; // get number of bodies in >> numbodies; @@ -165,12 +166,12 @@ bool System::ReadIn(istream& in){ delete [] bodyarray; return false; } - + joint->SetBodies(bodyarray[body1], bodyarray[body2]); bodyarray[body1]->AddJoint(joint); bodyarray[body2]->AddJoint(joint); - + in >> point1 >> point2; joint->SetPoints(bodyarray[body1]->GetPoint(point1),bodyarray[body2]->GetPoint(point2)); @@ -203,7 +204,7 @@ void System::WriteOut(ostream& out){ // set the body ID for later identification body->SetID(i); - + // write out the data body->WriteOut(out); @@ -211,7 +212,7 @@ void System::WriteOut(ostream& out){ } // number of joints - out << joints.GetNumElements() << endl; + out << joints.GetNumElements() << endl; // joints loop i = 0; @@ -226,7 +227,7 @@ void System::WriteOut(ostream& out){ // write out the data joint->WriteOut(out); - + i++; j_ele = j_ele->next; } } @@ -252,68 +253,68 @@ void System::ClearJointIDs(){ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space){ - //-------------------------------------------------------------------------// - // Declaring Temporary Entities - //-------------------------------------------------------------------------// + //-------------------------------------------------------------------------// + // Declaring Temporary Entities + //-------------------------------------------------------------------------// Body* body = NULL; Body* prev; Body* Inertial; Point* origin; Joint* joint; - Point* point_CM; - Point* point_p; - Point* point_k; + Point* point_CM; + Point* point_p; + Point* point_k; Point* point_ch = NULL; - Vect3 r1,r2,r3,v1,v2,v3; + Vect3 r1,r2,r3,v1,v2,v3; Mat3x3 IM, N, PKCK,PKCN ; ColMatrix qo, uo, q, qdot,w; - - mappings = new int[nfree]; - for(int i = 0; i < nfree; i++) - { - mappings[i] = freelist[i]; - } + + mappings = new int[nfree]; + for(int i = 0; i < nfree; i++) + { + mappings[i] = freelist[i]; + } qo.Dim(4); uo.Dim(3); q.Dim(4); - qdot.Dim(4); + qdot.Dim(4); PKCN.Identity(); PKCK.Identity(); w.Dim(3); - -//-------------------------------------------------------------------------// - // Setting up Inertial Frame, gravity and Origin + +//-------------------------------------------------------------------------// + // Setting up Inertial Frame, gravity and Origin //-------------------------------------------------------------------------// - Inertial= new InertialFrame; + Inertial= new InertialFrame; AddBody(Inertial); - - Vect3 temp1; - temp1.Zeros(); - ((InertialFrame*) Inertial)->SetGravity(temp1); + + Vect3 temp1; + temp1.Zeros(); + ((InertialFrame*) Inertial)->SetGravity(temp1); origin= new FixedPoint(temp1); - Inertial->AddPoint(origin); + Inertial->AddPoint(origin); +//-------------------------------------------------------------------------// + double ** xh1 = new double*[nfree]; + double ** xh2 = new double*[nfree]; + + for (int i=0; imass=masstotal[mappings[i]-1]; IM(1,1)=inertia[mappings[i]-1][0]; IM(2,2)=inertia[mappings[i]-1][1]; @@ -324,49 +325,49 @@ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstota IM(2,1)=IM(1,2); IM(3,1)=IM(1,3); IM(3,2)=IM(2,3); - body->inertia = IM; - -//-------------------------------------------------------// - - - for (int k=0;k<3;k++){ - r1(k+1)=xh1[i][k]-xcm[mappings[i]-1][k]; - r3(k+1) = xcm[mappings[i]-1][k]; - r3(k+1)=xh2[i][k]-xcm[mappings[i]-1][k]; - } - - r2.Zeros(); - - for (int k=1;k<=3;k++){ - N(k,1)=ex_space[mappings[i]-1][k-1]; - N(k,2)=ey_space[mappings[i]-1][k-1]; - N(k,3)=ez_space[mappings[i]-1][k-1]; - } - + body->inertia = IM; + +//-------------------------------------------------------// + + + for (int k=0;k<3;k++){ + r1(k+1)=xh1[i][k]-xcm[mappings[i]-1][k]; + r3(k+1) = xcm[mappings[i]-1][k]; + r3(k+1)=xh2[i][k]-xcm[mappings[i]-1][k]; + } + + r2.Zeros(); + + for (int k=1;k<=3;k++){ + N(k,1)=ex_space[mappings[i]-1][k-1]; + N(k,2)=ey_space[mappings[i]-1][k-1]; + N(k,3)=ez_space[mappings[i]-1][k-1]; + } + PKCK=T(N); PKCN=T(N); - - q.Zeros(); + + q.Zeros(); EP_FromTransformation(q,N); - + r1=PKCN*r1; r3=PKCN*r3; - + for (int k=1;k<=3;k++){ - w(k)=omega[mappings[i]-1][k-1]; - } - + w(k)=omega[mappings[i]-1][k-1]; + } + Vect3 cart_r, cart_v; for (int k=1;k<=3;k++){ - cart_r(k)=xcm[mappings[i]-1][k-1]; - cart_v(k)=vcm[mappings[i]-1][k-1]; - } - - w=PKCN*w; - EP_Derivatives(q,w,qdot); - - -//-------------------------------------------------------------------------// + cart_r(k)=xcm[mappings[i]-1][k-1]; + cart_v(k)=vcm[mappings[i]-1][k-1]; + } + + w=PKCN*w; + EP_Derivatives(q,w,qdot); + + +//-------------------------------------------------------------------------// // Create bodies and joints with associated properties for POEMS //-------------------------------------------------------------------------// @@ -376,12 +377,12 @@ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstota body->AddPoint(point_CM); body->AddPoint(point_k); body->AddPoint(point_ch); - AddBody(body); - + AddBody(body); + Mat3x3 One; - One.Identity(); - ColMatrix qq=Stack(q,cart_r); - ColMatrix vv=Stack(qdot,cart_v); + One.Identity(); + ColMatrix qq=Stack(q,cart_r); + ColMatrix vv=Stack(qdot,cart_v); joint=new FreeBodyJoint; AddJoint(joint); joint->SetBodies(prev,body); @@ -391,225 +392,225 @@ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstota joint->SetZeroOrientation(One); joint->DimQandU(7,6); joint->SetInitialState(qq,vv); - joint->ForwardKinematics(); + joint->ForwardKinematics(); } for(int i = 0; i < nfree; i++) { - delete [] xh1[i]; - delete [] xh2[i]; + delete [] xh1[i]; + delete [] xh2[i]; } delete [] xh1; - delete [] xh2; + delete [] xh2; } void System::Create_System_LAMMPS(int numbodies, double *mass,double **inertia, double ** xcm, double ** xjoint,double **vcm,double **omega,double **ex_space, double **ey_space, double **ez_space, int b, int * mapping, int count){ - //-------------------------------------------------------------------------// - // Declaring Temporary Entities - //-------------------------------------------------------------------------// - - Body* body = NULL; - Body* prev; - Body* Inertial; - Point* origin; - Joint* joint; - Point* point_CM; - Point* point_p; - Point* point_k; - Point* point_ch = NULL; - Vect3 r1,r2,r3,v1,v2,v3; - Mat3x3 IM, N, PKCK,PKCN ; - ColMatrix qo, uo, q, qdot,w; - Vect3 cart_r, cart_v; - mappings = new int[b]; - for(int i = 0; i < b; i++){ - mappings[i] = mapping[i]; - } - - - qo.Dim(4); - uo.Dim(3); - q.Dim(4); - qdot.Dim(4); - PKCN.Identity(); - PKCK.Identity(); - w.Dim(3); - - //-------------------------------------------------------------------------// - // Setting up Inertial Frame, gravity and Origin - //-------------------------------------------------------------------------// - Inertial= new InertialFrame; - AddBody(Inertial); - - Vect3 temp1; - temp1.Zeros(); - ((InertialFrame*) Inertial)->SetGravity(temp1); - origin= new FixedPoint(temp1); - Inertial->AddPoint(origin); - //-------------------------------------------------------------------------// - - double ** xh1; - double ** xh2; - - xh1 = new double*[b]; - xh2 = new double*[b]; - - - for (int i=0; iSetGravity(temp1); + origin= new FixedPoint(temp1); + Inertial->AddPoint(origin); + //-------------------------------------------------------------------------// + + double ** xh1; + double ** xh2; + + xh1 = new double*[b]; + xh2 = new double*[b]; + + + for (int i=0; imass=mass[mapping[i]-1]; - IM(1,1)=inertia[mapping[i]-1][0]; - IM(2,2)=inertia[mapping[i]-1][1]; - IM(3,3)=inertia[mapping[i]-1][2]; - IM(1,2)=0.0; - IM(1,3)=0.0; - IM(2,3)=0.0; - IM(2,1)=IM(1,2); - IM(3,1)=IM(1,3); - IM(3,2)=IM(2,3); - body->inertia = IM; - - //-------------------------------------------------------// - - for (int k=0;k<3;k++){ - r1(k+1)=xh1[i][k]-xcm[mapping[i]-1][k]; - r3(k+1)=xh2[i][k]-xcm[mapping[i]-1][k]; - } - r2.Zeros(); - - for (int k=1;k<=3;k++){ - N(k,1)=ex_space[mapping[i]-1][k-1]; - N(k,2)=ey_space[mapping[i]-1][k-1]; - N(k,3)=ez_space[mapping[i]-1][k-1]; - } - - - if (i==0){ - PKCK=T(N); - PKCN=T(N); - - q.Zeros(); - EP_FromTransformation(q,N); - - r1=PKCN*r1; - r3=PKCN*r3; - - for (int k=1;k<=3;k++){ - w(k)=omega[mappings[i]-1][k-1]; - } - - for (int k=1;k<=3;k++){ - cart_r(k)=xcm[mappings[i]-1][k-1]; - cart_v(k)=vcm[mappings[i]-1][k-1]; - } - w=PKCN*w; - EP_Derivatives(q,w,qdot); - - } - else{ - PKCK=PKCN*N; - PKCN=T(N); - - q.Zeros(); - EP_FromTransformation(q,PKCK); - - r1=PKCN*r1; - r3=PKCN*r3; - - for (int k=1;k<=3;k++){ - w(k)=omega[mapping[i]-1][k-1]-omega[mapping[i-1]-1][k-1]; - } - - w=PKCN*w; - EP_Derivatives(q, w, qdot); - } - - - //-------------------------------------------------------------------------// + //-------------------------------------------------------------------------// + for(int i=0;imass=mass[mapping[i]-1]; + IM(1,1)=inertia[mapping[i]-1][0]; + IM(2,2)=inertia[mapping[i]-1][1]; + IM(3,3)=inertia[mapping[i]-1][2]; + IM(1,2)=0.0; + IM(1,3)=0.0; + IM(2,3)=0.0; + IM(2,1)=IM(1,2); + IM(3,1)=IM(1,3); + IM(3,2)=IM(2,3); + body->inertia = IM; + + //-------------------------------------------------------// + + for (int k=0;k<3;k++){ + r1(k+1)=xh1[i][k]-xcm[mapping[i]-1][k]; + r3(k+1)=xh2[i][k]-xcm[mapping[i]-1][k]; + } + r2.Zeros(); + + for (int k=1;k<=3;k++){ + N(k,1)=ex_space[mapping[i]-1][k-1]; + N(k,2)=ey_space[mapping[i]-1][k-1]; + N(k,3)=ez_space[mapping[i]-1][k-1]; + } + + + if (i==0){ + PKCK=T(N); + PKCN=T(N); + + q.Zeros(); + EP_FromTransformation(q,N); + + r1=PKCN*r1; + r3=PKCN*r3; + + for (int k=1;k<=3;k++){ + w(k)=omega[mappings[i]-1][k-1]; + } + + for (int k=1;k<=3;k++){ + cart_r(k)=xcm[mappings[i]-1][k-1]; + cart_v(k)=vcm[mappings[i]-1][k-1]; + } + w=PKCN*w; + EP_Derivatives(q,w,qdot); + + } + else{ + PKCK=PKCN*N; + PKCN=T(N); + + q.Zeros(); + EP_FromTransformation(q,PKCK); + + r1=PKCN*r1; + r3=PKCN*r3; + + for (int k=1;k<=3;k++){ + w(k)=omega[mapping[i]-1][k-1]-omega[mapping[i-1]-1][k-1]; + } + + w=PKCN*w; + EP_Derivatives(q, w, qdot); + } + + + //-------------------------------------------------------------------------// // Create bodies and joints with associated properties for POEMS - //-------------------------------------------------------------------------// - - point_CM = new FixedPoint(r2); - point_k = new FixedPoint(r1); - point_ch = new FixedPoint(r3); - body->AddPoint(point_CM); - body->AddPoint(point_k); - body->AddPoint(point_ch); - AddBody(body); - - Mat3x3 One; - One.Identity(); - if (i==0){ - ColMatrix qq=Stack(q,cart_r); - ColMatrix vv=Stack(qdot,cart_v); - joint=new FreeBodyJoint; - AddJoint(joint); - joint->SetBodies(prev,body); - body->AddJoint(joint); - prev->AddJoint(joint); - joint->SetPoints(point_p,point_k); - joint->SetZeroOrientation(One); - joint->DimQandU(7,6); - joint->SetInitialState(qq,vv); - joint->ForwardKinematics(); - } - else{ - joint= new SphericalJoint; - AddJoint(joint); - joint->SetBodies(prev,body); - body->AddJoint(joint); - prev->AddJoint(joint); - joint->SetPoints(point_p,point_k); - joint->SetZeroOrientation(One); - joint->DimQandU(4,3); - joint->SetInitialState(q,qdot); - joint->ForwardKinematics(); - } - } - for(int i = 0; i < b; i++) - { - delete [] xh1[i]; - delete [] xh2[i]; - } - delete [] xh1; - delete [] xh2; - + //-------------------------------------------------------------------------// + + point_CM = new FixedPoint(r2); + point_k = new FixedPoint(r1); + point_ch = new FixedPoint(r3); + body->AddPoint(point_CM); + body->AddPoint(point_k); + body->AddPoint(point_ch); + AddBody(body); + + Mat3x3 One; + One.Identity(); + if (i==0){ + ColMatrix qq=Stack(q,cart_r); + ColMatrix vv=Stack(qdot,cart_v); + joint=new FreeBodyJoint; + AddJoint(joint); + joint->SetBodies(prev,body); + body->AddJoint(joint); + prev->AddJoint(joint); + joint->SetPoints(point_p,point_k); + joint->SetZeroOrientation(One); + joint->DimQandU(7,6); + joint->SetInitialState(qq,vv); + joint->ForwardKinematics(); + } + else{ + joint= new SphericalJoint; + AddJoint(joint); + joint->SetBodies(prev,body); + body->AddJoint(joint); + prev->AddJoint(joint); + joint->SetPoints(point_p,point_k); + joint->SetZeroOrientation(One); + joint->DimQandU(4,3); + joint->SetInitialState(q,qdot); + joint->ForwardKinematics(); + } + } + for(int i = 0; i < b; i++) + { + delete [] xh1[i]; + delete [] xh2[i]; + } + delete [] xh1; + delete [] xh2; + } diff --git a/lib/poems/system.h b/lib/poems/system.h index e5ce27194b..2402e5852f 100644 --- a/lib/poems/system.h +++ b/lib/poems/system.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: system.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -22,6 +22,7 @@ #include #include "poemslist.h" +namespace POEMS { class Body; class Joint; @@ -33,37 +34,37 @@ double time; List bodies; List joints; - + System(); ~System(); void Delete(); - + int GetNumBodies(); - + int * GetMappings(); void AddBody(Body* body); - + void AddJoint(Joint* joint); - + void SetTime(double t); - + double GetTime(); - + void ComputeForces(); - + bool ReadIn(std::istream& in); - + void WriteOut(std::ostream& out); - + void ClearBodyIDs(); - - void ClearJointIDs(); + + void ClearJointIDs(); void Create_System_LAMMPS(int numbodies, double *mass,double **inertia, double ** xcm, double ** xjoint,double **vh1,double **omega,double **ex_space, double **ey_space, double **ez_space, int b, int * mapping, int count); - + void Create_DegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space); }; - +} #endif diff --git a/lib/poems/vect3.cpp b/lib/poems/vect3.cpp index 7ce3230238..66c2f902d5 100644 --- a/lib/poems/vect3.cpp +++ b/lib/poems/vect3.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + Vect3::Vect3(){ numrows = 3; numcols = 1; diff --git a/lib/poems/vect3.h b/lib/poems/vect3.h index a28832db6c..6b0efc371a 100644 --- a/lib/poems/vect3.h +++ b/lib/poems/vect3.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: vect3.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -23,6 +23,7 @@ #include "virtualcolmatrix.h" #include "virtualmatrix.h" +namespace POEMS { class Matrix; class Mat3x3; class Mat6x6; @@ -82,7 +83,6 @@ public: friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); friend void FastAssign(ColMatrix&A, Vect3& C); friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); - }; - +} #endif diff --git a/lib/poems/vect4.cpp b/lib/poems/vect4.cpp index b045998017..8e903d57bd 100644 --- a/lib/poems/vect4.cpp +++ b/lib/poems/vect4.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + Vect4::Vect4(){ numrows = 4; numcols = 1; diff --git a/lib/poems/vect4.h b/lib/poems/vect4.h index 0b28994043..754706f10a 100644 --- a/lib/poems/vect4.h +++ b/lib/poems/vect4.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: vect4.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -23,6 +23,7 @@ #include "virtualcolmatrix.h" #include "virtualmatrix.h" +namespace POEMS { class Matrix; class Mat4x4; @@ -41,7 +42,7 @@ public: void BasicSet_1int(int i, double value); void BasicIncrement_1int(int i, double value); - + void Const(double value); MatrixType GetType() const; std::ostream& WriteData(std::ostream& c) const; @@ -69,5 +70,5 @@ public: friend void FastAdd(Vect4& A, Vect4& B, Vect4& C); friend void FastSubt(Vect4& A, Vect4& B, Vect4& C); }; - +} #endif diff --git a/lib/poems/vect6.cpp b/lib/poems/vect6.cpp index 5baadafc34..5aabe520e1 100644 --- a/lib/poems/vect6.cpp +++ b/lib/poems/vect6.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + Vect6::Vect6(){ numrows = 6; numcols = 1; diff --git a/lib/poems/vect6.h b/lib/poems/vect6.h index 8047c1bbf8..5def4c6b1b 100644 --- a/lib/poems/vect6.h +++ b/lib/poems/vect6.h @@ -23,6 +23,7 @@ #include "virtualcolmatrix.h" #include "virtualmatrix.h" +namespace POEMS { class Matrix; class Mat6x6; class ColMatrix; @@ -69,5 +70,5 @@ public: friend void OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV); }; - +} #endif diff --git a/lib/poems/virtualcolmatrix.cpp b/lib/poems/virtualcolmatrix.cpp index 3a6c6e22cd..fa430b81f7 100644 --- a/lib/poems/virtualcolmatrix.cpp +++ b/lib/poems/virtualcolmatrix.cpp @@ -20,6 +20,8 @@ #include using namespace std; +using namespace POEMS; + VirtualColMatrix::VirtualColMatrix(){ numcols = 1; diff --git a/lib/poems/virtualcolmatrix.h b/lib/poems/virtualcolmatrix.h index 1548794ca0..040fce051e 100644 --- a/lib/poems/virtualcolmatrix.h +++ b/lib/poems/virtualcolmatrix.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: virtualcolmatrix.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,25 +21,25 @@ #include "virtualmatrix.h" - +namespace POEMS { class VirtualColMatrix : public VirtualMatrix { -public: - VirtualColMatrix(); - ~VirtualColMatrix(); - double& operator_2int (int i, int j); // array access - double Get_2int (int i, int j) const; - void Set_2int (int i, int j, double value); - double BasicGet_2int(int i, int j) const; - void BasicSet_2int(int i, int j, double value); - void BasicIncrement_2int(int i, int j, double value); - - virtual double& operator_1int (int i) = 0; // array access - virtual double Get_1int(int i) const = 0; - virtual void Set_1int(int i, double value) = 0; - virtual double BasicGet_1int(int i) const = 0; - virtual void BasicSet_1int(int i, double value) = 0; - virtual void BasicIncrement_1int(int i, double value) = 0; +public: + VirtualColMatrix(); + ~VirtualColMatrix(); + double& operator_2int (int i, int j); // array access + double Get_2int (int i, int j) const; + void Set_2int (int i, int j, double value); + double BasicGet_2int(int i, int j) const; + void BasicSet_2int(int i, int j, double value); + void BasicIncrement_2int(int i, int j, double value); + + virtual double& operator_1int (int i) = 0; // array access + virtual double Get_1int(int i) const = 0; + virtual void Set_1int(int i, double value) = 0; + virtual double BasicGet_1int(int i) const = 0; + virtual void BasicSet_1int(int i, double value) = 0; + virtual void BasicIncrement_1int(int i, double value) = 0; }; - +} #endif diff --git a/lib/poems/virtualmatrix.cpp b/lib/poems/virtualmatrix.cpp index 19d5946961..bfffeb3d74 100644 --- a/lib/poems/virtualmatrix.cpp +++ b/lib/poems/virtualmatrix.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + VirtualMatrix::VirtualMatrix(){ numrows = numcols = 0; @@ -140,14 +142,14 @@ istream& VirtualMatrix::ReadData(istream& c){ // operators and functions // -ostream& operator<< (ostream& c, const VirtualMatrix& A){ //output +ostream& POEMS::operator<< (ostream& c, const VirtualMatrix& A){ //output c << A.GetType() << ' '; A.WriteData(c); c << endl; return c; } -istream& operator>> (istream& c, VirtualMatrix& A){ //input +istream& POEMS::operator>> (istream& c, VirtualMatrix& A){ //input VirtualMatrix* vm; int matrixtype; c >> matrixtype; diff --git a/lib/poems/virtualmatrix.h b/lib/poems/virtualmatrix.h index a27c7de047..706b943d66 100644 --- a/lib/poems/virtualmatrix.h +++ b/lib/poems/virtualmatrix.h @@ -20,6 +20,7 @@ #define VIRTUALMATRIX_H #include +namespace POEMS { enum MatrixType { MATRIX = 0, COLMATRIX = 1, @@ -83,5 +84,5 @@ protected: // overloaded operators std::ostream& operator<< (std::ostream& c, const VirtualMatrix& A); // output std::istream& operator>> (std::istream& c, VirtualMatrix& A); // input - +} #endif diff --git a/lib/poems/virtualrowmatrix.cpp b/lib/poems/virtualrowmatrix.cpp index 1a12cfbfd9..740c747407 100644 --- a/lib/poems/virtualrowmatrix.cpp +++ b/lib/poems/virtualrowmatrix.cpp @@ -21,6 +21,8 @@ #include using namespace std; +using namespace POEMS; + VirtualRowMatrix::VirtualRowMatrix(){ numrows = 1; diff --git a/lib/poems/virtualrowmatrix.h b/lib/poems/virtualrowmatrix.h index 68b39f137d..0a3c877f64 100644 --- a/lib/poems/virtualrowmatrix.h +++ b/lib/poems/virtualrowmatrix.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: virtualrowmatrix.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,8 +21,9 @@ #include "virtualmatrix.h" +namespace POEMS { class VirtualRowMatrix : public VirtualMatrix { -public: +public: VirtualRowMatrix(); ~VirtualRowMatrix(); double& operator_2int (int i, int j); // array access @@ -31,7 +32,7 @@ public: double BasicGet_2int(int i, int j) const; void BasicSet_2int(int i, int j, double value); void BasicIncrement_2int(int i, int j, double value); - + virtual double& operator_1int (int i) = 0; // array access virtual double Get_1int(int i) const = 0; virtual void Set_1int(int i, double value) = 0; @@ -39,5 +40,5 @@ public: virtual void BasicSet_1int(int i, double value) = 0; virtual void BasicIncrement_1int(int i, double value) = 0; }; - +} #endif diff --git a/lib/poems/workspace.cpp b/lib/poems/workspace.cpp index 29a1c95832..03f18a7895 100644 --- a/lib/poems/workspace.cpp +++ b/lib/poems/workspace.cpp @@ -38,6 +38,8 @@ using namespace std; +using namespace POEMS; + void Workspace::allocateNewSystem() { currentIndex++; diff --git a/lib/poems/workspace.h b/lib/poems/workspace.h index 6213815d81..2510b2fc3a 100644 --- a/lib/poems/workspace.h +++ b/lib/poems/workspace.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: workspace.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -19,61 +19,62 @@ #ifndef WORKSPACE_H #define WORKSPACE_H +namespace POEMS { class System; class Solver; struct SysData{ - System * system; - int solver; - int integrator; + System * system; + int solver; + int integrator; }; class Workspace { - SysData * system; // the multibody systems data - int currentIndex; - int maxAlloc; - + SysData * system; // the multibody systems data + int currentIndex; + int maxAlloc; + public: Workspace(); ~Workspace(); - + double Thalf; double Tfull; double ConFac; double KE_val; - int FirstTime; - + int FirstTime; + bool LoadFile(char* filename); - + bool SaveFile(char* filename, int index = -1); System* GetSystem(int index = -1); - - void AddSolver(Solver* s, int index = -1); - - - void LobattoOne(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); - - void LobattoTwo(double **&vcm,double **&omega,double **&torque, double **&fcm); - - + + void AddSolver(Solver* s, int index = -1); + + + void LobattoOne(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); + + void LobattoTwo(double **&vcm,double **&omega,double **&torque, double **&fcm); + + bool MakeSystem(int& nbody, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space, int &njoint, int **&jointbody, double **&xjoint, int& nfree, int*freelist, double dthalf, double dtv, double tempcon, double KE); - - - bool SaveSystem(int& nbody, double *&masstotal, double **&inertia, double **&xcm, double **&xjoint, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space, double **&acm, double **&alpha, double **&torque, double **&fcm, int **&jointbody, int &njoint); - - bool MakeDegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space); + + + bool SaveSystem(int& nbody, double *&masstotal, double **&inertia, double **&xcm, double **&xjoint, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space, double **&acm, double **&alpha, double **&torque, double **&fcm, int **&jointbody, int &njoint); + + bool MakeDegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space); int getNumberOfSystems(); - + void SetLammpsValues(double dtv, double dthalf, double tempcon); void SetKE(int temp, double SysKE); - - void RKStep(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); - - void WriteFile(char* filename); + + void RKStep(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); + + void WriteFile(char* filename); private: - void allocateNewSystem(); //helper function to handle vector resizing and such for the array of system pointers + void allocateNewSystem(); //helper function to handle vector resizing and such for the array of system pointers }; - +} #endif diff --git a/src/POEMS/fix_poems.cpp b/src/POEMS/fix_poems.cpp index 6d943a79db..21c12f700b 100644 --- a/src/POEMS/fix_poems.cpp +++ b/src/POEMS/fix_poems.cpp @@ -20,7 +20,6 @@ #include "fix_poems.h" #include #include -#include #include #include #include "workspace.h" @@ -30,7 +29,6 @@ #include "respa.h" #include "modify.h" #include "force.h" -#include "output.h" #include "group.h" #include "comm.h" #include "citeme.h" @@ -265,7 +263,7 @@ FixPOEMS::FixPOEMS(LAMMPS *lmp, int narg, char **arg) : // create POEMS instance - poems = new Workspace; + poems = new POEMS::Workspace; // compute per body forces and torques inside final_integrate() by default diff --git a/src/POEMS/fix_poems.h b/src/POEMS/fix_poems.h index 7b2c77a1bd..87f9557ac0 100644 --- a/src/POEMS/fix_poems.h +++ b/src/POEMS/fix_poems.h @@ -22,6 +22,7 @@ FixStyle(poems,FixPOEMS) #include "fix.h" +namespace POEMS { class Workspace; } namespace LAMMPS_NS { class FixPOEMS : public Fix { @@ -94,7 +95,7 @@ class FixPOEMS : public Fix { // POEMS object - class Workspace *poems; + POEMS::Workspace *poems; // internal class functions -- GitLab From fa15bf5edd552cafcfb5cfd28edc2ad327015921 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 4 Jul 2019 00:25:33 -0400 Subject: [PATCH 177/469] recover compilation of USER-COLVARS package --- src/USER-COLVARS/colvarproxy_lammps.h | 10 ++++++++-- 1 file changed, 8 insertions(+), 2 deletions(-) diff --git a/src/USER-COLVARS/colvarproxy_lammps.h b/src/USER-COLVARS/colvarproxy_lammps.h index c3d9dbb35f..3243a14fbd 100644 --- a/src/USER-COLVARS/colvarproxy_lammps.h +++ b/src/USER-COLVARS/colvarproxy_lammps.h @@ -38,6 +38,12 @@ inline std::ostream & operator<< (std::ostream &out, const commdata &cd) return out; } +// forward declarations +namespace LAMMPS_NS { + class LAMMPS; + class RanPark; +} + /// \brief Communication between colvars and LAMMPS /// (implementation of \link colvarproxy \endlink) class colvarproxy_lammps : public colvarproxy { @@ -46,8 +52,8 @@ class colvarproxy_lammps : public colvarproxy { protected: // pointers to LAMMPS class instances - class LAMMPS_NS::LAMMPS *_lmp; - class LAMMPS_NS::RanPark *_random; + LAMMPS_NS::LAMMPS *_lmp; + LAMMPS_NS::RanPark *_random; // state of LAMMPS properties double t_target, my_timestep, my_boltzmann, my_angstrom; -- GitLab From 49f27573a7b1e2efade8be7ef7a7d9c101ab7c5c Mon Sep 17 00:00:00 2001 From: Trung Nguyen Date: Wed, 3 Jul 2019 23:44:33 -0500 Subject: [PATCH 178/469] Fixed a bug in lj96 involving missing the special_lj factor --- lib/gpu/lal_lj96.cu | 1 + 1 file changed, 1 insertion(+) diff --git a/lib/gpu/lal_lj96.cu b/lib/gpu/lal_lj96.cu index 3bb7750022..8dd63ef920 100644 --- a/lib/gpu/lal_lj96.cu +++ b/lib/gpu/lal_lj96.cu @@ -174,6 +174,7 @@ __kernel void k_lj96_fast(const __global numtyp4 *restrict x_, numtyp r6inv = r2inv*r2inv*r2inv; numtyp r3inv = ucl_sqrt(r6inv); numtyp force = r2inv*r6inv*(lj1[mtype].x*r3inv-lj1[mtype].y); + force*=factor_lj; f.x+=delx*force; f.y+=dely*force; -- GitLab From 732bd937e0416d46be708778bd234cd3e0c9ba97 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 4 Jul 2019 01:16:56 -0400 Subject: [PATCH 179/469] clean up includes in USER-COLVARS package --- src/USER-COLVARS/colvarproxy_lammps.cpp | 13 +-------- src/USER-COLVARS/colvarproxy_lammps.h | 39 +++++++------------------ src/USER-COLVARS/fix_colvars.cpp | 25 ++++++++++++---- src/USER-COLVARS/fix_colvars.h | 5 ++-- src/USER-COLVARS/group_ndx.cpp | 3 +- src/USER-COLVARS/ndx_group.cpp | 4 +-- 6 files changed, 36 insertions(+), 53 deletions(-) diff --git a/src/USER-COLVARS/colvarproxy_lammps.cpp b/src/USER-COLVARS/colvarproxy_lammps.cpp index 685c698ab6..2c43a3fb26 100644 --- a/src/USER-COLVARS/colvarproxy_lammps.cpp +++ b/src/USER-COLVARS/colvarproxy_lammps.cpp @@ -10,30 +10,19 @@ #include "colvarproxy_lammps.h" #include -#include #include -#include - #include -#include #include - #include -#include +#include #include #include "lammps.h" -#include "atom.h" #include "error.h" #include "output.h" #include "random_park.h" -#include "fix_colvars.h" - #include "colvarmodule.h" -#include "colvar.h" -#include "colvarbias.h" -#include "colvaratoms.h" #include "colvarproxy.h" #define HASH_FAIL -1 diff --git a/src/USER-COLVARS/colvarproxy_lammps.h b/src/USER-COLVARS/colvarproxy_lammps.h index 3243a14fbd..8ed03309a3 100644 --- a/src/USER-COLVARS/colvarproxy_lammps.h +++ b/src/USER-COLVARS/colvarproxy_lammps.h @@ -10,39 +10,22 @@ #ifndef COLVARPROXY_LAMMPS_H #define COLVARPROXY_LAMMPS_H -#include "colvarproxy_lammps_version.h" - -#include "colvarmodule.h" -#include "colvarproxy.h" -#include "colvarvalue.h" - -#include "lammps.h" -#include "domain.h" -#include "force.h" -#include "update.h" +#include "colvarproxy_lammps_version.h" // IWYU pragma: export +#include +#include #include #include -#include -/* struct for packed data communication of coordinates and forces. */ -struct commdata { - int tag,type; - double x,y,z,m,q; -}; +#include "colvarmodule.h" +#include "colvarproxy.h" +#include "colvartypes.h" -inline std::ostream & operator<< (std::ostream &out, const commdata &cd) -{ - out << " (" << cd.tag << "/" << cd.type << ": " - << cd.x << ", " << cd.y << ", " << cd.z << ") "; - return out; -} - -// forward declarations -namespace LAMMPS_NS { - class LAMMPS; - class RanPark; -} +#include "random_park.h" +#include "lammps.h" // IWYU pragma: keep +#include "domain.h" // IWYU pragma: keep +#include "force.h" // IWYU pragma: keep +#include "update.h" // IWYU pragma: keep /// \brief Communication between colvars and LAMMPS /// (implementation of \link colvarproxy \endlink) diff --git a/src/USER-COLVARS/fix_colvars.cpp b/src/USER-COLVARS/fix_colvars.cpp index 9331fe7abb..4a57e59fbd 100644 --- a/src/USER-COLVARS/fix_colvars.cpp +++ b/src/USER-COLVARS/fix_colvars.cpp @@ -25,26 +25,28 @@ ------------------------------------------------------------------------- */ #include "fix_colvars.h" -#include -#include +#include #include #include -#include +#include +#include +#include +#include #include "atom.h" #include "comm.h" #include "domain.h" #include "error.h" -#include "group.h" +#include "force.h" #include "memory.h" #include "modify.h" -#include "random_park.h" #include "respa.h" #include "universe.h" #include "update.h" #include "citeme.h" #include "colvarproxy_lammps.h" +#include "colvarmodule.h" static const char colvars_pub[] = "fix colvars command:\n\n" @@ -57,6 +59,19 @@ static const char colvars_pub[] = " note = {doi: 10.1080/00268976.2013.813594}\n" "}\n\n"; +/* struct for packed data communication of coordinates and forces. */ +struct LAMMPS_NS::commdata { + int tag,type; + double x,y,z,m,q; +}; + +inline std::ostream & operator<< (std::ostream &out, const LAMMPS_NS::commdata &cd) +{ + out << " (" << cd.tag << "/" << cd.type << ": " + << cd.x << ", " << cd.y << ", " << cd.z << ") "; + return out; +} + /* re-usable integer hash table code with static linkage. */ /** hash table top level data structure */ diff --git a/src/USER-COLVARS/fix_colvars.h b/src/USER-COLVARS/fix_colvars.h index a0c197fca4..985457e746 100644 --- a/src/USER-COLVARS/fix_colvars.h +++ b/src/USER-COLVARS/fix_colvars.h @@ -34,10 +34,9 @@ FixStyle(colvars,FixColvars) #define LMP_FIX_COLVARS_H #include "fix.h" +#include -// forward declaration class colvarproxy_lammps; -struct commdata; namespace LAMMPS_NS { @@ -64,7 +63,7 @@ class FixColvars : public Fix { virtual void restart(char *); protected: - class colvarproxy_lammps *proxy; // pointer to the colvars proxy class + colvarproxy_lammps *proxy; // pointer to the colvars proxy class char *conf_file; // name of colvars config file char *inp_name; // name/prefix of colvars restart file char *out_name; // prefix string for all output files diff --git a/src/USER-COLVARS/group_ndx.cpp b/src/USER-COLVARS/group_ndx.cpp index 7350712c40..1e37e2de9c 100644 --- a/src/USER-COLVARS/group_ndx.cpp +++ b/src/USER-COLVARS/group_ndx.cpp @@ -17,12 +17,11 @@ ------------------------------------------------------------------------- */ #include "group_ndx.h" -#include +#include #include #include "atom.h" #include "comm.h" #include "group.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-COLVARS/ndx_group.cpp b/src/USER-COLVARS/ndx_group.cpp index 5436ba7b6b..a1369df2fb 100644 --- a/src/USER-COLVARS/ndx_group.cpp +++ b/src/USER-COLVARS/ndx_group.cpp @@ -17,14 +17,12 @@ ------------------------------------------------------------------------- */ #include "ndx_group.h" -#include +#include #include #include #include "atom.h" #include "comm.h" #include "group.h" -#include "memory.h" -#include "force.h" #include "error.h" using namespace LAMMPS_NS; -- GitLab From b4cf4b1ed7d976dba74536659bd59c1887f1f546 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 4 Jul 2019 06:51:52 -0400 Subject: [PATCH 180/469] recover compilation of KOKKOS package --- src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp b/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp index 7a2fca47a0..27a7a59c2a 100644 --- a/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp +++ b/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp @@ -20,6 +20,7 @@ #include #include #include +#include "atom_kokkos.h" #include "atom_vec.h" #include "comm.h" #include "update.h" -- GitLab From ce6fa0118ab69fd09fa19410f6bbfec3608f0f73 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 4 Jul 2019 07:23:01 -0400 Subject: [PATCH 181/469] continuing to clean up include file lists --- src/pair_lj_cut_coul_wolf.cpp | 7 +------ src/pair_lj_expand.cpp | 3 +-- src/pair_lj_gromacs.cpp | 5 +---- src/pair_lj_gromacs_coul_gromacs.cpp | 4 +--- src/pair_lj_smooth.cpp | 3 +-- src/pair_lj_smooth_linear.cpp | 3 +-- src/pair_mie_cut.cpp | 4 +--- src/pair_morse.cpp | 3 +-- src/pair_soft.cpp | 4 +--- src/pair_table.cpp | 1 + src/pair_ufm.cpp | 10 +--------- src/pair_yukawa.cpp | 2 +- src/pair_zbl.cpp | 10 ---------- src/pair_zero.cpp | 4 +--- src/procmap.cpp | 8 +++++--- src/rcb.cpp | 1 - src/read_data.cpp | 4 ---- src/read_dump.cpp | 8 +------- src/read_restart.cpp | 2 -- src/reader.cpp | 1 - src/reader_xyz.cpp | 2 -- src/region.cpp | 1 - src/region_block.cpp | 1 - src/region_cone.cpp | 1 - src/region_cylinder.cpp | 1 - src/region_intersect.cpp | 1 - src/region_plane.cpp | 2 -- src/region_prism.cpp | 2 -- src/region_sphere.cpp | 1 - src/region_union.cpp | 1 - src/replicate.cpp | 3 +-- src/rerun.cpp | 1 - src/reset_ids.cpp | 1 + src/respa.cpp | 4 +--- src/run.cpp | 1 - src/set.cpp | 4 +--- src/special.cpp | 2 -- src/thermo.cpp | 5 ----- src/thermo.h | 3 --- 39 files changed, 23 insertions(+), 101 deletions(-) diff --git a/src/pair_lj_cut_coul_wolf.cpp b/src/pair_lj_cut_coul_wolf.cpp index fb641f7d24..00a5832529 100644 --- a/src/pair_lj_cut_coul_wolf.cpp +++ b/src/pair_lj_cut_coul_wolf.cpp @@ -16,18 +16,13 @@ ------------------------------------------------------------------------- */ #include "pair_lj_cut_coul_wolf.h" +#include #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/pair_lj_expand.cpp b/src/pair_lj_expand.cpp index 60593fd01d..a5184bc2f5 100644 --- a/src/pair_lj_expand.cpp +++ b/src/pair_lj_expand.cpp @@ -12,9 +12,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_expand.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/pair_lj_gromacs.cpp b/src/pair_lj_gromacs.cpp index 4796c288d7..baef482ef9 100644 --- a/src/pair_lj_gromacs.cpp +++ b/src/pair_lj_gromacs.cpp @@ -16,14 +16,11 @@ ------------------------------------------------------------------------- */ #include "pair_lj_gromacs.h" +#include #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/pair_lj_gromacs_coul_gromacs.cpp b/src/pair_lj_gromacs_coul_gromacs.cpp index 45beeb1daf..c62944b6a1 100644 --- a/src/pair_lj_gromacs_coul_gromacs.cpp +++ b/src/pair_lj_gromacs_coul_gromacs.cpp @@ -16,10 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_gromacs_coul_gromacs.h" +#include #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_smooth.cpp b/src/pair_lj_smooth.cpp index d89fee1148..7c7eb51b53 100644 --- a/src/pair_lj_smooth.cpp +++ b/src/pair_lj_smooth.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_smooth.h" +#include #include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 6ed19a452f..a3e4aed2fe 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_smooth_linear.h" +#include #include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/pair_mie_cut.cpp b/src/pair_mie_cut.cpp index d2b0c20cd5..46657687f6 100644 --- a/src/pair_mie_cut.cpp +++ b/src/pair_mie_cut.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_mie_cut.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" @@ -27,7 +26,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory.h" diff --git a/src/pair_morse.cpp b/src/pair_morse.cpp index 47102932db..d088f98bf4 100644 --- a/src/pair_morse.cpp +++ b/src/pair_morse.cpp @@ -12,9 +12,8 @@ ------------------------------------------------------------------------- */ #include "pair_morse.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/pair_soft.cpp b/src/pair_soft.cpp index f3d7423b04..6f821e684b 100644 --- a/src/pair_soft.cpp +++ b/src/pair_soft.cpp @@ -12,14 +12,12 @@ ------------------------------------------------------------------------- */ #include "pair_soft.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" #include "force.h" -#include "update.h" #include "neigh_list.h" #include "math_const.h" #include "memory.h" diff --git a/src/pair_table.cpp b/src/pair_table.cpp index 63cda78c67..9fcbc3ee9f 100644 --- a/src/pair_table.cpp +++ b/src/pair_table.cpp @@ -20,6 +20,7 @@ #include #include #include +#include #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/pair_ufm.cpp b/src/pair_ufm.cpp index 40b72136ff..8cc4d2796f 100644 --- a/src/pair_ufm.cpp +++ b/src/pair_ufm.cpp @@ -18,25 +18,17 @@ ------------------------------------------------------------------------- */ #include "pair_ufm.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/pair_yukawa.cpp b/src/pair_yukawa.cpp index 4a2cf23952..e8775c9668 100644 --- a/src/pair_yukawa.cpp +++ b/src/pair_yukawa.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include "pair_yukawa.h" +#include #include -#include #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/pair_zbl.cpp b/src/pair_zbl.cpp index b01c301785..199e4f0907 100644 --- a/src/pair_zbl.cpp +++ b/src/pair_zbl.cpp @@ -17,19 +17,10 @@ #include "pair_zbl.h" #include -#include -#include -#include #include "atom.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" -#include "math_const.h" #include "memory.h" #include "error.h" @@ -37,7 +28,6 @@ // "The Stopping and Range of Ions in Matter" volume 1, Pergamon, 1985. using namespace LAMMPS_NS; -using namespace MathConst; using namespace PairZBLConstants; /* ---------------------------------------------------------------------- */ diff --git a/src/pair_zero.cpp b/src/pair_zero.cpp index 2692710e20..403bd73944 100644 --- a/src/pair_zero.cpp +++ b/src/pair_zero.cpp @@ -16,9 +16,7 @@ ------------------------------------------------------------------------- */ #include "pair_zero.h" -#include -#include -#include +#include #include #include "atom.h" #include "comm.h" diff --git a/src/procmap.cpp b/src/procmap.cpp index 47afb76da9..69585aa453 100644 --- a/src/procmap.cpp +++ b/src/procmap.cpp @@ -16,7 +16,12 @@ ------------------------------------------------------------------------- */ #include "procmap.h" +#include +#include #include +#include +#include +#include #include "universe.h" #include "comm.h" #include "domain.h" @@ -24,9 +29,6 @@ #include "memory.h" #include "error.h" -#include -#include - using namespace LAMMPS_NS; #define MAXLINE 128 diff --git a/src/rcb.cpp b/src/rcb.cpp index b19beae3c5..f1a6377046 100644 --- a/src/rcb.cpp +++ b/src/rcb.cpp @@ -16,7 +16,6 @@ #include #include "irregular.h" #include "memory.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/read_data.cpp b/src/read_data.cpp index a50d41b498..dad48110f7 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -16,18 +16,14 @@ // before lmptype.h can set flags to insure it is done correctly #include "read_data.h" -#include "lmptype.h" #include -#include #include -#include #include #include "atom.h" #include "atom_vec.h" #include "atom_vec_ellipsoid.h" #include "atom_vec_line.h" #include "atom_vec_tri.h" -#include "force.h" #include "molecule.h" #include "group.h" #include "comm.h" diff --git a/src/read_dump.cpp b/src/read_dump.cpp index 49f96db680..d83a96f0fa 100644 --- a/src/read_dump.cpp +++ b/src/read_dump.cpp @@ -20,24 +20,18 @@ // before lmptype.h can set flags to insure it is done correctly #include "read_dump.h" -#include "lmptype.h" #include #include -#include +#include #include "reader.h" #include "style_reader.h" #include "atom.h" #include "atom_vec.h" #include "update.h" -#include "modify.h" -#include "fix.h" -#include "compute.h" #include "domain.h" #include "comm.h" #include "force.h" #include "irregular.h" -#include "input.h" -#include "variable.h" #include "error.h" #include "memory.h" #include "utils.h" diff --git a/src/read_restart.cpp b/src/read_restart.cpp index 17b313bfa2..3d2e2b6592 100644 --- a/src/read_restart.cpp +++ b/src/read_restart.cpp @@ -14,7 +14,6 @@ #include "read_restart.h" #include #include -#include #include #include "atom.h" #include "atom_vec.h" @@ -23,7 +22,6 @@ #include "irregular.h" #include "update.h" #include "modify.h" -#include "fix.h" #include "fix_read_restart.h" #include "group.h" #include "force.h" diff --git a/src/reader.cpp b/src/reader.cpp index a1fe51f662..b2751662e2 100644 --- a/src/reader.cpp +++ b/src/reader.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "reader.h" -#include #include #include "error.h" diff --git a/src/reader_xyz.cpp b/src/reader_xyz.cpp index fa553dc30f..81aaba77bc 100644 --- a/src/reader_xyz.cpp +++ b/src/reader_xyz.cpp @@ -16,9 +16,7 @@ ------------------------------------------------------------------------- */ #include "reader_xyz.h" -#include #include -#include "atom.h" #include "memory.h" #include "error.h" #include "force.h" diff --git a/src/region.cpp b/src/region.cpp index 0c4bec16e0..7a676de1af 100644 --- a/src/region.cpp +++ b/src/region.cpp @@ -13,7 +13,6 @@ #include "region.h" #include -#include #include #include "update.h" #include "domain.h" diff --git a/src/region_block.cpp b/src/region_block.cpp index bc52fcd7cf..8ea8b3f202 100644 --- a/src/region_block.cpp +++ b/src/region_block.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "region_block.h" -#include #include #include "force.h" #include "domain.h" diff --git a/src/region_cone.cpp b/src/region_cone.cpp index 345c9fa8e2..3c7d0a29d8 100644 --- a/src/region_cone.cpp +++ b/src/region_cone.cpp @@ -17,7 +17,6 @@ #include "region_cone.h" #include -#include #include #include "domain.h" #include "error.h" diff --git a/src/region_cylinder.cpp b/src/region_cylinder.cpp index 968453cf37..b2c06270d0 100644 --- a/src/region_cylinder.cpp +++ b/src/region_cylinder.cpp @@ -13,7 +13,6 @@ #include "region_cylinder.h" #include -#include #include #include "update.h" #include "domain.h" diff --git a/src/region_intersect.cpp b/src/region_intersect.cpp index c6c11cf35c..fe074a6b4c 100644 --- a/src/region_intersect.cpp +++ b/src/region_intersect.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "region_intersect.h" -#include #include #include "domain.h" #include "error.h" diff --git a/src/region_plane.cpp b/src/region_plane.cpp index 950c0a4b53..85671357ef 100644 --- a/src/region_plane.cpp +++ b/src/region_plane.cpp @@ -13,8 +13,6 @@ #include "region_plane.h" #include -#include -#include #include "error.h" #include "force.h" diff --git a/src/region_prism.cpp b/src/region_prism.cpp index 38fc23da21..b6c54c2fb9 100644 --- a/src/region_prism.cpp +++ b/src/region_prism.cpp @@ -16,8 +16,6 @@ ------------------------------------------------------------------------- */ #include "region_prism.h" -#include -#include #include #include "domain.h" #include "force.h" diff --git a/src/region_sphere.cpp b/src/region_sphere.cpp index 9c478960e3..bf874ad311 100644 --- a/src/region_sphere.cpp +++ b/src/region_sphere.cpp @@ -13,7 +13,6 @@ #include "region_sphere.h" #include -#include #include #include "update.h" #include "input.h" diff --git a/src/region_union.cpp b/src/region_union.cpp index f4e30f5b94..be1fe6eeff 100644 --- a/src/region_union.cpp +++ b/src/region_union.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "region_union.h" -#include #include #include "domain.h" #include "error.h" diff --git a/src/replicate.cpp b/src/replicate.cpp index 6f8c94238a..1617ab0313 100644 --- a/src/replicate.cpp +++ b/src/replicate.cpp @@ -12,11 +12,10 @@ ------------------------------------------------------------------------- */ #include "replicate.h" -#include +#include #include #include "atom.h" #include "atom_vec.h" -#include "atom_vec_hybrid.h" #include "force.h" #include "domain.h" #include "comm.h" diff --git a/src/rerun.cpp b/src/rerun.cpp index e75779ccc0..3cd1c53628 100644 --- a/src/rerun.cpp +++ b/src/rerun.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "rerun.h" -#include #include #include "read_dump.h" #include "domain.h" diff --git a/src/reset_ids.cpp b/src/reset_ids.cpp index b68b7ca797..857738e841 100644 --- a/src/reset_ids.cpp +++ b/src/reset_ids.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include "reset_ids.h" +#include #include "atom.h" #include "atom_vec.h" #include "domain.h" diff --git a/src/respa.cpp b/src/respa.cpp index 867662b3c2..a184756335 100644 --- a/src/respa.cpp +++ b/src/respa.cpp @@ -16,13 +16,13 @@ ------------------------------------------------------------------------- */ #include "respa.h" -#include #include #include "neighbor.h" #include "atom.h" #include "atom_vec.h" #include "domain.h" #include "comm.h" +#include "fix.h" #include "force.h" #include "pair.h" #include "bond.h" @@ -33,10 +33,8 @@ #include "output.h" #include "update.h" #include "modify.h" -#include "compute.h" #include "fix_respa.h" #include "timer.h" -#include "memory.h" #include "error.h" #include "utils.h" #include "pair_hybrid.h" diff --git a/src/run.cpp b/src/run.cpp index 60861ad3b9..2c2f00a7a8 100644 --- a/src/run.cpp +++ b/src/run.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "run.h" -#include #include #include "domain.h" #include "update.h" diff --git a/src/set.cpp b/src/set.cpp index d34aa7753a..3bf00063c5 100644 --- a/src/set.cpp +++ b/src/set.cpp @@ -14,8 +14,8 @@ #include "set.h" #include #include -#include #include +#include #include "atom.h" #include "atom_vec.h" #include "atom_vec_ellipsoid.h" @@ -26,9 +26,7 @@ #include "region.h" #include "group.h" #include "comm.h" -#include "neighbor.h" #include "force.h" -#include "pair.h" #include "input.h" #include "variable.h" #include "random_park.h" diff --git a/src/special.cpp b/src/special.cpp index f8661e238c..b64aa96e2b 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -13,7 +13,6 @@ #include "special.h" #include -#include #include "atom.h" #include "atom_vec.h" #include "force.h" @@ -23,7 +22,6 @@ #include "accelerator_kokkos.h" #include "atom_masks.h" #include "memory.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/thermo.cpp b/src/thermo.cpp index d267ea260c..be725d907b 100644 --- a/src/thermo.cpp +++ b/src/thermo.cpp @@ -16,10 +16,8 @@ // before lmptype.h can set flags to insure it is done correctly #include "thermo.h" -#include "lmptype.h" #include #include -#include #include #include "atom.h" #include "update.h" @@ -43,11 +41,8 @@ #include "kspace.h" #include "output.h" #include "timer.h" -#include "math_const.h" #include "memory.h" #include "error.h" -#include "universe.h" - #include "math_const.h" using namespace LAMMPS_NS; diff --git a/src/thermo.h b/src/thermo.h index 8c32f24d3c..f2384e0ac3 100644 --- a/src/thermo.h +++ b/src/thermo.h @@ -18,9 +18,6 @@ namespace LAMMPS_NS { -class DumpNetCDF; -class DumpNetCDFMPIIO; - class Thermo : protected Pointers { friend class MinCG; // accesses compute_pe friend class DumpNetCDF; // accesses thermo properties -- GitLab From 2f72b9f1203e6506da83aabfad7d9de6b9d56250 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Sebastian=20H=C3=BCtter?= Date: Thu, 28 Mar 2019 16:13:02 +0100 Subject: [PATCH 182/469] Factor out embedding function, make sure documented logic for emb_lin_neg is obeyed --- src/USER-MEAMC/meam.h | 1 + src/USER-MEAMC/meam_dens_final.cpp | 37 +++++++----------------------- src/USER-MEAMC/meam_funcs.cpp | 22 ++++++++++++++++++ src/USER-MEAMC/meam_setup_done.cpp | 22 ++++-------------- 4 files changed, 36 insertions(+), 46 deletions(-) diff --git a/src/USER-MEAMC/meam.h b/src/USER-MEAMC/meam.h index 42fd722e01..7ca849c983 100644 --- a/src/USER-MEAMC/meam.h +++ b/src/USER-MEAMC/meam.h @@ -187,6 +187,7 @@ protected: double G_gam(const double gamma, const int ibar, int &errorflag) const; double dG_gam(const double gamma, const int ibar, double &dG) const; static double zbl(const double r, const int z1, const int z2); + double embedding(const double A, const double Ec, const double rhobar, double& dF) const; static double erose(const double r, const double re, const double alpha, const double Ec, const double repuls, const double attrac, const int form); static void get_shpfcn(const lattice_t latt, double (&s)[3]); diff --git a/src/USER-MEAMC/meam_dens_final.cpp b/src/USER-MEAMC/meam_dens_final.cpp index 2be215c282..b7d191d812 100644 --- a/src/USER-MEAMC/meam_dens_final.cpp +++ b/src/USER-MEAMC/meam_dens_final.cpp @@ -10,7 +10,7 @@ MEAM::meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_ int i, elti; int m; double rhob, G, dG, Gbar, dGbar, gam, shp[3], Z; - double B, denom, rho_bkgd; + double denom, rho_bkgd, Fl; // Complete the calculation of density @@ -111,35 +111,14 @@ MEAM::meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_ dgamma3[i] = 0.0; } - B = this->A_meam[elti] * this->Ec_meam[elti][elti]; - - if (!iszero(rhob)) { - if (this->emb_lin_neg == 1 && rhob <= 0) { - frhop[i] = -B; - } else { - frhop[i] = B * (log(rhob) + 1.0); - } - if (eflag_either != 0) { - if (eflag_global != 0) { - if (this->emb_lin_neg == 1 && rhob <= 0) { - *eng_vdwl = *eng_vdwl - B * rhob; - } else { - *eng_vdwl = *eng_vdwl + B * rhob * log(rhob); - } - } - if (eflag_atom != 0) { - if (this->emb_lin_neg == 1 && rhob <= 0) { - eatom[i] = eatom[i] - B * rhob; - } else { - eatom[i] = eatom[i] + B * rhob * log(rhob); - } - } + Fl = embedding(this->A_meam[elti], this->Ec_meam[elti][elti], rhob, frhop[i]); + + if (eflag_either != 0) { + if (eflag_global != 0) { + *eng_vdwl = *eng_vdwl + Fl; } - } else { - if (this->emb_lin_neg == 1) { - frhop[i] = -B; - } else { - frhop[i] = B; + if (eflag_atom != 0) { + eatom[i] = eatom[i] + Fl; } } } diff --git a/src/USER-MEAMC/meam_funcs.cpp b/src/USER-MEAMC/meam_funcs.cpp index 1d47dcc1f6..50cabd101c 100644 --- a/src/USER-MEAMC/meam_funcs.cpp +++ b/src/USER-MEAMC/meam_funcs.cpp @@ -143,6 +143,28 @@ MEAM::zbl(const double r, const int z1, const int z2) return result; } +//----------------------------------------------------------------------------- +// Compute embedding function F(rhobar) and derivative F'(rhobar), eqn I.5 +// +double +MEAM::embedding(const double A, const double Ec, const double rhobar, double& dF) const +{ + const double AEc = A * Ec; + + if (rhobar > 0.0) { + dF = AEc * (1.0 + log(rhobar)); + return AEc * rhobar * log(rhobar); + } else { + if (this->emb_lin_neg == 0) { + dF = 0.0; + return 0.0; + } else { + dF = - AEc; + return - AEc * rhobar; + } + } +} + //----------------------------------------------------------------------------- // Compute Rose energy function, I.16 // diff --git a/src/USER-MEAMC/meam_setup_done.cpp b/src/USER-MEAMC/meam_setup_done.cpp index e18a391378..3cd9510cf3 100644 --- a/src/USER-MEAMC/meam_setup_done.cpp +++ b/src/USER-MEAMC/meam_setup_done.cpp @@ -319,7 +319,7 @@ MEAM::phi_meam(double r, int a, int b) double t11av, t21av, t31av, t12av, t22av, t32av; double G1, G2, s1[3], s2[3], rho0_1, rho0_2; double Gam1, Gam2, Z1, Z2; - double rhobar1, rhobar2, F1, F2; + double rhobar1, rhobar2, F1, F2, dF; double rho01, rho11, rho21, rho31; double rho02, rho12, rho22, rho32; double scalfac, phiaa, phibb; @@ -447,22 +447,10 @@ MEAM::phi_meam(double r, int a, int b) } // compute embedding functions, eqn I.5 - if (iszero(rhobar1)) - F1 = 0.0; - else { - if (this->emb_lin_neg == 1 && rhobar1 <= 0) - F1 = -this->A_meam[a] * this->Ec_meam[a][a] * rhobar1; - else - F1 = this->A_meam[a] * this->Ec_meam[a][a] * rhobar1 * log(rhobar1); - } - if (iszero(rhobar2)) - F2 = 0.0; - else { - if (this->emb_lin_neg == 1 && rhobar2 <= 0) - F2 = -this->A_meam[b] * this->Ec_meam[b][b] * rhobar2; - else - F2 = this->A_meam[b] * this->Ec_meam[b][b] * rhobar2 * log(rhobar2); - } + + F1 = embedding(this->A_meam[a], this->Ec_meam[a][a], rhobar1, dF); + F2 = embedding(this->A_meam[b], this->Ec_meam[b][b], rhobar2, dF); + // compute Rose function, I.16 Eu = erose(r, this->re_meam[a][b], this->alpha_meam[a][b], this->Ec_meam[a][b], this->repuls_meam[a][b], -- GitLab From 8dcb42d49c738f96d5feb3b8f3e559e114886183 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Sebastian=20H=C3=BCtter?= Date: Thu, 28 Mar 2019 16:19:29 +0100 Subject: [PATCH 183/469] Check MEAM parameters for t0=1.0, mention this fact in documentation --- doc/src/pair_meamc.txt | 3 ++- src/USER-MEAMC/pair_meamc.cpp | 3 +++ 2 files changed, 5 insertions(+), 1 deletion(-) diff --git a/doc/src/pair_meamc.txt b/doc/src/pair_meamc.txt index 80f69b1a46..7c42e9d2f2 100644 --- a/doc/src/pair_meamc.txt +++ b/doc/src/pair_meamc.txt @@ -147,7 +147,8 @@ asub = "A" parameter for MEAM (see e.g. "(Baskes)"_#Baskes) :pre The alpha, b0, b1, b2, b3, t0, t1, t2, t3 parameters correspond to the standard MEAM parameters in the literature "(Baskes)"_#Baskes (the b -parameters are the standard beta parameters). The rozero parameter is +parameters are the standard beta parameters). Note that only parameters +normalized to t0 = 1.0 are supported. The rozero parameter is an element-dependent density scaling that weights the reference background density (see e.g. equation 4.5 in "(Gullet)"_#Gullet) and is typically 1.0 for single-element systems. The ibar parameter diff --git a/src/USER-MEAMC/pair_meamc.cpp b/src/USER-MEAMC/pair_meamc.cpp index a70fb77aae..7c96fadb44 100644 --- a/src/USER-MEAMC/pair_meamc.cpp +++ b/src/USER-MEAMC/pair_meamc.cpp @@ -460,6 +460,9 @@ void PairMEAMC::read_files(char *globalfile, char *userfile) rozero[i] = atof(words[17]); ibar[i] = atoi(words[18]); + if (!iszero(t0[i]-1.0)) + error->all(FLERR,"Unsupported parameter in MEAM potential file"); + nset++; } -- GitLab From 0d4bb8618325021a263f8705b3a8dcd4a443eee2 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Sebastian=20H=C3=BCtter?= Date: Wed, 10 Apr 2019 17:12:19 +0200 Subject: [PATCH 184/469] MEAM/C: code commenting --- src/USER-MEAMC/meam.h | 6 ++++-- 1 file changed, 4 insertions(+), 2 deletions(-) diff --git a/src/USER-MEAMC/meam.h b/src/USER-MEAMC/meam.h index 7ca849c983..ff9027dfb3 100644 --- a/src/USER-MEAMC/meam.h +++ b/src/USER-MEAMC/meam.h @@ -93,8 +93,9 @@ private: int augt1, ialloy, mix_ref_t, erose_form; int emb_lin_neg, bkgd_dyn; double gsmooth_factor; - int vind2D[3][3], vind3D[3][3][3]; - int v2D[6], v3D[10]; + + int vind2D[3][3], vind3D[3][3][3]; // x-y-z to Voigt-like index + int v2D[6], v3D[10]; // multiplicity of Voigt index (i.e. [1] -> xy+yx = 2 int nr, nrar; double dr, rdrar; @@ -121,6 +122,7 @@ protected: else if (xi <= 0.0) return 0.0; else { + // ( 1.d0 - (1.d0 - xi)**4 )**2, but with better codegen a = 1.0 - xi; a *= a; a *= a; a = 1.0 - a; -- GitLab From 7efb42f0d3926b5e25c29239f1422e8a1a632673 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Sebastian=20H=C3=BCtter?= Date: Mon, 13 May 2019 10:43:21 +0200 Subject: [PATCH 185/469] MEAM/C: code optimization for faster codegen --- src/USER-MEAMC/meam_dens_final.cpp | 2 +- src/USER-MEAMC/meam_dens_init.cpp | 158 ++++++++++++++--------------- src/USER-MEAMC/meam_funcs.cpp | 7 +- src/USER-MEAMC/meam_setup_done.cpp | 2 +- 4 files changed, 85 insertions(+), 84 deletions(-) diff --git a/src/USER-MEAMC/meam_dens_final.cpp b/src/USER-MEAMC/meam_dens_final.cpp index b7d191d812..c55b1b45c4 100644 --- a/src/USER-MEAMC/meam_dens_final.cpp +++ b/src/USER-MEAMC/meam_dens_final.cpp @@ -112,7 +112,7 @@ MEAM::meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_ } Fl = embedding(this->A_meam[elti], this->Ec_meam[elti][elti], rhob, frhop[i]); - + if (eflag_either != 0) { if (eflag_global != 0) { *eng_vdwl = *eng_vdwl + Fl; diff --git a/src/USER-MEAMC/meam_dens_init.cpp b/src/USER-MEAMC/meam_dens_init.cpp index 0aa71125c8..3bb9328142 100644 --- a/src/USER-MEAMC/meam_dens_init.cpp +++ b/src/USER-MEAMC/meam_dens_init.cpp @@ -127,72 +127,20 @@ MEAM::getscreen(int i, double* scrfcn, double* dscrfcn, double* fcpair, double** delyij = yjtmp - yitmp; delzij = zjtmp - zitmp; rij2 = delxij * delxij + delyij * delyij + delzij * delzij; - rij = sqrt(rij2); - const double rbound = this->ebound_meam[elti][eltj] * rij2; - if (rij > this->rc_meam) { - fcij = 0.0; - dfcij = 0.0; - sij = 0.0; - } else { - rnorm = (this->rc_meam - rij) * drinv; - sij = 1.0; - - // if rjk2 > ebound*rijsq, atom k is definitely outside the ellipse - for (kn = 0; kn < numneigh_full; kn++) { - k = firstneigh_full[kn]; - eltk = fmap[type[k]]; - if (eltk < 0) continue; - if (k == j) continue; - - delxjk = x[k][0] - xjtmp; - delyjk = x[k][1] - yjtmp; - delzjk = x[k][2] - zjtmp; - rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; - if (rjk2 > rbound) continue; - - delxik = x[k][0] - xitmp; - delyik = x[k][1] - yitmp; - delzik = x[k][2] - zitmp; - rik2 = delxik * delxik + delyik * delyik + delzik * delzik; - if (rik2 > rbound) continue; - - xik = rik2 / rij2; - xjk = rjk2 / rij2; - a = 1 - (xik - xjk) * (xik - xjk); - // if a < 0, then ellipse equation doesn't describe this case and - // atom k can't possibly screen i-j - if (a <= 0.0) continue; - - cikj = (2.0 * (xik + xjk) + a - 2.0) / a; - Cmax = this->Cmax_meam[elti][eltj][eltk]; - Cmin = this->Cmin_meam[elti][eltj][eltk]; - if (cikj >= Cmax) continue; - // note that cikj may be slightly negative (within numerical - // tolerance) if atoms are colinear, so don't reject that case here - // (other negative cikj cases were handled by the test on "a" above) - else if (cikj <= Cmin) { - sij = 0.0; - break; - } else { - delc = Cmax - Cmin; - cikj = (cikj - Cmin) / delc; - sikj = fcut(cikj); - } - sij *= sikj; - } - - fc = dfcut(rnorm, dfc); - fcij = fc; - dfcij = dfc * drinv; + if (rij2 > this->cutforcesq) { + dscrfcn[jn] = 0.0; + scrfcn[jn] = 0.0; + fcpair[jn] = 0.0; + continue; } - // Now compute derivatives - dscrfcn[jn] = 0.0; - sfcij = sij * fcij; - if (iszero(sfcij) || iszero(sfcij - 1.0)) - goto LABEL_100; + const double rbound = this->ebound_meam[elti][eltj] * rij2; + rij = sqrt(rij2); + rnorm = (this->cutforce - rij) * drinv; + sij = 1.0; + // if rjk2 > ebound*rijsq, atom k is definitely outside the ellipse for (kn = 0; kn < numneigh_full; kn++) { k = firstneigh_full[kn]; if (k == j) continue; @@ -202,6 +150,7 @@ MEAM::getscreen(int i, double* scrfcn, double* dscrfcn, double* fcpair, double** xktmp = x[k][0]; yktmp = x[k][1]; zktmp = x[k][2]; + delxjk = xktmp - xjtmp; delyjk = yktmp - yjtmp; delzjk = zktmp - zjtmp; @@ -224,29 +173,80 @@ MEAM::getscreen(int i, double* scrfcn, double* dscrfcn, double* fcpair, double** cikj = (2.0 * (xik + xjk) + a - 2.0) / a; Cmax = this->Cmax_meam[elti][eltj][eltk]; Cmin = this->Cmin_meam[elti][eltj][eltk]; - if (cikj >= Cmax) { - continue; - // Note that cikj may be slightly negative (within numerical - // tolerance) if atoms are colinear, so don't reject that case - // here - // (other negative cikj cases were handled by the test on "a" - // above) - // Note that we never have 0= Cmax) continue; + // note that cikj may be slightly negative (within numerical + // tolerance) if atoms are colinear, so don't reject that case here + // (other negative cikj cases were handled by the test on "a" above) + else if (cikj <= Cmin) { + sij = 0.0; + break; } else { delc = Cmax - Cmin; cikj = (cikj - Cmin) / delc; - sikj = dfcut(cikj, dfikj); - coef1 = dfikj / (delc * sikj); - dCikj = dCfunc(rij2, rik2, rjk2); - dscrfcn[jn] = dscrfcn[jn] + coef1 * dCikj; + sikj = fcut(cikj); + } + sij *= sikj; + } + + fc = dfcut(rnorm, dfc); + fcij = fc; + dfcij = dfc * drinv; + + // Now compute derivatives + dscrfcn[jn] = 0.0; + sfcij = sij * fcij; + if (!iszero(sfcij) && !iszero(sfcij - 1.0)) { + for (kn = 0; kn < numneigh_full; kn++) { + k = firstneigh_full[kn]; + if (k == j) continue; + eltk = fmap[type[k]]; + if (eltk < 0) continue; + + delxjk = x[k][0] - xjtmp; + delyjk = x[k][1] - yjtmp; + delzjk = x[k][2] - zjtmp; + rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; + if (rjk2 > rbound) continue; + + delxik = x[k][0] - xitmp; + delyik = x[k][1] - yitmp; + delzik = x[k][2] - zitmp; + rik2 = delxik * delxik + delyik * delyik + delzik * delzik; + if (rik2 > rbound) continue; + + xik = rik2 / rij2; + xjk = rjk2 / rij2; + a = 1 - (xik - xjk) * (xik - xjk); + // if a < 0, then ellipse equation doesn't describe this case and + // atom k can't possibly screen i-j + if (a <= 0.0) continue; + + cikj = (2.0 * (xik + xjk) + a - 2.0) / a; + Cmax = this->Cmax_meam[elti][eltj][eltk]; + Cmin = this->Cmin_meam[elti][eltj][eltk]; + if (cikj >= Cmax) { + continue; + // Note that cikj may be slightly negative (within numerical + // tolerance) if atoms are colinear, so don't reject that case + // here + // (other negative cikj cases were handled by the test on "a" + // above) + // Note that we never have 0= 0) { return sqrt(1.0 + gamma); @@ -152,8 +152,9 @@ MEAM::embedding(const double A, const double Ec, const double rhobar, double& dF const double AEc = A * Ec; if (rhobar > 0.0) { - dF = AEc * (1.0 + log(rhobar)); - return AEc * rhobar * log(rhobar); + const double lrb = log(rhobar); + dF = AEc * (1.0 + lrb); + return AEc * rhobar * lrb; } else { if (this->emb_lin_neg == 0) { dF = 0.0; diff --git a/src/USER-MEAMC/meam_setup_done.cpp b/src/USER-MEAMC/meam_setup_done.cpp index 3cd9510cf3..2a762d1204 100644 --- a/src/USER-MEAMC/meam_setup_done.cpp +++ b/src/USER-MEAMC/meam_setup_done.cpp @@ -697,7 +697,7 @@ MEAM::get_densref(double r, int a, int b, double* rho01, double* rho11, double* get_sijk(C, a, a, b, &s112); get_sijk(C, b, b, a, &s221); S11 = s111 * s111 * s112 * s112; - S22 = pow(s221, 4); + S22 = s221 * s221 * s221 * s221; *rho01 = *rho01 + 6 * S11 * rhoa01nn; *rho02 = *rho02 + 6 * S22 * rhoa02nn; -- GitLab From d07a49aeea8a13cb83eb1da6096877d0e6b53ea5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 5 Jul 2019 11:37:21 -0400 Subject: [PATCH 186/469] add missing prototypes --- lib/poems/fastmatrixops.h | 3 +++ 1 file changed, 3 insertions(+) diff --git a/lib/poems/fastmatrixops.h b/lib/poems/fastmatrixops.h index 4c3c1353bd..45573c3eab 100644 --- a/lib/poems/fastmatrixops.h +++ b/lib/poems/fastmatrixops.h @@ -32,6 +32,7 @@ class Vect6; void FastCross(Vect3& a, Vect3& b, Vect3& c); void FastSimpleRotation(Vect3& v, double q, Mat3x3& C); void FastQuaternions(ColMatrix& q, Mat3x3& C); +void FastInvQuaternions(Mat3x3& C, ColMatrix& q); void FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot); void FastLDLT(Matrix& A, Matrix& LD); // C is the LDL^T decomposition of A (SPD) void FastLDLT(Mat6x6& A, Mat6x6& LD); // C is the LDL^T decomposition of A (SPD) @@ -54,6 +55,7 @@ void FastTripleSumPPM(Vect3& a, Vect3& b, Vect3& c, Vect3& d); // d = a+b-c void FastMult(Matrix& A, Matrix& B, Matrix& C); // C = A*B void FastTMult(Matrix& A, Matrix& B, Matrix& C); // C = A^T*B +void FastTMult(Mat3x3& A, Vect3& B, Vect3& C); void FastMult(Mat3x3& A, Vect3& B, Vect3& C); // C = A*B void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); // C = A*B @@ -90,6 +92,7 @@ void FastAdd(Vect3& A, Vect3& B, Vect3& C); // C = A+B void FastAdd(Vect4& A, Vect4& B, Vect3& C); // C = A+B void FastAdd(Mat6x6& A, Mat6x6& B, Mat6x6& C); // C = A+B void FastAdd(Vect6& A, Vect6& B, Vect6& C); // C = A+B +void FastAdd(Vect4& A, Vect4& B, Vect4& C); void FastSubt(Vect3& A, Vect3& B, Vect3& C); // C = A-B void FastSubt(Vect4& A, Vect4& B, Vect4& C); // C = A-B -- GitLab From 46a9772a6d36504587338602b7adfbb2e50c1fa1 Mon Sep 17 00:00:00 2001 From: Trung Nguyen Date: Fri, 5 Jul 2019 12:12:29 -0500 Subject: [PATCH 187/469] Minor clean-up --- lib/gpu/lal_tersoff.cu | 40 ++++++----------------------------- lib/gpu/lal_tersoff_mod.cu | 37 ++++++-------------------------- lib/gpu/lal_tersoff_zbl.cu | 37 ++++++-------------------------- lib/gpu/lal_yukawa_colloid.cu | 12 +++++------ lib/gpu/lal_zbl.cu | 39 ++++++++++++++-------------------- 5 files changed, 41 insertions(+), 124 deletions(-) diff --git a/lib/gpu/lal_tersoff.cu b/lib/gpu/lal_tersoff.cu index 836f05660d..2e29ca721b 100644 --- a/lib/gpu/lal_tersoff.cu +++ b/lib/gpu/lal_tersoff.cu @@ -308,8 +308,6 @@ __kernel void k_tersoff_zeta(const __global numtyp4 *restrict x_, delr1.z = jx.z-ix.z; numtyp rsq1 = delr1.x*delr1.x+delr1.y*delr1.y+delr1.z*delr1.z; -// if (rsq1 > cutsq[ijparam]) continue; - // compute zeta_ij z = (acctyp)0; @@ -355,13 +353,9 @@ __kernel void k_tersoff_zeta(const __global numtyp4 *restrict x_, rsq1, rsq2, delr1, delr2); } - //int jj = (nbor_j-offset_j-2*nbor_pitch)/n_stride; - //int idx = jj*n_stride + i*t_per_atom + offset_j; - //idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor int idx = nbor_j; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// i, nbor_j, offset_j, idx); acc_zeta(z, tid, t_per_atom, offset_k); numtyp4 ts1_ijparam = ts1[ijparam]; //fetch4(ts1_ijparam,ijparam,ts1_tex); @@ -585,14 +579,9 @@ __kernel void k_tersoff_three_center(const __global numtyp4 *restrict x_, numtyp r1inv = ucl_rsqrt(rsq1); // look up for zeta_ij - - //int jj = (nbor_j-offset_j-2*nbor_pitch) / n_stride; - //int idx = jj*n_stride + i*t_per_atom + offset_j; - //idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor int idx = nbor_j; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// i, nbor_j, offset_j, idx); acctyp4 zeta_ij = zetaij[idx]; // fetch(zeta_ij,idx,zeta_tex); numtyp force = zeta_ij.x*tpainv; numtyp prefactor = zeta_ij.y; @@ -823,13 +812,9 @@ __kernel void k_tersoff_three_end(const __global numtyp4 *restrict x_, offset_kf = red_acc[2*m+1]; } - //int iix = (ijnum - offset_kf - 2*nbor_pitch) / n_stride; - //int idx = iix*n_stride + j*t_per_atom + offset_kf; - //idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor int idx = ijnum; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, ijnum, offset_kf, idx); acctyp4 zeta_ji = zetaij[idx]; // fetch(zeta_ji,idx,zeta_tex); numtyp force = zeta_ji.x*tpainv; numtyp prefactor_ji = zeta_ji.y; @@ -891,13 +876,10 @@ __kernel void k_tersoff_three_end(const __global numtyp4 *restrict x_, f.y += fi[1]; f.z += fi[2]; - //int kk = (nbor_k - offset_k - 2*nbor_pitch) / n_stride; - //int idx = kk*n_stride + j*t_per_atom + offset_k; - //idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor int idx = nbor_k; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, nbor_k, offset_k, idx); + acctyp4 zeta_jk = zetaij[idx]; // fetch(zeta_jk,idx,zeta_tex); numtyp prefactor_jk = zeta_jk.y; int jkiparam=elem2param[jtype*nelements*nelements+ktype*nelements+itype]; @@ -1068,13 +1050,9 @@ __kernel void k_tersoff_three_end_vatom(const __global numtyp4 *restrict x_, offset_kf = red_acc[2*m+1]; } - //int iix = (ijnum - offset_kf - 2*nbor_pitch) / n_stride; - //int idx = iix*n_stride + j*t_per_atom + offset_kf; - //idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor int idx = ijnum; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, ijnum, offset_kf, idx); acctyp4 zeta_ji = zetaij[idx]; // fetch(zeta_ji,idx,zeta_tex); numtyp force = zeta_ji.x*tpainv; numtyp prefactor_ji = zeta_ji.y; @@ -1143,13 +1121,9 @@ __kernel void k_tersoff_three_end_vatom(const __global numtyp4 *restrict x_, virial[4] += TWOTHIRD*(mdelr1[0]*fj[2] + delr2[0]*fk[2]); virial[5] += TWOTHIRD*(mdelr1[1]*fj[2] + delr2[1]*fk[2]); - //int kk = (nbor_k - offset_k - 2*nbor_pitch) / n_stride; - //int idx = kk*n_stride + j*t_per_atom + offset_k; - //idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor int idx = nbor_k; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, nbor_k, offset_k, idx); acctyp4 zeta_jk = zetaij[idx]; // fetch(zeta_jk,idx,zeta_tex); numtyp prefactor_jk = zeta_jk.y; diff --git a/lib/gpu/lal_tersoff_mod.cu b/lib/gpu/lal_tersoff_mod.cu index dfb94c4145..c85f5e08ca 100644 --- a/lib/gpu/lal_tersoff_mod.cu +++ b/lib/gpu/lal_tersoff_mod.cu @@ -356,13 +356,9 @@ __kernel void k_tersoff_mod_zeta(const __global numtyp4 *restrict x_, ijkparam_c5, rsq1, rsq2, delr1, delr2); } - //int jj = (nbor_j-offset_j-2*nbor_pitch)/n_stride; - //int idx = jj*n_stride + i*t_per_atom + offset_j; - //idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor int idx = nbor_j; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// i, nbor_j, offset_j, idx); acc_zeta(z, tid, t_per_atom, offset_k); numtyp4 ts1_ijparam = ts1[ijparam]; //fetch4(ts1_ijparam,ijparam,ts1_tex); @@ -587,14 +583,9 @@ __kernel void k_tersoff_mod_three_center(const __global numtyp4 *restrict x_, numtyp r1inv = ucl_rsqrt(rsq1); // look up for zeta_ij - - //int jj = (nbor_j-offset_j-2*nbor_pitch) / n_stride; - //int idx = jj*n_stride + i*t_per_atom + offset_j; - //idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor int idx = nbor_j; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// i, nbor_j, offset_j, idx); acctyp4 zeta_ij = zetaij[idx]; // fetch(zeta_ij,idx,zeta_tex); numtyp force = zeta_ij.x*tpainv; numtyp prefactor = zeta_ij.y; @@ -831,13 +822,9 @@ __kernel void k_tersoff_mod_three_end(const __global numtyp4 *restrict x_, offset_kf = red_acc[2*m+1]; } - //int iix = (ijnum - offset_kf - 2*nbor_pitch) / n_stride; - //int idx = iix*n_stride + j*t_per_atom + offset_kf; - //idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor int idx = ijnum; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, ijnum, offset_kf, idx); acctyp4 zeta_ji = zetaij[idx]; // fetch(zeta_ji,idx,zeta_tex); numtyp force = zeta_ji.x*tpainv; numtyp prefactor_ji = zeta_ji.y; @@ -902,13 +889,9 @@ __kernel void k_tersoff_mod_three_end(const __global numtyp4 *restrict x_, f.y += fi[1]; f.z += fi[2]; - //int kk = (nbor_k - offset_k - 2*nbor_pitch) / n_stride; - //int idx = kk*n_stride + j*t_per_atom + offset_k; - //idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor int idx = nbor_k; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, nbor_k, offset_k, idx); acctyp4 zeta_jk = zetaij[idx]; // fetch(zeta_jk,idx,zeta_tex); numtyp prefactor_jk = zeta_jk.y; int jkiparam=elem2param[jtype*nelements*nelements+ktype*nelements+itype]; @@ -1085,13 +1068,9 @@ __kernel void k_tersoff_mod_three_end_vatom(const __global numtyp4 *restrict x_, offset_kf = red_acc[2*m+1]; } - //int iix = (ijnum - offset_kf - 2*nbor_pitch) / n_stride; - //int idx = iix*n_stride + j*t_per_atom + offset_kf; - //idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor int idx = ijnum; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, ijnum, offset_kf, idx); acctyp4 zeta_ji = zetaij[idx]; // fetch(zeta_ji,idx,zeta_tex); numtyp force = zeta_ji.x*tpainv; numtyp prefactor_ji = zeta_ji.y; @@ -1163,13 +1142,9 @@ __kernel void k_tersoff_mod_three_end_vatom(const __global numtyp4 *restrict x_, virial[4] += TWOTHIRD*(mdelr1[0]*fj[2] + delr2[0]*fk[2]); virial[5] += TWOTHIRD*(mdelr1[1]*fj[2] + delr2[1]*fk[2]); - //int kk = (nbor_k - offset_k - 2*nbor_pitch) / n_stride; - //int idx = kk*n_stride + j*t_per_atom + offset_k; - //idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor int idx = nbor_k; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, nbor_k, offset_k, idx); acctyp4 zeta_jk = zetaij[idx]; // fetch(zeta_jk,idx,zeta_tex); numtyp prefactor_jk = zeta_jk.y; diff --git a/lib/gpu/lal_tersoff_zbl.cu b/lib/gpu/lal_tersoff_zbl.cu index 73ff51c704..b574a529c0 100644 --- a/lib/gpu/lal_tersoff_zbl.cu +++ b/lib/gpu/lal_tersoff_zbl.cu @@ -359,13 +359,9 @@ __kernel void k_tersoff_zbl_zeta(const __global numtyp4 *restrict x_, rsq1, rsq2, delr1, delr2); } - //int jj = (nbor_j-offset_j-2*nbor_pitch)/n_stride; - //int idx = jj*n_stride + i*t_per_atom + offset_j; - //idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor int idx = nbor_j; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// i, nbor_j, offset_j, idx); acc_zeta(z, tid, t_per_atom, offset_k); numtyp4 ts1_ijparam = ts1[ijparam]; //fetch4(ts1_ijparam,ijparam,ts1_tex); @@ -603,14 +599,9 @@ __kernel void k_tersoff_zbl_three_center(const __global numtyp4 *restrict x_, numtyp r1inv = ucl_rsqrt(rsq1); // look up for zeta_ij - - //int jj = (nbor_j-offset_j-2*nbor_pitch) / n_stride; - //int idx = jj*n_stride + i*t_per_atom + offset_j; - //idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_j in dev_short_nbor int idx = nbor_j; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// i, nbor_j, offset_j, idx); acctyp4 zeta_ij = zetaij[idx]; // fetch(zeta_ij,idx,zeta_tex); numtyp force = zeta_ij.x*tpainv; numtyp prefactor = zeta_ij.y; @@ -841,13 +832,9 @@ __kernel void k_tersoff_zbl_three_end(const __global numtyp4 *restrict x_, offset_kf = red_acc[2*m+1]; } - //int iix = (ijnum - offset_kf - 2*nbor_pitch) / n_stride; - //int idx = iix*n_stride + j*t_per_atom + offset_kf; - //idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor int idx = ijnum; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, ijnum, offset_kf, idx); acctyp4 zeta_ji = zetaij[idx]; // fetch(zeta_ji,idx,zeta_tex); numtyp force = zeta_ji.x*tpainv; numtyp prefactor_ji = zeta_ji.y; @@ -909,13 +896,9 @@ __kernel void k_tersoff_zbl_three_end(const __global numtyp4 *restrict x_, f.y += fi[1]; f.z += fi[2]; - //int kk = (nbor_k - offset_k - 2*nbor_pitch) / n_stride; - //int idx = kk*n_stride + j*t_per_atom + offset_k; - //idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor int idx = nbor_k; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, nbor_k, offset_k, idx); acctyp4 zeta_jk = zetaij[idx]; // fetch(zeta_jk,idx,zeta_tex); numtyp prefactor_jk = zeta_jk.y; int jkiparam=elem2param[jtype*nelements*nelements+ktype*nelements+itype]; @@ -1086,13 +1069,9 @@ __kernel void k_tersoff_zbl_three_end_vatom(const __global numtyp4 *restrict x_, offset_kf = red_acc[2*m+1]; } - //int iix = (ijnum - offset_kf - 2*nbor_pitch) / n_stride; - //int idx = iix*n_stride + j*t_per_atom + offset_kf; - //idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to ijnum in dev_short_nbor int idx = ijnum; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, ijnum, offset_kf, idx); acctyp4 zeta_ji = zetaij[idx]; // fetch(zeta_ji,idx,zeta_tex); numtyp force = zeta_ji.x*tpainv; numtyp prefactor_ji = zeta_ji.y; @@ -1161,13 +1140,9 @@ __kernel void k_tersoff_zbl_three_end_vatom(const __global numtyp4 *restrict x_, virial[4] += TWOTHIRD*(mdelr1[0]*fj[2] + delr2[0]*fk[2]); virial[5] += TWOTHIRD*(mdelr1[1]*fj[2] + delr2[1]*fk[2]); - //int kk = (nbor_k - offset_k - 2*nbor_pitch) / n_stride; - //int idx = kk*n_stride + j*t_per_atom + offset_k; - //idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor + // idx to zetaij is shifted by n_stride relative to nbor_k in dev_short_nbor int idx = nbor_k; if (dev_packed==dev_nbor) idx -= n_stride; -// zeta_idx(dev_nbor,dev_packed, nbor_pitch, n_stride, t_per_atom, -// j, nbor_k, offset_k, idx); acctyp4 zeta_jk = zetaij[idx]; // fetch(zeta_jk,idx,zeta_tex); numtyp prefactor_jk = zeta_jk.y; diff --git a/lib/gpu/lal_yukawa_colloid.cu b/lib/gpu/lal_yukawa_colloid.cu index 48ab47bc94..a3cbbbc11c 100644 --- a/lib/gpu/lal_yukawa_colloid.cu +++ b/lib/gpu/lal_yukawa_colloid.cu @@ -89,10 +89,10 @@ __kernel void k_yukawa_colloid(const __global numtyp4 *restrict x_, if (rsqcut_innersq) { - t = r - cut_inner; - force = t*t * (coeff1[mtype].x + coeff1[mtype].y*t); - } - + if (rsq>cut_innersq) { + t = r - cut_inner; + force = t*t * (coeff1[mtype].x + coeff1[mtype].y*t); + } force *= (numtyp)-1.0*ucl_recip(r); f.x+=delx*force; @@ -148,11 +145,10 @@ __kernel void k_zbl(const __global numtyp4 *restrict x_, if (eflag>0) { numtyp e=e_zbl(r, coeff2[mtype].x, coeff2[mtype].y, coeff2[mtype].z, coeff2[mtype].w, coeff1[mtype].z); - e += coeff3[mtype].z; - if (rsq > cut_innersq) { - e += t*t*t * (coeff3[mtype].x + coeff3[mtype].y*t); - } - + e += coeff3[mtype].z; + if (rsq > cut_innersq) { + e += t*t*t * (coeff3[mtype].x + coeff3[mtype].y*t); + } energy+=e; } if (vflag>0) { @@ -232,15 +228,13 @@ __kernel void k_zbl_fast(const __global numtyp4 *restrict x_, if (rsqcut_innersq) { - t = r - cut_inner; - force += t*t * (coeff1[mtype].x + coeff1[mtype].y*t); - } + if (rsq>cut_innersq) { + t = r - cut_inner; + force += t*t * (coeff1[mtype].x + coeff1[mtype].y*t); + } force *= (numtyp)-1.0*ucl_recip(r); @@ -251,11 +245,10 @@ __kernel void k_zbl_fast(const __global numtyp4 *restrict x_, if (eflag>0) { numtyp e=e_zbl(r, coeff2[mtype].x, coeff2[mtype].y, coeff2[mtype].z, coeff2[mtype].w, coeff1[mtype].z); - e += coeff3[mtype].z; - if (rsq > cut_innersq) { - e += t*t*t * (coeff3[mtype].x + coeff3[mtype].y*t); - } - + e += coeff3[mtype].z; + if (rsq > cut_innersq) { + e += t*t*t * (coeff3[mtype].x + coeff3[mtype].y*t); + } energy+=e; } if (vflag>0) { -- GitLab From 5fffccb076fd350cf0bf6c80374bccee87c210a1 Mon Sep 17 00:00:00 2001 From: Anne Gunn Date: Fri, 5 Jul 2019 12:08:57 -0600 Subject: [PATCH 188/469] Apply minor line editing to new documentation file. --- doc/include-file-conventions.md | 44 ++++++++++++++++----------------- 1 file changed, 22 insertions(+), 22 deletions(-) diff --git a/doc/include-file-conventions.md b/doc/include-file-conventions.md index 1f206c8f88..c9f8bd5cb1 100644 --- a/doc/include-file-conventions.md +++ b/doc/include-file-conventions.md @@ -3,7 +3,7 @@ This purpose of this document is to provide a point of reference for LAMMPS developers and contributors as to what include files and definitions to put where into LAMMPS source. -Last change 2019-06-27 +Last change 2019-07-05 ## Table of Contents @@ -14,43 +14,43 @@ Last change 2019-06-27 ## Motivation -The conventions outlined in this document are supposed to help making +The conventions outlined in this document are supposed to help make maintenance of the LAMMPS software easier. By trying to achieve consistency across files contributed by different developers, it will -become easier to modify and adjust files by the code maintainers, and -overall the chance for errors or portability issues will be reduced. -Also the rules employed are supposed to minimize naming conflicts and -simplify dependencies between files (and thus speed up compilation), as -well as make otherwise hidden dependencies visible. +become easier for the code maintainers to modify and adjust files and, +overall, the chance for errors or portability issues will be reduced. +The rules employed are supposed to minimize naming conflicts and +simplify dependencies between files and thus speed up compilation. They +may, as well, make otherwise hidden dependencies visible. ## Rules Below are the various rules that are applied. Not all are enforced strictly and automatically. If there are no significant side effects, -exceptions may be possible for cases, where a full compliance to the +exceptions may be possible for cases where a full compliance to the rules may require a large effort compared to the benefit. ### Core Files Versus Package Files -All rules listed below are most strictly observed for core LAMMPS files. -Which are the files that are not part of a package and files of the +All rules listed below are most strictly observed for core LAMMPS files, +which are the files that are not part of a package, and the files of the packages MOLECULE, MANYBODY, KSPACE, and RIGID. On the other end of the spectrum are USER packages and legacy packages that predate these -rules and thus may not be fully compliant. Also new contributions -will be checked more closely, while existing code is incrementally +rules and thus may not be fully compliant. Also, new contributions +will be checked more closely, while existing code will be incrementally adapted to the rules as time and required effort permits. ### System Versus Local Header Files -All system or library provided include files are included with angular +All system- or library-provided include files are included with angular brackets (examples: `#include ` or `#include `) while include files provided with LAMMPS are included with double quotes (examples: `#include "pointers.h"` or `#include "compute_temp.h"`). For headers declaring functions of the C-library, the corresponding C++ versions should be included (examples: `#include ` or -`#include `). However, those are limited to those defined -in the C++98 standard. Some files thus must use the older style unless +`#include `). However, these includes are limited to those defined +in the C++98 standard. Some files thus must use the older style until the minimum C++ standard requirement of LAMMPS is lifted to C++11 or even beyond (examples: `#include ` versus `#include ` or `#include ` versus `#include `). @@ -60,7 +60,7 @@ or `#include ` versus `#include `). LAMMPS core files currently correspond to the C++98 standard. Files requiring C++11 or later are only permitted in (optional) packages and particularly packages that are not part of the list of commonly -used packages like MOLECULE, KSPACE, MANYBODY, or RIGID. +used packages such as MOLECULE, KSPACE, MANYBODY, or RIGID. Also, LAMMPS uses the C-style stdio library for I/O instead of iostreams. Since using both at the same time can cause problems, iostreams should @@ -72,8 +72,8 @@ Header files will typically contain the definition of a (single) class. These header files should have as few include statements as possible. This is particularly important for classes that implement a "style" and thus use a macro of the kind `SomeStyle(some/name,SomeName)`. These will -be all included in the auto-generated `"some_style.h"` files which will -result in a high potential for direct or indirect symbol name clashes. +all be included in the auto-generated `"some_style.h"` files which +results in a high potential for direct or indirect symbol name clashes. In the ideal case, the header would only include one file defining the parent class. That would typically be either `#include "pointers.h"` for @@ -85,7 +85,7 @@ be employed. The full definition will then be included into the corresponding implementation file. In the given example from above, the header file would be called `some_name.h` and the implementation `some_name.cpp` (all lower case with underscores, while the class itself would be in camel case -and no underscores, and the style name with lower case names separated by +and no underscores `SomeName`, and the style name with lower case names separated by a forward slash). ### Implementation Files @@ -124,9 +124,9 @@ which include files should be added or removed. ## Legacy Code -A lot of code predates the application of the rules in this document, -and those rules are a moving target as well. So there is going to be -significant chunks of code, that does not fully comply. This applies +A lot of code predates the application of the rules in this document +and the rules themselves are a moving target. So there are going to be +significant chunks of code that do not fully comply. This applies for example to the USER-REAXC, or the USER-ATC package. The LAMMPS developers are dedicated to make an effort to improve the compliance and welcome volunteers wanting to help with the process. -- GitLab From 5d4016c285a1ff930a1e2dfaea055a0bc9f6e74b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 5 Jul 2019 14:42:46 -0400 Subject: [PATCH 189/469] cleaning up includes of ASPHERE package --- src/ASPHERE/compute_erotate_asphere.cpp | 1 - src/ASPHERE/compute_temp_asphere.cpp | 1 - src/ASPHERE/fix_nh_asphere.cpp | 5 ----- src/ASPHERE/fix_nve_asphere.cpp | 6 ------ src/ASPHERE/fix_nve_asphere_noforce.cpp | 6 ------ src/ASPHERE/fix_nve_line.cpp | 3 --- src/ASPHERE/fix_nve_tri.cpp | 3 --- src/ASPHERE/pair_gayberne.cpp | 5 +---- 8 files changed, 1 insertion(+), 29 deletions(-) diff --git a/src/ASPHERE/compute_erotate_asphere.cpp b/src/ASPHERE/compute_erotate_asphere.cpp index 665506acdf..3cf23b87eb 100644 --- a/src/ASPHERE/compute_erotate_asphere.cpp +++ b/src/ASPHERE/compute_erotate_asphere.cpp @@ -20,7 +20,6 @@ #include "atom_vec_tri.h" #include "update.h" #include "force.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/ASPHERE/compute_temp_asphere.cpp b/src/ASPHERE/compute_temp_asphere.cpp index 32773b2925..d591e2ca81 100644 --- a/src/ASPHERE/compute_temp_asphere.cpp +++ b/src/ASPHERE/compute_temp_asphere.cpp @@ -26,7 +26,6 @@ #include "domain.h" #include "modify.h" #include "group.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/ASPHERE/fix_nh_asphere.cpp b/src/ASPHERE/fix_nh_asphere.cpp index 9e8e9d73d9..2f8f11978e 100644 --- a/src/ASPHERE/fix_nh_asphere.cpp +++ b/src/ASPHERE/fix_nh_asphere.cpp @@ -16,14 +16,9 @@ ------------------------------------------------------------------------- */ #include "fix_nh_asphere.h" -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" -#include "group.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/ASPHERE/fix_nve_asphere.cpp b/src/ASPHERE/fix_nve_asphere.cpp index 05219e442f..93ccf008f4 100644 --- a/src/ASPHERE/fix_nve_asphere.cpp +++ b/src/ASPHERE/fix_nve_asphere.cpp @@ -16,15 +16,9 @@ ------------------------------------------------------------------------- */ #include "fix_nve_asphere.h" -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" -#include "force.h" -#include "update.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/ASPHERE/fix_nve_asphere_noforce.cpp b/src/ASPHERE/fix_nve_asphere_noforce.cpp index 015cc8cfb6..3a7d7e86e9 100644 --- a/src/ASPHERE/fix_nve_asphere_noforce.cpp +++ b/src/ASPHERE/fix_nve_asphere_noforce.cpp @@ -12,15 +12,9 @@ ------------------------------------------------------------------------- */ #include "fix_nve_asphere_noforce.h" -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" -#include "group.h" -#include "update.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/ASPHERE/fix_nve_line.cpp b/src/ASPHERE/fix_nve_line.cpp index 57335f22e0..5e17cb355f 100644 --- a/src/ASPHERE/fix_nve_line.cpp +++ b/src/ASPHERE/fix_nve_line.cpp @@ -12,9 +12,6 @@ ------------------------------------------------------------------------- */ #include "fix_nve_line.h" -#include -#include -#include #include "atom.h" #include "atom_vec_line.h" #include "domain.h" diff --git a/src/ASPHERE/fix_nve_tri.cpp b/src/ASPHERE/fix_nve_tri.cpp index b1f7667d06..797fea1c5b 100644 --- a/src/ASPHERE/fix_nve_tri.cpp +++ b/src/ASPHERE/fix_nve_tri.cpp @@ -12,9 +12,6 @@ ------------------------------------------------------------------------- */ #include "fix_nve_tri.h" -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_tri.h" diff --git a/src/ASPHERE/pair_gayberne.cpp b/src/ASPHERE/pair_gayberne.cpp index 7dbf11c5ea..93b164c503 100644 --- a/src/ASPHERE/pair_gayberne.cpp +++ b/src/ASPHERE/pair_gayberne.cpp @@ -16,10 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_gayberne.h" +#include #include -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" @@ -27,7 +25,6 @@ #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "integrate.h" #include "citeme.h" #include "memory.h" #include "error.h" -- GitLab From 2c0eeeb976075e6df3fc5362d2e06566cc20821c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 5 Jul 2019 14:43:20 -0400 Subject: [PATCH 190/469] one more chunk of files in src folder to be cleaned up --- src/universe.cpp | 1 - src/update.cpp | 5 ----- src/utils.cpp | 1 - src/velocity.cpp | 4 ---- src/verlet.cpp | 3 --- src/write_coeff.cpp | 1 + src/write_data.cpp | 1 - src/write_dump.cpp | 4 +--- 8 files changed, 2 insertions(+), 18 deletions(-) diff --git a/src/universe.cpp b/src/universe.cpp index 2a7117da51..a36b67d115 100644 --- a/src/universe.cpp +++ b/src/universe.cpp @@ -16,7 +16,6 @@ #include #include #include -#include #include "version.h" #include "error.h" #include "force.h" diff --git a/src/update.cpp b/src/update.cpp index e83f4d9f72..8a3e6f0d1d 100644 --- a/src/update.cpp +++ b/src/update.cpp @@ -13,21 +13,16 @@ #include "update.h" #include -#include #include "integrate.h" #include "min.h" #include "style_integrate.h" #include "style_minimize.h" #include "neighbor.h" -#include "neigh_list.h" #include "force.h" #include "modify.h" #include "fix.h" -#include "domain.h" -#include "region.h" #include "compute.h" #include "output.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/utils.cpp b/src/utils.cpp index ea2ab57f6f..f45a834bec 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "utils.h" -#include #include #include "lammps.h" #include "error.h" diff --git a/src/velocity.cpp b/src/velocity.cpp index 1a03f71128..e5985884f8 100644 --- a/src/velocity.cpp +++ b/src/velocity.cpp @@ -12,13 +12,9 @@ ------------------------------------------------------------------------- */ #include "velocity.h" -#include #include -#include -#include #include #include "atom.h" -#include "update.h" #include "domain.h" #include "lattice.h" #include "input.h" diff --git a/src/verlet.cpp b/src/verlet.cpp index 5ccef36259..8cd6fe940d 100644 --- a/src/verlet.cpp +++ b/src/verlet.cpp @@ -28,10 +28,7 @@ #include "output.h" #include "update.h" #include "modify.h" -#include "compute.h" -#include "fix.h" #include "timer.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/write_coeff.cpp b/src/write_coeff.cpp index 08ff964e7c..8e5b4fcb71 100644 --- a/src/write_coeff.cpp +++ b/src/write_coeff.cpp @@ -14,6 +14,7 @@ #include "write_coeff.h" #include #include +#include #include #include "pair.h" #include "bond.h" diff --git a/src/write_data.cpp b/src/write_data.cpp index b78e701d35..3d788b9665 100644 --- a/src/write_data.cpp +++ b/src/write_data.cpp @@ -16,7 +16,6 @@ #include #include "atom.h" #include "atom_vec.h" -#include "group.h" #include "force.h" #include "pair.h" #include "bond.h" diff --git a/src/write_dump.cpp b/src/write_dump.cpp index 903f0e0cdd..31ceb4cbbf 100644 --- a/src/write_dump.cpp +++ b/src/write_dump.cpp @@ -17,13 +17,11 @@ #include "write_dump.h" #include +#include #include "style_dump.h" #include "dump.h" #include "dump_image.h" -#include "atom.h" #include "comm.h" -#include "group.h" -#include "input.h" #include "update.h" #include "error.h" #include "utils.h" -- GitLab From 4db483339504396f084bf269db6b06862f2025cb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 5 Jul 2019 21:11:06 -0400 Subject: [PATCH 191/469] fix up includes for BODY package --- src/BODY/body_rounded_polygon.cpp | 2 +- src/BODY/body_rounded_polyhedron.cpp | 2 +- src/BODY/compute_body_local.cpp | 4 +--- src/BODY/compute_temp_body.cpp | 1 - src/BODY/fix_nh_body.cpp | 5 ----- src/BODY/fix_nve_body.cpp | 6 ------ src/BODY/fix_wall_body_polygon.cpp | 4 ---- src/BODY/fix_wall_body_polyhedron.cpp | 4 ---- src/BODY/pair_body_nparticle.cpp | 2 -- src/BODY/pair_body_rounded_polygon.cpp | 3 +-- src/BODY/pair_body_rounded_polyhedron.cpp | 5 +---- 11 files changed, 5 insertions(+), 33 deletions(-) diff --git a/src/BODY/body_rounded_polygon.cpp b/src/BODY/body_rounded_polygon.cpp index 21f1d7e221..caf7e4bb8c 100644 --- a/src/BODY/body_rounded_polygon.cpp +++ b/src/BODY/body_rounded_polygon.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "body_rounded_polygon.h" +#include #include -#include #include "my_pool_chunk.h" #include "atom_vec_body.h" #include "atom.h" diff --git a/src/BODY/body_rounded_polyhedron.cpp b/src/BODY/body_rounded_polyhedron.cpp index 15e1871e02..98f7913859 100644 --- a/src/BODY/body_rounded_polyhedron.cpp +++ b/src/BODY/body_rounded_polyhedron.cpp @@ -16,13 +16,13 @@ ------------------------------------------------------------------------- */ #include "body_rounded_polyhedron.h" +#include #include #include #include "my_pool_chunk.h" #include "atom_vec_body.h" #include "atom.h" #include "force.h" -#include "domain.h" #include "math_extra.h" #include "memory.h" #include "error.h" diff --git a/src/BODY/compute_body_local.cpp b/src/BODY/compute_body_local.cpp index f58b66c2ca..c12502df42 100644 --- a/src/BODY/compute_body_local.cpp +++ b/src/BODY/compute_body_local.cpp @@ -12,15 +12,13 @@ ------------------------------------------------------------------------- */ #include "compute_body_local.h" -#include +#include #include #include "atom.h" #include "atom_vec_body.h" #include "body.h" #include "update.h" -#include "domain.h" #include "force.h" -#include "bond.h" #include "memory.h" #include "error.h" diff --git a/src/BODY/compute_temp_body.cpp b/src/BODY/compute_temp_body.cpp index 7beca36df8..d9007f573d 100644 --- a/src/BODY/compute_temp_body.cpp +++ b/src/BODY/compute_temp_body.cpp @@ -27,7 +27,6 @@ #include "domain.h" #include "modify.h" #include "group.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/BODY/fix_nh_body.cpp b/src/BODY/fix_nh_body.cpp index 6064f1f9de..b9a0c81e15 100644 --- a/src/BODY/fix_nh_body.cpp +++ b/src/BODY/fix_nh_body.cpp @@ -17,14 +17,9 @@ ------------------------------------------------------------------------- */ #include "fix_nh_body.h" -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" -#include "group.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/BODY/fix_nve_body.cpp b/src/BODY/fix_nve_body.cpp index 3f3bd41cbc..185e397540 100644 --- a/src/BODY/fix_nve_body.cpp +++ b/src/BODY/fix_nve_body.cpp @@ -12,15 +12,9 @@ ------------------------------------------------------------------------- */ #include "fix_nve_body.h" -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" -#include "force.h" -#include "update.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/BODY/fix_wall_body_polygon.cpp b/src/BODY/fix_wall_body_polygon.cpp index 8f27a094cb..e51476de60 100644 --- a/src/BODY/fix_wall_body_polygon.cpp +++ b/src/BODY/fix_wall_body_polygon.cpp @@ -17,7 +17,6 @@ #include "fix_wall_body_polygon.h" #include -#include #include #include "atom.h" #include "atom_vec_body.h" @@ -25,9 +24,6 @@ #include "domain.h" #include "update.h" #include "force.h" -#include "pair.h" -#include "modify.h" -#include "respa.h" #include "math_const.h" #include "math_extra.h" #include "memory.h" diff --git a/src/BODY/fix_wall_body_polyhedron.cpp b/src/BODY/fix_wall_body_polyhedron.cpp index 37b542803f..42c62de436 100644 --- a/src/BODY/fix_wall_body_polyhedron.cpp +++ b/src/BODY/fix_wall_body_polyhedron.cpp @@ -17,7 +17,6 @@ #include "fix_wall_body_polyhedron.h" #include -#include #include #include "atom.h" #include "atom_vec_body.h" @@ -25,9 +24,6 @@ #include "domain.h" #include "update.h" #include "force.h" -#include "pair.h" -#include "modify.h" -#include "respa.h" #include "math_const.h" #include "math_extra.h" #include "memory.h" diff --git a/src/BODY/pair_body_nparticle.cpp b/src/BODY/pair_body_nparticle.cpp index 96a7af6255..bd7aba5455 100644 --- a/src/BODY/pair_body_nparticle.cpp +++ b/src/BODY/pair_body_nparticle.cpp @@ -13,8 +13,6 @@ #include "pair_body_nparticle.h" #include -#include -#include #include #include "math_extra.h" #include "atom.h" diff --git a/src/BODY/pair_body_rounded_polygon.cpp b/src/BODY/pair_body_rounded_polygon.cpp index c818b5a2e6..f5e18e9d89 100644 --- a/src/BODY/pair_body_rounded_polygon.cpp +++ b/src/BODY/pair_body_rounded_polygon.cpp @@ -19,9 +19,8 @@ ------------------------------------------------------------------------- */ #include "pair_body_rounded_polygon.h" +#include #include -#include -#include #include #include "math_extra.h" #include "atom.h" diff --git a/src/BODY/pair_body_rounded_polyhedron.cpp b/src/BODY/pair_body_rounded_polyhedron.cpp index 75caab88bd..2df58d45cd 100644 --- a/src/BODY/pair_body_rounded_polyhedron.cpp +++ b/src/BODY/pair_body_rounded_polyhedron.cpp @@ -21,11 +21,9 @@ ------------------------------------------------------------------------- */ #include "pair_body_rounded_polyhedron.h" +#include #include -#include -#include #include -#include "math_extra.h" #include "atom.h" #include "atom_vec_body.h" #include "body_rounded_polyhedron.h" @@ -41,7 +39,6 @@ #include "math_const.h" using namespace LAMMPS_NS; -using namespace MathExtra; using namespace MathConst; #define DELTA 10000 -- GitLab From a00d38572e425f7734cfd651959b760b36eb6b12 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 6 Jul 2019 06:29:22 -0400 Subject: [PATCH 192/469] clean up includes in packages CLASS2, COLLOID, COMPRESS, and CORESHELL --- src/CLASS2/angle_class2.cpp | 2 +- src/CLASS2/bond_class2.cpp | 3 +-- src/CLASS2/dihedral_class2.cpp | 3 +-- src/CLASS2/improper_class2.cpp | 3 +-- src/CLASS2/pair_lj_class2.cpp | 4 +--- src/CLASS2/pair_lj_class2_coul_cut.cpp | 3 +-- src/CLASS2/pair_lj_class2_coul_long.cpp | 4 +--- src/COLLOID/fix_wall_colloid.cpp | 4 +--- src/COLLOID/pair_brownian.cpp | 6 +----- src/COLLOID/pair_brownian_poly.cpp | 7 +------ src/COLLOID/pair_colloid.cpp | 5 +---- src/COLLOID/pair_lubricate.cpp | 6 +----- src/COLLOID/pair_lubricateU.cpp | 5 ----- src/COLLOID/pair_lubricateU_poly.cpp | 5 ----- src/COLLOID/pair_lubricate_poly.cpp | 6 +----- src/COLLOID/pair_yukawa_colloid.cpp | 3 --- src/COMPRESS/dump_xyz_gz.cpp | 1 - src/CORESHELL/compute_temp_cs.cpp | 3 --- src/CORESHELL/pair_born_coul_dsf_cs.cpp | 6 ------ src/CORESHELL/pair_born_coul_long_cs.cpp | 9 --------- src/CORESHELL/pair_born_coul_wolf_cs.cpp | 8 -------- src/CORESHELL/pair_buck_coul_long_cs.cpp | 10 ---------- src/CORESHELL/pair_coul_long_cs.cpp | 11 ----------- src/CORESHELL/pair_coul_wolf_cs.cpp | 8 -------- src/CORESHELL/pair_lj_cut_coul_long_cs.cpp | 14 -------------- 25 files changed, 13 insertions(+), 126 deletions(-) diff --git a/src/CLASS2/angle_class2.cpp b/src/CLASS2/angle_class2.cpp index 340152abd4..99e1b39c9d 100644 --- a/src/CLASS2/angle_class2.cpp +++ b/src/CLASS2/angle_class2.cpp @@ -16,9 +16,9 @@ ------------------------------------------------------------------------- */ #include "angle_class2.h" +#include #include #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/CLASS2/bond_class2.cpp b/src/CLASS2/bond_class2.cpp index 945555f772..cfc1a93bde 100644 --- a/src/CLASS2/bond_class2.cpp +++ b/src/CLASS2/bond_class2.cpp @@ -16,11 +16,10 @@ ------------------------------------------------------------------------- */ #include "bond_class2.h" +#include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/CLASS2/dihedral_class2.cpp b/src/CLASS2/dihedral_class2.cpp index c36d976525..725228666e 100644 --- a/src/CLASS2/dihedral_class2.cpp +++ b/src/CLASS2/dihedral_class2.cpp @@ -16,13 +16,12 @@ ------------------------------------------------------------------------- */ #include "dihedral_class2.h" +#include #include #include -#include #include "atom.h" #include "neighbor.h" #include "update.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "math_const.h" diff --git a/src/CLASS2/improper_class2.cpp b/src/CLASS2/improper_class2.cpp index aff37df318..ca7ac95239 100644 --- a/src/CLASS2/improper_class2.cpp +++ b/src/CLASS2/improper_class2.cpp @@ -16,13 +16,12 @@ ------------------------------------------------------------------------- */ #include "improper_class2.h" +#include #include #include -#include #include "atom.h" #include "neighbor.h" #include "update.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "math_const.h" diff --git a/src/CLASS2/pair_lj_class2.cpp b/src/CLASS2/pair_lj_class2.cpp index 9a67fafecb..a0088e52b7 100644 --- a/src/CLASS2/pair_lj_class2.cpp +++ b/src/CLASS2/pair_lj_class2.cpp @@ -10,9 +10,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_class2.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" @@ -21,7 +20,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory.h" diff --git a/src/CLASS2/pair_lj_class2_coul_cut.cpp b/src/CLASS2/pair_lj_class2_coul_cut.cpp index 24620611c6..e999a3682e 100644 --- a/src/CLASS2/pair_lj_class2_coul_cut.cpp +++ b/src/CLASS2/pair_lj_class2_coul_cut.cpp @@ -12,9 +12,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_class2_coul_cut.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/CLASS2/pair_lj_class2_coul_long.cpp b/src/CLASS2/pair_lj_class2_coul_long.cpp index cd11294327..b56c076996 100644 --- a/src/CLASS2/pair_lj_class2_coul_long.cpp +++ b/src/CLASS2/pair_lj_class2_coul_long.cpp @@ -12,16 +12,14 @@ ------------------------------------------------------------------------- */ #include "pair_lj_class2_coul_long.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/COLLOID/fix_wall_colloid.cpp b/src/COLLOID/fix_wall_colloid.cpp index f2e895c4f3..58593a99b1 100644 --- a/src/COLLOID/fix_wall_colloid.cpp +++ b/src/COLLOID/fix_wall_colloid.cpp @@ -16,12 +16,10 @@ ------------------------------------------------------------------------- */ #include "fix_wall_colloid.h" +#include #include -#include #include "atom.h" #include "atom_vec.h" -#include "update.h" -#include "respa.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/COLLOID/pair_brownian.cpp b/src/COLLOID/pair_brownian.cpp index f9185264e0..71a5f8c056 100644 --- a/src/COLLOID/pair_brownian.cpp +++ b/src/COLLOID/pair_brownian.cpp @@ -16,22 +16,18 @@ ------------------------------------------------------------------------- */ #include "pair_brownian.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "domain.h" #include "update.h" #include "modify.h" #include "fix.h" -#include "fix_deform.h" #include "fix_wall.h" #include "input.h" #include "variable.h" diff --git a/src/COLLOID/pair_brownian_poly.cpp b/src/COLLOID/pair_brownian_poly.cpp index 250dcef1fd..c3eb4f28a5 100644 --- a/src/COLLOID/pair_brownian_poly.cpp +++ b/src/COLLOID/pair_brownian_poly.cpp @@ -17,13 +17,10 @@ ------------------------------------------------------------------------- */ #include "pair_brownian_poly.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" @@ -32,14 +29,12 @@ #include "update.h" #include "modify.h" #include "fix.h" -#include "fix_deform.h" #include "fix_wall.h" #include "input.h" #include "variable.h" #include "random_mars.h" #include "math_const.h" #include "math_special.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/COLLOID/pair_colloid.cpp b/src/COLLOID/pair_colloid.cpp index 306cdfebdf..ad25184181 100644 --- a/src/COLLOID/pair_colloid.cpp +++ b/src/COLLOID/pair_colloid.cpp @@ -16,14 +16,11 @@ ------------------------------------------------------------------------- */ #include "pair_colloid.h" +#include #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "math_special.h" #include "memory.h" diff --git a/src/COLLOID/pair_lubricate.cpp b/src/COLLOID/pair_lubricate.cpp index ee55c6cbf5..4492de3cbb 100644 --- a/src/COLLOID/pair_lubricate.cpp +++ b/src/COLLOID/pair_lubricate.cpp @@ -17,17 +17,14 @@ ------------------------------------------------------------------------- */ #include "pair_lubricate.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "domain.h" #include "modify.h" #include "fix.h" @@ -35,7 +32,6 @@ #include "fix_wall.h" #include "input.h" #include "variable.h" -#include "random_mars.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/COLLOID/pair_lubricateU.cpp b/src/COLLOID/pair_lubricateU.cpp index be589167c9..4f7e3917e8 100644 --- a/src/COLLOID/pair_lubricateU.cpp +++ b/src/COLLOID/pair_lubricateU.cpp @@ -18,22 +18,17 @@ #include "pair_lubricateU.h" #include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "domain.h" #include "update.h" #include "math_const.h" #include "modify.h" #include "fix.h" -#include "fix_deform.h" #include "fix_wall.h" #include "input.h" #include "variable.h" diff --git a/src/COLLOID/pair_lubricateU_poly.cpp b/src/COLLOID/pair_lubricateU_poly.cpp index ebcf939cff..0f16d94300 100644 --- a/src/COLLOID/pair_lubricateU_poly.cpp +++ b/src/COLLOID/pair_lubricateU_poly.cpp @@ -20,21 +20,16 @@ #include "pair_lubricateU_poly.h" #include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "domain.h" -#include "update.h" #include "modify.h" #include "fix.h" -#include "fix_deform.h" #include "fix_wall.h" #include "input.h" #include "variable.h" diff --git a/src/COLLOID/pair_lubricate_poly.cpp b/src/COLLOID/pair_lubricate_poly.cpp index f1bfa0c695..e347441cf4 100644 --- a/src/COLLOID/pair_lubricate_poly.cpp +++ b/src/COLLOID/pair_lubricate_poly.cpp @@ -18,12 +18,10 @@ ------------------------------------------------------------------------- */ #include "pair_lubricate_poly.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "force.h" #include "neighbor.h" @@ -33,8 +31,6 @@ #include "modify.h" #include "fix.h" #include "fix_deform.h" -#include "memory.h" -#include "random_mars.h" #include "fix_wall.h" #include "input.h" #include "variable.h" diff --git a/src/COLLOID/pair_yukawa_colloid.cpp b/src/COLLOID/pair_yukawa_colloid.cpp index 98d0586925..1866fa60b5 100644 --- a/src/COLLOID/pair_yukawa_colloid.cpp +++ b/src/COLLOID/pair_yukawa_colloid.cpp @@ -17,14 +17,11 @@ #include "pair_yukawa_colloid.h" #include -#include #include "atom.h" #include "atom_vec.h" #include "force.h" -#include "comm.h" #include "neighbor.h" #include "neigh_list.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/COMPRESS/dump_xyz_gz.cpp b/src/COMPRESS/dump_xyz_gz.cpp index 7be1a10fe2..c76b7afa17 100644 --- a/src/COMPRESS/dump_xyz_gz.cpp +++ b/src/COMPRESS/dump_xyz_gz.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "dump_xyz_gz.h" -#include "domain.h" #include "error.h" #include "update.h" diff --git a/src/CORESHELL/compute_temp_cs.cpp b/src/CORESHELL/compute_temp_cs.cpp index 4217fe3410..cccccaf254 100644 --- a/src/CORESHELL/compute_temp_cs.cpp +++ b/src/CORESHELL/compute_temp_cs.cpp @@ -18,9 +18,7 @@ #include "compute_temp_cs.h" #include -#include #include -#include #include "atom.h" #include "atom_vec.h" #include "domain.h" @@ -28,7 +26,6 @@ #include "force.h" #include "group.h" #include "modify.h" -#include "fix.h" #include "fix_store.h" #include "comm.h" #include "memory.h" diff --git a/src/CORESHELL/pair_born_coul_dsf_cs.cpp b/src/CORESHELL/pair_born_coul_dsf_cs.cpp index cd932e560b..9440bca109 100644 --- a/src/CORESHELL/pair_born_coul_dsf_cs.cpp +++ b/src/CORESHELL/pair_born_coul_dsf_cs.cpp @@ -18,17 +18,11 @@ #include "pair_born_coul_dsf_cs.h" #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "math_const.h" -#include "memory.h" -#include "error.h" #include "math_special.h" using namespace LAMMPS_NS; diff --git a/src/CORESHELL/pair_born_coul_long_cs.cpp b/src/CORESHELL/pair_born_coul_long_cs.cpp index 2ef7fdb273..f6262fa9e7 100644 --- a/src/CORESHELL/pair_born_coul_long_cs.cpp +++ b/src/CORESHELL/pair_born_coul_long_cs.cpp @@ -17,21 +17,12 @@ #include "pair_born_coul_long_cs.h" #include -#include -#include #include #include "atom.h" -#include "comm.h" #include "force.h" -#include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" -#include "math_const.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; #define EWALD_F 1.12837917 #define EWALD_P 9.95473818e-1 diff --git a/src/CORESHELL/pair_born_coul_wolf_cs.cpp b/src/CORESHELL/pair_born_coul_wolf_cs.cpp index c0374e2ddb..398c2ba1ee 100644 --- a/src/CORESHELL/pair_born_coul_wolf_cs.cpp +++ b/src/CORESHELL/pair_born_coul_wolf_cs.cpp @@ -14,22 +14,14 @@ #include "pair_born_coul_wolf_cs.h" #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "math_const.h" -#include "math_special.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; using namespace MathConst; -using namespace MathSpecial; #define EPSILON 1.0e-20 diff --git a/src/CORESHELL/pair_buck_coul_long_cs.cpp b/src/CORESHELL/pair_buck_coul_long_cs.cpp index 6c897622fa..1392ec1880 100644 --- a/src/CORESHELL/pair_buck_coul_long_cs.cpp +++ b/src/CORESHELL/pair_buck_coul_long_cs.cpp @@ -17,21 +17,11 @@ #include "pair_buck_coul_long_cs.h" #include -#include -#include -#include #include "atom.h" -#include "comm.h" #include "force.h" -#include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" -#include "math_const.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; #define EWALD_F 1.12837917 #define EWALD_P 9.95473818e-1 diff --git a/src/CORESHELL/pair_coul_long_cs.cpp b/src/CORESHELL/pair_coul_long_cs.cpp index 6094ae072a..8280799389 100644 --- a/src/CORESHELL/pair_coul_long_cs.cpp +++ b/src/CORESHELL/pair_coul_long_cs.cpp @@ -17,20 +17,9 @@ #include "pair_coul_long_cs.h" #include -#include -#include -#include #include "atom.h" -#include "comm.h" #include "force.h" -#include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/CORESHELL/pair_coul_wolf_cs.cpp b/src/CORESHELL/pair_coul_wolf_cs.cpp index 40ade7bfe4..20b7339480 100644 --- a/src/CORESHELL/pair_coul_wolf_cs.cpp +++ b/src/CORESHELL/pair_coul_wolf_cs.cpp @@ -13,22 +13,14 @@ #include "pair_coul_wolf_cs.h" #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "math_const.h" -#include "math_special.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; using namespace MathConst; -using namespace MathSpecial; #define EPSILON 1.0e-20 diff --git a/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp b/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp index 3f20377cf1..7ad544051a 100644 --- a/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp +++ b/src/CORESHELL/pair_lj_cut_coul_long_cs.cpp @@ -17,25 +17,11 @@ #include "pair_lj_cut_coul_long_cs.h" #include -#include -#include -#include #include "atom.h" -#include "comm.h" #include "force.h" -#include "kspace.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "math_const.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; #define EWALD_F 1.12837917 #define EWALD_P 9.95473818e-1 -- GitLab From 316554297c15d1a5dc62f7d0649c6c5d8a6e9bae Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 6 Jul 2019 10:00:24 -0400 Subject: [PATCH 193/469] clean up includes in packages DIPOLE and GRANULAR --- src/DIPOLE/pair_lj_cut_dipole_cut.cpp | 2 +- src/DIPOLE/pair_lj_cut_dipole_long.cpp | 3 +-- src/DIPOLE/pair_lj_long_dipole_long.cpp | 6 +----- src/GRANULAR/fix_freeze.cpp | 2 +- src/GRANULAR/fix_pour.cpp | 2 +- src/GRANULAR/fix_wall_gran.cpp | 2 -- src/GRANULAR/fix_wall_gran_region.cpp | 7 ------- src/GRANULAR/pair_gran_hertz_history.cpp | 2 -- src/GRANULAR/pair_gran_hooke.cpp | 2 -- src/GRANULAR/pair_gran_hooke_history.cpp | 5 +---- src/GRANULAR/pair_granular.cpp | 5 +---- 11 files changed, 7 insertions(+), 31 deletions(-) diff --git a/src/DIPOLE/pair_lj_cut_dipole_cut.cpp b/src/DIPOLE/pair_lj_cut_dipole_cut.cpp index 44708edec9..14c511c100 100644 --- a/src/DIPOLE/pair_lj_cut_dipole_cut.cpp +++ b/src/DIPOLE/pair_lj_cut_dipole_cut.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_cut_dipole_cut.h" +#include #include -#include #include #include "atom.h" #include "neighbor.h" diff --git a/src/DIPOLE/pair_lj_cut_dipole_long.cpp b/src/DIPOLE/pair_lj_cut_dipole_long.cpp index 071dbaeb02..fe020ed2e6 100644 --- a/src/DIPOLE/pair_lj_cut_dipole_long.cpp +++ b/src/DIPOLE/pair_lj_cut_dipole_long.cpp @@ -12,9 +12,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_cut_dipole_long.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/DIPOLE/pair_lj_long_dipole_long.cpp b/src/DIPOLE/pair_lj_long_dipole_long.cpp index 1391cc1a1a..5e7819c2f4 100644 --- a/src/DIPOLE/pair_lj_long_dipole_long.cpp +++ b/src/DIPOLE/pair_lj_long_dipole_long.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_long_dipole_long.h" +#include #include -#include -#include #include #include "math_const.h" #include "math_vector.h" @@ -26,12 +25,9 @@ #include "comm.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" -#include "respa.h" #include "memory.h" #include "error.h" diff --git a/src/GRANULAR/fix_freeze.cpp b/src/GRANULAR/fix_freeze.cpp index e2345bdf19..1df5c9d0a8 100644 --- a/src/GRANULAR/fix_freeze.cpp +++ b/src/GRANULAR/fix_freeze.cpp @@ -12,11 +12,11 @@ ------------------------------------------------------------------------- */ #include "fix_freeze.h" +#include #include #include "atom.h" #include "update.h" #include "modify.h" -#include "comm.h" #include "respa.h" #include "error.h" diff --git a/src/GRANULAR/fix_pour.cpp b/src/GRANULAR/fix_pour.cpp index 0fe7493127..3b1bbcef35 100644 --- a/src/GRANULAR/fix_pour.cpp +++ b/src/GRANULAR/fix_pour.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include "fix_pour.h" +#include #include -#include #include #include "atom.h" #include "atom_vec.h" diff --git a/src/GRANULAR/fix_wall_gran.cpp b/src/GRANULAR/fix_wall_gran.cpp index b0fbc0c2b8..e7464a78a9 100644 --- a/src/GRANULAR/fix_wall_gran.cpp +++ b/src/GRANULAR/fix_wall_gran.cpp @@ -18,13 +18,11 @@ #include "fix_wall_gran.h" #include -#include #include #include "atom.h" #include "domain.h" #include "update.h" #include "force.h" -#include "pair.h" #include "modify.h" #include "respa.h" #include "math_const.h" diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index 97e889ddcc..a4b798d6aa 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -16,18 +16,12 @@ ------------------------------------------------------------------------- */ #include "fix_wall_gran_region.h" -#include -#include #include #include "region.h" #include "atom.h" #include "domain.h" #include "update.h" -#include "force.h" #include "pair.h" -#include "modify.h" -#include "respa.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "comm.h" @@ -35,7 +29,6 @@ using namespace LAMMPS_NS; using namespace FixConst; -using namespace MathConst; // same as FixWallGran diff --git a/src/GRANULAR/pair_gran_hertz_history.cpp b/src/GRANULAR/pair_gran_hertz_history.cpp index e303089e56..4a362c0928 100644 --- a/src/GRANULAR/pair_gran_hertz_history.cpp +++ b/src/GRANULAR/pair_gran_hertz_history.cpp @@ -17,8 +17,6 @@ #include "pair_gran_hertz_history.h" #include -#include -#include #include #include "atom.h" #include "update.h" diff --git a/src/GRANULAR/pair_gran_hooke.cpp b/src/GRANULAR/pair_gran_hooke.cpp index a30aa0bb6c..d4be320554 100644 --- a/src/GRANULAR/pair_gran_hooke.cpp +++ b/src/GRANULAR/pair_gran_hooke.cpp @@ -17,8 +17,6 @@ #include "pair_gran_hooke.h" #include -#include -#include #include "atom.h" #include "force.h" #include "fix.h" diff --git a/src/GRANULAR/pair_gran_hooke_history.cpp b/src/GRANULAR/pair_gran_hooke_history.cpp index f832fdfac3..771a5566df 100644 --- a/src/GRANULAR/pair_gran_hooke_history.cpp +++ b/src/GRANULAR/pair_gran_hooke_history.cpp @@ -16,13 +16,10 @@ ------------------------------------------------------------------------- */ #include "pair_gran_hooke_history.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" -#include "domain.h" #include "force.h" #include "update.h" #include "modify.h" diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 942587a676..e7b4c01f5e 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -17,13 +17,10 @@ See the README file in the top-level LAMMPS directory. ----------------------------------------------------------------------- */ #include "pair_granular.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" -#include "domain.h" #include "force.h" #include "update.h" #include "modify.h" -- GitLab From 61ed3b65b75c3781bce511cc00ff298b023965ab Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 6 Jul 2019 10:20:13 -0400 Subject: [PATCH 194/469] clean up includes in KSPACE package --- src/KSPACE/ewald.cpp | 3 --- src/KSPACE/ewald_dipole.cpp | 5 ----- src/KSPACE/ewald_dipole_spin.cpp | 7 ------- src/KSPACE/ewald_disp.cpp | 2 -- src/KSPACE/gridcomm.cpp | 2 -- src/KSPACE/msm.cpp | 2 -- src/KSPACE/msm_cg.cpp | 5 ----- src/KSPACE/pair_born_coul_long.cpp | 2 -- src/KSPACE/pair_born_coul_msm.cpp | 6 ------ src/KSPACE/pair_coul_long.cpp | 6 +----- src/KSPACE/pair_coul_msm.cpp | 7 ------- src/KSPACE/pair_lj_charmm_coul_long.cpp | 3 --- src/KSPACE/pair_lj_charmm_coul_msm.cpp | 7 ------- src/KSPACE/pair_lj_charmmfsw_coul_long.cpp | 4 ---- src/KSPACE/pair_lj_cut_coul_long.cpp | 3 --- src/KSPACE/pair_lj_cut_coul_msm.cpp | 9 --------- src/KSPACE/pair_lj_cut_tip4p_long.cpp | 7 +------ src/KSPACE/pair_lj_long_coul_long.cpp | 4 +--- src/KSPACE/pair_lj_long_tip4p_long.cpp | 7 +------ src/KSPACE/pair_tip4p_long.cpp | 7 +------ src/KSPACE/pppm.cpp | 2 -- src/KSPACE/pppm_cg.cpp | 2 +- src/KSPACE/pppm_dipole.cpp | 5 ----- src/KSPACE/pppm_dipole_spin.cpp | 10 ---------- src/KSPACE/pppm_disp.cpp | 2 -- src/KSPACE/pppm_disp_tip4p.cpp | 1 - src/KSPACE/pppm_stagger.cpp | 3 --- src/KSPACE/pppm_tip4p.cpp | 2 +- src/KSPACE/remap.cpp | 1 + 29 files changed, 8 insertions(+), 118 deletions(-) diff --git a/src/KSPACE/ewald.cpp b/src/KSPACE/ewald.cpp index aad0e364d0..d74d90b0d6 100644 --- a/src/KSPACE/ewald.cpp +++ b/src/KSPACE/ewald.cpp @@ -20,9 +20,6 @@ #include "ewald.h" #include -#include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/KSPACE/ewald_dipole.cpp b/src/KSPACE/ewald_dipole.cpp index 53bac0637f..c3442beef5 100644 --- a/src/KSPACE/ewald_dipole.cpp +++ b/src/KSPACE/ewald_dipole.cpp @@ -17,8 +17,6 @@ #include "ewald_dipole.h" #include -#include -#include #include #include #include "atom.h" @@ -32,9 +30,6 @@ #include "error.h" #include "update.h" -#include "math_const.h" -#include "math_special.h" - using namespace LAMMPS_NS; using namespace MathConst; using namespace MathSpecial; diff --git a/src/KSPACE/ewald_dipole_spin.cpp b/src/KSPACE/ewald_dipole_spin.cpp index 2b6c95f174..e7d67680a1 100644 --- a/src/KSPACE/ewald_dipole_spin.cpp +++ b/src/KSPACE/ewald_dipole_spin.cpp @@ -17,8 +17,6 @@ #include "ewald_dipole_spin.h" #include -#include -#include #include #include #include "atom.h" @@ -27,17 +25,12 @@ #include "pair.h" #include "domain.h" #include "math_const.h" -#include "math_special.h" #include "memory.h" #include "error.h" #include "update.h" -#include "math_const.h" -#include "math_special.h" - using namespace LAMMPS_NS; using namespace MathConst; -using namespace MathSpecial; #define SMALL 0.00001 diff --git a/src/KSPACE/ewald_disp.cpp b/src/KSPACE/ewald_disp.cpp index c775056dd8..a7ac66fdd3 100644 --- a/src/KSPACE/ewald_disp.cpp +++ b/src/KSPACE/ewald_disp.cpp @@ -18,8 +18,6 @@ #include "ewald_disp.h" #include #include -#include -#include #include #include "math_vector.h" #include "math_const.h" diff --git a/src/KSPACE/gridcomm.cpp b/src/KSPACE/gridcomm.cpp index 552d80daab..368e7370fe 100644 --- a/src/KSPACE/gridcomm.cpp +++ b/src/KSPACE/gridcomm.cpp @@ -13,10 +13,8 @@ #include "gridcomm.h" #include -#include "comm.h" #include "kspace.h" #include "memory.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/KSPACE/msm.cpp b/src/KSPACE/msm.cpp index bc5360dcd2..81dbabdbbd 100644 --- a/src/KSPACE/msm.cpp +++ b/src/KSPACE/msm.cpp @@ -18,8 +18,6 @@ #include "msm.h" #include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/KSPACE/msm_cg.cpp b/src/KSPACE/msm_cg.cpp index 22976b8442..9119d51878 100644 --- a/src/KSPACE/msm_cg.cpp +++ b/src/KSPACE/msm_cg.cpp @@ -18,8 +18,6 @@ #include "msm_cg.h" #include #include -#include -#include #include #include "atom.h" #include "gridcomm.h" @@ -29,10 +27,7 @@ #include "neighbor.h" #include "memory.h" -#include "math_const.h" - using namespace LAMMPS_NS; -using namespace MathConst; #define OFFSET 16384 #define SMALLQ 0.00001 diff --git a/src/KSPACE/pair_born_coul_long.cpp b/src/KSPACE/pair_born_coul_long.cpp index cb8360e401..e248a24ef7 100644 --- a/src/KSPACE/pair_born_coul_long.cpp +++ b/src/KSPACE/pair_born_coul_long.cpp @@ -17,8 +17,6 @@ #include "pair_born_coul_long.h" #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/KSPACE/pair_born_coul_msm.cpp b/src/KSPACE/pair_born_coul_msm.cpp index deaf224334..7300cd92e0 100644 --- a/src/KSPACE/pair_born_coul_msm.cpp +++ b/src/KSPACE/pair_born_coul_msm.cpp @@ -17,21 +17,15 @@ #include "pair_born_coul_msm.h" #include -#include -#include #include #include "atom.h" -#include "comm.h" #include "force.h" #include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/KSPACE/pair_coul_long.cpp b/src/KSPACE/pair_coul_long.cpp index cb45b7a906..7cedf3d003 100644 --- a/src/KSPACE/pair_coul_long.cpp +++ b/src/KSPACE/pair_coul_long.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_coul_long.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" @@ -26,9 +25,6 @@ #include "kspace.h" #include "neighbor.h" #include "neigh_list.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pair_coul_msm.cpp b/src/KSPACE/pair_coul_msm.cpp index 2173171e79..0917bb9275 100644 --- a/src/KSPACE/pair_coul_msm.cpp +++ b/src/KSPACE/pair_coul_msm.cpp @@ -17,18 +17,11 @@ #include "pair_coul_msm.h" #include -#include -#include #include #include "atom.h" -#include "comm.h" #include "force.h" #include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pair_lj_charmm_coul_long.cpp b/src/KSPACE/pair_lj_charmm_coul_long.cpp index 3ad14c8ea7..751ee77388 100644 --- a/src/KSPACE/pair_lj_charmm_coul_long.cpp +++ b/src/KSPACE/pair_lj_charmm_coul_long.cpp @@ -17,15 +17,12 @@ #include "pair_lj_charmm_coul_long.h" #include -#include -#include #include #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/KSPACE/pair_lj_charmm_coul_msm.cpp b/src/KSPACE/pair_lj_charmm_coul_msm.cpp index 2d1775802f..804ae5919d 100644 --- a/src/KSPACE/pair_lj_charmm_coul_msm.cpp +++ b/src/KSPACE/pair_lj_charmm_coul_msm.cpp @@ -17,19 +17,12 @@ #include "pair_lj_charmm_coul_msm.h" #include -#include -#include #include #include "atom.h" -#include "comm.h" #include "force.h" #include "kspace.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp b/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp index 7f32613cba..494a349768 100644 --- a/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp +++ b/src/KSPACE/pair_lj_charmmfsw_coul_long.cpp @@ -21,16 +21,12 @@ #include "pair_lj_charmmfsw_coul_long.h" #include -#include -#include #include #include "atom.h" -#include "update.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/KSPACE/pair_lj_cut_coul_long.cpp b/src/KSPACE/pair_lj_cut_coul_long.cpp index 59f4766fa3..7921c814c3 100644 --- a/src/KSPACE/pair_lj_cut_coul_long.cpp +++ b/src/KSPACE/pair_lj_cut_coul_long.cpp @@ -17,15 +17,12 @@ #include "pair_lj_cut_coul_long.h" #include -#include -#include #include #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/KSPACE/pair_lj_cut_coul_msm.cpp b/src/KSPACE/pair_lj_cut_coul_msm.cpp index 1305d485da..f8021cc180 100644 --- a/src/KSPACE/pair_lj_cut_coul_msm.cpp +++ b/src/KSPACE/pair_lj_cut_coul_msm.cpp @@ -17,25 +17,16 @@ #include "pair_lj_cut_coul_msm.h" #include -#include -#include #include #include "atom.h" -#include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" -#include "respa.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/KSPACE/pair_lj_cut_tip4p_long.cpp b/src/KSPACE/pair_lj_cut_tip4p_long.cpp index cd9b3c032d..c98092f19b 100644 --- a/src/KSPACE/pair_lj_cut_tip4p_long.cpp +++ b/src/KSPACE/pair_lj_cut_tip4p_long.cpp @@ -17,9 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_cut_tip4p_long.h" +#include #include -#include -#include #include #include "angle.h" #include "atom.h" @@ -27,12 +26,8 @@ #include "comm.h" #include "domain.h" #include "force.h" -#include "kspace.h" -#include "update.h" -#include "respa.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pair_lj_long_coul_long.cpp b/src/KSPACE/pair_lj_long_coul_long.cpp index 46dbb60a96..610fc4e89b 100644 --- a/src/KSPACE/pair_lj_long_coul_long.cpp +++ b/src/KSPACE/pair_lj_long_coul_long.cpp @@ -18,9 +18,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_long_coul_long.h" +#include #include -#include -#include #include #include "math_vector.h" #include "atom.h" @@ -31,7 +30,6 @@ #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pair_lj_long_tip4p_long.cpp b/src/KSPACE/pair_lj_long_tip4p_long.cpp index 5a1e347c78..08409dce72 100644 --- a/src/KSPACE/pair_lj_long_tip4p_long.cpp +++ b/src/KSPACE/pair_lj_long_tip4p_long.cpp @@ -17,9 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_long_tip4p_long.h" +#include #include -#include -#include #include #include "angle.h" #include "atom.h" @@ -27,12 +26,8 @@ #include "comm.h" #include "domain.h" #include "force.h" -#include "kspace.h" -#include "update.h" -#include "respa.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pair_tip4p_long.cpp b/src/KSPACE/pair_tip4p_long.cpp index deb8662a8b..2c47f42beb 100644 --- a/src/KSPACE/pair_tip4p_long.cpp +++ b/src/KSPACE/pair_tip4p_long.cpp @@ -17,9 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_tip4p_long.h" +#include #include -#include -#include #include #include "angle.h" #include "atom.h" @@ -27,12 +26,8 @@ #include "comm.h" #include "domain.h" #include "force.h" -#include "kspace.h" -#include "update.h" -#include "respa.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pppm.cpp b/src/KSPACE/pppm.cpp index ae545c5c27..90db943750 100644 --- a/src/KSPACE/pppm.cpp +++ b/src/KSPACE/pppm.cpp @@ -21,8 +21,6 @@ #include "pppm.h" #include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/KSPACE/pppm_cg.cpp b/src/KSPACE/pppm_cg.cpp index f9bd7b0cb4..bd23dedef1 100644 --- a/src/KSPACE/pppm_cg.cpp +++ b/src/KSPACE/pppm_cg.cpp @@ -18,7 +18,6 @@ #include "pppm_cg.h" #include #include -#include #include #include "atom.h" #include "gridcomm.h" @@ -28,6 +27,7 @@ #include "neighbor.h" #include "memory.h" #include "math_const.h" +#include "remap.h" using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/KSPACE/pppm_dipole.cpp b/src/KSPACE/pppm_dipole.cpp index ad03b8205a..0eb761d9be 100644 --- a/src/KSPACE/pppm_dipole.cpp +++ b/src/KSPACE/pppm_dipole.cpp @@ -18,17 +18,12 @@ #include "pppm_dipole.h" #include #include -#include -#include #include #include "atom.h" #include "comm.h" #include "gridcomm.h" -#include "neighbor.h" #include "force.h" #include "pair.h" -#include "bond.h" -#include "angle.h" #include "domain.h" #include "fft3d_wrap.h" #include "remap_wrap.h" diff --git a/src/KSPACE/pppm_dipole_spin.cpp b/src/KSPACE/pppm_dipole_spin.cpp index 2c96eadde1..9e9f07322c 100644 --- a/src/KSPACE/pppm_dipole_spin.cpp +++ b/src/KSPACE/pppm_dipole_spin.cpp @@ -18,30 +18,20 @@ #include "pppm_dipole_spin.h" #include #include -#include -#include -#include #include "atom.h" #include "comm.h" #include "gridcomm.h" -#include "neighbor.h" #include "force.h" #include "pair.h" -#include "bond.h" -#include "angle.h" #include "domain.h" -#include "fft3d_wrap.h" -#include "remap_wrap.h" #include "memory.h" #include "error.h" #include "update.h" #include "math_const.h" -#include "math_special.h" using namespace LAMMPS_NS; using namespace MathConst; -using namespace MathSpecial; #define MAXORDER 7 #define OFFSET 16384 diff --git a/src/KSPACE/pppm_disp.cpp b/src/KSPACE/pppm_disp.cpp index 22e570049c..d936025d04 100644 --- a/src/KSPACE/pppm_disp.cpp +++ b/src/KSPACE/pppm_disp.cpp @@ -19,8 +19,6 @@ #include "pppm_disp.h" #include #include -#include -#include #include #include "math_const.h" #include "atom.h" diff --git a/src/KSPACE/pppm_disp_tip4p.cpp b/src/KSPACE/pppm_disp_tip4p.cpp index 36e6159131..bc46152e2b 100644 --- a/src/KSPACE/pppm_disp_tip4p.cpp +++ b/src/KSPACE/pppm_disp_tip4p.cpp @@ -22,7 +22,6 @@ #include "atom.h" #include "domain.h" #include "force.h" -#include "memory.h" #include "error.h" #include "math_const.h" diff --git a/src/KSPACE/pppm_stagger.cpp b/src/KSPACE/pppm_stagger.cpp index 5c2e2a6098..7b708d0355 100644 --- a/src/KSPACE/pppm_stagger.cpp +++ b/src/KSPACE/pppm_stagger.cpp @@ -18,12 +18,9 @@ #include "pppm_stagger.h" #include #include -#include -#include #include #include "atom.h" #include "gridcomm.h" -#include "force.h" #include "domain.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pppm_tip4p.cpp b/src/KSPACE/pppm_tip4p.cpp index 52a1fb3787..f664a0dca3 100644 --- a/src/KSPACE/pppm_tip4p.cpp +++ b/src/KSPACE/pppm_tip4p.cpp @@ -16,11 +16,11 @@ ------------------------------------------------------------------------- */ #include "pppm_tip4p.h" +#include #include #include "atom.h" #include "domain.h" #include "force.h" -#include "memory.h" #include "error.h" #include "math_const.h" diff --git a/src/KSPACE/remap.cpp b/src/KSPACE/remap.cpp index 85fe78c9d7..d4cfdea2b0 100644 --- a/src/KSPACE/remap.cpp +++ b/src/KSPACE/remap.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include "remap.h" +#include #include #include -- GitLab From 35e2401099f2332e1a65d3a26c23fe685e1b06e5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 7 Jul 2019 03:56:44 -0400 Subject: [PATCH 195/469] clean up includes in MANYBODY package --- src/MANYBODY/fix_qeq_comb.cpp | 3 - src/MANYBODY/pair_adp.cpp | 2 +- src/MANYBODY/pair_airebo.cpp | 5 -- src/MANYBODY/pair_airebo.h | 1 - src/MANYBODY/pair_airebo_morse.cpp | 2 - src/MANYBODY/pair_atm.cpp | 1 + src/MANYBODY/pair_bop.cpp | 7 +- src/MANYBODY/pair_bop.h | 104 +++++++++++--------------- src/MANYBODY/pair_comb.cpp | 3 +- src/MANYBODY/pair_comb.h | 1 - src/MANYBODY/pair_comb3.cpp | 4 +- src/MANYBODY/pair_comb3.h | 1 - src/MANYBODY/pair_eam.cpp | 2 +- src/MANYBODY/pair_eam_alloy.cpp | 3 +- src/MANYBODY/pair_eam_cd.cpp | 3 +- src/MANYBODY/pair_eam_fs.cpp | 3 +- src/MANYBODY/pair_eim.cpp | 3 +- src/MANYBODY/pair_gw.cpp | 2 +- src/MANYBODY/pair_gw_zbl.cpp | 5 +- src/MANYBODY/pair_lcbop.cpp | 21 +----- src/MANYBODY/pair_lcbop.h | 1 - src/MANYBODY/pair_nb3b_harmonic.cpp | 4 +- src/MANYBODY/pair_polymorphic.cpp | 5 +- src/MANYBODY/pair_rebo.cpp | 2 +- src/MANYBODY/pair_sw.cpp | 10 +-- src/MANYBODY/pair_tersoff.cpp | 2 +- src/MANYBODY/pair_tersoff_mod.cpp | 8 +- src/MANYBODY/pair_tersoff_mod_c.cpp | 8 +- src/MANYBODY/pair_tersoff_zbl.cpp | 7 +- src/MANYBODY/pair_vashishta.cpp | 10 +-- src/MANYBODY/pair_vashishta_table.cpp | 9 +-- 31 files changed, 77 insertions(+), 165 deletions(-) diff --git a/src/MANYBODY/fix_qeq_comb.cpp b/src/MANYBODY/fix_qeq_comb.cpp index 9e9bbcc9d6..2f324bf097 100644 --- a/src/MANYBODY/fix_qeq_comb.cpp +++ b/src/MANYBODY/fix_qeq_comb.cpp @@ -18,13 +18,10 @@ #include "fix_qeq_comb.h" #include #include -#include #include #include "pair_comb.h" #include "pair_comb3.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/MANYBODY/pair_adp.cpp b/src/MANYBODY/pair_adp.cpp index 8051f97634..64c778659c 100644 --- a/src/MANYBODY/pair_adp.cpp +++ b/src/MANYBODY/pair_adp.cpp @@ -17,8 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_adp.h" +#include #include -#include #include #include #include "atom.h" diff --git a/src/MANYBODY/pair_airebo.cpp b/src/MANYBODY/pair_airebo.cpp index fd2016b7a7..818663222f 100644 --- a/src/MANYBODY/pair_airebo.cpp +++ b/src/MANYBODY/pair_airebo.cpp @@ -22,26 +22,21 @@ #include "pair_airebo.h" #include -#include -#include #include #include #include "atom.h" #include "neighbor.h" #include "force.h" #include "comm.h" -#include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "my_page.h" -#include "math_const.h" #include "math_special.h" #include "memory.h" #include "error.h" #include "utils.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace MathSpecial; #define MAXLINE 1024 diff --git a/src/MANYBODY/pair_airebo.h b/src/MANYBODY/pair_airebo.h index 8e92807afb..04d3fc399f 100644 --- a/src/MANYBODY/pair_airebo.h +++ b/src/MANYBODY/pair_airebo.h @@ -21,7 +21,6 @@ PairStyle(airebo,PairAIREBO) #define LMP_PAIR_AIREBO_H #include "pair.h" -#include "my_page.h" #include #include "math_const.h" diff --git a/src/MANYBODY/pair_airebo_morse.cpp b/src/MANYBODY/pair_airebo_morse.cpp index a39f7df82e..121f9557fd 100644 --- a/src/MANYBODY/pair_airebo_morse.cpp +++ b/src/MANYBODY/pair_airebo_morse.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "pair_airebo_morse.h" -#include "force.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/MANYBODY/pair_atm.cpp b/src/MANYBODY/pair_atm.cpp index ba68033721..e604f44003 100644 --- a/src/MANYBODY/pair_atm.cpp +++ b/src/MANYBODY/pair_atm.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "pair_atm.h" +#include #include #include "atom.h" #include "citeme.h" diff --git a/src/MANYBODY/pair_bop.cpp b/src/MANYBODY/pair_bop.cpp index 27c24ce3d7..38c33e5963 100644 --- a/src/MANYBODY/pair_bop.cpp +++ b/src/MANYBODY/pair_bop.cpp @@ -34,22 +34,17 @@ #include "pair_bop.h" #include -#include -#include #include +#include #include #include "atom.h" #include "neighbor.h" #include "neigh_request.h" #include "force.h" #include "comm.h" -#include "domain.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" -#include using namespace LAMMPS_NS; diff --git a/src/MANYBODY/pair_bop.h b/src/MANYBODY/pair_bop.h index 3bd9b8cea9..eca0ec52b8 100644 --- a/src/MANYBODY/pair_bop.h +++ b/src/MANYBODY/pair_bop.h @@ -26,8 +26,6 @@ PairStyle(bop,PairBOP) #define LMP_PAIR_BOP_H #include "pair.h" -#include -#include "update.h" namespace LAMMPS_NS { @@ -44,20 +42,20 @@ class PairBOP : public Pair { private: int me; - int maxneigh; // maximum size of neighbor list on this processor - int maxneigh3; // maximum size of neighbor list on this processor - int update_list; // check for changing maximum size of neighbor list - int maxbopn; // maximum size of bop neighbor list for allocation - int maxnall; // maximum size of bop neighbor list for allocation - int *map; // mapping from atom types to elements - int nelements; // # of unique elments - int nr; // increments for the BOP pair potential - int ntheta; // increments for the angle function - int npower; // power of the angular function - int nBOt; // second BO increments - int bop_types; // number of elments in potential - int npairs; // number of element pairs - char **elements; // names of unique elements + int maxneigh; // maximum size of neighbor list on this processor + int maxneigh3; // maximum size of neighbor list on this processor + int update_list; // check for changing maximum size of neighbor list + int maxbopn; // maximum size of bop neighbor list for allocation + int maxnall; // maximum size of bop neighbor list for allocation + int *map; // mapping from atom types to elements + int nelements; // # of unique elments + int nr; // increments for the BOP pair potential + int ntheta; // increments for the angle function + int npower; // power of the angular function + int nBOt; // second BO increments + int bop_types; // number of elments in potential + int npairs; // number of element pairs + char **elements; // names of unique elements int ***elem2param; int nparams; int bop_step; @@ -66,23 +64,22 @@ class PairBOP : public Pair { int allocate_neigh; int nb_pi,nb_sg; int ago1; -// int cnt1; - - int *BOP_index; // index for neighbor list position - int *BOP_total; // index for neighbor list position - int *BOP_index3; // index for neighbor list position - int *BOP_total3; // index for neighbor list position - int *neigh_index; // index for neighbor list position - int *neigh_index3; // index for neighbor list position - int neigh_total; // total number of neighbors stored - int neigh_total3; // total number of neighbors stored - int *cos_index; // index for neighbor cosine if not using on the fly - int *neigh_flag; // index for neighbor cosine if not using on the fly - int *neigh_flag3; // index for neighbor cosine if not using on the fly - int cos_total; // number of cosines stored if not using on the fly - int neigh_ct; // limit for large arrays - -/*Parameters variables*/ + + int *BOP_index; // index for neighbor list position + int *BOP_total; // index for neighbor list position + int *BOP_index3; // index for neighbor list position + int *BOP_total3; // index for neighbor list position + int *neigh_index; // index for neighbor list position + int *neigh_index3; // index for neighbor list position + int neigh_total; // total number of neighbors stored + int neigh_total3; // total number of neighbors stored + int *cos_index; // index for neighbor cosine if not using on the fly + int *neigh_flag; // index for neighbor cosine if not using on the fly + int *neigh_flag3; // index for neighbor cosine if not using on the fly + int cos_total; // number of cosines stored if not using on the fly + int neigh_ct; // limit for large arrays + + // Parameters variables int ncutoff,nfunc; int a_flag; @@ -98,51 +95,50 @@ class PairBOP : public Pair { double beta3,rsmall,rbig,rcore; char **words; - double cutmax; //max cutoff for all elements - int otfly; //Defines whether to do on the fly - //calculations of angles and distances - //on the fly will slow down calculations - //but requires less memory on = 1, off=0 + double cutmax; // max cutoff for all elements + int otfly; // Defines whether to do on the fly + // calculations of angles and distances + // on the fly will slow down calculations + // but requires less memory on = 1, off=0 -/* Neigh variables */ + // Neigh variables double *rcut,*rcut3,*dr,*rdr,*dr3,*rdr3; double *rcutsq,*rcutsq3; double **disij,*rij; double rcutall,rctroot; -/*Triple variables */ + // Triple variables double *cosAng,***dcosAng,***dcAng; -/*Double variables */ + // Double variables double *betaS,*dBetaS,*betaP; double *dBetaP,*repul,*dRepul; -/*Sigma variables */ + // Sigma variables int *itypeSigBk,nSigBk; double sigB,sigB_0; double sigB1; - -/*Pi variables */ + // Pi variables int *itypePiBk,nPiBk; double piB,piB_0; -/*Grids1 variables */ + // Grids1 variables double **pBetaS,**pBetaS1,**pBetaS2,**pBetaS3; double **pBetaS4,**pBetaS5,**pBetaS6; -/*Grids2 variables */ + // Grids2 variables double **pBetaP,**pBetaP1,**pBetaP2,**pBetaP3; double **pBetaP4,**pBetaP5,**pBetaP6; -/*Grids3 variables */ + // Grids3 variables double **pRepul,**pRepul1,**pRepul2,**pRepul3; double **pRepul4,**pRepul5,**pRepul6; @@ -155,13 +151,13 @@ class PairBOP : public Pair { double ****gfunc4,****gfunc5,****gfunc6; double dtheta,rdtheta; -/*Grids4 variables */ + // Grids4 variables double **FsigBO,**FsigBO1,**FsigBO2,**FsigBO3; double **FsigBO4,**FsigBO5,**FsigBO6; double dBO,rdBO; -/* End of BOP variables */ + // End of BOP variables double **rcmin,**rcmax,**rcmaxp; struct B_PI{ @@ -211,14 +207,6 @@ class PairBOP : public Pair { void memory_theta_destroy(); void memory_theta_grow(); double cutoff(double, double, int, double); -/* - double betaSfunc(int, double); - double dBetaSfunc(int, double, double, double); - double betaPfunc(int, double); - double dBetaPfunc(int, double, double, double); - double repulfunc(int, double); - double dRepulfunc(int, double, double, double); -*/ void read_table(char *); void allocate(); @@ -229,9 +217,7 @@ class PairBOP : public Pair { void grow_pi(int,int); void grow_sigma(int,int); }; - } - #endif #endif diff --git a/src/MANYBODY/pair_comb.cpp b/src/MANYBODY/pair_comb.cpp index b9a17eeb35..2fc4caec7b 100644 --- a/src/MANYBODY/pair_comb.cpp +++ b/src/MANYBODY/pair_comb.cpp @@ -19,8 +19,8 @@ ------------------------------------------------------------------------- */ #include "pair_comb.h" +#include #include -#include #include #include #include "atom.h" @@ -30,7 +30,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "group.h" -#include "update.h" #include "my_page.h" #include "math_const.h" #include "memory.h" diff --git a/src/MANYBODY/pair_comb.h b/src/MANYBODY/pair_comb.h index c798d5f347..19788dfab1 100644 --- a/src/MANYBODY/pair_comb.h +++ b/src/MANYBODY/pair_comb.h @@ -21,7 +21,6 @@ PairStyle(comb,PairComb) #define LMP_PAIR_COMB_H #include "pair.h" -#include "my_page.h" namespace LAMMPS_NS { diff --git a/src/MANYBODY/pair_comb3.cpp b/src/MANYBODY/pair_comb3.cpp index 846ef7d4b9..6f1732dbb7 100644 --- a/src/MANYBODY/pair_comb3.cpp +++ b/src/MANYBODY/pair_comb3.cpp @@ -18,18 +18,18 @@ ------------------------------------------------------------------------- */ #include "pair_comb3.h" +#include #include -#include #include #include #include "atom.h" #include "comm.h" #include "force.h" +#include "my_page.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "group.h" -#include "update.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/MANYBODY/pair_comb3.h b/src/MANYBODY/pair_comb3.h index 5d7e5d6beb..210f843139 100644 --- a/src/MANYBODY/pair_comb3.h +++ b/src/MANYBODY/pair_comb3.h @@ -21,7 +21,6 @@ PairStyle(comb3,PairComb3) #define LMP_PAIR_COMB3_H #include "pair.h" -#include "my_page.h" namespace LAMMPS_NS { diff --git a/src/MANYBODY/pair_eam.cpp b/src/MANYBODY/pair_eam.cpp index e6476b78c5..acb0e654d8 100644 --- a/src/MANYBODY/pair_eam.cpp +++ b/src/MANYBODY/pair_eam.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_eam.h" +#include #include -#include #include #include #include "atom.h" diff --git a/src/MANYBODY/pair_eam_alloy.cpp b/src/MANYBODY/pair_eam_alloy.cpp index 7aae786720..5b7f9877d7 100644 --- a/src/MANYBODY/pair_eam_alloy.cpp +++ b/src/MANYBODY/pair_eam_alloy.cpp @@ -16,8 +16,7 @@ ------------------------------------------------------------------------- */ #include "pair_eam_alloy.h" -#include -#include +#include #include #include "atom.h" #include "comm.h" diff --git a/src/MANYBODY/pair_eam_cd.cpp b/src/MANYBODY/pair_eam_cd.cpp index 55ad597cce..28004eae7f 100644 --- a/src/MANYBODY/pair_eam_cd.cpp +++ b/src/MANYBODY/pair_eam_cd.cpp @@ -18,14 +18,13 @@ ------------------------------------------------------------------------- */ #include "pair_eam_cd.h" +#include #include -#include #include #include #include "atom.h" #include "force.h" #include "comm.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/MANYBODY/pair_eam_fs.cpp b/src/MANYBODY/pair_eam_fs.cpp index 7b13988d0c..7e00783922 100644 --- a/src/MANYBODY/pair_eam_fs.cpp +++ b/src/MANYBODY/pair_eam_fs.cpp @@ -16,8 +16,7 @@ ------------------------------------------------------------------------- */ #include "pair_eam_fs.h" -#include -#include +#include #include #include "atom.h" #include "comm.h" diff --git a/src/MANYBODY/pair_eim.cpp b/src/MANYBODY/pair_eim.cpp index 58cb1fd2e0..dd65d92cdd 100644 --- a/src/MANYBODY/pair_eim.cpp +++ b/src/MANYBODY/pair_eim.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_eim.h" +#include #include -#include -#include #include #include "atom.h" #include "force.h" diff --git a/src/MANYBODY/pair_gw.cpp b/src/MANYBODY/pair_gw.cpp index 07e9201f94..667311812b 100644 --- a/src/MANYBODY/pair_gw.cpp +++ b/src/MANYBODY/pair_gw.cpp @@ -17,8 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_gw.h" +#include #include -#include #include #include #include "atom.h" diff --git a/src/MANYBODY/pair_gw_zbl.cpp b/src/MANYBODY/pair_gw_zbl.cpp index cd83727ed3..d39bf53b99 100644 --- a/src/MANYBODY/pair_gw_zbl.cpp +++ b/src/MANYBODY/pair_gw_zbl.cpp @@ -17,15 +17,12 @@ ------------------------------------------------------------------------- */ #include "pair_gw_zbl.h" +#include #include -#include #include #include #include "atom.h" #include "update.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "force.h" #include "comm.h" #include "memory.h" diff --git a/src/MANYBODY/pair_lcbop.cpp b/src/MANYBODY/pair_lcbop.cpp index b0240978a9..873a675cd9 100644 --- a/src/MANYBODY/pair_lcbop.cpp +++ b/src/MANYBODY/pair_lcbop.cpp @@ -17,26 +17,20 @@ ------------------------------------------------------------------------- */ #include "pair_lcbop.h" +#include #include -#include -#include #include -#include #include "atom.h" -#include "neighbor.h" -#include "neigh_request.h" #include "force.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "my_page.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; #define MAXLINE 1024 #define TOL 1.0e-9 @@ -1099,19 +1093,6 @@ void PairLCBOP::read_file(char *filename) init coefficients for TF_conj ------------------------------------------------------------------------- */ -#include -#include -#include -template< class function > void print_function( double x_0, double x_1, size_t n, function f, std::ostream &stream ) { - double dx = (x_1-x_0)/n; - for( double x=x_0; x<=x_1+0.0001; x+=dx ) { - double f_val, df; - f_val = f(x, &df); - stream << x << " " << f_val << " " << df << std::endl; - } - stream << std::endl; -} - void PairLCBOP::spline_init() { for( size_t N_conj_ij=0; N_conj_ij<2; N_conj_ij++ ) // N_conj_ij for( size_t N_ij=0; N_ij<4-1; N_ij++ ) diff --git a/src/MANYBODY/pair_lcbop.h b/src/MANYBODY/pair_lcbop.h index 0d7c7a51b1..c7a7fab46d 100644 --- a/src/MANYBODY/pair_lcbop.h +++ b/src/MANYBODY/pair_lcbop.h @@ -21,7 +21,6 @@ PairStyle(lcbop,PairLCBOP) #define LMP_PAIR_LCBOP_H #include "pair.h" -#include "my_page.h" #include #include "math_const.h" diff --git a/src/MANYBODY/pair_nb3b_harmonic.cpp b/src/MANYBODY/pair_nb3b_harmonic.cpp index ac20c3e61f..92456790cc 100644 --- a/src/MANYBODY/pair_nb3b_harmonic.cpp +++ b/src/MANYBODY/pair_nb3b_harmonic.cpp @@ -17,8 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_nb3b_harmonic.h" +#include #include -#include #include #include #include "atom.h" @@ -26,8 +26,6 @@ #include "neigh_request.h" #include "force.h" #include "comm.h" -#include "memory.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/MANYBODY/pair_polymorphic.cpp b/src/MANYBODY/pair_polymorphic.cpp index 0cca50823d..d3964b292c 100644 --- a/src/MANYBODY/pair_polymorphic.cpp +++ b/src/MANYBODY/pair_polymorphic.cpp @@ -17,8 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_polymorphic.h" +#include #include -#include #include #include #include "atom.h" @@ -30,10 +30,7 @@ #include "memory.h" #include "error.h" -#include "math_const.h" - using namespace LAMMPS_NS; -using namespace MathConst; #define MAXLINE 1024 #define DELTA 4 diff --git a/src/MANYBODY/pair_rebo.cpp b/src/MANYBODY/pair_rebo.cpp index e07a1b3495..06357d8368 100644 --- a/src/MANYBODY/pair_rebo.cpp +++ b/src/MANYBODY/pair_rebo.cpp @@ -26,7 +26,7 @@ PairREBO::PairREBO(LAMMPS *lmp) : PairAIREBO(lmp) { global settings ------------------------------------------------------------------------- */ -void PairREBO::settings(int narg, char **/*arg*/) +void PairREBO::settings(int narg, char ** /* arg */) { if (narg != 0) error->all(FLERR,"Illegal pair_style command"); diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index ea47fc97c3..f1d1a6fa9f 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -16,20 +16,18 @@ ------------------------------------------------------------------------- */ #include "pair_sw.h" +#include #include -#include #include #include #include "atom.h" -#include "neighbor.h" -#include "neigh_request.h" -#include "force.h" #include "comm.h" +#include "error.h" +#include "force.h" #include "memory.h" #include "neighbor.h" #include "neigh_list.h" -#include "memory.h" -#include "error.h" +#include "neigh_request.h" using namespace LAMMPS_NS; diff --git a/src/MANYBODY/pair_tersoff.cpp b/src/MANYBODY/pair_tersoff.cpp index 9d7f804f9a..62c74576e0 100644 --- a/src/MANYBODY/pair_tersoff.cpp +++ b/src/MANYBODY/pair_tersoff.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_tersoff.h" +#include #include -#include #include #include #include "atom.h" diff --git a/src/MANYBODY/pair_tersoff_mod.cpp b/src/MANYBODY/pair_tersoff_mod.cpp index df3c41fc33..698dd8fa03 100644 --- a/src/MANYBODY/pair_tersoff_mod.cpp +++ b/src/MANYBODY/pair_tersoff_mod.cpp @@ -17,21 +17,17 @@ ------------------------------------------------------------------------- */ #include "pair_tersoff_mod.h" +#include #include -#include #include #include #include "atom.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "force.h" #include "comm.h" +#include "math_const.h" #include "memory.h" #include "error.h" -#include "math_const.h" - using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/MANYBODY/pair_tersoff_mod_c.cpp b/src/MANYBODY/pair_tersoff_mod_c.cpp index d34291f6cd..6c2c4f4e7a 100644 --- a/src/MANYBODY/pair_tersoff_mod_c.cpp +++ b/src/MANYBODY/pair_tersoff_mod_c.cpp @@ -16,23 +16,17 @@ ------------------------------------------------------------------------- */ #include "pair_tersoff_mod_c.h" +#include #include -#include #include #include #include "atom.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "force.h" #include "comm.h" #include "memory.h" #include "error.h" -#include "math_const.h" - using namespace LAMMPS_NS; -using namespace MathConst; #define MAXLINE 1024 #define DELTA 4 diff --git a/src/MANYBODY/pair_tersoff_zbl.cpp b/src/MANYBODY/pair_tersoff_zbl.cpp index 6a8aa40782..ab06e6ec31 100644 --- a/src/MANYBODY/pair_tersoff_zbl.cpp +++ b/src/MANYBODY/pair_tersoff_zbl.cpp @@ -17,21 +17,18 @@ ------------------------------------------------------------------------- */ #include "pair_tersoff_zbl.h" +#include #include -#include #include #include #include "atom.h" #include "update.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "force.h" #include "comm.h" #include "memory.h" #include "error.h" - #include "math_const.h" + using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/MANYBODY/pair_vashishta.cpp b/src/MANYBODY/pair_vashishta.cpp index 5055dadfaf..13b44c58a4 100644 --- a/src/MANYBODY/pair_vashishta.cpp +++ b/src/MANYBODY/pair_vashishta.cpp @@ -17,20 +17,18 @@ ------------------------------------------------------------------------- */ #include "pair_vashishta.h" +#include #include -#include #include #include #include "atom.h" -#include "neighbor.h" -#include "neigh_request.h" -#include "force.h" #include "comm.h" +#include "error.h" +#include "force.h" #include "memory.h" #include "neighbor.h" #include "neigh_list.h" -#include "memory.h" -#include "error.h" +#include "neigh_request.h" using namespace LAMMPS_NS; diff --git a/src/MANYBODY/pair_vashishta_table.cpp b/src/MANYBODY/pair_vashishta_table.cpp index 726e0f83f1..bf39183b9d 100644 --- a/src/MANYBODY/pair_vashishta_table.cpp +++ b/src/MANYBODY/pair_vashishta_table.cpp @@ -16,20 +16,13 @@ ------------------------------------------------------------------------- */ #include "pair_vashishta_table.h" -#include #include -#include -#include #include "atom.h" -#include "neighbor.h" -#include "neigh_request.h" +#include "error.h" #include "force.h" #include "comm.h" #include "memory.h" -#include "neighbor.h" #include "neigh_list.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; -- GitLab From e5af9db84c7aee6f86e8cb1598fd99e65c4689d0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 7 Jul 2019 11:49:13 -0400 Subject: [PATCH 196/469] clean up includes in MC and MISC package --- src/MC/fix_atom_swap.cpp | 11 ++--------- src/MC/fix_bond_break.cpp | 4 ---- src/MC/fix_bond_create.cpp | 3 --- src/MC/fix_gcmc.cpp | 1 - src/MC/fix_tfmc.cpp | 1 - src/MC/pair_dsmc.cpp | 4 +--- src/MISC/compute_msd_nongauss.cpp | 3 +-- src/MISC/compute_ti.cpp | 1 - src/MISC/dump_xtc.cpp | 1 - src/MISC/fix_deposit.cpp | 2 +- src/MISC/fix_efield.cpp | 3 +-- src/MISC/fix_evaporate.cpp | 4 +--- src/MISC/fix_gld.cpp | 5 +---- src/MISC/fix_oneway.cpp | 1 - src/MISC/fix_orient_bcc.cpp | 1 - src/MISC/fix_orient_fcc.cpp | 1 - src/MISC/fix_thermal_conductivity.cpp | 2 -- src/MISC/fix_ttm.cpp | 2 -- src/MISC/fix_viscosity.cpp | 3 +-- src/MISC/pair_nm_cut.cpp | 3 +-- src/MISC/pair_nm_cut_coul_cut.cpp | 3 +-- src/MISC/pair_nm_cut_coul_long.cpp | 6 +----- src/MISC/xdr_compat.cpp | 1 - src/MISC/xdr_compat.h | 1 - 24 files changed, 12 insertions(+), 55 deletions(-) diff --git a/src/MC/fix_atom_swap.cpp b/src/MC/fix_atom_swap.cpp index c14efcca46..9a4a0b6a7f 100644 --- a/src/MC/fix_atom_swap.cpp +++ b/src/MC/fix_atom_swap.cpp @@ -17,13 +17,12 @@ ------------------------------------------------------------------------- */ #include "fix_atom_swap.h" +#include #include +#include #include -#include #include #include "atom.h" -#include "atom_vec.h" -#include "atom_vec_hybrid.h" #include "update.h" #include "modify.h" #include "fix.h" @@ -40,18 +39,12 @@ #include "dihedral.h" #include "improper.h" #include "kspace.h" -#include "math_const.h" #include "memory.h" #include "error.h" -#include "thermo.h" -#include "output.h" #include "neighbor.h" -#include -using namespace std; using namespace LAMMPS_NS; using namespace FixConst; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/MC/fix_bond_break.cpp b/src/MC/fix_bond_break.cpp index 1b07395f1e..2ff0e4126f 100644 --- a/src/MC/fix_bond_break.cpp +++ b/src/MC/fix_bond_break.cpp @@ -12,18 +12,14 @@ ------------------------------------------------------------------------- */ #include "fix_bond_break.h" -#include #include #include -#include #include "update.h" #include "respa.h" #include "atom.h" -#include "atom_vec.h" #include "force.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "random_mars.h" #include "memory.h" #include "error.h" diff --git a/src/MC/fix_bond_create.cpp b/src/MC/fix_bond_create.cpp index d2d93b67f6..3f63a22d60 100644 --- a/src/MC/fix_bond_create.cpp +++ b/src/MC/fix_bond_create.cpp @@ -12,14 +12,11 @@ ------------------------------------------------------------------------- */ #include "fix_bond_create.h" -#include #include #include -#include #include "update.h" #include "respa.h" #include "atom.h" -#include "atom_vec.h" #include "force.h" #include "pair.h" #include "comm.h" diff --git a/src/MC/fix_gcmc.cpp b/src/MC/fix_gcmc.cpp index 8fe6042c2e..1050fd4712 100644 --- a/src/MC/fix_gcmc.cpp +++ b/src/MC/fix_gcmc.cpp @@ -21,7 +21,6 @@ #include #include "atom.h" #include "atom_vec.h" -#include "atom_vec_hybrid.h" #include "molecule.h" #include "update.h" #include "modify.h" diff --git a/src/MC/fix_tfmc.cpp b/src/MC/fix_tfmc.cpp index 46c5e592ae..e57f1cdf4a 100644 --- a/src/MC/fix_tfmc.cpp +++ b/src/MC/fix_tfmc.cpp @@ -22,7 +22,6 @@ #include #include "atom.h" #include "force.h" -#include "update.h" #include "group.h" #include "random_mars.h" #include "comm.h" diff --git a/src/MC/pair_dsmc.cpp b/src/MC/pair_dsmc.cpp index cf48706133..43bffa7e8d 100644 --- a/src/MC/pair_dsmc.cpp +++ b/src/MC/pair_dsmc.cpp @@ -16,10 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_dsmc.h" +#include #include -#include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/MISC/compute_msd_nongauss.cpp b/src/MISC/compute_msd_nongauss.cpp index e02dd633cb..6123bf49af 100644 --- a/src/MISC/compute_msd_nongauss.cpp +++ b/src/MISC/compute_msd_nongauss.cpp @@ -16,13 +16,12 @@ ------------------------------------------------------------------------- */ #include "compute_msd_nongauss.h" -#include +#include #include "atom.h" #include "update.h" #include "group.h" #include "domain.h" #include "fix_store.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/MISC/compute_ti.cpp b/src/MISC/compute_ti.cpp index 266263785f..06188de238 100644 --- a/src/MISC/compute_ti.cpp +++ b/src/MISC/compute_ti.cpp @@ -20,7 +20,6 @@ #include #include "atom.h" #include "update.h" -#include "modify.h" #include "domain.h" #include "force.h" #include "pair.h" diff --git a/src/MISC/dump_xtc.cpp b/src/MISC/dump_xtc.cpp index 7abe4c4093..1a2b71ab6d 100644 --- a/src/MISC/dump_xtc.cpp +++ b/src/MISC/dump_xtc.cpp @@ -24,7 +24,6 @@ #include "dump_xtc.h" #include -#include #include #include #include diff --git a/src/MISC/fix_deposit.cpp b/src/MISC/fix_deposit.cpp index 22a144da60..c9d4958594 100644 --- a/src/MISC/fix_deposit.cpp +++ b/src/MISC/fix_deposit.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include "fix_deposit.h" +#include #include -#include #include #include "atom.h" #include "atom_vec.h" diff --git a/src/MISC/fix_efield.cpp b/src/MISC/fix_efield.cpp index 87ece82f57..5a13b93b91 100644 --- a/src/MISC/fix_efield.cpp +++ b/src/MISC/fix_efield.cpp @@ -17,9 +17,8 @@ ------------------------------------------------------------------------- */ #include "fix_efield.h" -#include +#include #include -#include #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/MISC/fix_evaporate.cpp b/src/MISC/fix_evaporate.cpp index e2c7844853..d868254c50 100644 --- a/src/MISC/fix_evaporate.cpp +++ b/src/MISC/fix_evaporate.cpp @@ -12,8 +12,7 @@ ------------------------------------------------------------------------- */ #include "fix_evaporate.h" -#include -#include +#include #include #include "atom.h" #include "atom_vec.h" @@ -25,7 +24,6 @@ #include "force.h" #include "group.h" #include "random_park.h" -#include "random_mars.h" #include "memory.h" #include "error.h" diff --git a/src/MISC/fix_gld.cpp b/src/MISC/fix_gld.cpp index 265ee4fb09..380c038e4a 100644 --- a/src/MISC/fix_gld.cpp +++ b/src/MISC/fix_gld.cpp @@ -17,17 +17,14 @@ ------------------------------------------------------------------------- */ #include "fix_gld.h" +#include #include -#include #include -#include "math_extra.h" #include "atom.h" #include "force.h" #include "update.h" #include "respa.h" #include "comm.h" -#include "input.h" -#include "variable.h" #include "random_mars.h" #include "memory.h" #include "error.h" diff --git a/src/MISC/fix_oneway.cpp b/src/MISC/fix_oneway.cpp index fcf5a7a0bd..68a27b68be 100644 --- a/src/MISC/fix_oneway.cpp +++ b/src/MISC/fix_oneway.cpp @@ -22,7 +22,6 @@ #include "error.h" #include "force.h" #include "region.h" -#include "error.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/MISC/fix_orient_bcc.cpp b/src/MISC/fix_orient_bcc.cpp index a300631658..1453ceb317 100644 --- a/src/MISC/fix_orient_bcc.cpp +++ b/src/MISC/fix_orient_bcc.cpp @@ -30,7 +30,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "comm.h" -#include "output.h" #include "force.h" #include "math_const.h" #include "citeme.h" diff --git a/src/MISC/fix_orient_fcc.cpp b/src/MISC/fix_orient_fcc.cpp index d898f95d2c..082ecaf459 100644 --- a/src/MISC/fix_orient_fcc.cpp +++ b/src/MISC/fix_orient_fcc.cpp @@ -27,7 +27,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "comm.h" -#include "output.h" #include "force.h" #include "math_const.h" #include "citeme.h" diff --git a/src/MISC/fix_thermal_conductivity.cpp b/src/MISC/fix_thermal_conductivity.cpp index 8da303c8ab..d0add6fecb 100644 --- a/src/MISC/fix_thermal_conductivity.cpp +++ b/src/MISC/fix_thermal_conductivity.cpp @@ -17,10 +17,8 @@ ------------------------------------------------------------------------- */ #include "fix_thermal_conductivity.h" -#include #include #include -#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/MISC/fix_ttm.cpp b/src/MISC/fix_ttm.cpp index 06de732de6..eb9eb2620d 100644 --- a/src/MISC/fix_ttm.cpp +++ b/src/MISC/fix_ttm.cpp @@ -20,12 +20,10 @@ #include #include #include -#include #include "atom.h" #include "force.h" #include "update.h" #include "domain.h" -#include "region.h" #include "respa.h" #include "comm.h" #include "random_mars.h" diff --git a/src/MISC/fix_viscosity.cpp b/src/MISC/fix_viscosity.cpp index 52107954c2..d5a97cd4b0 100644 --- a/src/MISC/fix_viscosity.cpp +++ b/src/MISC/fix_viscosity.cpp @@ -17,10 +17,9 @@ ------------------------------------------------------------------------- */ #include "fix_viscosity.h" -#include #include +#include #include -#include #include "atom.h" #include "domain.h" #include "modify.h" diff --git a/src/MISC/pair_nm_cut.cpp b/src/MISC/pair_nm_cut.cpp index 9b8c36da3a..a084491a78 100644 --- a/src/MISC/pair_nm_cut.cpp +++ b/src/MISC/pair_nm_cut.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_nm_cut.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/MISC/pair_nm_cut_coul_cut.cpp b/src/MISC/pair_nm_cut_coul_cut.cpp index 069c363817..df8a34062a 100644 --- a/src/MISC/pair_nm_cut_coul_cut.cpp +++ b/src/MISC/pair_nm_cut_coul_cut.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_nm_cut_coul_cut.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/MISC/pair_nm_cut_coul_long.cpp b/src/MISC/pair_nm_cut_coul_long.cpp index b3d42b05f8..4109fb0d9e 100644 --- a/src/MISC/pair_nm_cut_coul_long.cpp +++ b/src/MISC/pair_nm_cut_coul_long.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "pair_nm_cut_coul_long.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" -#include "update.h" -#include "integrate.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/MISC/xdr_compat.cpp b/src/MISC/xdr_compat.cpp index e124d52d7b..9806b0bbd2 100644 --- a/src/MISC/xdr_compat.cpp +++ b/src/MISC/xdr_compat.cpp @@ -1,6 +1,5 @@ #include "xdr_compat.h" #include -#include #include /* This file is needed for systems, that do not provide XDR support diff --git a/src/MISC/xdr_compat.h b/src/MISC/xdr_compat.h index 3062235080..5dfa01e0e8 100644 --- a/src/MISC/xdr_compat.h +++ b/src/MISC/xdr_compat.h @@ -3,7 +3,6 @@ #include #include -#include #ifdef __cplusplus extern "C" { -- GitLab From 57a558854908efe838e9da312389b49080149862 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 7 Jul 2019 15:46:34 -0400 Subject: [PATCH 197/469] cleaning up include file handling in packages MOLECULE and PERI --- src/MOLECULE/angle_charmm.cpp | 2 +- src/MOLECULE/angle_cosine.cpp | 2 +- src/MOLECULE/angle_cosine_delta.cpp | 4 ---- src/MOLECULE/angle_cosine_periodic.cpp | 2 +- src/MOLECULE/angle_cosine_squared.cpp | 2 +- src/MOLECULE/angle_harmonic.cpp | 2 +- src/MOLECULE/angle_table.cpp | 1 + src/MOLECULE/atom_vec_template.cpp | 1 - src/MOLECULE/bond_fene.cpp | 3 +-- src/MOLECULE/bond_fene_expand.cpp | 3 +-- src/MOLECULE/bond_gromos.cpp | 4 +--- src/MOLECULE/bond_harmonic.cpp | 3 +-- src/MOLECULE/bond_morse.cpp | 3 +-- src/MOLECULE/bond_nonlinear.cpp | 3 +-- src/MOLECULE/bond_quartic.cpp | 4 +--- src/MOLECULE/bond_table.cpp | 2 +- src/MOLECULE/dihedral_charmm.cpp | 2 -- src/MOLECULE/dihedral_charmmfsw.cpp | 2 -- src/MOLECULE/dihedral_harmonic.cpp | 2 -- src/MOLECULE/dihedral_helix.cpp | 2 -- src/MOLECULE/dihedral_multi_harmonic.cpp | 3 +-- src/MOLECULE/dihedral_opls.cpp | 3 +-- src/MOLECULE/fix_cmap.cpp | 4 ---- src/MOLECULE/improper_cvff.cpp | 2 -- src/MOLECULE/improper_harmonic.cpp | 2 -- src/MOLECULE/improper_umbrella.cpp | 2 -- src/MOLECULE/pair_hbond_dreiding_lj.cpp | 3 --- src/MOLECULE/pair_hbond_dreiding_morse.cpp | 3 --- src/MOLECULE/pair_lj_charmm_coul_charmm.cpp | 3 +-- .../pair_lj_charmm_coul_charmm_implicit.cpp | 2 -- .../pair_lj_charmmfsw_coul_charmmfsh.cpp | 3 +-- src/MOLECULE/pair_lj_cut_tip4p_cut.cpp | 2 +- src/MOLECULE/pair_tip4p_cut.cpp | 4 +--- src/PERI/compute_damage_atom.cpp | 2 -- src/PERI/compute_dilatation_atom.cpp | 4 +--- src/PERI/compute_plasticity_atom.cpp | 3 +-- src/PERI/fix_peri_neigh.cpp | 3 +-- src/PERI/pair_peri_eps.cpp | 16 +++++++--------- src/PERI/pair_peri_lps.cpp | 4 +--- src/PERI/pair_peri_pmb.cpp | 4 +--- src/PERI/pair_peri_ves.cpp | 16 ++++++++-------- 41 files changed, 40 insertions(+), 97 deletions(-) diff --git a/src/MOLECULE/angle_charmm.cpp b/src/MOLECULE/angle_charmm.cpp index fb0afd78c3..8a45f29368 100644 --- a/src/MOLECULE/angle_charmm.cpp +++ b/src/MOLECULE/angle_charmm.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "angle_charmm.h" +#include #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_cosine.cpp b/src/MOLECULE/angle_cosine.cpp index aff5130323..645cf66ff2 100644 --- a/src/MOLECULE/angle_cosine.cpp +++ b/src/MOLECULE/angle_cosine.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include "angle_cosine.h" +#include #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_cosine_delta.cpp b/src/MOLECULE/angle_cosine_delta.cpp index 13ed00b327..679a8deb0e 100644 --- a/src/MOLECULE/angle_cosine_delta.cpp +++ b/src/MOLECULE/angle_cosine_delta.cpp @@ -17,14 +17,10 @@ #include "angle_cosine_delta.h" #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" -#include "comm.h" #include "force.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/MOLECULE/angle_cosine_periodic.cpp b/src/MOLECULE/angle_cosine_periodic.cpp index 9f7c02cabc..22c2f7ce8b 100644 --- a/src/MOLECULE/angle_cosine_periodic.cpp +++ b/src/MOLECULE/angle_cosine_periodic.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_periodic.h" +#include #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_cosine_squared.cpp b/src/MOLECULE/angle_cosine_squared.cpp index 789a536c98..56b3ee58cf 100644 --- a/src/MOLECULE/angle_cosine_squared.cpp +++ b/src/MOLECULE/angle_cosine_squared.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_squared.h" +#include #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_harmonic.cpp b/src/MOLECULE/angle_harmonic.cpp index b626bdfae5..2e96884c9d 100644 --- a/src/MOLECULE/angle_harmonic.cpp +++ b/src/MOLECULE/angle_harmonic.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ #include "angle_harmonic.h" +#include #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/MOLECULE/angle_table.cpp b/src/MOLECULE/angle_table.cpp index ce7fcdcaf2..f05a8c6a4e 100644 --- a/src/MOLECULE/angle_table.cpp +++ b/src/MOLECULE/angle_table.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "angle_table.h" +#include #include #include #include diff --git a/src/MOLECULE/atom_vec_template.cpp b/src/MOLECULE/atom_vec_template.cpp index 6a12027b7b..4c5f576943 100644 --- a/src/MOLECULE/atom_vec_template.cpp +++ b/src/MOLECULE/atom_vec_template.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "atom_vec_template.h" -#include #include #include "atom.h" #include "molecule.h" diff --git a/src/MOLECULE/bond_fene.cpp b/src/MOLECULE/bond_fene.cpp index d4f2a4010e..776291701b 100644 --- a/src/MOLECULE/bond_fene.cpp +++ b/src/MOLECULE/bond_fene.cpp @@ -12,11 +12,10 @@ ------------------------------------------------------------------------- */ #include "bond_fene.h" +#include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "update.h" #include "force.h" diff --git a/src/MOLECULE/bond_fene_expand.cpp b/src/MOLECULE/bond_fene_expand.cpp index 3e4ceab42c..d03dfd9125 100644 --- a/src/MOLECULE/bond_fene_expand.cpp +++ b/src/MOLECULE/bond_fene_expand.cpp @@ -12,11 +12,10 @@ ------------------------------------------------------------------------- */ #include "bond_fene_expand.h" +#include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "update.h" #include "force.h" diff --git a/src/MOLECULE/bond_gromos.cpp b/src/MOLECULE/bond_gromos.cpp index 44e99d8fe0..284c9202fd 100644 --- a/src/MOLECULE/bond_gromos.cpp +++ b/src/MOLECULE/bond_gromos.cpp @@ -16,12 +16,10 @@ ------------------------------------------------------------------------- */ #include "bond_gromos.h" -#include -#include +#include #include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/MOLECULE/bond_harmonic.cpp b/src/MOLECULE/bond_harmonic.cpp index bbbad4102d..7b19034629 100644 --- a/src/MOLECULE/bond_harmonic.cpp +++ b/src/MOLECULE/bond_harmonic.cpp @@ -12,12 +12,11 @@ ------------------------------------------------------------------------- */ #include "bond_harmonic.h" +#include #include -#include #include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/MOLECULE/bond_morse.cpp b/src/MOLECULE/bond_morse.cpp index af476d6fe8..6e16070cae 100644 --- a/src/MOLECULE/bond_morse.cpp +++ b/src/MOLECULE/bond_morse.cpp @@ -16,11 +16,10 @@ ------------------------------------------------------------------------- */ #include "bond_morse.h" +#include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/MOLECULE/bond_nonlinear.cpp b/src/MOLECULE/bond_nonlinear.cpp index 89ddb7b118..e06b1b9aac 100644 --- a/src/MOLECULE/bond_nonlinear.cpp +++ b/src/MOLECULE/bond_nonlinear.cpp @@ -12,11 +12,10 @@ ------------------------------------------------------------------------- */ #include "bond_nonlinear.h" +#include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/MOLECULE/bond_quartic.cpp b/src/MOLECULE/bond_quartic.cpp index 34b3ad8288..352b642bbe 100644 --- a/src/MOLECULE/bond_quartic.cpp +++ b/src/MOLECULE/bond_quartic.cpp @@ -16,13 +16,11 @@ ------------------------------------------------------------------------- */ #include "bond_quartic.h" +#include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" -#include "update.h" #include "force.h" #include "pair.h" #include "memory.h" diff --git a/src/MOLECULE/bond_table.cpp b/src/MOLECULE/bond_table.cpp index e80baee6e8..137690d002 100644 --- a/src/MOLECULE/bond_table.cpp +++ b/src/MOLECULE/bond_table.cpp @@ -16,12 +16,12 @@ ------------------------------------------------------------------------- */ #include "bond_table.h" +#include #include #include #include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/MOLECULE/dihedral_charmm.cpp b/src/MOLECULE/dihedral_charmm.cpp index 1905c14358..8cc0713024 100644 --- a/src/MOLECULE/dihedral_charmm.cpp +++ b/src/MOLECULE/dihedral_charmm.cpp @@ -18,12 +18,10 @@ #include "dihedral_charmm.h" #include #include -#include #include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "pair.h" #include "update.h" diff --git a/src/MOLECULE/dihedral_charmmfsw.cpp b/src/MOLECULE/dihedral_charmmfsw.cpp index 9b02b908d6..f384c4cd36 100644 --- a/src/MOLECULE/dihedral_charmmfsw.cpp +++ b/src/MOLECULE/dihedral_charmmfsw.cpp @@ -21,12 +21,10 @@ #include "dihedral_charmmfsw.h" #include #include -#include #include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "pair.h" #include "update.h" diff --git a/src/MOLECULE/dihedral_harmonic.cpp b/src/MOLECULE/dihedral_harmonic.cpp index 159636ecd5..f1e5811a84 100644 --- a/src/MOLECULE/dihedral_harmonic.cpp +++ b/src/MOLECULE/dihedral_harmonic.cpp @@ -18,11 +18,9 @@ #include "dihedral_harmonic.h" #include #include -#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "memory.h" diff --git a/src/MOLECULE/dihedral_helix.cpp b/src/MOLECULE/dihedral_helix.cpp index a7d2aba1d6..56f7a3b5e8 100644 --- a/src/MOLECULE/dihedral_helix.cpp +++ b/src/MOLECULE/dihedral_helix.cpp @@ -19,10 +19,8 @@ #include "dihedral_helix.h" #include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "update.h" diff --git a/src/MOLECULE/dihedral_multi_harmonic.cpp b/src/MOLECULE/dihedral_multi_harmonic.cpp index ba98cf6ddf..eda7cede3e 100644 --- a/src/MOLECULE/dihedral_multi_harmonic.cpp +++ b/src/MOLECULE/dihedral_multi_harmonic.cpp @@ -16,11 +16,10 @@ ------------------------------------------------------------------------- */ #include "dihedral_multi_harmonic.h" +#include #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "update.h" diff --git a/src/MOLECULE/dihedral_opls.cpp b/src/MOLECULE/dihedral_opls.cpp index d68eba0bec..556efd850a 100644 --- a/src/MOLECULE/dihedral_opls.cpp +++ b/src/MOLECULE/dihedral_opls.cpp @@ -16,12 +16,11 @@ ------------------------------------------------------------------------- */ #include "dihedral_opls.h" +#include #include -#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "memory.h" diff --git a/src/MOLECULE/fix_cmap.cpp b/src/MOLECULE/fix_cmap.cpp index 3d5bf90bdc..fb0a550898 100644 --- a/src/MOLECULE/fix_cmap.cpp +++ b/src/MOLECULE/fix_cmap.cpp @@ -32,15 +32,11 @@ #include #include #include -#include #include "atom.h" -#include "atom_vec.h" #include "update.h" #include "respa.h" -#include "modify.h" #include "domain.h" #include "force.h" -#include "group.h" #include "comm.h" #include "math_const.h" #include "memory.h" diff --git a/src/MOLECULE/improper_cvff.cpp b/src/MOLECULE/improper_cvff.cpp index fd24ab69c3..abd2d4e11e 100644 --- a/src/MOLECULE/improper_cvff.cpp +++ b/src/MOLECULE/improper_cvff.cpp @@ -14,11 +14,9 @@ #include "improper_cvff.h" #include #include -#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "memory.h" diff --git a/src/MOLECULE/improper_harmonic.cpp b/src/MOLECULE/improper_harmonic.cpp index 936c22e94a..778fe646e1 100644 --- a/src/MOLECULE/improper_harmonic.cpp +++ b/src/MOLECULE/improper_harmonic.cpp @@ -14,11 +14,9 @@ #include "improper_harmonic.h" #include #include -#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "math_const.h" diff --git a/src/MOLECULE/improper_umbrella.cpp b/src/MOLECULE/improper_umbrella.cpp index 2e41ac6493..d3adf19993 100644 --- a/src/MOLECULE/improper_umbrella.cpp +++ b/src/MOLECULE/improper_umbrella.cpp @@ -18,11 +18,9 @@ #include "improper_umbrella.h" #include #include -#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "math_const.h" diff --git a/src/MOLECULE/pair_hbond_dreiding_lj.cpp b/src/MOLECULE/pair_hbond_dreiding_lj.cpp index 58666f27d1..53c3101708 100644 --- a/src/MOLECULE/pair_hbond_dreiding_lj.cpp +++ b/src/MOLECULE/pair_hbond_dreiding_lj.cpp @@ -17,13 +17,10 @@ #include "pair_hbond_dreiding_lj.h" #include -#include -#include #include #include "atom.h" #include "atom_vec.h" #include "molecule.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MOLECULE/pair_hbond_dreiding_morse.cpp b/src/MOLECULE/pair_hbond_dreiding_morse.cpp index 120a2d8d55..3039a662e6 100644 --- a/src/MOLECULE/pair_hbond_dreiding_morse.cpp +++ b/src/MOLECULE/pair_hbond_dreiding_morse.cpp @@ -17,13 +17,10 @@ #include "pair_hbond_dreiding_morse.h" #include -#include -#include #include #include "atom.h" #include "atom_vec.h" #include "molecule.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_request.h" diff --git a/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp b/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp index c9becb75c3..5ebfe0a110 100644 --- a/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp +++ b/src/MOLECULE/pair_lj_charmm_coul_charmm.cpp @@ -16,9 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_charmm_coul_charmm.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp b/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp index a2be2936b2..ff7dbb290b 100644 --- a/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp +++ b/src/MOLECULE/pair_lj_charmm_coul_charmm_implicit.cpp @@ -12,8 +12,6 @@ ------------------------------------------------------------------------- */ #include "pair_lj_charmm_coul_charmm_implicit.h" -#include -#include #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp b/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp index f2f16c88ce..4fb7cc5229 100644 --- a/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp +++ b/src/MOLECULE/pair_lj_charmmfsw_coul_charmmfsh.cpp @@ -20,9 +20,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_charmmfsw_coul_charmmfsh.h" +#include #include -#include -#include #include #include "atom.h" #include "update.h" diff --git a/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp b/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp index 5bb82d7635..e5f25a511b 100644 --- a/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp +++ b/src/MOLECULE/pair_lj_cut_tip4p_cut.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_cut_tip4p_cut.h" +#include #include -#include #include #include "atom.h" #include "force.h" diff --git a/src/MOLECULE/pair_tip4p_cut.cpp b/src/MOLECULE/pair_tip4p_cut.cpp index 1511c09384..3a6702c9b2 100644 --- a/src/MOLECULE/pair_tip4p_cut.cpp +++ b/src/MOLECULE/pair_tip4p_cut.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_tip4p_cut.h" +#include #include -#include #include "atom.h" #include "force.h" #include "neighbor.h" @@ -26,12 +26,10 @@ #include "angle.h" #include "bond.h" #include "comm.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/PERI/compute_damage_atom.cpp b/src/PERI/compute_damage_atom.cpp index f5a532cd0b..230b766725 100644 --- a/src/PERI/compute_damage_atom.cpp +++ b/src/PERI/compute_damage_atom.cpp @@ -21,8 +21,6 @@ #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" -#include "pair_peri_pmb.h" #include "fix_peri_neigh.h" #include "memory.h" #include "error.h" diff --git a/src/PERI/compute_dilatation_atom.cpp b/src/PERI/compute_dilatation_atom.cpp index 7a6607d65c..095f619838 100644 --- a/src/PERI/compute_dilatation_atom.cpp +++ b/src/PERI/compute_dilatation_atom.cpp @@ -21,13 +21,11 @@ #include "update.h" #include "modify.h" #include "comm.h" +#include "fix.h" #include "force.h" -#include "pair.h" #include "pair_peri_lps.h" -#include "pair_peri_pmb.h" #include "pair_peri_ves.h" #include "pair_peri_eps.h" -#include "fix_peri_neigh.h" #include "memory.h" #include "error.h" diff --git a/src/PERI/compute_plasticity_atom.cpp b/src/PERI/compute_plasticity_atom.cpp index 0b20bc5075..e312630b62 100644 --- a/src/PERI/compute_plasticity_atom.cpp +++ b/src/PERI/compute_plasticity_atom.cpp @@ -21,9 +21,8 @@ #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" -#include "pair_peri_pmb.h" #include "fix_peri_neigh.h" +#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/PERI/fix_peri_neigh.cpp b/src/PERI/fix_peri_neigh.cpp index 297936577f..70f46dcdc1 100644 --- a/src/PERI/fix_peri_neigh.cpp +++ b/src/PERI/fix_peri_neigh.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "fix_peri_neigh.h" +#include #include -#include "pair_peri_pmb.h" #include "pair_peri_lps.h" #include "pair_peri_ves.h" #include "pair_peri_eps.h" @@ -25,7 +25,6 @@ #include "domain.h" #include "force.h" #include "comm.h" -#include "update.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/PERI/pair_peri_eps.cpp b/src/PERI/pair_peri_eps.cpp index 07314081da..2579a9b75a 100644 --- a/src/PERI/pair_peri_eps.cpp +++ b/src/PERI/pair_peri_eps.cpp @@ -16,14 +16,13 @@ ------------------------------------------------------------------------- */ #include "pair_peri_eps.h" +#include #include -#include #include #include "atom.h" #include "domain.h" #include "lattice.h" #include "force.h" -#include "update.h" #include "modify.h" #include "fix.h" #include "fix_peri_neigh.h" @@ -32,7 +31,6 @@ #include "neigh_list.h" #include "memory.h" #include "error.h" -#include "update.h" using namespace LAMMPS_NS; @@ -451,12 +449,12 @@ void PairPeriEPS::coeff(int narg, char **arg) force->bounds(FLERR,arg[0],atom->ntypes,ilo,ihi); force->bounds(FLERR,arg[1],atom->ntypes,jlo,jhi); - double bulkmodulus_one = atof(arg[2]); - double shearmodulus_one = atof(arg[3]); - double cut_one = atof(arg[4]); - double s00_one = atof(arg[5]); - double alpha_one = atof(arg[6]); - double myieldstress_one = atof(arg[7]); + double bulkmodulus_one = force->numeric(FLERR,arg[2]); + double shearmodulus_one = force->numeric(FLERR,arg[3]); + double cut_one = force->numeric(FLERR,arg[4]); + double s00_one = force->numeric(FLERR,arg[5]); + double alpha_one = force->numeric(FLERR,arg[6]); + double myieldstress_one = force->numeric(FLERR,arg[7]); int count = 0; for (int i = ilo; i <= ihi; i++) { diff --git a/src/PERI/pair_peri_lps.cpp b/src/PERI/pair_peri_lps.cpp index 660209f3f5..f32ce5fb1c 100644 --- a/src/PERI/pair_peri_lps.cpp +++ b/src/PERI/pair_peri_lps.cpp @@ -16,14 +16,13 @@ ------------------------------------------------------------------------- */ #include "pair_peri_lps.h" +#include #include -#include #include #include "atom.h" #include "domain.h" #include "lattice.h" #include "force.h" -#include "update.h" #include "modify.h" #include "fix.h" #include "fix_peri_neigh.h" @@ -32,7 +31,6 @@ #include "neigh_list.h" #include "memory.h" #include "error.h" -#include "update.h" #include "math_const.h" using namespace LAMMPS_NS; diff --git a/src/PERI/pair_peri_pmb.cpp b/src/PERI/pair_peri_pmb.cpp index fa53efc344..ceab40d88d 100644 --- a/src/PERI/pair_peri_pmb.cpp +++ b/src/PERI/pair_peri_pmb.cpp @@ -16,22 +16,20 @@ ------------------------------------------------------------------------- */ #include "pair_peri_pmb.h" +#include #include #include -#include #include #include "atom.h" #include "domain.h" #include "lattice.h" #include "force.h" -#include "update.h" #include "modify.h" #include "fix.h" #include "fix_peri_neigh.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" diff --git a/src/PERI/pair_peri_ves.cpp b/src/PERI/pair_peri_ves.cpp index 1687bed35d..930ecc6812 100644 --- a/src/PERI/pair_peri_ves.cpp +++ b/src/PERI/pair_peri_ves.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "pair_peri_ves.h" +#include #include #include #include @@ -23,7 +24,6 @@ #include "domain.h" #include "lattice.h" #include "force.h" -#include "update.h" #include "modify.h" #include "fix.h" #include "fix_peri_neigh.h" @@ -428,13 +428,13 @@ void PairPeriVES::coeff(int narg, char **arg) force->bounds(FLERR,arg[0],atom->ntypes,ilo,ihi); force->bounds(FLERR,arg[1],atom->ntypes,jlo,jhi); - double bulkmodulus_one = atof(arg[2]); - double shearmodulus_one = atof(arg[3]); - double cut_one = atof(arg[4]); - double s00_one = atof(arg[5]); - double alpha_one = atof(arg[6]); - double mlambdai_one = atof(arg[7]); - double mtaui_one = atof(arg[8]); + double bulkmodulus_one = force->numeric(FLERR,arg[2]); + double shearmodulus_one = force->numeric(FLERR,arg[3]); + double cut_one = force->numeric(FLERR,arg[4]); + double s00_one = force->numeric(FLERR,arg[5]); + double alpha_one = force->numeric(FLERR,arg[6]); + double mlambdai_one = force->numeric(FLERR,arg[7]); + double mtaui_one = force->numeric(FLERR,arg[8]); int count = 0; for (int i = ilo; i <= ihi; i++) { -- GitLab From 15e1b39531f6d7f17d748b1e1358f5839ffba641 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 7 Jul 2019 15:52:21 -0400 Subject: [PATCH 198/469] validate more numbers read from data files through using force->numeric()/force->inumeric() instead of atof()/atoi() --- src/DIPOLE/atom_vec_dipole.cpp | 18 ++++---- src/KOKKOS/atom_vec_angle_kokkos.cpp | 8 ++-- src/KOKKOS/atom_vec_atomic_kokkos.cpp | 4 +- src/KOKKOS/atom_vec_bond_kokkos.cpp | 8 ++-- src/KOKKOS/atom_vec_charge_kokkos.cpp | 8 ++-- src/KOKKOS/atom_vec_dpd_kokkos.cpp | 6 +-- src/KOKKOS/atom_vec_full_kokkos.cpp | 12 ++--- src/KOKKOS/atom_vec_hybrid_kokkos.cpp | 8 ++-- src/KOKKOS/atom_vec_molecular_kokkos.cpp | 8 ++-- src/KOKKOS/atom_vec_sphere_kokkos.cpp | 28 ++++++------ src/MOLECULE/atom_vec_angle.cpp | 2 +- src/MOLECULE/atom_vec_bond.cpp | 2 +- src/MOLECULE/atom_vec_full.cpp | 6 +-- src/MOLECULE/atom_vec_molecular.cpp | 2 +- src/MOLECULE/atom_vec_template.cpp | 10 ++-- src/PERI/atom_vec_peri.cpp | 10 ++-- src/SPIN/atom_vec_spin.cpp | 18 ++++---- src/USER-AWPMD/atom_vec_wavepacket.cpp | 36 +++++++-------- src/USER-DPD/atom_vec_dpd.cpp | 6 +-- src/USER-EFF/atom_vec_electron.cpp | 24 +++++----- src/USER-MESO/atom_vec_edpd.cpp | 6 +-- src/USER-MESO/atom_vec_mdpd.cpp | 6 +-- src/USER-MESO/atom_vec_tdpd.cpp | 2 +- src/USER-SMD/atom_vec_smd.cpp | 28 ++++++------ src/USER-SPH/atom_vec_meso.cpp | 14 +++--- src/atom_vec.cpp | 6 +-- src/atom_vec_atomic.cpp | 2 +- src/atom_vec_body.cpp | 28 ++++++------ src/atom_vec_charge.cpp | 6 +-- src/atom_vec_ellipsoid.cpp | 42 ++++++++--------- src/atom_vec_hybrid.cpp | 8 ++-- src/atom_vec_line.cpp | 36 +++++++-------- src/atom_vec_sphere.cpp | 28 ++++++------ src/atom_vec_tri.cpp | 58 ++++++++++++------------ 34 files changed, 247 insertions(+), 247 deletions(-) diff --git a/src/DIPOLE/atom_vec_dipole.cpp b/src/DIPOLE/atom_vec_dipole.cpp index c304ae3bc6..c6f8fbb432 100644 --- a/src/DIPOLE/atom_vec_dipole.cpp +++ b/src/DIPOLE/atom_vec_dipole.cpp @@ -780,19 +780,19 @@ void AtomVecDipole::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = atof(values[2]); + q[nlocal] = force->numeric(FLERR,values[2]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; x[nlocal][2] = coord[2]; - mu[nlocal][0] = atof(values[6]); - mu[nlocal][1] = atof(values[7]); - mu[nlocal][2] = atof(values[8]); + mu[nlocal][0] = force->numeric(FLERR,values[6]); + mu[nlocal][1] = force->numeric(FLERR,values[7]); + mu[nlocal][2] = force->numeric(FLERR,values[8]); mu[nlocal][3] = sqrt(mu[nlocal][0]*mu[nlocal][0] + mu[nlocal][1]*mu[nlocal][1] + mu[nlocal][2]*mu[nlocal][2]); @@ -814,10 +814,10 @@ void AtomVecDipole::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecDipole::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = atof(values[0]); - mu[nlocal][0] = atof(values[1]); - mu[nlocal][1] = atof(values[2]); - mu[nlocal][2] = atof(values[3]); + q[nlocal] = force->numeric(FLERR,values[0]); + mu[nlocal][0] = force->numeric(FLERR,values[1]); + mu[nlocal][1] = force->numeric(FLERR,values[2]); + mu[nlocal][2] = force->numeric(FLERR,values[3]); mu[nlocal][3] = sqrt(mu[nlocal][0]*mu[nlocal][0] + mu[nlocal][1]*mu[nlocal][1] + mu[nlocal][2]*mu[nlocal][2]); diff --git a/src/KOKKOS/atom_vec_angle_kokkos.cpp b/src/KOKKOS/atom_vec_angle_kokkos.cpp index e4f27e733a..36fa47c712 100644 --- a/src/KOKKOS/atom_vec_angle_kokkos.cpp +++ b/src/KOKKOS/atom_vec_angle_kokkos.cpp @@ -1632,9 +1632,9 @@ void AtomVecAngleKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = atoi(values[0]); - h_molecule(nlocal) = atoi(values[1]); - h_type(nlocal) = atoi(values[2]); + h_tag(nlocal) = force->inumeric(FLERR,values[0]); + h_molecule(nlocal) = force->inumeric(FLERR,values[1]); + h_type(nlocal) = force->inumeric(FLERR,values[2]); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1661,7 +1661,7 @@ void AtomVecAngleKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecAngleKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = atoi(values[0]); + h_molecule(nlocal) = force->inumeric(FLERR,values[0]); h_num_bond(nlocal) = 0; h_num_angle(nlocal) = 0; return 1; diff --git a/src/KOKKOS/atom_vec_atomic_kokkos.cpp b/src/KOKKOS/atom_vec_atomic_kokkos.cpp index 95e4ddd72b..61703d1cc8 100644 --- a/src/KOKKOS/atom_vec_atomic_kokkos.cpp +++ b/src/KOKKOS/atom_vec_atomic_kokkos.cpp @@ -823,8 +823,8 @@ void AtomVecAtomicKokkos::data_atom(double *coord, tagint imagetmp, int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - h_tag[nlocal] = atoi(values[0]); - h_type[nlocal] = atoi(values[1]); + h_tag[nlocal] = force->inumeric(FLERR,values[0]); + h_type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/KOKKOS/atom_vec_bond_kokkos.cpp b/src/KOKKOS/atom_vec_bond_kokkos.cpp index 92311d5d09..bbf9f58b58 100644 --- a/src/KOKKOS/atom_vec_bond_kokkos.cpp +++ b/src/KOKKOS/atom_vec_bond_kokkos.cpp @@ -1058,9 +1058,9 @@ void AtomVecBondKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = atoi(values[0]); - h_molecule(nlocal) = atoi(values[1]); - h_type(nlocal) = atoi(values[2]); + h_tag(nlocal) = force->inumeric(FLERR,values[0]); + h_molecule(nlocal) = force->inumeric(FLERR,values[1]); + h_type(nlocal) = force->inumeric(FLERR,values[2]); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1086,7 +1086,7 @@ void AtomVecBondKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecBondKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = atoi(values[0]); + h_molecule(nlocal) = force->inumeric(FLERR,values[0]); h_num_bond(nlocal) = 0; return 1; } diff --git a/src/KOKKOS/atom_vec_charge_kokkos.cpp b/src/KOKKOS/atom_vec_charge_kokkos.cpp index 31a690f521..be267d8b16 100644 --- a/src/KOKKOS/atom_vec_charge_kokkos.cpp +++ b/src/KOKKOS/atom_vec_charge_kokkos.cpp @@ -959,12 +959,12 @@ void AtomVecChargeKokkos::data_atom(double *coord, imageint imagetmp, int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - h_tag[nlocal] = atoi(values[0]); - h_type[nlocal] = atoi(values[1]); + h_tag[nlocal] = force->inumeric(FLERR,values[0]); + h_type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - h_q[nlocal] = atof(values[2]); + h_q[nlocal] = force->numeric(FLERR,values[2]); h_x(nlocal,0) = coord[0]; h_x(nlocal,1) = coord[1]; @@ -988,7 +988,7 @@ void AtomVecChargeKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecChargeKokkos::data_atom_hybrid(int nlocal, char **values) { - h_q[nlocal] = atof(values[0]); + h_q[nlocal] = force->numeric(FLERR,values[0]); return 1; } diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index 4034efee9e..ffbfc75a93 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -1723,11 +1723,11 @@ void AtomVecDPDKokkos::data_atom(double *coord, tagint imagetmp, if (nlocal == nmax) grow(0); h_tag[nlocal] = ATOTAGINT(values[0]); - h_type[nlocal] = atoi(values[1]); + h_type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - h_dpdTheta[nlocal] = atof(values[2]); + h_dpdTheta[nlocal] = force->numeric(FLERR,values[2]); if (h_dpdTheta[nlocal] <= 0) error->one(FLERR,"Internal temperature in Atoms section of date file must be > zero"); @@ -1761,7 +1761,7 @@ void AtomVecDPDKokkos::data_atom(double *coord, tagint imagetmp, int AtomVecDPDKokkos::data_atom_hybrid(int nlocal, char **values) { - h_dpdTheta(nlocal) = atof(values[0]); + h_dpdTheta(nlocal) = force->numeric(FLERR,values[0]); atomKK->modified(Host,DPDTHETA_MASK); diff --git a/src/KOKKOS/atom_vec_full_kokkos.cpp b/src/KOKKOS/atom_vec_full_kokkos.cpp index 034da88f73..1974c12ebb 100644 --- a/src/KOKKOS/atom_vec_full_kokkos.cpp +++ b/src/KOKKOS/atom_vec_full_kokkos.cpp @@ -1487,13 +1487,13 @@ void AtomVecFullKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = atoi(values[0]); - h_molecule(nlocal) = atoi(values[1]); - h_type(nlocal) = atoi(values[2]); + h_tag(nlocal) = force->inumeric(FLERR,values[0]); + h_molecule(nlocal) = force->inumeric(FLERR,values[1]); + h_type(nlocal) = force->inumeric(FLERR,values[2]); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - h_q(nlocal) = atof(values[3]); + h_q(nlocal) = force->numeric(FLERR,values[3]); h_x(nlocal,0) = coord[0]; h_x(nlocal,1) = coord[1]; @@ -1520,8 +1520,8 @@ void AtomVecFullKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecFullKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = atoi(values[0]); - h_q(nlocal) = atof(values[1]); + h_molecule(nlocal) = force->inumeric(FLERR,values[0]); + h_q(nlocal) = force->numeric(FLERR,values[1]); h_num_bond(nlocal) = 0; h_num_angle(nlocal) = 0; h_num_dihedral(nlocal) = 0; diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp index 03cbe1ee5e..88dbdd068a 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp @@ -975,7 +975,7 @@ void AtomVecHybridKokkos::data_atom(double *coord, imageint imagetmp, char **val if (nlocal == nmax) grow(0); h_tag[nlocal] = ATOTAGINT(values[0]); - h_type[nlocal] = atoi(values[1]); + h_type[nlocal] = force->inumeric(FLERR,values[1]); if (h_type[nlocal] <= 0 || h_type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom h_type in Atoms section of data file"); @@ -1019,9 +1019,9 @@ void AtomVecHybridKokkos::data_vel(int m, char **values) { atomKK->sync(Host,V_MASK); - h_v(m,0) = atof(values[0]); - h_v(m,1) = atof(values[1]); - h_v(m,2) = atof(values[2]); + h_v(m,0) = force->numeric(FLERR,values[0]); + h_v(m,1) = force->numeric(FLERR,values[1]); + h_v(m,2) = force->numeric(FLERR,values[2]); atomKK->modified(Host,V_MASK); diff --git a/src/KOKKOS/atom_vec_molecular_kokkos.cpp b/src/KOKKOS/atom_vec_molecular_kokkos.cpp index 9ac8ecd264..060228f37e 100644 --- a/src/KOKKOS/atom_vec_molecular_kokkos.cpp +++ b/src/KOKKOS/atom_vec_molecular_kokkos.cpp @@ -1891,9 +1891,9 @@ void AtomVecMolecularKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = atoi(values[0]); - h_molecule(nlocal) = atoi(values[1]); - h_type(nlocal) = atoi(values[2]); + h_tag(nlocal) = force->inumeric(FLERR,values[0]); + h_molecule(nlocal) = force->inumeric(FLERR,values[1]); + h_type(nlocal) = force->inumeric(FLERR,values[2]); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1922,7 +1922,7 @@ void AtomVecMolecularKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecMolecularKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = atoi(values[0]); + h_molecule(nlocal) = force->inumeric(FLERR,values[0]); h_num_bond(nlocal) = 0; h_num_angle(nlocal) = 0; h_num_dihedral(nlocal) = 0; diff --git a/src/KOKKOS/atom_vec_sphere_kokkos.cpp b/src/KOKKOS/atom_vec_sphere_kokkos.cpp index 9e8388488f..57dc7ef43d 100644 --- a/src/KOKKOS/atom_vec_sphere_kokkos.cpp +++ b/src/KOKKOS/atom_vec_sphere_kokkos.cpp @@ -2549,15 +2549,15 @@ void AtomVecSphereKokkos::data_atom(double *coord, imageint imagetmp, char **val if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - radius[nlocal] = 0.5 * atof(values[2]); + radius[nlocal] = 0.5 * force->numeric(FLERR,values[2]); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = atof(values[3]); + double density = force->numeric(FLERR,values[3]); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -2592,11 +2592,11 @@ void AtomVecSphereKokkos::data_atom(double *coord, imageint imagetmp, char **val int AtomVecSphereKokkos::data_atom_hybrid(int nlocal, char **values) { - radius[nlocal] = 0.5 * atof(values[0]); + radius[nlocal] = 0.5 * force->numeric(FLERR,values[0]); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = atof(values[1]); + double density = force->numeric(FLERR,values[1]); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -2618,12 +2618,12 @@ int AtomVecSphereKokkos::data_atom_hybrid(int nlocal, char **values) void AtomVecSphereKokkos::data_vel(int m, char **values) { atomKK->sync(Host,V_MASK|OMEGA_MASK); - h_v(m,0) = atof(values[0]); - h_v(m,1) = atof(values[1]); - h_v(m,2) = atof(values[2]); - h_omega(m,0) = atof(values[3]); - h_omega(m,1) = atof(values[4]); - h_omega(m,2) = atof(values[5]); + h_v(m,0) = force->numeric(FLERR,values[0]); + h_v(m,1) = force->numeric(FLERR,values[1]); + h_v(m,2) = force->numeric(FLERR,values[2]); + h_omega(m,0) = force->numeric(FLERR,values[3]); + h_omega(m,1) = force->numeric(FLERR,values[4]); + h_omega(m,2) = force->numeric(FLERR,values[5]); atomKK->modified(Host,V_MASK|OMEGA_MASK); } @@ -2634,9 +2634,9 @@ void AtomVecSphereKokkos::data_vel(int m, char **values) int AtomVecSphereKokkos::data_vel_hybrid(int m, char **values) { atomKK->sync(Host,OMEGA_MASK); - omega[m][0] = atof(values[0]); - omega[m][1] = atof(values[1]); - omega[m][2] = atof(values[2]); + omega[m][0] = force->numeric(FLERR,values[0]); + omega[m][1] = force->numeric(FLERR,values[1]); + omega[m][2] = force->numeric(FLERR,values[2]); atomKK->modified(Host,OMEGA_MASK); return 3; } diff --git a/src/MOLECULE/atom_vec_angle.cpp b/src/MOLECULE/atom_vec_angle.cpp index 6eb5b50fd2..338ac2879e 100644 --- a/src/MOLECULE/atom_vec_angle.cpp +++ b/src/MOLECULE/atom_vec_angle.cpp @@ -793,7 +793,7 @@ void AtomVecAngle::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = atoi(values[2]); + type[nlocal] = force->inumeric(FLERR,values[2]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/MOLECULE/atom_vec_bond.cpp b/src/MOLECULE/atom_vec_bond.cpp index 6a7b3585b4..96797bcd55 100644 --- a/src/MOLECULE/atom_vec_bond.cpp +++ b/src/MOLECULE/atom_vec_bond.cpp @@ -739,7 +739,7 @@ void AtomVecBond::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = atoi(values[2]); + type[nlocal] = force->inumeric(FLERR,values[2]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/MOLECULE/atom_vec_full.cpp b/src/MOLECULE/atom_vec_full.cpp index d682abf799..bfd1864d6e 100644 --- a/src/MOLECULE/atom_vec_full.cpp +++ b/src/MOLECULE/atom_vec_full.cpp @@ -942,11 +942,11 @@ void AtomVecFull::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = atoi(values[2]); + type[nlocal] = force->inumeric(FLERR,values[2]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = atof(values[3]); + q[nlocal] = force->numeric(FLERR,values[3]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -974,7 +974,7 @@ void AtomVecFull::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecFull::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - q[nlocal] = atof(values[1]); + q[nlocal] = force->numeric(FLERR,values[1]); num_bond[nlocal] = 0; num_angle[nlocal] = 0; diff --git a/src/MOLECULE/atom_vec_molecular.cpp b/src/MOLECULE/atom_vec_molecular.cpp index cdd3f02505..7e4d4fadad 100644 --- a/src/MOLECULE/atom_vec_molecular.cpp +++ b/src/MOLECULE/atom_vec_molecular.cpp @@ -926,7 +926,7 @@ void AtomVecMolecular::data_atom(double *coord, imageint imagetmp, tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = atoi(values[2]); + type[nlocal] = force->inumeric(FLERR,values[2]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/MOLECULE/atom_vec_template.cpp b/src/MOLECULE/atom_vec_template.cpp index 3172804b95..c856684330 100644 --- a/src/MOLECULE/atom_vec_template.cpp +++ b/src/MOLECULE/atom_vec_template.cpp @@ -745,8 +745,8 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) error->one(FLERR,"Invalid atom ID in Atoms section of data file"); molecule[nlocal] = ATOTAGINT(values[1]); - molindex[nlocal] = atoi(values[2]) - 1; - molatom[nlocal] = atoi(values[3]) - 1; + molindex[nlocal] = force->inumeric(FLERR,values[2]) - 1; + molatom[nlocal] = force->inumeric(FLERR,values[3]) - 1; if (molindex[nlocal] < 0 || molindex[nlocal] >= nset) error->one(FLERR,"Invalid template index in Atoms section of data file"); @@ -754,7 +754,7 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) molatom[nlocal] >= onemols[molindex[nlocal]]->natoms) error->one(FLERR,"Invalid template atom in Atoms section of data file"); - type[nlocal] = atoi(values[4]); + type[nlocal] = force->inumeric(FLERR,values[4]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -780,8 +780,8 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecTemplate::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - molindex[nlocal] = atoi(values[1]) - 1; - molatom[nlocal] = atoi(values[2]) - 1; + molindex[nlocal] = force->inumeric(FLERR,values[1]) - 1; + molatom[nlocal] = force->inumeric(FLERR,values[2]) - 1; return 3; } diff --git a/src/PERI/atom_vec_peri.cpp b/src/PERI/atom_vec_peri.cpp index d78fe27c94..a8a94b86c9 100644 --- a/src/PERI/atom_vec_peri.cpp +++ b/src/PERI/atom_vec_peri.cpp @@ -792,12 +792,12 @@ void AtomVecPeri::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - vfrac[nlocal] = atof(values[2]); - rmass[nlocal] = atof(values[3]); + vfrac[nlocal] = force->numeric(FLERR,values[2]); + rmass[nlocal] = force->numeric(FLERR,values[3]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid mass value"); x[nlocal][0] = coord[0]; @@ -826,8 +826,8 @@ void AtomVecPeri::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecPeri::data_atom_hybrid(int nlocal, char **values) { - vfrac[nlocal] = atof(values[0]); - rmass[nlocal] = atof(values[1]); + vfrac[nlocal] = force->numeric(FLERR,values[0]); + rmass[nlocal] = force->numeric(FLERR,values[1]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid mass value"); s0[nlocal] = DBL_MAX; diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index 37d6fb1e59..1d82114fe8 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -812,7 +812,7 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -820,10 +820,10 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) x[nlocal][1] = coord[1]; x[nlocal][2] = coord[2]; - sp[nlocal][3] = atof(values[2]); - sp[nlocal][0] = atof(values[6]); - sp[nlocal][1] = atof(values[7]); - sp[nlocal][2] = atof(values[8]); + sp[nlocal][3] = force->numeric(FLERR,values[2]); + sp[nlocal][0] = force->numeric(FLERR,values[6]); + sp[nlocal][1] = force->numeric(FLERR,values[7]); + sp[nlocal][2] = force->numeric(FLERR,values[8]); double inorm = 1.0/sqrt(sp[nlocal][0]*sp[nlocal][0] + sp[nlocal][1]*sp[nlocal][1] + sp[nlocal][2]*sp[nlocal][2]); @@ -849,16 +849,16 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecSpin::data_atom_hybrid(int nlocal, char **values) { - sp[nlocal][0] = atof(values[0]); - sp[nlocal][1] = atof(values[1]); - sp[nlocal][2] = atof(values[2]); + sp[nlocal][0] = force->numeric(FLERR,values[0]); + sp[nlocal][1] = force->numeric(FLERR,values[1]); + sp[nlocal][2] = force->numeric(FLERR,values[2]); double inorm = 1.0/sqrt(sp[nlocal][0]*sp[nlocal][0] + sp[nlocal][1]*sp[nlocal][1] + sp[nlocal][2]*sp[nlocal][2]); sp[nlocal][0] *= inorm; sp[nlocal][1] *= inorm; sp[nlocal][2] *= inorm; - sp[nlocal][3] = atof(values[3]); + sp[nlocal][3] = force->numeric(FLERR,values[3]); return 4; } diff --git a/src/USER-AWPMD/atom_vec_wavepacket.cpp b/src/USER-AWPMD/atom_vec_wavepacket.cpp index 7556dd2c8e..912544c860 100644 --- a/src/USER-AWPMD/atom_vec_wavepacket.cpp +++ b/src/USER-AWPMD/atom_vec_wavepacket.cpp @@ -916,19 +916,19 @@ void AtomVecWavepacket::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = atof(values[2]); - spin[nlocal] = atoi(values[3]); - eradius[nlocal] = atof(values[4]); + q[nlocal] = force->numeric(FLERR,values[2]); + spin[nlocal] = force->inumeric(FLERR,values[3]); + eradius[nlocal] = force->numeric(FLERR,values[4]); if (eradius[nlocal] < 0.0) error->one(FLERR,"Invalid eradius in Atoms section of data file"); - etag[nlocal] = atoi(values[5]); - cs[2*nlocal] = atoi(values[6]); - cs[2*nlocal+1] = atof(values[7]); + etag[nlocal] = force->inumeric(FLERR,values[5]); + cs[2*nlocal] = force->inumeric(FLERR,values[6]); + cs[2*nlocal+1] = force->numeric(FLERR,values[7]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -952,15 +952,15 @@ void AtomVecWavepacket::data_atom(double *coord, imageint imagetmp, int AtomVecWavepacket::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = atof(values[0]); - spin[nlocal] = atoi(values[1]); - eradius[nlocal] = atof(values[2]); + q[nlocal] = force->numeric(FLERR,values[0]); + spin[nlocal] = force->inumeric(FLERR,values[1]); + eradius[nlocal] = force->numeric(FLERR,values[2]); if (eradius[nlocal] < 0.0) error->one(FLERR,"Invalid eradius in Atoms section of data file"); - etag[nlocal] = atoi(values[3]); - cs[2*nlocal] = atoi(values[4]); - cs[2*nlocal+1] = atof(values[5]); + etag[nlocal] = force->inumeric(FLERR,values[3]); + cs[2*nlocal] = force->inumeric(FLERR,values[4]); + cs[2*nlocal+1] = force->numeric(FLERR,values[5]); v[nlocal][0] = 0.0; v[nlocal][1] = 0.0; @@ -976,10 +976,10 @@ int AtomVecWavepacket::data_atom_hybrid(int nlocal, char **values) void AtomVecWavepacket::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - ervel[m] = atof(values[3]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + ervel[m] = force->numeric(FLERR,values[3]); } /* ---------------------------------------------------------------------- @@ -988,7 +988,7 @@ void AtomVecWavepacket::data_vel(int m, char **values) int AtomVecWavepacket::data_vel_hybrid(int m, char **values) { - ervel[m] = atof(values[0]); + ervel[m] = force->numeric(FLERR,values[0]); return 1; } diff --git a/src/USER-DPD/atom_vec_dpd.cpp b/src/USER-DPD/atom_vec_dpd.cpp index 4cf6356100..c67034baf2 100644 --- a/src/USER-DPD/atom_vec_dpd.cpp +++ b/src/USER-DPD/atom_vec_dpd.cpp @@ -814,11 +814,11 @@ void AtomVecDPD::data_atom(double *coord, tagint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - dpdTheta[nlocal] = atof(values[2]); + dpdTheta[nlocal] = force->numeric(FLERR,values[2]); if (dpdTheta[nlocal] <= 0) error->one(FLERR,"Internal temperature in Atoms section of date file must be > zero"); @@ -850,7 +850,7 @@ void AtomVecDPD::data_atom(double *coord, tagint imagetmp, char **values) int AtomVecDPD::data_atom_hybrid(int nlocal, char **values) { - dpdTheta[nlocal] = atof(values[0]); + dpdTheta[nlocal] = force->numeric(FLERR,values[0]); return 1; } diff --git a/src/USER-EFF/atom_vec_electron.cpp b/src/USER-EFF/atom_vec_electron.cpp index 1bc5387c9e..2cf04e189a 100644 --- a/src/USER-EFF/atom_vec_electron.cpp +++ b/src/USER-EFF/atom_vec_electron.cpp @@ -799,15 +799,15 @@ void AtomVecElectron::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = atof(values[2]); - spin[nlocal] = atoi(values[3]); + q[nlocal] = force->numeric(FLERR,values[2]); + spin[nlocal] = force->inumeric(FLERR,values[3]); if (spin[nlocal] == 3) atom->ecp_flag = 1; - eradius[nlocal] = atof(values[4]); + eradius[nlocal] = force->numeric(FLERR,values[4]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -831,9 +831,9 @@ void AtomVecElectron::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecElectron::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = atof(values[0]); - spin[nlocal] = atoi(values[1]); - eradius[nlocal] = atof(values[2]); + q[nlocal] = force->numeric(FLERR,values[0]); + spin[nlocal] = force->inumeric(FLERR,values[1]); + eradius[nlocal] = force->numeric(FLERR,values[2]); if (eradius[nlocal] < 0.0) error->one(FLERR,"Invalid eradius in Atoms section of data file"); @@ -851,10 +851,10 @@ int AtomVecElectron::data_atom_hybrid(int nlocal, char **values) void AtomVecElectron::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - ervel[m] = atof(values[3]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + ervel[m] = force->numeric(FLERR,values[3]); } /* ---------------------------------------------------------------------- @@ -863,7 +863,7 @@ void AtomVecElectron::data_vel(int m, char **values) int AtomVecElectron::data_vel_hybrid(int m, char **values) { - ervel[m] = atof(values[0]); + ervel[m] = force->numeric(FLERR,values[0]); return 1; } diff --git a/src/USER-MESO/atom_vec_edpd.cpp b/src/USER-MESO/atom_vec_edpd.cpp index d956e914b5..b55573e409 100644 --- a/src/USER-MESO/atom_vec_edpd.cpp +++ b/src/USER-MESO/atom_vec_edpd.cpp @@ -759,12 +759,12 @@ void AtomVecEDPD::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - edpd_temp[nlocal] = atof(values[2]); - edpd_cv[nlocal] = atof(values[3]); + edpd_temp[nlocal] = force->numeric(FLERR,values[2]); + edpd_cv[nlocal] = force->numeric(FLERR,values[3]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; diff --git a/src/USER-MESO/atom_vec_mdpd.cpp b/src/USER-MESO/atom_vec_mdpd.cpp index 5bc5e212ff..47082a3b82 100644 --- a/src/USER-MESO/atom_vec_mdpd.cpp +++ b/src/USER-MESO/atom_vec_mdpd.cpp @@ -798,7 +798,7 @@ void AtomVecMDPD::data_atom(double *coord, imageint imagetmp, char **values) { if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -817,7 +817,7 @@ void AtomVecMDPD::data_atom(double *coord, imageint imagetmp, char **values) { vest[nlocal][1] = 0.0; vest[nlocal][2] = 0.0; - rho[nlocal] = atof(values[2]); + rho[nlocal] = force->numeric(FLERR,values[2]); drho[nlocal] = 0.0; atom->nlocal++; @@ -830,7 +830,7 @@ void AtomVecMDPD::data_atom(double *coord, imageint imagetmp, char **values) { int AtomVecMDPD::data_atom_hybrid(int nlocal, char **values) { - rho[nlocal] = atof(values[0]); + rho[nlocal] = force->numeric(FLERR,values[0]); return 3; } diff --git a/src/USER-MESO/atom_vec_tdpd.cpp b/src/USER-MESO/atom_vec_tdpd.cpp index aa0dc93809..261bef1795 100644 --- a/src/USER-MESO/atom_vec_tdpd.cpp +++ b/src/USER-MESO/atom_vec_tdpd.cpp @@ -792,7 +792,7 @@ void AtomVecTDPD::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-SMD/atom_vec_smd.cpp b/src/USER-SMD/atom_vec_smd.cpp index 020284312b..fb2b1ccc69 100644 --- a/src/USER-SMD/atom_vec_smd.cpp +++ b/src/USER-SMD/atom_vec_smd.cpp @@ -1029,7 +1029,7 @@ void AtomVecSMD::data_atom(double *coord, imageint imagetmp, char **values) { tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR, "Invalid atom type in Atoms section of data file"); @@ -1037,27 +1037,27 @@ void AtomVecSMD::data_atom(double *coord, imageint imagetmp, char **values) { if (molecule[nlocal] <= 0) error->one(FLERR, "Invalid molecule in Atoms section of data file"); - vfrac[nlocal] = atof(values[3]); + vfrac[nlocal] = force->numeric(FLERR,values[3]); if (vfrac[nlocal] < 0.0) error->one(FLERR, "Invalid volume in Atoms section of data file"); - rmass[nlocal] = atof(values[4]); + rmass[nlocal] = force->numeric(FLERR,values[4]); if (rmass[nlocal] == 0.0) error->one(FLERR, "Invalid mass in Atoms section of data file"); - radius[nlocal] = atof(values[5]); + radius[nlocal] = force->numeric(FLERR,values[5]); if (radius[nlocal] < 0.0) error->one(FLERR, "Invalid radius in Atoms section of data file"); - contact_radius[nlocal] = atof(values[6]); + contact_radius[nlocal] = force->numeric(FLERR,values[6]); if (contact_radius[nlocal] < 0.0) error->one(FLERR, "Invalid contact radius in Atoms section of data file"); e[nlocal] = 0.0; - x0[nlocal][0] = atof(values[7]); - x0[nlocal][1] = atof(values[8]); - x0[nlocal][2] = atof(values[9]); + x0[nlocal][0] = force->numeric(FLERR,values[7]); + x0[nlocal][1] = force->numeric(FLERR,values[8]); + x0[nlocal][2] = force->numeric(FLERR,values[9]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -1108,12 +1108,12 @@ int AtomVecSMD::data_atom_hybrid(int /*nlocal*/, char **/*values*/) { ------------------------------------------------------------------------- */ void AtomVecSMD::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - vest[m][0] = atof(values[0]); - vest[m][1] = atof(values[1]); - vest[m][2] = atof(values[2]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + vest[m][0] = force->numeric(FLERR,values[0]); + vest[m][1] = force->numeric(FLERR,values[1]); + vest[m][2] = force->numeric(FLERR,values[2]); } /* ---------------------------------------------------------------------- diff --git a/src/USER-SPH/atom_vec_meso.cpp b/src/USER-SPH/atom_vec_meso.cpp index 7dc6c6f7bd..144eaa2433 100644 --- a/src/USER-SPH/atom_vec_meso.cpp +++ b/src/USER-SPH/atom_vec_meso.cpp @@ -843,13 +843,13 @@ void AtomVecMeso::data_atom(double *coord, imageint imagetmp, char **values) { if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rho[nlocal] = atof(values[2]); - e[nlocal] = atof(values[3]); - cv[nlocal] = atof(values[4]); + rho[nlocal] = force->numeric(FLERR,values[2]); + e[nlocal] = force->numeric(FLERR,values[3]); + cv[nlocal] = force->numeric(FLERR,values[4]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -881,9 +881,9 @@ void AtomVecMeso::data_atom(double *coord, imageint imagetmp, char **values) { int AtomVecMeso::data_atom_hybrid(int nlocal, char **values) { - rho[nlocal] = atof(values[0]); - e[nlocal] = atof(values[1]); - cv[nlocal] = atof(values[2]); + rho[nlocal] = force->numeric(FLERR,values[0]); + e[nlocal] = force->numeric(FLERR,values[1]); + cv[nlocal] = force->numeric(FLERR,values[2]); return 3; } diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index a7ca6fcb19..33caea05a2 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -113,9 +113,9 @@ int AtomVec::grow_nmax_bonus(int nmax_bonus) void AtomVec::data_vel(int m, char **values) { double **v = atom->v; - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); } /* ---------------------------------------------------------------------- diff --git a/src/atom_vec_atomic.cpp b/src/atom_vec_atomic.cpp index e1c9a1e524..0f391baae9 100644 --- a/src/atom_vec_atomic.cpp +++ b/src/atom_vec_atomic.cpp @@ -612,7 +612,7 @@ void AtomVecAtomic::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_body.cpp b/src/atom_vec_body.cpp index d5f286c077..f54605fbb0 100644 --- a/src/atom_vec_body.cpp +++ b/src/atom_vec_body.cpp @@ -1280,16 +1280,16 @@ void AtomVecBody::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - body[nlocal] = atoi(values[2]); + body[nlocal] = force->inumeric(FLERR,values[2]); if (body[nlocal] == 0) body[nlocal] = -1; else if (body[nlocal] == 1) body[nlocal] = 0; else error->one(FLERR,"Invalid bodyflag in Atoms section of data file"); - rmass[nlocal] = atof(values[3]); + rmass[nlocal] = force->numeric(FLERR,values[3]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1318,12 +1318,12 @@ void AtomVecBody::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecBody::data_atom_hybrid(int nlocal, char **values) { - body[nlocal] = atoi(values[0]); + body[nlocal] = force->inumeric(FLERR,values[0]); if (body[nlocal] == 0) body[nlocal] = -1; else if (body[nlocal] == 1) body[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = atof(values[1]); + rmass[nlocal] = force->numeric(FLERR,values[1]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1350,12 +1350,12 @@ void AtomVecBody::data_body(int m, int ninteger, int ndouble, void AtomVecBody::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - angmom[m][0] = atof(values[3]); - angmom[m][1] = atof(values[4]); - angmom[m][2] = atof(values[5]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + angmom[m][0] = force->numeric(FLERR,values[3]); + angmom[m][1] = force->numeric(FLERR,values[4]); + angmom[m][2] = force->numeric(FLERR,values[5]); } /* ---------------------------------------------------------------------- @@ -1364,9 +1364,9 @@ void AtomVecBody::data_vel(int m, char **values) int AtomVecBody::data_vel_hybrid(int m, char **values) { - angmom[m][0] = atof(values[0]); - angmom[m][1] = atof(values[1]); - angmom[m][2] = atof(values[2]); + angmom[m][0] = force->numeric(FLERR,values[0]); + angmom[m][1] = force->numeric(FLERR,values[1]); + angmom[m][2] = force->numeric(FLERR,values[2]); return 3; } diff --git a/src/atom_vec_charge.cpp b/src/atom_vec_charge.cpp index 440393385d..a6fd5962ca 100644 --- a/src/atom_vec_charge.cpp +++ b/src/atom_vec_charge.cpp @@ -663,11 +663,11 @@ void AtomVecCharge::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = atof(values[2]); + q[nlocal] = force->numeric(FLERR,values[2]); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -690,7 +690,7 @@ void AtomVecCharge::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecCharge::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = atof(values[0]); + q[nlocal] = force->numeric(FLERR,values[0]); return 1; } diff --git a/src/atom_vec_ellipsoid.cpp b/src/atom_vec_ellipsoid.cpp index 2bf3f683d0..1fc713e583 100644 --- a/src/atom_vec_ellipsoid.cpp +++ b/src/atom_vec_ellipsoid.cpp @@ -1141,16 +1141,16 @@ void AtomVecEllipsoid::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - ellipsoid[nlocal] = atoi(values[2]); + ellipsoid[nlocal] = force->inumeric(FLERR,values[2]); if (ellipsoid[nlocal] == 0) ellipsoid[nlocal] = -1; else if (ellipsoid[nlocal] == 1) ellipsoid[nlocal] = 0; else error->one(FLERR,"Invalid ellipsoidflag in Atoms section of data file"); - rmass[nlocal] = atof(values[3]); + rmass[nlocal] = force->numeric(FLERR,values[3]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1178,12 +1178,12 @@ void AtomVecEllipsoid::data_atom(double *coord, imageint imagetmp, int AtomVecEllipsoid::data_atom_hybrid(int nlocal, char **values) { - ellipsoid[nlocal] = atoi(values[0]); + ellipsoid[nlocal] = force->inumeric(FLERR,values[0]); if (ellipsoid[nlocal] == 0) ellipsoid[nlocal] = -1; else if (ellipsoid[nlocal] == 1) ellipsoid[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = atof(values[1]); + rmass[nlocal] = force->numeric(FLERR,values[1]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1202,17 +1202,17 @@ void AtomVecEllipsoid::data_atom_bonus(int m, char **values) if (nlocal_bonus == nmax_bonus) grow_bonus(); double *shape = bonus[nlocal_bonus].shape; - shape[0] = 0.5 * atof(values[0]); - shape[1] = 0.5 * atof(values[1]); - shape[2] = 0.5 * atof(values[2]); + shape[0] = 0.5 * force->numeric(FLERR,values[0]); + shape[1] = 0.5 * force->numeric(FLERR,values[1]); + shape[2] = 0.5 * force->numeric(FLERR,values[2]); if (shape[0] <= 0.0 || shape[1] <= 0.0 || shape[2] <= 0.0) error->one(FLERR,"Invalid shape in Ellipsoids section of data file"); double *quat = bonus[nlocal_bonus].quat; - quat[0] = atof(values[3]); - quat[1] = atof(values[4]); - quat[2] = atof(values[5]); - quat[3] = atof(values[6]); + quat[0] = force->numeric(FLERR,values[3]); + quat[1] = force->numeric(FLERR,values[4]); + quat[2] = force->numeric(FLERR,values[5]); + quat[3] = force->numeric(FLERR,values[6]); MathExtra::qnormalize(quat); // reset ellipsoid mass @@ -1230,12 +1230,12 @@ void AtomVecEllipsoid::data_atom_bonus(int m, char **values) void AtomVecEllipsoid::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - angmom[m][0] = atof(values[3]); - angmom[m][1] = atof(values[4]); - angmom[m][2] = atof(values[5]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + angmom[m][0] = force->numeric(FLERR,values[3]); + angmom[m][1] = force->numeric(FLERR,values[4]); + angmom[m][2] = force->numeric(FLERR,values[5]); } /* ---------------------------------------------------------------------- @@ -1244,9 +1244,9 @@ void AtomVecEllipsoid::data_vel(int m, char **values) int AtomVecEllipsoid::data_vel_hybrid(int m, char **values) { - angmom[m][0] = atof(values[0]); - angmom[m][1] = atof(values[1]); - angmom[m][2] = atof(values[2]); + angmom[m][0] = force->numeric(FLERR,values[0]); + angmom[m][1] = force->numeric(FLERR,values[1]); + angmom[m][2] = force->numeric(FLERR,values[2]); return 3; } diff --git a/src/atom_vec_hybrid.cpp b/src/atom_vec_hybrid.cpp index 7e1fb01e5d..cf99a90632 100644 --- a/src/atom_vec_hybrid.cpp +++ b/src/atom_vec_hybrid.cpp @@ -863,7 +863,7 @@ void AtomVecHybrid::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -903,9 +903,9 @@ void AtomVecHybrid::data_atom(double *coord, imageint imagetmp, char **values) void AtomVecHybrid::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); // each sub-style parses sub-style specific values diff --git a/src/atom_vec_line.cpp b/src/atom_vec_line.cpp index 020b622c93..f229297798 100644 --- a/src/atom_vec_line.cpp +++ b/src/atom_vec_line.cpp @@ -1037,16 +1037,16 @@ void AtomVecLine::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = atoi(values[2]); + type[nlocal] = force->inumeric(FLERR,values[2]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - line[nlocal] = atoi(values[3]); + line[nlocal] = force->inumeric(FLERR,values[3]); if (line[nlocal] == 0) line[nlocal] = -1; else if (line[nlocal] == 1) line[nlocal] = 0; else error->one(FLERR,"Invalid lineflag in Atoms section of data file"); - rmass[nlocal] = atof(values[4]); + rmass[nlocal] = force->numeric(FLERR,values[4]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1082,12 +1082,12 @@ int AtomVecLine::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - line[nlocal] = atoi(values[1]); + line[nlocal] = force->inumeric(FLERR,values[1]); if (line[nlocal] == 0) line[nlocal] = -1; else if (line[nlocal] == 1) line[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = atof(values[2]); + rmass[nlocal] = force->numeric(FLERR,values[2]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1110,10 +1110,10 @@ void AtomVecLine::data_atom_bonus(int m, char **values) if (nlocal_bonus == nmax_bonus) grow_bonus(); - double x1 = atof(values[0]); - double y1 = atof(values[1]); - double x2 = atof(values[2]); - double y2 = atof(values[3]); + double x1 = force->numeric(FLERR,values[0]); + double y1 = force->numeric(FLERR,values[1]); + double x2 = force->numeric(FLERR,values[2]); + double y2 = force->numeric(FLERR,values[3]); double dx = x2 - x1; double dy = y2 - y1; double length = sqrt(dx*dx + dy*dy); @@ -1150,12 +1150,12 @@ void AtomVecLine::data_atom_bonus(int m, char **values) void AtomVecLine::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - omega[m][0] = atof(values[3]); - omega[m][1] = atof(values[4]); - omega[m][2] = atof(values[5]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + omega[m][0] = force->numeric(FLERR,values[3]); + omega[m][1] = force->numeric(FLERR,values[4]); + omega[m][2] = force->numeric(FLERR,values[5]); } /* ---------------------------------------------------------------------- @@ -1164,9 +1164,9 @@ void AtomVecLine::data_vel(int m, char **values) int AtomVecLine::data_vel_hybrid(int m, char **values) { - omega[m][0] = atof(values[0]); - omega[m][1] = atof(values[1]); - omega[m][2] = atof(values[2]); + omega[m][0] = force->numeric(FLERR,values[0]); + omega[m][1] = force->numeric(FLERR,values[1]); + omega[m][2] = force->numeric(FLERR,values[2]); return 3; } diff --git a/src/atom_vec_sphere.cpp b/src/atom_vec_sphere.cpp index dec98e5200..705b7411e7 100644 --- a/src/atom_vec_sphere.cpp +++ b/src/atom_vec_sphere.cpp @@ -965,15 +965,15 @@ void AtomVecSphere::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = atoi(values[1]); + type[nlocal] = force->inumeric(FLERR,values[1]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - radius[nlocal] = 0.5 * atof(values[2]); + radius[nlocal] = 0.5 * force->numeric(FLERR,values[2]); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = atof(values[3]); + double density = force->numeric(FLERR,values[3]); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1006,11 +1006,11 @@ void AtomVecSphere::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecSphere::data_atom_hybrid(int nlocal, char **values) { - radius[nlocal] = 0.5 * atof(values[0]); + radius[nlocal] = 0.5 * force->numeric(FLERR,values[0]); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = atof(values[1]); + double density = force->numeric(FLERR,values[1]); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1028,12 +1028,12 @@ int AtomVecSphere::data_atom_hybrid(int nlocal, char **values) void AtomVecSphere::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - omega[m][0] = atof(values[3]); - omega[m][1] = atof(values[4]); - omega[m][2] = atof(values[5]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + omega[m][0] = force->numeric(FLERR,values[3]); + omega[m][1] = force->numeric(FLERR,values[4]); + omega[m][2] = force->numeric(FLERR,values[5]); } /* ---------------------------------------------------------------------- @@ -1042,9 +1042,9 @@ void AtomVecSphere::data_vel(int m, char **values) int AtomVecSphere::data_vel_hybrid(int m, char **values) { - omega[m][0] = atof(values[0]); - omega[m][1] = atof(values[1]); - omega[m][2] = atof(values[2]); + omega[m][0] = force->numeric(FLERR,values[0]); + omega[m][1] = force->numeric(FLERR,values[1]); + omega[m][2] = force->numeric(FLERR,values[2]); return 3; } diff --git a/src/atom_vec_tri.cpp b/src/atom_vec_tri.cpp index 8fbe0a92dc..9f4557b63d 100644 --- a/src/atom_vec_tri.cpp +++ b/src/atom_vec_tri.cpp @@ -1436,16 +1436,16 @@ void AtomVecTri::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = atoi(values[2]); + type[nlocal] = force->inumeric(FLERR,values[2]); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - tri[nlocal] = atoi(values[3]); + tri[nlocal] = force->inumeric(FLERR,values[3]); if (tri[nlocal] == 0) tri[nlocal] = -1; else if (tri[nlocal] == 1) tri[nlocal] = 0; else error->one(FLERR,"Invalid triflag in Atoms section of data file"); - rmass[nlocal] = atof(values[4]); + rmass[nlocal] = force->numeric(FLERR,values[4]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1484,12 +1484,12 @@ int AtomVecTri::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - tri[nlocal] = atoi(values[1]); + tri[nlocal] = force->inumeric(FLERR,values[1]); if (tri[nlocal] == 0) tri[nlocal] = -1; else if (tri[nlocal] == 1) tri[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = atof(values[2]); + rmass[nlocal] = force->numeric(FLERR,values[2]); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1513,15 +1513,15 @@ void AtomVecTri::data_atom_bonus(int m, char **values) if (nlocal_bonus == nmax_bonus) grow_bonus(); double c1[3],c2[3],c3[3]; - c1[0] = atof(values[0]); - c1[1] = atof(values[1]); - c1[2] = atof(values[2]); - c2[0] = atof(values[3]); - c2[1] = atof(values[4]); - c2[2] = atof(values[5]); - c3[0] = atof(values[6]); - c3[1] = atof(values[7]); - c3[2] = atof(values[8]); + c1[0] = force->numeric(FLERR,values[0]); + c1[1] = force->numeric(FLERR,values[1]); + c1[2] = force->numeric(FLERR,values[2]); + c2[0] = force->numeric(FLERR,values[3]); + c2[1] = force->numeric(FLERR,values[4]); + c2[2] = force->numeric(FLERR,values[5]); + c3[0] = force->numeric(FLERR,values[6]); + c3[1] = force->numeric(FLERR,values[7]); + c3[2] = force->numeric(FLERR,values[8]); // check for duplicate points @@ -1641,15 +1641,15 @@ void AtomVecTri::data_atom_bonus(int m, char **values) void AtomVecTri::data_vel(int m, char **values) { - v[m][0] = atof(values[0]); - v[m][1] = atof(values[1]); - v[m][2] = atof(values[2]); - omega[m][0] = atof(values[3]); - omega[m][1] = atof(values[4]); - omega[m][2] = atof(values[5]); - angmom[m][0] = atof(values[6]); - angmom[m][1] = atof(values[7]); - angmom[m][2] = atof(values[8]); + v[m][0] = force->numeric(FLERR,values[0]); + v[m][1] = force->numeric(FLERR,values[1]); + v[m][2] = force->numeric(FLERR,values[2]); + omega[m][0] = force->numeric(FLERR,values[3]); + omega[m][1] = force->numeric(FLERR,values[4]); + omega[m][2] = force->numeric(FLERR,values[5]); + angmom[m][0] = force->numeric(FLERR,values[6]); + angmom[m][1] = force->numeric(FLERR,values[7]); + angmom[m][2] = force->numeric(FLERR,values[8]); } /* ---------------------------------------------------------------------- @@ -1658,12 +1658,12 @@ void AtomVecTri::data_vel(int m, char **values) int AtomVecTri::data_vel_hybrid(int m, char **values) { - omega[m][0] = atof(values[0]); - omega[m][1] = atof(values[1]); - omega[m][2] = atof(values[2]); - angmom[m][0] = atof(values[3]); - angmom[m][1] = atof(values[4]); - angmom[m][2] = atof(values[5]); + omega[m][0] = force->numeric(FLERR,values[0]); + omega[m][1] = force->numeric(FLERR,values[1]); + omega[m][2] = force->numeric(FLERR,values[2]); + angmom[m][0] = force->numeric(FLERR,values[3]); + angmom[m][1] = force->numeric(FLERR,values[4]); + angmom[m][2] = force->numeric(FLERR,values[5]); return 6; } -- GitLab From b469ff6791c2d35a417696f6a0cc4df4bac8a082 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 7 Jul 2019 16:06:30 -0400 Subject: [PATCH 199/469] need to include 'force.h' header for conversion functions --- src/DIPOLE/atom_vec_dipole.cpp | 1 + src/KOKKOS/atom_vec_angle_kokkos.cpp | 1 + src/KOKKOS/atom_vec_atomic_kokkos.cpp | 1 + src/KOKKOS/atom_vec_bond_kokkos.cpp | 1 + src/KOKKOS/atom_vec_charge_kokkos.cpp | 1 + src/KOKKOS/atom_vec_dpd_kokkos.cpp | 1 + src/KOKKOS/atom_vec_full_kokkos.cpp | 1 + src/KOKKOS/atom_vec_hybrid_kokkos.cpp | 1 + src/KOKKOS/atom_vec_molecular_kokkos.cpp | 1 + src/MOLECULE/atom_vec_angle.cpp | 1 + src/MOLECULE/atom_vec_bond.cpp | 1 + src/MOLECULE/atom_vec_full.cpp | 1 + src/MOLECULE/atom_vec_molecular.cpp | 1 + src/MOLECULE/atom_vec_template.cpp | 1 + src/PERI/atom_vec_peri.cpp | 1 + src/SPIN/atom_vec_spin.cpp | 1 + src/USER-DPD/atom_vec_dpd.cpp | 1 + src/USER-MESO/atom_vec_edpd.cpp | 1 + src/USER-MESO/atom_vec_mdpd.cpp | 1 + src/USER-SPH/atom_vec_meso.cpp | 1 + src/atom_vec_atomic.cpp | 1 + src/atom_vec_charge.cpp | 1 + src/atom_vec_hybrid.cpp | 1 + 23 files changed, 23 insertions(+) diff --git a/src/DIPOLE/atom_vec_dipole.cpp b/src/DIPOLE/atom_vec_dipole.cpp index c6f8fbb432..b469327c80 100644 --- a/src/DIPOLE/atom_vec_dipole.cpp +++ b/src/DIPOLE/atom_vec_dipole.cpp @@ -17,6 +17,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/KOKKOS/atom_vec_angle_kokkos.cpp b/src/KOKKOS/atom_vec_angle_kokkos.cpp index 36fa47c712..b6cf8ba2b2 100644 --- a/src/KOKKOS/atom_vec_angle_kokkos.cpp +++ b/src/KOKKOS/atom_vec_angle_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_atomic_kokkos.cpp b/src/KOKKOS/atom_vec_atomic_kokkos.cpp index 61703d1cc8..b0cf4e483a 100644 --- a/src/KOKKOS/atom_vec_atomic_kokkos.cpp +++ b/src/KOKKOS/atom_vec_atomic_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_bond_kokkos.cpp b/src/KOKKOS/atom_vec_bond_kokkos.cpp index bbf9f58b58..bac06e7845 100644 --- a/src/KOKKOS/atom_vec_bond_kokkos.cpp +++ b/src/KOKKOS/atom_vec_bond_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_charge_kokkos.cpp b/src/KOKKOS/atom_vec_charge_kokkos.cpp index be267d8b16..44f9a44052 100644 --- a/src/KOKKOS/atom_vec_charge_kokkos.cpp +++ b/src/KOKKOS/atom_vec_charge_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index ffbfc75a93..d3c3e71331 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_full_kokkos.cpp b/src/KOKKOS/atom_vec_full_kokkos.cpp index 1974c12ebb..c10402de8c 100644 --- a/src/KOKKOS/atom_vec_full_kokkos.cpp +++ b/src/KOKKOS/atom_vec_full_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp index 88dbdd068a..4c3de20a49 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_vec_hybrid_kokkos.h" #include "atom_kokkos.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/atom_vec_molecular_kokkos.cpp b/src/KOKKOS/atom_vec_molecular_kokkos.cpp index 060228f37e..0616b3dfe0 100644 --- a/src/KOKKOS/atom_vec_molecular_kokkos.cpp +++ b/src/KOKKOS/atom_vec_molecular_kokkos.cpp @@ -18,6 +18,7 @@ #include "domain.h" #include "modify.h" #include "fix.h" +#include "force.h" #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" diff --git a/src/MOLECULE/atom_vec_angle.cpp b/src/MOLECULE/atom_vec_angle.cpp index 338ac2879e..594a039463 100644 --- a/src/MOLECULE/atom_vec_angle.cpp +++ b/src/MOLECULE/atom_vec_angle.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_bond.cpp b/src/MOLECULE/atom_vec_bond.cpp index 96797bcd55..12eafbc6ce 100644 --- a/src/MOLECULE/atom_vec_bond.cpp +++ b/src/MOLECULE/atom_vec_bond.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_full.cpp b/src/MOLECULE/atom_vec_full.cpp index bfd1864d6e..4cad70f782 100644 --- a/src/MOLECULE/atom_vec_full.cpp +++ b/src/MOLECULE/atom_vec_full.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_molecular.cpp b/src/MOLECULE/atom_vec_molecular.cpp index 7e4d4fadad..dfd833d1c8 100644 --- a/src/MOLECULE/atom_vec_molecular.cpp +++ b/src/MOLECULE/atom_vec_molecular.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_template.cpp b/src/MOLECULE/atom_vec_template.cpp index c856684330..2498010888 100644 --- a/src/MOLECULE/atom_vec_template.cpp +++ b/src/MOLECULE/atom_vec_template.cpp @@ -16,6 +16,7 @@ #include "atom_vec_template.h" #include "atom.h" #include "molecule.h" +#include "force.h" #include "comm.h" #include "domain.h" #include "modify.h" diff --git a/src/PERI/atom_vec_peri.cpp b/src/PERI/atom_vec_peri.cpp index a8a94b86c9..9b262477a6 100644 --- a/src/PERI/atom_vec_peri.cpp +++ b/src/PERI/atom_vec_peri.cpp @@ -22,6 +22,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "citeme.h" diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index 1d82114fe8..ba33372542 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -32,6 +32,7 @@ #include "domain.h" #include "error.h" #include "fix.h" +#include "force.h" #include "memory.h" #include "modify.h" diff --git a/src/USER-DPD/atom_vec_dpd.cpp b/src/USER-DPD/atom_vec_dpd.cpp index c67034baf2..776de845ab 100644 --- a/src/USER-DPD/atom_vec_dpd.cpp +++ b/src/USER-DPD/atom_vec_dpd.cpp @@ -20,6 +20,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/USER-MESO/atom_vec_edpd.cpp b/src/USER-MESO/atom_vec_edpd.cpp index b55573e409..25049ce003 100644 --- a/src/USER-MESO/atom_vec_edpd.cpp +++ b/src/USER-MESO/atom_vec_edpd.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "update.h" diff --git a/src/USER-MESO/atom_vec_mdpd.cpp b/src/USER-MESO/atom_vec_mdpd.cpp index 47082a3b82..9952182851 100644 --- a/src/USER-MESO/atom_vec_mdpd.cpp +++ b/src/USER-MESO/atom_vec_mdpd.cpp @@ -17,6 +17,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "update.h" diff --git a/src/USER-SPH/atom_vec_meso.cpp b/src/USER-SPH/atom_vec_meso.cpp index 144eaa2433..763ce5af5a 100644 --- a/src/USER-SPH/atom_vec_meso.cpp +++ b/src/USER-SPH/atom_vec_meso.cpp @@ -17,6 +17,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/atom_vec_atomic.cpp b/src/atom_vec_atomic.cpp index 0f391baae9..2f01424d9d 100644 --- a/src/atom_vec_atomic.cpp +++ b/src/atom_vec_atomic.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/atom_vec_charge.cpp b/src/atom_vec_charge.cpp index a6fd5962ca..03ef95a2e4 100644 --- a/src/atom_vec_charge.cpp +++ b/src/atom_vec_charge.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "comm.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/atom_vec_hybrid.cpp b/src/atom_vec_hybrid.cpp index cf99a90632..94391ec9f3 100644 --- a/src/atom_vec_hybrid.cpp +++ b/src/atom_vec_hybrid.cpp @@ -16,6 +16,7 @@ #include "atom_vec_hybrid.h" #include "atom.h" #include "domain.h" +#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" -- GitLab From 13d4fbdcfbad171fd83ac74d7dcc66170979cd05 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 7 Jul 2019 16:23:36 -0400 Subject: [PATCH 200/469] clean up includes in QEQ, REPLICA, and RIGID packages --- src/PERI/pair_peri_ves.cpp | 1 - src/QEQ/fix_qeq.cpp | 12 +----------- src/QEQ/fix_qeq_dynamic.cpp | 5 +---- src/QEQ/fix_qeq_fire.cpp | 5 +---- src/QEQ/fix_qeq_point.cpp | 3 --- src/QEQ/fix_qeq_shielded.cpp | 3 --- src/QEQ/fix_qeq_slater.cpp | 3 --- src/REPLICA/compute_event_displace.cpp | 3 --- src/REPLICA/fix_event.cpp | 8 +------- src/REPLICA/fix_event_hyper.cpp | 9 +-------- src/REPLICA/fix_event_prd.cpp | 9 +-------- src/REPLICA/fix_event_tad.cpp | 9 +-------- src/REPLICA/fix_hyper_global.cpp | 2 -- src/REPLICA/fix_hyper_local.cpp | 3 +-- src/REPLICA/fix_hyper_local.h | 1 - src/REPLICA/fix_neb.cpp | 1 - src/REPLICA/hyper.cpp | 4 +--- src/REPLICA/neb.cpp | 5 ----- src/REPLICA/prd.cpp | 9 --------- src/REPLICA/tad.cpp | 12 ------------ src/REPLICA/temper.cpp | 4 ---- src/REPLICA/verlet_split.cpp | 1 - src/RIGID/compute_erotate_rigid.cpp | 1 - src/RIGID/compute_ke_rigid.cpp | 1 - src/RIGID/compute_rigid_local.cpp | 1 - 25 files changed, 9 insertions(+), 106 deletions(-) diff --git a/src/PERI/pair_peri_ves.cpp b/src/PERI/pair_peri_ves.cpp index 930ecc6812..bd1eaa5fd2 100644 --- a/src/PERI/pair_peri_ves.cpp +++ b/src/PERI/pair_peri_ves.cpp @@ -18,7 +18,6 @@ #include "pair_peri_ves.h" #include #include -#include #include #include "atom.h" #include "domain.h" diff --git a/src/QEQ/fix_qeq.cpp b/src/QEQ/fix_qeq.cpp index 2e0b7edbe5..7768c01a41 100644 --- a/src/QEQ/fix_qeq.cpp +++ b/src/QEQ/fix_qeq.cpp @@ -17,28 +17,18 @@ ------------------------------------------------------------------------- */ #include "fix_qeq.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" -#include "domain.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "update.h" #include "force.h" -#include "kspace.h" -#include "group.h" -#include "pair.h" -#include "respa.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace FixConst; #define MAXLINE 1024 diff --git a/src/QEQ/fix_qeq_dynamic.cpp b/src/QEQ/fix_qeq_dynamic.cpp index fb5fd2ddac..a2cc683b56 100644 --- a/src/QEQ/fix_qeq_dynamic.cpp +++ b/src/QEQ/fix_qeq_dynamic.cpp @@ -16,23 +16,20 @@ ------------------------------------------------------------------------- */ #include "fix_qeq_dynamic.h" +#include #include -#include #include #include #include "atom.h" #include "comm.h" -#include "domain.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" #include "force.h" #include "group.h" -#include "pair.h" #include "kspace.h" #include "respa.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/QEQ/fix_qeq_fire.cpp b/src/QEQ/fix_qeq_fire.cpp index 561a82b714..265528a089 100644 --- a/src/QEQ/fix_qeq_fire.cpp +++ b/src/QEQ/fix_qeq_fire.cpp @@ -16,25 +16,22 @@ ------------------------------------------------------------------------- */ #include "fix_qeq_fire.h" +#include #include -#include #include #include #include "atom.h" #include "comm.h" -#include "domain.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" #include "force.h" #include "group.h" -#include "pair.h" #include "pair_comb.h" #include "pair_comb3.h" #include "kspace.h" #include "respa.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/QEQ/fix_qeq_point.cpp b/src/QEQ/fix_qeq_point.cpp index bb3ce835fc..8fb9fd3273 100644 --- a/src/QEQ/fix_qeq_point.cpp +++ b/src/QEQ/fix_qeq_point.cpp @@ -17,12 +17,9 @@ #include "fix_qeq_point.h" #include -#include -#include #include #include "atom.h" #include "comm.h" -#include "domain.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/QEQ/fix_qeq_shielded.cpp b/src/QEQ/fix_qeq_shielded.cpp index 60ff62ca07..13e25475ae 100644 --- a/src/QEQ/fix_qeq_shielded.cpp +++ b/src/QEQ/fix_qeq_shielded.cpp @@ -17,12 +17,9 @@ #include "fix_qeq_shielded.h" #include -#include -#include #include #include "atom.h" #include "comm.h" -#include "domain.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/QEQ/fix_qeq_slater.cpp b/src/QEQ/fix_qeq_slater.cpp index 95105b5ef2..4f5369eb87 100644 --- a/src/QEQ/fix_qeq_slater.cpp +++ b/src/QEQ/fix_qeq_slater.cpp @@ -17,12 +17,10 @@ #include "fix_qeq_slater.h" #include -#include #include #include #include "atom.h" #include "comm.h" -#include "domain.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" @@ -33,7 +31,6 @@ #include "kspace.h" #include "respa.h" #include "math_const.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/REPLICA/compute_event_displace.cpp b/src/REPLICA/compute_event_displace.cpp index 4c8d022d70..a6abcce85d 100644 --- a/src/REPLICA/compute_event_displace.cpp +++ b/src/REPLICA/compute_event_displace.cpp @@ -17,14 +17,11 @@ #include "compute_event_displace.h" #include -#include -#include #include #include "atom.h" #include "domain.h" #include "modify.h" #include "fix_event.h" -#include "memory.h" #include "error.h" #include "force.h" #include "update.h" diff --git a/src/REPLICA/fix_event.cpp b/src/REPLICA/fix_event.cpp index 8cf1acba94..41f91332cb 100644 --- a/src/REPLICA/fix_event.cpp +++ b/src/REPLICA/fix_event.cpp @@ -16,16 +16,10 @@ ------------------------------------------------------------------------- */ #include "fix_event.h" -#include -#include #include "atom.h" -#include "update.h" #include "domain.h" -#include "neighbor.h" -#include "comm.h" -#include "universe.h" -#include "memory.h" #include "error.h" +#include "memory.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/REPLICA/fix_event_hyper.cpp b/src/REPLICA/fix_event_hyper.cpp index 3dd1a03eb9..0d32516dee 100644 --- a/src/REPLICA/fix_event_hyper.cpp +++ b/src/REPLICA/fix_event_hyper.cpp @@ -12,16 +12,9 @@ ------------------------------------------------------------------------- */ #include "fix_event_hyper.h" -#include -#include -#include "atom.h" -#include "update.h" -#include "domain.h" -#include "neighbor.h" #include "comm.h" -#include "universe.h" -#include "memory.h" #include "error.h" +#include "update.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/REPLICA/fix_event_prd.cpp b/src/REPLICA/fix_event_prd.cpp index 63c9c2718b..19a89e988c 100644 --- a/src/REPLICA/fix_event_prd.cpp +++ b/src/REPLICA/fix_event_prd.cpp @@ -16,16 +16,9 @@ ------------------------------------------------------------------------- */ #include "fix_event_prd.h" -#include -#include -#include "atom.h" -#include "update.h" -#include "domain.h" -#include "neighbor.h" #include "comm.h" -#include "universe.h" -#include "memory.h" #include "error.h" +#include "update.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/REPLICA/fix_event_tad.cpp b/src/REPLICA/fix_event_tad.cpp index b92bc1fd73..d0b94a216b 100644 --- a/src/REPLICA/fix_event_tad.cpp +++ b/src/REPLICA/fix_event_tad.cpp @@ -16,16 +16,9 @@ ------------------------------------------------------------------------- */ #include "fix_event_tad.h" -#include -#include -#include "atom.h" -#include "update.h" -#include "domain.h" -#include "neighbor.h" #include "comm.h" -#include "universe.h" -#include "memory.h" #include "error.h" +#include "update.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/REPLICA/fix_hyper_global.cpp b/src/REPLICA/fix_hyper_global.cpp index a58798a63e..5e9da02768 100644 --- a/src/REPLICA/fix_hyper_global.cpp +++ b/src/REPLICA/fix_hyper_global.cpp @@ -14,7 +14,6 @@ #include "fix_hyper_global.h" #include #include -#include #include #include "atom.h" #include "update.h" @@ -24,7 +23,6 @@ #include "neighbor.h" #include "neigh_request.h" #include "neigh_list.h" -#include "modify.h" #include "math_extra.h" #include "memory.h" #include "error.h" diff --git a/src/REPLICA/fix_hyper_local.cpp b/src/REPLICA/fix_hyper_local.cpp index 555c5234f6..e8773095d1 100644 --- a/src/REPLICA/fix_hyper_local.cpp +++ b/src/REPLICA/fix_hyper_local.cpp @@ -14,7 +14,6 @@ #include "fix_hyper_local.h" #include #include -#include #include #include "atom.h" #include "update.h" @@ -22,10 +21,10 @@ #include "pair.h" #include "domain.h" #include "comm.h" +#include "my_page.h" #include "neighbor.h" #include "neigh_request.h" #include "neigh_list.h" -#include "modify.h" #include "math_extra.h" #include "memory.h" #include "error.h" diff --git a/src/REPLICA/fix_hyper_local.h b/src/REPLICA/fix_hyper_local.h index 6f13acb606..8fb3a445c2 100644 --- a/src/REPLICA/fix_hyper_local.h +++ b/src/REPLICA/fix_hyper_local.h @@ -21,7 +21,6 @@ FixStyle(hyper/local,FixHyperLocal) #define LMP_FIX_HYPER_LOCAL_H #include "fix_hyper.h" -#include "my_page.h" namespace LAMMPS_NS { diff --git a/src/REPLICA/fix_neb.cpp b/src/REPLICA/fix_neb.cpp index 2803c37b23..7b377ae9ec 100644 --- a/src/REPLICA/fix_neb.cpp +++ b/src/REPLICA/fix_neb.cpp @@ -19,7 +19,6 @@ #include "fix_neb.h" #include #include -#include #include #include "universe.h" #include "update.h" diff --git a/src/REPLICA/hyper.cpp b/src/REPLICA/hyper.cpp index c400ae097d..af2a963616 100644 --- a/src/REPLICA/hyper.cpp +++ b/src/REPLICA/hyper.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "hyper.h" -#include -#include +#include #include #include "update.h" -#include "atom.h" #include "domain.h" #include "region.h" #include "integrate.h" diff --git a/src/REPLICA/neb.cpp b/src/REPLICA/neb.cpp index b670f3d8f1..84337ce8ae 100644 --- a/src/REPLICA/neb.cpp +++ b/src/REPLICA/neb.cpp @@ -11,12 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -// lmptype.h must be first b/c this file uses MAXBIGINT and includes mpi.h -// due to OpenMPI bug which sets INT64_MAX via its mpi.h -// before lmptype.h can set flags to insure it is done correctly - #include "neb.h" -#include "lmptype.h" #include #include #include diff --git a/src/REPLICA/prd.cpp b/src/REPLICA/prd.cpp index 19a12ddbbb..f631cc6a0a 100644 --- a/src/REPLICA/prd.cpp +++ b/src/REPLICA/prd.cpp @@ -15,15 +15,8 @@ Contributing author: Mike Brown (SNL) ------------------------------------------------------------------------- */ -// lmptype.h must be first b/c this file uses MAXBIGINT and includes mpi.h -// due to OpenMPI bug which sets INT64_MAX via its mpi.h -// before lmptype.h can set flags to insure it is done correctly - #include "prd.h" -#include "lmptype.h" #include -#include -#include #include #include "universe.h" #include "update.h" @@ -40,11 +33,9 @@ #include "fix.h" #include "fix_event_prd.h" #include "force.h" -#include "pair.h" #include "random_park.h" #include "random_mars.h" #include "output.h" -#include "dump.h" #include "finish.h" #include "timer.h" #include "memory.h" diff --git a/src/REPLICA/tad.cpp b/src/REPLICA/tad.cpp index 90667b8865..8a51f6d00e 100644 --- a/src/REPLICA/tad.cpp +++ b/src/REPLICA/tad.cpp @@ -15,36 +15,24 @@ Contributing author: Aidan Thompson (SNL) ------------------------------------------------------------------------- */ -// lmptype.h must be first b/c this file uses MAXBIGINT and includes mpi.h -// due to OpenMPI bug which sets INT64_MAX via its mpi.h -// before lmptype.h can set flags to insure it is done correctly - #include "tad.h" -#include "lmptype.h" #include #include -#include #include #include "universe.h" #include "update.h" #include "atom.h" #include "domain.h" -#include "region.h" -#include "comm.h" -#include "velocity.h" #include "integrate.h" #include "min.h" #include "neighbor.h" #include "modify.h" #include "neb.h" #include "compute.h" -#include "fix.h" #include "fix_event_tad.h" #include "fix_store.h" #include "force.h" -#include "pair.h" #include "output.h" -#include "dump.h" #include "finish.h" #include "timer.h" #include "memory.h" diff --git a/src/REPLICA/temper.cpp b/src/REPLICA/temper.cpp index 6eb50c8d9f..46fc3af649 100644 --- a/src/REPLICA/temper.cpp +++ b/src/REPLICA/temper.cpp @@ -17,7 +17,6 @@ #include "temper.h" #include -#include #include #include "universe.h" #include "domain.h" @@ -27,13 +26,10 @@ #include "modify.h" #include "compute.h" #include "force.h" -#include "output.h" -#include "thermo.h" #include "fix.h" #include "random_park.h" #include "finish.h" #include "timer.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/REPLICA/verlet_split.cpp b/src/REPLICA/verlet_split.cpp index f268afe7f8..a5ed1a671d 100644 --- a/src/REPLICA/verlet_split.cpp +++ b/src/REPLICA/verlet_split.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include "verlet_split.h" -#include #include "universe.h" #include "neighbor.h" #include "domain.h" diff --git a/src/RIGID/compute_erotate_rigid.cpp b/src/RIGID/compute_erotate_rigid.cpp index 1a7236e263..e15c0deb82 100644 --- a/src/RIGID/compute_erotate_rigid.cpp +++ b/src/RIGID/compute_erotate_rigid.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "compute_erotate_rigid.h" -#include #include #include "update.h" #include "force.h" diff --git a/src/RIGID/compute_ke_rigid.cpp b/src/RIGID/compute_ke_rigid.cpp index 66b7a92566..031919b7a9 100644 --- a/src/RIGID/compute_ke_rigid.cpp +++ b/src/RIGID/compute_ke_rigid.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "compute_ke_rigid.h" -#include #include #include "update.h" #include "force.h" diff --git a/src/RIGID/compute_rigid_local.cpp b/src/RIGID/compute_rigid_local.cpp index 75334bb759..57f69a64e2 100644 --- a/src/RIGID/compute_rigid_local.cpp +++ b/src/RIGID/compute_rigid_local.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "compute_rigid_local.h" -#include #include #include "atom.h" #include "update.h" -- GitLab From 65e281d661190ed8e1255fd31cff4a1d45d7a63d Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 7 Jul 2019 18:00:07 -0600 Subject: [PATCH 201/469] Fixed a few problems with read_dump xyz --- src/read_dump.cpp | 7 +++++-- src/reader.cpp | 10 ++++++++++ src/reader.h | 2 +- 3 files changed, 16 insertions(+), 3 deletions(-) diff --git a/src/read_dump.cpp b/src/read_dump.cpp index 395f4c8edd..1a0a746c07 100644 --- a/src/read_dump.cpp +++ b/src/read_dump.cpp @@ -507,7 +507,10 @@ void ReadDump::header(int fieldinfo) yhi = box[1][1]; zlo = box[2][0]; zhi = box[2][1]; - if (triclinic_snap) { + + // value of 1 indicates possible change in tilt factors + + if (triclinic_snap == 1) { xy = box[0][2]; xz = box[1][2]; yz = box[2][2]; @@ -546,7 +549,7 @@ void ReadDump::header(int fieldinfo) error->one(FLERR,"Read_dump triclinic status does not match simulation"); } - // error check on requested fields exisiting in dump file + // error check on requested fields existing in dump file if (fieldflag < 0) error->one(FLERR,"Read_dump field not found in dump file"); diff --git a/src/reader.cpp b/src/reader.cpp index cf344b37b3..5292c9c992 100644 --- a/src/reader.cpp +++ b/src/reader.cpp @@ -75,3 +75,13 @@ void Reader::close_file() else fclose(fp); fp = NULL; } + +/* ---------------------------------------------------------------------- + detect unused arguments +------------------------------------------------------------------------- */ + +void Reader::settings(int narg, char** /*args*/) +{ + if (narg > 0) + error->all(FLERR,"Illegal read_dump command"); +} diff --git a/src/reader.h b/src/reader.h index 8f36bf622a..08b0010b81 100644 --- a/src/reader.h +++ b/src/reader.h @@ -25,7 +25,7 @@ class Reader : protected Pointers { Reader(class LAMMPS *); virtual ~Reader() {} - virtual void settings(int, char**) {}; + virtual void settings(int, char**); virtual int read_time(bigint &) = 0; virtual void skip() = 0; -- GitLab From 5b7ae3713b5722fc87871b716f6107885fd6cbe5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 7 Jul 2019 21:02:51 -0400 Subject: [PATCH 202/469] clean up include handling for VORONOI package --- src/VORONOI/compute_voronoi_atom.cpp | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/src/VORONOI/compute_voronoi_atom.cpp b/src/VORONOI/compute_voronoi_atom.cpp index 860126fa77..27252fae89 100644 --- a/src/VORONOI/compute_voronoi_atom.cpp +++ b/src/VORONOI/compute_voronoi_atom.cpp @@ -15,16 +15,14 @@ Contributing author: Daniel Schwen ------------------------------------------------------------------------- */ +#include "compute_voronoi_atom.h" #include #include #include -#include #include "voro++.hh" -#include "compute_voronoi_atom.h" #include "atom.h" #include "group.h" #include "update.h" -#include "modify.h" #include "domain.h" #include "memory.h" #include "error.h" -- GitLab From 60a808d25b61d57d68513d05cc5b99491610e53d Mon Sep 17 00:00:00 2001 From: jrgissing Date: Sun, 7 Jul 2019 21:17:23 -0600 Subject: [PATCH 203/469] bond/react: error->all vs. error->one also, correct several incorrect instances of error printing, which could cause code to hang without explanation --- src/USER-MISC/fix_bond_react.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/USER-MISC/fix_bond_react.cpp b/src/USER-MISC/fix_bond_react.cpp index c641912db6..7be8ec9f4f 100644 --- a/src/USER-MISC/fix_bond_react.cpp +++ b/src/USER-MISC/fix_bond_react.cpp @@ -1286,7 +1286,7 @@ void FixBondReact::make_a_guess() for (int i = 0; i < nxspecial[atom->map(glove[pion][1])][0]; i++) { if (atom->map(xspecial[atom->map(glove[pion][1])][i]) < 0) { - error->all(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away1"); // parallel issues. + error->one(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away"); // parallel issues. } if (i_limit_tags[(int)atom->map(xspecial[atom->map(glove[pion][1])][i])] != 0) { status = GUESSFAIL; @@ -1397,7 +1397,7 @@ void FixBondReact::check_a_neighbor() //another check for ghost atoms. perhaps remove the one in make_a_guess if (atom->map(glove[(int)onemol_xspecial[pion][neigh]-1][1]) < 0) { - error->all(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away2"); + error->one(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away"); } for (int j = 0; j < onemol_nxspecial[onemol_xspecial[pion][neigh]-1][0]; j++) { @@ -1449,7 +1449,7 @@ void FixBondReact::check_a_neighbor() //another check for ghost atoms. perhaps remove the one in make_a_guess if (atom->map(glove[(int)onemol_xspecial[pion][neigh]-1][1]) < 0) { - error->all(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away3"); + error->one(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away"); } for (int ii = 0; ii < onemol_nxspecial[onemol_xspecial[pion][neigh]-1][0]; ii++) { @@ -1560,7 +1560,7 @@ void FixBondReact::inner_crosscheck_loop() //another check for ghost atoms. perhaps remove the one in make_a_guess if (atom->map(glove[(int)onemol_xspecial[pion][neigh]-1][1]) < 0) { - error->all(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away4"); + error->one(FLERR,"Bond/react: Fix bond/react needs ghost atoms from further away"); } if (guess_branch[avail_guesses-1] == 0) avail_guesses--; -- GitLab From 03418be6452b62299638122a183f016751c19cf3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 8 Jul 2019 15:43:57 -0400 Subject: [PATCH 204/469] minor tweaks to already processed files --- src/ASPHERE/pair_line_lj.cpp | 3 --- src/ASPHERE/pair_resquared.cpp | 5 +---- src/ASPHERE/pair_tri_lj.cpp | 3 --- src/CORESHELL/pair_born_coul_long_cs.cpp | 1 - src/GRANULAR/fix_wall_gran_region.cpp | 1 - src/KSPACE/msm.h | 3 --- src/KSPACE/pair_coul_msm.cpp | 1 - src/angle.h | 2 +- src/dump.h | 1 - src/kspace.h | 3 +-- src/mpiio.h | 2 +- src/region.h | 2 +- src/timer.cpp | 1 - src/write_restart.cpp | 1 - 14 files changed, 5 insertions(+), 24 deletions(-) diff --git a/src/ASPHERE/pair_line_lj.cpp b/src/ASPHERE/pair_line_lj.cpp index 0cb603c4fa..fdeb09aac4 100644 --- a/src/ASPHERE/pair_line_lj.cpp +++ b/src/ASPHERE/pair_line_lj.cpp @@ -13,9 +13,6 @@ #include "pair_line_lj.h" #include -#include -#include -#include #include "atom.h" #include "atom_vec_line.h" #include "force.h" diff --git a/src/ASPHERE/pair_resquared.cpp b/src/ASPHERE/pair_resquared.cpp index ba73c5ba0c..f139564320 100644 --- a/src/ASPHERE/pair_resquared.cpp +++ b/src/ASPHERE/pair_resquared.cpp @@ -16,10 +16,8 @@ ------------------------------------------------------------------------- */ #include "pair_resquared.h" +#include #include -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" @@ -27,7 +25,6 @@ #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "integrate.h" #include "memory.h" #include "error.h" diff --git a/src/ASPHERE/pair_tri_lj.cpp b/src/ASPHERE/pair_tri_lj.cpp index 3dde2a4f44..0984b0a30c 100644 --- a/src/ASPHERE/pair_tri_lj.cpp +++ b/src/ASPHERE/pair_tri_lj.cpp @@ -13,9 +13,6 @@ #include "pair_tri_lj.h" #include -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_tri.h" diff --git a/src/CORESHELL/pair_born_coul_long_cs.cpp b/src/CORESHELL/pair_born_coul_long_cs.cpp index f6262fa9e7..b56389e180 100644 --- a/src/CORESHELL/pair_born_coul_long_cs.cpp +++ b/src/CORESHELL/pair_born_coul_long_cs.cpp @@ -17,7 +17,6 @@ #include "pair_born_coul_long_cs.h" #include -#include #include "atom.h" #include "force.h" #include "neigh_list.h" diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index a4b798d6aa..95553b83b7 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -21,7 +21,6 @@ #include "atom.h" #include "domain.h" #include "update.h" -#include "pair.h" #include "memory.h" #include "error.h" #include "comm.h" diff --git a/src/KSPACE/msm.h b/src/KSPACE/msm.h index 0f81eb9c3f..bf393473e7 100644 --- a/src/KSPACE/msm.h +++ b/src/KSPACE/msm.h @@ -20,9 +20,6 @@ KSpaceStyle(msm,MSM) #ifndef LMP_MSM_H #define LMP_MSM_H -#include "lmptype.h" -#include - #include "kspace.h" namespace LAMMPS_NS { diff --git a/src/KSPACE/pair_coul_msm.cpp b/src/KSPACE/pair_coul_msm.cpp index 0917bb9275..5d42e1f046 100644 --- a/src/KSPACE/pair_coul_msm.cpp +++ b/src/KSPACE/pair_coul_msm.cpp @@ -22,7 +22,6 @@ #include "force.h" #include "kspace.h" #include "neigh_list.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/angle.h b/src/angle.h index 3e6812c4fd..7a008f7ca7 100644 --- a/src/angle.h +++ b/src/angle.h @@ -14,7 +14,7 @@ #ifndef LMP_ANGLE_H #define LMP_ANGLE_H -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/dump.h b/src/dump.h index 0173aa3112..bc7fd2d5a5 100644 --- a/src/dump.h +++ b/src/dump.h @@ -14,7 +14,6 @@ #ifndef LMP_DUMP_H #define LMP_DUMP_H -#include #include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/kspace.h b/src/kspace.h index 83ce19cd87..c04a0db989 100644 --- a/src/kspace.h +++ b/src/kspace.h @@ -14,8 +14,7 @@ #ifndef LMP_KSPACE_H #define LMP_KSPACE_H -#include -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export #ifdef FFT_SINGLE typedef float FFT_SCALAR; diff --git a/src/mpiio.h b/src/mpiio.h index 4953ade185..0098fca0e1 100644 --- a/src/mpiio.h +++ b/src/mpiio.h @@ -23,7 +23,7 @@ #error "The MPIIO package cannot be compiled in serial with MPI STUBS" #endif -#include "restart_mpiio.h" +#include "restart_mpiio.h" // IWYU pragma: export #else diff --git a/src/region.h b/src/region.h index 6a3806fed7..0dce004a5b 100644 --- a/src/region.h +++ b/src/region.h @@ -14,7 +14,7 @@ #ifndef LMP_REGION_H #define LMP_REGION_H -#include "pointers.h" +#include "pointers.h" // IWYU pragma: export namespace LAMMPS_NS { diff --git a/src/timer.cpp b/src/timer.cpp index 0dad8fb756..0a5e56ab35 100644 --- a/src/timer.cpp +++ b/src/timer.cpp @@ -18,7 +18,6 @@ #include "comm.h" #include "error.h" #include "force.h" -#include "memory.h" #ifdef _WIN32 #include diff --git a/src/write_restart.cpp b/src/write_restart.cpp index 5adb39067c..4b84e790b8 100644 --- a/src/write_restart.cpp +++ b/src/write_restart.cpp @@ -16,7 +16,6 @@ #include #include "atom.h" #include "atom_vec.h" -#include "atom_vec_hybrid.h" #include "group.h" #include "force.h" #include "pair.h" -- GitLab From 31e19e0824893165038f096313c5fe069c53c94a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 8 Jul 2019 16:23:49 -0400 Subject: [PATCH 205/469] complete cleaning includes in some more packages --- src/KSPACE/pair_buck_coul_msm.cpp | 6 ------ src/KSPACE/pair_lj_charmm_coul_msm.cpp | 1 - src/KSPACE/pair_lj_cut_coul_long.cpp | 1 + src/KSPACE/pair_lj_cut_coul_msm.cpp | 1 - src/MPIIO/dump_atom_mpiio.cpp | 4 ++-- src/MPIIO/dump_atom_mpiio.h | 1 - src/MPIIO/dump_cfg_mpiio.cpp | 6 ------ src/MPIIO/dump_custom_mpiio.cpp | 5 ----- src/MPIIO/dump_xyz_mpiio.cpp | 7 ------- src/USER-BOCS/fix_bocs.cpp | 1 - src/USER-CGDNA/bond_oxdna2_fene.cpp | 2 -- src/USER-CGDNA/bond_oxdna_fene.cpp | 2 -- src/USER-CGDNA/fix_nve_dot.cpp | 5 ----- src/USER-CGDNA/fix_nve_dotc_langevin.cpp | 2 -- src/USER-CGDNA/pair_oxdna2_coaxstk.cpp | 6 +----- src/USER-CGDNA/pair_oxdna2_dh.cpp | 10 +--------- src/USER-CGDNA/pair_oxdna2_excv.cpp | 4 ---- src/USER-CGDNA/pair_oxdna2_stk.cpp | 4 ---- src/USER-CGDNA/pair_oxdna_coaxstk.cpp | 6 +----- src/USER-CGDNA/pair_oxdna_excv.cpp | 8 +------- src/USER-CGDNA/pair_oxdna_hbond.cpp | 8 +------- src/USER-CGDNA/pair_oxdna_stk.cpp | 10 ++-------- src/USER-CGDNA/pair_oxdna_xstk.cpp | 6 +----- src/USER-DPD/pair_dpd_fdt_energy.cpp | 7 ++----- src/USER-DPD/pair_exp6_rx.cpp | 6 ++---- src/USER-MESO/atom_vec_tdpd.cpp | 1 - src/USER-MESO/compute_edpd_temp_atom.cpp | 3 +-- src/USER-MESO/fix_edpd_source.cpp | 11 ++--------- src/USER-MESO/fix_mvv_edpd.cpp | 4 +--- src/USER-MESO/fix_mvv_tdpd.cpp | 4 +--- src/VORONOI/compute_voronoi_atom.cpp | 2 +- 31 files changed, 21 insertions(+), 123 deletions(-) diff --git a/src/KSPACE/pair_buck_coul_msm.cpp b/src/KSPACE/pair_buck_coul_msm.cpp index 3d7687df90..1355a2f13a 100644 --- a/src/KSPACE/pair_buck_coul_msm.cpp +++ b/src/KSPACE/pair_buck_coul_msm.cpp @@ -13,21 +13,15 @@ #include "pair_buck_coul_msm.h" #include -#include -#include #include #include "atom.h" -#include "comm.h" #include "force.h" #include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/KSPACE/pair_lj_charmm_coul_msm.cpp b/src/KSPACE/pair_lj_charmm_coul_msm.cpp index 804ae5919d..a93a1275f4 100644 --- a/src/KSPACE/pair_lj_charmm_coul_msm.cpp +++ b/src/KSPACE/pair_lj_charmm_coul_msm.cpp @@ -21,7 +21,6 @@ #include "atom.h" #include "force.h" #include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/KSPACE/pair_lj_cut_coul_long.cpp b/src/KSPACE/pair_lj_cut_coul_long.cpp index 7921c814c3..fb79451b37 100644 --- a/src/KSPACE/pair_lj_cut_coul_long.cpp +++ b/src/KSPACE/pair_lj_cut_coul_long.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "pair_lj_cut_coul_long.h" +#include #include #include #include "atom.h" diff --git a/src/KSPACE/pair_lj_cut_coul_msm.cpp b/src/KSPACE/pair_lj_cut_coul_msm.cpp index f8021cc180..4ebbcb9a3f 100644 --- a/src/KSPACE/pair_lj_cut_coul_msm.cpp +++ b/src/KSPACE/pair_lj_cut_coul_msm.cpp @@ -21,7 +21,6 @@ #include "atom.h" #include "force.h" #include "kspace.h" -#include "update.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/MPIIO/dump_atom_mpiio.cpp b/src/MPIIO/dump_atom_mpiio.cpp index cde5b6258b..2b663554cc 100644 --- a/src/MPIIO/dump_atom_mpiio.cpp +++ b/src/MPIIO/dump_atom_mpiio.cpp @@ -16,11 +16,11 @@ ------------------------------------------------------------------------- */ #include "dump_atom_mpiio.h" +#include +#include #include #include "domain.h" -#include "atom.h" #include "update.h" -#include "group.h" #include "memory.h" #include "error.h" diff --git a/src/MPIIO/dump_atom_mpiio.h b/src/MPIIO/dump_atom_mpiio.h index ad49fa1182..36b43e3f08 100644 --- a/src/MPIIO/dump_atom_mpiio.h +++ b/src/MPIIO/dump_atom_mpiio.h @@ -21,7 +21,6 @@ DumpStyle(atom/mpiio,DumpAtomMPIIO) #define LMP_DUMP_ATOM_MPIIO_H #include "dump_atom.h" -#include namespace LAMMPS_NS { diff --git a/src/MPIIO/dump_cfg_mpiio.cpp b/src/MPIIO/dump_cfg_mpiio.cpp index 90f92d094d..31848b550c 100644 --- a/src/MPIIO/dump_cfg_mpiio.cpp +++ b/src/MPIIO/dump_cfg_mpiio.cpp @@ -21,12 +21,6 @@ #include #include "atom.h" #include "domain.h" -#include "comm.h" -#include "modify.h" -#include "compute.h" -#include "input.h" -#include "fix.h" -#include "variable.h" #include "update.h" #include "memory.h" #include "error.h" diff --git a/src/MPIIO/dump_custom_mpiio.cpp b/src/MPIIO/dump_custom_mpiio.cpp index 5838c61124..dca5833c5b 100644 --- a/src/MPIIO/dump_custom_mpiio.cpp +++ b/src/MPIIO/dump_custom_mpiio.cpp @@ -19,16 +19,11 @@ #include #include #include -#include "atom.h" -#include "force.h" #include "domain.h" -#include "region.h" -#include "group.h" #include "input.h" #include "variable.h" #include "update.h" #include "modify.h" -#include "compute.h" #include "fix.h" #include "memory.h" #include "error.h" diff --git a/src/MPIIO/dump_xyz_mpiio.cpp b/src/MPIIO/dump_xyz_mpiio.cpp index 7b647561bf..ee0532399a 100644 --- a/src/MPIIO/dump_xyz_mpiio.cpp +++ b/src/MPIIO/dump_xyz_mpiio.cpp @@ -19,17 +19,10 @@ #include #include #include -#include "atom.h" -#include "force.h" #include "domain.h" -#include "region.h" -#include "group.h" -#include "input.h" -#include "variable.h" #include "update.h" #include "modify.h" #include "compute.h" -#include "fix.h" #include "memory.h" #include "error.h" diff --git a/src/USER-BOCS/fix_bocs.cpp b/src/USER-BOCS/fix_bocs.cpp index e0952086dd..936e5ff58e 100644 --- a/src/USER-BOCS/fix_bocs.cpp +++ b/src/USER-BOCS/fix_bocs.cpp @@ -18,7 +18,6 @@ #include #include #include -#include "math_extra.h" #include "atom.h" #include "force.h" #include "group.h" diff --git a/src/USER-CGDNA/bond_oxdna2_fene.cpp b/src/USER-CGDNA/bond_oxdna2_fene.cpp index 2cd7883600..97005ef5f9 100644 --- a/src/USER-CGDNA/bond_oxdna2_fene.cpp +++ b/src/USER-CGDNA/bond_oxdna2_fene.cpp @@ -15,8 +15,6 @@ ------------------------------------------------------------------------- */ #include "bond_oxdna2_fene.h" -#include -#include using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/bond_oxdna_fene.cpp b/src/USER-CGDNA/bond_oxdna_fene.cpp index 8b94fd6a5a..8314576d63 100644 --- a/src/USER-CGDNA/bond_oxdna_fene.cpp +++ b/src/USER-CGDNA/bond_oxdna_fene.cpp @@ -16,10 +16,8 @@ #include "bond_oxdna_fene.h" #include -#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "update.h" #include "force.h" diff --git a/src/USER-CGDNA/fix_nve_dot.cpp b/src/USER-CGDNA/fix_nve_dot.cpp index 3bf6757df7..ff8e1c0ee2 100644 --- a/src/USER-CGDNA/fix_nve_dot.cpp +++ b/src/USER-CGDNA/fix_nve_dot.cpp @@ -15,15 +15,10 @@ ------------------------------------------------------------------------- */ #include "fix_nve_dot.h" -#include -#include -#include #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" -#include "force.h" #include "update.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/fix_nve_dotc_langevin.cpp b/src/USER-CGDNA/fix_nve_dotc_langevin.cpp index 61e3552f11..59def4c812 100644 --- a/src/USER-CGDNA/fix_nve_dotc_langevin.cpp +++ b/src/USER-CGDNA/fix_nve_dotc_langevin.cpp @@ -17,7 +17,6 @@ #include "fix_nve_dotc_langevin.h" #include -#include #include #include "math_extra.h" #include "atom.h" @@ -26,7 +25,6 @@ #include "update.h" #include "comm.h" #include "random_mars.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp index 1d0a2eb494..b96da3fa4a 100644 --- a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp +++ b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp @@ -15,9 +15,8 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna2_coaxstk.h" +#include #include -#include -#include #include #include "mf_oxdna.h" #include "atom.h" @@ -25,9 +24,6 @@ #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/USER-CGDNA/pair_oxdna2_dh.cpp b/src/USER-CGDNA/pair_oxdna2_dh.cpp index 22fc79dae4..ea1f4f84f4 100644 --- a/src/USER-CGDNA/pair_oxdna2_dh.cpp +++ b/src/USER-CGDNA/pair_oxdna2_dh.cpp @@ -15,28 +15,20 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna2_dh.h" +#include #include -#include -#include #include -#include "mf_oxdna.h" #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "atom_vec_ellipsoid.h" #include "math_extra.h" using namespace LAMMPS_NS; -using namespace MathConst; -using namespace MFOxdna; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-CGDNA/pair_oxdna2_excv.cpp b/src/USER-CGDNA/pair_oxdna2_excv.cpp index de4f8319b9..0a7da8e81a 100644 --- a/src/USER-CGDNA/pair_oxdna2_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna2_excv.cpp @@ -15,10 +15,6 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna2_excv.h" -#include -#include -#include -#include using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/pair_oxdna2_stk.cpp b/src/USER-CGDNA/pair_oxdna2_stk.cpp index 3b9480bff6..26bae766e1 100644 --- a/src/USER-CGDNA/pair_oxdna2_stk.cpp +++ b/src/USER-CGDNA/pair_oxdna2_stk.cpp @@ -15,10 +15,6 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna2_stk.h" -#include -#include -#include -#include using namespace LAMMPS_NS; diff --git a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp index 7310f60ec3..6e37352ef0 100644 --- a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp +++ b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp @@ -15,9 +15,8 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna_coaxstk.h" +#include #include -#include -#include #include #include "mf_oxdna.h" #include "atom.h" @@ -25,9 +24,6 @@ #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/USER-CGDNA/pair_oxdna_excv.cpp b/src/USER-CGDNA/pair_oxdna_excv.cpp index 68091f4190..9fb3dd041a 100644 --- a/src/USER-CGDNA/pair_oxdna_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna_excv.cpp @@ -15,9 +15,8 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna_excv.h" +#include #include -#include -#include #include #include "mf_oxdna.h" #include "atom.h" @@ -25,17 +24,12 @@ #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "atom_vec_ellipsoid.h" #include "math_extra.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace MFOxdna; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-CGDNA/pair_oxdna_hbond.cpp b/src/USER-CGDNA/pair_oxdna_hbond.cpp index 2de05e66ae..12e4b08c46 100644 --- a/src/USER-CGDNA/pair_oxdna_hbond.cpp +++ b/src/USER-CGDNA/pair_oxdna_hbond.cpp @@ -15,9 +15,8 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna_hbond.h" +#include #include -#include -#include #include #include "mf_oxdna.h" #include "atom.h" @@ -25,17 +24,12 @@ #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "atom_vec_ellipsoid.h" #include "math_extra.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace MFOxdna; // sequence-specific base-pairing strength diff --git a/src/USER-CGDNA/pair_oxdna_stk.cpp b/src/USER-CGDNA/pair_oxdna_stk.cpp index aaa25039ef..022d94f935 100644 --- a/src/USER-CGDNA/pair_oxdna_stk.cpp +++ b/src/USER-CGDNA/pair_oxdna_stk.cpp @@ -15,27 +15,21 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna_stk.h" +#include #include -#include -#include #include +#include #include "mf_oxdna.h" #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "atom_vec_ellipsoid.h" #include "math_extra.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace MFOxdna; // sequence-specific stacking strength diff --git a/src/USER-CGDNA/pair_oxdna_xstk.cpp b/src/USER-CGDNA/pair_oxdna_xstk.cpp index 806f8a42c6..384a7768bd 100644 --- a/src/USER-CGDNA/pair_oxdna_xstk.cpp +++ b/src/USER-CGDNA/pair_oxdna_xstk.cpp @@ -15,9 +15,8 @@ ------------------------------------------------------------------------- */ #include "pair_oxdna_xstk.h" +#include #include -#include -#include #include #include "mf_oxdna.h" #include "atom.h" @@ -25,9 +24,6 @@ #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/USER-DPD/pair_dpd_fdt_energy.cpp b/src/USER-DPD/pair_dpd_fdt_energy.cpp index 12e6989c00..22741a055d 100644 --- a/src/USER-DPD/pair_dpd_fdt_energy.cpp +++ b/src/USER-DPD/pair_dpd_fdt_energy.cpp @@ -15,23 +15,20 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ +#include "pair_dpd_fdt_energy.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "update.h" #include "fix.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "random_mars.h" #include "memory.h" #include "modify.h" -#include "pair_dpd_fdt_energy.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-DPD/pair_exp6_rx.cpp b/src/USER-DPD/pair_exp6_rx.cpp index 13521b52b1..5cf2859ae3 100644 --- a/src/USER-DPD/pair_exp6_rx.cpp +++ b/src/USER-DPD/pair_exp6_rx.cpp @@ -11,17 +11,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_exp6_rx.h" +#include #include -#include #include #include #include -#include "pair_exp6_rx.h" #include "atom.h" #include "comm.h" #include "force.h" #include "neigh_list.h" -#include "math_const.h" #include "math_special.h" #include "memory.h" #include "error.h" @@ -29,7 +28,6 @@ #include "fix.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace MathSpecial; #define MAXLINE 1024 diff --git a/src/USER-MESO/atom_vec_tdpd.cpp b/src/USER-MESO/atom_vec_tdpd.cpp index aa0dc93809..0db5437c4a 100644 --- a/src/USER-MESO/atom_vec_tdpd.cpp +++ b/src/USER-MESO/atom_vec_tdpd.cpp @@ -23,7 +23,6 @@ #include "update.h" #include "memory.h" #include "error.h" -#include "input.h" using namespace LAMMPS_NS; diff --git a/src/USER-MESO/compute_edpd_temp_atom.cpp b/src/USER-MESO/compute_edpd_temp_atom.cpp index 119e0079d1..9eb6e9752b 100644 --- a/src/USER-MESO/compute_edpd_temp_atom.cpp +++ b/src/USER-MESO/compute_edpd_temp_atom.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_edpd_temp_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MESO/fix_edpd_source.cpp b/src/USER-MESO/fix_edpd_source.cpp index 24bef2b1f7..e62d9a8a79 100644 --- a/src/USER-MESO/fix_edpd_source.cpp +++ b/src/USER-MESO/fix_edpd_source.cpp @@ -11,17 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "fix_edpd_source.h" +#include +#include #include "atom.h" -#include "comm.h" -#include "update.h" -#include "modify.h" -#include "domain.h" -#include "lattice.h" -#include "input.h" -#include "variable.h" #include "error.h" #include "force.h" diff --git a/src/USER-MESO/fix_mvv_edpd.cpp b/src/USER-MESO/fix_mvv_edpd.cpp index 8719d0d262..bd9cd9cc2a 100644 --- a/src/USER-MESO/fix_mvv_edpd.cpp +++ b/src/USER-MESO/fix_mvv_edpd.cpp @@ -29,13 +29,11 @@ Communications, 2015, 51: 11038-11040. ------------------------------------------------------------------------- */ -#include -#include #include "fix_mvv_edpd.h" +#include #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-MESO/fix_mvv_tdpd.cpp b/src/USER-MESO/fix_mvv_tdpd.cpp index 24b1bbcf48..b7fe37d7ee 100644 --- a/src/USER-MESO/fix_mvv_tdpd.cpp +++ b/src/USER-MESO/fix_mvv_tdpd.cpp @@ -25,13 +25,11 @@ -reaction problems". The Journal of Chemical Physics, 2015, 143: 014101. ------------------------------------------------------------------------- */ -#include -#include #include "fix_mvv_tdpd.h" +#include #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/VORONOI/compute_voronoi_atom.cpp b/src/VORONOI/compute_voronoi_atom.cpp index 27252fae89..d5976f85d3 100644 --- a/src/VORONOI/compute_voronoi_atom.cpp +++ b/src/VORONOI/compute_voronoi_atom.cpp @@ -19,7 +19,7 @@ #include #include #include -#include "voro++.hh" +#include #include "atom.h" #include "group.h" #include "update.h" -- GitLab From cfaa53729697d88ecf1c5bb7453306b887823f5a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 8 Jul 2019 17:40:30 -0400 Subject: [PATCH 206/469] use alternate implementation of numeric conversion functions these new functions allow to choose between aborting with Error::one() and exiting with Error::all(). in the long run those should replace all of the functions in Force. --- src/DIPOLE/atom_vec_dipole.cpp | 19 +-- src/KOKKOS/atom_vec_angle_kokkos.cpp | 9 +- src/KOKKOS/atom_vec_atomic_kokkos.cpp | 5 +- src/KOKKOS/atom_vec_bond_kokkos.cpp | 9 +- src/KOKKOS/atom_vec_charge_kokkos.cpp | 9 +- src/KOKKOS/atom_vec_dpd_kokkos.cpp | 7 +- src/KOKKOS/atom_vec_full_kokkos.cpp | 13 +- src/KOKKOS/atom_vec_hybrid_kokkos.cpp | 9 +- src/KOKKOS/atom_vec_molecular_kokkos.cpp | 9 +- src/KOKKOS/atom_vec_sphere_kokkos.cpp | 29 ++--- src/MOLECULE/atom_vec_angle.cpp | 3 +- src/MOLECULE/atom_vec_bond.cpp | 3 +- src/MOLECULE/atom_vec_full.cpp | 7 +- src/MOLECULE/atom_vec_molecular.cpp | 3 +- src/MOLECULE/atom_vec_template.cpp | 11 +- src/PERI/atom_vec_peri.cpp | 11 +- src/SPIN/atom_vec_spin.cpp | 19 +-- src/USER-AWPMD/atom_vec_wavepacket.cpp | 37 +++--- src/USER-DPD/atom_vec_dpd.cpp | 7 +- src/USER-EFF/atom_vec_electron.cpp | 25 ++-- src/USER-MESO/atom_vec_edpd.cpp | 7 +- src/USER-MESO/atom_vec_mdpd.cpp | 7 +- src/USER-MESO/atom_vec_tdpd.cpp | 3 +- src/USER-SMD/atom_vec_smd.cpp | 29 ++--- src/USER-SPH/atom_vec_meso.cpp | 15 +-- src/atom_vec.cpp | 7 +- src/atom_vec_atomic.cpp | 3 +- src/atom_vec_body.cpp | 28 ++--- src/atom_vec_charge.cpp | 7 +- src/atom_vec_ellipsoid.cpp | 43 +++---- src/atom_vec_hybrid.cpp | 9 +- src/atom_vec_line.cpp | 37 +++--- src/atom_vec_sphere.cpp | 29 ++--- src/atom_vec_tri.cpp | 59 +++++----- src/utils.cpp | 144 +++++++++++++++++++++++ src/utils.h | 56 ++++++++- 36 files changed, 479 insertions(+), 248 deletions(-) diff --git a/src/DIPOLE/atom_vec_dipole.cpp b/src/DIPOLE/atom_vec_dipole.cpp index b469327c80..47fff1d4c5 100644 --- a/src/DIPOLE/atom_vec_dipole.cpp +++ b/src/DIPOLE/atom_vec_dipole.cpp @@ -22,6 +22,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -781,19 +782,19 @@ void AtomVecDipole::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = force->numeric(FLERR,values[2]); + q[nlocal] = utils::numeric(FLERR,values[2],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; x[nlocal][2] = coord[2]; - mu[nlocal][0] = force->numeric(FLERR,values[6]); - mu[nlocal][1] = force->numeric(FLERR,values[7]); - mu[nlocal][2] = force->numeric(FLERR,values[8]); + mu[nlocal][0] = utils::numeric(FLERR,values[6],true,lmp); + mu[nlocal][1] = utils::numeric(FLERR,values[7],true,lmp); + mu[nlocal][2] = utils::numeric(FLERR,values[8],true,lmp); mu[nlocal][3] = sqrt(mu[nlocal][0]*mu[nlocal][0] + mu[nlocal][1]*mu[nlocal][1] + mu[nlocal][2]*mu[nlocal][2]); @@ -815,10 +816,10 @@ void AtomVecDipole::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecDipole::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = force->numeric(FLERR,values[0]); - mu[nlocal][0] = force->numeric(FLERR,values[1]); - mu[nlocal][1] = force->numeric(FLERR,values[2]); - mu[nlocal][2] = force->numeric(FLERR,values[3]); + q[nlocal] = utils::numeric(FLERR,values[0],true,lmp); + mu[nlocal][0] = utils::numeric(FLERR,values[1],true,lmp); + mu[nlocal][1] = utils::numeric(FLERR,values[2],true,lmp); + mu[nlocal][2] = utils::numeric(FLERR,values[3],true,lmp); mu[nlocal][3] = sqrt(mu[nlocal][0]*mu[nlocal][0] + mu[nlocal][1]*mu[nlocal][1] + mu[nlocal][2]*mu[nlocal][2]); diff --git a/src/KOKKOS/atom_vec_angle_kokkos.cpp b/src/KOKKOS/atom_vec_angle_kokkos.cpp index b6cf8ba2b2..06358289b6 100644 --- a/src/KOKKOS/atom_vec_angle_kokkos.cpp +++ b/src/KOKKOS/atom_vec_angle_kokkos.cpp @@ -22,6 +22,7 @@ #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -1633,9 +1634,9 @@ void AtomVecAngleKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = force->inumeric(FLERR,values[0]); - h_molecule(nlocal) = force->inumeric(FLERR,values[1]); - h_type(nlocal) = force->inumeric(FLERR,values[2]); + h_tag(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); + h_molecule(nlocal) = utils::inumeric(FLERR,values[1],true,lmp); + h_type(nlocal) = utils::inumeric(FLERR,values[2],true,lmp); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1662,7 +1663,7 @@ void AtomVecAngleKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecAngleKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = force->inumeric(FLERR,values[0]); + h_molecule(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); h_num_bond(nlocal) = 0; h_num_angle(nlocal) = 0; return 1; diff --git a/src/KOKKOS/atom_vec_atomic_kokkos.cpp b/src/KOKKOS/atom_vec_atomic_kokkos.cpp index b0cf4e483a..6e530bdbe9 100644 --- a/src/KOKKOS/atom_vec_atomic_kokkos.cpp +++ b/src/KOKKOS/atom_vec_atomic_kokkos.cpp @@ -22,6 +22,7 @@ #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -824,8 +825,8 @@ void AtomVecAtomicKokkos::data_atom(double *coord, tagint imagetmp, int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - h_tag[nlocal] = force->inumeric(FLERR,values[0]); - h_type[nlocal] = force->inumeric(FLERR,values[1]); + h_tag[nlocal] = utils::inumeric(FLERR,values[0],true,lmp); + h_type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/KOKKOS/atom_vec_bond_kokkos.cpp b/src/KOKKOS/atom_vec_bond_kokkos.cpp index bac06e7845..3195ea0876 100644 --- a/src/KOKKOS/atom_vec_bond_kokkos.cpp +++ b/src/KOKKOS/atom_vec_bond_kokkos.cpp @@ -22,6 +22,7 @@ #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -1059,9 +1060,9 @@ void AtomVecBondKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = force->inumeric(FLERR,values[0]); - h_molecule(nlocal) = force->inumeric(FLERR,values[1]); - h_type(nlocal) = force->inumeric(FLERR,values[2]); + h_tag(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); + h_molecule(nlocal) = utils::inumeric(FLERR,values[1],true,lmp); + h_type(nlocal) = utils::inumeric(FLERR,values[2],true,lmp); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1087,7 +1088,7 @@ void AtomVecBondKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecBondKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = force->inumeric(FLERR,values[0]); + h_molecule(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); h_num_bond(nlocal) = 0; return 1; } diff --git a/src/KOKKOS/atom_vec_charge_kokkos.cpp b/src/KOKKOS/atom_vec_charge_kokkos.cpp index 44f9a44052..77d0c1dae3 100644 --- a/src/KOKKOS/atom_vec_charge_kokkos.cpp +++ b/src/KOKKOS/atom_vec_charge_kokkos.cpp @@ -22,6 +22,7 @@ #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -960,12 +961,12 @@ void AtomVecChargeKokkos::data_atom(double *coord, imageint imagetmp, int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - h_tag[nlocal] = force->inumeric(FLERR,values[0]); - h_type[nlocal] = force->inumeric(FLERR,values[1]); + h_tag[nlocal] = utils::inumeric(FLERR,values[0],true,lmp); + h_type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - h_q[nlocal] = force->numeric(FLERR,values[2]); + h_q[nlocal] = utils::numeric(FLERR,values[2],true,lmp); h_x(nlocal,0) = coord[0]; h_x(nlocal,1) = coord[1]; @@ -989,7 +990,7 @@ void AtomVecChargeKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecChargeKokkos::data_atom_hybrid(int nlocal, char **values) { - h_q[nlocal] = force->numeric(FLERR,values[0]); + h_q[nlocal] = utils::numeric(FLERR,values[0],true,lmp); return 1; } diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index d3c3e71331..93ca976892 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -22,6 +22,7 @@ #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -1724,11 +1725,11 @@ void AtomVecDPDKokkos::data_atom(double *coord, tagint imagetmp, if (nlocal == nmax) grow(0); h_tag[nlocal] = ATOTAGINT(values[0]); - h_type[nlocal] = force->inumeric(FLERR,values[1]); + h_type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - h_dpdTheta[nlocal] = force->numeric(FLERR,values[2]); + h_dpdTheta[nlocal] = utils::numeric(FLERR,values[2],true,lmp); if (h_dpdTheta[nlocal] <= 0) error->one(FLERR,"Internal temperature in Atoms section of date file must be > zero"); @@ -1762,7 +1763,7 @@ void AtomVecDPDKokkos::data_atom(double *coord, tagint imagetmp, int AtomVecDPDKokkos::data_atom_hybrid(int nlocal, char **values) { - h_dpdTheta(nlocal) = force->numeric(FLERR,values[0]); + h_dpdTheta(nlocal) = utils::numeric(FLERR,values[0],true,lmp); atomKK->modified(Host,DPDTHETA_MASK); diff --git a/src/KOKKOS/atom_vec_full_kokkos.cpp b/src/KOKKOS/atom_vec_full_kokkos.cpp index c10402de8c..19443b231f 100644 --- a/src/KOKKOS/atom_vec_full_kokkos.cpp +++ b/src/KOKKOS/atom_vec_full_kokkos.cpp @@ -22,6 +22,7 @@ #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -1488,13 +1489,13 @@ void AtomVecFullKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = force->inumeric(FLERR,values[0]); - h_molecule(nlocal) = force->inumeric(FLERR,values[1]); - h_type(nlocal) = force->inumeric(FLERR,values[2]); + h_tag(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); + h_molecule(nlocal) = utils::inumeric(FLERR,values[1],true,lmp); + h_type(nlocal) = utils::inumeric(FLERR,values[2],true,lmp); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - h_q(nlocal) = force->numeric(FLERR,values[3]); + h_q(nlocal) = utils::numeric(FLERR,values[3],true,lmp); h_x(nlocal,0) = coord[0]; h_x(nlocal,1) = coord[1]; @@ -1521,8 +1522,8 @@ void AtomVecFullKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecFullKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = force->inumeric(FLERR,values[0]); - h_q(nlocal) = force->numeric(FLERR,values[1]); + h_molecule(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); + h_q(nlocal) = utils::numeric(FLERR,values[1],true,lmp); h_num_bond(nlocal) = 0; h_num_angle(nlocal) = 0; h_num_dihedral(nlocal) = 0; diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp index 4c3de20a49..54dd89bfb3 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp @@ -22,6 +22,7 @@ #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -976,7 +977,7 @@ void AtomVecHybridKokkos::data_atom(double *coord, imageint imagetmp, char **val if (nlocal == nmax) grow(0); h_tag[nlocal] = ATOTAGINT(values[0]); - h_type[nlocal] = force->inumeric(FLERR,values[1]); + h_type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (h_type[nlocal] <= 0 || h_type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom h_type in Atoms section of data file"); @@ -1020,9 +1021,9 @@ void AtomVecHybridKokkos::data_vel(int m, char **values) { atomKK->sync(Host,V_MASK); - h_v(m,0) = force->numeric(FLERR,values[0]); - h_v(m,1) = force->numeric(FLERR,values[1]); - h_v(m,2) = force->numeric(FLERR,values[2]); + h_v(m,0) = utils::numeric(FLERR,values[0],true,lmp); + h_v(m,1) = utils::numeric(FLERR,values[1],true,lmp); + h_v(m,2) = utils::numeric(FLERR,values[2],true,lmp); atomKK->modified(Host,V_MASK); diff --git a/src/KOKKOS/atom_vec_molecular_kokkos.cpp b/src/KOKKOS/atom_vec_molecular_kokkos.cpp index 0616b3dfe0..9871b1247a 100644 --- a/src/KOKKOS/atom_vec_molecular_kokkos.cpp +++ b/src/KOKKOS/atom_vec_molecular_kokkos.cpp @@ -22,6 +22,7 @@ #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -1892,9 +1893,9 @@ void AtomVecMolecularKokkos::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); atomKK->modified(Host,ALL_MASK); - h_tag(nlocal) = force->inumeric(FLERR,values[0]); - h_molecule(nlocal) = force->inumeric(FLERR,values[1]); - h_type(nlocal) = force->inumeric(FLERR,values[2]); + h_tag(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); + h_molecule(nlocal) = utils::inumeric(FLERR,values[1],true,lmp); + h_type(nlocal) = utils::inumeric(FLERR,values[2],true,lmp); if (h_type(nlocal) <= 0 || h_type(nlocal) > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1923,7 +1924,7 @@ void AtomVecMolecularKokkos::data_atom(double *coord, imageint imagetmp, int AtomVecMolecularKokkos::data_atom_hybrid(int nlocal, char **values) { - h_molecule(nlocal) = force->inumeric(FLERR,values[0]); + h_molecule(nlocal) = utils::inumeric(FLERR,values[0],true,lmp); h_num_bond(nlocal) = 0; h_num_angle(nlocal) = 0; h_num_dihedral(nlocal) = 0; diff --git a/src/KOKKOS/atom_vec_sphere_kokkos.cpp b/src/KOKKOS/atom_vec_sphere_kokkos.cpp index 57dc7ef43d..bc72bcbf5e 100644 --- a/src/KOKKOS/atom_vec_sphere_kokkos.cpp +++ b/src/KOKKOS/atom_vec_sphere_kokkos.cpp @@ -27,6 +27,7 @@ #include "memory.h" #include "error.h" #include "memory_kokkos.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -2549,15 +2550,15 @@ void AtomVecSphereKokkos::data_atom(double *coord, imageint imagetmp, char **val if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - radius[nlocal] = 0.5 * force->numeric(FLERR,values[2]); + radius[nlocal] = 0.5 * utils::numeric(FLERR,values[2],true,lmp); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = force->numeric(FLERR,values[3]); + double density = utils::numeric(FLERR,values[3],true,lmp); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -2592,11 +2593,11 @@ void AtomVecSphereKokkos::data_atom(double *coord, imageint imagetmp, char **val int AtomVecSphereKokkos::data_atom_hybrid(int nlocal, char **values) { - radius[nlocal] = 0.5 * force->numeric(FLERR,values[0]); + radius[nlocal] = 0.5 * utils::numeric(FLERR,values[0],true,lmp); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = force->numeric(FLERR,values[1]); + double density = utils::numeric(FLERR,values[1],true,lmp); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -2618,12 +2619,12 @@ int AtomVecSphereKokkos::data_atom_hybrid(int nlocal, char **values) void AtomVecSphereKokkos::data_vel(int m, char **values) { atomKK->sync(Host,V_MASK|OMEGA_MASK); - h_v(m,0) = force->numeric(FLERR,values[0]); - h_v(m,1) = force->numeric(FLERR,values[1]); - h_v(m,2) = force->numeric(FLERR,values[2]); - h_omega(m,0) = force->numeric(FLERR,values[3]); - h_omega(m,1) = force->numeric(FLERR,values[4]); - h_omega(m,2) = force->numeric(FLERR,values[5]); + h_v(m,0) = utils::numeric(FLERR,values[0],true,lmp); + h_v(m,1) = utils::numeric(FLERR,values[1],true,lmp); + h_v(m,2) = utils::numeric(FLERR,values[2],true,lmp); + h_omega(m,0) = utils::numeric(FLERR,values[3],true,lmp); + h_omega(m,1) = utils::numeric(FLERR,values[4],true,lmp); + h_omega(m,2) = utils::numeric(FLERR,values[5],true,lmp); atomKK->modified(Host,V_MASK|OMEGA_MASK); } @@ -2634,9 +2635,9 @@ void AtomVecSphereKokkos::data_vel(int m, char **values) int AtomVecSphereKokkos::data_vel_hybrid(int m, char **values) { atomKK->sync(Host,OMEGA_MASK); - omega[m][0] = force->numeric(FLERR,values[0]); - omega[m][1] = force->numeric(FLERR,values[1]); - omega[m][2] = force->numeric(FLERR,values[2]); + omega[m][0] = utils::numeric(FLERR,values[0],true,lmp); + omega[m][1] = utils::numeric(FLERR,values[1],true,lmp); + omega[m][2] = utils::numeric(FLERR,values[2],true,lmp); atomKK->modified(Host,OMEGA_MASK); return 3; } diff --git a/src/MOLECULE/atom_vec_angle.cpp b/src/MOLECULE/atom_vec_angle.cpp index 594a039463..87220bfad6 100644 --- a/src/MOLECULE/atom_vec_angle.cpp +++ b/src/MOLECULE/atom_vec_angle.cpp @@ -21,6 +21,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -794,7 +795,7 @@ void AtomVecAngle::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = force->inumeric(FLERR,values[2]); + type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/MOLECULE/atom_vec_bond.cpp b/src/MOLECULE/atom_vec_bond.cpp index 12eafbc6ce..6f0c63529b 100644 --- a/src/MOLECULE/atom_vec_bond.cpp +++ b/src/MOLECULE/atom_vec_bond.cpp @@ -21,6 +21,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -740,7 +741,7 @@ void AtomVecBond::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = force->inumeric(FLERR,values[2]); + type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/MOLECULE/atom_vec_full.cpp b/src/MOLECULE/atom_vec_full.cpp index 4cad70f782..0cb95254e3 100644 --- a/src/MOLECULE/atom_vec_full.cpp +++ b/src/MOLECULE/atom_vec_full.cpp @@ -21,6 +21,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -943,11 +944,11 @@ void AtomVecFull::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = force->inumeric(FLERR,values[2]); + type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = force->numeric(FLERR,values[3]); + q[nlocal] = utils::numeric(FLERR,values[3],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -975,7 +976,7 @@ void AtomVecFull::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecFull::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - q[nlocal] = force->numeric(FLERR,values[1]); + q[nlocal] = utils::numeric(FLERR,values[1],true,lmp); num_bond[nlocal] = 0; num_angle[nlocal] = 0; diff --git a/src/MOLECULE/atom_vec_molecular.cpp b/src/MOLECULE/atom_vec_molecular.cpp index dfd833d1c8..28766fa67d 100644 --- a/src/MOLECULE/atom_vec_molecular.cpp +++ b/src/MOLECULE/atom_vec_molecular.cpp @@ -21,6 +21,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -927,7 +928,7 @@ void AtomVecMolecular::data_atom(double *coord, imageint imagetmp, tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = force->inumeric(FLERR,values[2]); + type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/MOLECULE/atom_vec_template.cpp b/src/MOLECULE/atom_vec_template.cpp index 2498010888..f7cf5f96db 100644 --- a/src/MOLECULE/atom_vec_template.cpp +++ b/src/MOLECULE/atom_vec_template.cpp @@ -23,6 +23,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -746,8 +747,8 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) error->one(FLERR,"Invalid atom ID in Atoms section of data file"); molecule[nlocal] = ATOTAGINT(values[1]); - molindex[nlocal] = force->inumeric(FLERR,values[2]) - 1; - molatom[nlocal] = force->inumeric(FLERR,values[3]) - 1; + molindex[nlocal] = utils::inumeric(FLERR,values[2],true,lmp) - 1; + molatom[nlocal] = utils::inumeric(FLERR,values[3],true,lmp) - 1; if (molindex[nlocal] < 0 || molindex[nlocal] >= nset) error->one(FLERR,"Invalid template index in Atoms section of data file"); @@ -755,7 +756,7 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) molatom[nlocal] >= onemols[molindex[nlocal]]->natoms) error->one(FLERR,"Invalid template atom in Atoms section of data file"); - type[nlocal] = force->inumeric(FLERR,values[4]); + type[nlocal] = utils::inumeric(FLERR,values[4],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -781,8 +782,8 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecTemplate::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - molindex[nlocal] = force->inumeric(FLERR,values[1]) - 1; - molatom[nlocal] = force->inumeric(FLERR,values[2]) - 1; + molindex[nlocal] = utils::inumeric(FLERR,values[1],true,lmp) - 1; + molatom[nlocal] = utils::inumeric(FLERR,values[2],true,lmp) - 1; return 3; } diff --git a/src/PERI/atom_vec_peri.cpp b/src/PERI/atom_vec_peri.cpp index 9b262477a6..25a0b8a933 100644 --- a/src/PERI/atom_vec_peri.cpp +++ b/src/PERI/atom_vec_peri.cpp @@ -28,6 +28,7 @@ #include "citeme.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -793,12 +794,12 @@ void AtomVecPeri::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - vfrac[nlocal] = force->numeric(FLERR,values[2]); - rmass[nlocal] = force->numeric(FLERR,values[3]); + vfrac[nlocal] = utils::numeric(FLERR,values[2],true,lmp); + rmass[nlocal] = utils::numeric(FLERR,values[3],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid mass value"); x[nlocal][0] = coord[0]; @@ -827,8 +828,8 @@ void AtomVecPeri::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecPeri::data_atom_hybrid(int nlocal, char **values) { - vfrac[nlocal] = force->numeric(FLERR,values[0]); - rmass[nlocal] = force->numeric(FLERR,values[1]); + vfrac[nlocal] = utils::numeric(FLERR,values[0],true,lmp); + rmass[nlocal] = utils::numeric(FLERR,values[1],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid mass value"); s0[nlocal] = DBL_MAX; diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index ba33372542..63c55759be 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -35,6 +35,7 @@ #include "force.h" #include "memory.h" #include "modify.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -813,7 +814,7 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -821,10 +822,10 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) x[nlocal][1] = coord[1]; x[nlocal][2] = coord[2]; - sp[nlocal][3] = force->numeric(FLERR,values[2]); - sp[nlocal][0] = force->numeric(FLERR,values[6]); - sp[nlocal][1] = force->numeric(FLERR,values[7]); - sp[nlocal][2] = force->numeric(FLERR,values[8]); + sp[nlocal][3] = utils::numeric(FLERR,values[2],true,lmp); + sp[nlocal][0] = utils::numeric(FLERR,values[6],true,lmp); + sp[nlocal][1] = utils::numeric(FLERR,values[7],true,lmp); + sp[nlocal][2] = utils::numeric(FLERR,values[8],true,lmp); double inorm = 1.0/sqrt(sp[nlocal][0]*sp[nlocal][0] + sp[nlocal][1]*sp[nlocal][1] + sp[nlocal][2]*sp[nlocal][2]); @@ -850,16 +851,16 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecSpin::data_atom_hybrid(int nlocal, char **values) { - sp[nlocal][0] = force->numeric(FLERR,values[0]); - sp[nlocal][1] = force->numeric(FLERR,values[1]); - sp[nlocal][2] = force->numeric(FLERR,values[2]); + sp[nlocal][0] = utils::numeric(FLERR,values[0],true,lmp); + sp[nlocal][1] = utils::numeric(FLERR,values[1],true,lmp); + sp[nlocal][2] = utils::numeric(FLERR,values[2],true,lmp); double inorm = 1.0/sqrt(sp[nlocal][0]*sp[nlocal][0] + sp[nlocal][1]*sp[nlocal][1] + sp[nlocal][2]*sp[nlocal][2]); sp[nlocal][0] *= inorm; sp[nlocal][1] *= inorm; sp[nlocal][2] *= inorm; - sp[nlocal][3] = force->numeric(FLERR,values[3]); + sp[nlocal][3] = utils::numeric(FLERR,values[3],true,lmp); return 4; } diff --git a/src/USER-AWPMD/atom_vec_wavepacket.cpp b/src/USER-AWPMD/atom_vec_wavepacket.cpp index 912544c860..67eaf94551 100644 --- a/src/USER-AWPMD/atom_vec_wavepacket.cpp +++ b/src/USER-AWPMD/atom_vec_wavepacket.cpp @@ -27,6 +27,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -916,19 +917,19 @@ void AtomVecWavepacket::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = force->numeric(FLERR,values[2]); - spin[nlocal] = force->inumeric(FLERR,values[3]); - eradius[nlocal] = force->numeric(FLERR,values[4]); + q[nlocal] = utils::numeric(FLERR,values[2],true,lmp); + spin[nlocal] = utils::inumeric(FLERR,values[3],true,lmp); + eradius[nlocal] = utils::numeric(FLERR,values[4],true,lmp); if (eradius[nlocal] < 0.0) error->one(FLERR,"Invalid eradius in Atoms section of data file"); - etag[nlocal] = force->inumeric(FLERR,values[5]); - cs[2*nlocal] = force->inumeric(FLERR,values[6]); - cs[2*nlocal+1] = force->numeric(FLERR,values[7]); + etag[nlocal] = utils::inumeric(FLERR,values[5],true,lmp); + cs[2*nlocal] = utils::inumeric(FLERR,values[6],true,lmp); + cs[2*nlocal+1] = utils::numeric(FLERR,values[7],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -952,15 +953,15 @@ void AtomVecWavepacket::data_atom(double *coord, imageint imagetmp, int AtomVecWavepacket::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = force->numeric(FLERR,values[0]); - spin[nlocal] = force->inumeric(FLERR,values[1]); - eradius[nlocal] = force->numeric(FLERR,values[2]); + q[nlocal] = utils::numeric(FLERR,values[0],true,lmp); + spin[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); + eradius[nlocal] = utils::numeric(FLERR,values[2],true,lmp); if (eradius[nlocal] < 0.0) error->one(FLERR,"Invalid eradius in Atoms section of data file"); - etag[nlocal] = force->inumeric(FLERR,values[3]); - cs[2*nlocal] = force->inumeric(FLERR,values[4]); - cs[2*nlocal+1] = force->numeric(FLERR,values[5]); + etag[nlocal] = utils::inumeric(FLERR,values[3],true,lmp); + cs[2*nlocal] = utils::inumeric(FLERR,values[4],true,lmp); + cs[2*nlocal+1] = utils::numeric(FLERR,values[5],true,lmp); v[nlocal][0] = 0.0; v[nlocal][1] = 0.0; @@ -976,10 +977,10 @@ int AtomVecWavepacket::data_atom_hybrid(int nlocal, char **values) void AtomVecWavepacket::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - ervel[m] = force->numeric(FLERR,values[3]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + ervel[m] = utils::numeric(FLERR,values[3],true,lmp); } /* ---------------------------------------------------------------------- @@ -988,7 +989,7 @@ void AtomVecWavepacket::data_vel(int m, char **values) int AtomVecWavepacket::data_vel_hybrid(int m, char **values) { - ervel[m] = force->numeric(FLERR,values[0]); + ervel[m] = utils::numeric(FLERR,values[0],true,lmp); return 1; } diff --git a/src/USER-DPD/atom_vec_dpd.cpp b/src/USER-DPD/atom_vec_dpd.cpp index 776de845ab..2aef55ff9f 100644 --- a/src/USER-DPD/atom_vec_dpd.cpp +++ b/src/USER-DPD/atom_vec_dpd.cpp @@ -25,6 +25,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -815,11 +816,11 @@ void AtomVecDPD::data_atom(double *coord, tagint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - dpdTheta[nlocal] = force->numeric(FLERR,values[2]); + dpdTheta[nlocal] = utils::numeric(FLERR,values[2],true,lmp); if (dpdTheta[nlocal] <= 0) error->one(FLERR,"Internal temperature in Atoms section of date file must be > zero"); @@ -851,7 +852,7 @@ void AtomVecDPD::data_atom(double *coord, tagint imagetmp, char **values) int AtomVecDPD::data_atom_hybrid(int nlocal, char **values) { - dpdTheta[nlocal] = force->numeric(FLERR,values[0]); + dpdTheta[nlocal] = utils::numeric(FLERR,values[0],true,lmp); return 1; } diff --git a/src/USER-EFF/atom_vec_electron.cpp b/src/USER-EFF/atom_vec_electron.cpp index 2cf04e189a..e62519d223 100644 --- a/src/USER-EFF/atom_vec_electron.cpp +++ b/src/USER-EFF/atom_vec_electron.cpp @@ -28,6 +28,7 @@ #include "citeme.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -799,15 +800,15 @@ void AtomVecElectron::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = force->numeric(FLERR,values[2]); - spin[nlocal] = force->inumeric(FLERR,values[3]); + q[nlocal] = utils::numeric(FLERR,values[2],true,lmp); + spin[nlocal] = utils::inumeric(FLERR,values[3],true,lmp); if (spin[nlocal] == 3) atom->ecp_flag = 1; - eradius[nlocal] = force->numeric(FLERR,values[4]); + eradius[nlocal] = utils::numeric(FLERR,values[4],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -831,9 +832,9 @@ void AtomVecElectron::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecElectron::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = force->numeric(FLERR,values[0]); - spin[nlocal] = force->inumeric(FLERR,values[1]); - eradius[nlocal] = force->numeric(FLERR,values[2]); + q[nlocal] = utils::numeric(FLERR,values[0],true,lmp); + spin[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); + eradius[nlocal] = utils::numeric(FLERR,values[2],true,lmp); if (eradius[nlocal] < 0.0) error->one(FLERR,"Invalid eradius in Atoms section of data file"); @@ -851,10 +852,10 @@ int AtomVecElectron::data_atom_hybrid(int nlocal, char **values) void AtomVecElectron::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - ervel[m] = force->numeric(FLERR,values[3]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + ervel[m] = utils::numeric(FLERR,values[3],true,lmp); } /* ---------------------------------------------------------------------- @@ -863,7 +864,7 @@ void AtomVecElectron::data_vel(int m, char **values) int AtomVecElectron::data_vel_hybrid(int m, char **values) { - ervel[m] = force->numeric(FLERR,values[0]); + ervel[m] = utils::numeric(FLERR,values[0],true,lmp); return 1; } diff --git a/src/USER-MESO/atom_vec_edpd.cpp b/src/USER-MESO/atom_vec_edpd.cpp index 25049ce003..ff8515abc6 100644 --- a/src/USER-MESO/atom_vec_edpd.cpp +++ b/src/USER-MESO/atom_vec_edpd.cpp @@ -22,6 +22,7 @@ #include "update.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -760,12 +761,12 @@ void AtomVecEDPD::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - edpd_temp[nlocal] = force->numeric(FLERR,values[2]); - edpd_cv[nlocal] = force->numeric(FLERR,values[3]); + edpd_temp[nlocal] = utils::numeric(FLERR,values[2],true,lmp); + edpd_cv[nlocal] = utils::numeric(FLERR,values[3],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; diff --git a/src/USER-MESO/atom_vec_mdpd.cpp b/src/USER-MESO/atom_vec_mdpd.cpp index 9952182851..965891a283 100644 --- a/src/USER-MESO/atom_vec_mdpd.cpp +++ b/src/USER-MESO/atom_vec_mdpd.cpp @@ -23,6 +23,7 @@ #include "update.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -799,7 +800,7 @@ void AtomVecMDPD::data_atom(double *coord, imageint imagetmp, char **values) { if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -818,7 +819,7 @@ void AtomVecMDPD::data_atom(double *coord, imageint imagetmp, char **values) { vest[nlocal][1] = 0.0; vest[nlocal][2] = 0.0; - rho[nlocal] = force->numeric(FLERR,values[2]); + rho[nlocal] = utils::numeric(FLERR,values[2],true,lmp); drho[nlocal] = 0.0; atom->nlocal++; @@ -831,7 +832,7 @@ void AtomVecMDPD::data_atom(double *coord, imageint imagetmp, char **values) { int AtomVecMDPD::data_atom_hybrid(int nlocal, char **values) { - rho[nlocal] = force->numeric(FLERR,values[0]); + rho[nlocal] = utils::numeric(FLERR,values[0],true,lmp); return 3; } diff --git a/src/USER-MESO/atom_vec_tdpd.cpp b/src/USER-MESO/atom_vec_tdpd.cpp index 261bef1795..def0a8ad7b 100644 --- a/src/USER-MESO/atom_vec_tdpd.cpp +++ b/src/USER-MESO/atom_vec_tdpd.cpp @@ -24,6 +24,7 @@ #include "memory.h" #include "error.h" #include "input.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -792,7 +793,7 @@ void AtomVecTDPD::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-SMD/atom_vec_smd.cpp b/src/USER-SMD/atom_vec_smd.cpp index fb2b1ccc69..278652bf43 100644 --- a/src/USER-SMD/atom_vec_smd.cpp +++ b/src/USER-SMD/atom_vec_smd.cpp @@ -36,6 +36,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -1029,7 +1030,7 @@ void AtomVecSMD::data_atom(double *coord, imageint imagetmp, char **values) { tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR, "Invalid atom type in Atoms section of data file"); @@ -1037,27 +1038,27 @@ void AtomVecSMD::data_atom(double *coord, imageint imagetmp, char **values) { if (molecule[nlocal] <= 0) error->one(FLERR, "Invalid molecule in Atoms section of data file"); - vfrac[nlocal] = force->numeric(FLERR,values[3]); + vfrac[nlocal] = utils::numeric(FLERR,values[3],true,lmp); if (vfrac[nlocal] < 0.0) error->one(FLERR, "Invalid volume in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[4]); + rmass[nlocal] = utils::numeric(FLERR,values[4],true,lmp); if (rmass[nlocal] == 0.0) error->one(FLERR, "Invalid mass in Atoms section of data file"); - radius[nlocal] = force->numeric(FLERR,values[5]); + radius[nlocal] = utils::numeric(FLERR,values[5],true,lmp); if (radius[nlocal] < 0.0) error->one(FLERR, "Invalid radius in Atoms section of data file"); - contact_radius[nlocal] = force->numeric(FLERR,values[6]); + contact_radius[nlocal] = utils::numeric(FLERR,values[6],true,lmp); if (contact_radius[nlocal] < 0.0) error->one(FLERR, "Invalid contact radius in Atoms section of data file"); e[nlocal] = 0.0; - x0[nlocal][0] = force->numeric(FLERR,values[7]); - x0[nlocal][1] = force->numeric(FLERR,values[8]); - x0[nlocal][2] = force->numeric(FLERR,values[9]); + x0[nlocal][0] = utils::numeric(FLERR,values[7],true,lmp); + x0[nlocal][1] = utils::numeric(FLERR,values[8],true,lmp); + x0[nlocal][2] = utils::numeric(FLERR,values[9],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -1108,12 +1109,12 @@ int AtomVecSMD::data_atom_hybrid(int /*nlocal*/, char **/*values*/) { ------------------------------------------------------------------------- */ void AtomVecSMD::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - vest[m][0] = force->numeric(FLERR,values[0]); - vest[m][1] = force->numeric(FLERR,values[1]); - vest[m][2] = force->numeric(FLERR,values[2]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + vest[m][0] = utils::numeric(FLERR,values[0],true,lmp); + vest[m][1] = utils::numeric(FLERR,values[1],true,lmp); + vest[m][2] = utils::numeric(FLERR,values[2],true,lmp); } /* ---------------------------------------------------------------------- diff --git a/src/USER-SPH/atom_vec_meso.cpp b/src/USER-SPH/atom_vec_meso.cpp index 763ce5af5a..0960141ae2 100644 --- a/src/USER-SPH/atom_vec_meso.cpp +++ b/src/USER-SPH/atom_vec_meso.cpp @@ -22,6 +22,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -844,13 +845,13 @@ void AtomVecMeso::data_atom(double *coord, imageint imagetmp, char **values) { if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rho[nlocal] = force->numeric(FLERR,values[2]); - e[nlocal] = force->numeric(FLERR,values[3]); - cv[nlocal] = force->numeric(FLERR,values[4]); + rho[nlocal] = utils::numeric(FLERR,values[2],true,lmp); + e[nlocal] = utils::numeric(FLERR,values[3],true,lmp); + cv[nlocal] = utils::numeric(FLERR,values[4],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -882,9 +883,9 @@ void AtomVecMeso::data_atom(double *coord, imageint imagetmp, char **values) { int AtomVecMeso::data_atom_hybrid(int nlocal, char **values) { - rho[nlocal] = force->numeric(FLERR,values[0]); - e[nlocal] = force->numeric(FLERR,values[1]); - cv[nlocal] = force->numeric(FLERR,values[2]); + rho[nlocal] = utils::numeric(FLERR,values[0],true,lmp); + e[nlocal] = utils::numeric(FLERR,values[1],true,lmp); + cv[nlocal] = utils::numeric(FLERR,values[2],true,lmp); return 3; } diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index 33caea05a2..d4bea15d0b 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -18,6 +18,7 @@ #include "force.h" #include "domain.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -113,9 +114,9 @@ int AtomVec::grow_nmax_bonus(int nmax_bonus) void AtomVec::data_vel(int m, char **values) { double **v = atom->v; - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); } /* ---------------------------------------------------------------------- diff --git a/src/atom_vec_atomic.cpp b/src/atom_vec_atomic.cpp index 2f01424d9d..0574db1d8e 100644 --- a/src/atom_vec_atomic.cpp +++ b/src/atom_vec_atomic.cpp @@ -21,6 +21,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -613,7 +614,7 @@ void AtomVecAtomic::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_body.cpp b/src/atom_vec_body.cpp index f54605fbb0..4b22933881 100644 --- a/src/atom_vec_body.cpp +++ b/src/atom_vec_body.cpp @@ -1280,16 +1280,16 @@ void AtomVecBody::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - body[nlocal] = force->inumeric(FLERR,values[2]); + body[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (body[nlocal] == 0) body[nlocal] = -1; else if (body[nlocal] == 1) body[nlocal] = 0; else error->one(FLERR,"Invalid bodyflag in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[3]); + rmass[nlocal] = utils::numeric(FLERR,values[3],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1318,12 +1318,12 @@ void AtomVecBody::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecBody::data_atom_hybrid(int nlocal, char **values) { - body[nlocal] = force->inumeric(FLERR,values[0]); + body[nlocal] = utils::inumeric(FLERR,values[0],true,lmp); if (body[nlocal] == 0) body[nlocal] = -1; else if (body[nlocal] == 1) body[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[1]); + rmass[nlocal] = utils::numeric(FLERR,values[1],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1350,12 +1350,12 @@ void AtomVecBody::data_body(int m, int ninteger, int ndouble, void AtomVecBody::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - angmom[m][0] = force->numeric(FLERR,values[3]); - angmom[m][1] = force->numeric(FLERR,values[4]); - angmom[m][2] = force->numeric(FLERR,values[5]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + angmom[m][0] = utils::numeric(FLERR,values[3],true,lmp); + angmom[m][1] = utils::numeric(FLERR,values[4],true,lmp); + angmom[m][2] = utils::numeric(FLERR,values[5],true,lmp); } /* ---------------------------------------------------------------------- @@ -1364,9 +1364,9 @@ void AtomVecBody::data_vel(int m, char **values) int AtomVecBody::data_vel_hybrid(int m, char **values) { - angmom[m][0] = force->numeric(FLERR,values[0]); - angmom[m][1] = force->numeric(FLERR,values[1]); - angmom[m][2] = force->numeric(FLERR,values[2]); + angmom[m][0] = utils::numeric(FLERR,values[0],true,lmp); + angmom[m][1] = utils::numeric(FLERR,values[1],true,lmp); + angmom[m][2] = utils::numeric(FLERR,values[2],true,lmp); return 3; } diff --git a/src/atom_vec_charge.cpp b/src/atom_vec_charge.cpp index 03ef95a2e4..1a78ba0e2d 100644 --- a/src/atom_vec_charge.cpp +++ b/src/atom_vec_charge.cpp @@ -21,6 +21,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -664,11 +665,11 @@ void AtomVecCharge::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - q[nlocal] = force->numeric(FLERR,values[2]); + q[nlocal] = utils::numeric(FLERR,values[2],true,lmp); x[nlocal][0] = coord[0]; x[nlocal][1] = coord[1]; @@ -691,7 +692,7 @@ void AtomVecCharge::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecCharge::data_atom_hybrid(int nlocal, char **values) { - q[nlocal] = force->numeric(FLERR,values[0]); + q[nlocal] = utils::numeric(FLERR,values[0],true,lmp); return 1; } diff --git a/src/atom_vec_ellipsoid.cpp b/src/atom_vec_ellipsoid.cpp index 1fc713e583..0b94359c55 100644 --- a/src/atom_vec_ellipsoid.cpp +++ b/src/atom_vec_ellipsoid.cpp @@ -27,6 +27,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -1141,16 +1142,16 @@ void AtomVecEllipsoid::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - ellipsoid[nlocal] = force->inumeric(FLERR,values[2]); + ellipsoid[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (ellipsoid[nlocal] == 0) ellipsoid[nlocal] = -1; else if (ellipsoid[nlocal] == 1) ellipsoid[nlocal] = 0; else error->one(FLERR,"Invalid ellipsoidflag in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[3]); + rmass[nlocal] = utils::numeric(FLERR,values[3],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1178,12 +1179,12 @@ void AtomVecEllipsoid::data_atom(double *coord, imageint imagetmp, int AtomVecEllipsoid::data_atom_hybrid(int nlocal, char **values) { - ellipsoid[nlocal] = force->inumeric(FLERR,values[0]); + ellipsoid[nlocal] = utils::inumeric(FLERR,values[0],true,lmp); if (ellipsoid[nlocal] == 0) ellipsoid[nlocal] = -1; else if (ellipsoid[nlocal] == 1) ellipsoid[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[1]); + rmass[nlocal] = utils::numeric(FLERR,values[1],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1202,17 +1203,17 @@ void AtomVecEllipsoid::data_atom_bonus(int m, char **values) if (nlocal_bonus == nmax_bonus) grow_bonus(); double *shape = bonus[nlocal_bonus].shape; - shape[0] = 0.5 * force->numeric(FLERR,values[0]); - shape[1] = 0.5 * force->numeric(FLERR,values[1]); - shape[2] = 0.5 * force->numeric(FLERR,values[2]); + shape[0] = 0.5 * utils::numeric(FLERR,values[0],true,lmp); + shape[1] = 0.5 * utils::numeric(FLERR,values[1],true,lmp); + shape[2] = 0.5 * utils::numeric(FLERR,values[2],true,lmp); if (shape[0] <= 0.0 || shape[1] <= 0.0 || shape[2] <= 0.0) error->one(FLERR,"Invalid shape in Ellipsoids section of data file"); double *quat = bonus[nlocal_bonus].quat; - quat[0] = force->numeric(FLERR,values[3]); - quat[1] = force->numeric(FLERR,values[4]); - quat[2] = force->numeric(FLERR,values[5]); - quat[3] = force->numeric(FLERR,values[6]); + quat[0] = utils::numeric(FLERR,values[3],true,lmp); + quat[1] = utils::numeric(FLERR,values[4],true,lmp); + quat[2] = utils::numeric(FLERR,values[5],true,lmp); + quat[3] = utils::numeric(FLERR,values[6],true,lmp); MathExtra::qnormalize(quat); // reset ellipsoid mass @@ -1230,12 +1231,12 @@ void AtomVecEllipsoid::data_atom_bonus(int m, char **values) void AtomVecEllipsoid::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - angmom[m][0] = force->numeric(FLERR,values[3]); - angmom[m][1] = force->numeric(FLERR,values[4]); - angmom[m][2] = force->numeric(FLERR,values[5]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + angmom[m][0] = utils::numeric(FLERR,values[3],true,lmp); + angmom[m][1] = utils::numeric(FLERR,values[4],true,lmp); + angmom[m][2] = utils::numeric(FLERR,values[5],true,lmp); } /* ---------------------------------------------------------------------- @@ -1244,9 +1245,9 @@ void AtomVecEllipsoid::data_vel(int m, char **values) int AtomVecEllipsoid::data_vel_hybrid(int m, char **values) { - angmom[m][0] = force->numeric(FLERR,values[0]); - angmom[m][1] = force->numeric(FLERR,values[1]); - angmom[m][2] = force->numeric(FLERR,values[2]); + angmom[m][0] = utils::numeric(FLERR,values[0],true,lmp); + angmom[m][1] = utils::numeric(FLERR,values[1],true,lmp); + angmom[m][2] = utils::numeric(FLERR,values[2],true,lmp); return 3; } diff --git a/src/atom_vec_hybrid.cpp b/src/atom_vec_hybrid.cpp index 94391ec9f3..a7816efbed 100644 --- a/src/atom_vec_hybrid.cpp +++ b/src/atom_vec_hybrid.cpp @@ -21,6 +21,7 @@ #include "fix.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -864,7 +865,7 @@ void AtomVecHybrid::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -904,9 +905,9 @@ void AtomVecHybrid::data_atom(double *coord, imageint imagetmp, char **values) void AtomVecHybrid::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); // each sub-style parses sub-style specific values diff --git a/src/atom_vec_line.cpp b/src/atom_vec_line.cpp index f229297798..6bffc1b0de 100644 --- a/src/atom_vec_line.cpp +++ b/src/atom_vec_line.cpp @@ -24,6 +24,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -1037,16 +1038,16 @@ void AtomVecLine::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = force->inumeric(FLERR,values[2]); + type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - line[nlocal] = force->inumeric(FLERR,values[3]); + line[nlocal] = utils::inumeric(FLERR,values[3],true,lmp); if (line[nlocal] == 0) line[nlocal] = -1; else if (line[nlocal] == 1) line[nlocal] = 0; else error->one(FLERR,"Invalid lineflag in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[4]); + rmass[nlocal] = utils::numeric(FLERR,values[4],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1082,12 +1083,12 @@ int AtomVecLine::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - line[nlocal] = force->inumeric(FLERR,values[1]); + line[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (line[nlocal] == 0) line[nlocal] = -1; else if (line[nlocal] == 1) line[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[2]); + rmass[nlocal] = utils::numeric(FLERR,values[2],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1110,10 +1111,10 @@ void AtomVecLine::data_atom_bonus(int m, char **values) if (nlocal_bonus == nmax_bonus) grow_bonus(); - double x1 = force->numeric(FLERR,values[0]); - double y1 = force->numeric(FLERR,values[1]); - double x2 = force->numeric(FLERR,values[2]); - double y2 = force->numeric(FLERR,values[3]); + double x1 = utils::numeric(FLERR,values[0],true,lmp); + double y1 = utils::numeric(FLERR,values[1],true,lmp); + double x2 = utils::numeric(FLERR,values[2],true,lmp); + double y2 = utils::numeric(FLERR,values[3],true,lmp); double dx = x2 - x1; double dy = y2 - y1; double length = sqrt(dx*dx + dy*dy); @@ -1150,12 +1151,12 @@ void AtomVecLine::data_atom_bonus(int m, char **values) void AtomVecLine::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - omega[m][0] = force->numeric(FLERR,values[3]); - omega[m][1] = force->numeric(FLERR,values[4]); - omega[m][2] = force->numeric(FLERR,values[5]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + omega[m][0] = utils::numeric(FLERR,values[3],true,lmp); + omega[m][1] = utils::numeric(FLERR,values[4],true,lmp); + omega[m][2] = utils::numeric(FLERR,values[5],true,lmp); } /* ---------------------------------------------------------------------- @@ -1164,9 +1165,9 @@ void AtomVecLine::data_vel(int m, char **values) int AtomVecLine::data_vel_hybrid(int m, char **values) { - omega[m][0] = force->numeric(FLERR,values[0]); - omega[m][1] = force->numeric(FLERR,values[1]); - omega[m][2] = force->numeric(FLERR,values[2]); + omega[m][0] = utils::numeric(FLERR,values[0],true,lmp); + omega[m][1] = utils::numeric(FLERR,values[1],true,lmp); + omega[m][2] = utils::numeric(FLERR,values[2],true,lmp); return 3; } diff --git a/src/atom_vec_sphere.cpp b/src/atom_vec_sphere.cpp index 705b7411e7..b37b853c86 100644 --- a/src/atom_vec_sphere.cpp +++ b/src/atom_vec_sphere.cpp @@ -25,6 +25,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -965,15 +966,15 @@ void AtomVecSphere::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); tag[nlocal] = ATOTAGINT(values[0]); - type[nlocal] = force->inumeric(FLERR,values[1]); + type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - radius[nlocal] = 0.5 * force->numeric(FLERR,values[2]); + radius[nlocal] = 0.5 * utils::numeric(FLERR,values[2],true,lmp); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = force->numeric(FLERR,values[3]); + double density = utils::numeric(FLERR,values[3],true,lmp); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1006,11 +1007,11 @@ void AtomVecSphere::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecSphere::data_atom_hybrid(int nlocal, char **values) { - radius[nlocal] = 0.5 * force->numeric(FLERR,values[0]); + radius[nlocal] = 0.5 * utils::numeric(FLERR,values[0],true,lmp); if (radius[nlocal] < 0.0) error->one(FLERR,"Invalid radius in Atoms section of data file"); - double density = force->numeric(FLERR,values[1]); + double density = utils::numeric(FLERR,values[1],true,lmp); if (density <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1028,12 +1029,12 @@ int AtomVecSphere::data_atom_hybrid(int nlocal, char **values) void AtomVecSphere::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - omega[m][0] = force->numeric(FLERR,values[3]); - omega[m][1] = force->numeric(FLERR,values[4]); - omega[m][2] = force->numeric(FLERR,values[5]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + omega[m][0] = utils::numeric(FLERR,values[3],true,lmp); + omega[m][1] = utils::numeric(FLERR,values[4],true,lmp); + omega[m][2] = utils::numeric(FLERR,values[5],true,lmp); } /* ---------------------------------------------------------------------- @@ -1042,9 +1043,9 @@ void AtomVecSphere::data_vel(int m, char **values) int AtomVecSphere::data_vel_hybrid(int m, char **values) { - omega[m][0] = force->numeric(FLERR,values[0]); - omega[m][1] = force->numeric(FLERR,values[1]); - omega[m][2] = force->numeric(FLERR,values[2]); + omega[m][0] = utils::numeric(FLERR,values[0],true,lmp); + omega[m][1] = utils::numeric(FLERR,values[1],true,lmp); + omega[m][2] = utils::numeric(FLERR,values[2],true,lmp); return 3; } diff --git a/src/atom_vec_tri.cpp b/src/atom_vec_tri.cpp index 9f4557b63d..4070c6795e 100644 --- a/src/atom_vec_tri.cpp +++ b/src/atom_vec_tri.cpp @@ -25,6 +25,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -1436,16 +1437,16 @@ void AtomVecTri::data_atom(double *coord, imageint imagetmp, char **values) tag[nlocal] = ATOTAGINT(values[0]); molecule[nlocal] = ATOTAGINT(values[1]); - type[nlocal] = force->inumeric(FLERR,values[2]); + type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); - tri[nlocal] = force->inumeric(FLERR,values[3]); + tri[nlocal] = utils::inumeric(FLERR,values[3],true,lmp); if (tri[nlocal] == 0) tri[nlocal] = -1; else if (tri[nlocal] == 1) tri[nlocal] = 0; else error->one(FLERR,"Invalid triflag in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[4]); + rmass[nlocal] = utils::numeric(FLERR,values[4],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1484,12 +1485,12 @@ int AtomVecTri::data_atom_hybrid(int nlocal, char **values) { molecule[nlocal] = ATOTAGINT(values[0]); - tri[nlocal] = force->inumeric(FLERR,values[1]); + tri[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (tri[nlocal] == 0) tri[nlocal] = -1; else if (tri[nlocal] == 1) tri[nlocal] = 0; else error->one(FLERR,"Invalid atom type in Atoms section of data file"); - rmass[nlocal] = force->numeric(FLERR,values[2]); + rmass[nlocal] = utils::numeric(FLERR,values[2],true,lmp); if (rmass[nlocal] <= 0.0) error->one(FLERR,"Invalid density in Atoms section of data file"); @@ -1513,15 +1514,15 @@ void AtomVecTri::data_atom_bonus(int m, char **values) if (nlocal_bonus == nmax_bonus) grow_bonus(); double c1[3],c2[3],c3[3]; - c1[0] = force->numeric(FLERR,values[0]); - c1[1] = force->numeric(FLERR,values[1]); - c1[2] = force->numeric(FLERR,values[2]); - c2[0] = force->numeric(FLERR,values[3]); - c2[1] = force->numeric(FLERR,values[4]); - c2[2] = force->numeric(FLERR,values[5]); - c3[0] = force->numeric(FLERR,values[6]); - c3[1] = force->numeric(FLERR,values[7]); - c3[2] = force->numeric(FLERR,values[8]); + c1[0] = utils::numeric(FLERR,values[0],true,lmp); + c1[1] = utils::numeric(FLERR,values[1],true,lmp); + c1[2] = utils::numeric(FLERR,values[2],true,lmp); + c2[0] = utils::numeric(FLERR,values[3],true,lmp); + c2[1] = utils::numeric(FLERR,values[4],true,lmp); + c2[2] = utils::numeric(FLERR,values[5],true,lmp); + c3[0] = utils::numeric(FLERR,values[6],true,lmp); + c3[1] = utils::numeric(FLERR,values[7],true,lmp); + c3[2] = utils::numeric(FLERR,values[8],true,lmp); // check for duplicate points @@ -1641,15 +1642,15 @@ void AtomVecTri::data_atom_bonus(int m, char **values) void AtomVecTri::data_vel(int m, char **values) { - v[m][0] = force->numeric(FLERR,values[0]); - v[m][1] = force->numeric(FLERR,values[1]); - v[m][2] = force->numeric(FLERR,values[2]); - omega[m][0] = force->numeric(FLERR,values[3]); - omega[m][1] = force->numeric(FLERR,values[4]); - omega[m][2] = force->numeric(FLERR,values[5]); - angmom[m][0] = force->numeric(FLERR,values[6]); - angmom[m][1] = force->numeric(FLERR,values[7]); - angmom[m][2] = force->numeric(FLERR,values[8]); + v[m][0] = utils::numeric(FLERR,values[0],true,lmp); + v[m][1] = utils::numeric(FLERR,values[1],true,lmp); + v[m][2] = utils::numeric(FLERR,values[2],true,lmp); + omega[m][0] = utils::numeric(FLERR,values[3],true,lmp); + omega[m][1] = utils::numeric(FLERR,values[4],true,lmp); + omega[m][2] = utils::numeric(FLERR,values[5],true,lmp); + angmom[m][0] = utils::numeric(FLERR,values[6],true,lmp); + angmom[m][1] = utils::numeric(FLERR,values[7],true,lmp); + angmom[m][2] = utils::numeric(FLERR,values[8],true,lmp); } /* ---------------------------------------------------------------------- @@ -1658,12 +1659,12 @@ void AtomVecTri::data_vel(int m, char **values) int AtomVecTri::data_vel_hybrid(int m, char **values) { - omega[m][0] = force->numeric(FLERR,values[0]); - omega[m][1] = force->numeric(FLERR,values[1]); - omega[m][2] = force->numeric(FLERR,values[2]); - angmom[m][0] = force->numeric(FLERR,values[3]); - angmom[m][1] = force->numeric(FLERR,values[4]); - angmom[m][2] = force->numeric(FLERR,values[5]); + omega[m][0] = utils::numeric(FLERR,values[0],true,lmp); + omega[m][1] = utils::numeric(FLERR,values[1],true,lmp); + omega[m][2] = utils::numeric(FLERR,values[2],true,lmp); + angmom[m][0] = utils::numeric(FLERR,values[3],true,lmp); + angmom[m][1] = utils::numeric(FLERR,values[4],true,lmp); + angmom[m][2] = utils::numeric(FLERR,values[5],true,lmp); return 6; } diff --git a/src/utils.cpp b/src/utils.cpp index 8468b22d8c..bbda22f24c 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -141,6 +141,150 @@ std::string utils::check_packages_for_style(std::string style, return errmsg; } + +/* ---------------------------------------------------------------------- + read a floating point value from a string + generate an error if not a legitimate floating point value + called by various commands to check validity of their arguments +------------------------------------------------------------------------- */ + +double utils::numeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp) +{ + int n = 0; + + if (str) n = strlen(str); + if (n == 0) { + if (do_abort) + lmp->error->one(file,line,"Expected floating point parameter instead of" + " NULL or empty string in input script or data file"); + else + lmp->error->all(file,line,"Expected floating point parameter instead of" + " NULL or empty string in input script or data file"); + } + + for (int i = 0; i < n; i++) { + if (isdigit(str[i])) continue; + if (str[i] == '-' || str[i] == '+' || str[i] == '.') continue; + if (str[i] == 'e' || str[i] == 'E') continue; + std::string msg("Expected floating point parameter instead of '"); + msg += str; + msg += "' in input script or data file"; + if (do_abort) + lmp->error->one(file,line,msg.c_str()); + else + lmp->error->all(file,line,msg.c_str()); + } + + return atof(str); +} + +/* ---------------------------------------------------------------------- + read an integer value from a string + generate an error if not a legitimate integer value + called by various commands to check validity of their arguments +------------------------------------------------------------------------- */ + +int utils::inumeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp) +{ + int n = 0; + + if (str) n = strlen(str); + if (n == 0) { + if (do_abort) + lmp->error->one(file,line,"Expected integer parameter instead of " + "NULL or empty string in input script or data file"); + else + lmp->error->all(file,line,"Expected integer parameter instead of " + "NULL or empty string in input script or data file"); + } + + for (int i = 0; i < n; i++) { + if (isdigit(str[i]) || str[i] == '-' || str[i] == '+') continue; + std::string msg("Expected integer parameter instead of '"); + msg += str; + msg += "' in input script or data file"; + if (do_abort) + lmp->error->one(file,line,msg.c_str()); + else + lmp->error->all(file,line,msg.c_str()); + } + + return atoi(str); +} + +/* ---------------------------------------------------------------------- + read a big integer value from a string + generate an error if not a legitimate integer value + called by various commands to check validity of their arguments +------------------------------------------------------------------------- */ + +bigint utils::bnumeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp) +{ + int n = 0; + + if (str) n = strlen(str); + if (n == 0) { + if (do_abort) + lmp->error->one(file,line,"Expected integer parameter instead of " + "NULL or empty string in input script or data file"); + else + lmp->error->all(file,line,"Expected integer parameter instead of " + "NULL or empty string in input script or data file"); + } + + for (int i = 0; i < n; i++) { + if (isdigit(str[i]) || str[i] == '-' || str[i] == '+') continue; + std::string msg("Expected integer parameter instead of '"); + msg += str; + msg += "' in input script or data file"; + if (do_abort) + lmp->error->one(file,line,msg.c_str()); + else + lmp->error->all(file,line,msg.c_str()); + } + + return ATOBIGINT(str); +} + +/* ---------------------------------------------------------------------- + read a tag integer value from a string + generate an error if not a legitimate integer value + called by various commands to check validity of their arguments +------------------------------------------------------------------------- */ + +tagint utils::tnumeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp) +{ + int n = 0; + + if (str) n = strlen(str); + if (n == 0) { + if (do_abort) + lmp->error->one(file,line,"Expected integer parameter instead of " + "NULL or empty string in input script or data file"); + else + lmp->error->all(file,line,"Expected integer parameter instead of " + "NULL or empty string in input script or data file"); + } + + for (int i = 0; i < n; i++) { + if (isdigit(str[i]) || str[i] == '-' || str[i] == '+') continue; + std::string msg("Expected integer parameter instead of '"); + msg += str; + msg += "' in input script or data file"; + if (do_abort) + lmp->error->one(file,line,msg.c_str()); + else + lmp->error->all(file,line,msg.c_str()); + } + + return ATOTAGINT(str); +} + + /* ------------------------------------------------------------------ */ extern "C" { diff --git a/src/utils.h b/src/utils.h index 7dfba8ead0..5f71bfae76 100644 --- a/src/utils.h +++ b/src/utils.h @@ -16,6 +16,7 @@ /*! \file utils.h */ +#include "lmptype.h" #include #include @@ -75,7 +76,60 @@ namespace LAMMPS_NS { * \param lmp pointer to top-level LAMMPS class instance * \return string usable for error messages */ - std::string check_packages_for_style(std::string style, std::string name, LAMMPS *lmp); + std::string check_packages_for_style(std::string style, + std::string name, LAMMPS *lmp); + + /** \brief Convert a string to a floating point number while checking + if it is a valid floating point or integer number + * + * \param file name of source file for error message + * \param line in source file for error message + * \param str string to be converted to number + * \param do_abort determines whether to call Error::one() or Error::all() + * \param lmp pointer to top-level LAMMPS class instance + * \return double precision floating point number + */ + double numeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp); + + /** \brief Convert a string to an integer number while checking + if it is a valid integer number (regular int) + * + * \param file name of source file for error message + * \param line in source file for error message + * \param str string to be converted to number + * \param do_abort determines whether to call Error::one() or Error::all() + * \param lmp pointer to top-level LAMMPS class instance + * \return integer number (regular int) + */ + int inumeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp); + + /** \brief Convert a string to an integer number while checking + if it is a valid integer number (bigint) + * + * \param file name of source file for error message + * \param line in source file for error message + * \param str string to be converted to number + * \param do_abort determines whether to call Error::one() or Error::all() + * \param lmp pointer to top-level LAMMPS class instance + * \return integer number (bigint) + */ + bigint bnumeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp); + + /** \brief Convert a string to an integer number while checking + if it is a valid integer number (tagint) + * + * \param file name of source file for error message + * \param line in source file for error message + * \param str string to be converted to number + * \param do_abort determines whether to call Error::one() or Error::all() + * \param lmp pointer to top-level LAMMPS class instance + * \return integer number (tagint) + */ + tagint tnumeric(const char *file, int line, const char *str, + bool do_abort, LAMMPS *lmp); } } -- GitLab From cbdc5dba13399718e0f2f48f545b438e774e49a6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 8 Jul 2019 18:09:41 -0400 Subject: [PATCH 207/469] fix bug in atom style wavepacket --- src/USER-AWPMD/atom_vec_wavepacket.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/USER-AWPMD/atom_vec_wavepacket.cpp b/src/USER-AWPMD/atom_vec_wavepacket.cpp index 67eaf94551..0edaf7ac02 100644 --- a/src/USER-AWPMD/atom_vec_wavepacket.cpp +++ b/src/USER-AWPMD/atom_vec_wavepacket.cpp @@ -928,7 +928,7 @@ void AtomVecWavepacket::data_atom(double *coord, imageint imagetmp, error->one(FLERR,"Invalid eradius in Atoms section of data file"); etag[nlocal] = utils::inumeric(FLERR,values[5],true,lmp); - cs[2*nlocal] = utils::inumeric(FLERR,values[6],true,lmp); + cs[2*nlocal] = utils::numeric(FLERR,values[6],true,lmp); cs[2*nlocal+1] = utils::numeric(FLERR,values[7],true,lmp); x[nlocal][0] = coord[0]; -- GitLab From 1f47da6c51deaac5f29f56bc532a683965d85a82 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Mon, 8 Jul 2019 17:46:47 -0500 Subject: [PATCH 208/469] Add fixed_types to kim_init & split to kim_query --- examples/kim/in.query | 7 ++- src/KIM/kim_interactions.cpp | 106 ++++++++++++++++++++--------------- src/KIM/kim_query.cpp | 32 +++++++++-- 3 files changed, 94 insertions(+), 51 deletions(-) diff --git a/examples/kim/in.query b/examples/kim/in.query index 33272dc298..72e739fb52 100644 --- a/examples/kim/in.query +++ b/examples/kim/in.query @@ -4,8 +4,9 @@ # lattice constant for a specific test used for a specific model and then # assigns it to the variable 'latconst' -units metal +kim_init EAM_CubicNaturalSpline_ErcolessiAdams_1994_Al__MO_800509458712_002 metal info variables out log -kim_query latconst get_test_result test=TE_156715955670 species=["Al"] model=MO_800509458712 prop=structure-cubic-crystal-npt keys=["a"] units=["angstrom"] +kim_query latconst split get_test_result test=TE_156715955670 species=["Al"] prop=structure-cubic-crystal-npt keys=["a","a"] units=["angstrom","angstrom"] info variables out log -lattice fcc ${latconst} +lattice fcc ${latconst_1} +lattice fcc ${latconst_2} diff --git a/src/KIM/kim_interactions.cpp b/src/KIM/kim_interactions.cpp index 355df9c3be..d0fbb809d2 100644 --- a/src/KIM/kim_interactions.cpp +++ b/src/KIM/kim_interactions.cpp @@ -115,8 +115,16 @@ void KimInteractions::kim_interactions_log_delimiter( void KimInteractions::do_setup(int narg, char **arg) { - if (narg != atom->ntypes) + bool fixed_types; + if ((narg == 1) && (0 == strcmp("fixed_types",arg[0]))) { + fixed_types = true; + } + else if (narg != atom->ntypes) { error->all(FLERR,"Illegal kim_interactions command"); + } + else { + fixed_types = false; + } char *model_name = NULL; KIM_SimulatorModel *simulatorModel(NULL); @@ -137,53 +145,59 @@ void KimInteractions::do_setup(int narg, char **arg) if (simulatorModel) { - std::string delimiter(""); - std::string atom_type_sym_list; - std::string atom_type_num_list; + if (!fixed_types) { + std::string delimiter(""); + std::string atom_type_sym_list; + std::string atom_type_num_list; - for (int i = 0; i < narg; i++) - { - atom_type_sym_list += delimiter + arg[i]; - atom_type_num_list += delimiter + SNUM(species_to_atomic_no(arg[i])); - delimiter = " "; - } - - KIM_SimulatorModel_AddTemplateMap( - simulatorModel,"atom-type-sym-list",atom_type_sym_list.c_str()); - KIM_SimulatorModel_AddTemplateMap( - simulatorModel,"atom-type-num-list",atom_type_num_list.c_str()); - KIM_SimulatorModel_CloseTemplateMap(simulatorModel); - - int len = strlen(atom_type_sym_list.c_str())+1; - char *strbuf = new char[len]; - char *strword; - - // validate species selection - - int sim_num_species; - bool species_is_supported; - char const *sim_species; - KIM_SimulatorModel_GetNumberOfSupportedSpecies( - simulatorModel,&sim_num_species); - strcpy(strbuf,atom_type_sym_list.c_str()); - strword = strtok(strbuf," \t"); - while (strword) { - species_is_supported = false; - if (strcmp(strword,"NULL") == 0) continue; - for (int i=0; i < sim_num_species; ++i) { - KIM_SimulatorModel_GetSupportedSpecies(simulatorModel,i,&sim_species); - if (strcmp(sim_species,strword) == 0) - species_is_supported = true; + for (int i = 0; i < narg; i++) + { + atom_type_sym_list += delimiter + arg[i]; + atom_type_num_list += delimiter + SNUM(species_to_atomic_no(arg[i])); + delimiter = " "; } - if (!species_is_supported) { - std::string msg("Species '"); - msg += strword; - msg += "' is not supported by this KIM Simulator Model"; - error->all(FLERR,msg.c_str()); + + KIM_SimulatorModel_AddTemplateMap( + simulatorModel,"atom-type-sym-list",atom_type_sym_list.c_str()); + KIM_SimulatorModel_AddTemplateMap( + simulatorModel,"atom-type-num-list",atom_type_num_list.c_str()); + KIM_SimulatorModel_CloseTemplateMap(simulatorModel); + + int len = strlen(atom_type_sym_list.c_str())+1; + char *strbuf = new char[len]; + char *strword; + + // validate species selection + + int sim_num_species; + bool species_is_supported; + char const *sim_species; + KIM_SimulatorModel_GetNumberOfSupportedSpecies( + simulatorModel,&sim_num_species); + strcpy(strbuf,atom_type_sym_list.c_str()); + strword = strtok(strbuf," \t"); + while (strword) { + species_is_supported = false; + if (strcmp(strword,"NULL") == 0) continue; + for (int i=0; i < sim_num_species; ++i) { + KIM_SimulatorModel_GetSupportedSpecies(simulatorModel,i,&sim_species); + if (strcmp(sim_species,strword) == 0) + species_is_supported = true; + } + if (!species_is_supported) { + std::string msg("Species '"); + msg += strword; + msg += "' is not supported by this KIM Simulator Model"; + error->all(FLERR,msg.c_str()); + } + strword = strtok(NULL," \t"); } - strword = strtok(NULL," \t"); + delete[] strbuf; + } + else + { + KIM_SimulatorModel_CloseTemplateMap(simulatorModel); } - delete[] strbuf; // check if units are unchanged @@ -223,6 +237,10 @@ void KimInteractions::do_setup(int narg, char **arg) } else { // not a simulator model. issue pair_style and pair_coeff commands. + + if (fixed_types) + error->all(FLERR,"fixed_types cannot be used with a KIM Portable Model"); + // NOTE: all references to arg must appear before calls to input->one() // as that will reset the argument vector. diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index 2bb404ec26..cf4efc2b12 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -57,6 +57,7 @@ #include #include #include +#include #include "kim_query.h" #include "comm.h" #include "error.h" @@ -104,6 +105,13 @@ void KimQuery::command(int narg, char **arg) varname = arg[0]; + bool split = false; + if (0 == strcmp("split",arg[1])) { + if (narg == 2) error->all(FLERR,"Illegal kim_query command"); + split = true; + arg++; + narg--; + } function = arg[1]; #if defined(LMP_KIM_CURL) @@ -123,11 +131,27 @@ void KimQuery::command(int narg, char **arg) } char **varcmd = new char*[3]; - varcmd[0] = varname; - varcmd[1] = (char *) "string"; - varcmd[2] = value; + if (split) { + int counter = 1; + std::stringstream ss(value); + std::string token; + varcmd[1] = (char *) "string"; + + while(std::getline(ss, token, ',')) { + std::stringstream splitname; + splitname << varname << "_" << counter++; + varcmd[0] = const_cast(splitname.str().c_str()); + varcmd[2] = const_cast(token.c_str()); + input->variable->set(3,varcmd); + } + } + else { + varcmd[0] = varname; + varcmd[1] = (char *) "string"; + varcmd[2] = value; - input->variable->set(3,varcmd); + input->variable->set(3,varcmd); + } delete[] varcmd; delete[] value; -- GitLab From 74414afdea0563131122228d4318cbcf950c7dfc Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 8 Jul 2019 17:25:23 -0600 Subject: [PATCH 209/469] Added the boxinfo argument --- src/read_dump.cpp | 69 ++++++++++++++++++++++--------------------- src/reader.h | 2 +- src/reader_native.cpp | 3 +- src/reader_native.h | 2 +- src/reader_xyz.cpp | 4 +-- src/reader_xyz.h | 2 +- 6 files changed, 42 insertions(+), 40 deletions(-) diff --git a/src/read_dump.cpp b/src/read_dump.cpp index 1a0a746c07..85e2312a42 100644 --- a/src/read_dump.cpp +++ b/src/read_dump.cpp @@ -483,51 +483,52 @@ bigint ReadDump::next(bigint ncurrent, bigint nlast, int nevery, int nskip) void ReadDump::header(int fieldinfo) { - int triclinic_snap; + int boxinfo, triclinic_snap; int fieldflag,xflag,yflag,zflag; if (filereader) { for (int i = 0; i < nreader; i++) - nsnapatoms[i] = readers[i]->read_header(box,triclinic_snap,fieldinfo, + nsnapatoms[i] = readers[i]->read_header(box,boxinfo,triclinic_snap,fieldinfo, nfield,fieldtype,fieldlabel, scaleflag,wrapflag,fieldflag, xflag,yflag,zflag); } MPI_Bcast(nsnapatoms,nreader,MPI_LMP_BIGINT,0,clustercomm); + MPI_Bcast(&boxinfo,1,MPI_INT,0,clustercomm); MPI_Bcast(&triclinic_snap,1,MPI_INT,0,clustercomm); MPI_Bcast(&box[0][0],9,MPI_DOUBLE,0,clustercomm); // local copy of snapshot box parameters // used in xfield,yfield,zfield when converting dump atom to absolute coords - xlo = box[0][0]; - xhi = box[0][1]; - ylo = box[1][0]; - yhi = box[1][1]; - zlo = box[2][0]; - zhi = box[2][1]; - - // value of 1 indicates possible change in tilt factors - - if (triclinic_snap == 1) { - xy = box[0][2]; - xz = box[1][2]; - yz = box[2][2]; - double xdelta = MIN(0.0,xy); - xdelta = MIN(xdelta,xz); - xdelta = MIN(xdelta,xy+xz); - xlo = xlo - xdelta; - xdelta = MAX(0.0,xy); - xdelta = MAX(xdelta,xz); - xdelta = MAX(xdelta,xy+xz); - xhi = xhi - xdelta; - ylo = ylo - MIN(0.0,yz); - yhi = yhi - MAX(0.0,yz); + if (boxinfo) { + xlo = box[0][0]; + xhi = box[0][1]; + ylo = box[1][0]; + yhi = box[1][1]; + zlo = box[2][0]; + zhi = box[2][1]; + + if (triclinic_snap) { + xy = box[0][2]; + xz = box[1][2]; + yz = box[2][2]; + double xdelta = MIN(0.0,xy); + xdelta = MIN(xdelta,xz); + xdelta = MIN(xdelta,xy+xz); + xlo = xlo - xdelta; + xdelta = MAX(0.0,xy); + xdelta = MAX(xdelta,xz); + xdelta = MAX(xdelta,xy+xz); + xhi = xhi - xdelta; + ylo = ylo - MIN(0.0,yz); + yhi = yhi - MAX(0.0,yz); + } + xprd = xhi - xlo; + yprd = yhi - ylo; + zprd = zhi - zlo; } - xprd = xhi - xlo; - yprd = yhi - ylo; - zprd = zhi - zlo; // done if not checking fields @@ -539,13 +540,13 @@ void ReadDump::header(int fieldinfo) MPI_Bcast(&zflag,1,MPI_INT,0,clustercomm); // error check on current vs new box and fields - // triclinic_snap < 0 means no box info in file + // boxinfo == 0 means no box info in file - if (triclinic_snap < 0 && boxflag > 0) - error->all(FLERR,"No box information in dump, must use 'box no'"); - if (triclinic_snap >= 0) { - if ((triclinic_snap && !triclinic) || - (!triclinic_snap && triclinic)) + if (boxflag) { + if (!boxinfo) + error->all(FLERR,"No box information in dump, must use 'box no'"); + else if ((triclinic_snap && !triclinic) || + (!triclinic_snap && triclinic)) error->one(FLERR,"Read_dump triclinic status does not match simulation"); } diff --git a/src/reader.h b/src/reader.h index 08b0010b81..7b31b666ba 100644 --- a/src/reader.h +++ b/src/reader.h @@ -29,7 +29,7 @@ class Reader : protected Pointers { virtual int read_time(bigint &) = 0; virtual void skip() = 0; - virtual bigint read_header(double [3][3], int &, int, int, int *, char **, + virtual bigint read_header(double [3][3], int &, int &, int, int, int *, char **, int, int, int &, int &, int &, int &) = 0; virtual void read_atoms(int, int, double **) = 0; diff --git a/src/reader_native.cpp b/src/reader_native.cpp index 2c60ffdfd4..7c772ab6b8 100644 --- a/src/reader_native.cpp +++ b/src/reader_native.cpp @@ -103,7 +103,7 @@ void ReaderNative::skip() only called by proc 0 ------------------------------------------------------------------------- */ -bigint ReaderNative::read_header(double box[3][3], int &triclinic, +bigint ReaderNative::read_header(double box[3][3], int &boxinfo, int &triclinic, int fieldinfo, int nfield, int *fieldtype, char **fieldlabel, int scaleflag, int wrapflag, int &fieldflag, @@ -113,6 +113,7 @@ bigint ReaderNative::read_header(double box[3][3], int &triclinic, read_lines(2); sscanf(line,BIGINT_FORMAT,&natoms); + boxinfo = 1; triclinic = 0; box[0][2] = box[1][2] = box[2][2] = 0.0; read_lines(1); diff --git a/src/reader_native.h b/src/reader_native.h index ab99469aa8..de43e43003 100644 --- a/src/reader_native.h +++ b/src/reader_native.h @@ -33,7 +33,7 @@ class ReaderNative : public Reader { int read_time(bigint &); void skip(); - bigint read_header(double [3][3], int &, int, int, int *, char **, + bigint read_header(double [3][3], int &, int &, int, int, int *, char **, int, int, int &, int &, int &, int &); void read_atoms(int, int, double **); diff --git a/src/reader_xyz.cpp b/src/reader_xyz.cpp index 37d30bd740..303c25cd7a 100644 --- a/src/reader_xyz.cpp +++ b/src/reader_xyz.cpp @@ -117,7 +117,7 @@ void ReaderXYZ::skip() only called by proc 0 ------------------------------------------------------------------------- */ -bigint ReaderXYZ::read_header(double /*box*/[3][3], int &triclinic, +bigint ReaderXYZ::read_header(double /*box*/[3][3], int &boxinfo, int &/*triclinic*/, int fieldinfo, int nfield, int *fieldtype, char **/*fieldlabel*/, int scaleflag, int wrapflag, int &fieldflag, @@ -128,7 +128,7 @@ bigint ReaderXYZ::read_header(double /*box*/[3][3], int &triclinic, // signal that we have no box info at all - triclinic = -1; + boxinfo = 0; // if no field info requested, just return diff --git a/src/reader_xyz.h b/src/reader_xyz.h index 698c6ef240..f8b0ebcea1 100644 --- a/src/reader_xyz.h +++ b/src/reader_xyz.h @@ -33,7 +33,7 @@ class ReaderXYZ : public Reader { int read_time(bigint &); void skip(); - bigint read_header(double [3][3], int &, int, int, int *, char **, + bigint read_header(double [3][3], int &, int &, int, int, int *, char **, int, int, int &, int &, int &, int &); void read_atoms(int, int, double **); -- GitLab From 7a62717051277ef0e3ff1d04b676444c18e5f1bd Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 8 Jul 2019 19:40:31 -0600 Subject: [PATCH 210/469] Updated USER-MOLFILE --- src/USER-MOLFILE/reader_molfile.cpp | 18 ++++++++++++++---- src/USER-MOLFILE/reader_molfile.h | 2 +- 2 files changed, 15 insertions(+), 5 deletions(-) diff --git a/src/USER-MOLFILE/reader_molfile.cpp b/src/USER-MOLFILE/reader_molfile.cpp index bbbe65959e..ca1a61850c 100644 --- a/src/USER-MOLFILE/reader_molfile.cpp +++ b/src/USER-MOLFILE/reader_molfile.cpp @@ -195,7 +195,7 @@ void ReaderMolfile::skip() only called by proc 0 ------------------------------------------------------------------------- */ -bigint ReaderMolfile::read_header(double box[3][3], int &triclinic, +bigint ReaderMolfile::read_header(double box[3][3], int &boxinfo, int &triclinic, int fieldinfo, int nfield, int *fieldtype, char ** /* fieldlabel */, int scaleflag, int wrapflag, int &fieldflag, @@ -204,17 +204,24 @@ bigint ReaderMolfile::read_header(double box[3][3], int &triclinic, nid = 0; // signal that we have no box info at all so far. - triclinic = -1; + + boxinfo = 0; + triclinic = 0; // heuristics to determine if we have boxinfo (first if) // and whether we have an orthogonal box (second if) + if (!is_smalldiff(cell[0]*cell[1]*cell[2], 0.0f)) { + boxinfo = 1; if (is_smalldiff(cell[3],90.0f) && is_smalldiff(cell[4],90.0f) && is_smalldiff(cell[5],90.0f)) { + triclinic = 0; + // we have no information about the absolute location // of the box, so we assume that the origin is in the middle. // also we cannot tell periodicity. we assume, yes. + box[0][0] = -0.5*static_cast(cell[0]); box[0][1] = 0.5*static_cast(cell[0]); box[0][2] = 0.0; @@ -224,6 +231,7 @@ bigint ReaderMolfile::read_header(double box[3][3], int &triclinic, box[2][0] = -0.5*static_cast(cell[2]); box[2][1] = 0.5*static_cast(cell[2]); box[2][2] = 0.0; + } else { triclinic = 1; @@ -243,7 +251,8 @@ bigint ReaderMolfile::read_header(double box[3][3], int &triclinic, (lb*lc*cos(alpha/90.0*MY_PI2) - xy*xz) / ly : 0.0; const double lz = sqrt(lc*lc - xz*xz - yz*yz); - /* go from box length to boundary */ + // go from box length to boundary + double xbnd; xbnd = 0.0; @@ -275,7 +284,8 @@ bigint ReaderMolfile::read_header(double box[3][3], int &triclinic, } // if no field info requested, just return - if (!fieldinfo) return natoms; + + if (!fieldinfo) return natoms; memory->create(fieldindex,nfield,"read_dump:fieldindex"); diff --git a/src/USER-MOLFILE/reader_molfile.h b/src/USER-MOLFILE/reader_molfile.h index 5450843d6d..a56a4e0b96 100644 --- a/src/USER-MOLFILE/reader_molfile.h +++ b/src/USER-MOLFILE/reader_molfile.h @@ -35,7 +35,7 @@ class ReaderMolfile : public Reader { virtual int read_time(bigint &); virtual void skip(); - virtual bigint read_header(double [3][3], int &, int, int, int *, char **, + virtual bigint read_header(double [3][3], int &, int &, int, int, int *, char **, int, int, int &, int &, int &, int &); virtual void read_atoms(int, int, double **); -- GitLab From 39c8a7de6e8f4e36f5dc87b775445e7c1c93fd0d Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Tue, 9 Jul 2019 07:35:50 -0400 Subject: [PATCH 211/469] Updated kim_commands doc to descript kim_query split mode --- doc/src/kim_commands.txt | 12 ++++++++++-- 1 file changed, 10 insertions(+), 2 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 66319d7a08..16d8ea785d 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -14,13 +14,14 @@ kim_query command :h3 kim_init model user_units unitarg kim_interactions typeargs -kim_query variable query_function queryargs :pre +kim_query variable formatarg query_function queryargs :pre model = name of the KIM interatomic model (the KIM ID for models archived in OpenKIM) user_units = the LAMMPS "units"_units.html style assumed in the LAMMPS input script unitarg = {unit_conversion_mode} (optional) typeargs = atom type to species mapping (one entry per atom type) variable = name of a (string style) variable where the result of the query is stored +formatarg = {split} (optional) query_function = name of the OpenKIM web API query function to be used queryargs = a series of {keyword=value} pairs that represent the web query; supported keywords depend on the query function :ul @@ -377,7 +378,7 @@ changed to: "lattice fcc $\{a0\}*$\{_u_distance\}". kim_init EAM_Dynamo_Mendelev_2007_Zr__MO_848899341753_000 metal boundary p p p -kim_query latconst get_lattice_constant_hcp species=\["Zr"\] units=\["angstrom"\] +kim_query latconst split get_lattice_constant_hcp species=\["Zr"\] units=\["angstrom"\] variable a0 equal latconst_1 variable c0 equal latconst_2 variable c_to_a equal $\{c0\}/$\{a0\} @@ -387,6 +388,13 @@ lattice custom $\{a0\} a1 0.5 -0.866025 0 a2 0.5 0.866025 0 a3 0 0 $\{c In this case the {kim_query} returns two arguments (since the hexagonal close packed (hcp) structure has two independent lattice constants). +The default behavior of {kim_query} returns the result as a string +with the values separated by commas. The optional keyword {split} +separates the result values into individual variables of the form +{prefix_I}, where {prefix} is set to the the {kim_query} {variable} argument +and {I} ranges from 1 to the number of returned values. The number and order of +the returned values is determined by the type of query performed. + In the case where a query returns multiple results, the default behavior for {kim_query} is to split these into individual variables of the form {prefix_I}, where {prefix} is set to the the {kim_query} {variable} argument -- GitLab From 30086950b87ccb019b2a723b6c684fce7fd6fe7f Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Tue, 9 Jul 2019 09:43:34 -0400 Subject: [PATCH 212/469] Added preliminary doc for kim_interactions fixed_types --- doc/src/kim_commands.txt | 18 +++++++++++++++--- 1 file changed, 15 insertions(+), 3 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 16d8ea785d..437b768df6 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -19,7 +19,7 @@ kim_query variable formatarg query_function queryargs :pre model = name of the KIM interatomic model (the KIM ID for models archived in OpenKIM) user_units = the LAMMPS "units"_units.html style assumed in the LAMMPS input script unitarg = {unit_conversion_mode} (optional) -typeargs = atom type to species mapping (one entry per atom type) +typeargs = atom type to species mapping (one entry per atom type) or {fixed_types} for models with a preset fixed mapping variable = name of a (string style) variable where the result of the query is stored formatarg = {split} (optional) query_function = name of the OpenKIM web API query function to be used @@ -33,6 +33,8 @@ kim_interactions Si kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 metal unit_conversion_mode kim_interactions C H O +kim_init Sim_LAMMPS_IFF_OtherInfo_AuthorList_Year_Species__SM_064312669787_000 real +kim_interactions fixed_types kim_query a0 get_lattice_constant_fcc species=\["Al"] units=\["angstrom"\] :pre @@ -272,8 +274,13 @@ The second and final step in using an OpenKIM IM is to execute the command and a "create_box"_create_box.html command, which defines the number of atom types {N}. The {kim_interactions} command has one argument {typeargs}. This argument -contains a list of {N} chemical species, which defines a mapping between -atom types in LAMMPS to the available species in the OpenKIM IM. +contains either a list of {N} chemical species, which defines a mapping between +atom types in LAMMPS to the available species in the OpenKIM IM, or the +keyword {fixed_types} for models that have a preset fixed mapping (i.e. +the mapping between LAMMPS atom types and chemical species is defined by +the model and cannot be changed). In the latter case, the user must consult +the model documentation to see how many atom types there are and how they +map to the chemcial species. For example, consider an OpenKIM IM that supports Si and C species. If the LAMMPS simulation has four atom types, where the first three are Si, @@ -282,6 +289,11 @@ and the fourth is C, the following {kim_interactions} command would be used: kim_interactions Si Si Si C :pre +Alternatively, for a model with a fixed mapping the command would be: + +kim_interactions fixed_types +:pre + The {kim_interactions} command performs all the necessary steps to set up the OpenKIM IM selected in the {kim_init} command. The specific actions depend on whether the IM is a KIM PM or a KIM SM. For a KIM PM, -- GitLab From 5013fd699ffcf5c844b2f34cca10c964bbaf967a Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Tue, 9 Jul 2019 09:43:50 -0600 Subject: [PATCH 213/469] Fix issue in Kokkos neighor binning when using non-Kokkos lists on GPUs --- src/KOKKOS/nbin_kokkos.cpp | 1 + src/KOKKOS/neighbor_kokkos.cpp | 1 + src/nbin.cpp | 2 ++ src/nbin.h | 4 ++++ 4 files changed, 8 insertions(+) diff --git a/src/KOKKOS/nbin_kokkos.cpp b/src/KOKKOS/nbin_kokkos.cpp index 090519a5a8..5fc3a89732 100644 --- a/src/KOKKOS/nbin_kokkos.cpp +++ b/src/KOKKOS/nbin_kokkos.cpp @@ -40,6 +40,7 @@ NBinKokkos::NBinKokkos(LAMMPS *lmp) : NBinStandard(lmp) { #endif h_resize() = 1; + kokkos = 1; } /* ---------------------------------------------------------------------- diff --git a/src/KOKKOS/neighbor_kokkos.cpp b/src/KOKKOS/neighbor_kokkos.cpp index e912956a3f..a594c8f7a0 100644 --- a/src/KOKKOS/neighbor_kokkos.cpp +++ b/src/KOKKOS/neighbor_kokkos.cpp @@ -301,6 +301,7 @@ void NeighborKokkos::build_kokkos(int topoflag) if (style != Neighbor::NSQ) { for (int i = 0; i < nbin; i++) { + if (!neigh_bin[i]->kokkos) atomKK->sync(Host,ALL_MASK); neigh_bin[i]->bin_atoms_setup(nall); neigh_bin[i]->bin_atoms(); } diff --git a/src/nbin.cpp b/src/nbin.cpp index a30b76cca0..3e50148a04 100644 --- a/src/nbin.cpp +++ b/src/nbin.cpp @@ -35,6 +35,8 @@ NBin::NBin(LAMMPS *lmp) : Pointers(lmp) dimension = domain->dimension; triclinic = domain->triclinic; + + kokkos = 0; } /* ---------------------------------------------------------------------- */ diff --git a/src/nbin.h b/src/nbin.h index d6022a6a35..54b8da171d 100644 --- a/src/nbin.h +++ b/src/nbin.h @@ -47,6 +47,10 @@ class NBin : protected Pointers { virtual void setup_bins(int) = 0; virtual void bin_atoms() = 0; + // Kokkos package + + int kokkos; // 1 if class stores Kokkos data + protected: // data from Neighbor class -- GitLab From c2dc624ec90575027328f0b3b9ab52fff2b00631 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 9 Jul 2019 15:04:41 -0400 Subject: [PATCH 214/469] update packages USER-SPH, USER-SMTBQ, USER-SDPD, USER-TALLY, USER-UEF, USER-YAFF --- src/USER-SDPD/pair_sdpd_taitwater_isothermal.cpp | 3 +-- src/USER-SMTBQ/pair_smtbq.cpp | 7 +++---- src/USER-SPH/compute_meso_e_atom.cpp | 3 +-- src/USER-SPH/compute_meso_rho_atom.cpp | 3 +-- src/USER-SPH/compute_meso_t_atom.cpp | 3 +-- src/USER-SPH/fix_meso.cpp | 12 ------------ src/USER-SPH/fix_meso_stationary.cpp | 12 ------------ src/USER-SPH/pair_sph_heatconduction.cpp | 4 +--- src/USER-SPH/pair_sph_idealgas.cpp | 4 +--- src/USER-SPH/pair_sph_lj.cpp | 4 +--- src/USER-SPH/pair_sph_rhosum.cpp | 2 -- src/USER-SPH/pair_sph_taitwater.cpp | 3 +-- src/USER-SPH/pair_sph_taitwater_morris.cpp | 3 +-- src/USER-TALLY/compute_force_tally.cpp | 4 ++-- src/USER-TALLY/compute_heat_flux_tally.cpp | 2 +- src/USER-TALLY/compute_pe_mol_tally.cpp | 3 +-- src/USER-TALLY/compute_pe_tally.cpp | 2 +- src/USER-TALLY/compute_stress_tally.cpp | 2 +- src/USER-UEF/compute_pressure_uef.cpp | 9 +-------- src/USER-UEF/compute_temp_uef.cpp | 4 +--- src/USER-UEF/dump_cfg_uef.cpp | 6 +----- src/USER-UEF/fix_nh_uef.cpp | 5 +---- src/USER-YAFF/angle_cross.cpp | 4 +--- src/USER-YAFF/angle_cross.h | 1 - src/USER-YAFF/angle_mm3.cpp | 5 ++--- src/USER-YAFF/angle_mm3.h | 1 - src/USER-YAFF/bond_mm3.cpp | 5 ++--- src/USER-YAFF/bond_mm3.h | 1 - src/USER-YAFF/improper_distharm.cpp | 6 ++---- src/USER-YAFF/improper_distharm.h | 1 - src/USER-YAFF/improper_sqdistharm.cpp | 6 ++---- src/USER-YAFF/improper_sqdistharm.h | 1 - src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp | 8 +++----- src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp | 8 +++----- 34 files changed, 37 insertions(+), 110 deletions(-) diff --git a/src/USER-SDPD/pair_sdpd_taitwater_isothermal.cpp b/src/USER-SDPD/pair_sdpd_taitwater_isothermal.cpp index db80debe51..d799869db3 100644 --- a/src/USER-SDPD/pair_sdpd_taitwater_isothermal.cpp +++ b/src/USER-SDPD/pair_sdpd_taitwater_isothermal.cpp @@ -18,9 +18,8 @@ references: Espanol and Revenga, Phys Rev E 67, 026705 (2003) ------------------------------------------------------------------------- */ -#include -#include #include "pair_sdpd_taitwater_isothermal.h" +#include #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/USER-SMTBQ/pair_smtbq.cpp b/src/USER-SMTBQ/pair_smtbq.cpp index ba7f8eb88c..f61fc1a72e 100644 --- a/src/USER-SMTBQ/pair_smtbq.cpp +++ b/src/USER-SMTBQ/pair_smtbq.cpp @@ -38,25 +38,24 @@ . ------------------------------------------------------------------------- */ +#include "pair_smtbq.h" +#include #include -#include #include #include +#include #include -#include "pair_smtbq.h" #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "group.h" #include "update.h" #include "math_const.h" #include "math_special.h" #include "memory.h" #include "error.h" -#include "domain.h" #include #include diff --git a/src/USER-SPH/compute_meso_e_atom.cpp b/src/USER-SPH/compute_meso_e_atom.cpp index e39dee2b5f..c56243e5ed 100644 --- a/src/USER-SPH/compute_meso_e_atom.cpp +++ b/src/USER-SPH/compute_meso_e_atom.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_meso_e_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SPH/compute_meso_rho_atom.cpp b/src/USER-SPH/compute_meso_rho_atom.cpp index eeb3f987bc..b2fbd2d70a 100644 --- a/src/USER-SPH/compute_meso_rho_atom.cpp +++ b/src/USER-SPH/compute_meso_rho_atom.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_meso_rho_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SPH/compute_meso_t_atom.cpp b/src/USER-SPH/compute_meso_t_atom.cpp index dc4f3407f1..bab96468dd 100644 --- a/src/USER-SPH/compute_meso_t_atom.cpp +++ b/src/USER-SPH/compute_meso_t_atom.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_meso_t_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SPH/fix_meso.cpp b/src/USER-SPH/fix_meso.cpp index b688eccfea..4f4e532291 100644 --- a/src/USER-SPH/fix_meso.cpp +++ b/src/USER-SPH/fix_meso.cpp @@ -11,23 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "fix_meso.h" #include "atom.h" -#include "comm.h" #include "force.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "update.h" -#include "integrate.h" -#include "respa.h" -#include "memory.h" #include "error.h" -#include "pair.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-SPH/fix_meso_stationary.cpp b/src/USER-SPH/fix_meso_stationary.cpp index 29e8a1554c..b7f0675ef8 100644 --- a/src/USER-SPH/fix_meso_stationary.cpp +++ b/src/USER-SPH/fix_meso_stationary.cpp @@ -11,23 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "fix_meso_stationary.h" #include "atom.h" -#include "comm.h" #include "force.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "update.h" -#include "integrate.h" -#include "respa.h" -#include "memory.h" #include "error.h" -#include "pair.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-SPH/pair_sph_heatconduction.cpp b/src/USER-SPH/pair_sph_heatconduction.cpp index bafa26be89..cff9009015 100644 --- a/src/USER-SPH/pair_sph_heatconduction.cpp +++ b/src/USER-SPH/pair_sph_heatconduction.cpp @@ -11,12 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "pair_sph_heatconduction.h" +#include #include "atom.h" #include "force.h" -#include "comm.h" #include "memory.h" #include "error.h" #include "neigh_list.h" diff --git a/src/USER-SPH/pair_sph_idealgas.cpp b/src/USER-SPH/pair_sph_idealgas.cpp index db5ec964bc..f206bf68f5 100644 --- a/src/USER-SPH/pair_sph_idealgas.cpp +++ b/src/USER-SPH/pair_sph_idealgas.cpp @@ -11,12 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "pair_sph_idealgas.h" +#include #include "atom.h" #include "force.h" -#include "comm.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SPH/pair_sph_lj.cpp b/src/USER-SPH/pair_sph_lj.cpp index 7d315c975c..3173e2a47d 100644 --- a/src/USER-SPH/pair_sph_lj.cpp +++ b/src/USER-SPH/pair_sph_lj.cpp @@ -11,12 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "pair_sph_lj.h" +#include #include "atom.h" #include "force.h" -#include "comm.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SPH/pair_sph_rhosum.cpp b/src/USER-SPH/pair_sph_rhosum.cpp index 842dddc744..fa51dc3781 100644 --- a/src/USER-SPH/pair_sph_rhosum.cpp +++ b/src/USER-SPH/pair_sph_rhosum.cpp @@ -11,8 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "pair_sph_rhosum.h" #include "atom.h" #include "force.h" diff --git a/src/USER-SPH/pair_sph_taitwater.cpp b/src/USER-SPH/pair_sph_taitwater.cpp index cf3c0e914b..f2a34d4edd 100644 --- a/src/USER-SPH/pair_sph_taitwater.cpp +++ b/src/USER-SPH/pair_sph_taitwater.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "pair_sph_taitwater.h" +#include #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/USER-SPH/pair_sph_taitwater_morris.cpp b/src/USER-SPH/pair_sph_taitwater_morris.cpp index 5cbaa5959f..9ca03e3476 100644 --- a/src/USER-SPH/pair_sph_taitwater_morris.cpp +++ b/src/USER-SPH/pair_sph_taitwater_morris.cpp @@ -11,9 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "pair_sph_taitwater_morris.h" +#include #include "atom.h" #include "force.h" #include "comm.h" diff --git a/src/USER-TALLY/compute_force_tally.cpp b/src/USER-TALLY/compute_force_tally.cpp index 3339e0555b..9d15fbc441 100644 --- a/src/USER-TALLY/compute_force_tally.cpp +++ b/src/USER-TALLY/compute_force_tally.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "compute_force_tally.h" +#include +#include #include "atom.h" #include "group.h" #include "pair.h" diff --git a/src/USER-TALLY/compute_heat_flux_tally.cpp b/src/USER-TALLY/compute_heat_flux_tally.cpp index 2a5f724953..350bc4b4b6 100644 --- a/src/USER-TALLY/compute_heat_flux_tally.cpp +++ b/src/USER-TALLY/compute_heat_flux_tally.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_heat_flux_tally.h" +#include #include "atom.h" #include "group.h" #include "pair.h" diff --git a/src/USER-TALLY/compute_pe_mol_tally.cpp b/src/USER-TALLY/compute_pe_mol_tally.cpp index 5fabd4a77b..ce647a04c3 100644 --- a/src/USER-TALLY/compute_pe_mol_tally.cpp +++ b/src/USER-TALLY/compute_pe_mol_tally.cpp @@ -11,13 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_pe_mol_tally.h" +#include #include "atom.h" #include "group.h" #include "pair.h" #include "update.h" -#include "memory.h" #include "error.h" #include "force.h" #include "comm.h" diff --git a/src/USER-TALLY/compute_pe_tally.cpp b/src/USER-TALLY/compute_pe_tally.cpp index 8e6703bde1..edfa49b1b1 100644 --- a/src/USER-TALLY/compute_pe_tally.cpp +++ b/src/USER-TALLY/compute_pe_tally.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_pe_tally.h" +#include #include "atom.h" #include "group.h" #include "pair.h" diff --git a/src/USER-TALLY/compute_stress_tally.cpp b/src/USER-TALLY/compute_stress_tally.cpp index 07d685a9c2..1ea096e286 100644 --- a/src/USER-TALLY/compute_stress_tally.cpp +++ b/src/USER-TALLY/compute_stress_tally.cpp @@ -11,8 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_stress_tally.h" +#include #include "atom.h" #include "group.h" #include "pair.h" diff --git a/src/USER-UEF/compute_pressure_uef.cpp b/src/USER-UEF/compute_pressure_uef.cpp index 8b62853042..adb9970c12 100644 --- a/src/USER-UEF/compute_pressure_uef.cpp +++ b/src/USER-UEF/compute_pressure_uef.cpp @@ -13,21 +13,14 @@ Contributing author: David Nicholson (MIT) ------------------------------------------------------------------------- */ -#include -#include -#include #include "compute_pressure_uef.h" +#include #include "fix_nh_uef.h" #include "update.h" #include "domain.h" #include "modify.h" #include "fix.h" #include "force.h" -#include "pair.h" -#include "bond.h" -#include "angle.h" -#include "dihedral.h" -#include "improper.h" #include "kspace.h" #include "error.h" diff --git a/src/USER-UEF/compute_temp_uef.cpp b/src/USER-UEF/compute_temp_uef.cpp index 999296ec7e..698c4452c2 100644 --- a/src/USER-UEF/compute_temp_uef.cpp +++ b/src/USER-UEF/compute_temp_uef.cpp @@ -13,11 +13,9 @@ Contributing author: David Nicholson (MIT) ------------------------------------------------------------------------- */ -#include -#include #include "compute_temp_uef.h" +#include #include "fix_nh_uef.h" -#include "update.h" #include "modify.h" #include "fix.h" #include "error.h" diff --git a/src/USER-UEF/dump_cfg_uef.cpp b/src/USER-UEF/dump_cfg_uef.cpp index 58b3ec5a1f..5e3733f422 100644 --- a/src/USER-UEF/dump_cfg_uef.cpp +++ b/src/USER-UEF/dump_cfg_uef.cpp @@ -13,15 +13,11 @@ Contributing Author: David Nicholson (MIT) ------------------------------------------------------------------------- */ - +#include "dump_cfg.h" #include -#include #include -#include "dump_cfg.h" #include "atom.h" -#include "domain.h" #include "modify.h" -#include "compute.h" #include "fix.h" #include "error.h" #include "uef_utils.h" diff --git a/src/USER-UEF/fix_nh_uef.cpp b/src/USER-UEF/fix_nh_uef.cpp index bffcd7849f..8873688eb7 100644 --- a/src/USER-UEF/fix_nh_uef.cpp +++ b/src/USER-UEF/fix_nh_uef.cpp @@ -13,19 +13,16 @@ Contributing author: David Nicholson (MIT) ------------------------------------------------------------------------- */ +#include "fix_nh_uef.h" #include -#include #include -#include "fix_nh_uef.h" #include "atom.h" #include "force.h" -#include "group.h" #include "comm.h" #include "citeme.h" #include "irregular.h" #include "modify.h" #include "compute.h" -#include "kspace.h" #include "update.h" #include "domain.h" #include "error.h" diff --git a/src/USER-YAFF/angle_cross.cpp b/src/USER-YAFF/angle_cross.cpp index 2e6731f494..2ebb08f56b 100644 --- a/src/USER-YAFF/angle_cross.cpp +++ b/src/USER-YAFF/angle_cross.cpp @@ -15,10 +15,8 @@ Contributing author: Steven Vandenbrande ------------------------------------------------------------------------- */ -#include -#include -#include #include "angle_cross.h" +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-YAFF/angle_cross.h b/src/USER-YAFF/angle_cross.h index 7709c10414..ba958f98ec 100644 --- a/src/USER-YAFF/angle_cross.h +++ b/src/USER-YAFF/angle_cross.h @@ -20,7 +20,6 @@ AngleStyle(cross,AngleCross) #ifndef LMP_ANGLE_CROSS_H #define LMP_ANGLE_CROSS_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-YAFF/angle_mm3.cpp b/src/USER-YAFF/angle_mm3.cpp index 53cb11b5df..24ce8229ba 100644 --- a/src/USER-YAFF/angle_mm3.cpp +++ b/src/USER-YAFF/angle_mm3.cpp @@ -15,10 +15,9 @@ Contributing author: Steven Vandenbrande ------------------------------------------------------------------------- */ -#include -#include -#include #include "angle_mm3.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-YAFF/angle_mm3.h b/src/USER-YAFF/angle_mm3.h index 2d19b4d1b4..985c4bb9b4 100644 --- a/src/USER-YAFF/angle_mm3.h +++ b/src/USER-YAFF/angle_mm3.h @@ -20,7 +20,6 @@ AngleStyle(mm3,AngleMM3) #ifndef LMP_ANGLE_MM3_H #define LMP_ANGLE_MM3_H -#include #include "angle.h" namespace LAMMPS_NS { diff --git a/src/USER-YAFF/bond_mm3.cpp b/src/USER-YAFF/bond_mm3.cpp index ee1ebcdd61..2a7d5d1843 100644 --- a/src/USER-YAFF/bond_mm3.cpp +++ b/src/USER-YAFF/bond_mm3.cpp @@ -15,12 +15,11 @@ Contributing author: Steven Vandenbrande ------------------------------------------------------------------------- */ -#include -#include #include "bond_mm3.h" +#include +#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/USER-YAFF/bond_mm3.h b/src/USER-YAFF/bond_mm3.h index 9711d89529..56f3136ea8 100644 --- a/src/USER-YAFF/bond_mm3.h +++ b/src/USER-YAFF/bond_mm3.h @@ -20,7 +20,6 @@ BondStyle(mm3,BondMM3) #ifndef LMP_BOND_MM3_H #define LMP_BOND_MM3_H -#include #include "bond.h" namespace LAMMPS_NS { diff --git a/src/USER-YAFF/improper_distharm.cpp b/src/USER-YAFF/improper_distharm.cpp index b45087a9ab..2b62f827e7 100644 --- a/src/USER-YAFF/improper_distharm.cpp +++ b/src/USER-YAFF/improper_distharm.cpp @@ -16,16 +16,14 @@ improper_distance code by Paolo Raiteri (Curtin University) ------------------------------------------------------------------------- */ -#include -#include -#include #include "improper_distharm.h" +#include +#include #include "atom.h" #include "comm.h" #include "neighbor.h" #include "domain.h" #include "force.h" -#include "update.h" #include "memory.h" #include "error.h" diff --git a/src/USER-YAFF/improper_distharm.h b/src/USER-YAFF/improper_distharm.h index b8b9ae780e..0a8d34ac44 100644 --- a/src/USER-YAFF/improper_distharm.h +++ b/src/USER-YAFF/improper_distharm.h @@ -20,7 +20,6 @@ ImproperStyle(distharm,ImproperDistHarm) #ifndef LMP_IMPROPER_DISTHARM_H #define LMP_IMPROPER_DISTHARM_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/USER-YAFF/improper_sqdistharm.cpp b/src/USER-YAFF/improper_sqdistharm.cpp index ae702820cb..bcc0549f7e 100644 --- a/src/USER-YAFF/improper_sqdistharm.cpp +++ b/src/USER-YAFF/improper_sqdistharm.cpp @@ -16,16 +16,14 @@ improper_distance code by Paolo Raiteri (Curtin University) ------------------------------------------------------------------------- */ -#include -#include -#include #include "improper_sqdistharm.h" +#include +#include #include "atom.h" #include "comm.h" #include "neighbor.h" #include "domain.h" #include "force.h" -#include "update.h" #include "memory.h" #include "error.h" diff --git a/src/USER-YAFF/improper_sqdistharm.h b/src/USER-YAFF/improper_sqdistharm.h index 301b5066cb..3aceb01a03 100644 --- a/src/USER-YAFF/improper_sqdistharm.h +++ b/src/USER-YAFF/improper_sqdistharm.h @@ -20,7 +20,6 @@ ImproperStyle(sqdistharm,ImproperSQDistHarm) #ifndef LMP_IMPROPER_SQDISTHARM_H #define LMP_IMPROPER_SQDISTHARM_H -#include #include "improper.h" namespace LAMMPS_NS { diff --git a/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp b/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp index f37dcc3ed1..ab983a78bc 100644 --- a/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp +++ b/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp @@ -15,17 +15,15 @@ Contributing author: Steven Vandenbrande ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "pair_lj_switch3_coulgauss_long.h" +#include +#include +#include #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp b/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp index 931ed1d116..4175ef915d 100644 --- a/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp +++ b/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp @@ -15,17 +15,15 @@ Contributing author: Steven Vandenbrande ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "pair_mm3_switch3_coulgauss_long.h" +#include +#include +#include #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" -- GitLab From 2fd327d05738ce6a87521f658256a81851947e88 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 9 Jul 2019 16:17:54 -0600 Subject: [PATCH 215/469] more robust version of atom exchange size --- src/BODY/body_nparticle.cpp | 1 + src/BODY/body_rounded_polygon.cpp | 1 + src/BODY/body_rounded_polyhedron.cpp | 1 + src/atom_vec.cpp | 2 ++ src/atom_vec.h | 2 ++ src/body.h | 2 ++ src/comm.cpp | 40 ++++++++++++++++++++++++++-- src/comm.h | 15 +++++++---- src/comm_brick.cpp | 30 +++++++++------------ src/comm_brick.h | 1 - src/comm_tiled.cpp | 30 +++++++++------------ src/comm_tiled.h | 1 - src/fix.cpp | 2 ++ src/fix.h | 2 ++ src/fix_neigh_history.cpp | 16 +++++------ src/fix_store.cpp | 1 + 16 files changed, 93 insertions(+), 54 deletions(-) diff --git a/src/BODY/body_nparticle.cpp b/src/BODY/body_nparticle.cpp index 10529ad3af..1a85531a31 100644 --- a/src/BODY/body_nparticle.cpp +++ b/src/BODY/body_nparticle.cpp @@ -44,6 +44,7 @@ BodyNparticle::BodyNparticle(LAMMPS *lmp, int narg, char **arg) : icp = new MyPoolChunk(1,1); dcp = new MyPoolChunk(3*nmin,3*nmax); + maxexchange = 1 + 3*nmax; // icp max + dcp max memory->create(imflag,nmax,"body/nparticle:imflag"); memory->create(imdata,nmax,4,"body/nparticle:imdata"); diff --git a/src/BODY/body_rounded_polygon.cpp b/src/BODY/body_rounded_polygon.cpp index d352c789d7..f4d9cede18 100644 --- a/src/BODY/body_rounded_polygon.cpp +++ b/src/BODY/body_rounded_polygon.cpp @@ -61,6 +61,7 @@ BodyRoundedPolygon::BodyRoundedPolygon(LAMMPS *lmp, int narg, char **arg) : icp = new MyPoolChunk(1,1); dcp = new MyPoolChunk(3*nmin+2*nmin+1+1,3*nmax+2*nmax+1+1); + maxexchange = 1 + 3*nmax+2*nmax+1+1; // icp max + dcp max memory->create(imflag,nmax,"body/rounded/polygon:imflag"); memory->create(imdata,nmax,7,"body/nparticle:imdata"); diff --git a/src/BODY/body_rounded_polyhedron.cpp b/src/BODY/body_rounded_polyhedron.cpp index 99a380a932..6d5824ecc5 100644 --- a/src/BODY/body_rounded_polyhedron.cpp +++ b/src/BODY/body_rounded_polyhedron.cpp @@ -61,6 +61,7 @@ BodyRoundedPolyhedron::BodyRoundedPolyhedron(LAMMPS *lmp, int narg, char **arg) icp = new MyPoolChunk(1,3); dcp = new MyPoolChunk(3*nmin+2+1+1, 3*nmax+2*nmax+MAX_FACE_SIZE*nmax+1+1); + maxexchange = 3 + 3*nmax+2*nmax+MAX_FACE_SIZE*nmax+1+1; // icp max + dcp max memory->create(imflag,2*nmax,"body/rounded/polyhedron:imflag"); memory->create(imdata,2*nmax,7,"body/polyhedron:imdata"); diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index d4bea15d0b..93433c6bea 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -34,6 +34,8 @@ AtomVec::AtomVec(LAMMPS *lmp) : Pointers(lmp) mass_type = dipole_type = 0; forceclearflag = 0; size_data_bonus = 0; + maxexchange = 0; + kokkosable = 0; nargcopy = 0; diff --git a/src/atom_vec.h b/src/atom_vec.h index 87fb35d9c7..e4e8014cd5 100644 --- a/src/atom_vec.h +++ b/src/atom_vec.h @@ -39,6 +39,8 @@ class AtomVec : protected Pointers { int size_data_vel; // number of values in Velocity line int size_data_bonus; // number of values in Bonus line int xcol_data; // column (1-N) where x is in Atom line + int maxexchange; // max size of exchanged atom + // only needs to be set if size > BUFEXTRA class Molecule **onemols; // list of molecules for style template int nset; // # of molecules in list diff --git a/src/body.h b/src/body.h index 59001620f8..7da08733c5 100644 --- a/src/body.h +++ b/src/body.h @@ -28,6 +28,8 @@ class Body : protected Pointers { char *style; int size_forward; // max extra values packed for comm int size_border; // max extra values packed for border comm + int maxexchange; // max size of exchanged atom + AtomVecBody *avec; // ptr to class that stores body bonus info Body(class LAMMPS *, int, char **); diff --git a/src/comm.cpp b/src/comm.cpp index 052de93793..0356f88be7 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -39,7 +39,7 @@ using namespace LAMMPS_NS; -#define BUFMIN 1000 // also in comm styles +#define BUFEXTRA 1024 enum{ONELEVEL,TWOLEVEL,NUMA,CUSTOM}; enum{CART,CARTREORDER,XYZ}; @@ -65,7 +65,10 @@ Comm::Comm(LAMMPS *lmp) : Pointers(lmp) outfile = NULL; recv_from_partition = send_to_partition = -1; otherflag = 0; - maxexchange_atom = maxexchange_fix = 0; + + maxexchange = maxexchange_atom = maxexchange_fix = 0; + maxexchange_fix_dynamic = 0; + bufextra = BUFEXTRA; grid2proc = NULL; xsplit = ysplit = zsplit = NULL; @@ -225,6 +228,39 @@ void Comm::init() if (force->newton == 0) maxreverse = 0; if (force->pair) maxreverse = MAX(maxreverse,force->pair->comm_reverse_off); + + // maxexchange_atom = size of an exchanged atom, set by AtomVec + // only needs to be set if size > BUFEXTRA + // maxexchange_fix_dynamic = 1 if any fix sets its maxexchange dynamically + + maxexchange_atom = atom->avec->maxexchange; + + int nfix = modify->nfix; + Fix **fix = modify->fix; + + maxexchange_fix_dynamic = 0; + for (int i = 0; i < nfix; i++) + if (fix[i]->maxexchange_dynamic) maxexchange_fix_dynamic = 1; +} + +/* ---------------------------------------------------------------------- + set maxexchange based on AtomVec and fixes +------------------------------------------------------------------------- */ + +void Comm::init_exchange() +{ + int nfix = modify->nfix; + Fix **fix = modify->fix; + + int onefix; + maxexchange_fix = 0; + for (int i = 0; i < nfix; i++) { + onefix = fix[i]->maxexchange; + maxexchange_fix = MAX(maxexchange_fix,onefix); + } + + maxexchange = maxexchange_atom + maxexchange_fix; + bufextra = maxexchange + BUFEXTRA; } /* ---------------------------------------------------------------------- diff --git a/src/comm.h b/src/comm.h index 30360b1059..3367051e3c 100644 --- a/src/comm.h +++ b/src/comm.h @@ -38,9 +38,8 @@ class Comm : protected Pointers { // -1 if no recv or send int other_partition_style; // 0 = recv layout dims must be multiple of // my layout dims - int maxexchange_atom; // max contribution to exchange from AtomVec - int maxexchange_fix; // max contribution to exchange from Fixes - int nthreads; // OpenMP threads per MPI process + + int nthreads; // OpenMP threads per MPI process // public settings specific to layout = UNIFORM, NONUNIFORM @@ -130,8 +129,13 @@ class Comm : protected Pointers { int size_reverse; // # of datums in reverse comm int size_border; // # of datums in forward border comm - int maxforward,maxreverse; // max # of datums in forward/reverse comm - int maxexchange; // max # of datums/atom in exchange comm + int maxforward,maxreverse; // max # of datums in forward/reverse comm + int maxexchange; // max size of one exchanged atom + int maxexchange_atom; // contribution to maxexchange from AtomVec + int maxexchange_fix; // static contribution to maxexchange from Fixes + int maxexchange_fix_dynamic; // 1 if a fix has a dynamic contribution + int bufextra; // augment size of send buf for an exchange atom + int gridflag; // option for creating 3d grid int mapflag; // option for mapping procs to 3d grid @@ -147,6 +151,7 @@ class Comm : protected Pointers { int coregrid[3]; // 3d grid of cores within a node int user_coregrid[3]; // user request for cores in each dim + void init_exchange(); int rendezvous_irregular(int, char *, int, int, int *, int (*)(int, char *, int &, int *&, char *&, void *), int, char *&, int, void *, int); diff --git a/src/comm_brick.cpp b/src/comm_brick.cpp index 330551aaed..97114e5734 100644 --- a/src/comm_brick.cpp +++ b/src/comm_brick.cpp @@ -42,8 +42,7 @@ using namespace LAMMPS_NS; #define BUFFACTOR 1.5 -#define BUFMIN 1000 -#define BUFEXTRA 1000 +#define BUFMIN 1024 #define BIG 1.0e20 /* ---------------------------------------------------------------------- */ @@ -110,14 +109,6 @@ void CommBrick::init_buffers() multilo = multihi = NULL; cutghostmulti = NULL; - // bufextra = max size of one exchanged atom - // = allowed overflow of sendbuf in exchange() - // atomvec, fix reset these 2 maxexchange values if needed - // only necessary if their size > BUFEXTRA - - maxexchange = maxexchange_atom + maxexchange_fix; - bufextra = maxexchange + BUFEXTRA; - maxsend = BUFMIN; memory->create(buf_send,maxsend+bufextra,"comm:buf_send"); maxrecv = BUFMIN; @@ -141,6 +132,10 @@ void CommBrick::init() { Comm::init(); + int bufextra_old = bufextra; + init_exchange(); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,0); + // memory for multi-style communication if (mode == Comm::MULTI && multilo == NULL) { @@ -603,15 +598,14 @@ void CommBrick::exchange() atom->nghost = 0; atom->avec->clear_bonus(); - // insure send buf is large enough for single atom - // bufextra = max size of one atom = allowed overflow of sendbuf - // fixes can change per-atom size requirement on-the-fly + // insure send buf has extra space for a single atom + // only need to reset if a fix can dynamically add to size of single atom - int bufextra_old = bufextra; - maxexchange = maxexchange_atom + maxexchange_fix; - bufextra = maxexchange + BUFEXTRA; - if (bufextra > bufextra_old) - grow_send(maxsend+bufextra,1); + if (maxexchange_fix_dynamic) { + int bufextra_old = bufextra; + init_exchange(); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,0); + } // subbox bounds for orthogonal or triclinic diff --git a/src/comm_brick.h b/src/comm_brick.h index b3a3a7e094..05268da63e 100644 --- a/src/comm_brick.h +++ b/src/comm_brick.h @@ -74,7 +74,6 @@ class CommBrick : public Comm { double *buf_send; // send buffer for all comm double *buf_recv; // recv buffer for all comm int maxsend,maxrecv; // current size of send/recv buffer - int bufextra; // extra space beyond maxsend in send buffer int smax,rmax; // max size in atoms of single borders send/recv // NOTE: init_buffers is called from a constructor and must not be made virtual diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index d1d625445a..c9f1a63fbc 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -32,8 +32,7 @@ using namespace LAMMPS_NS; #define BUFFACTOR 1.5 #define BUFFACTOR 1.5 -#define BUFMIN 1000 -#define BUFEXTRA 1000 +#define BUFMIN 1024 #define EPSILON 1.0e-6 #define DELTA_PROCS 16 @@ -80,14 +79,6 @@ CommTiled::~CommTiled() void CommTiled::init_buffers() { - // bufextra = max size of one exchanged atom - // = allowed overflow of sendbuf in exchange() - // atomvec, fix reset these 2 maxexchange values if needed - // only necessary if their size > BUFEXTRA - - maxexchange = maxexchange_atom + maxexchange_fix; - bufextra = maxexchange + BUFEXTRA; - maxsend = BUFMIN; memory->create(buf_send,maxsend+bufextra,"comm:buf_send"); maxrecv = BUFMIN; @@ -108,6 +99,10 @@ void CommTiled::init() { Comm::init(); + int bufextra_old = bufextra; + init_exchange(); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,0); + // temporary restrictions if (triclinic) @@ -644,15 +639,14 @@ void CommTiled::exchange() atom->nghost = 0; atom->avec->clear_bonus(); - // insure send buf is large enough for single atom - // bufextra = max size of one atom = allowed overflow of sendbuf - // fixes can change per-atom size requirement on-the-fly + // insure send buf has extra space for a single atom + // only need to reset if a fix can dynamically add to size of single atom - int bufextra_old = bufextra; - maxexchange = maxexchange_atom + maxexchange_fix; - bufextra = maxexchange + BUFEXTRA; - if (bufextra > bufextra_old) - memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); + if (maxexchange_fix_dynamic) { + int bufextra_old = bufextra; + init_exchange(); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,1); + } // domain properties used in exchange method and methods it calls // subbox bounds for orthogonal or triclinic diff --git a/src/comm_tiled.h b/src/comm_tiled.h index 13ecbc4b01..679be195aa 100644 --- a/src/comm_tiled.h +++ b/src/comm_tiled.h @@ -87,7 +87,6 @@ class CommTiled : public Comm { double *buf_send; // send buffer for all comm double *buf_recv; // recv buffer for all comm int maxsend,maxrecv; // current size of send/recv buffer - int bufextra; // extra space beyond maxsend in send buffer int smaxone,rmaxone; // max size in atoms of single borders send/recv int smaxall,rmaxall; // max size in atoms of any borders send/recv // for comm to all procs in one swap diff --git a/src/fix.cpp b/src/fix.cpp index 634bc2393d..2a94340842 100644 --- a/src/fix.cpp +++ b/src/fix.cpp @@ -78,6 +78,8 @@ Fix::Fix(LAMMPS *lmp, int /*narg*/, char **arg) : enforce2d_flag = 0; respa_level_support = 0; respa_level = -1; + maxexchange = 0; + maxexchange_dynamic = 0; scalar_flag = vector_flag = array_flag = 0; peratom_flag = local_flag = 0; diff --git a/src/fix.h b/src/fix.h index 7eaff38bd3..f4bf7f9c01 100644 --- a/src/fix.h +++ b/src/fix.h @@ -56,6 +56,8 @@ class Fix : protected Pointers { int enforce2d_flag; // 1 if has enforce2d method int respa_level_support; // 1 if fix supports fix_modify respa int respa_level; // which respa level to apply fix (1-Nrespa) + int maxexchange; // max # of per-atom values for Comm::exchange() + int maxexchange_dynamic; // 1 if fix sets maxexchange dynamically int scalar_flag; // 0/1 if compute_scalar() function exists int vector_flag; // 0/1 if compute_vector() function exists diff --git a/src/fix_neigh_history.cpp b/src/fix_neigh_history.cpp index 207c409596..7405b6d81f 100644 --- a/src/fix_neigh_history.cpp +++ b/src/fix_neigh_history.cpp @@ -42,6 +42,7 @@ FixNeighHistory::FixNeighHistory(LAMMPS *lmp, int narg, char **arg) : restart_peratom = 1; create_attribute = 1; + maxexchange_dynamic = 1; newton_pair = force->newton_pair; @@ -296,11 +297,11 @@ void FixNeighHistory::pre_exchange_onesided() } // set maxpartner = max # of partners of any owned atom - // bump up comm->maxexchange_fix if necessary + // maxexchange = max # of values for any Comm::exchange() atom maxpartner = 0; for (i = 0; i < nlocal_neigh; i++) maxpartner = MAX(maxpartner,npartner[i]); - comm->maxexchange_fix = MAX(comm->maxexchange_fix,(dnum+1)*maxpartner+1); + maxexchange = (dnum+1)*maxpartner + 1; // zero npartner values from previous nlocal_neigh to current nlocal @@ -424,11 +425,11 @@ void FixNeighHistory::pre_exchange_newton() comm->reverse_comm_fix_variable(this); // set maxpartner = max # of partners of any owned atom - // bump up comm->maxexchange_fix if necessary + // maxexchange = max # of values for any Comm::exchange() atom maxpartner = 0; for (i = 0; i < nlocal_neigh; i++) maxpartner = MAX(maxpartner,npartner[i]); - comm->maxexchange_fix = MAX(comm->maxexchange_fix,(dnum+1)*maxpartner+1); + maxexchange = (dnum+1)*maxpartner + 1; // zero npartner values from previous nlocal_neigh to current nlocal @@ -531,11 +532,11 @@ void FixNeighHistory::pre_exchange_no_newton() } // set maxpartner = max # of partners of any owned atom - // bump up comm->maxexchange_fix if necessary + // maxexchange = max # of values for any Comm::exchange() atom maxpartner = 0; for (i = 0; i < nlocal_neigh; i++) maxpartner = MAX(maxpartner,npartner[i]); - comm->maxexchange_fix = MAX(comm->maxexchange_fix,(dnum+1)*maxpartner+1); + maxexchange = (dnum+1)*maxpartner + 1; // zero npartner values from previous nlocal_neigh to current nlocal @@ -796,9 +797,6 @@ void FixNeighHistory::unpack_reverse_comm(int n, int *list, double *buf) int FixNeighHistory::pack_exchange(int i, double *buf) { - // NOTE: how do I know comm buf is big enough if extreme # of touching neighs - // Comm::BUFEXTRA may need to be increased - int m = 0; buf[m++] = npartner[i]; for (int n = 0; n < npartner[i]; n++) { diff --git a/src/fix_store.cpp b/src/fix_store.cpp index 9db65d0987..941132a837 100644 --- a/src/fix_store.cpp +++ b/src/fix_store.cpp @@ -106,6 +106,7 @@ vstore(NULL), astore(NULL), rbuf(NULL) for (int i = 0; i < nlocal; i++) for (int j = 0; j < nvalues; j++) astore[i][j] = 0.0; + maxexchange = nvalues; } } -- GitLab From 5236497932c7b775480123d6e11516158796f035 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Tue, 9 Jul 2019 18:36:51 -0400 Subject: [PATCH 216/469] Changed 'bohr_per_atu_si' to 'bohr_per_atu_electron_si' --- src/KIM/kim_units.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/KIM/kim_units.cpp b/src/KIM/kim_units.cpp index 40f4917601..45f9b81a35 100644 --- a/src/KIM/kim_units.cpp +++ b/src/KIM/kim_units.cpp @@ -175,7 +175,7 @@ double const nanometer_per_nanosecond_si = nanometer_si/nanosecond_si; // [m/s] nanometer/nanosecond double const centimeter_per_second_si = centimeter_si; // [m/s] centimeter/second -double const bohr_per_atu_si = +double const bohr_per_atu_electron_si = bohr_si/atu_electron_si; // [m/s] bohr/atu /*---------------------- @@ -803,7 +803,7 @@ double get_velocity_conversion_factor(units from_unit_enum, units to_unit_enum) conv[meter_per_second][angstrom_per_femtosecond] = 1.0/angstrom_per_femtosecond_si; conv[meter_per_second][angstrom_per_picosecond] = 1.0/angstrom_per_picosecond_si; conv[meter_per_second][centimeter_per_second] = 1.0/centimeter_per_second_si; - conv[meter_per_second][bohr_per_atu] = 1.0/bohr_per_atu_si; + conv[meter_per_second][bohr_per_atu] = 1.0/bohr_per_atu_electron_si; conv[meter_per_second][micrometer_per_microsecond] = 1.0/micrometer_per_microsecond_si; conv[meter_per_second][nanometer_per_nanosecond] = 1.0/nanometer_per_nanosecond_si; -- GitLab From 39315268e885fba886a0ff30eccc619ffaa64c5f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 9 Jul 2019 16:53:19 -0600 Subject: [PATCH 217/469] new versions of jacobi() method --- src/math_extra.cpp | 229 +++++++++++++++++++++++++++++++++------------ src/math_extra.h | 9 +- 2 files changed, 175 insertions(+), 63 deletions(-) diff --git a/src/math_extra.cpp b/src/math_extra.cpp index f7e5bb646b..e72b3d3997 100644 --- a/src/math_extra.cpp +++ b/src/math_extra.cpp @@ -13,6 +13,7 @@ /* ---------------------------------------------------------------------- Contributing author: Mike Brown (SNL) + Arno Mayrhofer (DCS Computing), jacobi() functions ------------------------------------------------------------------------- */ #include @@ -95,83 +96,189 @@ int mldivide3(const double m[3][3], const double *v, double *ans) /* ---------------------------------------------------------------------- compute evalues and evectors of 3x3 real symmetric matrix based on Jacobi rotations - adapted from Numerical Recipes jacobi() function + two variants for passing in matrix + + procedure jacobi(S ∈ Rn×n; out e ∈ Rn; out E ∈ Rn×n) + var + i, k, l, m, state ∈ N + s, c, t, p, y, d, r ∈ R + ind ∈ Nn + changed ∈ Ln + ! init e, E, and arrays ind, changed + E := I; state := n + for k := 1 to n do indk := maxind(k); ek := Skk; changedk := true endfor + while state≠0 do ! next rotation + m := 1 ! find index (k,l) of pivot p + for k := 2 to n−1 do + if │Sk indk│ > │Sm indm│ then m := k endif + endfor + k := m; l := indm; p := Skl + ! calculate c = cos φ, s = sin φ + y := (el−ek)/2; d := │y│+√(p2+y2) + r := √(p2+d2); c := d/r; s := p/r; t := p2/d + if y<0 then s := −s; t := −t endif + Skl := 0.0; update(k,−t); update(l,t) + ! rotate rows and columns k and l + for i := 1 to k−1 do rotate(i,k,i,l) endfor + for i := k+1 to l−1 do rotate(k,i,i,l) endfor + for i := l+1 to n do rotate(k,i,l,i) endfor + ! rotate eigenvectors + for i := 1 to n do + ┌ ┐ ┌ ┐┌ ┐ + │Eik│ │c −s││Eik│ + │ │ := │ ││ │ + │Eil│ │s c││Eil│ + └ ┘ └ ┘└ ┘ + endfor + ! rows k, l have changed, update rows indk, indl + indk := maxind(k); indl := maxind(l) + loop + endproc ------------------------------------------------------------------------- */ int jacobi(double matrix[3][3], double *evalues, double evectors[3][3]) { - int i,j,k; - double tresh,theta,tau,t,sm,s,h,g,c,b[3],z[3]; - - for (i = 0; i < 3; i++) { - for (j = 0; j < 3; j++) evectors[i][j] = 0.0; - evectors[i][i] = 1.0; - } - for (i = 0; i < 3; i++) { - b[i] = evalues[i] = matrix[i][i]; - z[i] = 0.0; - } - - for (int iter = 1; iter <= MAXJACOBI; iter++) { - sm = 0.0; - for (i = 0; i < 2; i++) - for (j = i+1; j < 3; j++) - sm += fabs(matrix[i][j]); - if (sm == 0.0) return 0; - - if (iter < 4) tresh = 0.2*sm/(3*3); - else tresh = 0.0; - - for (i = 0; i < 2; i++) { - for (j = i+1; j < 3; j++) { - g = 100.0*fabs(matrix[i][j]); - if (iter > 4 && fabs(evalues[i])+g == fabs(evalues[i]) - && fabs(evalues[j])+g == fabs(evalues[j])) - matrix[i][j] = 0.0; - else if (fabs(matrix[i][j]) > tresh) { - h = evalues[j]-evalues[i]; - if (fabs(h)+g == fabs(h)) t = (matrix[i][j])/h; - else { - theta = 0.5*h/(matrix[i][j]); - t = 1.0/(fabs(theta)+sqrt(1.0+theta*theta)); - if (theta < 0.0) t = -t; - } - c = 1.0/sqrt(1.0+t*t); - s = t*c; - tau = s/(1.0+c); - h = t*matrix[i][j]; - z[i] -= h; - z[j] += h; - evalues[i] -= h; - evalues[j] += h; - matrix[i][j] = 0.0; - for (k = 0; k < i; k++) rotate(matrix,k,i,k,j,s,tau); - for (k = i+1; k < j; k++) rotate(matrix,i,k,k,j,s,tau); - for (k = j+1; k < 3; k++) rotate(matrix,i,k,j,k,s,tau); - for (k = 0; k < 3; k++) rotate(evectors,k,i,k,j,s,tau); + evectors[0][0] = 1.0; evectors[0][1] = 0.0; evectors[0][2] = 0.0; + evectors[1][0] = 0.0; evectors[1][1] = 1.0; evectors[1][2] = 0.0; + evectors[2][0] = 0.0; evectors[2][1] = 0.0; evectors[2][2] = 1.0; + evalues[0] = 0.0; evalues[1] = 0.0; evalues[2] = 0.0; + double threshold = 0.0; + + for (int i = 0; i < 3; i++) + for (int j = i; j < 3; j++) + threshold += fabs(matrix[i][j]); + + if (threshold < 1.0e-200) return 0; + threshold *= 1.0e-12; + int state = 2; + bool changed[3] = {true, true, true}; + + int iteration = 0; + while (state > 0 && iteration < MAXJACOBI) { + for (int k = 0; k < 2; k++) { + for (int l = k+1; l < 3; l++) { + const double p = matrix[k][l]; + const double y = (matrix[l][l]-matrix[k][k])*0.5; + const double d = fabs(y)+sqrt(p*p + y*y); + const double r = sqrt(p*p + d*d); + const double c = r > threshold ? d/r : 1.0; + double s = r > threshold ? p/r : 0.0; + double t = d > threshold ? p*p/d : 0.0; + if (y < 0.0) { + s *= -1.0; + t *= -1.0; } + matrix[k][l] = 0.0; + update_eigenvalue(matrix[k][k], changed[k], state, -t, threshold); + update_eigenvalue(matrix[l][l], changed[l], state, t, threshold); + for (int i = 0; i < k; i++) + rotate(matrix[i][k], matrix[i][l],c,s); + for (int i = k+1; i < l; i++) + rotate(matrix[k][i], matrix[i][l],c,s); + for (int i = l+1; i < 3; i++) + rotate(matrix[k][i], matrix[l][i],c,s); + for (int i = 0; i < 3; i++) + rotate(evectors[i][k], evectors[i][l],c,s); } } + iteration++; + } + + for (int i = 0; i < 3; i++) + evalues[i] = matrix[i][i]; - for (i = 0; i < 3; i++) { - evalues[i] = b[i] += z[i]; - z[i] = 0.0; + if (iteration == MAXJACOBI) return 1; + return 0; +} + +int jacobi(double **matrix, double *evalues, double **evectors) +{ + evectors[0][0] = 1.0; evectors[0][1] = 0.0; evectors[0][2] = 0.0; + evectors[1][0] = 0.0; evectors[1][1] = 1.0; evectors[1][2] = 0.0; + evectors[2][0] = 0.0; evectors[2][1] = 0.0; evectors[2][2] = 1.0; + evalues[0] = 0.0; evalues[1] = 0.0; evalues[2] = 0.0; + double threshold = 0.0; + + for (int i = 0; i < 3; i++) + for (int j = i; j < 3; j++) + threshold += fabs(matrix[i][j]); + + if (threshold < 1.0e-200) return 0; + threshold *= 1.0e-12; + int state = 2; + bool changed[3] = {true, true, true}; + + int iteration = 0; + while (state > 0 && iteration < MAXJACOBI) { + for (int k = 0; k < 2; k++) { + for (int l = k+1; l < 3; l++) { + const double p = matrix[k][l]; + const double y = (matrix[l][l]-matrix[k][k])*0.5; + const double d = fabs(y)+sqrt(p*p + y*y); + const double r = sqrt(p*p + d*d); + const double c = r > threshold ? d/r : 1.0; + double s = r > threshold ? p/r : 0.0; + double t = d > threshold ? p*p/d : 0.0; + if (y < 0.0) { + s *= -1.0; + t *= -1.0; + } + matrix[k][l] = 0.0; + update_eigenvalue(matrix[k][k], changed[k], state, -t, threshold); + update_eigenvalue(matrix[l][l], changed[l], state, t, threshold); + for (int i = 0; i < k; i++) + rotate(matrix[i][k], matrix[i][l],c,s); + for (int i = k+1; i < l; i++) + rotate(matrix[k][i], matrix[i][l],c,s); + for (int i = l+1; i < 3; i++) + rotate(matrix[k][i], matrix[l][i],c,s); + for (int i = 0; i < 3; i++) + rotate(evectors[i][k], evectors[i][l],c,s); + } } + iteration++; } - return 1; + + for (int i = 0; i < 3; i++) + evalues[i] = matrix[i][i]; + + if (iteration == MAXJACOBI) return 1; + return 0; } /* ---------------------------------------------------------------------- - perform a single Jacobi rotation + perform a single Jacobi rotation of Sij, Skl + ┌ ┐ ┌ ┐┌ ┐ + │Skl│ │c −s││Skl│ + │ │ := │ ││ │ + │Sij│ │s c││Sij│ + └ ┘ └ ┘└ ┘ ------------------------------------------------------------------------- */ -void rotate(double matrix[3][3], int i, int j, int k, int l, - double s, double tau) +void rotate(double &matrix_kl, double &matrix_ij, + const double c, const double s) { - double g = matrix[i][j]; - double h = matrix[k][l]; - matrix[i][j] = g-s*(h+g*tau); - matrix[k][l] = h+s*(g-h*tau); + const double tmp_kl = matrix_kl; + matrix_kl = c*matrix_kl - s*matrix_ij; + matrix_ij = s*tmp_kl + c*matrix_ij; +} + +/* ---------------------------------------------------------------------- + update eigenvalue and its status +------------------------------------------------------------------------- */ + +void update_eigenvalue(double &eigenvalue, bool &changed, int &state, + const double t, const double threshold) +{ + eigenvalue += t; + + if (changed && fabs(t) < threshold) { + changed = false; + state--; + } else if (!changed && fabs(t) > threshold) { + changed = true; + state++; + } } /* ---------------------------------------------------------------------- diff --git a/src/math_extra.h b/src/math_extra.h index 85f57224cf..2befc7ee97 100644 --- a/src/math_extra.h +++ b/src/math_extra.h @@ -77,9 +77,14 @@ namespace MathExtra { void write3(const double mat[3][3]); int mldivide3(const double mat[3][3], const double *vec, double *ans); + int jacobi(double matrix[3][3], double *evalues, double evectors[3][3]); - void rotate(double matrix[3][3], int i, int j, int k, int l, - double s, double tau); + int jacobi(double **matrix, double *evalues, double **evectors); + void rotate(double &matrix_kl, double &matrix_ij, + const double c, const double s); + void update_eigenvalue(double &eigenvalue, bool &changed, int &state, + const double t, const double threshold); + void richardson(double *q, double *m, double *w, double *moments, double dtq); void no_squish_rotate(int k, double *p, double *q, double *inertia, double dt); -- GitLab From d6ed4ee1b12489d126ca35d0005c59c1baf9a93c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 9 Jul 2019 17:34:54 -0600 Subject: [PATCH 218/469] add missing term to per-atom stress --- src/MANYBODY/pair_bop.cpp | 3 +++ 1 file changed, 3 insertions(+) diff --git a/src/MANYBODY/pair_bop.cpp b/src/MANYBODY/pair_bop.cpp index ac157e071c..39f48cd05e 100644 --- a/src/MANYBODY/pair_bop.cpp +++ b/src/MANYBODY/pair_bop.cpp @@ -3740,6 +3740,9 @@ double PairBOP::sigmaBo(int itmp, int jtmp) if(sigma_f[iij]==0.5&&sigma_k[iij]==0.0) { sigB=dsigB1; pp1=2.0*betaS_ij; + xtmp[0]=x[bt_j][0]-x[bt_i][0]; + xtmp[1]=x[bt_j][1]-x[bt_i][1]; + xtmp[2]=x[bt_j][2]-x[bt_i][2]; for(pp=0;pp<3;pp++) { bt_sg[m].dSigB[pp]=dsigB2*bt_sg[m].dSigB1[pp]; } -- GitLab From 93748a18ae4fd370e43244fed4c5e3b07eae4e4f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 10 Jul 2019 00:22:03 -0400 Subject: [PATCH 219/469] further clean up of AtomVec classes after merging PR #1552 to master --- src/DIPOLE/atom_vec_dipole.cpp | 2 -- src/KOKKOS/atom_vec_angle_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_atomic_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_bond_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_charge_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_dpd_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_full_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_hybrid_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_molecular_kokkos.cpp | 2 -- src/KOKKOS/atom_vec_sphere_kokkos.cpp | 2 -- src/MOLECULE/atom_vec_angle.cpp | 2 -- src/MOLECULE/atom_vec_bond.cpp | 2 -- src/MOLECULE/atom_vec_full.cpp | 2 -- src/MOLECULE/atom_vec_molecular.cpp | 2 -- src/MOLECULE/atom_vec_template.cpp | 2 -- src/PERI/atom_vec_peri.cpp | 2 -- src/SPIN/atom_vec_spin.cpp | 2 -- src/USER-AWPMD/atom_vec_wavepacket.cpp | 2 -- src/USER-DPD/atom_vec_dpd.cpp | 2 -- src/USER-EFF/atom_vec_electron.cpp | 3 +-- src/USER-MESO/atom_vec_edpd.cpp | 4 +--- src/USER-MESO/atom_vec_mdpd.cpp | 4 +--- src/USER-MESO/atom_vec_tdpd.cpp | 8 +++----- src/USER-SMD/atom_vec_smd.cpp | 4 +--- src/USER-SPH/atom_vec_meso.cpp | 4 +--- src/atom_vec.cpp | 1 - src/atom_vec_atomic.cpp | 2 -- src/atom_vec_body.cpp | 1 - src/atom_vec_charge.cpp | 2 -- src/atom_vec_ellipsoid.cpp | 1 - src/atom_vec_hybrid.cpp | 2 -- src/atom_vec_line.cpp | 1 - src/atom_vec_sphere.cpp | 1 - src/atom_vec_tri.cpp | 1 - 34 files changed, 8 insertions(+), 69 deletions(-) diff --git a/src/DIPOLE/atom_vec_dipole.cpp b/src/DIPOLE/atom_vec_dipole.cpp index 945732f74b..a3ff3fd0f5 100644 --- a/src/DIPOLE/atom_vec_dipole.cpp +++ b/src/DIPOLE/atom_vec_dipole.cpp @@ -13,11 +13,9 @@ #include "atom_vec_dipole.h" #include -#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/KOKKOS/atom_vec_angle_kokkos.cpp b/src/KOKKOS/atom_vec_angle_kokkos.cpp index b8f5634fa0..736e1c1fca 100644 --- a/src/KOKKOS/atom_vec_angle_kokkos.cpp +++ b/src/KOKKOS/atom_vec_angle_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_angle_kokkos.h" -#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_atomic_kokkos.cpp b/src/KOKKOS/atom_vec_atomic_kokkos.cpp index f65f34419a..4fec5740d6 100644 --- a/src/KOKKOS/atom_vec_atomic_kokkos.cpp +++ b/src/KOKKOS/atom_vec_atomic_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_atomic_kokkos.h" -#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_bond_kokkos.cpp b/src/KOKKOS/atom_vec_bond_kokkos.cpp index c36b084637..74c05a506c 100644 --- a/src/KOKKOS/atom_vec_bond_kokkos.cpp +++ b/src/KOKKOS/atom_vec_bond_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_bond_kokkos.h" -#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_charge_kokkos.cpp b/src/KOKKOS/atom_vec_charge_kokkos.cpp index 631c4b237c..3f26b1e9ea 100644 --- a/src/KOKKOS/atom_vec_charge_kokkos.cpp +++ b/src/KOKKOS/atom_vec_charge_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_charge_kokkos.h" -#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index e7123037ca..4162b71374 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_dpd_kokkos.h" -#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_full_kokkos.cpp b/src/KOKKOS/atom_vec_full_kokkos.cpp index 4b6e413b64..1fdbcbec8c 100644 --- a/src/KOKKOS/atom_vec_full_kokkos.cpp +++ b/src/KOKKOS/atom_vec_full_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_full_kokkos.h" -#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "atom_masks.h" diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp index 630648b3a6..318e79d955 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_hybrid_kokkos.h" -#include #include #include "atom_kokkos.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/atom_vec_molecular_kokkos.cpp b/src/KOKKOS/atom_vec_molecular_kokkos.cpp index 8790f0bdbc..f3b4ae98ca 100644 --- a/src/KOKKOS/atom_vec_molecular_kokkos.cpp +++ b/src/KOKKOS/atom_vec_molecular_kokkos.cpp @@ -12,13 +12,11 @@ ------------------------------------------------------------------------- */ #include "atom_vec_molecular_kokkos.h" -#include #include "atom_kokkos.h" #include "comm_kokkos.h" #include "domain.h" #include "modify.h" #include "fix.h" -#include "force.h" #include "atom_masks.h" #include "memory_kokkos.h" #include "error.h" diff --git a/src/KOKKOS/atom_vec_sphere_kokkos.cpp b/src/KOKKOS/atom_vec_sphere_kokkos.cpp index 0f69cc9c5a..d93b98a4b0 100644 --- a/src/KOKKOS/atom_vec_sphere_kokkos.cpp +++ b/src/KOKKOS/atom_vec_sphere_kokkos.cpp @@ -13,14 +13,12 @@ #include "atom_vec_sphere_kokkos.h" #include -#include #include #include "atom_kokkos.h" #include "atom_masks.h" #include "comm_kokkos.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "fix_adapt.h" #include "math_const.h" diff --git a/src/MOLECULE/atom_vec_angle.cpp b/src/MOLECULE/atom_vec_angle.cpp index c8053266ca..b6f5a013cb 100644 --- a/src/MOLECULE/atom_vec_angle.cpp +++ b/src/MOLECULE/atom_vec_angle.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_angle.h" -#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_bond.cpp b/src/MOLECULE/atom_vec_bond.cpp index 0d267d10cc..b9d4177b4f 100644 --- a/src/MOLECULE/atom_vec_bond.cpp +++ b/src/MOLECULE/atom_vec_bond.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_bond.h" -#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_full.cpp b/src/MOLECULE/atom_vec_full.cpp index 167edde18f..e71e23a661 100644 --- a/src/MOLECULE/atom_vec_full.cpp +++ b/src/MOLECULE/atom_vec_full.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_full.h" -#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_molecular.cpp b/src/MOLECULE/atom_vec_molecular.cpp index 5ccf5529b4..1bafb6dc43 100644 --- a/src/MOLECULE/atom_vec_molecular.cpp +++ b/src/MOLECULE/atom_vec_molecular.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_molecular.h" -#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/MOLECULE/atom_vec_template.cpp b/src/MOLECULE/atom_vec_template.cpp index ae31870fd0..27c6ab4183 100644 --- a/src/MOLECULE/atom_vec_template.cpp +++ b/src/MOLECULE/atom_vec_template.cpp @@ -12,10 +12,8 @@ ------------------------------------------------------------------------- */ #include "atom_vec_template.h" -#include #include "atom.h" #include "molecule.h" -#include "force.h" #include "comm.h" #include "domain.h" #include "modify.h" diff --git a/src/PERI/atom_vec_peri.cpp b/src/PERI/atom_vec_peri.cpp index 0829dfb1c0..47b88995b8 100644 --- a/src/PERI/atom_vec_peri.cpp +++ b/src/PERI/atom_vec_peri.cpp @@ -17,12 +17,10 @@ #include "atom_vec_peri.h" #include -#include #include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "citeme.h" diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index 345a2d6c04..f5560b6ee9 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -25,14 +25,12 @@ #include "atom_vec_spin.h" #include -#include #include #include "atom.h" #include "comm.h" #include "domain.h" #include "error.h" #include "fix.h" -#include "force.h" #include "memory.h" #include "modify.h" #include "utils.h" diff --git a/src/USER-AWPMD/atom_vec_wavepacket.cpp b/src/USER-AWPMD/atom_vec_wavepacket.cpp index bafd172254..c12798688e 100644 --- a/src/USER-AWPMD/atom_vec_wavepacket.cpp +++ b/src/USER-AWPMD/atom_vec_wavepacket.cpp @@ -17,13 +17,11 @@ #include "atom_vec_wavepacket.h" #include -#include #include #include "atom.h" #include "comm.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "memory.h" #include "error.h" diff --git a/src/USER-DPD/atom_vec_dpd.cpp b/src/USER-DPD/atom_vec_dpd.cpp index 2aef55ff9f..bf11840d1e 100644 --- a/src/USER-DPD/atom_vec_dpd.cpp +++ b/src/USER-DPD/atom_vec_dpd.cpp @@ -15,12 +15,10 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ -#include #include "atom_vec_dpd.h" #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/USER-EFF/atom_vec_electron.cpp b/src/USER-EFF/atom_vec_electron.cpp index cca71545f4..707a75c7c1 100644 --- a/src/USER-EFF/atom_vec_electron.cpp +++ b/src/USER-EFF/atom_vec_electron.cpp @@ -15,9 +15,8 @@ Contributing author: Andres Jaramillo-Botero (Caltech) ------------------------------------------------------------------------- */ -#include -#include #include "atom_vec_electron.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/USER-MESO/atom_vec_edpd.cpp b/src/USER-MESO/atom_vec_edpd.cpp index ff8515abc6..dccc8b9efa 100644 --- a/src/USER-MESO/atom_vec_edpd.cpp +++ b/src/USER-MESO/atom_vec_edpd.cpp @@ -10,13 +10,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "atom_vec_edpd.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "update.h" diff --git a/src/USER-MESO/atom_vec_mdpd.cpp b/src/USER-MESO/atom_vec_mdpd.cpp index 965891a283..0aa6aedcee 100644 --- a/src/USER-MESO/atom_vec_mdpd.cpp +++ b/src/USER-MESO/atom_vec_mdpd.cpp @@ -11,13 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "atom_vec_mdpd.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "update.h" diff --git a/src/USER-MESO/atom_vec_tdpd.cpp b/src/USER-MESO/atom_vec_tdpd.cpp index f19758f884..278baa2024 100644 --- a/src/USER-MESO/atom_vec_tdpd.cpp +++ b/src/USER-MESO/atom_vec_tdpd.cpp @@ -11,12 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "atom_vec_tdpd.h" +#include #include "atom.h" #include "comm.h" -#include "force.h" #include "domain.h" #include "modify.h" #include "fix.h" @@ -65,7 +63,7 @@ void AtomVecTDPD::process_args(int narg, char **arg) { if (narg < 1) error->all(FLERR,"Invalid atom_style tdpd command"); - atom->cc_species = force->inumeric(FLERR,arg[0]); + atom->cc_species = utils::inumeric(FLERR,arg[0],false,lmp); cc_species = atom->cc_species; // reset sizes that depend on cc_species @@ -801,7 +799,7 @@ void AtomVecTDPD::data_atom(double *coord, imageint imagetmp, char **values) x[nlocal][2] = coord[2]; for(int k = 0; k < cc_species; k++) - cc[nlocal][k] = atof( values[5+k] ); + cc[nlocal][k] = utils::numeric(FLERR,values[5+k],true,lmp); image[nlocal] = imagetmp; diff --git a/src/USER-SMD/atom_vec_smd.cpp b/src/USER-SMD/atom_vec_smd.cpp index 278652bf43..5cc411a832 100644 --- a/src/USER-SMD/atom_vec_smd.cpp +++ b/src/USER-SMD/atom_vec_smd.cpp @@ -22,15 +22,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "atom_vec_smd.h" #include -#include #include -#include "atom_vec_smd.h" #include "atom.h" #include "comm.h" #include "domain.h" #include "modify.h" -#include "force.h" #include "fix.h" #include "fix_adapt.h" #include "math_const.h" diff --git a/src/USER-SPH/atom_vec_meso.cpp b/src/USER-SPH/atom_vec_meso.cpp index 0960141ae2..59e6638f16 100644 --- a/src/USER-SPH/atom_vec_meso.cpp +++ b/src/USER-SPH/atom_vec_meso.cpp @@ -11,13 +11,11 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "atom_vec_meso.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index 146a503221..1ea085b869 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -13,7 +13,6 @@ #include "atom_vec.h" #include -#include #include "atom.h" #include "force.h" #include "domain.h" diff --git a/src/atom_vec_atomic.cpp b/src/atom_vec_atomic.cpp index f1583ab8cc..3cf037f182 100644 --- a/src/atom_vec_atomic.cpp +++ b/src/atom_vec_atomic.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_atomic.h" -#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/atom_vec_body.cpp b/src/atom_vec_body.cpp index 622b698bd9..53ed708c4e 100644 --- a/src/atom_vec_body.cpp +++ b/src/atom_vec_body.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "atom_vec_body.h" -#include #include #include #include "my_pool_chunk.h" diff --git a/src/atom_vec_charge.cpp b/src/atom_vec_charge.cpp index da863f0949..923d892acd 100644 --- a/src/atom_vec_charge.cpp +++ b/src/atom_vec_charge.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_charge.h" -#include #include "atom.h" #include "comm.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/atom_vec_ellipsoid.cpp b/src/atom_vec_ellipsoid.cpp index 44cd818c9d..586e6a80ff 100644 --- a/src/atom_vec_ellipsoid.cpp +++ b/src/atom_vec_ellipsoid.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include "atom_vec_ellipsoid.h" -#include #include #include "math_extra.h" #include "atom.h" diff --git a/src/atom_vec_hybrid.cpp b/src/atom_vec_hybrid.cpp index 25c85b2e3d..9ad07b9032 100644 --- a/src/atom_vec_hybrid.cpp +++ b/src/atom_vec_hybrid.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "atom_vec_hybrid.h" -#include #include #include "atom.h" #include "domain.h" -#include "force.h" #include "modify.h" #include "fix.h" #include "memory.h" diff --git a/src/atom_vec_line.cpp b/src/atom_vec_line.cpp index f9feb9b046..30736c02c9 100644 --- a/src/atom_vec_line.cpp +++ b/src/atom_vec_line.cpp @@ -13,7 +13,6 @@ #include "atom_vec_line.h" #include -#include #include #include "atom.h" #include "comm.h" diff --git a/src/atom_vec_sphere.cpp b/src/atom_vec_sphere.cpp index 1defcf8d01..9d52d005ba 100644 --- a/src/atom_vec_sphere.cpp +++ b/src/atom_vec_sphere.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "atom_vec_sphere.h" -#include #include #include "atom.h" #include "comm.h" diff --git a/src/atom_vec_tri.cpp b/src/atom_vec_tri.cpp index 8835255591..640e0fcb34 100644 --- a/src/atom_vec_tri.cpp +++ b/src/atom_vec_tri.cpp @@ -13,7 +13,6 @@ #include "atom_vec_tri.h" #include -#include #include #include "math_extra.h" #include "atom.h" -- GitLab From 054ff97a5168830fbc6cda3fedcb1ad1f4bdf0aa Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 10 Jul 2019 00:27:31 -0400 Subject: [PATCH 220/469] replace ATOTAGINT() calls with utils::tnumeric() in AtomVec classes --- src/DIPOLE/atom_vec_dipole.cpp | 2 +- src/KOKKOS/atom_vec_dpd_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_hybrid_kokkos.cpp | 2 +- src/KOKKOS/atom_vec_sphere_kokkos.cpp | 2 +- src/MOLECULE/atom_vec_angle.cpp | 6 +++--- src/MOLECULE/atom_vec_bond.cpp | 6 +++--- src/MOLECULE/atom_vec_full.cpp | 6 +++--- src/MOLECULE/atom_vec_molecular.cpp | 6 +++--- src/MOLECULE/atom_vec_template.cpp | 6 +++--- src/PERI/atom_vec_peri.cpp | 2 +- src/SPIN/atom_vec_spin.cpp | 2 +- src/USER-AWPMD/atom_vec_wavepacket.cpp | 2 +- src/USER-DPD/atom_vec_dpd.cpp | 2 +- src/USER-EFF/atom_vec_electron.cpp | 2 +- src/USER-MESO/atom_vec_edpd.cpp | 2 +- src/USER-MESO/atom_vec_mdpd.cpp | 2 +- src/USER-MESO/atom_vec_tdpd.cpp | 2 +- src/USER-SMD/atom_vec_smd.cpp | 4 ++-- src/USER-SPH/atom_vec_meso.cpp | 2 +- src/atom_vec_atomic.cpp | 2 +- src/atom_vec_body.cpp | 2 +- src/atom_vec_charge.cpp | 2 +- src/atom_vec_ellipsoid.cpp | 2 +- src/atom_vec_hybrid.cpp | 2 +- src/atom_vec_line.cpp | 6 +++--- src/atom_vec_sphere.cpp | 2 +- src/atom_vec_tri.cpp | 6 +++--- 27 files changed, 42 insertions(+), 42 deletions(-) diff --git a/src/DIPOLE/atom_vec_dipole.cpp b/src/DIPOLE/atom_vec_dipole.cpp index 47fff1d4c5..a6f454dc98 100644 --- a/src/DIPOLE/atom_vec_dipole.cpp +++ b/src/DIPOLE/atom_vec_dipole.cpp @@ -781,7 +781,7 @@ void AtomVecDipole::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index 93ca976892..317914e4f8 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -1724,7 +1724,7 @@ void AtomVecDPDKokkos::data_atom(double *coord, tagint imagetmp, int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - h_tag[nlocal] = ATOTAGINT(values[0]); + h_tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); h_type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp index 54dd89bfb3..c4dd90ce05 100644 --- a/src/KOKKOS/atom_vec_hybrid_kokkos.cpp +++ b/src/KOKKOS/atom_vec_hybrid_kokkos.cpp @@ -976,7 +976,7 @@ void AtomVecHybridKokkos::data_atom(double *coord, imageint imagetmp, char **val int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - h_tag[nlocal] = ATOTAGINT(values[0]); + h_tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); h_type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (h_type[nlocal] <= 0 || h_type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom h_type in Atoms section of data file"); diff --git a/src/KOKKOS/atom_vec_sphere_kokkos.cpp b/src/KOKKOS/atom_vec_sphere_kokkos.cpp index bc72bcbf5e..3b64ceeb42 100644 --- a/src/KOKKOS/atom_vec_sphere_kokkos.cpp +++ b/src/KOKKOS/atom_vec_sphere_kokkos.cpp @@ -2549,7 +2549,7 @@ void AtomVecSphereKokkos::data_atom(double *coord, imageint imagetmp, char **val int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/MOLECULE/atom_vec_angle.cpp b/src/MOLECULE/atom_vec_angle.cpp index 87220bfad6..bdafdae148 100644 --- a/src/MOLECULE/atom_vec_angle.cpp +++ b/src/MOLECULE/atom_vec_angle.cpp @@ -793,8 +793,8 @@ void AtomVecAngle::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); - molecule[nlocal] = ATOTAGINT(values[1]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); + molecule[nlocal] = utils::tnumeric(FLERR,values[1],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -822,7 +822,7 @@ void AtomVecAngle::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecAngle::data_atom_hybrid(int nlocal, char **values) { - molecule[nlocal] = ATOTAGINT(values[0]); + molecule[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); num_bond[nlocal] = 0; num_angle[nlocal] = 0; diff --git a/src/MOLECULE/atom_vec_bond.cpp b/src/MOLECULE/atom_vec_bond.cpp index 6f0c63529b..275c424941 100644 --- a/src/MOLECULE/atom_vec_bond.cpp +++ b/src/MOLECULE/atom_vec_bond.cpp @@ -739,8 +739,8 @@ void AtomVecBond::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); - molecule[nlocal] = ATOTAGINT(values[1]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); + molecule[nlocal] = utils::tnumeric(FLERR,values[1],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -767,7 +767,7 @@ void AtomVecBond::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecBond::data_atom_hybrid(int nlocal, char **values) { - molecule[nlocal] = ATOTAGINT(values[0]); + molecule[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); num_bond[nlocal] = 0; diff --git a/src/MOLECULE/atom_vec_full.cpp b/src/MOLECULE/atom_vec_full.cpp index 0cb95254e3..036324cb2c 100644 --- a/src/MOLECULE/atom_vec_full.cpp +++ b/src/MOLECULE/atom_vec_full.cpp @@ -942,8 +942,8 @@ void AtomVecFull::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); - molecule[nlocal] = ATOTAGINT(values[1]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); + molecule[nlocal] = utils::tnumeric(FLERR,values[1],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -975,7 +975,7 @@ void AtomVecFull::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecFull::data_atom_hybrid(int nlocal, char **values) { - molecule[nlocal] = ATOTAGINT(values[0]); + molecule[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); q[nlocal] = utils::numeric(FLERR,values[1],true,lmp); num_bond[nlocal] = 0; diff --git a/src/MOLECULE/atom_vec_molecular.cpp b/src/MOLECULE/atom_vec_molecular.cpp index 28766fa67d..49606f0a69 100644 --- a/src/MOLECULE/atom_vec_molecular.cpp +++ b/src/MOLECULE/atom_vec_molecular.cpp @@ -926,8 +926,8 @@ void AtomVecMolecular::data_atom(double *coord, imageint imagetmp, int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); - molecule[nlocal] = ATOTAGINT(values[1]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); + molecule[nlocal] = utils::tnumeric(FLERR,values[1],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -957,7 +957,7 @@ void AtomVecMolecular::data_atom(double *coord, imageint imagetmp, int AtomVecMolecular::data_atom_hybrid(int nlocal, char **values) { - molecule[nlocal] = ATOTAGINT(values[0]); + molecule[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); num_bond[nlocal] = 0; num_angle[nlocal] = 0; diff --git a/src/MOLECULE/atom_vec_template.cpp b/src/MOLECULE/atom_vec_template.cpp index f7cf5f96db..14e7736b50 100644 --- a/src/MOLECULE/atom_vec_template.cpp +++ b/src/MOLECULE/atom_vec_template.cpp @@ -742,11 +742,11 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); if (tag[nlocal] <= 0) error->one(FLERR,"Invalid atom ID in Atoms section of data file"); - molecule[nlocal] = ATOTAGINT(values[1]); + molecule[nlocal] = utils::tnumeric(FLERR,values[1],true,lmp); molindex[nlocal] = utils::inumeric(FLERR,values[2],true,lmp) - 1; molatom[nlocal] = utils::inumeric(FLERR,values[3],true,lmp) - 1; @@ -781,7 +781,7 @@ void AtomVecTemplate::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecTemplate::data_atom_hybrid(int nlocal, char **values) { - molecule[nlocal] = ATOTAGINT(values[0]); + molecule[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); molindex[nlocal] = utils::inumeric(FLERR,values[1],true,lmp) - 1; molatom[nlocal] = utils::inumeric(FLERR,values[2],true,lmp) - 1; return 3; diff --git a/src/PERI/atom_vec_peri.cpp b/src/PERI/atom_vec_peri.cpp index 25a0b8a933..64ce323a3f 100644 --- a/src/PERI/atom_vec_peri.cpp +++ b/src/PERI/atom_vec_peri.cpp @@ -793,7 +793,7 @@ void AtomVecPeri::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index 63c55759be..5b4173509f 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -813,7 +813,7 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-AWPMD/atom_vec_wavepacket.cpp b/src/USER-AWPMD/atom_vec_wavepacket.cpp index 0edaf7ac02..bffe49e6c5 100644 --- a/src/USER-AWPMD/atom_vec_wavepacket.cpp +++ b/src/USER-AWPMD/atom_vec_wavepacket.cpp @@ -916,7 +916,7 @@ void AtomVecWavepacket::data_atom(double *coord, imageint imagetmp, if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-DPD/atom_vec_dpd.cpp b/src/USER-DPD/atom_vec_dpd.cpp index 2aef55ff9f..de673caec0 100644 --- a/src/USER-DPD/atom_vec_dpd.cpp +++ b/src/USER-DPD/atom_vec_dpd.cpp @@ -815,7 +815,7 @@ void AtomVecDPD::data_atom(double *coord, tagint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-EFF/atom_vec_electron.cpp b/src/USER-EFF/atom_vec_electron.cpp index e62519d223..cf4555f02e 100644 --- a/src/USER-EFF/atom_vec_electron.cpp +++ b/src/USER-EFF/atom_vec_electron.cpp @@ -799,7 +799,7 @@ void AtomVecElectron::data_atom(double *coord, imageint imagetmp, char **values) if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-MESO/atom_vec_edpd.cpp b/src/USER-MESO/atom_vec_edpd.cpp index ff8515abc6..eee8ae25b0 100644 --- a/src/USER-MESO/atom_vec_edpd.cpp +++ b/src/USER-MESO/atom_vec_edpd.cpp @@ -760,7 +760,7 @@ void AtomVecEDPD::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-MESO/atom_vec_mdpd.cpp b/src/USER-MESO/atom_vec_mdpd.cpp index 965891a283..fd3c01f0c6 100644 --- a/src/USER-MESO/atom_vec_mdpd.cpp +++ b/src/USER-MESO/atom_vec_mdpd.cpp @@ -799,7 +799,7 @@ void AtomVecMDPD::data_atom(double *coord, imageint imagetmp, char **values) { int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-MESO/atom_vec_tdpd.cpp b/src/USER-MESO/atom_vec_tdpd.cpp index def0a8ad7b..f91731f8ac 100644 --- a/src/USER-MESO/atom_vec_tdpd.cpp +++ b/src/USER-MESO/atom_vec_tdpd.cpp @@ -792,7 +792,7 @@ void AtomVecTDPD::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/USER-SMD/atom_vec_smd.cpp b/src/USER-SMD/atom_vec_smd.cpp index 278652bf43..9c634be091 100644 --- a/src/USER-SMD/atom_vec_smd.cpp +++ b/src/USER-SMD/atom_vec_smd.cpp @@ -1028,13 +1028,13 @@ void AtomVecSMD::data_atom(double *coord, imageint imagetmp, char **values) { if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR, "Invalid atom type in Atoms section of data file"); - molecule[nlocal] = ATOTAGINT(values[2]); + molecule[nlocal] = utils::tnumeric(FLERR,values[2],true,lmp); if (molecule[nlocal] <= 0) error->one(FLERR, "Invalid molecule in Atoms section of data file"); diff --git a/src/USER-SPH/atom_vec_meso.cpp b/src/USER-SPH/atom_vec_meso.cpp index 0960141ae2..aa3e680c61 100644 --- a/src/USER-SPH/atom_vec_meso.cpp +++ b/src/USER-SPH/atom_vec_meso.cpp @@ -844,7 +844,7 @@ void AtomVecMeso::data_atom(double *coord, imageint imagetmp, char **values) { int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_atomic.cpp b/src/atom_vec_atomic.cpp index 0574db1d8e..af4b4e617d 100644 --- a/src/atom_vec_atomic.cpp +++ b/src/atom_vec_atomic.cpp @@ -613,7 +613,7 @@ void AtomVecAtomic::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_body.cpp b/src/atom_vec_body.cpp index 4b22933881..96cf0ec909 100644 --- a/src/atom_vec_body.cpp +++ b/src/atom_vec_body.cpp @@ -1279,7 +1279,7 @@ void AtomVecBody::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_charge.cpp b/src/atom_vec_charge.cpp index 1a78ba0e2d..fa3c99ca34 100644 --- a/src/atom_vec_charge.cpp +++ b/src/atom_vec_charge.cpp @@ -664,7 +664,7 @@ void AtomVecCharge::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_ellipsoid.cpp b/src/atom_vec_ellipsoid.cpp index 0b94359c55..455e4f192f 100644 --- a/src/atom_vec_ellipsoid.cpp +++ b/src/atom_vec_ellipsoid.cpp @@ -1141,7 +1141,7 @@ void AtomVecEllipsoid::data_atom(double *coord, imageint imagetmp, int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_hybrid.cpp b/src/atom_vec_hybrid.cpp index a7816efbed..18f6fb567d 100644 --- a/src/atom_vec_hybrid.cpp +++ b/src/atom_vec_hybrid.cpp @@ -864,7 +864,7 @@ void AtomVecHybrid::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_line.cpp b/src/atom_vec_line.cpp index 6bffc1b0de..ba59b3d17a 100644 --- a/src/atom_vec_line.cpp +++ b/src/atom_vec_line.cpp @@ -1036,8 +1036,8 @@ void AtomVecLine::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); - molecule[nlocal] = ATOTAGINT(values[1]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); + molecule[nlocal] = utils::tnumeric(FLERR,values[1],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1081,7 +1081,7 @@ void AtomVecLine::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecLine::data_atom_hybrid(int nlocal, char **values) { - molecule[nlocal] = ATOTAGINT(values[0]); + molecule[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); line[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (line[nlocal] == 0) line[nlocal] = -1; diff --git a/src/atom_vec_sphere.cpp b/src/atom_vec_sphere.cpp index b37b853c86..2a77ec418b 100644 --- a/src/atom_vec_sphere.cpp +++ b/src/atom_vec_sphere.cpp @@ -965,7 +965,7 @@ void AtomVecSphere::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); diff --git a/src/atom_vec_tri.cpp b/src/atom_vec_tri.cpp index 4070c6795e..45418b35fd 100644 --- a/src/atom_vec_tri.cpp +++ b/src/atom_vec_tri.cpp @@ -1435,8 +1435,8 @@ void AtomVecTri::data_atom(double *coord, imageint imagetmp, char **values) int nlocal = atom->nlocal; if (nlocal == nmax) grow(0); - tag[nlocal] = ATOTAGINT(values[0]); - molecule[nlocal] = ATOTAGINT(values[1]); + tag[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); + molecule[nlocal] = utils::tnumeric(FLERR,values[1],true,lmp); type[nlocal] = utils::inumeric(FLERR,values[2],true,lmp); if (type[nlocal] <= 0 || type[nlocal] > atom->ntypes) error->one(FLERR,"Invalid atom type in Atoms section of data file"); @@ -1483,7 +1483,7 @@ void AtomVecTri::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecTri::data_atom_hybrid(int nlocal, char **values) { - molecule[nlocal] = ATOTAGINT(values[0]); + molecule[nlocal] = utils::tnumeric(FLERR,values[0],true,lmp); tri[nlocal] = utils::inumeric(FLERR,values[1],true,lmp); if (tri[nlocal] == 0) tri[nlocal] = -1; -- GitLab From 0f691de031b8000f91e451172d72f329c937c428 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 10 Jul 2019 00:50:34 -0400 Subject: [PATCH 221/469] include file cleanup in some more packages --- src/SPIN/fix_setforce_spin.cpp | 1 - src/USER-CGDNA/bond_oxdna_fene.cpp | 1 + src/USER-CGSDK/angle_sdk.cpp | 2 +- src/USER-CGSDK/pair_lj_sdk.cpp | 7 +------ src/USER-CGSDK/pair_lj_sdk_coul_long.cpp | 8 +------- src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp | 9 --------- src/USER-DIFFRACTION/compute_saed.cpp | 3 +-- src/USER-DIFFRACTION/compute_xrd.cpp | 3 +-- src/USER-DIFFRACTION/fix_saed_vtk.cpp | 5 +---- src/USER-DPD/compute_dpd.cpp | 5 +---- src/USER-DPD/compute_dpd_atom.cpp | 8 +------- src/USER-DPD/fix_dpd_energy.cpp | 4 ---- src/USER-DPD/fix_eos_cv.cpp | 2 -- src/USER-DPD/fix_eos_table.cpp | 3 ++- src/USER-DPD/fix_eos_table_rx.cpp | 3 ++- src/USER-DPD/fix_rx.cpp | 4 ++-- src/USER-DPD/fix_shardlow.cpp | 5 +---- src/USER-DPD/nbin_ssa.cpp | 2 -- src/USER-DPD/npair_half_bin_newton_ssa.cpp | 2 -- src/USER-DPD/nstencil_half_bin_2d_newton_ssa.cpp | 2 -- src/USER-DPD/nstencil_half_bin_3d_newton_ssa.cpp | 2 -- src/USER-DPD/pair_dpd_fdt.cpp | 7 ++----- src/USER-DPD/pair_table_rx.cpp | 4 +--- src/USER-DRUDE/compute_temp_drude.cpp | 8 ++------ src/USER-DRUDE/compute_temp_drude.h | 3 +-- src/USER-DRUDE/fix_drude.cpp | 5 +++-- src/USER-DRUDE/fix_drude_transform.cpp | 4 ++-- src/USER-DRUDE/fix_drude_transform.h | 3 +-- src/USER-DRUDE/fix_langevin_drude.cpp | 5 ++--- src/USER-DRUDE/fix_langevin_drude.h | 3 +-- src/USER-DRUDE/pair_lj_cut_thole_long.cpp | 9 +++------ src/USER-DRUDE/pair_lj_cut_thole_long.h | 3 +-- src/USER-DRUDE/pair_thole.cpp | 7 +++---- src/USER-DRUDE/pair_thole.h | 3 +-- src/USER-EFF/compute_temp_eff.cpp | 3 +-- src/USER-FEP/compute_fep.cpp | 3 +-- src/USER-FEP/fix_adapt_fep.cpp | 4 +--- src/USER-FEP/pair_coul_cut_soft.cpp | 5 ++--- src/USER-FEP/pair_coul_long_soft.cpp | 7 ++----- src/USER-FEP/pair_lj_charmm_coul_long_soft.cpp | 6 ++---- src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp | 5 ++--- src/USER-FEP/pair_lj_class2_coul_long_soft.cpp | 5 ++--- src/USER-FEP/pair_lj_class2_soft.cpp | 5 ++--- src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp | 5 ++--- src/USER-FEP/pair_lj_cut_coul_long_soft.cpp | 6 ++---- src/USER-FEP/pair_lj_cut_soft.cpp | 6 ++---- src/USER-FEP/pair_lj_cut_tip4p_long_soft.cpp | 9 ++------- src/USER-FEP/pair_morse_soft.cpp | 5 ++--- src/USER-FEP/pair_tip4p_long_soft.cpp | 9 ++------- src/USER-MESO/fix_mvv_dpd.cpp | 4 +--- src/USER-MESO/fix_tdpd_source.cpp | 11 ++--------- src/USER-MESO/pair_edpd.cpp | 6 ++---- src/USER-MESO/pair_mdpd.cpp | 6 ++---- src/USER-MESO/pair_mdpd_rhosum.cpp | 5 +---- src/USER-MESO/pair_tdpd.cpp | 5 +---- 55 files changed, 75 insertions(+), 190 deletions(-) diff --git a/src/SPIN/fix_setforce_spin.cpp b/src/SPIN/fix_setforce_spin.cpp index 15e5aacfb6..e36a9d260d 100644 --- a/src/SPIN/fix_setforce_spin.cpp +++ b/src/SPIN/fix_setforce_spin.cpp @@ -22,7 +22,6 @@ ------------------------------------------------------------------------- */ #include "fix_setforce_spin.h" -#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/USER-CGDNA/bond_oxdna_fene.cpp b/src/USER-CGDNA/bond_oxdna_fene.cpp index 8314576d63..2f76e67ef4 100644 --- a/src/USER-CGDNA/bond_oxdna_fene.cpp +++ b/src/USER-CGDNA/bond_oxdna_fene.cpp @@ -15,6 +15,7 @@ ------------------------------------------------------------------------- */ #include "bond_oxdna_fene.h" +#include #include #include "atom.h" #include "neighbor.h" diff --git a/src/USER-CGSDK/angle_sdk.cpp b/src/USER-CGSDK/angle_sdk.cpp index 575b0fae69..862c165bbd 100644 --- a/src/USER-CGSDK/angle_sdk.cpp +++ b/src/USER-CGSDK/angle_sdk.cpp @@ -19,8 +19,8 @@ ------------------------------------------------------------------------- */ #include "angle_sdk.h" +#include #include -#include #include "atom.h" #include "neighbor.h" #include "pair.h" diff --git a/src/USER-CGSDK/pair_lj_sdk.cpp b/src/USER-CGSDK/pair_lj_sdk.cpp index b22469566e..6ad77a6183 100644 --- a/src/USER-CGSDK/pair_lj_sdk.cpp +++ b/src/USER-CGSDK/pair_lj_sdk.cpp @@ -17,18 +17,13 @@ ------------------------------------------------------------------------- */ #include "pair_lj_sdk.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp b/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp index 5fba8cde66..62acf00d27 100644 --- a/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp +++ b/src/USER-CGSDK/pair_lj_sdk_coul_long.cpp @@ -17,9 +17,8 @@ ------------------------------------------------------------------------- */ #include "pair_lj_sdk_coul_long.h" +#include #include -#include -#include #include #include "atom.h" #include "comm.h" @@ -27,10 +26,6 @@ #include "kspace.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "math_const.h" #include "memory.h" #include "error.h" @@ -38,7 +33,6 @@ #include "lj_sdk_common.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace LJSDKParms; #define EWALD_F 1.12837917 diff --git a/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp b/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp index b61ed5528f..1095521de3 100644 --- a/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp +++ b/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp @@ -18,26 +18,17 @@ #include "pair_lj_sdk_coul_msm.h" #include -#include -#include #include #include "atom.h" -#include "comm.h" #include "force.h" #include "kspace.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "lj_sdk_common.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace LJSDKParms; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-DIFFRACTION/compute_saed.cpp b/src/USER-DIFFRACTION/compute_saed.cpp index dcafe57ba8..971d9bd380 100644 --- a/src/USER-DIFFRACTION/compute_saed.cpp +++ b/src/USER-DIFFRACTION/compute_saed.cpp @@ -15,13 +15,12 @@ Contributing authors: Shawn Coleman & Douglas Spearot (Arkansas) ------------------------------------------------------------------------- */ +#include "compute_saed.h" #include #include #include -#include #include #include "math_const.h" -#include "compute_saed.h" #include "compute_saed_consts.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-DIFFRACTION/compute_xrd.cpp b/src/USER-DIFFRACTION/compute_xrd.cpp index d6b7549272..f48951f1ff 100644 --- a/src/USER-DIFFRACTION/compute_xrd.cpp +++ b/src/USER-DIFFRACTION/compute_xrd.cpp @@ -16,13 +16,12 @@ Updated: 06/17/2015-2 ------------------------------------------------------------------------- */ +#include "compute_xrd.h" #include #include #include -#include #include #include "math_const.h" -#include "compute_xrd.h" #include "compute_xrd_consts.h" #include "atom.h" #include "comm.h" diff --git a/src/USER-DIFFRACTION/fix_saed_vtk.cpp b/src/USER-DIFFRACTION/fix_saed_vtk.cpp index 4d9af66818..c3a72e494b 100644 --- a/src/USER-DIFFRACTION/fix_saed_vtk.cpp +++ b/src/USER-DIFFRACTION/fix_saed_vtk.cpp @@ -16,17 +16,14 @@ Incorporating SAED: Shawn Coleman (Arkansas) ------------------------------------------------------------------------- */ +#include "fix_saed_vtk.h" #include #include #include -#include "fix_saed_vtk.h" #include "update.h" #include "modify.h" #include "compute.h" #include "compute_saed.h" -#include "group.h" -#include "input.h" -#include "variable.h" #include "memory.h" #include "error.h" #include "force.h" diff --git a/src/USER-DPD/compute_dpd.cpp b/src/USER-DPD/compute_dpd.cpp index 08aa19bcdf..0ef7868164 100644 --- a/src/USER-DPD/compute_dpd.cpp +++ b/src/USER-DPD/compute_dpd.cpp @@ -15,13 +15,10 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ -#include #include "compute_dpd.h" +#include #include "atom.h" #include "update.h" -#include "force.h" -#include "domain.h" -#include "group.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-DPD/compute_dpd_atom.cpp b/src/USER-DPD/compute_dpd_atom.cpp index 78f842a68f..0fd732f669 100644 --- a/src/USER-DPD/compute_dpd_atom.cpp +++ b/src/USER-DPD/compute_dpd_atom.cpp @@ -15,21 +15,15 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ -#include -#include -#include #include "compute_dpd_atom.h" +#include #include "atom.h" #include "update.h" #include "modify.h" -#include "domain.h" -#include "group.h" #include "memory.h" #include "error.h" #include "comm.h" -#include - using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-DPD/fix_dpd_energy.cpp b/src/USER-DPD/fix_dpd_energy.cpp index 5759a164f5..6ee88ea88a 100644 --- a/src/USER-DPD/fix_dpd_energy.cpp +++ b/src/USER-DPD/fix_dpd_energy.cpp @@ -11,14 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "fix_dpd_energy.h" #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" -#include "modify.h" #include "error.h" #include "pair_dpd_fdt_energy.h" diff --git a/src/USER-DPD/fix_eos_cv.cpp b/src/USER-DPD/fix_eos_cv.cpp index 919e6829f3..5b25519a40 100644 --- a/src/USER-DPD/fix_eos_cv.cpp +++ b/src/USER-DPD/fix_eos_cv.cpp @@ -15,8 +15,6 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ -#include -#include #include "fix_eos_cv.h" #include "atom.h" #include "error.h" diff --git a/src/USER-DPD/fix_eos_table.cpp b/src/USER-DPD/fix_eos_table.cpp index 7d701f5fb8..ff9a186c47 100644 --- a/src/USER-DPD/fix_eos_table.cpp +++ b/src/USER-DPD/fix_eos_table.cpp @@ -15,9 +15,10 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ +#include "fix_eos_table.h" +#include #include #include -#include "fix_eos_table.h" #include "atom.h" #include "error.h" #include "force.h" diff --git a/src/USER-DPD/fix_eos_table_rx.cpp b/src/USER-DPD/fix_eos_table_rx.cpp index 779cee0e8b..9f1bd6a3bb 100644 --- a/src/USER-DPD/fix_eos_table_rx.cpp +++ b/src/USER-DPD/fix_eos_table_rx.cpp @@ -15,10 +15,11 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ +#include "fix_eos_table_rx.h" +#include #include #include #include -#include "fix_eos_table_rx.h" #include "atom.h" #include "error.h" #include "force.h" diff --git a/src/USER-DPD/fix_rx.cpp b/src/USER-DPD/fix_rx.cpp index cb8349786f..03e8ae49a4 100644 --- a/src/USER-DPD/fix_rx.cpp +++ b/src/USER-DPD/fix_rx.cpp @@ -11,12 +11,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include "fix_rx.h" +#include #include #include #include #include // DBL_EPSILON -#include "fix_rx.h" #include "atom.h" #include "error.h" #include "group.h" diff --git a/src/USER-DPD/fix_shardlow.cpp b/src/USER-DPD/fix_shardlow.cpp index 4e133480ad..f181436f91 100644 --- a/src/USER-DPD/fix_shardlow.cpp +++ b/src/USER-DPD/fix_shardlow.cpp @@ -33,15 +33,13 @@ 135, 204105. ------------------------------------------------------------------------- */ -#include +#include "fix_shardlow.h" #include #include #include -#include "fix_shardlow.h" #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" #include "atom_vec.h" #include "comm.h" @@ -53,7 +51,6 @@ #include "modify.h" #include "pair_dpd_fdt.h" #include "pair_dpd_fdt_energy.h" -#include "pair.h" #include "npair_half_bin_newton_ssa.h" #include "citeme.h" diff --git a/src/USER-DPD/nbin_ssa.cpp b/src/USER-DPD/nbin_ssa.cpp index dcd434cb4a..e3fa71aedf 100644 --- a/src/USER-DPD/nbin_ssa.cpp +++ b/src/USER-DPD/nbin_ssa.cpp @@ -21,8 +21,6 @@ #include "update.h" #include "group.h" #include "domain.h" -#include "memory.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-DPD/npair_half_bin_newton_ssa.cpp b/src/USER-DPD/npair_half_bin_newton_ssa.cpp index ba90ebc465..2139173d47 100644 --- a/src/USER-DPD/npair_half_bin_newton_ssa.cpp +++ b/src/USER-DPD/npair_half_bin_newton_ssa.cpp @@ -17,7 +17,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_bin_newton_ssa.h" -#include "neighbor.h" #include "nstencil_ssa.h" #include "nbin_ssa.h" #include "neigh_list.h" @@ -25,7 +24,6 @@ #include "atom_vec.h" #include "molecule.h" #include "domain.h" -#include "group.h" #include "memory.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-DPD/nstencil_half_bin_2d_newton_ssa.cpp b/src/USER-DPD/nstencil_half_bin_2d_newton_ssa.cpp index 451381c104..9953fca62c 100644 --- a/src/USER-DPD/nstencil_half_bin_2d_newton_ssa.cpp +++ b/src/USER-DPD/nstencil_half_bin_2d_newton_ssa.cpp @@ -17,8 +17,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_2d_newton_ssa.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/USER-DPD/nstencil_half_bin_3d_newton_ssa.cpp b/src/USER-DPD/nstencil_half_bin_3d_newton_ssa.cpp index cdd3b8856f..4dd3c4a5fe 100644 --- a/src/USER-DPD/nstencil_half_bin_3d_newton_ssa.cpp +++ b/src/USER-DPD/nstencil_half_bin_3d_newton_ssa.cpp @@ -17,8 +17,6 @@ ------------------------------------------------------------------------- */ #include "nstencil_half_bin_3d_newton_ssa.h" -#include "neighbor.h" -#include "neigh_list.h" using namespace LAMMPS_NS; diff --git a/src/USER-DPD/pair_dpd_fdt.cpp b/src/USER-DPD/pair_dpd_fdt.cpp index 07ef8190f0..1cb9d68d06 100644 --- a/src/USER-DPD/pair_dpd_fdt.cpp +++ b/src/USER-DPD/pair_dpd_fdt.cpp @@ -15,23 +15,20 @@ Contributing author: James Larentzos (U.S. Army Research Laboratory) ------------------------------------------------------------------------- */ +#include "pair_dpd_fdt.h" +#include #include -#include -#include #include #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "update.h" #include "fix.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "random_mars.h" #include "memory.h" #include "modify.h" -#include "pair_dpd_fdt.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-DPD/pair_table_rx.cpp b/src/USER-DPD/pair_table_rx.cpp index f2d0d7b1fb..e767f93367 100644 --- a/src/USER-DPD/pair_table_rx.cpp +++ b/src/USER-DPD/pair_table_rx.cpp @@ -15,14 +15,12 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_table_rx.h" #include #include -#include #include -#include "pair_table_rx.h" #include "atom.h" #include "force.h" -#include "comm.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/USER-DRUDE/compute_temp_drude.cpp b/src/USER-DRUDE/compute_temp_drude.cpp index 4830e950d0..a12c248680 100644 --- a/src/USER-DRUDE/compute_temp_drude.cpp +++ b/src/USER-DRUDE/compute_temp_drude.cpp @@ -11,19 +11,15 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_temp_drude.h" #include -#include #include -#include "compute_temp_drude.h" #include "atom.h" #include "update.h" #include "force.h" -#include "group.h" #include "modify.h" -#include "fix.h" +#include "fix_drude.h" #include "domain.h" -#include "lattice.h" -#include "memory.h" #include "error.h" #include "comm.h" diff --git a/src/USER-DRUDE/compute_temp_drude.h b/src/USER-DRUDE/compute_temp_drude.h index 88d767f8b7..530c84ce3d 100644 --- a/src/USER-DRUDE/compute_temp_drude.h +++ b/src/USER-DRUDE/compute_temp_drude.h @@ -21,7 +21,6 @@ ComputeStyle(temp/drude,ComputeTempDrude) #define LMP_COMPUTE_TEMP_DRUDE_H #include "compute.h" -#include "fix_drude.h" namespace LAMMPS_NS { @@ -37,7 +36,7 @@ class ComputeTempDrude : public Compute { private: int fix_dof; - FixDrude * fix_drude; + class FixDrude * fix_drude; char *id_temp; class Compute *temperature; bigint dof_core, dof_drude; diff --git a/src/USER-DRUDE/fix_drude.cpp b/src/USER-DRUDE/fix_drude.cpp index 7800efe7ff..080408459c 100644 --- a/src/USER-DRUDE/fix_drude.cpp +++ b/src/USER-DRUDE/fix_drude.cpp @@ -11,9 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "fix_drude.h" +#include +#include +#include #include "atom.h" #include "comm.h" #include "modify.h" diff --git a/src/USER-DRUDE/fix_drude_transform.cpp b/src/USER-DRUDE/fix_drude_transform.cpp index 34742a0683..8e85f1dffd 100644 --- a/src/USER-DRUDE/fix_drude_transform.cpp +++ b/src/USER-DRUDE/fix_drude_transform.cpp @@ -12,15 +12,15 @@ ------------------------------------------------------------------------- */ /** Fix Drude Transform ******************************************************/ +#include "fix_drude_transform.h" #include #include -#include "fix_drude_transform.h" +#include "fix_drude.h" #include "atom.h" #include "domain.h" #include "comm.h" #include "error.h" #include "modify.h" -#include "force.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-DRUDE/fix_drude_transform.h b/src/USER-DRUDE/fix_drude_transform.h index 41f4e147ed..b74a500c95 100644 --- a/src/USER-DRUDE/fix_drude_transform.h +++ b/src/USER-DRUDE/fix_drude_transform.h @@ -22,7 +22,6 @@ FixStyle(drude/transform/inverse,FixDrudeTransform) #define LMP_FIX_DRUDE_TRANSFORM_H #include "fix.h" -#include "fix_drude.h" namespace LAMMPS_NS { @@ -42,7 +41,7 @@ class FixDrudeTransform : public Fix { void unpack_forward_comm(int n, int first, double *buf); protected: double * mcoeff; - FixDrude * fix_drude; + class FixDrude * fix_drude; }; } diff --git a/src/USER-DRUDE/fix_langevin_drude.cpp b/src/USER-DRUDE/fix_langevin_drude.cpp index b9d1139f83..1a16c3df96 100644 --- a/src/USER-DRUDE/fix_langevin_drude.cpp +++ b/src/USER-DRUDE/fix_langevin_drude.cpp @@ -11,17 +11,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_langevin_drude.h" #include -#include #include -#include "fix_langevin_drude.h" +#include "fix_drude.h" #include "atom.h" #include "force.h" #include "comm.h" #include "input.h" #include "variable.h" #include "random_mars.h" -#include "group.h" #include "update.h" #include "modify.h" #include "compute.h" diff --git a/src/USER-DRUDE/fix_langevin_drude.h b/src/USER-DRUDE/fix_langevin_drude.h index d65440582c..9437883ba3 100644 --- a/src/USER-DRUDE/fix_langevin_drude.h +++ b/src/USER-DRUDE/fix_langevin_drude.h @@ -21,7 +21,6 @@ FixStyle(langevin/drude,FixLangevinDrude) #define LMP_FIX_LANGEVIN_DRUDE_H #include "fix.h" -#include "fix_drude.h" namespace LAMMPS_NS { @@ -51,7 +50,7 @@ class FixLangevinDrude : public Fix { class RanMars *random_core, *random_drude; int zero; bigint ncore; - FixDrude * fix_drude; + class FixDrude * fix_drude; class Compute *temperature; char *id_temp; }; diff --git a/src/USER-DRUDE/pair_lj_cut_thole_long.cpp b/src/USER-DRUDE/pair_lj_cut_thole_long.cpp index 1ebe4a4c2d..851effd89c 100644 --- a/src/USER-DRUDE/pair_lj_cut_thole_long.cpp +++ b/src/USER-DRUDE/pair_lj_cut_thole_long.cpp @@ -15,20 +15,17 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_thole_long.h" +#include #include -#include -#include #include -#include "pair_lj_cut_thole_long.h" +#include "fix_drude.h" #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" -#include "update.h" -#include "integrate.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/USER-DRUDE/pair_lj_cut_thole_long.h b/src/USER-DRUDE/pair_lj_cut_thole_long.h index 27a917c737..4c3a883064 100644 --- a/src/USER-DRUDE/pair_lj_cut_thole_long.h +++ b/src/USER-DRUDE/pair_lj_cut_thole_long.h @@ -21,7 +21,6 @@ PairStyle(lj/cut/thole/long,PairLJCutTholeLong) #define LMP_PAIR_LJ_CUT_THOLE_LONG_H #include "pair.h" -#include "fix_drude.h" namespace LAMMPS_NS { @@ -58,7 +57,7 @@ class PairLJCutTholeLong : public Pair { double cut_global; double **cut,**scale; double **polar,**thole,**ascreen; - FixDrude *fix_drude; + class FixDrude *fix_drude; virtual void allocate(); }; diff --git a/src/USER-DRUDE/pair_thole.cpp b/src/USER-DRUDE/pair_thole.cpp index 1bb75af825..1f81263e95 100644 --- a/src/USER-DRUDE/pair_thole.cpp +++ b/src/USER-DRUDE/pair_thole.cpp @@ -11,11 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_thole.h" +#include #include -#include -#include #include -#include "pair_thole.h" #include "atom.h" #include "comm.h" #include "force.h" @@ -24,7 +23,7 @@ #include "memory.h" #include "error.h" #include "fix.h" -#include "fix_store.h" +#include "fix_drude.h" #include "domain.h" #include "modify.h" diff --git a/src/USER-DRUDE/pair_thole.h b/src/USER-DRUDE/pair_thole.h index 2c462b431a..88c00b6d20 100644 --- a/src/USER-DRUDE/pair_thole.h +++ b/src/USER-DRUDE/pair_thole.h @@ -21,7 +21,6 @@ PairStyle(thole,PairThole) #define LMP_PAIR_THOLE_H #include "pair.h" -#include "fix_drude.h" namespace LAMMPS_NS { @@ -46,7 +45,7 @@ class PairThole : public Pair { double cut_global; double **cut,**scale; double **polar,**thole,**ascreen; - FixDrude * fix_drude; + class FixDrude * fix_drude; virtual void allocate(); }; diff --git a/src/USER-EFF/compute_temp_eff.cpp b/src/USER-EFF/compute_temp_eff.cpp index d745269ff5..8e07e390fa 100644 --- a/src/USER-EFF/compute_temp_eff.cpp +++ b/src/USER-EFF/compute_temp_eff.cpp @@ -15,9 +15,8 @@ Contributing author: Andres Jaramillo-Botero (Caltech) ------------------------------------------------------------------------- */ -#include -#include #include "compute_temp_eff.h" +#include #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/USER-FEP/compute_fep.cpp b/src/USER-FEP/compute_fep.cpp index dc0b71e71b..1853828db3 100644 --- a/src/USER-FEP/compute_fep.cpp +++ b/src/USER-FEP/compute_fep.cpp @@ -15,7 +15,7 @@ Contributing author: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ -#include +#include "compute_fep.h" #include #include #include @@ -34,7 +34,6 @@ #include "timer.h" #include "memory.h" #include "error.h" -#include "compute_fep.h" using namespace LAMMPS_NS; diff --git a/src/USER-FEP/fix_adapt_fep.cpp b/src/USER-FEP/fix_adapt_fep.cpp index 7304bc4ef6..46cf32cf0b 100644 --- a/src/USER-FEP/fix_adapt_fep.cpp +++ b/src/USER-FEP/fix_adapt_fep.cpp @@ -15,10 +15,8 @@ Charges by type and after option: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ -#include -#include -#include #include "fix_adapt_fep.h" +#include #include "atom.h" #include "update.h" #include "group.h" diff --git a/src/USER-FEP/pair_coul_cut_soft.cpp b/src/USER-FEP/pair_coul_cut_soft.cpp index 86a6d02819..a4ff3ca846 100644 --- a/src/USER-FEP/pair_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_coul_cut_soft.cpp @@ -15,11 +15,10 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_coul_cut_soft.h" +#include #include -#include -#include #include -#include "pair_coul_cut_soft.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-FEP/pair_coul_long_soft.cpp b/src/USER-FEP/pair_coul_long_soft.cpp index 9d3ffc0da1..c0030f8935 100644 --- a/src/USER-FEP/pair_coul_long_soft.cpp +++ b/src/USER-FEP/pair_coul_long_soft.cpp @@ -16,19 +16,16 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_coul_long_soft.h" +#include #include -#include -#include #include -#include "pair_coul_long_soft.h" #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "neighbor.h" #include "neigh_list.h" -#include "update.h" -#include "integrate.h" #include "memory.h" #include "error.h" diff --git a/src/USER-FEP/pair_lj_charmm_coul_long_soft.cpp b/src/USER-FEP/pair_lj_charmm_coul_long_soft.cpp index ac6f1e6384..4c3be6addb 100644 --- a/src/USER-FEP/pair_lj_charmm_coul_long_soft.cpp +++ b/src/USER-FEP/pair_lj_charmm_coul_long_soft.cpp @@ -16,17 +16,15 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_lj_charmm_coul_long_soft.h" +#include #include -#include -#include #include -#include "pair_lj_charmm_coul_long_soft.h" #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp b/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp index ae79515488..bbe67e4ff3 100644 --- a/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp @@ -11,11 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2_coul_cut_soft.h" +#include #include -#include -#include #include -#include "pair_lj_class2_coul_cut_soft.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-FEP/pair_lj_class2_coul_long_soft.cpp b/src/USER-FEP/pair_lj_class2_coul_long_soft.cpp index 275486d1e2..a3e0f732a2 100644 --- a/src/USER-FEP/pair_lj_class2_coul_long_soft.cpp +++ b/src/USER-FEP/pair_lj_class2_coul_long_soft.cpp @@ -11,11 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2_coul_long_soft.h" +#include #include -#include -#include #include -#include "pair_lj_class2_coul_long_soft.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-FEP/pair_lj_class2_soft.cpp b/src/USER-FEP/pair_lj_class2_soft.cpp index d22cd53883..d98a5db5f3 100644 --- a/src/USER-FEP/pair_lj_class2_soft.cpp +++ b/src/USER-FEP/pair_lj_class2_soft.cpp @@ -11,11 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_lj_class2_soft.h" +#include #include -#include -#include #include -#include "pair_lj_class2_soft.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp b/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp index 35c9162dbc..38fcb6fc07 100644 --- a/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp @@ -15,11 +15,10 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_cut_soft.h" +#include #include -#include -#include #include -#include "pair_lj_cut_coul_cut_soft.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-FEP/pair_lj_cut_coul_long_soft.cpp b/src/USER-FEP/pair_lj_cut_coul_long_soft.cpp index 79253d2b9c..740daabf62 100644 --- a/src/USER-FEP/pair_lj_cut_coul_long_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_coul_long_soft.cpp @@ -16,17 +16,15 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_coul_long_soft.h" +#include #include -#include -#include #include -#include "pair_lj_cut_coul_long_soft.h" #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-FEP/pair_lj_cut_soft.cpp b/src/USER-FEP/pair_lj_cut_soft.cpp index 4192d6546b..5e9a77877e 100644 --- a/src/USER-FEP/pair_lj_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_soft.cpp @@ -16,11 +16,10 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_soft.h" +#include #include -#include -#include #include -#include "pair_lj_cut_soft.h" #include "atom.h" #include "comm.h" #include "force.h" @@ -28,7 +27,6 @@ #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory.h" diff --git a/src/USER-FEP/pair_lj_cut_tip4p_long_soft.cpp b/src/USER-FEP/pair_lj_cut_tip4p_long_soft.cpp index 8ac28f9fa9..d4f6dcb910 100644 --- a/src/USER-FEP/pair_lj_cut_tip4p_long_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_tip4p_long_soft.cpp @@ -17,23 +17,18 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_tip4p_long_soft.h" +#include #include -#include -#include #include -#include "pair_lj_cut_tip4p_long_soft.h" #include "angle.h" #include "atom.h" #include "bond.h" #include "comm.h" #include "domain.h" #include "force.h" -#include "kspace.h" -#include "update.h" -#include "respa.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" diff --git a/src/USER-FEP/pair_morse_soft.cpp b/src/USER-FEP/pair_morse_soft.cpp index 21f616a082..2803e7df49 100644 --- a/src/USER-FEP/pair_morse_soft.cpp +++ b/src/USER-FEP/pair_morse_soft.cpp @@ -11,11 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_morse_soft.h" +#include #include -#include -#include #include -#include "pair_morse_soft.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-FEP/pair_tip4p_long_soft.cpp b/src/USER-FEP/pair_tip4p_long_soft.cpp index 9b6a6841fe..9cea5b54c5 100644 --- a/src/USER-FEP/pair_tip4p_long_soft.cpp +++ b/src/USER-FEP/pair_tip4p_long_soft.cpp @@ -17,23 +17,18 @@ Soft-core version: Agilio Padua (Univ Blaise Pascal & CNRS) ------------------------------------------------------------------------- */ +#include "pair_tip4p_long_soft.h" +#include #include -#include -#include #include -#include "pair_tip4p_long_soft.h" #include "angle.h" #include "atom.h" #include "bond.h" #include "comm.h" #include "domain.h" #include "force.h" -#include "kspace.h" -#include "update.h" -#include "respa.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MESO/fix_mvv_dpd.cpp b/src/USER-MESO/fix_mvv_dpd.cpp index f663165f78..116bbf506a 100644 --- a/src/USER-MESO/fix_mvv_dpd.cpp +++ b/src/USER-MESO/fix_mvv_dpd.cpp @@ -20,13 +20,11 @@ Email: zhen_li@brown.edu ------------------------------------------------------------------------- */ -#include -#include #include "fix_mvv_dpd.h" +#include #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-MESO/fix_tdpd_source.cpp b/src/USER-MESO/fix_tdpd_source.cpp index 89e8005b43..990f6a5b78 100644 --- a/src/USER-MESO/fix_tdpd_source.cpp +++ b/src/USER-MESO/fix_tdpd_source.cpp @@ -11,17 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "fix_tdpd_source.h" +#include +#include #include "atom.h" -#include "comm.h" -#include "update.h" -#include "modify.h" -#include "domain.h" -#include "lattice.h" -#include "input.h" -#include "variable.h" #include "error.h" #include "force.h" diff --git a/src/USER-MESO/pair_edpd.cpp b/src/USER-MESO/pair_edpd.cpp index e428b02822..f72b6d6b93 100644 --- a/src/USER-MESO/pair_edpd.cpp +++ b/src/USER-MESO/pair_edpd.cpp @@ -16,14 +16,12 @@ Email: zhen_li@brown.edu ------------------------------------------------------------------------- */ +#include "pair_edpd.h" +#include #include -#include -#include #include #include -#include "pair_edpd.h" #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "update.h" #include "force.h" diff --git a/src/USER-MESO/pair_mdpd.cpp b/src/USER-MESO/pair_mdpd.cpp index 4102499d46..56adad26ce 100644 --- a/src/USER-MESO/pair_mdpd.cpp +++ b/src/USER-MESO/pair_mdpd.cpp @@ -16,13 +16,11 @@ Email: zhen_li@brown.edu ------------------------------------------------------------------------- */ +#include "pair_mdpd.h" +#include #include -#include -#include #include -#include "pair_mdpd.h" #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "update.h" #include "force.h" diff --git a/src/USER-MESO/pair_mdpd_rhosum.cpp b/src/USER-MESO/pair_mdpd_rhosum.cpp index 2fd238088c..05cb123f61 100644 --- a/src/USER-MESO/pair_mdpd_rhosum.cpp +++ b/src/USER-MESO/pair_mdpd_rhosum.cpp @@ -19,9 +19,8 @@ Contributing author: Zhen Li (Brown University) ------------------------------------------------------------------------- */ -#include -#include #include "pair_mdpd_rhosum.h" +#include #include "atom.h" #include "force.h" #include "comm.h" @@ -30,8 +29,6 @@ #include "memory.h" #include "error.h" #include "neighbor.h" -#include "update.h" -#include "domain.h" using namespace LAMMPS_NS; diff --git a/src/USER-MESO/pair_tdpd.cpp b/src/USER-MESO/pair_tdpd.cpp index 7df9d6d163..346401b1ba 100644 --- a/src/USER-MESO/pair_tdpd.cpp +++ b/src/USER-MESO/pair_tdpd.cpp @@ -16,13 +16,10 @@ Email: zhen_li@brown.edu ------------------------------------------------------------------------- */ +#include "pair_tdpd.h" #include -#include -#include #include -#include "pair_tdpd.h" #include "atom.h" -#include "atom_vec.h" #include "comm.h" #include "update.h" #include "force.h" -- GitLab From 872d43f02f8e9cc274344baba158366106c338c0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 10 Jul 2019 07:29:29 -0400 Subject: [PATCH 222/469] recover compilation of USER-OMP package --- src/USER-OMP/pair_lj_cut_thole_long_omp.cpp | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp b/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp index 85cab4fe7b..d0db6262b1 100644 --- a/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp +++ b/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp @@ -15,13 +15,14 @@ Contributing author: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "pair_lj_cut_thole_long_omp.h" #include #include #include #include -#include "pair_lj_cut_thole_long_omp.h" #include "atom.h" #include "comm.h" +#include "fix_drude.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" -- GitLab From c5044d648463ae307bcbd1aa90565077489442df Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 10 Jul 2019 08:49:16 -0400 Subject: [PATCH 223/469] continuing include file handling cleanup --- src/USER-MANIFOLD/fix_manifoldforce.cpp | 5 +- src/USER-MANIFOLD/fix_manifoldforce.h | 2 +- src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp | 10 +- src/USER-MANIFOLD/fix_nve_manifold_rattle.h | 6 +- src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp | 9 +- src/USER-MANIFOLD/manifold_factory.h | 11 +- src/USER-MANIFOLD/manifold_thylakoid.cpp | 2 +- src/USER-MANIFOLD/manifold_thylakoid.h | 4 +- src/USER-MEAMC/meam.h | 2 +- src/USER-MEAMC/meam_dens_final.cpp | 1 - src/USER-MEAMC/meam_dens_init.cpp | 2 + src/USER-MEAMC/meam_force.cpp | 3 +- src/USER-MEAMC/meam_impl.cpp | 1 + src/USER-MEAMC/meam_setup_done.cpp | 6 +- src/USER-MEAMC/pair_meamc.cpp | 6 +- src/USER-MEAMC/pair_meamc.h | 1 - src/USER-MGPT/mgpt_linalg.cpp | 2 - src/USER-MGPT/mgpt_readpot.h | 4 +- src/USER-MGPT/pair_mgpt.cpp | 5 +- src/USER-MGPT/pair_mgpt.h | 381 +++++++++--------- src/USER-MISC/angle_cosine_shift.cpp | 4 +- src/USER-MISC/angle_cosine_shift_exp.cpp | 4 +- src/USER-MISC/angle_dipole.cpp | 4 +- src/USER-MISC/angle_fourier.cpp | 4 +- src/USER-MISC/angle_fourier_simple.cpp | 4 +- src/USER-MISC/angle_quartic.cpp | 4 +- src/USER-MISC/bond_harmonic_shift.cpp | 5 +- src/USER-MISC/bond_harmonic_shift_cut.cpp | 5 +- src/USER-MISC/compute_cnp_atom.cpp | 5 +- src/USER-MISC/compute_entropy_atom.cpp | 5 +- src/USER-MISC/compute_pressure_cylinder.cpp | 6 +- src/USER-MISC/compute_pressure_grem.cpp | 6 +- src/USER-MISC/compute_stress_mop.cpp | 6 +- src/USER-MISC/compute_stress_mop_profile.cpp | 6 +- src/USER-MISC/compute_temp_rotate.cpp | 5 +- src/USER-MISC/dihedral_cosine_shift_exp.cpp | 4 +- src/USER-MISC/dihedral_fourier.cpp | 5 +- src/USER-MISC/dihedral_nharmonic.cpp | 5 +- src/USER-MISC/dihedral_quadratic.cpp | 5 +- src/USER-MISC/dihedral_spherical.cpp | 5 +- src/USER-MISC/dihedral_table.cpp | 9 +- src/USER-MISC/dihedral_table_cut.cpp | 14 +- src/USER-MISC/fix_addtorque.cpp | 5 +- src/USER-MISC/fix_ave_correlate_long.cpp | 3 +- src/USER-MISC/fix_bond_react.cpp | 3 +- src/USER-MISC/fix_electron_stopping.cpp | 4 +- src/USER-MISC/fix_ffl.cpp | 14 +- src/USER-MISC/fix_filter_corotate.cpp | 17 +- src/USER-MISC/fix_flow_gauss.cpp | 5 +- src/USER-MISC/fix_gle.cpp | 11 +- src/USER-MISC/fix_grem.cpp | 7 +- src/USER-MISC/fix_ipi.cpp | 7 +- src/USER-MISC/fix_nvk.cpp | 6 +- src/USER-MISC/fix_pimd.cpp | 3 +- src/USER-MISC/fix_rhok.cpp | 5 +- src/USER-MISC/fix_smd.cpp | 4 +- src/USER-MISC/fix_srp.cpp | 9 +- src/USER-MISC/fix_ti_spring.cpp | 4 +- src/USER-MISC/fix_ttm_mod.cpp | 5 +- src/USER-MISC/fix_wall_ees.cpp | 10 +- src/USER-MISC/fix_wall_region_ees.cpp | 7 +- 61 files changed, 302 insertions(+), 410 deletions(-) diff --git a/src/USER-MANIFOLD/fix_manifoldforce.cpp b/src/USER-MANIFOLD/fix_manifoldforce.cpp index 00293bfec7..74a9a1833f 100644 --- a/src/USER-MANIFOLD/fix_manifoldforce.cpp +++ b/src/USER-MANIFOLD/fix_manifoldforce.cpp @@ -11,9 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include "fix_manifoldforce.h" // For stuff +#include #include -#include #include "atom.h" #include "update.h" #include "respa.h" @@ -21,7 +21,6 @@ #include "force.h" #include "manifold.h" -#include "fix_manifoldforce.h" // For stuff #include "manifold_factory.h" // For constructing manifold diff --git a/src/USER-MANIFOLD/fix_manifoldforce.h b/src/USER-MANIFOLD/fix_manifoldforce.h index 527bee3f86..1d5afc7afc 100644 --- a/src/USER-MANIFOLD/fix_manifoldforce.h +++ b/src/USER-MANIFOLD/fix_manifoldforce.h @@ -43,9 +43,9 @@ FixStyle(manifoldforce,FixManifoldForce) #define LMP_FIX_MANIFOLDFORCE_H #include "fix.h" -#include "manifold.h" namespace LAMMPS_NS { +namespace user_manifold { class manifold; } class FixManifoldForce : public Fix { public: diff --git a/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp b/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp index de134e32ed..7f8d9d5675 100644 --- a/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp +++ b/src/USER-MANIFOLD/fix_nve_manifold_rattle.cpp @@ -32,24 +32,18 @@ ------------------------------------------------------------------------- */ -#include -#include +#include "fix_nve_manifold_rattle.h" +#include #include #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" -#include "group.h" -#include #include "input.h" #include "variable.h" #include "citeme.h" -#include "memory.h" #include "comm.h" - -#include "fix_nve_manifold_rattle.h" #include "manifold_factory.h" #include "manifold.h" diff --git a/src/USER-MANIFOLD/fix_nve_manifold_rattle.h b/src/USER-MANIFOLD/fix_nve_manifold_rattle.h index 2bc821ab04..581ecf36d3 100644 --- a/src/USER-MANIFOLD/fix_nve_manifold_rattle.h +++ b/src/USER-MANIFOLD/fix_nve_manifold_rattle.h @@ -42,12 +42,10 @@ FixStyle(nve/manifold/rattle,FixNVEManifoldRattle) #define LMP_FIX_NVE_MANIFOLD_RATTLE_H #include "fix.h" -#include "manifold.h" - namespace LAMMPS_NS { -// namespace user_manifold { +namespace user_manifold { class manifold; } class FixNVEManifoldRattle : public Fix { public: @@ -98,9 +96,7 @@ namespace LAMMPS_NS { user_manifold::manifold *ptr_m; - void print_stats( const char * ); - int was_var( const char * ); virtual void update_var_params(); diff --git a/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp b/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp index a4eed66336..2789f8738a 100644 --- a/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp +++ b/src/USER-MANIFOLD/fix_nvt_manifold_rattle.cpp @@ -32,25 +32,18 @@ ------------------------------------------------------------------------- */ -#include -#include +#include "fix_nvt_manifold_rattle.h" #include #include #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" #include "group.h" -#include "input.h" -#include "variable.h" #include "citeme.h" -#include "memory.h" -#include "comm.h" #include "modify.h" #include "compute.h" -#include "fix_nvt_manifold_rattle.h" #include "manifold.h" diff --git a/src/USER-MANIFOLD/manifold_factory.h b/src/USER-MANIFOLD/manifold_factory.h index cc3e1245bf..ac2aee8a26 100644 --- a/src/USER-MANIFOLD/manifold_factory.h +++ b/src/USER-MANIFOLD/manifold_factory.h @@ -35,8 +35,7 @@ #ifndef LMP_MANIFOLD_FACTORY_H #define LMP_MANIFOLD_FACTORY_H - -#include "manifold.h" +#include #include /* @@ -79,14 +78,16 @@ static FILE *screen = fopen("/dev/stdout","w"); #define FLERR __FILE__,__LINE__ // Equivalent to definition in pointers.h #endif // USE_PHONY_LAMMPS - - /* Here the actual implementation of LAMMPS-related functions begins. */ namespace LAMMPS_NS { +class LAMMPS; namespace user_manifold { +// forward declaration +class manifold; + // Templated, so needs to be in header. template void make_manifold_if( manifold **man_ptr, const char *name, @@ -103,8 +104,6 @@ namespace user_manifold { int , char ** ); } // namespace user_manifold - } // namespace LAMMPS_NS - #endif // LMP_MANIFOLD_FACTORY_H diff --git a/src/USER-MANIFOLD/manifold_thylakoid.cpp b/src/USER-MANIFOLD/manifold_thylakoid.cpp index 530e0a876d..e4ef039832 100644 --- a/src/USER-MANIFOLD/manifold_thylakoid.cpp +++ b/src/USER-MANIFOLD/manifold_thylakoid.cpp @@ -1,6 +1,6 @@ #include "manifold_thylakoid.h" #include - +#include "manifold_thylakoid_shared.h" #include "comm.h" #include "domain.h" // For some checks regarding the simulation box. #include "error.h" diff --git a/src/USER-MANIFOLD/manifold_thylakoid.h b/src/USER-MANIFOLD/manifold_thylakoid.h index d8ebe2e94f..35ad4dfd9c 100644 --- a/src/USER-MANIFOLD/manifold_thylakoid.h +++ b/src/USER-MANIFOLD/manifold_thylakoid.h @@ -4,12 +4,10 @@ #include "manifold.h" #include -#include "manifold_thylakoid_shared.h" - namespace LAMMPS_NS { namespace user_manifold { - + struct thyla_part; class manifold_thylakoid : public manifold { public: diff --git a/src/USER-MEAMC/meam.h b/src/USER-MEAMC/meam.h index 74b1eb0e54..da55805790 100644 --- a/src/USER-MEAMC/meam.h +++ b/src/USER-MEAMC/meam.h @@ -1,12 +1,12 @@ #ifndef LMP_MEAM_H #define LMP_MEAM_H -#include "memory.h" #include #define maxelt 5 namespace LAMMPS_NS { +class Memory; typedef enum { FCC, BCC, HCP, DIM, DIA, B1, C11, L12, B2 } lattice_t; diff --git a/src/USER-MEAMC/meam_dens_final.cpp b/src/USER-MEAMC/meam_dens_final.cpp index c55b1b45c4..867106df88 100644 --- a/src/USER-MEAMC/meam_dens_final.cpp +++ b/src/USER-MEAMC/meam_dens_final.cpp @@ -1,5 +1,4 @@ #include "meam.h" -#include "math_special.h" using namespace LAMMPS_NS; diff --git a/src/USER-MEAMC/meam_dens_init.cpp b/src/USER-MEAMC/meam_dens_init.cpp index 3bb9328142..155941422c 100644 --- a/src/USER-MEAMC/meam_dens_init.cpp +++ b/src/USER-MEAMC/meam_dens_init.cpp @@ -1,4 +1,6 @@ #include "meam.h" +#include +#include "memory.h" #include "math_special.h" using namespace LAMMPS_NS; diff --git a/src/USER-MEAMC/meam_force.cpp b/src/USER-MEAMC/meam_force.cpp index 06fbb57adb..09aad90111 100644 --- a/src/USER-MEAMC/meam_force.cpp +++ b/src/USER-MEAMC/meam_force.cpp @@ -1,6 +1,7 @@ #include "meam.h" -#include "math_special.h" +#include #include +#include "math_special.h" using namespace LAMMPS_NS; diff --git a/src/USER-MEAMC/meam_impl.cpp b/src/USER-MEAMC/meam_impl.cpp index b099ead8d5..3b40a2b612 100644 --- a/src/USER-MEAMC/meam_impl.cpp +++ b/src/USER-MEAMC/meam_impl.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "meam.h" +#include #include "memory.h" using namespace LAMMPS_NS; diff --git a/src/USER-MEAMC/meam_setup_done.cpp b/src/USER-MEAMC/meam_setup_done.cpp index 2a762d1204..7000eac6ae 100644 --- a/src/USER-MEAMC/meam_setup_done.cpp +++ b/src/USER-MEAMC/meam_setup_done.cpp @@ -1,6 +1,10 @@ #include "meam.h" -#include "math_special.h" +#include +#include #include +#include "math_special.h" +#include "memory.h" + using namespace LAMMPS_NS; void diff --git a/src/USER-MEAMC/pair_meamc.cpp b/src/USER-MEAMC/pair_meamc.cpp index 7c96fadb44..a9034a1af3 100644 --- a/src/USER-MEAMC/pair_meamc.cpp +++ b/src/USER-MEAMC/pair_meamc.cpp @@ -15,16 +15,14 @@ Contributing author: Greg Wagner (SNL) ------------------------------------------------------------------------- */ -#include -#include +#include "pair_meamc.h" +#include #include #include #include "meam.h" -#include "pair_meamc.h" #include "atom.h" #include "force.h" #include "comm.h" -#include "memory.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/USER-MEAMC/pair_meamc.h b/src/USER-MEAMC/pair_meamc.h index a006e70bdb..31dd8ba022 100644 --- a/src/USER-MEAMC/pair_meamc.h +++ b/src/USER-MEAMC/pair_meamc.h @@ -24,7 +24,6 @@ PairStyle(meam,PairMEAMC) #include "pair.h" namespace LAMMPS_NS { -class MEAM; class PairMEAMC : public Pair { public: diff --git a/src/USER-MGPT/mgpt_linalg.cpp b/src/USER-MGPT/mgpt_linalg.cpp index 68701037f4..bc15873739 100644 --- a/src/USER-MGPT/mgpt_linalg.cpp +++ b/src/USER-MGPT/mgpt_linalg.cpp @@ -20,8 +20,6 @@ #include #include -#include -#include #define restrict __restrict__ diff --git a/src/USER-MGPT/mgpt_readpot.h b/src/USER-MGPT/mgpt_readpot.h index 62f66883b6..8f46592e8a 100644 --- a/src/USER-MGPT/mgpt_readpot.h +++ b/src/USER-MGPT/mgpt_readpot.h @@ -19,7 +19,9 @@ #ifndef READPOT__ #define READPOT__ - +#include +#include +#include #include "mgpt_splinetab.h" struct potdata { diff --git a/src/USER-MGPT/pair_mgpt.cpp b/src/USER-MGPT/pair_mgpt.cpp index 91c624eec5..0634872c70 100644 --- a/src/USER-MGPT/pair_mgpt.cpp +++ b/src/USER-MGPT/pair_mgpt.cpp @@ -21,17 +21,16 @@ (2011). See LLNL copyright notice at bottom of this file. ------------------------------------------------------------------------- */ +#include "pair_mgpt.h" +#include #include -#include #include #include #include -#include "pair_mgpt.h" #include "atom.h" #include "force.h" #include "comm.h" -#include "memory.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/USER-MGPT/pair_mgpt.h b/src/USER-MGPT/pair_mgpt.h index 70b36364b1..3e861a0198 100644 --- a/src/USER-MGPT/pair_mgpt.h +++ b/src/USER-MGPT/pair_mgpt.h @@ -32,6 +32,7 @@ PairStyle(mgpt,PairMGPT) #include #include +#include #include #include "pair.h" @@ -77,29 +78,29 @@ public: Link(const K &k,Link *n) : next(n),key(k),hits(1) {} static void *operator new(std::size_t sz) { - const size_t align = 32; - size_t x = (size_t) (void *) ::operator new(sz+align); - size_t y = (x + align) - ((x+align)&(align-1)); - assert(sizeof(void *) <= align); - assert((x & (sizeof(void *)-1)) == 0); - ((void **) y)[-1] = (void *) x; - return (void *) y; + const size_t align = 32; + size_t x = (size_t) (void *) ::operator new(sz+align); + size_t y = (x + align) - ((x+align)&(align-1)); + assert(sizeof(void *) <= align); + assert((x & (sizeof(void *)-1)) == 0); + ((void **) y)[-1] = (void *) x; + return (void *) y; } static void operator delete(void *ptr) { - ::operator delete(((void **) ptr)[-1]); + ::operator delete(((void **) ptr)[-1]); } }; int isprime(int x) { if(x%2 == 0) - return 0; + return 0; else { - int k = 3; - while(k*k <= x) { - if(x%k == 0) return 0; - k = k+2; - } - return 1; + int k = 3; + while(k*k <= x) { + if(x%k == 0) return 0; + k = k+2; + } + return 1; } } @@ -117,25 +118,25 @@ public: Iterator(Hash &HH) : H(HH),idx(-1),p(0) { next(); } Iterator(Hash &HH,int iidx,Link *pp) : H(HH),idx(iidx),p(pp) {} void next() { - if(idx >= H.Size()) return; - if(p != 0) p = p->next; - if(p == 0) { - do { - idx = idx+1; - if(idx >= H.Size()) return; - p = H.table[idx]; - } while(p == 0); - } + if(idx >= H.Size()) return; + if(p != 0) p = p->next; + if(p == 0) { + do { + idx = idx+1; + if(idx >= H.Size()) return; + p = H.table[idx]; + } while(p == 0); + } } K *key() { return &p->key; } T *data() { return &p->data; } Link *link() { return p; } int operator==(const Iterator &a) { - return idx==a.idx && p==a.p; + return idx==a.idx && p==a.p; } int operator!=(const Iterator &a) { - return !(*this == a); + return !(*this == a); } }; @@ -147,7 +148,7 @@ public: table = new Link *[size]; for(int i = 0; inext; - delete p; - p = q; - } + Link *p = table[i]; + while(p != 0) { + Link *q = p->next; + delete p; + p = q; + } } delete[] table; } @@ -179,24 +180,24 @@ public: int idx = key.hash() % size; if(idx < 0) idx = idx + size; if(idx >= size || idx < 0) { - printf("(1) Damn... key = %d, idx = %d, size = %d\n",key.hash(),idx,size); - exit(1); + printf("(1) Damn... key = %d, idx = %d, size = %d\n",key.hash(),idx,size); + exit(1); } used = used + 1; if(1) { - table[idx] = new Link(key,table[idx]); - return &table[idx]->data; + table[idx] = new Link(key,table[idx]); + return &table[idx]->data; } else { /* This is for threading... and incomplete */ - typedef Link *LinkPtr; - LinkPtr ptr = table[idx],last = 0,dataptr = new Link(key,0); - - while(ptr != 0) { - last = ptr; - ptr = ptr->next; - } - *((volatile LinkPtr *) &(last->next)) = dataptr; - return &(dataptr->data); + typedef Link *LinkPtr; + LinkPtr ptr = table[idx],last = 0,dataptr = new Link(key,0); + + while(ptr != 0) { + last = ptr; + ptr = ptr->next; + } + *((volatile LinkPtr *) &(last->next)) = dataptr; + return &(dataptr->data); } } void Remove(const K &key) { @@ -205,28 +206,28 @@ public: int count = 1; if(idx < 0) idx = idx + size; if(idx >= size || idx < 0) { - printf("(2) Damn... key = %d, idx = %d, size = %d\n",key.hash(),idx,size); - exit(1); + printf("(2) Damn... key = %d, idx = %d, size = %d\n",key.hash(),idx,size); + exit(1); } p = table[idx]; while(p != 0 && !(p->key == key)) { - last = p; - p = p->next; - count = count + 1; + last = p; + p = p->next; + count = count + 1; } if(p != 0) { - used = used - 1; - if(last == 0) - table[idx] = p->next; - else - last->next = p->next; - delete p; + used = used - 1; + if(last == 0) + table[idx] = p->next; + else + last->next = p->next; + delete p; } if(count > maxlength) - maxlength = count; + maxlength = count; nsearch = nsearch + 1; nstep = nstep + count; } @@ -236,19 +237,19 @@ public: int count = 1; if(idx < 0) idx = idx + size; if(idx >= size || idx < 0) { - printf("(3) Damn... key = %d, idx = %d, size = %d\n",key.hash(),idx,size); - exit(1); + printf("(3) Damn... key = %d, idx = %d, size = %d\n",key.hash(),idx,size); + exit(1); } p = table[idx]; while(p != 0 && !(p->key == key)) { - p = p->next; - count = count + 1; + p = p->next; + count = count + 1; } if(count > maxlength) - maxlength = count; + maxlength = count; nsearch = nsearch + 1; nstep = nstep + count; @@ -283,46 +284,46 @@ public: } void zero() { for(int i = 0; i<8; i++) - for(int j = 0; j<8; j++) - m[i][j] = 0.0; + for(int j = 0; j<8; j++) + m[i][j] = 0.0; } void operator=(const Matrix &A) { for(int i = 1; i<=sz; i++) - for(int j = 1; j<=sz; j++) - m[i][j] = A.m[i][j]; + for(int j = 1; j<=sz; j++) + m[i][j] = A.m[i][j]; } void operator=(double x) { for(int i = 1; i<=sz; i++) - for(int j = 1; j<=sz; j++) - m[i][j] = x; + for(int j = 1; j<=sz; j++) + m[i][j] = x; } Matrix operator+(const Matrix &B) const { Matrix s; for(int i = 1; i<=sz; i++) - for(int j = 1; j<=sz; j++) - s.m[i][j] = m[i][j] + B.m[i][j]; + for(int j = 1; j<=sz; j++) + s.m[i][j] = m[i][j] + B.m[i][j]; return s; } Matrix operator-(const Matrix &B) const { Matrix s; for(int i = 1; i<=sz; i++) - for(int j = 1; j<=sz; j++) - s.m[i][j] = m[i][j] - B.m[i][j]; + for(int j = 1; j<=sz; j++) + s.m[i][j] = m[i][j] - B.m[i][j]; return s; } Matrix operator-() const { Matrix s; for(int i = 1; i<=sz; i++) - for(int j = 1; j<=sz; j++) - s.m[i][j] = -m[i][j]; + for(int j = 1; j<=sz; j++) + s.m[i][j] = -m[i][j]; return s; } Matrix operator*(double x) const { Matrix P; for(int i = 1; i<=sz; i++) - for(int j = 0; j<=sz; j++) - P.m[i][j] = m[i][j] * x; + for(int j = 0; j<=sz; j++) + P.m[i][j] = m[i][j] * x; return P; } Matrix operator/(double x) const { @@ -331,8 +332,8 @@ public: Matrix transpose() const { Matrix T; for(int i = 1; i<=sz; i++) - for(int j = 1; j<=sz; j++) - T.m[j][i] = m[i][j]; + for(int j = 1; j<=sz; j++) + T.m[j][i] = m[i][j]; return T; } }; @@ -374,13 +375,13 @@ public: int align_check() { return - (H1H2.align_check() << 0) | - (H1xH2.align_check() << 1) | - (H1yH2.align_check() << 2) | - (H1zH2.align_check() << 3) | - (H1H2x.align_check() << 4) | - (H1H2y.align_check() << 5) | - (H1H2z.align_check() << 6) ; + (H1H2.align_check() << 0) | + (H1xH2.align_check() << 1) | + (H1yH2.align_check() << 2) | + (H1zH2.align_check() << 3) | + (H1H2x.align_check() << 4) | + (H1H2y.align_check() << 5) | + (H1H2z.align_check() << 6) ; } void zero() { @@ -396,18 +397,18 @@ public: void make_bond(const double xx[][3],int i,int j,bond_data *bptr); void make_triplet(bond_data *ij_bond,bond_data *ik_bond,triplet_data *triptr); triplet_data *get_triplet(const double xx[][3],int i,int j,int k, - Hash *bhash,triplet_data *twork, - double *dvir_ij_p,double *dvir_ik_p); + Hash *bhash,triplet_data *twork, + double *dvir_ij_p,double *dvir_ik_p); int c1_outside(const double a[3], - int triclinic,const double alpha[3]) { + int triclinic,const double alpha[3]) { const double stol = 1e-5; if(triclinic) { for(int p = 0; p<3; p++) { - double cog = a[p]; - if(cog < domain->sublo_lamda[p]-0.5*rmax*alpha[p]-stol) return 1; - if(cog > domain->subhi_lamda[p]+0.5*rmax*alpha[p]+stol) return 1; + double cog = a[p]; + if(cog < domain->sublo_lamda[p]-0.5*rmax*alpha[p]-stol) return 1; + if(cog > domain->subhi_lamda[p]+0.5*rmax*alpha[p]+stol) return 1; } } else { @@ -415,63 +416,63 @@ public: for(int p = 0; p<3; p++) { - double cog = a[p]; - if(cog < domain->sublo[p]-0.5*rmax-stol) return 1; - if(cog > domain->subhi[p]+0.5*rmax+stol) return 1; - - if(cog < domain->sublo[p]-stol) { - double t = cog - (domain->sublo[p]-stol); - rout = rout + t*t; - } else if(cog > domain->subhi[p]+stol) { - double t = cog - (domain->subhi[p]+stol); - rout = rout + t*t; - } + double cog = a[p]; + if(cog < domain->sublo[p]-0.5*rmax-stol) return 1; + if(cog > domain->subhi[p]+0.5*rmax+stol) return 1; + + if(cog < domain->sublo[p]-stol) { + double t = cog - (domain->sublo[p]-stol); + rout = rout + t*t; + } else if(cog > domain->subhi[p]+stol) { + double t = cog - (domain->subhi[p]+stol); + rout = rout + t*t; + } } if(rout > 0.25*rmax*rmax) - return 1; + return 1; } return 0; } int c2_outside(const double a[3],const double b[3], - int triclinic,const double alpha[3]) { + int triclinic,const double alpha[3]) { const double stol = 1e-5; if(triclinic) { for(int p = 0; p<3; p++) { - double cog = 0.5*(a[p] + b[p]); - if(cog < domain->sublo_lamda[p]-0.5*rcrit*alpha[p]-stol) return 1; - if(cog > domain->subhi_lamda[p]+0.5*rcrit*alpha[p]+stol) return 1; + double cog = 0.5*(a[p] + b[p]); + if(cog < domain->sublo_lamda[p]-0.5*rcrit*alpha[p]-stol) return 1; + if(cog > domain->subhi_lamda[p]+0.5*rcrit*alpha[p]+stol) return 1; } } else { double rout = 0.0; for(int p = 0; p<3; p++) { - double cog = 0.5*(a[p] + b[p]); - if(cog < domain->sublo[p]-0.5*rcrit-stol) return 1; - if(cog > domain->subhi[p]+0.5*rcrit+stol) return 1; - - if(cog < domain->sublo[p]-stol) { - double t = cog - (domain->sublo[p]-stol); - rout = rout + t*t; - } else if(cog > domain->subhi[p]+stol) { - double t = cog - (domain->subhi[p]+stol); - rout = rout + t*t; - } + double cog = 0.5*(a[p] + b[p]); + if(cog < domain->sublo[p]-0.5*rcrit-stol) return 1; + if(cog > domain->subhi[p]+0.5*rcrit+stol) return 1; + + if(cog < domain->sublo[p]-stol) { + double t = cog - (domain->sublo[p]-stol); + rout = rout + t*t; + } else if(cog > domain->subhi[p]+stol) { + double t = cog - (domain->subhi[p]+stol); + rout = rout + t*t; + } } if(rout > 0.25*rcrit*rcrit) - return 1; + return 1; } return 0; } double get_weight(const int triclinic, - const double a[3] = 0,const double b[3] = 0, - const double c[3] = 0,const double d[3] = 0) { + const double a[3] = 0,const double b[3] = 0, + const double c[3] = 0,const double d[3] = 0) { const double *s0 = triclinic ? domain->sublo_lamda : domain->sublo, *s1 = triclinic ? domain->subhi_lamda : domain->subhi; @@ -498,46 +499,46 @@ public: } void force_debug_3t(double xx[][3], - int i0,int j0,int k0, - int i ,int j ,int k , - double dfix,double dfiy,double dfiz, - double dfjx,double dfjy,double dfjz, - double dfkx,double dfky,double dfkz); + int i0,int j0,int k0, + int i ,int j ,int k , + double dfix,double dfiy,double dfiz, + double dfjx,double dfjy,double dfjz, + double dfkx,double dfky,double dfkz); void force_debug_3v(double xx[][3], - int i0,int j0,int k0, - int i ,int j ,int k , - double dfix,double dfiy,double dfiz, - double dfjx,double dfjy,double dfjz, - double dfkx,double dfky,double dfkz); + int i0,int j0,int k0, + int i ,int j ,int k , + double dfix,double dfiy,double dfiz, + double dfjx,double dfjy,double dfjz, + double dfkx,double dfky,double dfkz); void force_debug_4(double xx[][3], - int i0,int j0,int k0,int m0, - int i ,int j ,int k ,int m , - double dfix,double dfiy,double dfiz, - double dfjx,double dfjy,double dfjz, - double dfkx,double dfky,double dfkz, - double dfmx,double dfmy,double dfmz); + int i0,int j0,int k0,int m0, + int i ,int j ,int k ,int m , + double dfix,double dfiy,double dfiz, + double dfjx,double dfjy,double dfjz, + double dfkx,double dfky,double dfkz, + double dfmx,double dfmy,double dfmz); double numderiv3t(double xx[][3],int i,int j,int k,int p); double numderiv3v(double xx[][3],int i,int j,int k,int p,int ipert); double numderiv4(double xx[][3],int i,int j,int k,int m,int p); void compute_x(const int *nnei,const int * const *nlist, - double *e_s,double *e_p,double *e_t,double *e_q, - int evflag,int newton_pair); + double *e_s,double *e_p,double *e_t,double *e_q, + int evflag,int newton_pair); /* Reimplementation of bond matrix computation */ void fl_deriv_new(double r,double ri,double xhat,double yhat,double zhat, - double &fl_0,double &fl_x,double &fl_y,double &fl_z, - double &fl_rp,double &fl_p1,double &fl_r0,double &fl_al); + double &fl_0,double &fl_x,double &fl_y,double &fl_z, + double &fl_rp,double &fl_p1,double &fl_r0,double &fl_al); void hamltn_5_raw(const double xin,const double yin,const double zin, - double M [8][8],double Mx[8][8], - double My[8][8],double Mz[8][8], - double *fl_deriv_sum_p); + double M [8][8],double Mx[8][8], + double My[8][8],double Mz[8][8], + double *fl_deriv_sum_p); void hamltn_7_raw(const double xin,const double yin,const double zin, - double M [8][8],double Mx[8][8], - double My[8][8],double Mz[8][8], - double *fl_deriv_sum_p); + double M [8][8],double Mx[8][8], + double My[8][8],double Mz[8][8], + double *fl_deriv_sum_p); /* * */ // Old matrix routines, only used in force debug routines. @@ -546,9 +547,9 @@ public: Matrix h; for(int l = 1; l <= lmax; l++) { for(int n = 1; n <= lmax; n++) { - h.m[l][n] = 0.0; - for(int m = 1; m <= lmax; m++) - h.m[l][n] += ha.m[l][m] * hb.m[m][n]; + h.m[l][n] = 0.0; + for(int m = 1; m <= lmax; m++) + h.m[l][n] += ha.m[l][m] * hb.m[m][n]; } } return h; @@ -560,7 +561,7 @@ public: for(int n = 1; n <= lmax; n++) { double cquan = 0.0; for(int m = 1; m <= lmax; m++) - cquan += ha.m[n][m] * hb.m[m][n]; + cquan += ha.m[n][m] * hb.m[m][n]; zquan += cquan; } return zquan; @@ -572,32 +573,32 @@ public: int i,j,k; if(lmax == 5) { - const int n = 5; - for(i = 1; i<=n; i++) - for(j = 1; j<=n; j++) { - double s = 0.0; - for(k = 1; k<=n; k++) - s = s + a.m[i][k]*b.m[j][k]; - c.m[i][j] = s; - } + const int n = 5; + for(i = 1; i<=n; i++) + for(j = 1; j<=n; j++) { + double s = 0.0; + for(k = 1; k<=n; k++) + s = s + a.m[i][k]*b.m[j][k]; + c.m[i][j] = s; + } } else if(lmax == 7) { - const int n = 7; - for(i = 1; i<=n; i++) - for(j = 1; j<=n; j++) { - double s = 0.0; - for(k = 1; k<=n; k++) - s = s + a.m[i][k]*b.m[j][k]; - c.m[i][j] = s; - } + const int n = 7; + for(i = 1; i<=n; i++) + for(j = 1; j<=n; j++) { + double s = 0.0; + for(k = 1; k<=n; k++) + s = s + a.m[i][k]*b.m[j][k]; + c.m[i][j] = s; + } } else { - const int n = lmax; - for(i = 1; i<=n; i++) - for(j = 1; j<=n; j++) { - double s = 0.0; - for(k = 1; k<=n; k++) - s = s + a.m[i][k]*b.m[j][k]; - c.m[i][j] = s; - } + const int n = lmax; + for(i = 1; i<=n; i++) + for(j = 1; j<=n; j++) { + double s = 0.0; + for(k = 1; k<=n; k++) + s = s + a.m[i][k]*b.m[j][k]; + c.m[i][j] = s; + } } } @@ -608,7 +609,7 @@ public: for(i = 0; i -#include #include "angle_cosine_shift.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-MISC/angle_cosine_shift_exp.cpp b/src/USER-MISC/angle_cosine_shift_exp.cpp index 8c6282de20..79cb0fea7c 100644 --- a/src/USER-MISC/angle_cosine_shift_exp.cpp +++ b/src/USER-MISC/angle_cosine_shift_exp.cpp @@ -15,9 +15,9 @@ Contributing author: Carsten Svaneborg, science@zqex.dk ------------------------------------------------------------------------- */ -#include -#include #include "angle_cosine_shift_exp.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-MISC/angle_dipole.cpp b/src/USER-MISC/angle_dipole.cpp index 781da46869..0956ba3b8f 100644 --- a/src/USER-MISC/angle_dipole.cpp +++ b/src/USER-MISC/angle_dipole.cpp @@ -15,9 +15,9 @@ Contributing authors: Mario Orsi & Wei Ding (QMUL), m.orsi@qmul.ac.uk ------------------------------------------------------------------------- */ -#include -#include #include "angle_dipole.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-MISC/angle_fourier.cpp b/src/USER-MISC/angle_fourier.cpp index 8f5074ff5d..dcf5080431 100644 --- a/src/USER-MISC/angle_fourier.cpp +++ b/src/USER-MISC/angle_fourier.cpp @@ -16,9 +16,9 @@ [ based on angle_cosine_squared.cpp Naveen Michaud-Agrawal (Johns Hopkins U)] ------------------------------------------------------------------------- */ -#include -#include #include "angle_fourier.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-MISC/angle_fourier_simple.cpp b/src/USER-MISC/angle_fourier_simple.cpp index 615556bbe7..bbe3f8520b 100644 --- a/src/USER-MISC/angle_fourier_simple.cpp +++ b/src/USER-MISC/angle_fourier_simple.cpp @@ -16,9 +16,9 @@ [ based on angle_cosine_squared.cpp Naveen Michaud-Agrawal (Johns Hopkins U)] ------------------------------------------------------------------------- */ -#include -#include #include "angle_fourier_simple.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-MISC/angle_quartic.cpp b/src/USER-MISC/angle_quartic.cpp index 21a96100aa..5c5f3411e4 100644 --- a/src/USER-MISC/angle_quartic.cpp +++ b/src/USER-MISC/angle_quartic.cpp @@ -16,9 +16,9 @@ [ based on angle_harmonic.cpp] ------------------------------------------------------------------------- */ -#include -#include #include "angle_quartic.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-MISC/bond_harmonic_shift.cpp b/src/USER-MISC/bond_harmonic_shift.cpp index c7e4444cce..fdd3111783 100644 --- a/src/USER-MISC/bond_harmonic_shift.cpp +++ b/src/USER-MISC/bond_harmonic_shift.cpp @@ -15,12 +15,11 @@ Contributing author: Carsten Svaneborg, science@zqex.dk ------------------------------------------------------------------------- */ -#include -#include #include "bond_harmonic_shift.h" +#include +#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/USER-MISC/bond_harmonic_shift_cut.cpp b/src/USER-MISC/bond_harmonic_shift_cut.cpp index 5b396f5d72..0688cb428a 100644 --- a/src/USER-MISC/bond_harmonic_shift_cut.cpp +++ b/src/USER-MISC/bond_harmonic_shift_cut.cpp @@ -15,12 +15,11 @@ Contributing author: Carsten Svaneborg, science@zqex.dk ------------------------------------------------------------------------- */ -#include -#include #include "bond_harmonic_shift_cut.h" +#include +#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "memory.h" diff --git a/src/USER-MISC/compute_cnp_atom.cpp b/src/USER-MISC/compute_cnp_atom.cpp index 6fa16f1a9a..ba97be25d4 100644 --- a/src/USER-MISC/compute_cnp_atom.cpp +++ b/src/USER-MISC/compute_cnp_atom.cpp @@ -21,11 +21,10 @@ branicio@usc.edu ------------------------------------------------------------------------- */ +#include "compute_cnp_atom.h" +#include #include -#include #include - -#include "compute_cnp_atom.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/USER-MISC/compute_entropy_atom.cpp b/src/USER-MISC/compute_entropy_atom.cpp index 0367d7fe6d..00f7e6dc8b 100644 --- a/src/USER-MISC/compute_entropy_atom.cpp +++ b/src/USER-MISC/compute_entropy_atom.cpp @@ -15,10 +15,9 @@ Contributing author: Pablo Piaggi (EPFL Lausanne) ------------------------------------------------------------------------- */ +#include "compute_entropy_atom.h" #include #include -#include -#include "compute_entropy_atom.h" #include "atom.h" #include "update.h" #include "modify.h" @@ -28,13 +27,11 @@ #include "force.h" #include "pair.h" #include "comm.h" -#include "math_extra.h" #include "math_const.h" #include "memory.h" #include "error.h" #include "domain.h" - using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/USER-MISC/compute_pressure_cylinder.cpp b/src/USER-MISC/compute_pressure_cylinder.cpp index c250eaf677..6d2509d685 100644 --- a/src/USER-MISC/compute_pressure_cylinder.cpp +++ b/src/USER-MISC/compute_pressure_cylinder.cpp @@ -11,10 +11,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include #include "compute_pressure_cylinder.h" +#include +#include #include "atom.h" #include "update.h" #include "force.h" @@ -22,7 +21,6 @@ #include "neighbor.h" #include "neigh_request.h" #include "neigh_list.h" -#include "group.h" #include "memory.h" #include "error.h" #include "citeme.h" diff --git a/src/USER-MISC/compute_pressure_grem.cpp b/src/USER-MISC/compute_pressure_grem.cpp index 087c01bd8e..ba949727b0 100644 --- a/src/USER-MISC/compute_pressure_grem.cpp +++ b/src/USER-MISC/compute_pressure_grem.cpp @@ -11,17 +11,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include #include "compute_pressure_grem.h" -#include "atom.h" +#include #include "update.h" #include "domain.h" #include "modify.h" #include "fix.h" #include "force.h" -#include "pair.h" #include "kspace.h" #include "error.h" diff --git a/src/USER-MISC/compute_stress_mop.cpp b/src/USER-MISC/compute_stress_mop.cpp index cb2a0b9713..2f932321e1 100644 --- a/src/USER-MISC/compute_stress_mop.cpp +++ b/src/USER-MISC/compute_stress_mop.cpp @@ -15,18 +15,14 @@ Contributing Authors : Romain Vermorel (LFCR), Laurent Joly (ULyon) --------------------------------------------------------------------------*/ +#include "compute_stress_mop.h" #include #include #include -#include -#include "compute_stress_mop.h" #include "atom.h" #include "update.h" #include "domain.h" -#include "group.h" -#include "modify.h" -#include "fix.h" #include "neighbor.h" #include "force.h" #include "pair.h" diff --git a/src/USER-MISC/compute_stress_mop_profile.cpp b/src/USER-MISC/compute_stress_mop_profile.cpp index 5499a37a46..5f6d0a36b2 100644 --- a/src/USER-MISC/compute_stress_mop_profile.cpp +++ b/src/USER-MISC/compute_stress_mop_profile.cpp @@ -15,18 +15,14 @@ Contributing Authors : Romain Vermorel (LFCR), Laurent Joly (ULyon) --------------------------------------------------------------------------*/ +#include "compute_stress_mop_profile.h" #include #include #include -#include -#include "compute_stress_mop_profile.h" #include "atom.h" #include "update.h" #include "domain.h" -#include "group.h" -#include "modify.h" -#include "fix.h" #include "neighbor.h" #include "force.h" #include "pair.h" diff --git a/src/USER-MISC/compute_temp_rotate.cpp b/src/USER-MISC/compute_temp_rotate.cpp index 36093bd1e1..94c6115186 100644 --- a/src/USER-MISC/compute_temp_rotate.cpp +++ b/src/USER-MISC/compute_temp_rotate.cpp @@ -15,16 +15,13 @@ Contributing author: Laurent Joly (U Lyon, France), ljoly.ulyon@gmail.com ------------------------------------------------------------------------- */ -#include -#include -#include #include "compute_temp_rotate.h" +#include #include "atom.h" #include "update.h" #include "force.h" #include "group.h" #include "domain.h" -#include "lattice.h" #include "error.h" #include "memory.h" diff --git a/src/USER-MISC/dihedral_cosine_shift_exp.cpp b/src/USER-MISC/dihedral_cosine_shift_exp.cpp index c411ea8150..820dfabdeb 100644 --- a/src/USER-MISC/dihedral_cosine_shift_exp.cpp +++ b/src/USER-MISC/dihedral_cosine_shift_exp.cpp @@ -15,14 +15,12 @@ Contributing author: Carsten Svaneborg, science@zqex.dk ------------------------------------------------------------------------- */ +#include "dihedral_cosine_shift_exp.h" #include #include -#include -#include "dihedral_cosine_shift_exp.h" #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "memory.h" diff --git a/src/USER-MISC/dihedral_fourier.cpp b/src/USER-MISC/dihedral_fourier.cpp index af86259c01..7cc250b1a8 100644 --- a/src/USER-MISC/dihedral_fourier.cpp +++ b/src/USER-MISC/dihedral_fourier.cpp @@ -16,16 +16,13 @@ [ based on dihedral_charmm.cpp Paul Crozier (SNL) ] ------------------------------------------------------------------------- */ +#include "dihedral_fourier.h" #include #include -#include -#include "dihedral_fourier.h" #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" -#include "pair.h" #include "update.h" #include "math_const.h" #include "memory.h" diff --git a/src/USER-MISC/dihedral_nharmonic.cpp b/src/USER-MISC/dihedral_nharmonic.cpp index ea2b76f415..f1e0018689 100644 --- a/src/USER-MISC/dihedral_nharmonic.cpp +++ b/src/USER-MISC/dihedral_nharmonic.cpp @@ -16,12 +16,11 @@ [ based on dihedral_multi_harmonic.cpp Mathias Puetz (SNL) and friends ] ------------------------------------------------------------------------- */ -#include -#include #include "dihedral_nharmonic.h" +#include +#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "update.h" diff --git a/src/USER-MISC/dihedral_quadratic.cpp b/src/USER-MISC/dihedral_quadratic.cpp index 8436e73c5c..02effc2f4f 100644 --- a/src/USER-MISC/dihedral_quadratic.cpp +++ b/src/USER-MISC/dihedral_quadratic.cpp @@ -16,12 +16,11 @@ [ based on dihedral_helix.cpp Paul Crozier (SNL) ] ------------------------------------------------------------------------- */ -#include -#include #include "dihedral_quadratic.h" +#include +#include #include "atom.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "update.h" diff --git a/src/USER-MISC/dihedral_spherical.cpp b/src/USER-MISC/dihedral_spherical.cpp index 3b30121551..78d45f923d 100644 --- a/src/USER-MISC/dihedral_spherical.cpp +++ b/src/USER-MISC/dihedral_spherical.cpp @@ -17,22 +17,19 @@ and Paul Crozier (SNL) ] ------------------------------------------------------------------------- */ +#include "dihedral_spherical.h" #include #include -#include #include #include "atom.h" #include "comm.h" #include "neighbor.h" #include "domain.h" #include "force.h" -#include "pair.h" -#include "update.h" #include "math_const.h" #include "math_extra.h" #include "memory.h" #include "error.h" -#include "dihedral_spherical.h" using namespace std; using namespace LAMMPS_NS; diff --git a/src/USER-MISC/dihedral_table.cpp b/src/USER-MISC/dihedral_table.cpp index a97ae3649f..7fa871d3be 100644 --- a/src/USER-MISC/dihedral_table.cpp +++ b/src/USER-MISC/dihedral_table.cpp @@ -17,21 +17,20 @@ the "tridiag.c" written by Gerard Jungman for GSL ------------------------------------------------------------------------- */ +#include +#include #include #include #include -#include #include -#include -#include -#include +#include // IWYU pragma: keep +#include // IWYU pragma: keep #include "atom.h" #include "comm.h" #include "neighbor.h" #include "domain.h" #include "force.h" -#include "update.h" #include "memory.h" #include "error.h" #include "dihedral_table.h" diff --git a/src/USER-MISC/dihedral_table_cut.cpp b/src/USER-MISC/dihedral_table_cut.cpp index 18a645cd75..71f9ea0df1 100644 --- a/src/USER-MISC/dihedral_table_cut.cpp +++ b/src/USER-MISC/dihedral_table_cut.cpp @@ -16,25 +16,23 @@ Based on tabulated dihedral (dihedral_table.cpp) by Andrew Jewett ------------------------------------------------------------------------- */ +#include "dihedral_table_cut.h" +#include +#include #include #include #include -#include #include -#include -#include -#include +#include // IWYU pragma: keep +#include // IWYU pragma: keep -#include "dihedral_table_cut.h" #include "atom.h" #include "neighbor.h" #include "update.h" -#include "domain.h" #include "comm.h" #include "force.h" #include "citeme.h" #include "math_const.h" -#include "math_extra.h" #include "memory.h" #include "error.h" #include "utils.h" @@ -42,8 +40,6 @@ using namespace LAMMPS_NS; using namespace MathConst; using namespace std; -using namespace MathExtra; - static const char cite_dihedral_tablecut[] = "dihedral_style table/cut command:\n\n" diff --git a/src/USER-MISC/fix_addtorque.cpp b/src/USER-MISC/fix_addtorque.cpp index 2cd1ac7527..665f1d4a60 100644 --- a/src/USER-MISC/fix_addtorque.cpp +++ b/src/USER-MISC/fix_addtorque.cpp @@ -15,9 +15,9 @@ Contributing author: Laurent Joly (U Lyon, France), ljoly.ulyon@gmail.com ------------------------------------------------------------------------- */ -#include -#include #include "fix_addtorque.h" +#include +#include #include "atom.h" #include "update.h" #include "modify.h" @@ -25,7 +25,6 @@ #include "respa.h" #include "input.h" #include "variable.h" -#include "memory.h" #include "error.h" #include "group.h" #include "force.h" diff --git a/src/USER-MISC/fix_ave_correlate_long.cpp b/src/USER-MISC/fix_ave_correlate_long.cpp index dc52d94b14..b1bcc07fa7 100644 --- a/src/USER-MISC/fix_ave_correlate_long.cpp +++ b/src/USER-MISC/fix_ave_correlate_long.cpp @@ -21,11 +21,12 @@ see J. Chem. Phys. 133, 154103 (2010) ------------------------------------------------------------------------- */ +#include "fix_ave_correlate_long.h" +#include #include #include #include #include -#include "fix_ave_correlate_long.h" #include "update.h" #include "modify.h" #include "compute.h" diff --git a/src/USER-MISC/fix_bond_react.cpp b/src/USER-MISC/fix_bond_react.cpp index c641912db6..ef23f98d64 100644 --- a/src/USER-MISC/fix_bond_react.cpp +++ b/src/USER-MISC/fix_bond_react.cpp @@ -15,11 +15,10 @@ See the README file in the top-level LAMMPS directory. Contributing Author: Jacob Gissinger (jacob.gissinger@colorado.edu) ------------------------------------------------------------------------- */ +#include "fix_bond_react.h" #include #include #include -#include -#include "fix_bond_react.h" #include "update.h" #include "modify.h" #include "respa.h" diff --git a/src/USER-MISC/fix_electron_stopping.cpp b/src/USER-MISC/fix_electron_stopping.cpp index 0831ebcf89..2130f07420 100644 --- a/src/USER-MISC/fix_electron_stopping.cpp +++ b/src/USER-MISC/fix_electron_stopping.cpp @@ -16,16 +16,14 @@ Information: k.avchachov@gmail.com ------------------------------------------------------------------------- */ +#include "fix_electron_stopping.h" #include -#include #include -#include "fix_electron_stopping.h" #include "mpi.h" #include "atom.h" #include "update.h" #include "domain.h" #include "region.h" -#include "group.h" #include "force.h" #include "fix.h" #include "memory.h" diff --git a/src/USER-MISC/fix_ffl.cpp b/src/USER-MISC/fix_ffl.cpp index 9ab113aeaa..a245b6b4e5 100644 --- a/src/USER-MISC/fix_ffl.cpp +++ b/src/USER-MISC/fix_ffl.cpp @@ -18,31 +18,21 @@ /* ---------------------------------------------------------------------- Contributing authors: Lionel Constantin (EPFL), David M. Wilkins (EPFL), - Michele Ceriotti (EPFL) + Michele Ceriotti (EPFL) ------------------------------------------------------------------------- */ +#include "fix_ffl.h" #include #include #include -#include -#include "fix_ffl.h" -#include "math_extra.h" #include "atom.h" -#include "atom_vec_ellipsoid.h" #include "force.h" #include "update.h" -#include "modify.h" -#include "compute.h" -#include "domain.h" -#include "region.h" #include "respa.h" #include "comm.h" -#include "input.h" -#include "variable.h" #include "random_mars.h" #include "memory.h" #include "error.h" -#include "group.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-MISC/fix_filter_corotate.cpp b/src/USER-MISC/fix_filter_corotate.cpp index f6cc1c435f..bfc5f58f93 100644 --- a/src/USER-MISC/fix_filter_corotate.cpp +++ b/src/USER-MISC/fix_filter_corotate.cpp @@ -16,30 +16,25 @@ some subroutines are from fix_shake.cpp ------------------------------------------------------------------------- */ +#include "fix_filter_corotate.h" #include +#include +#include #include #include -#include "fix_filter_corotate.h" #include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "bond.h" +#include "comm.h" +#include "domain.h" #include "angle.h" +#include "bond.h" #include "math_const.h" #include "update.h" #include "modify.h" -#include "domain.h" -#include "region.h" #include "memory.h" #include "error.h" #include "force.h" -#include "comm.h" -#include "error.h" -#include "memory.h" -#include "domain.h" -#include "integrate.h" #include "respa.h" -#include "neighbor.h" #include "citeme.h" using namespace LAMMPS_NS; diff --git a/src/USER-MISC/fix_flow_gauss.cpp b/src/USER-MISC/fix_flow_gauss.cpp index b6366ec509..70be1f1e45 100644 --- a/src/USER-MISC/fix_flow_gauss.cpp +++ b/src/USER-MISC/fix_flow_gauss.cpp @@ -16,13 +16,12 @@ Joel.Eaves@Colorado.edu ------------------------------------------------------------------------- */ -#include -#include #include "fix_flow_gauss.h" +#include +#include #include "atom.h" #include "force.h" #include "group.h" -#include "comm.h" #include "update.h" #include "domain.h" #include "error.h" diff --git a/src/USER-MISC/fix_gle.cpp b/src/USER-MISC/fix_gle.cpp index 01da7f87cf..b8bdc66d08 100644 --- a/src/USER-MISC/fix_gle.cpp +++ b/src/USER-MISC/fix_gle.cpp @@ -16,28 +16,19 @@ Axel Kohylmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_gle.h" #include #include #include #include -#include "fix_gle.h" -#include "math_extra.h" #include "atom.h" -#include "atom_vec_ellipsoid.h" #include "force.h" #include "update.h" -#include "modify.h" -#include "compute.h" -#include "domain.h" -#include "region.h" #include "respa.h" #include "comm.h" -#include "input.h" -#include "variable.h" #include "random_mars.h" #include "memory.h" #include "error.h" -#include "group.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-MISC/fix_grem.cpp b/src/USER-MISC/fix_grem.cpp index 635acf705c..4272740068 100644 --- a/src/USER-MISC/fix_grem.cpp +++ b/src/USER-MISC/fix_grem.cpp @@ -22,19 +22,14 @@ Tom Keyes (Boston University) ------------------------------------------------------------------------- */ -#include -#include -#include -#include "comm.h" #include "fix_grem.h" +#include #include "atom.h" #include "force.h" #include "update.h" #include "modify.h" #include "domain.h" -#include "input.h" #include "compute.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-MISC/fix_ipi.cpp b/src/USER-MISC/fix_ipi.cpp index 32892d87a8..08b39ee89b 100644 --- a/src/USER-MISC/fix_ipi.cpp +++ b/src/USER-MISC/fix_ipi.cpp @@ -15,15 +15,12 @@ Contributing author: Michele Ceriotti (EPFL), Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_ipi.h" #include -#include #include -#include -#include "fix_ipi.h" #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" #include "kspace.h" #include "modify.h" @@ -32,8 +29,6 @@ #include "neighbor.h" #include "irregular.h" #include "domain.h" -#include "compute_pressure.h" -#include using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-MISC/fix_nvk.cpp b/src/USER-MISC/fix_nvk.cpp index 2ac2a7c9fc..410a269f8c 100644 --- a/src/USER-MISC/fix_nvk.cpp +++ b/src/USER-MISC/fix_nvk.cpp @@ -15,18 +15,16 @@ Contributing author: Efrem Braun (UC Berkeley) ------------------------------------------------------------------------- */ +#include "fix_nvk.h" +#include #include -#include #include -#include "fix_nvk.h" #include "atom.h" #include "force.h" #include "update.h" #include "respa.h" #include "error.h" -#include "compute.h" #include "math_extra.h" -#include "domain.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-MISC/fix_pimd.cpp b/src/USER-MISC/fix_pimd.cpp index 3929d47d6b..8f790f0a59 100644 --- a/src/USER-MISC/fix_pimd.cpp +++ b/src/USER-MISC/fix_pimd.cpp @@ -21,10 +21,11 @@ Version 1.0 ------------------------------------------------------------------------- */ +#include "fix_pimd.h" +#include #include #include #include -#include "fix_pimd.h" #include "universe.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/fix_rhok.cpp b/src/USER-MISC/fix_rhok.cpp index 6a6e71ebaa..c638adf6a4 100644 --- a/src/USER-MISC/fix_rhok.cpp +++ b/src/USER-MISC/fix_rhok.cpp @@ -13,12 +13,11 @@ Contributing author: Ulf R. Pedersen, ulf@urp.dk ------------------------------------------------------------------------- */ -#include -#include +#include "fix_rhok.h" +#include #include #include -#include "fix_rhok.h" #include "atom.h" #include "domain.h" #include "error.h" diff --git a/src/USER-MISC/fix_smd.cpp b/src/USER-MISC/fix_smd.cpp index cbebdebdbf..32c040c2b4 100644 --- a/src/USER-MISC/fix_smd.cpp +++ b/src/USER-MISC/fix_smd.cpp @@ -16,10 +16,10 @@ based on fix spring by: Paul Crozier (SNL) ------------------------------------------------------------------------- */ +#include "fix_smd.h" +#include #include -#include #include -#include "fix_smd.h" #include "atom.h" #include "comm.h" #include "update.h" diff --git a/src/USER-MISC/fix_srp.cpp b/src/USER-MISC/fix_srp.cpp index ebc161ff99..c0db252db4 100644 --- a/src/USER-MISC/fix_srp.cpp +++ b/src/USER-MISC/fix_srp.cpp @@ -15,9 +15,10 @@ Contributing authors: Timothy Sirk (ARL), Pieter in't Veld (BASF) ------------------------------------------------------------------------- */ -#include -#include #include "fix_srp.h" +#include +#include +#include #include "atom.h" #include "force.h" #include "domain.h" @@ -635,11 +636,11 @@ void FixSRP::restart(char *buf) int FixSRP::modify_param(int /*narg*/, char **arg) { if (strcmp(arg[0],"btype") == 0) { - btype = atoi(arg[1]); + btype = force->inumeric(FLERR,arg[1]); return 2; } if (strcmp(arg[0],"bptype") == 0) { - bptype = atoi(arg[1]); + bptype = force->inumeric(FLERR,arg[1]); return 2; } return 0; diff --git a/src/USER-MISC/fix_ti_spring.cpp b/src/USER-MISC/fix_ti_spring.cpp index 305e29e033..8481b34a6b 100644 --- a/src/USER-MISC/fix_ti_spring.cpp +++ b/src/USER-MISC/fix_ti_spring.cpp @@ -18,9 +18,9 @@ Maurice de Koning (Unicamp/Brazil) - dekoning@ifi.unicamp.br ------------------------------------------------------------------------- */ -#include -#include #include "fix_ti_spring.h" +#include +#include #include "atom.h" #include "update.h" #include "domain.h" diff --git a/src/USER-MISC/fix_ttm_mod.cpp b/src/USER-MISC/fix_ttm_mod.cpp index a34c2eb42f..55526a9149 100644 --- a/src/USER-MISC/fix_ttm_mod.cpp +++ b/src/USER-MISC/fix_ttm_mod.cpp @@ -17,17 +17,14 @@ Vasily Pisarev (Joint Institute for High Temperatures of RAS) ------------------------------------------------------------------------- */ -#include "lmptype.h" +#include "fix_ttm_mod.h" #include #include #include -#include -#include "fix_ttm_mod.h" #include "atom.h" #include "force.h" #include "update.h" #include "domain.h" -#include "region.h" #include "respa.h" #include "comm.h" #include "random_mars.h" diff --git a/src/USER-MISC/fix_wall_ees.cpp b/src/USER-MISC/fix_wall_ees.cpp index 5ca16ebdad..bd7e230472 100644 --- a/src/USER-MISC/fix_wall_ees.cpp +++ b/src/USER-MISC/fix_wall_ees.cpp @@ -15,21 +15,13 @@ Contributing author: Abdoreza Ershadinia, a.ershadinia at gmail.com ------------------------------------------------------------------------- */ +#include "fix_wall_ees.h" #include #include "math_extra.h" -#include "fix_wall_ees.h" #include "atom.h" #include "atom_vec.h" #include "atom_vec_ellipsoid.h" -#include "domain.h" -#include "region.h" -#include "force.h" -#include "lattice.h" -#include "update.h" -#include "output.h" -#include "respa.h" #include "error.h" -#include "math_extra.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-MISC/fix_wall_region_ees.cpp b/src/USER-MISC/fix_wall_region_ees.cpp index 33bf636e64..5c6bb1874b 100644 --- a/src/USER-MISC/fix_wall_region_ees.cpp +++ b/src/USER-MISC/fix_wall_region_ees.cpp @@ -15,19 +15,16 @@ Contributing author: Abdoreza Ershadinia, a.ershadinia at gmail.com ------------------------------------------------------------------------- */ +#include "fix_wall_region_ees.h" +#include #include -#include #include -#include "fix_wall_region_ees.h" #include "atom.h" -#include "atom_vec.h" #include "atom_vec_ellipsoid.h" #include "domain.h" #include "region.h" #include "force.h" -#include "lattice.h" #include "update.h" -#include "output.h" #include "respa.h" #include "error.h" #include "math_extra.h" -- GitLab From 89af88bd10343585de91b695c0348252f109f04e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 10 Jul 2019 08:41:27 -0600 Subject: [PATCH 224/469] more changes to robustify comm buf_send length --- src/atom_vec_hybrid.cpp | 3 ++ src/comm.h | 2 +- src/comm_brick.cpp | 27 ++++++++++------- src/comm_tiled.cpp | 23 +++++++++------ src/irregular.cpp | 64 ++++++++++++++++++++++++++++++++--------- src/irregular.h | 2 ++ 6 files changed, 87 insertions(+), 34 deletions(-) diff --git a/src/atom_vec_hybrid.cpp b/src/atom_vec_hybrid.cpp index a7816efbed..d0e8ed62ed 100644 --- a/src/atom_vec_hybrid.cpp +++ b/src/atom_vec_hybrid.cpp @@ -95,6 +95,7 @@ void AtomVecHybrid::process_args(int narg, char **arg) size_data_atom = 5; size_data_vel = 4; xcol_data = 3; + maxexchange = 0; for (int k = 0; k < nstyles; k++) { if ((styles[k]->molecular == 1 && molecular == 2) || @@ -120,6 +121,8 @@ void AtomVecHybrid::process_args(int narg, char **arg) size_border += styles[k]->size_border - 6; size_data_atom += styles[k]->size_data_atom - 5; size_data_vel += styles[k]->size_data_vel - 4; + + maxexchange += styles[k]->maxexchange; } size_velocity = 3; diff --git a/src/comm.h b/src/comm.h index 3367051e3c..967af0a014 100644 --- a/src/comm.h +++ b/src/comm.h @@ -134,7 +134,7 @@ class Comm : protected Pointers { int maxexchange_atom; // contribution to maxexchange from AtomVec int maxexchange_fix; // static contribution to maxexchange from Fixes int maxexchange_fix_dynamic; // 1 if a fix has a dynamic contribution - int bufextra; // augment size of send buf for an exchange atom + int bufextra; // augment send buf size for an exchange atom int gridflag; // option for creating 3d grid diff --git a/src/comm_brick.cpp b/src/comm_brick.cpp index 97114e5734..5c5fec47c0 100644 --- a/src/comm_brick.cpp +++ b/src/comm_brick.cpp @@ -109,9 +109,9 @@ void CommBrick::init_buffers() multilo = multihi = NULL; cutghostmulti = NULL; - maxsend = BUFMIN; - memory->create(buf_send,maxsend+bufextra,"comm:buf_send"); - maxrecv = BUFMIN; + buf_send = buf_recv = NULL; + maxsend = maxrecv = BUFMIN; + grow_send(maxsend,2); memory->create(buf_recv,maxrecv,"comm:buf_recv"); nswap = 0; @@ -134,7 +134,7 @@ void CommBrick::init() int bufextra_old = bufextra; init_exchange(); - if (bufextra > bufextra_old) grow_send(maxsend+bufextra,0); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,2); // memory for multi-style communication @@ -604,7 +604,7 @@ void CommBrick::exchange() if (maxexchange_fix_dynamic) { int bufextra_old = bufextra; init_exchange(); - if (bufextra > bufextra_old) grow_send(maxsend+bufextra,0); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,2); } // subbox bounds for orthogonal or triclinic @@ -1346,18 +1346,23 @@ int CommBrick::exchange_variable(int n, double *inbuf, double *&outbuf) /* ---------------------------------------------------------------------- realloc the size of the send buffer as needed with BUFFACTOR and bufextra - if flag = 1, realloc - if flag = 0, don't need to realloc with copy, just free/malloc + flag = 0, don't need to realloc with copy, just free/malloc w/ BUFFACTOR + flag = 1, realloc with BUFFACTOR + flag = 2, free/malloc w/out BUFFACTOR ------------------------------------------------------------------------- */ void CommBrick::grow_send(int n, int flag) { - maxsend = static_cast (BUFFACTOR * n); - if (flag) - memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); - else { + if (flag == 0) { + maxsend = static_cast (BUFFACTOR * n); memory->destroy(buf_send); memory->create(buf_send,maxsend+bufextra,"comm:buf_send"); + } else if (flag == 1) { + maxsend = static_cast (BUFFACTOR * n); + memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); + } else { + memory->destroy(buf_send); + memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); } } diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index c9f1a63fbc..2e04aa2978 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -79,9 +79,9 @@ CommTiled::~CommTiled() void CommTiled::init_buffers() { - maxsend = BUFMIN; - memory->create(buf_send,maxsend+bufextra,"comm:buf_send"); - maxrecv = BUFMIN; + buf_send = buf_recv = NULL; + maxsend = maxrecv = BUFMIN; + grow_send(maxsend,2); memory->create(buf_recv,maxrecv,"comm:buf_recv"); maxoverlap = 0; @@ -1804,18 +1804,23 @@ int CommTiled::coord2proc(double *x, int &igx, int &igy, int &igz) /* ---------------------------------------------------------------------- realloc the size of the send buffer as needed with BUFFACTOR and bufextra - if flag = 1, realloc - if flag = 0, don't need to realloc with copy, just free/malloc + flag = 0, don't need to realloc with copy, just free/malloc w/ BUFFACTOR + flag = 1, realloc with BUFFACTOR + flag = 2, free/malloc w/out BUFFACTOR ------------------------------------------------------------------------- */ void CommTiled::grow_send(int n, int flag) { - maxsend = static_cast (BUFFACTOR * n); - if (flag) - memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); - else { + if (flag == 0) { + maxsend = static_cast (BUFFACTOR * n); memory->destroy(buf_send); memory->create(buf_send,maxsend+bufextra,"comm:buf_send"); + } else if (flag == 1) { + maxsend = static_cast (BUFFACTOR * n); + memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); + } else { + memory->destroy(buf_send); + memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); } } diff --git a/src/irregular.cpp b/src/irregular.cpp index 1865f9cbf6..9851770612 100644 --- a/src/irregular.cpp +++ b/src/irregular.cpp @@ -19,6 +19,8 @@ #include "atom_vec.h" #include "domain.h" #include "comm.h" +#include "modify.h" +#include "fix.h" #include "memory.h" using namespace LAMMPS_NS; @@ -35,8 +37,8 @@ static int compare_standalone(const int, const int, void *); #endif #define BUFFACTOR 1.5 -#define BUFMIN 1000 -#define BUFEXTRA 1000 +#define BUFMIN 1024 +#define BUFEXTRA 1024 /* ---------------------------------------------------------------------- */ @@ -69,9 +71,10 @@ Irregular::Irregular(LAMMPS *lmp) : Pointers(lmp) // initialize buffers for migrate atoms, not used for datum comm // these can persist for multiple irregular operations - maxsend = BUFMIN; - memory->create(buf_send,maxsend+BUFEXTRA,"comm:buf_send"); - maxrecv = BUFMIN; + buf_send = buf_recv = NULL; + maxsend = maxrecv = BUFMIN; + bufextra = BUFEXTRA; + grow_send(maxsend,2); memory->create(buf_recv,maxrecv,"comm:buf_recv"); } @@ -103,6 +106,13 @@ Irregular::~Irregular() void Irregular::migrate_atoms(int sortflag, int preassign, int *procassign) { + // check if buf_send needs to be extended due to atom style or per-atom fixes + // same as in Comm::exchange() + + int bufextra_old = bufextra; + init_exchange(); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,2); + // clear global->local map since atoms move to new procs // clear old ghosts so map_set() at end will operate only on local atoms // exchange() doesn't need to clear ghosts b/c borders() @@ -983,24 +993,52 @@ void Irregular::destroy_data() } /* ---------------------------------------------------------------------- - realloc the size of the send buffer as needed with BUFFACTOR & BUFEXTRA - if flag = 1, realloc - if flag = 0, don't need to realloc with copy, just free/malloc + set bufextra based on AtomVec and fixes + similar to Comm::init_exchange() +------------------------------------------------------------------------- */ + +void Irregular::init_exchange() +{ + int nfix = modify->nfix; + Fix **fix = modify->fix; + + int onefix; + int maxexchange_fix = 0; + for (int i = 0; i < nfix; i++) { + onefix = fix[i]->maxexchange; + maxexchange_fix = MAX(maxexchange_fix,onefix); + } + + int maxexchange = atom->avec->maxexchange + maxexchange_fix; + bufextra = maxexchange + BUFEXTRA; +} + +/* ---------------------------------------------------------------------- + realloc the size of the send buffer as needed with BUFFACTOR and bufextra + flag = 0, don't need to realloc with copy, just free/malloc w/ BUFFACTOR + flag = 1, realloc with BUFFACTOR + flag = 2, free/malloc w/out BUFFACTOR + same as Comm::grow_send() ------------------------------------------------------------------------- */ void Irregular::grow_send(int n, int flag) { - maxsend = static_cast (BUFFACTOR * n); - if (flag) - memory->grow(buf_send,maxsend+BUFEXTRA,"comm:buf_send"); - else { + if (flag == 0) { + maxsend = static_cast (BUFFACTOR * n); + memory->destroy(buf_send); + memory->create(buf_send,maxsend+bufextra,"comm:buf_send"); + } else if (flag == 1) { + maxsend = static_cast (BUFFACTOR * n); + memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); + } else { memory->destroy(buf_send); - memory->create(buf_send,maxsend+BUFEXTRA,"comm:buf_send"); + memory->grow(buf_send,maxsend+bufextra,"comm:buf_send"); } } /* ---------------------------------------------------------------------- free/malloc the size of the recv buffer as needed with BUFFACTOR + same as Comm::grow_recv() ------------------------------------------------------------------------- */ void Irregular::grow_recv(int n) diff --git a/src/irregular.h b/src/irregular.h index d56bcb253d..01fe40c46b 100644 --- a/src/irregular.h +++ b/src/irregular.h @@ -43,6 +43,7 @@ class Irregular : protected Pointers { int triclinic; int map_style; + int bufextra; // augment send buf size for a migrating atom int maxsend,maxrecv; // size of buf send/recv in # of doubles double *buf_send,*buf_recv; // bufs used in migrate_atoms int maxdbuf; // size of double buf in bytes @@ -91,6 +92,7 @@ class Irregular : protected Pointers { int binary(double, int, double *); + void init_exchange(); // reset bufxtra void grow_send(int,int); // reallocate send buffer void grow_recv(int); // free/allocate recv buffer }; -- GitLab From 941607595aff199660cc3e5a1fc682e29a213a5c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 10 Jul 2019 08:48:33 -0600 Subject: [PATCH 225/469] one more change --- src/comm_tiled.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index 2e04aa2978..652bb7add9 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -101,7 +101,7 @@ void CommTiled::init() int bufextra_old = bufextra; init_exchange(); - if (bufextra > bufextra_old) grow_send(maxsend+bufextra,0); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,2); // temporary restrictions @@ -645,7 +645,7 @@ void CommTiled::exchange() if (maxexchange_fix_dynamic) { int bufextra_old = bufextra; init_exchange(); - if (bufextra > bufextra_old) grow_send(maxsend+bufextra,1); + if (bufextra > bufextra_old) grow_send(maxsend+bufextra,2); } // domain properties used in exchange method and methods it calls -- GitLab From ea68db964a3dcbdab7aec33f9e4edee404469d53 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 10 Jul 2019 14:21:07 -0500 Subject: [PATCH 226/469] trim (left and right) strings from kim_query xxxx split --- src/KIM/kim_query.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index cf4efc2b12..221dc9e804 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -138,6 +138,8 @@ void KimQuery::command(int narg, char **arg) varcmd[1] = (char *) "string"; while(std::getline(ss, token, ',')) { + token.erase(0,token.find_first_not_of(" \n\r\t")); // ltrim + token.erase(token.find_last_not_of(" \n\r\t") + 1); // rtrim std::stringstream splitname; splitname << varname << "_" << counter++; varcmd[0] = const_cast(splitname.str().c_str()); -- GitLab From 956d21ec0ead2d94220c22dd5ba97c0bbe45189f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 10 Jul 2019 15:38:41 -0400 Subject: [PATCH 227/469] update include lists in packages USER-MISC, USER-MOFF, USER-PTM, and USER-SMD --- src/USER-MISC/fix_imd.cpp | 2 -- src/USER-MISC/improper_cossq.cpp | 4 +--- src/USER-MISC/improper_distance.cpp | 4 +--- src/USER-MISC/improper_fourier.cpp | 5 +---- src/USER-MISC/improper_ring.cpp | 5 +---- src/USER-MISC/pair_agni.cpp | 6 ++---- src/USER-MISC/pair_buck_mdf.cpp | 7 ++----- src/USER-MISC/pair_coul_diel.cpp | 6 ++---- src/USER-MISC/pair_coul_shield.cpp | 5 +---- src/USER-MISC/pair_drip.cpp | 6 ++---- src/USER-MISC/pair_drip.h | 2 -- src/USER-MISC/pair_e3b.cpp | 8 +++----- src/USER-MISC/pair_edip.cpp | 4 ++-- src/USER-MISC/pair_edip_multi.cpp | 5 ++--- src/USER-MISC/pair_extep.cpp | 4 ++-- src/USER-MISC/pair_extep.h | 1 - src/USER-MISC/pair_gauss_cut.cpp | 9 ++------- src/USER-MISC/pair_ilp_graphene_hbn.cpp | 3 +-- src/USER-MISC/pair_ilp_graphene_hbn.h | 2 -- src/USER-MISC/pair_kolmogorov_crespi_full.cpp | 3 +-- src/USER-MISC/pair_kolmogorov_crespi_full.h | 2 -- src/USER-MISC/pair_kolmogorov_crespi_z.cpp | 4 ++-- src/USER-MISC/pair_lebedeva_z.cpp | 4 ++-- src/USER-MISC/pair_lennard_mdf.cpp | 6 ++---- src/USER-MISC/pair_list.cpp | 10 +++------- src/USER-MISC/pair_lj_expand_coul_long.cpp | 6 ++---- src/USER-MISC/pair_lj_mdf.cpp | 6 ++---- src/USER-MISC/pair_lj_sf_dipole_sf.cpp | 4 ++-- src/USER-MISC/pair_meam_spline.cpp | 4 +--- src/USER-MISC/pair_meam_sw_spline.cpp | 4 +--- src/USER-MISC/pair_momb.cpp | 5 ++--- src/USER-MISC/pair_morse_smooth_linear.cpp | 5 ++--- src/USER-MISC/pair_srp.cpp | 4 +++- src/USER-MISC/pair_tersoff_table.cpp | 4 ++-- src/USER-MISC/temper_grem.cpp | 7 +------ src/USER-MISC/temper_npt.cpp | 6 +----- src/USER-MOFFF/angle_class2_p6.cpp | 4 ++-- src/USER-MOFFF/angle_cosine_buck6d.cpp | 6 ++---- src/USER-MOFFF/improper_inversion_harmonic.cpp | 6 +----- src/USER-MOFFF/pair_buck6d_coul_gauss_dsf.cpp | 4 +--- src/USER-MOFFF/pair_buck6d_coul_gauss_long.cpp | 7 ++----- src/USER-PTM/compute_ptm_atom.cpp | 4 +--- src/USER-PTM/ptm_convex_hull_incremental.cpp | 1 - src/USER-PTM/ptm_index.cpp | 4 ---- src/USER-PTM/ptm_initialize_data.cpp | 8 +------- src/USER-PTM/ptm_neighbour_ordering.cpp | 5 ++--- src/USER-PTM/ptm_polar.h | 1 - src/USER-PTM/ptm_quat.cpp | 2 +- src/USER-PTM/ptm_voronoi_cell.cpp | 2 +- src/USER-PTM/ptm_voronoi_cell.h | 3 --- src/USER-SMD/atom_vec_smd.cpp | 5 +---- src/USER-SMD/compute_smd_contact_radius.cpp | 3 +-- src/USER-SMD/compute_smd_damage.cpp | 3 +-- src/USER-SMD/compute_smd_internal_energy.cpp | 1 - src/USER-SMD/compute_smd_plastic_strain.cpp | 3 +-- src/USER-SMD/compute_smd_plastic_strain_rate.cpp | 3 +-- src/USER-SMD/compute_smd_rho.cpp | 3 +-- src/USER-SMD/compute_smd_tlsph_defgrad.cpp | 8 ++------ src/USER-SMD/compute_smd_tlsph_shape.cpp | 6 +----- src/USER-SMD/compute_smd_tlsph_strain.cpp | 5 +---- src/USER-SMD/compute_smd_tlsph_stress.cpp | 3 ++- src/USER-SMD/compute_smd_triangle_vertices.cpp | 9 +-------- src/USER-SMD/compute_smd_ulsph_strain.cpp | 9 +-------- src/USER-SMD/compute_smd_ulsph_stress.cpp | 3 ++- src/USER-SMD/compute_smd_vol.cpp | 4 ++-- src/USER-SMD/fix_smd_adjust_dt.cpp | 11 ++--------- src/USER-SMD/fix_smd_integrate_tlsph.cpp | 10 ++-------- src/USER-SMD/fix_smd_integrate_ulsph.cpp | 11 +---------- src/USER-SMD/fix_smd_move_triangulated_surface.cpp | 14 ++------------ src/USER-SMD/fix_smd_setvel.cpp | 4 ++-- .../fix_smd_tlsph_reference_configuration.cpp | 6 +----- .../fix_smd_tlsph_reference_configuration.h | 1 - src/USER-SMD/fix_smd_wall_surface.cpp | 12 +++--------- src/USER-SMD/pair_smd_hertz.cpp | 7 ++----- src/USER-SMD/pair_smd_tlsph.cpp | 11 +++-------- src/USER-SMD/pair_smd_triangulated_surface.cpp | 9 ++------- src/USER-SMD/pair_smd_ulsph.cpp | 8 +------- src/USER-SMD/smd_material_models.cpp | 4 ++++ 78 files changed, 111 insertions(+), 294 deletions(-) diff --git a/src/USER-MISC/fix_imd.cpp b/src/USER-MISC/fix_imd.cpp index 1c3eafdc46..10aaa285a5 100644 --- a/src/USER-MISC/fix_imd.cpp +++ b/src/USER-MISC/fix_imd.cpp @@ -58,8 +58,6 @@ negotiate an appropriate license for such distribution." #include "group.h" #include "memory.h" -#include -#include #include #include diff --git a/src/USER-MISC/improper_cossq.cpp b/src/USER-MISC/improper_cossq.cpp index c8eb0808fb..2ea804b95d 100644 --- a/src/USER-MISC/improper_cossq.cpp +++ b/src/USER-MISC/improper_cossq.cpp @@ -16,14 +16,12 @@ gvog@chemeng.ntua.gr ------------------------------------------------------------------------- */ +#include "improper_cossq.h" #include #include -#include -#include "improper_cossq.h" #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "memory.h" diff --git a/src/USER-MISC/improper_distance.cpp b/src/USER-MISC/improper_distance.cpp index 50babcc84e..2efab8b5f8 100644 --- a/src/USER-MISC/improper_distance.cpp +++ b/src/USER-MISC/improper_distance.cpp @@ -15,16 +15,14 @@ Contributing author: Paolo Raiteri (Curtin University) ------------------------------------------------------------------------- */ +#include "improper_distance.h" #include #include -#include -#include "improper_distance.h" #include "atom.h" #include "comm.h" #include "neighbor.h" #include "domain.h" #include "force.h" -#include "update.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MISC/improper_fourier.cpp b/src/USER-MISC/improper_fourier.cpp index 288d888d12..a0ef3a2058 100644 --- a/src/USER-MISC/improper_fourier.cpp +++ b/src/USER-MISC/improper_fourier.cpp @@ -16,15 +16,12 @@ [ based on improper_umbrella.cpp Tod A Pascal (Caltech) ] ------------------------------------------------------------------------- */ +#include "improper_fourier.h" #include #include -#include -#include -#include "improper_fourier.h" #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "memory.h" diff --git a/src/USER-MISC/improper_ring.cpp b/src/USER-MISC/improper_ring.cpp index 36ba73af0f..48db5a41e9 100644 --- a/src/USER-MISC/improper_ring.cpp +++ b/src/USER-MISC/improper_ring.cpp @@ -36,16 +36,13 @@ of j. ------------------------------------------------------------------------- */ +#include "improper_ring.h" #include #include -#include -#include "improper_ring.h" #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" -#include "update.h" #include "math_const.h" #include "math_special.h" #include "memory.h" diff --git a/src/USER-MISC/pair_agni.cpp b/src/USER-MISC/pair_agni.cpp index 21a6f1deee..b3abc647ef 100644 --- a/src/USER-MISC/pair_agni.cpp +++ b/src/USER-MISC/pair_agni.cpp @@ -15,18 +15,16 @@ Contributing authors: Axel Kohlmeyer (Temple U), Venkatesh Botu ------------------------------------------------------------------------- */ +#include "pair_agni.h" +#include #include -#include #include #include -#include "pair_agni.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" #include "force.h" #include "comm.h" -#include "memory.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MISC/pair_buck_mdf.cpp b/src/USER-MISC/pair_buck_mdf.cpp index afd15d7fdb..e977197522 100644 --- a/src/USER-MISC/pair_buck_mdf.cpp +++ b/src/USER-MISC/pair_buck_mdf.cpp @@ -15,21 +15,18 @@ Contributing author: Paolo Raiteri (Curtin University) ------------------------------------------------------------------------- */ +#include "pair_buck_mdf.h" +#include #include -#include -#include #include -#include "pair_buck_mdf.h" #include "atom.h" #include "comm.h" #include "force.h" #include "neigh_list.h" -#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -using namespace MathConst; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-MISC/pair_coul_diel.cpp b/src/USER-MISC/pair_coul_diel.cpp index a86921d296..a375901ecd 100644 --- a/src/USER-MISC/pair_coul_diel.cpp +++ b/src/USER-MISC/pair_coul_diel.cpp @@ -14,11 +14,9 @@ Contributiong authors: Arben Jusufi, Axel Kohlmeyer (Temple U.) ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "pair_coul_diel.h" +#include +#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_coul_shield.cpp b/src/USER-MISC/pair_coul_shield.cpp index f74dcfe7d8..9264e51287 100644 --- a/src/USER-MISC/pair_coul_shield.cpp +++ b/src/USER-MISC/pair_coul_shield.cpp @@ -18,11 +18,8 @@ [Maaravi et al, J. Phys. Chem. C 121, 22826-22835 (2017)] ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "pair_coul_shield.h" +#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_drip.cpp b/src/USER-MISC/pair_drip.cpp index 118c033b5c..20ec3abcf9 100644 --- a/src/USER-MISC/pair_drip.cpp +++ b/src/USER-MISC/pair_drip.cpp @@ -20,19 +20,17 @@ Phys. Rev. B, 98, 235404 (2018). ------------------------------------------------------------------------- */ +#include "pair_drip.h" +#include #include -#include #include #include -#include -#include "pair_drip.h" #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "my_page.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MISC/pair_drip.h b/src/USER-MISC/pair_drip.h index 0a8f90dfc2..3ea6c735a6 100644 --- a/src/USER-MISC/pair_drip.h +++ b/src/USER-MISC/pair_drip.h @@ -31,8 +31,6 @@ PairStyle(drip, PairDRIP) #define LMP_PAIR_DRIP_H #include "pair.h" -#include "my_page.h" -#include namespace LAMMPS_NS { diff --git a/src/USER-MISC/pair_e3b.cpp b/src/USER-MISC/pair_e3b.cpp index 43b472594a..aa19849baa 100644 --- a/src/USER-MISC/pair_e3b.cpp +++ b/src/USER-MISC/pair_e3b.cpp @@ -14,16 +14,14 @@ contact: stevene.strong at gmail dot com ------------------------------------------------------------------------- */ +#include "pair_e3b.h" +#include #include -#include -#include #include - -#include "pair_e3b.h" +#include #include "atom.h" #include "neighbor.h" -#include "neigh_request.h" #include "neigh_list.h" #include "force.h" #include "comm.h" diff --git a/src/USER-MISC/pair_edip.cpp b/src/USER-MISC/pair_edip.cpp index 0b5220fdfd..8dee4a606b 100644 --- a/src/USER-MISC/pair_edip.cpp +++ b/src/USER-MISC/pair_edip.cpp @@ -21,12 +21,12 @@ Phys. Rev. B 58, 2539 (1998) ------------------------------------------------------------------------- */ +#include "pair_edip.h" +#include #include #include -#include #include #include -#include "pair_edip.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-MISC/pair_edip_multi.cpp b/src/USER-MISC/pair_edip_multi.cpp index ab48fbaa73..9f953610de 100644 --- a/src/USER-MISC/pair_edip_multi.cpp +++ b/src/USER-MISC/pair_edip_multi.cpp @@ -17,12 +17,11 @@ Contributing author: Chao Jiang ------------------------------------------------------------------------- */ +#include "pair_edip_multi.h" +#include #include -#include -#include #include #include -#include "pair_edip_multi.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-MISC/pair_extep.cpp b/src/USER-MISC/pair_extep.cpp index bd5da71f4a..8507fd49f6 100644 --- a/src/USER-MISC/pair_extep.cpp +++ b/src/USER-MISC/pair_extep.cpp @@ -15,12 +15,12 @@ Contributing author: Jan Los ------------------------------------------------------------------------- */ +#include "pair_extep.h" +#include #include -#include #include #include #include -#include "pair_extep.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-MISC/pair_extep.h b/src/USER-MISC/pair_extep.h index 535e7261e3..1f127b71e0 100644 --- a/src/USER-MISC/pair_extep.h +++ b/src/USER-MISC/pair_extep.h @@ -21,7 +21,6 @@ PairStyle(extep,PairExTeP) #define LMP_PAIR_EXTEP_H #include "pair.h" -#include "my_page.h" #define MAXTYPES 8 #define NSPLINE 5 diff --git a/src/USER-MISC/pair_gauss_cut.cpp b/src/USER-MISC/pair_gauss_cut.cpp index 24d0b191d8..e6cfc02f63 100644 --- a/src/USER-MISC/pair_gauss_cut.cpp +++ b/src/USER-MISC/pair_gauss_cut.cpp @@ -15,18 +15,13 @@ Contributing authors: Arben Jusufi, Axel Kohlmeyer (Temple U.) ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "pair_gauss_cut.h" +#include +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" -#include "update.h" -#include "integrate.h" #include "memory.h" #include "error.h" #include "math_const.h" diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.cpp b/src/USER-MISC/pair_ilp_graphene_hbn.cpp index a41c660b7b..b94db6a871 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.cpp +++ b/src/USER-MISC/pair_ilp_graphene_hbn.cpp @@ -20,12 +20,11 @@ [Kolmogorov & Crespi, Phys. Rev. B 71, 235415 (2005)] ------------------------------------------------------------------------- */ +#include "pair_ilp_graphene_hbn.h" #include #include -#include #include #include -#include "pair_ilp_graphene_hbn.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.h b/src/USER-MISC/pair_ilp_graphene_hbn.h index 07c3b2e97b..ae4662cdc5 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.h +++ b/src/USER-MISC/pair_ilp_graphene_hbn.h @@ -21,8 +21,6 @@ PairStyle(ilp/graphene/hbn,PairILPGrapheneHBN) #define LMP_PAIR_ILP_GRAPHENE_HBN_H #include "pair.h" -#include "my_page.h" -#include namespace LAMMPS_NS { diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp index e73278968d..0009531ca8 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp @@ -20,12 +20,11 @@ [Kolmogorov & Crespi, Phys. Rev. B 71, 235415 (2005)] ------------------------------------------------------------------------- */ +#include "pair_kolmogorov_crespi_full.h" #include -#include #include #include #include -#include "pair_kolmogorov_crespi_full.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.h b/src/USER-MISC/pair_kolmogorov_crespi_full.h index 9923b409a7..68dede0dd5 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.h +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.h @@ -21,8 +21,6 @@ PairStyle(kolmogorov/crespi/full,PairKolmogorovCrespiFull) #define LMP_PAIR_KolmogorovCrespi_FULL_H #include "pair.h" -#include "my_page.h" -#include namespace LAMMPS_NS { diff --git a/src/USER-MISC/pair_kolmogorov_crespi_z.cpp b/src/USER-MISC/pair_kolmogorov_crespi_z.cpp index 79d6aa3daf..61c326ac87 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_z.cpp +++ b/src/USER-MISC/pair_kolmogorov_crespi_z.cpp @@ -21,11 +21,11 @@ The simplification is that all normals are taken along the z-direction ------------------------------------------------------------------------- */ +#include "pair_kolmogorov_crespi_z.h" +#include #include -#include #include #include -#include "pair_kolmogorov_crespi_z.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_lebedeva_z.cpp b/src/USER-MISC/pair_lebedeva_z.cpp index c9d90e2850..8930042cef 100644 --- a/src/USER-MISC/pair_lebedeva_z.cpp +++ b/src/USER-MISC/pair_lebedeva_z.cpp @@ -22,11 +22,11 @@ [Lebedeva et al., Physica E, 44(6), 949-954, 2012.] ------------------------------------------------------------------------- */ +#include "pair_lebedeva_z.h" +#include #include -#include #include #include -#include "pair_lebedeva_z.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_lennard_mdf.cpp b/src/USER-MISC/pair_lennard_mdf.cpp index e2e81e4943..50f59107a0 100644 --- a/src/USER-MISC/pair_lennard_mdf.cpp +++ b/src/USER-MISC/pair_lennard_mdf.cpp @@ -16,15 +16,13 @@ Contributing author: Paolo Raiteri (Curtin University) ------------------------------------------------------------------------- */ +#include "pair_lennard_mdf.h" +#include #include -#include -#include #include -#include "pair_lennard_mdf.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MISC/pair_list.cpp b/src/USER-MISC/pair_list.cpp index 562a60aa99..2f4e886a61 100644 --- a/src/USER-MISC/pair_list.cpp +++ b/src/USER-MISC/pair_list.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "pair_list.h" +#include +#include +#include #include "atom.h" #include "comm.h" -#include "domain.h" #include "force.h" #include "memory.h" - #include "error.h" -#include -#include -#include -#include - using namespace LAMMPS_NS; static const char * const stylename[] = { diff --git a/src/USER-MISC/pair_lj_expand_coul_long.cpp b/src/USER-MISC/pair_lj_expand_coul_long.cpp index fe21538f2d..ffa828826f 100644 --- a/src/USER-MISC/pair_lj_expand_coul_long.cpp +++ b/src/USER-MISC/pair_lj_expand_coul_long.cpp @@ -15,17 +15,15 @@ Contributing author: Trung Nguyen (Northwestern) ------------------------------------------------------------------------- */ +#include "pair_lj_expand_coul_long.h" +#include #include -#include -#include #include -#include "pair_lj_expand_coul_long.h" #include "atom.h" #include "comm.h" #include "force.h" #include "kspace.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-MISC/pair_lj_mdf.cpp b/src/USER-MISC/pair_lj_mdf.cpp index cfe125f21f..3fe0fa6bf9 100644 --- a/src/USER-MISC/pair_lj_mdf.cpp +++ b/src/USER-MISC/pair_lj_mdf.cpp @@ -16,15 +16,13 @@ Contributing author: Paolo Raiteri (Curtin University) ------------------------------------------------------------------------- */ +#include "pair_lj_mdf.h" +#include #include -#include -#include #include -#include "pair_lj_mdf.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MISC/pair_lj_sf_dipole_sf.cpp b/src/USER-MISC/pair_lj_sf_dipole_sf.cpp index af7d23370d..758962ce29 100644 --- a/src/USER-MISC/pair_lj_sf_dipole_sf.cpp +++ b/src/USER-MISC/pair_lj_sf_dipole_sf.cpp @@ -16,10 +16,10 @@ Samuel Genheden (University of Southampton) ------------------------------------------------------------------------- */ +#include "pair_lj_sf_dipole_sf.h" +#include #include -#include #include -#include "pair_lj_sf_dipole_sf.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-MISC/pair_meam_spline.cpp b/src/USER-MISC/pair_meam_spline.cpp index f09919ce0f..79e7ac7e09 100644 --- a/src/USER-MISC/pair_meam_spline.cpp +++ b/src/USER-MISC/pair_meam_spline.cpp @@ -31,15 +31,13 @@ conform with pairing, updated to LAMMPS style ------------------------------------------------------------------------- */ +#include "pair_meam_spline.h" #include -#include #include #include -#include "pair_meam_spline.h" #include "atom.h" #include "force.h" #include "comm.h" -#include "memory.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/USER-MISC/pair_meam_sw_spline.cpp b/src/USER-MISC/pair_meam_sw_spline.cpp index af1e8788bd..eeadacf33a 100644 --- a/src/USER-MISC/pair_meam_sw_spline.cpp +++ b/src/USER-MISC/pair_meam_sw_spline.cpp @@ -23,15 +23,13 @@ * 01-Aug-12 - RER: First code version. ------------------------------------------------------------------------- */ +#include "pair_meam_sw_spline.h" #include -#include #include #include -#include "pair_meam_sw_spline.h" #include "atom.h" #include "force.h" #include "comm.h" -#include "memory.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/USER-MISC/pair_momb.cpp b/src/USER-MISC/pair_momb.cpp index 1716149a98..29d5715302 100644 --- a/src/USER-MISC/pair_momb.cpp +++ b/src/USER-MISC/pair_momb.cpp @@ -16,10 +16,9 @@ Ya Zhou (Penn State University) ------------------------------------------------------------------------- */ -#include -#include -#include #include "pair_momb.h" +#include +#include #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_morse_smooth_linear.cpp b/src/USER-MISC/pair_morse_smooth_linear.cpp index 7c7973f830..c3cbe39db7 100644 --- a/src/USER-MISC/pair_morse_smooth_linear.cpp +++ b/src/USER-MISC/pair_morse_smooth_linear.cpp @@ -11,11 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_morse_smooth_linear.h" +#include #include -#include -#include #include -#include "pair_morse_smooth_linear.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_srp.cpp b/src/USER-MISC/pair_srp.cpp index 01deaf0fbe..416ace8132 100644 --- a/src/USER-MISC/pair_srp.cpp +++ b/src/USER-MISC/pair_srp.cpp @@ -25,9 +25,11 @@ There is an example script for this package in examples/USER/srp. Please contact Timothy Sirk for questions (tim.sirk@us.army.mil). ------------------------------------------------------------------------- */ +#include "pair_srp.h" +#include +#include #include #include -#include "pair_srp.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_tersoff_table.cpp b/src/USER-MISC/pair_tersoff_table.cpp index e0985d1dce..5c4f60f354 100644 --- a/src/USER-MISC/pair_tersoff_table.cpp +++ b/src/USER-MISC/pair_tersoff_table.cpp @@ -20,11 +20,11 @@ 1) Tersoff, Phys. Rev. B 39, 5566 (1988) ------------------------------------------------------------------------- */ +#include "pair_tersoff_table.h" +#include #include -#include #include #include -#include "pair_tersoff_table.h" #include "atom.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-MISC/temper_grem.cpp b/src/USER-MISC/temper_grem.cpp index 031a449689..d0e2fa5606 100644 --- a/src/USER-MISC/temper_grem.cpp +++ b/src/USER-MISC/temper_grem.cpp @@ -15,26 +15,21 @@ Contributing author: David Stelter (BU) ------------------------------------------------------------------------- */ +#include "temper_grem.h" #include -#include #include -#include "temper_grem.h" #include "fix_grem.h" #include "universe.h" #include "domain.h" -#include "atom.h" #include "update.h" #include "integrate.h" #include "modify.h" #include "compute.h" #include "force.h" -#include "output.h" -#include "thermo.h" #include "fix.h" #include "random_park.h" #include "finish.h" #include "timer.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-MISC/temper_npt.cpp b/src/USER-MISC/temper_npt.cpp index 7cf8fbab9b..9fd4bd6d06 100644 --- a/src/USER-MISC/temper_npt.cpp +++ b/src/USER-MISC/temper_npt.cpp @@ -17,10 +17,9 @@ Contact Email: amulyapervaje@gmail.com ------------------------------------------------------------------------- */ +#include "temper_npt.h" #include -#include #include -#include "temper_npt.h" #include "universe.h" #include "domain.h" #include "atom.h" @@ -29,13 +28,10 @@ #include "modify.h" #include "compute.h" #include "force.h" -#include "output.h" -#include "thermo.h" #include "fix.h" #include "random_park.h" #include "finish.h" #include "timer.h" -#include "memory.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-MOFFF/angle_class2_p6.cpp b/src/USER-MOFFF/angle_class2_p6.cpp index e8e6f279de..bb0a01d546 100644 --- a/src/USER-MOFFF/angle_class2_p6.cpp +++ b/src/USER-MOFFF/angle_class2_p6.cpp @@ -16,10 +16,10 @@ and Rochus Schmid (Ruhr-Universitaet Bochum) ------------------------------------------------------------------------- */ +#include "angle_class2_p6.h" +#include #include #include -#include -#include "angle_class2_p6.h" #include "atom.h" #include "neighbor.h" #include "domain.h" diff --git a/src/USER-MOFFF/angle_cosine_buck6d.cpp b/src/USER-MOFFF/angle_cosine_buck6d.cpp index 3829d2b8dc..c17b2a1dba 100644 --- a/src/USER-MOFFF/angle_cosine_buck6d.cpp +++ b/src/USER-MOFFF/angle_cosine_buck6d.cpp @@ -16,9 +16,9 @@ and Rochus Schmid (Ruhr-Universitaet Bochum) ------------------------------------------------------------------------- */ -#include -#include #include "angle_cosine_buck6d.h" +#include +#include #include "atom.h" #include "neighbor.h" #include "domain.h" @@ -26,13 +26,11 @@ #include "force.h" #include "pair.h" #include "math_const.h" -#include "math_special.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; using namespace MathConst; -using namespace MathSpecial; #define SMALL 0.001 diff --git a/src/USER-MOFFF/improper_inversion_harmonic.cpp b/src/USER-MOFFF/improper_inversion_harmonic.cpp index 3f1e61e54a..12f7062ccc 100644 --- a/src/USER-MOFFF/improper_inversion_harmonic.cpp +++ b/src/USER-MOFFF/improper_inversion_harmonic.cpp @@ -19,17 +19,13 @@ [ abbreviated from and verified via DLPOLY2.0 ] ------------------------------------------------------------------------- */ +#include "improper_inversion_harmonic.h" #include #include -#include -#include -#include "improper_inversion_harmonic.h" #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" -#include "update.h" #include "math_const.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MOFFF/pair_buck6d_coul_gauss_dsf.cpp b/src/USER-MOFFF/pair_buck6d_coul_gauss_dsf.cpp index 282bb0c58f..9c917d1c19 100644 --- a/src/USER-MOFFF/pair_buck6d_coul_gauss_dsf.cpp +++ b/src/USER-MOFFF/pair_buck6d_coul_gauss_dsf.cpp @@ -18,11 +18,9 @@ Fennell and Gezelter, JCP 124, 234104 (2006) ------------------------------------------------------------------------- */ +#include "pair_buck6d_coul_gauss_dsf.h" #include -#include -#include #include -#include "pair_buck6d_coul_gauss_dsf.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MOFFF/pair_buck6d_coul_gauss_long.cpp b/src/USER-MOFFF/pair_buck6d_coul_gauss_long.cpp index d6a4121d21..953507ce21 100644 --- a/src/USER-MOFFF/pair_buck6d_coul_gauss_long.cpp +++ b/src/USER-MOFFF/pair_buck6d_coul_gauss_long.cpp @@ -17,11 +17,10 @@ References: Bureekaew and Schmid, Phys. Status Solidi B 250, 1128 (2013) ------------------------------------------------------------------------- */ +#include "pair_buck6d_coul_gauss_long.h" +#include #include -#include -#include #include -#include "pair_buck6d_coul_gauss_long.h" #include "atom.h" #include "comm.h" #include "force.h" @@ -29,12 +28,10 @@ #include "neighbor.h" #include "neigh_list.h" #include "memory.h" -#include "math_const.h" #include "error.h" #include "math_special.h" using namespace LAMMPS_NS; -using namespace MathConst; #define EWALD_F 1.12837917 diff --git a/src/USER-PTM/compute_ptm_atom.cpp b/src/USER-PTM/compute_ptm_atom.cpp index 41e6540b97..ad3d3facdb 100644 --- a/src/USER-PTM/compute_ptm_atom.cpp +++ b/src/USER-PTM/compute_ptm_atom.cpp @@ -16,15 +16,14 @@ under Contributing author: PM Larsen (MIT) ------------------------------------------------------------------------- */ +#include "compute_ptm_atom.h" #include #include -#include #include #include #include "atom.h" #include "comm.h" -#include "compute_ptm_atom.h" #include "error.h" #include "force.h" #include "memory.h" @@ -32,7 +31,6 @@ under #include "neigh_list.h" #include "neigh_request.h" #include "neighbor.h" -#include "pair.h" #include "update.h" #include "ptm_functions.h" diff --git a/src/USER-PTM/ptm_convex_hull_incremental.cpp b/src/USER-PTM/ptm_convex_hull_incremental.cpp index 45643ec515..8dd06e8168 100644 --- a/src/USER-PTM/ptm_convex_hull_incremental.cpp +++ b/src/USER-PTM/ptm_convex_hull_incremental.cpp @@ -11,7 +11,6 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI #include #include #include -#include #include "ptm_convex_hull_incremental.h" #include "ptm_constants.h" diff --git a/src/USER-PTM/ptm_index.cpp b/src/USER-PTM/ptm_index.cpp index 3068e7a7f6..b50e5c4333 100644 --- a/src/USER-PTM/ptm_index.cpp +++ b/src/USER-PTM/ptm_index.cpp @@ -12,19 +12,15 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI #include "ptm_convex_hull_incremental.h" #include "ptm_deformation_gradient.h" #include "ptm_functions.h" -#include "ptm_graph_data.h" #include "ptm_initialize_data.h" #include "ptm_neighbour_ordering.h" #include "ptm_normalize_vertices.h" #include "ptm_polar.h" #include "ptm_quat.h" #include "ptm_structure_matcher.h" -#include #include -#include #include #include -#include #include static double calculate_interatomic_distance(int type, double scale) { diff --git a/src/USER-PTM/ptm_initialize_data.cpp b/src/USER-PTM/ptm_initialize_data.cpp index 49dc6f2323..1f0a5c94af 100644 --- a/src/USER-PTM/ptm_initialize_data.cpp +++ b/src/USER-PTM/ptm_initialize_data.cpp @@ -7,14 +7,8 @@ The above copyright notice and this permission notice shall be included in all c THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ -#include -#include -#include -#include -#include -#include -#include #include "ptm_initialize_data.h" +#include static void make_facets_clockwise(int num_facets, int8_t (*facets)[3], const double (*points)[3]) diff --git a/src/USER-PTM/ptm_neighbour_ordering.cpp b/src/USER-PTM/ptm_neighbour_ordering.cpp index cb72a43711..1332b8819b 100644 --- a/src/USER-PTM/ptm_neighbour_ordering.cpp +++ b/src/USER-PTM/ptm_neighbour_ordering.cpp @@ -9,16 +9,15 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI //todo: normalize vertices -#include +#include "ptm_neighbour_ordering.h" #include #include #include #include #include +#include #include "ptm_constants.h" #include "ptm_voronoi_cell.h" -#include "ptm_neighbour_ordering.h" -#include "ptm_normalize_vertices.h" namespace ptm { diff --git a/src/USER-PTM/ptm_polar.h b/src/USER-PTM/ptm_polar.h index e03963048b..f11dd98ee9 100644 --- a/src/USER-PTM/ptm_polar.h +++ b/src/USER-PTM/ptm_polar.h @@ -11,7 +11,6 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI #define PTM_POLAR_H #include -#include namespace ptm { diff --git a/src/USER-PTM/ptm_quat.cpp b/src/USER-PTM/ptm_quat.cpp index 4a93499b3a..527f4d1116 100644 --- a/src/USER-PTM/ptm_quat.cpp +++ b/src/USER-PTM/ptm_quat.cpp @@ -7,9 +7,9 @@ The above copyright notice and this permission notice shall be included in all c THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ +#include "ptm_quat.h" #include #include -#include #include diff --git a/src/USER-PTM/ptm_voronoi_cell.cpp b/src/USER-PTM/ptm_voronoi_cell.cpp index dfe61eb24f..dc4ce4e747 100644 --- a/src/USER-PTM/ptm_voronoi_cell.cpp +++ b/src/USER-PTM/ptm_voronoi_cell.cpp @@ -52,7 +52,7 @@ such enhancements or derivative works thereof, in binary and source code form. * \brief Function implementations for the voronoicell and related classes. */ #include -#include +#include #include #include "ptm_voronoi_config.h" #include "ptm_voronoi_cell.h" diff --git a/src/USER-PTM/ptm_voronoi_cell.h b/src/USER-PTM/ptm_voronoi_cell.h index eb091dd36b..69e3b5bdc4 100644 --- a/src/USER-PTM/ptm_voronoi_cell.h +++ b/src/USER-PTM/ptm_voronoi_cell.h @@ -56,9 +56,6 @@ such enhancements or derivative works thereof, in binary and source code form. #define PTM_VOROPP_CELL_HH #include -#include - -#include "ptm_voronoi_config.h" namespace ptm_voro { diff --git a/src/USER-SMD/atom_vec_smd.cpp b/src/USER-SMD/atom_vec_smd.cpp index 93a6f1308f..604504c5a7 100644 --- a/src/USER-SMD/atom_vec_smd.cpp +++ b/src/USER-SMD/atom_vec_smd.cpp @@ -23,21 +23,18 @@ ------------------------------------------------------------------------- */ #include "atom_vec_smd.h" -#include #include #include "atom.h" #include "comm.h" #include "domain.h" #include "modify.h" #include "fix.h" -#include "fix_adapt.h" -#include "math_const.h" #include "memory.h" #include "error.h" #include "utils.h" using namespace LAMMPS_NS; -using namespace MathConst; + #define NMAT_FULL 9 #define NMAT_SYMM 6 diff --git a/src/USER-SMD/compute_smd_contact_radius.cpp b/src/USER-SMD/compute_smd_contact_radius.cpp index 8193ad6ccf..46cbc602f2 100644 --- a/src/USER-SMD/compute_smd_contact_radius.cpp +++ b/src/USER-SMD/compute_smd_contact_radius.cpp @@ -23,13 +23,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_smd_contact_radius.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/compute_smd_damage.cpp b/src/USER-SMD/compute_smd_damage.cpp index 9603fd5c64..96a936cd82 100644 --- a/src/USER-SMD/compute_smd_damage.cpp +++ b/src/USER-SMD/compute_smd_damage.cpp @@ -23,13 +23,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_smd_damage.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/compute_smd_internal_energy.cpp b/src/USER-SMD/compute_smd_internal_energy.cpp index d937aa98a4..f88da8bc33 100644 --- a/src/USER-SMD/compute_smd_internal_energy.cpp +++ b/src/USER-SMD/compute_smd_internal_energy.cpp @@ -29,7 +29,6 @@ #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/compute_smd_plastic_strain.cpp b/src/USER-SMD/compute_smd_plastic_strain.cpp index 67466ebb72..c1c001a5dd 100644 --- a/src/USER-SMD/compute_smd_plastic_strain.cpp +++ b/src/USER-SMD/compute_smd_plastic_strain.cpp @@ -23,13 +23,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_smd_plastic_strain.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/compute_smd_plastic_strain_rate.cpp b/src/USER-SMD/compute_smd_plastic_strain_rate.cpp index 20dfa64edd..272a2c59e5 100644 --- a/src/USER-SMD/compute_smd_plastic_strain_rate.cpp +++ b/src/USER-SMD/compute_smd_plastic_strain_rate.cpp @@ -23,13 +23,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_smd_plastic_strain_rate.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/compute_smd_rho.cpp b/src/USER-SMD/compute_smd_rho.cpp index 5c78e604b6..d9c0a99b07 100644 --- a/src/USER-SMD/compute_smd_rho.cpp +++ b/src/USER-SMD/compute_smd_rho.cpp @@ -22,13 +22,12 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_smd_rho.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/compute_smd_tlsph_defgrad.cpp b/src/USER-SMD/compute_smd_tlsph_defgrad.cpp index 37ad78dcea..09aeeea74a 100644 --- a/src/USER-SMD/compute_smd_tlsph_defgrad.cpp +++ b/src/USER-SMD/compute_smd_tlsph_defgrad.cpp @@ -22,20 +22,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include "compute_smd_tlsph_defgrad.h" #include -#include #include -#include "compute_smd_tlsph_defgrad.h" #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" -#include "pair.h" + using namespace Eigen; using namespace std; using namespace LAMMPS_NS; diff --git a/src/USER-SMD/compute_smd_tlsph_shape.cpp b/src/USER-SMD/compute_smd_tlsph_shape.cpp index bbab274b5c..ba1a9306ef 100644 --- a/src/USER-SMD/compute_smd_tlsph_shape.cpp +++ b/src/USER-SMD/compute_smd_tlsph_shape.cpp @@ -22,13 +22,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include "compute_smd_tlsph_shape.h" #include -#include #include -#include -#include "compute_smd_tlsph_shape.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/USER-SMD/compute_smd_tlsph_strain.cpp b/src/USER-SMD/compute_smd_tlsph_strain.cpp index a94a3cd511..f0061bf7a1 100644 --- a/src/USER-SMD/compute_smd_tlsph_strain.cpp +++ b/src/USER-SMD/compute_smd_tlsph_strain.cpp @@ -23,12 +23,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include "compute_smd_tlsph_strain.h" #include -#include #include -#include "compute_smd_tlsph_strain.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/USER-SMD/compute_smd_tlsph_stress.cpp b/src/USER-SMD/compute_smd_tlsph_stress.cpp index a54b07dd1e..9c78b192ce 100644 --- a/src/USER-SMD/compute_smd_tlsph_stress.cpp +++ b/src/USER-SMD/compute_smd_tlsph_stress.cpp @@ -22,9 +22,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_smd_tlsph_stress.h" +#include #include #include -#include "compute_smd_tlsph_stress.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/USER-SMD/compute_smd_triangle_vertices.cpp b/src/USER-SMD/compute_smd_triangle_vertices.cpp index b24223b8b5..06706a85ad 100644 --- a/src/USER-SMD/compute_smd_triangle_vertices.cpp +++ b/src/USER-SMD/compute_smd_triangle_vertices.cpp @@ -23,22 +23,15 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include -#include -#include #include "compute_smd_triangle_vertices.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" -#include "pair.h" -using namespace Eigen; using namespace std; using namespace LAMMPS_NS; diff --git a/src/USER-SMD/compute_smd_ulsph_strain.cpp b/src/USER-SMD/compute_smd_ulsph_strain.cpp index 89b85f7bc1..cf1535759c 100644 --- a/src/USER-SMD/compute_smd_ulsph_strain.cpp +++ b/src/USER-SMD/compute_smd_ulsph_strain.cpp @@ -23,22 +23,15 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include -#include -#include #include "compute_smd_ulsph_strain.h" +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" -#include "pair.h" -using namespace Eigen; using namespace std; using namespace LAMMPS_NS; diff --git a/src/USER-SMD/compute_smd_ulsph_stress.cpp b/src/USER-SMD/compute_smd_ulsph_stress.cpp index 7f1bbc4c29..ea477375ce 100644 --- a/src/USER-SMD/compute_smd_ulsph_stress.cpp +++ b/src/USER-SMD/compute_smd_ulsph_stress.cpp @@ -22,9 +22,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_smd_ulsph_stress.h" +#include #include #include -#include "compute_smd_ulsph_stress.h" #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/USER-SMD/compute_smd_vol.cpp b/src/USER-SMD/compute_smd_vol.cpp index 17a6b556e8..eb1f144275 100644 --- a/src/USER-SMD/compute_smd_vol.cpp +++ b/src/USER-SMD/compute_smd_vol.cpp @@ -22,13 +22,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "compute_smd_vol.h" +#include +#include #include "atom.h" #include "update.h" #include "modify.h" #include "comm.h" -#include "force.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/fix_smd_adjust_dt.cpp b/src/USER-SMD/fix_smd_adjust_dt.cpp index f015c6c4df..ab6dd5ef5c 100644 --- a/src/USER-SMD/fix_smd_adjust_dt.cpp +++ b/src/USER-SMD/fix_smd_adjust_dt.cpp @@ -22,21 +22,14 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include #include "fix_smd_adjust_dt.h" -#include "atom.h" +#include +#include #include "update.h" -#include "integrate.h" -#include "domain.h" -#include "lattice.h" #include "force.h" #include "pair.h" #include "modify.h" #include "fix.h" -#include "output.h" -#include "dump.h" #include "comm.h" #include "error.h" diff --git a/src/USER-SMD/fix_smd_integrate_tlsph.cpp b/src/USER-SMD/fix_smd_integrate_tlsph.cpp index f931ae94ff..8464bed609 100644 --- a/src/USER-SMD/fix_smd_integrate_tlsph.cpp +++ b/src/USER-SMD/fix_smd_integrate_tlsph.cpp @@ -22,22 +22,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include "fix_smd_integrate_tlsph.h" +#include #include -#include #include -#include "fix_smd_integrate_tlsph.h" #include "atom.h" #include "force.h" #include "update.h" #include "error.h" #include "pair.h" -#include "neigh_list.h" -#include "domain.h" -#include "neighbor.h" #include "comm.h" -#include "modify.h" using namespace Eigen; using namespace LAMMPS_NS; diff --git a/src/USER-SMD/fix_smd_integrate_ulsph.cpp b/src/USER-SMD/fix_smd_integrate_ulsph.cpp index 6c4705eb96..0f0d224f95 100644 --- a/src/USER-SMD/fix_smd_integrate_ulsph.cpp +++ b/src/USER-SMD/fix_smd_integrate_ulsph.cpp @@ -22,25 +22,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include +#include "fix_smd_integrate_ulsph.h" #include -#include #include #include -#include "fix_smd_integrate_ulsph.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "update.h" -#include "integrate.h" -#include "respa.h" -#include "memory.h" #include "error.h" #include "pair.h" -#include "domain.h" using namespace Eigen; using namespace LAMMPS_NS; diff --git a/src/USER-SMD/fix_smd_move_triangulated_surface.cpp b/src/USER-SMD/fix_smd_move_triangulated_surface.cpp index fe8695b23e..cbaad9ac4c 100644 --- a/src/USER-SMD/fix_smd_move_triangulated_surface.cpp +++ b/src/USER-SMD/fix_smd_move_triangulated_surface.cpp @@ -22,25 +22,15 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include +#include "fix_smd_move_triangulated_surface.h" #include -#include +#include #include -#include "fix_smd_move_triangulated_surface.h" #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" #include "update.h" -#include "integrate.h" -#include "respa.h" -#include "memory.h" #include "error.h" -#include "pair.h" -#include "domain.h" #include "math_const.h" using namespace Eigen; diff --git a/src/USER-SMD/fix_smd_setvel.cpp b/src/USER-SMD/fix_smd_setvel.cpp index 4bc8b5127b..2964ded544 100644 --- a/src/USER-SMD/fix_smd_setvel.cpp +++ b/src/USER-SMD/fix_smd_setvel.cpp @@ -23,9 +23,9 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "fix_smd_setvel.h" +#include +#include #include "atom.h" #include "update.h" #include "modify.h" diff --git a/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp b/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp index a2813cc3ca..6aa23fe3b2 100644 --- a/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp +++ b/src/USER-SMD/fix_smd_tlsph_reference_configuration.cpp @@ -24,20 +24,16 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "fix_smd_tlsph_reference_configuration.h" #include -#include -#include #include -#include "fix_smd_tlsph_reference_configuration.h" #include "atom.h" #include "comm.h" -#include "neighbor.h" #include "neigh_list.h" #include "lattice.h" #include "force.h" #include "pair.h" #include "update.h" -#include "modify.h" #include "memory.h" #include "error.h" #include "domain.h" diff --git a/src/USER-SMD/fix_smd_tlsph_reference_configuration.h b/src/USER-SMD/fix_smd_tlsph_reference_configuration.h index 8549621c2f..5f952bde93 100644 --- a/src/USER-SMD/fix_smd_tlsph_reference_configuration.h +++ b/src/USER-SMD/fix_smd_tlsph_reference_configuration.h @@ -35,7 +35,6 @@ FixStyle(SMD_TLSPH_NEIGHBORS,FixSMD_TLSPH_ReferenceConfiguration) #define LMP_FIX_SMD_TLSPH_REFERENCE_H #include "fix.h" -#include "my_page.h" namespace LAMMPS_NS { diff --git a/src/USER-SMD/fix_smd_wall_surface.cpp b/src/USER-SMD/fix_smd_wall_surface.cpp index a37ba67a80..9183bcd9ea 100644 --- a/src/USER-SMD/fix_smd_wall_surface.cpp +++ b/src/USER-SMD/fix_smd_wall_surface.cpp @@ -15,21 +15,15 @@ Contributing authors: Mike Parks (SNL), Ezwanur Rahman, J.T. Foster (UTSA) ------------------------------------------------------------------------- */ -#include +#include "fix_smd_wall_surface.h" +#include #include -#include +#include #include -#include "fix_smd_wall_surface.h" #include "atom.h" #include "domain.h" #include "force.h" #include "comm.h" -#include "update.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" -#include "pair.h" -#include "lattice.h" #include "memory.h" #include "error.h" #include "atom_vec.h" diff --git a/src/USER-SMD/pair_smd_hertz.cpp b/src/USER-SMD/pair_smd_hertz.cpp index 541be9f05c..97be94d833 100644 --- a/src/USER-SMD/pair_smd_hertz.cpp +++ b/src/USER-SMD/pair_smd_hertz.cpp @@ -26,17 +26,14 @@ Contributing author: Mike Parks (SNL) ------------------------------------------------------------------------- */ +#include "pair_smd_hertz.h" +#include #include -#include #include #include -#include "pair_smd_hertz.h" #include "atom.h" #include "domain.h" #include "force.h" -#include "update.h" -#include "modify.h" -#include "fix.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-SMD/pair_smd_tlsph.cpp b/src/USER-SMD/pair_smd_tlsph.cpp index 1d7bbca780..0dff905962 100644 --- a/src/USER-SMD/pair_smd_tlsph.cpp +++ b/src/USER-SMD/pair_smd_tlsph.cpp @@ -22,15 +22,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_smd_tlsph.h" +#include #include -#include -#include #include -#include +#include #include -#include #include -#include "pair_smd_tlsph.h" #include "fix_smd_tlsph_reference_configuration.h" #include "atom.h" #include "domain.h" @@ -41,12 +39,9 @@ #include "fix.h" #include "comm.h" #include "neighbor.h" -#include "neigh_list.h" #include "neigh_request.h" #include "memory.h" #include "error.h" -#include "math_special.h" -#include "update.h" #include "smd_material_models.h" #include "smd_kernels.h" #include "smd_math.h" diff --git a/src/USER-SMD/pair_smd_triangulated_surface.cpp b/src/USER-SMD/pair_smd_triangulated_surface.cpp index d3a4983379..f9052be087 100644 --- a/src/USER-SMD/pair_smd_triangulated_surface.cpp +++ b/src/USER-SMD/pair_smd_triangulated_surface.cpp @@ -26,20 +26,15 @@ Contributing author: Mike Parks (SNL) ------------------------------------------------------------------------- */ +#include "pair_smd_triangulated_surface.h" +#include #include -#include #include #include -#include -#include #include -#include "pair_smd_triangulated_surface.h" #include "atom.h" #include "domain.h" #include "force.h" -#include "update.h" -#include "modify.h" -#include "fix.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-SMD/pair_smd_ulsph.cpp b/src/USER-SMD/pair_smd_ulsph.cpp index 2c4a2de989..9e824ded3c 100644 --- a/src/USER-SMD/pair_smd_ulsph.cpp +++ b/src/USER-SMD/pair_smd_ulsph.cpp @@ -22,19 +22,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "pair_smd_ulsph.h" #include -#include -#include #include -#include -#include -#include "pair_smd_ulsph.h" #include "atom.h" #include "domain.h" #include "force.h" #include "update.h" -#include "modify.h" -#include "fix.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" diff --git a/src/USER-SMD/smd_material_models.cpp b/src/USER-SMD/smd_material_models.cpp index 4213428872..5ee67fbb4e 100644 --- a/src/USER-SMD/smd_material_models.cpp +++ b/src/USER-SMD/smd_material_models.cpp @@ -21,6 +21,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "smd_material_models.h" +#include +#include +#include #include #include #include "math_special.h" -- GitLab From 39873fb7a3367367a6bba05fe4dffdf2dbd11cd8 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Wed, 10 Jul 2019 16:53:26 -0600 Subject: [PATCH 228/469] Fix issue in Kokkos neigh list when using half-from-full --- src/KOKKOS/neigh_list_kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/neigh_list_kokkos.cpp b/src/KOKKOS/neigh_list_kokkos.cpp index 1c78fe3a68..a5d832cab6 100644 --- a/src/KOKKOS/neigh_list_kokkos.cpp +++ b/src/KOKKOS/neigh_list_kokkos.cpp @@ -36,7 +36,7 @@ void NeighListKokkos::grow(int nmax) { // skip if this list is already long enough to store nmax atoms - if (nmax <= maxatoms) return; + if (nmax <= maxatoms && d_neighbors.extent(1) >= maxneighs) return; maxatoms = nmax; k_ilist = -- GitLab From 789d6a991eba4840315c239f69e51d96aa5bf49f Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Wed, 10 Jul 2019 17:01:46 -0600 Subject: [PATCH 229/469] Update comment --- src/KOKKOS/neigh_list_kokkos.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/KOKKOS/neigh_list_kokkos.cpp b/src/KOKKOS/neigh_list_kokkos.cpp index a5d832cab6..2b9c5ef645 100644 --- a/src/KOKKOS/neigh_list_kokkos.cpp +++ b/src/KOKKOS/neigh_list_kokkos.cpp @@ -35,6 +35,7 @@ template void NeighListKokkos::grow(int nmax) { // skip if this list is already long enough to store nmax atoms + // and maxneighs neighbors if (nmax <= maxatoms && d_neighbors.extent(1) >= maxneighs) return; maxatoms = nmax; -- GitLab From 1a0662c3860a68a38ee370812b069b58f8f7821d Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 10 Jul 2019 22:11:47 -0500 Subject: [PATCH 230/469] Some corrections and additions to kim_commands docs --- doc/src/kim_commands.txt | 14 +++++++++----- 1 file changed, 9 insertions(+), 5 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 437b768df6..1356ade9e2 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -35,7 +35,7 @@ kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657 kim_interactions C H O kim_init Sim_LAMMPS_IFF_OtherInfo_AuthorList_Year_Species__SM_064312669787_000 real kim_interactions fixed_types -kim_query a0 get_lattice_constant_fcc species=\["Al"] units=\["angstrom"\] :pre +kim_query a0 get_lattice_constant_fcc species=\["Al"\] units=\["angstrom"\] :pre [Description:] @@ -105,12 +105,16 @@ The URL for such a page is constructed from the "extended KIM ID"_https://openkim.org/about-kim-ids/ of the IM: https://openkim.org/id/extended_KIM_ID +or +https://openkim.org/id/short_KIM_ID :pre For example for the Stillinger-Weber potential listed above the Model Page is located at: "https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005"_https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005 +or +"https://openkim.org/id/MO_405512056662_005"_https://openkim.org/id/MO_405512056662_005 :pre See the "current list of KIM PMs and SMs archived in OpenKIM"_https://openkim.org/browse/models/by-species. @@ -271,8 +275,8 @@ OpenKIM IM Execution ({kim_interactions}) :h5 The second and final step in using an OpenKIM IM is to execute the {kim_interactions} command. This command must be preceded by a {kim_init} -command and a "create_box"_create_box.html command, -which defines the number of atom types {N}. +command and a command that creates the simulation box (such as +"create_box"_create_box.html), which defines the number of atom types {N}. The {kim_interactions} command has one argument {typeargs}. This argument contains either a list of {N} chemical species, which defines a mapping between atom types in LAMMPS to the available species in the OpenKIM IM, or the @@ -338,7 +342,7 @@ Note also that parameters like cutoff radii and charge tolerances, which have an effect on IM predictions, are also included in the SM definition ensuring reproducibility. -NOTE: When using using {kim_init} and {kim_interactions} to select +NOTE: When using {kim_init} and {kim_interactions} to select and set up an OpenKIM IM, other LAMMPS commands for the same functions (such as pair_style, pair_coeff, bond_style, bond_coeff, fixes related to charge equilibration, etc.) should normally @@ -356,7 +360,7 @@ argument of the {kim_query command}. The second required argument (e.g. {get_lattice_constant_fcc}). All following arguments are parameters handed over to the web query in the format {keyword=value}. The list of supported keywords and -and the type and format of their values depend on the query function +the type and format of their values depend on the query function used. NOTE: The current list of supported query functions is available on the OpenKIM -- GitLab From d05787ab99994e3cb6533280265026e55679e8aa Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 07:16:53 -0400 Subject: [PATCH 231/469] clean up include in USER-REAXC --- src/USER-REAXC/compute_spec_atom.cpp | 8 +------- src/USER-REAXC/compute_spec_atom.h | 1 - src/USER-REAXC/fix_qeq_reax.cpp | 7 +++---- src/USER-REAXC/fix_reaxc.cpp | 2 -- src/USER-REAXC/fix_reaxc_bonds.cpp | 12 ++---------- src/USER-REAXC/fix_reaxc_bonds.h | 1 - src/USER-REAXC/fix_reaxc_species.cpp | 12 ++++-------- src/USER-REAXC/fix_reaxc_species.h | 5 ----- src/USER-REAXC/pair_reaxc.cpp | 9 ++++++--- src/USER-REAXC/reaxc_allocate.cpp | 7 +++---- src/USER-REAXC/reaxc_bond_orders.cpp | 6 ++++-- src/USER-REAXC/reaxc_bonds.cpp | 7 +++---- src/USER-REAXC/reaxc_control.cpp | 4 ++-- src/USER-REAXC/reaxc_ffield.cpp | 8 +++++--- src/USER-REAXC/reaxc_ffield.h | 1 + src/USER-REAXC/reaxc_forces.cpp | 9 +++------ src/USER-REAXC/reaxc_hydrogen_bonds.cpp | 5 +++-- src/USER-REAXC/reaxc_init_md.cpp | 9 +++++---- src/USER-REAXC/reaxc_init_md.h | 2 +- src/USER-REAXC/reaxc_io_tools.cpp | 10 +++------- src/USER-REAXC/reaxc_list.cpp | 2 +- src/USER-REAXC/reaxc_lookup.cpp | 5 +++-- src/USER-REAXC/reaxc_lookup.h | 6 ++++-- src/USER-REAXC/reaxc_multi_body.cpp | 8 ++++---- src/USER-REAXC/reaxc_nonbonded.cpp | 7 ++++--- src/USER-REAXC/reaxc_reset_tools.cpp | 4 ++-- src/USER-REAXC/reaxc_system_props.cpp | 6 ++---- src/USER-REAXC/reaxc_system_props.h | 1 + src/USER-REAXC/reaxc_tool_box.cpp | 6 ++++-- src/USER-REAXC/reaxc_tool_box.h | 2 +- src/USER-REAXC/reaxc_torsion_angles.cpp | 6 +++--- src/USER-REAXC/reaxc_traj.cpp | 8 +++++--- src/USER-REAXC/reaxc_valence_angles.cpp | 5 +++-- src/USER-REAXC/reaxc_vector.cpp | 4 ++-- src/USER-REAXC/reaxc_vector.h | 2 -- 35 files changed, 88 insertions(+), 109 deletions(-) diff --git a/src/USER-REAXC/compute_spec_atom.cpp b/src/USER-REAXC/compute_spec_atom.cpp index 77b82b3e55..bc5b26b699 100644 --- a/src/USER-REAXC/compute_spec_atom.cpp +++ b/src/USER-REAXC/compute_spec_atom.cpp @@ -11,19 +11,13 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "compute_spec_atom.h" -#include "math_extra.h" +#include #include "atom.h" #include "update.h" #include "force.h" -#include "domain.h" #include "memory.h" #include "error.h" - -#include "reaxc_defs.h" -#include "reaxc_types.h" #include "pair_reaxc.h" using namespace LAMMPS_NS; diff --git a/src/USER-REAXC/compute_spec_atom.h b/src/USER-REAXC/compute_spec_atom.h index 4d5cb86d71..cf0aa0215d 100644 --- a/src/USER-REAXC/compute_spec_atom.h +++ b/src/USER-REAXC/compute_spec_atom.h @@ -21,7 +21,6 @@ ComputeStyle(SPEC/ATOM,ComputeSpecAtom) #define LMP_COMPUTE_SPEC_ATOM_H #include "compute.h" -#include "pointers.h" namespace LAMMPS_NS { diff --git a/src/USER-REAXC/fix_qeq_reax.cpp b/src/USER-REAXC/fix_qeq_reax.cpp index faa0632608..be6eccf764 100644 --- a/src/USER-REAXC/fix_qeq_reax.cpp +++ b/src/USER-REAXC/fix_qeq_reax.cpp @@ -18,15 +18,13 @@ Hybrid and sub-group capabilities: Ray Shan (Sandia) ------------------------------------------------------------------------- */ +#include "fix_qeq_reax.h" +#include #include -#include -#include #include -#include "fix_qeq_reax.h" #include "pair_reaxc.h" #include "atom.h" #include "comm.h" -#include "domain.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" @@ -39,6 +37,7 @@ #include "citeme.h" #include "error.h" #include "reaxc_defs.h" +#include "reaxc_types.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-REAXC/fix_reaxc.cpp b/src/USER-REAXC/fix_reaxc.cpp index dc67ad6ffb..c98adf5b45 100644 --- a/src/USER-REAXC/fix_reaxc.cpp +++ b/src/USER-REAXC/fix_reaxc.cpp @@ -23,8 +23,6 @@ #include "fix_reaxc.h" #include "atom.h" -#include "pair.h" -#include "comm.h" #include "memory.h" using namespace LAMMPS_NS; diff --git a/src/USER-REAXC/fix_reaxc_bonds.cpp b/src/USER-REAXC/fix_reaxc_bonds.cpp index 9dc347826f..f7ad7ed6d4 100644 --- a/src/USER-REAXC/fix_reaxc_bonds.cpp +++ b/src/USER-REAXC/fix_reaxc_bonds.cpp @@ -15,22 +15,14 @@ Contributing author: Ray Shan (Sandia, tnshan@sandia.gov) ------------------------------------------------------------------------- */ -#include -#include -#include "fix_ave_atom.h" #include "fix_reaxc_bonds.h" +#include +#include #include "atom.h" #include "update.h" #include "pair_reaxc.h" -#include "modify.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" -#include "comm.h" #include "force.h" -#include "compute.h" -#include "input.h" -#include "variable.h" #include "memory.h" #include "error.h" #include "reaxc_list.h" diff --git a/src/USER-REAXC/fix_reaxc_bonds.h b/src/USER-REAXC/fix_reaxc_bonds.h index 60f41beb02..e83e01f1d5 100644 --- a/src/USER-REAXC/fix_reaxc_bonds.h +++ b/src/USER-REAXC/fix_reaxc_bonds.h @@ -21,7 +21,6 @@ FixStyle(reax/c/bonds,FixReaxCBonds) #define LMP_FIX_REAXC_BONDS_H #include "fix.h" -#include "pointers.h" namespace LAMMPS_NS { diff --git a/src/USER-REAXC/fix_reaxc_species.cpp b/src/USER-REAXC/fix_reaxc_species.cpp index 46426d484a..74692f1c9b 100644 --- a/src/USER-REAXC/fix_reaxc_species.cpp +++ b/src/USER-REAXC/fix_reaxc_species.cpp @@ -16,27 +16,23 @@ Oleg Sergeev (VNIIA, sergeev@vniia.ru) ------------------------------------------------------------------------- */ +#include "fix_reaxc_species.h" +#include #include -#include #include #include "fix_ave_atom.h" -#include "fix_reaxc_species.h" #include "atom.h" #include "domain.h" #include "update.h" -#include "pair_reaxc.h" #include "modify.h" #include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "comm.h" #include "force.h" -#include "compute.h" -#include "input.h" -#include "variable.h" #include "memory.h" #include "error.h" -#include "reaxc_list.h" +#include "pair_reaxc.h" +#include "reaxc_defs.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-REAXC/fix_reaxc_species.h b/src/USER-REAXC/fix_reaxc_species.h index 23a470fd0a..937af98527 100644 --- a/src/USER-REAXC/fix_reaxc_species.h +++ b/src/USER-REAXC/fix_reaxc_species.h @@ -21,11 +21,6 @@ FixStyle(reax/c/species,FixReaxCSpecies) #define LMP_FIX_REAXC_SPECIES_H #include "fix.h" -#include "pointers.h" - -#include "pair_reaxc.h" -#include "reaxc_types.h" -#include "reaxc_defs.h" #define BUFLEN 1000 diff --git a/src/USER-REAXC/pair_reaxc.cpp b/src/USER-REAXC/pair_reaxc.cpp index 224f3e2568..959405576e 100644 --- a/src/USER-REAXC/pair_reaxc.cpp +++ b/src/USER-REAXC/pair_reaxc.cpp @@ -20,8 +20,12 @@ Hybrid and hybrid/overlay compatibility added by Ray Shan (Sandia) ------------------------------------------------------------------------- */ -#include #include "pair_reaxc.h" +#include +#include +#include +#include +#include #include "atom.h" #include "update.h" #include "force.h" @@ -36,6 +40,7 @@ #include "memory.h" #include "error.h" +#include "reaxc_defs.h" #include "reaxc_types.h" #include "reaxc_allocate.h" #include "reaxc_control.h" @@ -46,9 +51,7 @@ #include "reaxc_list.h" #include "reaxc_lookup.h" #include "reaxc_reset_tools.h" -#include "reaxc_traj.h" #include "reaxc_vector.h" -#include "fix_reaxc_bonds.h" using namespace LAMMPS_NS; diff --git a/src/USER-REAXC/reaxc_allocate.cpp b/src/USER-REAXC/reaxc_allocate.cpp index 460f8aeb6a..6303db5619 100644 --- a/src/USER-REAXC/reaxc_allocate.cpp +++ b/src/USER-REAXC/reaxc_allocate.cpp @@ -24,14 +24,13 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_allocate.h" +#include +#include "reaxc_defs.h" #include "reaxc_list.h" -#include "reaxc_reset_tools.h" #include "reaxc_tool_box.h" -#include "reaxc_vector.h" -#if defined(_OPENMP) +#if defined(LMP_USER_OMP) && defined(_OPENMP) #include #endif diff --git a/src/USER-REAXC/reaxc_bond_orders.cpp b/src/USER-REAXC/reaxc_bond_orders.cpp index 1ed58a0bfd..869e796661 100644 --- a/src/USER-REAXC/reaxc_bond_orders.cpp +++ b/src/USER-REAXC/reaxc_bond_orders.cpp @@ -24,9 +24,11 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" -#include "reaxc_types.h" #include "reaxc_bond_orders.h" +#include +#include "pair.h" +#include "reaxc_defs.h" +#include "reaxc_types.h" #include "reaxc_list.h" #include "reaxc_vector.h" diff --git a/src/USER-REAXC/reaxc_bonds.cpp b/src/USER-REAXC/reaxc_bonds.cpp index 48fb872324..4cfd2a3c3a 100644 --- a/src/USER-REAXC/reaxc_bonds.cpp +++ b/src/USER-REAXC/reaxc_bonds.cpp @@ -24,12 +24,11 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_bonds.h" -#include "reaxc_bond_orders.h" +#include +#include "pair.h" +#include "reaxc_defs.h" #include "reaxc_list.h" -#include "reaxc_tool_box.h" -#include "reaxc_vector.h" void Bonds( reax_system *system, control_params * /*control*/, simulation_data *data, storage *workspace, reax_list **lists, diff --git a/src/USER-REAXC/reaxc_control.cpp b/src/USER-REAXC/reaxc_control.cpp index 060c1a0342..12aa989fa2 100644 --- a/src/USER-REAXC/reaxc_control.cpp +++ b/src/USER-REAXC/reaxc_control.cpp @@ -24,10 +24,10 @@ . ----------------------------------------------------------------------*/ +#include "reaxc_control.h" #include #include -#include "pair_reaxc.h" -#include "reaxc_control.h" +#include "reaxc_defs.h" #include "reaxc_tool_box.h" #include "error.h" diff --git a/src/USER-REAXC/reaxc_ffield.cpp b/src/USER-REAXC/reaxc_ffield.cpp index 2160d180cf..e3a6645fc2 100644 --- a/src/USER-REAXC/reaxc_ffield.cpp +++ b/src/USER-REAXC/reaxc_ffield.cpp @@ -24,14 +24,16 @@ . ----------------------------------------------------------------------*/ +#include "reaxc_ffield.h" +#include +#include +#include #include #include -#include "pair_reaxc.h" +#include "reaxc_defs.h" #include "error.h" -#include "reaxc_ffield.h" #include "reaxc_tool_box.h" - char Read_Force_Field( FILE *fp, reax_interaction *reax, control_params *control ) { diff --git a/src/USER-REAXC/reaxc_ffield.h b/src/USER-REAXC/reaxc_ffield.h index 7cef730f91..b6fe1c9ea9 100644 --- a/src/USER-REAXC/reaxc_ffield.h +++ b/src/USER-REAXC/reaxc_ffield.h @@ -28,6 +28,7 @@ #define __FFIELD_H_ #include "reaxc_types.h" +#include char Read_Force_Field( FILE*, reax_interaction*, control_params* ); diff --git a/src/USER-REAXC/reaxc_forces.cpp b/src/USER-REAXC/reaxc_forces.cpp index 79094ece43..6cd627f05d 100644 --- a/src/USER-REAXC/reaxc_forces.cpp +++ b/src/USER-REAXC/reaxc_forces.cpp @@ -24,25 +24,22 @@ . ----------------------------------------------------------------------*/ -#include -#include "pair_reaxc.h" #include "reaxc_forces.h" +#include +#include +#include #include "reaxc_bond_orders.h" #include "reaxc_bonds.h" #include "reaxc_hydrogen_bonds.h" -#include "reaxc_io_tools.h" #include "reaxc_list.h" -#include "reaxc_lookup.h" #include "reaxc_multi_body.h" #include "reaxc_nonbonded.h" -#include "reaxc_tool_box.h" #include "reaxc_torsion_angles.h" #include "reaxc_valence_angles.h" #include "reaxc_vector.h" #include "error.h" - interaction_function Interaction_Functions[NUM_INTRS]; void Dummy_Interaction( reax_system * /*system*/, control_params * /*control*/, diff --git a/src/USER-REAXC/reaxc_hydrogen_bonds.cpp b/src/USER-REAXC/reaxc_hydrogen_bonds.cpp index be34df7571..5929703bad 100644 --- a/src/USER-REAXC/reaxc_hydrogen_bonds.cpp +++ b/src/USER-REAXC/reaxc_hydrogen_bonds.cpp @@ -24,9 +24,10 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_hydrogen_bonds.h" -#include "reaxc_bond_orders.h" +#include +#include "pair.h" +#include "reaxc_defs.h" #include "reaxc_list.h" #include "reaxc_valence_angles.h" #include "reaxc_vector.h" diff --git a/src/USER-REAXC/reaxc_init_md.cpp b/src/USER-REAXC/reaxc_init_md.cpp index a0e15e98f5..966ad78c34 100644 --- a/src/USER-REAXC/reaxc_init_md.cpp +++ b/src/USER-REAXC/reaxc_init_md.cpp @@ -24,18 +24,19 @@ . ----------------------------------------------------------------------*/ -#include -#include "pair_reaxc.h" #include "reaxc_init_md.h" +#include +#include +#include +#include +#include "reaxc_defs.h" #include "reaxc_allocate.h" #include "reaxc_forces.h" #include "reaxc_io_tools.h" #include "reaxc_list.h" #include "reaxc_lookup.h" #include "reaxc_reset_tools.h" -#include "reaxc_system_props.h" #include "reaxc_tool_box.h" -#include "reaxc_vector.h" #include "error.h" diff --git a/src/USER-REAXC/reaxc_init_md.h b/src/USER-REAXC/reaxc_init_md.h index ab519a4c72..5d593f50ea 100644 --- a/src/USER-REAXC/reaxc_init_md.h +++ b/src/USER-REAXC/reaxc_init_md.h @@ -28,7 +28,7 @@ #define __INIT_MD_H_ #include "reaxc_types.h" - +#include void Initialize( reax_system*, control_params*, simulation_data*, storage*, reax_list**, output_controls*, mpi_datatypes*, MPI_Comm ); diff --git a/src/USER-REAXC/reaxc_io_tools.cpp b/src/USER-REAXC/reaxc_io_tools.cpp index f4a1486c48..f68a2a2abb 100644 --- a/src/USER-REAXC/reaxc_io_tools.cpp +++ b/src/USER-REAXC/reaxc_io_tools.cpp @@ -24,16 +24,12 @@ . ----------------------------------------------------------------------*/ -#include -#include "pair_reaxc.h" -#include "update.h" #include "reaxc_io_tools.h" -#include "reaxc_list.h" -#include "reaxc_reset_tools.h" +#include +#include +#include "reaxc_defs.h" #include "reaxc_system_props.h" -#include "reaxc_tool_box.h" #include "reaxc_traj.h" -#include "reaxc_vector.h" int Init_Output_Files( reax_system *system, control_params *control, output_controls *out_control, mpi_datatypes *mpi_data, diff --git a/src/USER-REAXC/reaxc_list.cpp b/src/USER-REAXC/reaxc_list.cpp index cd4f815286..53bd05bc8d 100644 --- a/src/USER-REAXC/reaxc_list.cpp +++ b/src/USER-REAXC/reaxc_list.cpp @@ -24,8 +24,8 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_list.h" +#include "reaxc_defs.h" #include "reaxc_tool_box.h" #include "error.h" diff --git a/src/USER-REAXC/reaxc_lookup.cpp b/src/USER-REAXC/reaxc_lookup.cpp index 8d33a33fba..622483fdc9 100644 --- a/src/USER-REAXC/reaxc_lookup.cpp +++ b/src/USER-REAXC/reaxc_lookup.cpp @@ -24,12 +24,13 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_lookup.h" +#include +#include +#include "reaxc_defs.h" #include "reaxc_nonbonded.h" #include "reaxc_tool_box.h" - void Tridiagonal_Solve( const double *a, const double *b, double *c, double *d, double *x, unsigned int n){ int i; diff --git a/src/USER-REAXC/reaxc_lookup.h b/src/USER-REAXC/reaxc_lookup.h index 3fd0c2581a..3aae7e0b63 100644 --- a/src/USER-REAXC/reaxc_lookup.h +++ b/src/USER-REAXC/reaxc_lookup.h @@ -28,6 +28,7 @@ #define __LOOKUP_H_ #include "reaxc_types.h" +namespace LAMMPS_NS { class Error; } void Tridiagonal_Solve( const double *a, const double *b, double *c, double *d, double *x, unsigned int n); @@ -35,8 +36,9 @@ void Tridiagonal_Solve( const double *a, const double *b, void Natural_Cubic_Spline( LAMMPS_NS::Error*, const double *h, const double *f, cubic_spline_coef *coef, unsigned int n ); -void Complete_Cubic_Spline( LAMMPS_NS::Error*, const double *h, const double *f, double v0, double vlast, - cubic_spline_coef *coef, unsigned int n ); +void Complete_Cubic_Spline( LAMMPS_NS::Error*, const double *h, const double *f, + double v0, double vlast, cubic_spline_coef *coef, + unsigned int n ); int Init_Lookup_Tables( reax_system*, control_params*, storage*, mpi_datatypes*, char* ); diff --git a/src/USER-REAXC/reaxc_multi_body.cpp b/src/USER-REAXC/reaxc_multi_body.cpp index 371b8ed65e..ed1a3d5ac1 100644 --- a/src/USER-REAXC/reaxc_multi_body.cpp +++ b/src/USER-REAXC/reaxc_multi_body.cpp @@ -24,12 +24,12 @@ . ----------------------------------------------------------------------*/ -#include -#include "pair_reaxc.h" #include "reaxc_multi_body.h" -#include "reaxc_bond_orders.h" +#include +#include +#include "pair.h" +#include "reaxc_defs.h" #include "reaxc_list.h" -#include "reaxc_vector.h" void Atom_Energy( reax_system *system, control_params *control, simulation_data *data, storage *workspace, reax_list **lists, diff --git a/src/USER-REAXC/reaxc_nonbonded.cpp b/src/USER-REAXC/reaxc_nonbonded.cpp index b0fea8c1b9..497a1a0ebe 100644 --- a/src/USER-REAXC/reaxc_nonbonded.cpp +++ b/src/USER-REAXC/reaxc_nonbonded.cpp @@ -24,10 +24,11 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" -#include "reaxc_types.h" #include "reaxc_nonbonded.h" -#include "reaxc_bond_orders.h" +#include +#include "pair.h" +#include "reaxc_defs.h" +#include "reaxc_types.h" #include "reaxc_list.h" #include "reaxc_vector.h" diff --git a/src/USER-REAXC/reaxc_reset_tools.cpp b/src/USER-REAXC/reaxc_reset_tools.cpp index c72ccbadcd..91b1a9e14f 100644 --- a/src/USER-REAXC/reaxc_reset_tools.cpp +++ b/src/USER-REAXC/reaxc_reset_tools.cpp @@ -24,9 +24,9 @@ . ----------------------------------------------------------------------*/ -#include -#include "pair_reaxc.h" #include "reaxc_reset_tools.h" +#include +#include "reaxc_defs.h" #include "reaxc_list.h" #include "reaxc_tool_box.h" #include "reaxc_vector.h" diff --git a/src/USER-REAXC/reaxc_system_props.cpp b/src/USER-REAXC/reaxc_system_props.cpp index 5024feffcf..166f070be6 100644 --- a/src/USER-REAXC/reaxc_system_props.cpp +++ b/src/USER-REAXC/reaxc_system_props.cpp @@ -24,11 +24,9 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_system_props.h" -#include "reaxc_tool_box.h" -#include "reaxc_vector.h" - +#include +#include "reaxc_defs.h" void Compute_System_Energy( reax_system *system, simulation_data *data, MPI_Comm comm ) diff --git a/src/USER-REAXC/reaxc_system_props.h b/src/USER-REAXC/reaxc_system_props.h index 161060e184..4d80e22966 100644 --- a/src/USER-REAXC/reaxc_system_props.h +++ b/src/USER-REAXC/reaxc_system_props.h @@ -28,6 +28,7 @@ #define __SYSTEM_PROP_H_ #include "reaxc_types.h" +#include void Compute_System_Energy( reax_system*, simulation_data*, MPI_Comm ); diff --git a/src/USER-REAXC/reaxc_tool_box.cpp b/src/USER-REAXC/reaxc_tool_box.cpp index 2cf66d8655..811c2ed0ee 100644 --- a/src/USER-REAXC/reaxc_tool_box.cpp +++ b/src/USER-REAXC/reaxc_tool_box.cpp @@ -24,9 +24,11 @@ . ----------------------------------------------------------------------*/ -#include -#include "pair_reaxc.h" #include "reaxc_tool_box.h" +#include +#include +#include +#include "reaxc_defs.h" #if !defined(_MSC_VER) #include diff --git a/src/USER-REAXC/reaxc_tool_box.h b/src/USER-REAXC/reaxc_tool_box.h index 0465376dba..b325819265 100644 --- a/src/USER-REAXC/reaxc_tool_box.h +++ b/src/USER-REAXC/reaxc_tool_box.h @@ -28,7 +28,7 @@ #define __TOOL_BOX_H_ #include "reaxc_types.h" -#include "reaxc_defs.h" +namespace LAMMPS_NS { class Error; } /* from system_props.h */ double Get_Time( ); diff --git a/src/USER-REAXC/reaxc_torsion_angles.cpp b/src/USER-REAXC/reaxc_torsion_angles.cpp index ed76368d68..ce944b217f 100644 --- a/src/USER-REAXC/reaxc_torsion_angles.cpp +++ b/src/USER-REAXC/reaxc_torsion_angles.cpp @@ -24,11 +24,11 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_torsion_angles.h" -#include "reaxc_bond_orders.h" +#include +#include "pair.h" +#include "reaxc_defs.h" #include "reaxc_list.h" -#include "reaxc_tool_box.h" #include "reaxc_vector.h" #define MIN_SINE 1e-10 diff --git a/src/USER-REAXC/reaxc_traj.cpp b/src/USER-REAXC/reaxc_traj.cpp index a536445113..fb493feae5 100644 --- a/src/USER-REAXC/reaxc_traj.cpp +++ b/src/USER-REAXC/reaxc_traj.cpp @@ -24,11 +24,13 @@ . ----------------------------------------------------------------------*/ -#include -#include "pair_reaxc.h" #include "reaxc_traj.h" +#include +#include +#include +#include +#include "reaxc_defs.h" #include "reaxc_list.h" -#include "reaxc_tool_box.h" #include "error.h" diff --git a/src/USER-REAXC/reaxc_valence_angles.cpp b/src/USER-REAXC/reaxc_valence_angles.cpp index 4ba870b6d9..560955fa9d 100644 --- a/src/USER-REAXC/reaxc_valence_angles.cpp +++ b/src/USER-REAXC/reaxc_valence_angles.cpp @@ -24,9 +24,10 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_valence_angles.h" -#include "reaxc_bond_orders.h" +#include +#include "pair.h" +#include "reaxc_defs.h" #include "reaxc_list.h" #include "reaxc_vector.h" diff --git a/src/USER-REAXC/reaxc_vector.cpp b/src/USER-REAXC/reaxc_vector.cpp index b54d329ce9..207d745df3 100644 --- a/src/USER-REAXC/reaxc_vector.cpp +++ b/src/USER-REAXC/reaxc_vector.cpp @@ -24,9 +24,9 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc.h" #include "reaxc_vector.h" - +#include +#include "reaxc_defs.h" void rvec_Copy( rvec dest, rvec src ) { diff --git a/src/USER-REAXC/reaxc_vector.h b/src/USER-REAXC/reaxc_vector.h index 906b200dc9..549c1f927c 100644 --- a/src/USER-REAXC/reaxc_vector.h +++ b/src/USER-REAXC/reaxc_vector.h @@ -27,9 +27,7 @@ #ifndef __VECTOR_H_ #define __VECTOR_H_ -#include "pair.h" #include "reaxc_types.h" -#include "reaxc_defs.h" void rvec_Copy( rvec, rvec ); void rvec_Scale( rvec, double, rvec ); -- GitLab From ca4b26ddf8e0c0a6f7060387c999b21c3f13c9db Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 07:22:41 -0400 Subject: [PATCH 232/469] fix up some leftover include issues that got overlooked in previous changes --- src/USER-PTM/ptm_structure_matcher.cpp | 8 ++------ src/USER-PTM/ptm_structure_matcher.h | 2 +- src/USER-QTB/fix_qbmsst.cpp | 11 +---------- src/USER-QTB/fix_qtb.cpp | 9 +-------- src/USER-SDPD/fix_meso_move.cpp | 3 +-- src/USER-SDPD/fix_rigid_meso.cpp | 7 ------- src/USER-SMD/pair_smd_ulsph.cpp | 3 +++ src/USER-UEF/dump_cfg_uef.cpp | 1 - src/USER-YAFF/angle_cross.cpp | 1 + src/USER-YAFF/angle_mm3.cpp | 2 +- 10 files changed, 11 insertions(+), 36 deletions(-) diff --git a/src/USER-PTM/ptm_structure_matcher.cpp b/src/USER-PTM/ptm_structure_matcher.cpp index d50676a3c1..b587ad225f 100644 --- a/src/USER-PTM/ptm_structure_matcher.cpp +++ b/src/USER-PTM/ptm_structure_matcher.cpp @@ -7,20 +7,16 @@ The above copyright notice and this permission notice shall be included in all c THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. */ -#include -#include +#include "ptm_structure_matcher.h" #include #include -#include -#include -#include +#include #include "ptm_convex_hull_incremental.h" #include "ptm_canonical_coloured.h" #include "ptm_graph_data.h" #include "ptm_graph_tools.h" #include "ptm_normalize_vertices.h" #include "ptm_polar.h" -#include "ptm_structure_matcher.h" #include "ptm_constants.h" diff --git a/src/USER-PTM/ptm_structure_matcher.h b/src/USER-PTM/ptm_structure_matcher.h index e75892f8cb..63bc5ed1fe 100644 --- a/src/USER-PTM/ptm_structure_matcher.h +++ b/src/USER-PTM/ptm_structure_matcher.h @@ -12,7 +12,7 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI #include "ptm_initialize_data.h" #include "ptm_constants.h" - +#include "ptm_convex_hull_incremental.h" namespace ptm { diff --git a/src/USER-QTB/fix_qbmsst.cpp b/src/USER-QTB/fix_qbmsst.cpp index b9b07664d2..abbf1701b8 100644 --- a/src/USER-QTB/fix_qbmsst.cpp +++ b/src/USER-QTB/fix_qbmsst.cpp @@ -16,31 +16,22 @@ Implementation of the Multi-Scale Shock Method with quantum nuclear effects ------------------------------------------------------------------------- */ +#include "fix_qbmsst.h" #include #include #include #include -#include "fix_qbmsst.h" -#include "math_extra.h" #include "atom.h" -#include "atom_vec_ellipsoid.h" #include "force.h" #include "update.h" #include "modify.h" #include "compute.h" #include "domain.h" -#include "region.h" -#include "respa.h" #include "comm.h" -#include "input.h" -#include "output.h" -#include "variable.h" #include "random_mars.h" #include "memory.h" #include "error.h" -#include "group.h" #include "kspace.h" -#include "thermo.h" #include "utils.h" using namespace LAMMPS_NS; diff --git a/src/USER-QTB/fix_qtb.cpp b/src/USER-QTB/fix_qtb.cpp index 015f953b8e..593ca31006 100644 --- a/src/USER-QTB/fix_qtb.cpp +++ b/src/USER-QTB/fix_qtb.cpp @@ -16,28 +16,21 @@ Implementation of the colored thermostat for quantum nuclear effects ------------------------------------------------------------------------- */ +#include "fix_qtb.h" #include #include #include #include -#include "fix_qtb.h" -#include "math_extra.h" #include "atom.h" -#include "atom_vec_ellipsoid.h" #include "force.h" #include "update.h" #include "modify.h" #include "compute.h" -#include "domain.h" -#include "region.h" #include "respa.h" #include "comm.h" -#include "input.h" -#include "variable.h" #include "random_mars.h" #include "memory.h" #include "error.h" -#include "group.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-SDPD/fix_meso_move.cpp b/src/USER-SDPD/fix_meso_move.cpp index 85b08a2af7..176cd8b895 100644 --- a/src/USER-SDPD/fix_meso_move.cpp +++ b/src/USER-SDPD/fix_meso_move.cpp @@ -16,11 +16,10 @@ Morteza Jalalvand (IASBS) jalalvand.m AT gmail.com ------------------------------------------------------------------------- */ +#include "fix_meso_move.h" #include #include -#include "fix_meso_move.h" #include "atom.h" -#include "group.h" #include "update.h" #include "modify.h" #include "force.h" diff --git a/src/USER-SDPD/fix_rigid_meso.cpp b/src/USER-SDPD/fix_rigid_meso.cpp index 49c9ca8614..e93c543e72 100644 --- a/src/USER-SDPD/fix_rigid_meso.cpp +++ b/src/USER-SDPD/fix_rigid_meso.cpp @@ -27,17 +27,10 @@ and all codes relevant to that has been removed ------------------------------------------------------------------------- */ -#include #include "fix_rigid_meso.h" #include "math_extra.h" #include "atom.h" -#include "compute.h" #include "domain.h" -#include "update.h" -#include "modify.h" -#include "group.h" -#include "force.h" -#include "output.h" #include "memory.h" #include "error.h" diff --git a/src/USER-SMD/pair_smd_ulsph.cpp b/src/USER-SMD/pair_smd_ulsph.cpp index 9e824ded3c..b53eb779de 100644 --- a/src/USER-SMD/pair_smd_ulsph.cpp +++ b/src/USER-SMD/pair_smd_ulsph.cpp @@ -23,8 +23,11 @@ ------------------------------------------------------------------------- */ #include "pair_smd_ulsph.h" +#include #include #include +#include +#include #include "atom.h" #include "domain.h" #include "force.h" diff --git a/src/USER-UEF/dump_cfg_uef.cpp b/src/USER-UEF/dump_cfg_uef.cpp index 5e3733f422..8e6268eee6 100644 --- a/src/USER-UEF/dump_cfg_uef.cpp +++ b/src/USER-UEF/dump_cfg_uef.cpp @@ -14,7 +14,6 @@ ------------------------------------------------------------------------- */ #include "dump_cfg.h" -#include #include #include "atom.h" #include "modify.h" diff --git a/src/USER-YAFF/angle_cross.cpp b/src/USER-YAFF/angle_cross.cpp index 2ebb08f56b..0f8861cdf5 100644 --- a/src/USER-YAFF/angle_cross.cpp +++ b/src/USER-YAFF/angle_cross.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "angle_cross.h" +#include #include #include "atom.h" #include "neighbor.h" diff --git a/src/USER-YAFF/angle_mm3.cpp b/src/USER-YAFF/angle_mm3.cpp index 24ce8229ba..b90db37afa 100644 --- a/src/USER-YAFF/angle_mm3.cpp +++ b/src/USER-YAFF/angle_mm3.cpp @@ -16,8 +16,8 @@ ------------------------------------------------------------------------- */ #include "angle_mm3.h" +#include #include -#include #include "atom.h" #include "neighbor.h" #include "domain.h" -- GitLab From 01524d9850ab0896adb905d8c64d6b72a99cf1de Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 08:13:03 -0400 Subject: [PATCH 233/469] recover compilation of USER-OMP --- src/USER-OMP/reaxc_bond_orders_omp.cpp | 3 ++- src/USER-OMP/reaxc_bonds_omp.cpp | 5 +++-- src/USER-OMP/reaxc_forces_omp.cpp | 3 ++- src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp | 4 ++-- src/USER-OMP/reaxc_init_md_omp.cpp | 3 ++- src/USER-OMP/reaxc_multi_body_omp.cpp | 3 ++- src/USER-OMP/reaxc_nonbonded_omp.cpp | 1 + src/USER-OMP/reaxc_torsion_angles_omp.cpp | 3 ++- src/USER-OMP/reaxc_valence_angles_omp.cpp | 3 ++- 9 files changed, 18 insertions(+), 10 deletions(-) diff --git a/src/USER-OMP/reaxc_bond_orders_omp.cpp b/src/USER-OMP/reaxc_bond_orders_omp.cpp index 33780f5e3f..17715c6e26 100644 --- a/src/USER-OMP/reaxc_bond_orders_omp.cpp +++ b/src/USER-OMP/reaxc_bond_orders_omp.cpp @@ -26,9 +26,10 @@ . ----------------------------------------------------------------------*/ +#include "reaxc_bond_orders_omp.h" +#include "reaxc_defs.h" #include "pair_reaxc_omp.h" #include "reaxc_types.h" -#include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" #include "reaxc_vector.h" diff --git a/src/USER-OMP/reaxc_bonds_omp.cpp b/src/USER-OMP/reaxc_bonds_omp.cpp index 5160c6f55d..12ba1dcbfe 100644 --- a/src/USER-OMP/reaxc_bonds_omp.cpp +++ b/src/USER-OMP/reaxc_bonds_omp.cpp @@ -26,10 +26,11 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc_omp.h" - #include "reaxc_bonds_omp.h" +#include "reaxc_defs.h" #include "reaxc_bond_orders_omp.h" +#include "pair_reaxc_omp.h" + #include "reaxc_list.h" #include "reaxc_tool_box.h" #include "reaxc_vector.h" diff --git a/src/USER-OMP/reaxc_forces_omp.cpp b/src/USER-OMP/reaxc_forces_omp.cpp index 0a08bd6a46..1ada5e7e71 100644 --- a/src/USER-OMP/reaxc_forces_omp.cpp +++ b/src/USER-OMP/reaxc_forces_omp.cpp @@ -26,10 +26,11 @@ . ----------------------------------------------------------------------*/ +#include "reaxc_forces_omp.h" +#include "reaxc_defs.h" #include "pair_reaxc_omp.h" #include "thr_data.h" -#include "reaxc_forces_omp.h" #include "reaxc_bond_orders_omp.h" #include "reaxc_bonds_omp.h" #include "reaxc_hydrogen_bonds_omp.h" diff --git a/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp b/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp index 7acf26262e..e3c034a12e 100644 --- a/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp +++ b/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp @@ -26,9 +26,9 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc_omp.h" - #include "reaxc_hydrogen_bonds_omp.h" +#include "pair_reaxc_omp.h" +#include "reaxc_defs.h" #include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" #include "reaxc_valence_angles.h" // To access Calculate_Theta() diff --git a/src/USER-OMP/reaxc_init_md_omp.cpp b/src/USER-OMP/reaxc_init_md_omp.cpp index fe7682d035..847e916666 100644 --- a/src/USER-OMP/reaxc_init_md_omp.cpp +++ b/src/USER-OMP/reaxc_init_md_omp.cpp @@ -26,8 +26,9 @@ . ----------------------------------------------------------------------*/ -#include "pair_reaxc_omp.h" #include "reaxc_init_md_omp.h" +#include "pair_reaxc_omp.h" +#include "reaxc_defs.h" #include "reaxc_allocate.h" #include "reaxc_forces.h" #include "reaxc_forces_omp.h" diff --git a/src/USER-OMP/reaxc_multi_body_omp.cpp b/src/USER-OMP/reaxc_multi_body_omp.cpp index d791f945a8..164999b986 100644 --- a/src/USER-OMP/reaxc_multi_body_omp.cpp +++ b/src/USER-OMP/reaxc_multi_body_omp.cpp @@ -26,11 +26,12 @@ . ----------------------------------------------------------------------*/ +#include "reaxc_multi_body_omp.h" #include #include "pair_reaxc_omp.h" #include "thr_data.h" +#include "reaxc_defs.h" -#include "reaxc_multi_body_omp.h" #include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" #include "reaxc_vector.h" diff --git a/src/USER-OMP/reaxc_nonbonded_omp.cpp b/src/USER-OMP/reaxc_nonbonded_omp.cpp index ea92e0c210..564088880a 100644 --- a/src/USER-OMP/reaxc_nonbonded_omp.cpp +++ b/src/USER-OMP/reaxc_nonbonded_omp.cpp @@ -29,6 +29,7 @@ #include "pair_reaxc_omp.h" #include "thr_data.h" +#include "reaxc_defs.h" #include "reaxc_types.h" #include "reaxc_nonbonded.h" diff --git a/src/USER-OMP/reaxc_torsion_angles_omp.cpp b/src/USER-OMP/reaxc_torsion_angles_omp.cpp index d290dc264f..9cd716b594 100644 --- a/src/USER-OMP/reaxc_torsion_angles_omp.cpp +++ b/src/USER-OMP/reaxc_torsion_angles_omp.cpp @@ -26,11 +26,12 @@ . ----------------------------------------------------------------------*/ +#include "reaxc_torsion_angles_omp.h" #include "pair_reaxc_omp.h" #include "thr_data.h" +#include "reaxc_defs.h" #include "reaxc_types.h" -#include "reaxc_torsion_angles_omp.h" #include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" #include "reaxc_tool_box.h" diff --git a/src/USER-OMP/reaxc_valence_angles_omp.cpp b/src/USER-OMP/reaxc_valence_angles_omp.cpp index 195f16a75d..7fbe87d6e5 100644 --- a/src/USER-OMP/reaxc_valence_angles_omp.cpp +++ b/src/USER-OMP/reaxc_valence_angles_omp.cpp @@ -26,12 +26,13 @@ . ----------------------------------------------------------------------*/ +#include "reaxc_valence_angles_omp.h" #include "pair_reaxc_omp.h" #include "thr_data.h" +#include "reaxc_defs.h" #include "reaxc_types.h" #include "reaxc_valence_angles.h" -#include "reaxc_valence_angles_omp.h" #include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" #include "reaxc_vector.h" -- GitLab From b5fea1f4a7528776cf1944508b7ce445c97e0217 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 09:19:26 -0400 Subject: [PATCH 234/469] no need to zero out Ec_meam twice --- src/USER-MEAMC/meam_impl.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/USER-MEAMC/meam_impl.cpp b/src/USER-MEAMC/meam_impl.cpp index 3b40a2b612..74e8af1cde 100644 --- a/src/USER-MEAMC/meam_impl.cpp +++ b/src/USER-MEAMC/meam_impl.cpp @@ -44,7 +44,7 @@ MEAM::MEAM(Memory* mem) rho_ref_meam[i] = ibar_meam[i] = ielt_meam[i] = 0.0; for (int j = 0; j < maxelt; j++) { lattce_meam[i][j] = FCC; - Ec_meam[i][j] = re_meam[i][j] = alpha_meam[i][j] = delta_meam[i][j] = Ec_meam[i][j] = ebound_meam[i][j] = attrac_meam[i][j] = repuls_meam[i][j] = 0.0; + Ec_meam[i][j] = re_meam[i][j] = alpha_meam[i][j] = delta_meam[i][j] = ebound_meam[i][j] = attrac_meam[i][j] = repuls_meam[i][j] = 0.0; nn2_meam[i][j] = zbl_meam[i][j] = eltind[i][j] = 0; } } -- GitLab From b1f8c3f38acd9490fe4a17977428c31d20558e00 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 11:25:44 -0400 Subject: [PATCH 235/469] silence some compiler warnings --- src/MANYBODY/pair_airebo.cpp | 161 ++++++++++++++++++----------------- 1 file changed, 81 insertions(+), 80 deletions(-) diff --git a/src/MANYBODY/pair_airebo.cpp b/src/MANYBODY/pair_airebo.cpp index 818663222f..fcc3a3efd2 100644 --- a/src/MANYBODY/pair_airebo.cpp +++ b/src/MANYBODY/pair_airebo.cpp @@ -3193,6 +3193,7 @@ double PairAIREBO::piRCSpline(double Nij, double Nji, double Nijconj, dN3[0]=0.0; dN3[1]=0.0; dN3[2]=0.0; + piRC=0.0; if (typei==0 && typej==0) { @@ -4343,70 +4344,70 @@ void PairAIREBO::Sptricubic_patch_coeffs( ) { const double C_inv[64][32] = { // output_matrix(2, 8*4, get_matrix(3)) - 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, - -3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -2, -1, 0, 0, 0, 0, 0, 0, - 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 1, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - -3, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -2, 0, -1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 3, 0, 0, 0, 0, 0, - 9, -9, -9, 9, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 6, -6, 3, -3, 0, 0, 0, 0, 6, 3, -6, -3, 0, 0, 0, 0, - -6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -4, 4, -2, 2, 0, 0, 0, 0, -3, -3, 3, 3, 0, 0, 0, 0, - 2, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, -2, 0, 0, 0, 0, 0, - -6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 3, -3, 3, 0, 0, 0, 0, -4, -2, 4, 2, 0, 0, 0, 0, - 4, -4, -4, 4, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, -2, 2, -2, 0, 0, 0, 0, 2, 2, -2, -2, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, -3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 9, -9, -9, 9, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 4, -4, -4, 4, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - -3, 0, 0, 0, 3, 0, 0, 0, -2, 0, 0, 0, -1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 0, 0, 3, 0, 0, 0, - 9, -9, 0, 0, -9, 9, 0, 0, 6, -6, 0, 0, 3, -3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 6, 3, 0, 0, -6, -3, 0, 0, - -6, 6, 0, 0, 6, -6, 0, 0, -4, 4, 0, 0, -2, 2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, -3, 0, 0, 3, 3, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 0, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 9, -9, 0, 0, -9, 9, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 0, 0, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 9, 0, -9, 0, -9, 0, 9, 0, 6, 0, -6, 0, 3, 0, -3, 0, 6, 0, 3, 0, -6, 0, -3, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 9, 0, -9, 0, -9, 0, 9, 0, - -27, 27, 27,-27, 27,-27,-27, 27,-18, 18, 18,-18, -9, 9, 9, -9,-18, 18, -9, 9, 18,-18, 9, -9,-18, -9, 18, 9, 18, 9,-18, -9, - 18,-18,-18, 18,-18, 18, 18,-18, 12,-12,-12, 12, 6, -6, -6, 6, 12,-12, 6, -6,-12, 12, -6, 6, 9, 9, -9, -9, -9, -9, 9, 9, - -6, 0, 6, 0, 6, 0, -6, 0, -4, 0, 4, 0, -2, 0, 2, 0, -3, 0, -3, 0, 3, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 0, 6, 0, 6, 0, -6, 0, - 18,-18,-18, 18,-18, 18, 18,-18, 12,-12,-12, 12, 6, -6, -6, 6, 9, -9, 9, -9, -9, 9, -9, 9, 12, 6,-12, -6,-12, -6, 12, 6, - -12, 12, 12,-12, 12,-12,-12, 12, -8, 8, 8, -8, -4, 4, 4, -4, -6, 6, -6, 6, 6, -6, 6, -6, -6, -6, 6, 6, 6, 6, -6, -6, - 2, 0, 0, 0, -2, 0, 0, 0, 1, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, 0, 0, -2, 0, 0, 0, - -6, 6, 0, 0, 6, -6, 0, 0, -3, 3, 0, 0, -3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -4, -2, 0, 0, 4, 2, 0, 0, - 4, -4, 0, 0, -4, 4, 0, 0, 2, -2, 0, 0, 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 2, 0, 0, -2, -2, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, 0, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 0, 0, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 4, -4, 0, 0, -4, 4, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - -6, 0, 6, 0, 6, 0, -6, 0, -3, 0, 3, 0, -3, 0, 3, 0, -4, 0, -2, 0, 4, 0, 2, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 0, 6, 0, 6, 0, -6, 0, - 18,-18,-18, 18,-18, 18, 18,-18, 9, -9, -9, 9, 9, -9, -9, 9, 12,-12, 6, -6,-12, 12, -6, 6, 12, 6,-12, -6,-12, -6, 12, 6, - -12, 12, 12,-12, 12,-12,-12, 12, -6, 6, 6, -6, -6, 6, 6, -6, -8, 8, -4, 4, 8, -8, 4, -4, -6, -6, 6, 6, 6, 6, -6, -6, - 4, 0, -4, 0, -4, 0, 4, 0, 2, 0, -2, 0, 2, 0, -2, 0, 2, 0, 2, 0, -2, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 4, 0, -4, 0, -4, 0, 4, 0, - -12, 12, 12,-12, 12,-12,-12, 12, -6, 6, 6, -6, -6, 6, 6, -6, -6, 6, -6, 6, 6, -6, 6, -6, -8, -4, 8, 4, 8, 4, -8, -4, - 8, -8, -8, 8, -8, 8, 8, -8, 4, -4, -4, 4, 4, -4, -4, 4, 4, -4, 4, -4, -4, 4, -4, 4, 4, 4, -4, -4, -4, -4, 4, 4, + { 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0}, + {-3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -2, -1, 0, 0, 0, 0, 0, 0}, + { 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 1, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + {-3, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -2, 0, -1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 3, 0, 0, 0, 0, 0}, + { 9, -9, -9, 9, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 6, -6, 3, -3, 0, 0, 0, 0, 6, 3, -6, -3, 0, 0, 0, 0}, + {-6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -4, 4, -2, 2, 0, 0, 0, 0, -3, -3, 3, 3, 0, 0, 0, 0}, + { 2, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, -2, 0, 0, 0, 0, 0}, + {-6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 3, -3, 3, 0, 0, 0, 0, -4, -2, 4, 2, 0, 0, 0, 0}, + { 4, -4, -4, 4, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, -2, 2, -2, 0, 0, 0, 0, 2, 2, -2, -2, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, -3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 9, -9, -9, 9, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 4, -4, -4, 4, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + {-3, 0, 0, 0, 3, 0, 0, 0, -2, 0, 0, 0, -1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 0, 0, 3, 0, 0, 0}, + { 9, -9, 0, 0, -9, 9, 0, 0, 6, -6, 0, 0, 3, -3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 6, 3, 0, 0, -6, -3, 0, 0}, + {-6, 6, 0, 0, 6, -6, 0, 0, -4, 4, 0, 0, -2, 2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, -3, 0, 0, 3, 3, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -3, 0, 0, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 9, -9, 0, 0, -9, 9, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 0, 0, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 9, 0, -9, 0, -9, 0, 9, 0, 6, 0, -6, 0, 3, 0, -3, 0, 6, 0, 3, 0, -6, 0, -3, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 9, 0, -9, 0, -9, 0, 9, 0}, + {-27,27, 27,-27, 27,-27,-27, 27,-18, 18, 18,-18, -9, 9, 9, -9,-18, 18, -9, 9, 18,-18, 9, -9,-18, -9, 18, 9, 18, 9,-18, -9}, + {18,-18,-18, 18,-18, 18, 18,-18, 12,-12,-12, 12, 6, -6, -6, 6, 12,-12, 6, -6,-12, 12, -6, 6, 9, 9, -9, -9, -9, -9, 9, 9}, + {-6, 0, 6, 0, 6, 0, -6, 0, -4, 0, 4, 0, -2, 0, 2, 0, -3, 0, -3, 0, 3, 0, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 0, 6, 0, 6, 0, -6, 0}, + {18,-18,-18, 18,-18, 18, 18,-18, 12,-12,-12, 12, 6, -6, -6, 6, 9, -9, 9, -9, -9, 9, -9, 9, 12, 6,-12, -6,-12, -6, 12, 6}, + {-12,12, 12,-12, 12,-12,-12, 12, -8, 8, 8, -8, -4, 4, 4, -4, -6, 6, -6, 6, 6, -6, 6, -6, -6, -6, 6, 6, 6, 6, -6, -6}, + { 2, 0, 0, 0, -2, 0, 0, 0, 1, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, 0, 0, -2, 0, 0, 0}, + {-6, 6, 0, 0, 6, -6, 0, 0, -3, 3, 0, 0, -3, 3, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -4, -2, 0, 0, 4, 2, 0, 0}, + { 4, -4, 0, 0, -4, 4, 0, 0, 2, -2, 0, 0, 2, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 2, 0, 0, -2, -2, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 2, 0, 0, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 6, 0, 0, 6, -6, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 4, -4, 0, 0, -4, 4, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + {-6, 0, 6, 0, 6, 0, -6, 0, -3, 0, 3, 0, -3, 0, 3, 0, -4, 0, -2, 0, 4, 0, 2, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, -6, 0, 6, 0, 6, 0, -6, 0}, + {18,-18,-18, 18,-18, 18, 18,-18, 9, -9, -9, 9, 9, -9, -9, 9, 12,-12, 6, -6,-12, 12, -6, 6, 12, 6,-12, -6,-12, -6, 12, 6}, + {-12,12, 12,-12, 12,-12,-12, 12, -6, 6, 6, -6, -6, 6, 6, -6, -8, 8, -4, 4, 8, -8, 4, -4, -6, -6, 6, 6, 6, 6, -6, -6}, + { 4, 0, -4, 0, -4, 0, 4, 0, 2, 0, -2, 0, 2, 0, -2, 0, 2, 0, 2, 0, -2, 0, -2, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 4, 0, -4, 0, -4, 0, 4, 0}, + {-12,12, 12,-12, 12,-12,-12, 12, -6, 6, 6, -6, -6, 6, 6, -6, -6, 6, -6, 6, 6, -6, 6, -6, -8, -4, 8, 4, 8, 4, -8, -4}, + { 8, -8, -8, 8, -8, 8, 8, -8, 4, -4, -4, 4, 4, -4, -4, 4, 4, -4, 4, -4, -4, 4, -4, 4, 4, 4, -4, -4, -4, -4, 4, 4} }; double dx = xmax - xmin; double dy = ymax - ymin; @@ -4456,22 +4457,22 @@ void PairAIREBO::Spbicubic_patch_coeffs( ) { const double C_inv[16][12] = { // output_matrix(1, 4*3, get_matrix(2)) - 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0, - -3, 3, 0, 0, 0, 0, 0, 0,-2,-1, 0, 0, - 2,-2, 0, 0, 0, 0, 0, 0, 1, 1, 0, 0, - 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0,-3, 3, 0, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 2,-2, 0, 0, 0, 0, 0, 0, - -3, 0, 3, 0,-2, 0,-1, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0,-3, 0, 3, 0, - 9,-9,-9, 9, 6,-6, 3,-3, 6, 3,-6,-3, - -6, 6, 6,-6,-4, 4,-2, 2,-3,-3, 3, 3, - 2, 0,-2, 0, 1, 0, 1, 0, 0, 0, 0, 0, - 0, 0, 0, 0, 0, 0, 0, 0, 2, 0,-2, 0, - -6, 6, 6,-6,-3, 3,-3, 3,-4,-2, 4, 2, - 4,-4,-4, 4, 2,-2, 2,-2, 2, 2,-2,-2, + { 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, 0}, + {-3, 3, 0, 0, 0, 0, 0, 0,-2,-1, 0, 0}, + { 2,-2, 0, 0, 0, 0, 0, 0, 1, 1, 0, 0}, + { 0, 0, 0, 0, 1, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0,-3, 3, 0, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 2,-2, 0, 0, 0, 0, 0, 0}, + {-3, 0, 3, 0,-2, 0,-1, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0,-3, 0, 3, 0}, + { 9,-9,-9, 9, 6,-6, 3,-3, 6, 3,-6,-3}, + {-6, 6, 6,-6,-4, 4,-2, 2,-3,-3, 3, 3}, + { 2, 0,-2, 0, 1, 0, 1, 0, 0, 0, 0, 0}, + { 0, 0, 0, 0, 0, 0, 0, 0, 2, 0,-2, 0}, + {-6, 6, 6,-6,-3, 3,-3, 3,-4,-2, 4, 2}, + { 4,-4,-4, 4, 2,-2, 2,-2, 2, 2,-2,-2} }; double dx = xmax - xmin; double dy = ymax - ymin; -- GitLab From dbd0158d3f03abba93a219f8e7c40f097998d72e Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Thu, 11 Jul 2019 12:01:35 -0500 Subject: [PATCH 236/469] Adjust/update kim_query do_query() routine --- src/KIM/kim_query.cpp | 21 ++++++++++++++------- 1 file changed, 14 insertions(+), 7 deletions(-) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index 221dc9e804..6e77b8f859 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -124,7 +124,7 @@ void KimQuery::command(int narg, char **arg) // that was returned by the web server if (0 == strlen(value)) { - char errmsg[512]; + char errmsg[1024]; sprintf(errmsg,"OpenKIM query failed: %s",value+1); error->all(FLERR,errmsg); @@ -258,9 +258,15 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, if (value[0] == '[') { int len = strlen(value)-1; - retval = new char[len]; - value[len] = '\0'; - strcpy(retval,value+1); + if (value[len-1] == ']') { + retval = new char[len]; + value[len-1] = '\0'; + strcpy(retval,value+1); + } else { + retval = new char[len+2]; + retval[0] = '\0'; + strcpy(retval+1,value); + } } else if (value[0] == '\0') { int len = strlen(value+1)+2; retval = new char[len]; @@ -268,10 +274,11 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, strcpy(retval+1,value+1); } else { // unknown response type. we should not get here. - // copy response without modifications. - int len = strlen(value)+1; + // we return an "empty" string but add error message after it + int len = strlen(value)+2; retval = new char[len]; - strcpy(retval,value); + retval[0] = '\0'; + strcpy(retval+1,value); } return retval; } -- GitLab From 8e2f3e48832115af044efe39861b9a35480327fd Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Thu, 11 Jul 2019 12:04:54 -0500 Subject: [PATCH 237/469] Wording changes and removed duplicate text --- doc/src/kim_commands.txt | 8 +------- 1 file changed, 1 insertion(+), 7 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 437b768df6..f9615b8d5f 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -58,7 +58,7 @@ Reliability :h5 All content archived in OpenKIM is reviewed by the "KIM Editor"_https://openkim.org/governance/ for quality. IMs in OpenKIM are archived with full provenance control. Each is associated with a maintainer responsible for the integrity of the content. All changes are tracked and recorded. -IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/getting-started/kim-tests/ that compute a host of material properties, and "KIM Verification Checks"_https://openkim.org/about-verification-checks/ that provide the user with information on various aspects of the IM behavior and coding correctness. This information is displayed on the IM's page on "OpenKIM"_https://openkim.org. :ul +IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/getting-started/kim-tests/ that compute a host of material properties, and "KIM Verification Checks"_https://openkim.org/about-verification-checks/ that provide the user with information on various aspects of the IM behavior and coding correctness. This information is displayed on the IM's page accessible through the "OpenKIM browse interface"_https://openkim.org/browse. :ul Reproducibility :h5 @@ -407,12 +407,6 @@ separates the result values into individual variables of the form and {I} ranges from 1 to the number of returned values. The number and order of the returned values is determined by the type of query performed. -In the case where a query returns multiple results, the default behavior -for {kim_query} is to split these into individual variables of the form -{prefix_I}, where {prefix} is set to the the {kim_query} {variable} argument -and {I} ranges from 1 to the number of returned values. The number and order of -the returned values is determined by the type of query performed. - [Define a crystal at finite temperature accounting for thermal expansion] kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal -- GitLab From 3349ed00133553e8f2feac931b18b4cf4903cbdc Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Thu, 11 Jul 2019 12:22:36 -0500 Subject: [PATCH 238/469] Changed PM Page and SM Page to "Model Page" --- doc/src/kim_commands.txt | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 2a8f83e7a8..604aba4449 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -95,13 +95,12 @@ By convention SM prefixes begin with {Sim_} to readily identify them. SW_StillingerWeber_1985_Si__MO_405512056662_005 Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 :pre -Each OpenKIM IM has a dedicated page on "OpenKIM"_https://openkim.org +Each OpenKIM IM has a dedicated "Model Page" on "OpenKIM"_https://openkim.org providing all the information on the IM including a title, description, authorship and citation information, test and verification check results, visualizations of results, a wiki with documentation and user comments, and access to raw files, and other information. -This is referred to as the "PM Page" or "SM Page". -The URL for such a page is constructed from the +The URL for the Model Page is constructed from the "extended KIM ID"_https://openkim.org/about-kim-ids/ of the IM: https://openkim.org/id/extended_KIM_ID -- GitLab From 9f6bbe1d8e390a3614a10413dee95deb4d3c55cd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 14:21:55 -0400 Subject: [PATCH 239/469] recover compilation of KOKKOS package --- src/KOKKOS/fix_reaxc_species_kokkos.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/KOKKOS/fix_reaxc_species_kokkos.cpp b/src/KOKKOS/fix_reaxc_species_kokkos.cpp index 71aacba68d..f32bea2c67 100644 --- a/src/KOKKOS/fix_reaxc_species_kokkos.cpp +++ b/src/KOKKOS/fix_reaxc_species_kokkos.cpp @@ -23,6 +23,7 @@ #include "fix_ave_atom.h" #include "domain.h" #include "update.h" +#include "reaxc_defs.h" #include "pair_reaxc_kokkos.h" #include "modify.h" #include "neighbor.h" -- GitLab From 9718b99af969900fdd62614e9c0ccda418408eb6 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Thu, 11 Jul 2019 13:23:46 -0500 Subject: [PATCH 240/469] Clarification on what preceeds in kim_interactions --- doc/src/kim_commands.txt | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 604aba4449..a6551734f1 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -274,8 +274,8 @@ OpenKIM IM Execution ({kim_interactions}) :h5 The second and final step in using an OpenKIM IM is to execute the {kim_interactions} command. This command must be preceded by a {kim_init} -command and a command that creates the simulation box (such as -"create_box"_create_box.html), which defines the number of atom types {N}. +command and a command that defines the number of atom types {N} (such as +"create_box"_create_box.html). The {kim_interactions} command has one argument {typeargs}. This argument contains either a list of {N} chemical species, which defines a mapping between atom types in LAMMPS to the available species in the OpenKIM IM, or the -- GitLab From 48c73567436964589dd0a99d741be7e49530e53d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 16:51:48 -0400 Subject: [PATCH 241/469] starting to work on includes in USER-OMP --- src/USER-OMP/angle_charmm_omp.cpp | 8 ++------ src/USER-OMP/angle_class2_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_delta_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_periodic_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_shift_exp_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_shift_omp.cpp | 2 +- src/USER-OMP/angle_cosine_squared_omp.cpp | 8 ++------ src/USER-OMP/angle_dipole_omp.cpp | 8 ++------ src/USER-OMP/angle_fourier_omp.cpp | 2 +- src/USER-OMP/angle_fourier_simple_omp.cpp | 8 ++------ src/USER-OMP/angle_harmonic_omp.cpp | 8 ++------ src/USER-OMP/angle_quartic_omp.cpp | 2 +- src/USER-OMP/angle_sdk_omp.cpp | 8 ++------ src/USER-OMP/angle_table_omp.cpp | 8 ++------ src/USER-OMP/bond_class2_omp.cpp | 2 +- src/USER-OMP/bond_fene_expand_omp.cpp | 2 +- src/USER-OMP/bond_fene_omp.cpp | 2 +- src/USER-OMP/bond_gromos_omp.cpp | 2 +- src/USER-OMP/bond_harmonic_omp.cpp | 2 +- src/USER-OMP/bond_harmonic_shift_cut_omp.cpp | 2 +- src/USER-OMP/bond_harmonic_shift_omp.cpp | 2 +- src/USER-OMP/bond_morse_omp.cpp | 2 +- src/USER-OMP/bond_nonlinear_omp.cpp | 2 +- src/USER-OMP/bond_quartic_omp.cpp | 2 +- src/USER-OMP/bond_table_omp.cpp | 2 +- src/USER-OMP/dihedral_charmm_omp.cpp | 2 +- src/USER-OMP/dihedral_class2_omp.cpp | 2 +- src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp | 2 +- src/USER-OMP/dihedral_fourier_omp.cpp | 2 +- src/USER-OMP/dihedral_harmonic_omp.cpp | 2 +- src/USER-OMP/dihedral_helix_omp.cpp | 2 +- src/USER-OMP/dihedral_multi_harmonic_omp.cpp | 2 +- src/USER-OMP/dihedral_nharmonic_omp.cpp | 2 +- src/USER-OMP/dihedral_opls_omp.cpp | 2 +- src/USER-OMP/dihedral_quadratic_omp.cpp | 2 +- src/USER-OMP/dihedral_table_omp.cpp | 3 ++- src/USER-OMP/domain_omp.cpp | 1 - src/USER-OMP/fix_gravity_omp.cpp | 2 +- src/USER-OMP/fix_nh_omp.cpp | 4 +--- src/USER-OMP/fix_nh_sphere_omp.cpp | 3 --- src/USER-OMP/fix_nvt_sllod_omp.cpp | 5 +++-- src/USER-OMP/fix_omp.cpp | 10 +++++----- src/USER-OMP/fix_qeq_reax_omp.cpp | 2 +- src/USER-OMP/fix_rigid_nh_omp.cpp | 5 ++--- src/USER-OMP/fix_rigid_nph_omp.cpp | 2 +- src/USER-OMP/fix_rigid_npt_omp.cpp | 2 +- src/USER-OMP/fix_rigid_omp.cpp | 7 +++---- src/USER-OMP/fix_rigid_small_omp.cpp | 1 + src/USER-OMP/improper_class2_omp.cpp | 2 +- src/USER-OMP/improper_cossq_omp.cpp | 2 +- src/USER-OMP/improper_cvff_omp.cpp | 2 +- src/USER-OMP/improper_fourier_omp.cpp | 2 +- src/USER-OMP/improper_harmonic_omp.cpp | 2 +- src/USER-OMP/improper_ring_omp.cpp | 2 +- src/USER-OMP/improper_umbrella_omp.cpp | 2 +- src/USER-OMP/msm_cg_omp.cpp | 4 ++-- src/USER-OMP/msm_omp.cpp | 3 ++- src/USER-OMP/npair_full_bin_atomonly_omp.cpp | 1 + src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp | 2 +- src/USER-OMP/npair_halffull_newtoff_omp.cpp | 2 +- src/USER-OMP/npair_halffull_newton_omp.cpp | 2 +- src/USER-OMP/pair_brownian_omp.cpp | 3 ++- src/USER-OMP/pair_brownian_poly_omp.cpp | 2 +- src/USER-OMP/pair_lj_cut_thole_long_omp.cpp | 3 ++- src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp | 2 +- src/USER-OMP/pair_lubricate_poly_omp.cpp | 2 +- src/USER-OMP/pppm_cg_omp.cpp | 3 ++- src/USER-OMP/pppm_disp_omp.cpp | 3 ++- src/USER-OMP/pppm_disp_tip4p_omp.cpp | 3 ++- src/USER-OMP/pppm_omp.cpp | 3 ++- src/USER-OMP/respa_omp.cpp | 3 ++- src/USER-OMP/thr_data.h | 8 ++------ src/USER-OMP/thr_omp.cpp | 2 -- src/USER-OMP/thr_omp.h | 9 +++++---- src/special.cpp | 2 +- 76 files changed, 109 insertions(+), 158 deletions(-) diff --git a/src/USER-OMP/angle_charmm_omp.cpp b/src/USER-OMP/angle_charmm_omp.cpp index 118ba00226..f135446915 100644 --- a/src/USER-OMP/angle_charmm_omp.cpp +++ b/src/USER-OMP/angle_charmm_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_charmm_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_class2_omp.cpp b/src/USER-OMP/angle_class2_omp.cpp index e072d136e1..0cf5489663 100644 --- a/src/USER-OMP/angle_class2_omp.cpp +++ b/src/USER-OMP/angle_class2_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_class2_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_delta_omp.cpp b/src/USER-OMP/angle_cosine_delta_omp.cpp index a6dfb20433..7f4d994c4f 100644 --- a/src/USER-OMP/angle_cosine_delta_omp.cpp +++ b/src/USER-OMP/angle_cosine_delta_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_delta_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_omp.cpp b/src/USER-OMP/angle_cosine_omp.cpp index 9097c8569c..0543c94799 100644 --- a/src/USER-OMP/angle_cosine_omp.cpp +++ b/src/USER-OMP/angle_cosine_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_periodic_omp.cpp b/src/USER-OMP/angle_cosine_periodic_omp.cpp index 3fcea7ad1d..907315f83b 100644 --- a/src/USER-OMP/angle_cosine_periodic_omp.cpp +++ b/src/USER-OMP/angle_cosine_periodic_omp.cpp @@ -16,20 +16,16 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_periodic_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" +#include "timer.h" #include "math_special.h" -#include - #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace MathSpecial; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_shift_exp_omp.cpp b/src/USER-OMP/angle_cosine_shift_exp_omp.cpp index 6bd2feb023..6c42319905 100644 --- a/src/USER-OMP/angle_cosine_shift_exp_omp.cpp +++ b/src/USER-OMP/angle_cosine_shift_exp_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_shift_exp_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_shift_omp.cpp b/src/USER-OMP/angle_cosine_shift_omp.cpp index 56486faac1..2eea790595 100644 --- a/src/USER-OMP/angle_cosine_shift_omp.cpp +++ b/src/USER-OMP/angle_cosine_shift_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "math_const.h" diff --git a/src/USER-OMP/angle_cosine_squared_omp.cpp b/src/USER-OMP/angle_cosine_squared_omp.cpp index 6dd2a3bb3b..27c47b90d8 100644 --- a/src/USER-OMP/angle_cosine_squared_omp.cpp +++ b/src/USER-OMP/angle_cosine_squared_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_squared_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_dipole_omp.cpp b/src/USER-OMP/angle_dipole_omp.cpp index da2e819ee2..6af5b44a03 100644 --- a/src/USER-OMP/angle_dipole_omp.cpp +++ b/src/USER-OMP/angle_dipole_omp.cpp @@ -16,20 +16,16 @@ ------------------------------------------------------------------------- */ #include "angle_dipole_omp.h" +#include #include "atom.h" #include "comm.h" #include "error.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_fourier_omp.cpp b/src/USER-OMP/angle_fourier_omp.cpp index b2f9b47e05..52736ca60f 100644 --- a/src/USER-OMP/angle_fourier_omp.cpp +++ b/src/USER-OMP/angle_fourier_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "math_const.h" diff --git a/src/USER-OMP/angle_fourier_simple_omp.cpp b/src/USER-OMP/angle_fourier_simple_omp.cpp index 93532a30e5..71d0197b72 100644 --- a/src/USER-OMP/angle_fourier_simple_omp.cpp +++ b/src/USER-OMP/angle_fourier_simple_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_fourier_simple_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_harmonic_omp.cpp b/src/USER-OMP/angle_harmonic_omp.cpp index 824b254287..ee08bbd8ad 100644 --- a/src/USER-OMP/angle_harmonic_omp.cpp +++ b/src/USER-OMP/angle_harmonic_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_harmonic_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_quartic_omp.cpp b/src/USER-OMP/angle_quartic_omp.cpp index fff08ddb39..f97f39b16a 100644 --- a/src/USER-OMP/angle_quartic_omp.cpp +++ b/src/USER-OMP/angle_quartic_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "math_const.h" diff --git a/src/USER-OMP/angle_sdk_omp.cpp b/src/USER-OMP/angle_sdk_omp.cpp index e8c762092c..e0b1da0baf 100644 --- a/src/USER-OMP/angle_sdk_omp.cpp +++ b/src/USER-OMP/angle_sdk_omp.cpp @@ -16,20 +16,16 @@ ------------------------------------------------------------------------- */ #include "angle_sdk_omp.h" +#include #include "atom.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "comm.h" #include "force.h" -#include "math_const.h" - -#include - #include "lj_sdk_common.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace LJSDKParms; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_table_omp.cpp b/src/USER-OMP/angle_table_omp.cpp index d9d80b744d..4f6edf2073 100644 --- a/src/USER-OMP/angle_table_omp.cpp +++ b/src/USER-OMP/angle_table_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_table_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/bond_class2_omp.cpp b/src/USER-OMP/bond_class2_omp.cpp index fdd73c20b0..7d1b693faf 100644 --- a/src/USER-OMP/bond_class2_omp.cpp +++ b/src/USER-OMP/bond_class2_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_fene_expand_omp.cpp b/src/USER-OMP/bond_fene_expand_omp.cpp index a8eec11760..aefae6dcf7 100644 --- a/src/USER-OMP/bond_fene_expand_omp.cpp +++ b/src/USER-OMP/bond_fene_expand_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "error.h" #include "update.h" diff --git a/src/USER-OMP/bond_fene_omp.cpp b/src/USER-OMP/bond_fene_omp.cpp index be7dcd4b49..2b579114ba 100644 --- a/src/USER-OMP/bond_fene_omp.cpp +++ b/src/USER-OMP/bond_fene_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "error.h" #include "update.h" diff --git a/src/USER-OMP/bond_gromos_omp.cpp b/src/USER-OMP/bond_gromos_omp.cpp index 8f0926c0e9..88ef1dc23e 100644 --- a/src/USER-OMP/bond_gromos_omp.cpp +++ b/src/USER-OMP/bond_gromos_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_harmonic_omp.cpp b/src/USER-OMP/bond_harmonic_omp.cpp index a3bb69c53c..5515284f9a 100644 --- a/src/USER-OMP/bond_harmonic_omp.cpp +++ b/src/USER-OMP/bond_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp b/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp index 5c16e27a32..a871fa8c04 100644 --- a/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp +++ b/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_harmonic_shift_omp.cpp b/src/USER-OMP/bond_harmonic_shift_omp.cpp index 39e957c137..4117da9159 100644 --- a/src/USER-OMP/bond_harmonic_shift_omp.cpp +++ b/src/USER-OMP/bond_harmonic_shift_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_morse_omp.cpp b/src/USER-OMP/bond_morse_omp.cpp index c0203de0d6..e6526dc8dc 100644 --- a/src/USER-OMP/bond_morse_omp.cpp +++ b/src/USER-OMP/bond_morse_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_nonlinear_omp.cpp b/src/USER-OMP/bond_nonlinear_omp.cpp index 8fa3daf8ab..0d1a648415 100644 --- a/src/USER-OMP/bond_nonlinear_omp.cpp +++ b/src/USER-OMP/bond_nonlinear_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_quartic_omp.cpp b/src/USER-OMP/bond_quartic_omp.cpp index fd0ccaf79d..60d3a5601c 100644 --- a/src/USER-OMP/bond_quartic_omp.cpp +++ b/src/USER-OMP/bond_quartic_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "pair.h" #include diff --git a/src/USER-OMP/bond_table_omp.cpp b/src/USER-OMP/bond_table_omp.cpp index 1616988385..8e1e792c73 100644 --- a/src/USER-OMP/bond_table_omp.cpp +++ b/src/USER-OMP/bond_table_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/dihedral_charmm_omp.cpp b/src/USER-OMP/dihedral_charmm_omp.cpp index b09863613e..49dbd54035 100644 --- a/src/USER-OMP/dihedral_charmm_omp.cpp +++ b/src/USER-OMP/dihedral_charmm_omp.cpp @@ -21,7 +21,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "pair.h" #include "update.h" diff --git a/src/USER-OMP/dihedral_class2_omp.cpp b/src/USER-OMP/dihedral_class2_omp.cpp index 03ac9d9bab..6c2bc02ff4 100644 --- a/src/USER-OMP/dihedral_class2_omp.cpp +++ b/src/USER-OMP/dihedral_class2_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp b/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp index c64cad9fc3..d77e9d6b3e 100644 --- a/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp +++ b/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_fourier_omp.cpp b/src/USER-OMP/dihedral_fourier_omp.cpp index 94bdae3795..e853f56051 100644 --- a/src/USER-OMP/dihedral_fourier_omp.cpp +++ b/src/USER-OMP/dihedral_fourier_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_harmonic_omp.cpp b/src/USER-OMP/dihedral_harmonic_omp.cpp index 10ccbd3d9f..84aa584d9e 100644 --- a/src/USER-OMP/dihedral_harmonic_omp.cpp +++ b/src/USER-OMP/dihedral_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_helix_omp.cpp b/src/USER-OMP/dihedral_helix_omp.cpp index 8c8e29cac0..51b07754e2 100644 --- a/src/USER-OMP/dihedral_helix_omp.cpp +++ b/src/USER-OMP/dihedral_helix_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "math_const.h" diff --git a/src/USER-OMP/dihedral_multi_harmonic_omp.cpp b/src/USER-OMP/dihedral_multi_harmonic_omp.cpp index 38961e1746..4cb6919a96 100644 --- a/src/USER-OMP/dihedral_multi_harmonic_omp.cpp +++ b/src/USER-OMP/dihedral_multi_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_nharmonic_omp.cpp b/src/USER-OMP/dihedral_nharmonic_omp.cpp index e74238265d..203884531b 100644 --- a/src/USER-OMP/dihedral_nharmonic_omp.cpp +++ b/src/USER-OMP/dihedral_nharmonic_omp.cpp @@ -20,10 +20,10 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "error.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/dihedral_opls_omp.cpp b/src/USER-OMP/dihedral_opls_omp.cpp index 64eaffe6fe..af12bb866e 100644 --- a/src/USER-OMP/dihedral_opls_omp.cpp +++ b/src/USER-OMP/dihedral_opls_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_quadratic_omp.cpp b/src/USER-OMP/dihedral_quadratic_omp.cpp index 8df622b847..8cea62aaea 100644 --- a/src/USER-OMP/dihedral_quadratic_omp.cpp +++ b/src/USER-OMP/dihedral_quadratic_omp.cpp @@ -20,10 +20,10 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "error.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/dihedral_table_omp.cpp b/src/USER-OMP/dihedral_table_omp.cpp index 792ee90c26..928af079e8 100644 --- a/src/USER-OMP/dihedral_table_omp.cpp +++ b/src/USER-OMP/dihedral_table_omp.cpp @@ -22,11 +22,12 @@ #include "dihedral_table_omp.h" #include "atom.h" #include "comm.h" -#include "neighbor.h" #include "domain.h" +#include "neighbor.h" #include "force.h" #include "update.h" #include "error.h" +#include "timer.h" #include "math_const.h" #include "math_extra.h" diff --git a/src/USER-OMP/domain_omp.cpp b/src/USER-OMP/domain_omp.cpp index 584e56b1f0..a18931c551 100644 --- a/src/USER-OMP/domain_omp.cpp +++ b/src/USER-OMP/domain_omp.cpp @@ -15,7 +15,6 @@ Contributing author : Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include "domain.h" #include "accelerator_omp.h" #include "atom.h" diff --git a/src/USER-OMP/fix_gravity_omp.cpp b/src/USER-OMP/fix_gravity_omp.cpp index eae918ec52..ae00c44ffb 100644 --- a/src/USER-OMP/fix_gravity_omp.cpp +++ b/src/USER-OMP/fix_gravity_omp.cpp @@ -22,7 +22,7 @@ #include "fix_gravity_omp.h" #include "atom.h" #include "update.h" -#include "domain.h" +#include "timer.h" #include "input.h" #include "modify.h" #include "respa.h" diff --git a/src/USER-OMP/fix_nh_omp.cpp b/src/USER-OMP/fix_nh_omp.cpp index 76a47b71fd..2abd739f71 100644 --- a/src/USER-OMP/fix_nh_omp.cpp +++ b/src/USER-OMP/fix_nh_omp.cpp @@ -16,15 +16,13 @@ ------------------------------------------------------------------------- */ #include "fix_nh_omp.h" +#include #include "atom.h" #include "compute.h" #include "domain.h" #include "error.h" #include "modify.h" -#include -#include - using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_nh_sphere_omp.cpp b/src/USER-OMP/fix_nh_sphere_omp.cpp index a32f0f8b51..64bc536bb0 100644 --- a/src/USER-OMP/fix_nh_sphere_omp.cpp +++ b/src/USER-OMP/fix_nh_sphere_omp.cpp @@ -15,12 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "fix_nh_sphere_omp.h" #include "atom.h" -#include "atom_vec.h" #include "compute.h" -#include "group.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/fix_nvt_sllod_omp.cpp b/src/USER-OMP/fix_nvt_sllod_omp.cpp index e439647c12..6944cf15af 100644 --- a/src/USER-OMP/fix_nvt_sllod_omp.cpp +++ b/src/USER-OMP/fix_nvt_sllod_omp.cpp @@ -15,18 +15,19 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_nvt_sllod_omp.h" #include #include -#include "fix_nvt_sllod_omp.h" #include "math_extra.h" #include "atom.h" -#include "domain.h" #include "group.h" #include "modify.h" #include "fix.h" #include "fix_deform.h" #include "compute.h" #include "error.h" +#include "domain.h" +#include "timer.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_omp.cpp b/src/USER-OMP/fix_omp.cpp index a4587b1c14..1fca1e739b 100644 --- a/src/USER-OMP/fix_omp.cpp +++ b/src/USER-OMP/fix_omp.cpp @@ -24,13 +24,10 @@ #include "neigh_request.h" #include "universe.h" #include "update.h" -#include "integrate.h" -#include "min.h" #include "timer.h" #include "fix_omp.h" #include "thr_data.h" -#include "thr_omp.h" #include "pair_hybrid.h" #include "bond_hybrid.h" @@ -40,8 +37,11 @@ #include "kspace.h" #include -#include -#include + +#if defined(_OPENMP) +#include +#endif + #include "suffix.h" diff --git a/src/USER-OMP/fix_qeq_reax_omp.cpp b/src/USER-OMP/fix_qeq_reax_omp.cpp index 45da91305d..5c50c54bff 100644 --- a/src/USER-OMP/fix_qeq_reax_omp.cpp +++ b/src/USER-OMP/fix_qeq_reax_omp.cpp @@ -39,7 +39,7 @@ #include "pair_reaxc_omp.h" #include "atom.h" #include "comm.h" -#include "domain.h" +#include "timer.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/USER-OMP/fix_rigid_nh_omp.cpp b/src/USER-OMP/fix_rigid_nh_omp.cpp index e6a6e065bf..74b2a92775 100644 --- a/src/USER-OMP/fix_rigid_nh_omp.cpp +++ b/src/USER-OMP/fix_rigid_nh_omp.cpp @@ -15,11 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_rigid_nh_omp.h" #include #include - -#include "fix_rigid_nh_omp.h" - #include "atom.h" #include "atom_vec_ellipsoid.h" #include "atom_vec_line.h" @@ -32,6 +30,7 @@ #include "kspace.h" #include "modify.h" #include "update.h" +#include "timer.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/fix_rigid_nph_omp.cpp b/src/USER-OMP/fix_rigid_nph_omp.cpp index 7db45ed9bf..af59b65996 100644 --- a/src/USER-OMP/fix_rigid_nph_omp.cpp +++ b/src/USER-OMP/fix_rigid_nph_omp.cpp @@ -19,7 +19,7 @@ #include #include "fix_rigid_nph_omp.h" -#include "domain.h" +#include "timer.h" #include "modify.h" #include "error.h" diff --git a/src/USER-OMP/fix_rigid_npt_omp.cpp b/src/USER-OMP/fix_rigid_npt_omp.cpp index a041706f38..744b27ce01 100644 --- a/src/USER-OMP/fix_rigid_npt_omp.cpp +++ b/src/USER-OMP/fix_rigid_npt_omp.cpp @@ -19,7 +19,7 @@ #include #include "fix_rigid_npt_omp.h" -#include "domain.h" +#include "timer.h" #include "modify.h" #include "error.h" diff --git a/src/USER-OMP/fix_rigid_omp.cpp b/src/USER-OMP/fix_rigid_omp.cpp index 20478b3ca1..2e97adab35 100644 --- a/src/USER-OMP/fix_rigid_omp.cpp +++ b/src/USER-OMP/fix_rigid_omp.cpp @@ -15,18 +15,17 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_rigid_omp.h" #include #include - -#include "fix_rigid_omp.h" - #include "atom.h" #include "atom_vec_ellipsoid.h" #include "atom_vec_line.h" #include "atom_vec_tri.h" #include "comm.h" -#include "domain.h" #include "error.h" +#include "domain.h" +#include "timer.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/fix_rigid_small_omp.cpp b/src/USER-OMP/fix_rigid_small_omp.cpp index 1f6173497d..f8fea815c8 100644 --- a/src/USER-OMP/fix_rigid_small_omp.cpp +++ b/src/USER-OMP/fix_rigid_small_omp.cpp @@ -25,6 +25,7 @@ #include "atom_vec_tri.h" #include "comm.h" #include "domain.h" +#include "timer.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/improper_class2_omp.cpp b/src/USER-OMP/improper_class2_omp.cpp index c2b493f425..3bff179b44 100644 --- a/src/USER-OMP/improper_class2_omp.cpp +++ b/src/USER-OMP/improper_class2_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_cossq_omp.cpp b/src/USER-OMP/improper_cossq_omp.cpp index 3b328e5b78..0f99f2732f 100644 --- a/src/USER-OMP/improper_cossq_omp.cpp +++ b/src/USER-OMP/improper_cossq_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_cvff_omp.cpp b/src/USER-OMP/improper_cvff_omp.cpp index fe1fc45bec..fdc29c74b1 100644 --- a/src/USER-OMP/improper_cvff_omp.cpp +++ b/src/USER-OMP/improper_cvff_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_fourier_omp.cpp b/src/USER-OMP/improper_fourier_omp.cpp index b5af428cb9..b49b895c78 100644 --- a/src/USER-OMP/improper_fourier_omp.cpp +++ b/src/USER-OMP/improper_fourier_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_harmonic_omp.cpp b/src/USER-OMP/improper_harmonic_omp.cpp index 6e02d0968e..32e837fdfe 100644 --- a/src/USER-OMP/improper_harmonic_omp.cpp +++ b/src/USER-OMP/improper_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_ring_omp.cpp b/src/USER-OMP/improper_ring_omp.cpp index e198b99337..6d6c1094ec 100644 --- a/src/USER-OMP/improper_ring_omp.cpp +++ b/src/USER-OMP/improper_ring_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_umbrella_omp.cpp b/src/USER-OMP/improper_umbrella_omp.cpp index ceaca35074..f3fdf4570f 100644 --- a/src/USER-OMP/improper_umbrella_omp.cpp +++ b/src/USER-OMP/improper_umbrella_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/msm_cg_omp.cpp b/src/USER-OMP/msm_cg_omp.cpp index 8a920e05d5..94c64cd0cf 100644 --- a/src/USER-OMP/msm_cg_omp.cpp +++ b/src/USER-OMP/msm_cg_omp.cpp @@ -16,6 +16,7 @@ Original MSM class by: Paul Crozier, Stan Moore, Stephen Bond, (all SNL) ------------------------------------------------------------------------- */ +#include "msm_cg_omp.h" #include #include #include @@ -29,9 +30,8 @@ #include "force.h" #include "neighbor.h" #include "memory.h" -#include "msm_cg_omp.h" - #include "math_const.h" +#include "timer.h" using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/USER-OMP/msm_omp.cpp b/src/USER-OMP/msm_omp.cpp index 74cbb56be7..51aaa35d63 100644 --- a/src/USER-OMP/msm_omp.cpp +++ b/src/USER-OMP/msm_omp.cpp @@ -16,6 +16,7 @@ ------------------------------------------------------------------------- */ #include "msm_omp.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" @@ -23,8 +24,8 @@ #include "force.h" #include "memory.h" #include "math_const.h" +#include "timer.h" -#include #if defined(_OPENMP) #include diff --git a/src/USER-OMP/npair_full_bin_atomonly_omp.cpp b/src/USER-OMP/npair_full_bin_atomonly_omp.cpp index d9e0fb9297..a6a3f3e748 100644 --- a/src/USER-OMP/npair_full_bin_atomonly_omp.cpp +++ b/src/USER-OMP/npair_full_bin_atomonly_omp.cpp @@ -20,6 +20,7 @@ #include "domain.h" #include "my_page.h" #include "error.h" +#include "timer.h" using namespace LAMMPS_NS; using namespace NeighConst; diff --git a/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp b/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp index 02d98ff6ab..5a87ad1ea6 100644 --- a/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp +++ b/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp @@ -18,7 +18,7 @@ #include "atom.h" #include "atom_vec.h" #include "molecule.h" -#include "domain.h" +#include "timer.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/npair_halffull_newtoff_omp.cpp b/src/USER-OMP/npair_halffull_newtoff_omp.cpp index 947e4e1ad2..6f90f82752 100644 --- a/src/USER-OMP/npair_halffull_newtoff_omp.cpp +++ b/src/USER-OMP/npair_halffull_newtoff_omp.cpp @@ -18,7 +18,7 @@ #include "atom.h" #include "atom_vec.h" #include "molecule.h" -#include "domain.h" +#include "timer.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/npair_halffull_newton_omp.cpp b/src/USER-OMP/npair_halffull_newton_omp.cpp index 6e158d372d..6cf8ab8ac2 100644 --- a/src/USER-OMP/npair_halffull_newton_omp.cpp +++ b/src/USER-OMP/npair_halffull_newton_omp.cpp @@ -18,7 +18,7 @@ #include "atom.h" #include "atom_vec.h" #include "molecule.h" -#include "domain.h" +#include "timer.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/pair_brownian_omp.cpp b/src/USER-OMP/pair_brownian_omp.cpp index cef9fb0955..6367976c7d 100644 --- a/src/USER-OMP/pair_brownian_omp.cpp +++ b/src/USER-OMP/pair_brownian_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_brownian_omp.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" @@ -26,6 +26,7 @@ #include "random_mars.h" #include "math_const.h" #include "math_special.h" +#include "timer.h" #include "fix_wall.h" diff --git a/src/USER-OMP/pair_brownian_poly_omp.cpp b/src/USER-OMP/pair_brownian_poly_omp.cpp index 239a820242..dcb4124634 100644 --- a/src/USER-OMP/pair_brownian_poly_omp.cpp +++ b/src/USER-OMP/pair_brownian_poly_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_brownian_poly_omp.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp b/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp index d0db6262b1..87d637e80d 100644 --- a/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp +++ b/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp @@ -22,6 +22,7 @@ #include #include "atom.h" #include "comm.h" +#include "domain.h" #include "fix_drude.h" #include "force.h" #include "neighbor.h" @@ -30,7 +31,7 @@ #include "math_const.h" #include "error.h" #include "suffix.h" -#include "domain.h" +#include "timer.h" using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp b/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp index e2c1da1a89..18fc207015 100644 --- a/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp +++ b/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_lj_cut_tip4p_long_omp.h" +#include #include "atom.h" #include "domain.h" #include "comm.h" diff --git a/src/USER-OMP/pair_lubricate_poly_omp.cpp b/src/USER-OMP/pair_lubricate_poly_omp.cpp index 3a5f03364d..04ac59b121 100644 --- a/src/USER-OMP/pair_lubricate_poly_omp.cpp +++ b/src/USER-OMP/pair_lubricate_poly_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_lubricate_poly_omp.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/USER-OMP/pppm_cg_omp.cpp b/src/USER-OMP/pppm_cg_omp.cpp index 2b4619f685..f20fa37683 100644 --- a/src/USER-OMP/pppm_cg_omp.cpp +++ b/src/USER-OMP/pppm_cg_omp.cpp @@ -15,9 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_cg_omp.h" #include #include -#include "pppm_cg_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" @@ -28,6 +28,7 @@ #include "memory.h" #include "math_const.h" #include "math_special.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pppm_disp_omp.cpp b/src/USER-OMP/pppm_disp_omp.cpp index 435341a31c..295bd66266 100644 --- a/src/USER-OMP/pppm_disp_omp.cpp +++ b/src/USER-OMP/pppm_disp_omp.cpp @@ -16,15 +16,16 @@ Rolf Isele-Holder (RWTH Aachen University) ------------------------------------------------------------------------- */ +#include "pppm_disp_omp.h" #include #include -#include "pppm_disp_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" #include "force.h" #include "memory.h" #include "math_const.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pppm_disp_tip4p_omp.cpp b/src/USER-OMP/pppm_disp_tip4p_omp.cpp index a53c5b2ac5..04dec7365e 100644 --- a/src/USER-OMP/pppm_disp_tip4p_omp.cpp +++ b/src/USER-OMP/pppm_disp_tip4p_omp.cpp @@ -15,9 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_disp_tip4p_omp.h" #include #include -#include "pppm_disp_tip4p_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" @@ -27,6 +27,7 @@ #include "memory.h" #include "math_const.h" #include "math_special.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pppm_omp.cpp b/src/USER-OMP/pppm_omp.cpp index 66190b3f51..73b257efa9 100644 --- a/src/USER-OMP/pppm_omp.cpp +++ b/src/USER-OMP/pppm_omp.cpp @@ -15,9 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_omp.h" #include #include -#include "pppm_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" @@ -27,6 +27,7 @@ #include "memory.h" #include "math_const.h" #include "math_special.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/respa_omp.cpp b/src/USER-OMP/respa_omp.cpp index 9c8555c66d..4a7757723f 100644 --- a/src/USER-OMP/respa_omp.cpp +++ b/src/USER-OMP/respa_omp.cpp @@ -19,9 +19,9 @@ #include #include "respa_omp.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "atom.h" +#include "domain.h" #include "force.h" #include "pair.h" #include "bond.h" @@ -37,6 +37,7 @@ #include "timer.h" #include "memory.h" #include "error.h" +#include "timer.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/thr_data.h b/src/USER-OMP/thr_data.h index 3cea1b0018..edff17cad3 100644 --- a/src/USER-OMP/thr_data.h +++ b/src/USER-OMP/thr_data.h @@ -18,10 +18,6 @@ #ifndef LMP_THR_DATA_H #define LMP_THR_DATA_H -#if defined(_OPENMP) -#include -#endif - #include "timer.h" namespace LAMMPS_NS { @@ -35,7 +31,7 @@ class ThrData { public: ThrData(int tid, class Timer *t); - ~ThrData() { delete _timer; _timer = NULL; }; + ~ThrData() { delete _timer; _timer = nullptr; }; void check_tid(int); // thread id consistency check int get_tid() const { return _tid; }; // our thread id. @@ -140,7 +136,7 @@ class ThrData { // disabled default methods private: - ThrData() : _tid(-1), _timer(NULL) {}; + ThrData() : _tid(-1), _timer(nullptr) {}; }; //////////////////////////////////////////////////////////////////////// diff --git a/src/USER-OMP/thr_omp.cpp b/src/USER-OMP/thr_omp.cpp index 22f751e6c0..51030358d3 100644 --- a/src/USER-OMP/thr_omp.cpp +++ b/src/USER-OMP/thr_omp.cpp @@ -22,7 +22,6 @@ #include "comm.h" #include "error.h" #include "force.h" -#include "memory.h" #include "modify.h" #include "neighbor.h" #include "timer.h" @@ -34,7 +33,6 @@ #include "angle.h" #include "dihedral.h" #include "improper.h" -#include "kspace.h" #include "compute.h" #include "math_const.h" diff --git a/src/USER-OMP/thr_omp.h b/src/USER-OMP/thr_omp.h index 87d921290e..062d77bc0e 100644 --- a/src/USER-OMP/thr_omp.h +++ b/src/USER-OMP/thr_omp.h @@ -18,10 +18,13 @@ #ifndef LMP_THR_OMP_H #define LMP_THR_OMP_H +#if defined(_OPENMP) +#include +#endif #include "pointers.h" #include "error.h" -#include "fix_omp.h" -#include "thr_data.h" +#include "fix_omp.h" // IWYU pragma: export +#include "thr_data.h" // IWYU pragma: export namespace LAMMPS_NS { @@ -31,8 +34,6 @@ class Bond; class Angle; class Dihedral; class Improper; -class KSpace; -class Fix; class ThrOMP { diff --git a/src/special.cpp b/src/special.cpp index b64aa96e2b..3dd817bc7f 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -19,7 +19,7 @@ #include "comm.h" #include "modify.h" #include "fix.h" -#include "accelerator_kokkos.h" +#include "accelerator_kokkos.h" // IWYU pragma: export #include "atom_masks.h" #include "memory.h" -- GitLab From 944c3bc91d3b372397f5dc30f843cca787110cb0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 17:42:58 -0400 Subject: [PATCH 242/469] fix bug reported by jesse carter on lammps-users --- src/USER-INTEL/fix_nh_intel.cpp | 2 +- src/USER-INTEL/fix_nve_intel.cpp | 11 +++++++++++ 2 files changed, 12 insertions(+), 1 deletion(-) diff --git a/src/USER-INTEL/fix_nh_intel.cpp b/src/USER-INTEL/fix_nh_intel.cpp index bf4764f104..a072e823a4 100644 --- a/src/USER-INTEL/fix_nh_intel.cpp +++ b/src/USER-INTEL/fix_nh_intel.cpp @@ -335,7 +335,7 @@ void FixNHIntel::reset_dt() if (nlocal > _nlocal_max) { if (_nlocal_max) memory->destroy(_dtfm); _nlocal_max = static_cast(1.20 * nlocal); - memory->create(_dtfm, _nlocal_max * 3, "fix_nve_intel:dtfm"); + memory->create(_dtfm, _nlocal_max * 3, "fix_nh_intel:dtfm"); } _nlocal3 = nlocal * 3; diff --git a/src/USER-INTEL/fix_nve_intel.cpp b/src/USER-INTEL/fix_nve_intel.cpp index 7dee31d2f4..f5d0513b65 100644 --- a/src/USER-INTEL/fix_nve_intel.cpp +++ b/src/USER-INTEL/fix_nve_intel.cpp @@ -75,6 +75,7 @@ void FixNVEIntel::initial_integrate(int /*vflag*/) x[i] += dtv * v[i]; } } else if (igroup == 0) { + if (neighbor->ago == 0) reset_dt(); #if defined(LMP_SIMD_COMPILER) #pragma vector aligned #pragma simd @@ -84,6 +85,7 @@ void FixNVEIntel::initial_integrate(int /*vflag*/) x[i] += dtv * v[i]; } } else { + if (neighbor->ago == 0) reset_dt(); #if defined(LMP_SIMD_COMPILER) #pragma vector aligned #pragma simd @@ -114,6 +116,15 @@ void FixNVEIntel::final_integrate() #endif for (int i = 0; i < _nlocal3; i++) v[i] += dtfm * f[i]; + } else if (igroup == 0) { + if (neighbor->ago == 0) reset_dt(); + #if defined(LMP_SIMD_COMPILER) + #pragma vector aligned + #pragma simd + #endif + for (int i = 0; i < _nlocal3; i++) { + v[i] += _dtfm[i] * f[i]; + } } else { if (neighbor->ago == 0) reset_dt(); #if defined(LMP_SIMD_COMPILER) -- GitLab From b4f60ef477d86cf541bb10d7e3262e03c3fed036 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 16:51:48 -0400 Subject: [PATCH 243/469] starting to work on includes in USER-OMP --- src/USER-OMP/angle_charmm_omp.cpp | 8 ++------ src/USER-OMP/angle_class2_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_delta_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_periodic_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_shift_exp_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_shift_omp.cpp | 8 ++------ src/USER-OMP/angle_cosine_squared_omp.cpp | 8 ++------ src/USER-OMP/angle_dipole_omp.cpp | 8 ++------ src/USER-OMP/angle_fourier_omp.cpp | 8 ++------ src/USER-OMP/angle_fourier_simple_omp.cpp | 8 ++------ src/USER-OMP/angle_harmonic_omp.cpp | 8 ++------ src/USER-OMP/angle_quartic_omp.cpp | 8 ++------ src/USER-OMP/angle_sdk_omp.cpp | 8 ++------ src/USER-OMP/angle_table_omp.cpp | 8 ++------ src/USER-OMP/bond_class2_omp.cpp | 2 +- src/USER-OMP/bond_fene_expand_omp.cpp | 2 +- src/USER-OMP/bond_fene_omp.cpp | 2 +- src/USER-OMP/bond_gromos_omp.cpp | 4 +--- src/USER-OMP/bond_harmonic_omp.cpp | 2 +- src/USER-OMP/bond_harmonic_shift_cut_omp.cpp | 2 +- src/USER-OMP/bond_harmonic_shift_omp.cpp | 2 +- src/USER-OMP/bond_morse_omp.cpp | 2 +- src/USER-OMP/bond_nonlinear_omp.cpp | 2 +- src/USER-OMP/bond_quartic_omp.cpp | 2 +- src/USER-OMP/bond_table_omp.cpp | 2 +- src/USER-OMP/dihedral_charmm_omp.cpp | 5 ++--- src/USER-OMP/dihedral_class2_omp.cpp | 2 +- .../dihedral_cosine_shift_exp_omp.cpp | 2 +- src/USER-OMP/dihedral_fourier_omp.cpp | 6 ++---- src/USER-OMP/dihedral_harmonic_omp.cpp | 2 +- src/USER-OMP/dihedral_helix_omp.cpp | 2 +- src/USER-OMP/dihedral_multi_harmonic_omp.cpp | 2 +- src/USER-OMP/dihedral_nharmonic_omp.cpp | 2 +- src/USER-OMP/dihedral_opls_omp.cpp | 2 +- src/USER-OMP/dihedral_quadratic_omp.cpp | 2 +- src/USER-OMP/dihedral_table_omp.cpp | 11 +++-------- src/USER-OMP/domain_omp.cpp | 1 - src/USER-OMP/ewald_omp.cpp | 7 +++---- src/USER-OMP/fix_gravity_omp.cpp | 7 ------- src/USER-OMP/fix_neigh_history_omp.cpp | 7 +------ src/USER-OMP/fix_nh_omp.cpp | 4 +--- src/USER-OMP/fix_nh_sphere_omp.cpp | 3 --- src/USER-OMP/fix_nve_omp.cpp | 1 - src/USER-OMP/fix_nve_sphere_omp.cpp | 8 +------- src/USER-OMP/fix_nvt_sllod_omp.cpp | 5 ++--- src/USER-OMP/fix_omp.cpp | 10 +++++----- src/USER-OMP/fix_qeq_comb_omp.cpp | 8 ++------ src/USER-OMP/fix_qeq_reax_omp.cpp | 19 +++++++------------ src/USER-OMP/fix_rigid_nh_omp.cpp | 5 ++--- src/USER-OMP/fix_rigid_nph_omp.cpp | 3 +-- src/USER-OMP/fix_rigid_npt_omp.cpp | 3 +-- src/USER-OMP/fix_rigid_omp.cpp | 7 +++---- src/USER-OMP/fix_rigid_small_omp.cpp | 4 +--- src/USER-OMP/improper_class2_omp.cpp | 2 +- src/USER-OMP/improper_cossq_omp.cpp | 2 +- src/USER-OMP/improper_cvff_omp.cpp | 2 +- src/USER-OMP/improper_fourier_omp.cpp | 2 +- src/USER-OMP/improper_harmonic_omp.cpp | 2 +- src/USER-OMP/improper_ring_omp.cpp | 6 ++---- src/USER-OMP/improper_umbrella_omp.cpp | 2 +- src/USER-OMP/msm_cg_omp.cpp | 10 ++++++---- src/USER-OMP/msm_omp.cpp | 8 ++------ src/USER-OMP/npair_full_bin_atomonly_omp.cpp | 2 -- src/USER-OMP/npair_full_bin_ghost_omp.cpp | 1 - src/USER-OMP/npair_full_multi_omp.cpp | 1 - src/USER-OMP/npair_full_nsq_ghost_omp.cpp | 1 - src/USER-OMP/npair_full_nsq_omp.cpp | 1 - .../npair_half_bin_atomonly_newton_omp.cpp | 3 --- .../npair_half_bin_newtoff_ghost_omp.cpp | 1 - src/USER-OMP/npair_half_bin_newtoff_omp.cpp | 1 - src/USER-OMP/npair_half_bin_newton_omp.cpp | 2 -- .../npair_half_bin_newton_tri_omp.cpp | 1 - src/USER-OMP/npair_half_multi_newtoff_omp.cpp | 1 - src/USER-OMP/npair_half_multi_newton_omp.cpp | 1 - src/USER-OMP/npair_halffull_newtoff_omp.cpp | 2 +- src/USER-OMP/npair_halffull_newton_omp.cpp | 2 +- src/USER-OMP/pair_brownian_omp.cpp | 3 ++- src/USER-OMP/pair_brownian_poly_omp.cpp | 2 +- src/USER-OMP/pair_lj_cut_thole_long_omp.cpp | 3 ++- src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp | 2 +- src/USER-OMP/pair_lubricate_poly_omp.cpp | 2 +- src/USER-OMP/pppm_cg_omp.cpp | 12 ++++++------ src/USER-OMP/pppm_disp_omp.cpp | 9 +++++++-- src/USER-OMP/pppm_disp_tip4p_omp.cpp | 11 +++++------ src/USER-OMP/pppm_omp.cpp | 11 +++++++---- src/USER-OMP/pppm_tip4p_omp.cpp | 9 ++++++--- src/USER-OMP/reaxc_multi_body_omp.cpp | 7 +++---- src/USER-OMP/reaxc_valence_angles_omp.cpp | 6 ++++-- src/USER-OMP/respa_omp.cpp | 9 ++------- src/USER-OMP/thr_data.h | 8 ++------ src/USER-OMP/thr_omp.cpp | 2 -- src/USER-OMP/thr_omp.h | 9 +++++---- src/USER-SMD/pair_smd_tlsph.cpp | 8 +++----- src/special.cpp | 2 +- 95 files changed, 162 insertions(+), 293 deletions(-) diff --git a/src/USER-OMP/angle_charmm_omp.cpp b/src/USER-OMP/angle_charmm_omp.cpp index 118ba00226..f135446915 100644 --- a/src/USER-OMP/angle_charmm_omp.cpp +++ b/src/USER-OMP/angle_charmm_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_charmm_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_class2_omp.cpp b/src/USER-OMP/angle_class2_omp.cpp index e072d136e1..0cf5489663 100644 --- a/src/USER-OMP/angle_class2_omp.cpp +++ b/src/USER-OMP/angle_class2_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_class2_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_delta_omp.cpp b/src/USER-OMP/angle_cosine_delta_omp.cpp index a6dfb20433..7f4d994c4f 100644 --- a/src/USER-OMP/angle_cosine_delta_omp.cpp +++ b/src/USER-OMP/angle_cosine_delta_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_delta_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_omp.cpp b/src/USER-OMP/angle_cosine_omp.cpp index 9097c8569c..0543c94799 100644 --- a/src/USER-OMP/angle_cosine_omp.cpp +++ b/src/USER-OMP/angle_cosine_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_periodic_omp.cpp b/src/USER-OMP/angle_cosine_periodic_omp.cpp index 3fcea7ad1d..907315f83b 100644 --- a/src/USER-OMP/angle_cosine_periodic_omp.cpp +++ b/src/USER-OMP/angle_cosine_periodic_omp.cpp @@ -16,20 +16,16 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_periodic_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" +#include "timer.h" #include "math_special.h" -#include - #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace MathSpecial; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_shift_exp_omp.cpp b/src/USER-OMP/angle_cosine_shift_exp_omp.cpp index 6bd2feb023..6c42319905 100644 --- a/src/USER-OMP/angle_cosine_shift_exp_omp.cpp +++ b/src/USER-OMP/angle_cosine_shift_exp_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_shift_exp_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_shift_omp.cpp b/src/USER-OMP/angle_cosine_shift_omp.cpp index 56486faac1..5c0afcf316 100644 --- a/src/USER-OMP/angle_cosine_shift_omp.cpp +++ b/src/USER-OMP/angle_cosine_shift_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_shift_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_cosine_squared_omp.cpp b/src/USER-OMP/angle_cosine_squared_omp.cpp index 6dd2a3bb3b..27c47b90d8 100644 --- a/src/USER-OMP/angle_cosine_squared_omp.cpp +++ b/src/USER-OMP/angle_cosine_squared_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_cosine_squared_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_dipole_omp.cpp b/src/USER-OMP/angle_dipole_omp.cpp index da2e819ee2..6af5b44a03 100644 --- a/src/USER-OMP/angle_dipole_omp.cpp +++ b/src/USER-OMP/angle_dipole_omp.cpp @@ -16,20 +16,16 @@ ------------------------------------------------------------------------- */ #include "angle_dipole_omp.h" +#include #include "atom.h" #include "comm.h" #include "error.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_fourier_omp.cpp b/src/USER-OMP/angle_fourier_omp.cpp index b2f9b47e05..98527c2028 100644 --- a/src/USER-OMP/angle_fourier_omp.cpp +++ b/src/USER-OMP/angle_fourier_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_fourier_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_fourier_simple_omp.cpp b/src/USER-OMP/angle_fourier_simple_omp.cpp index 93532a30e5..71d0197b72 100644 --- a/src/USER-OMP/angle_fourier_simple_omp.cpp +++ b/src/USER-OMP/angle_fourier_simple_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_fourier_simple_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_harmonic_omp.cpp b/src/USER-OMP/angle_harmonic_omp.cpp index 824b254287..ee08bbd8ad 100644 --- a/src/USER-OMP/angle_harmonic_omp.cpp +++ b/src/USER-OMP/angle_harmonic_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_harmonic_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_quartic_omp.cpp b/src/USER-OMP/angle_quartic_omp.cpp index fff08ddb39..5745948222 100644 --- a/src/USER-OMP/angle_quartic_omp.cpp +++ b/src/USER-OMP/angle_quartic_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_quartic_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_sdk_omp.cpp b/src/USER-OMP/angle_sdk_omp.cpp index e8c762092c..e0b1da0baf 100644 --- a/src/USER-OMP/angle_sdk_omp.cpp +++ b/src/USER-OMP/angle_sdk_omp.cpp @@ -16,20 +16,16 @@ ------------------------------------------------------------------------- */ #include "angle_sdk_omp.h" +#include #include "atom.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "comm.h" #include "force.h" -#include "math_const.h" - -#include - #include "lj_sdk_common.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace LJSDKParms; #define SMALL 0.001 diff --git a/src/USER-OMP/angle_table_omp.cpp b/src/USER-OMP/angle_table_omp.cpp index d9d80b744d..4f6edf2073 100644 --- a/src/USER-OMP/angle_table_omp.cpp +++ b/src/USER-OMP/angle_table_omp.cpp @@ -16,19 +16,15 @@ ------------------------------------------------------------------------- */ #include "angle_table_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include "math_const.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define SMALL 0.001 diff --git a/src/USER-OMP/bond_class2_omp.cpp b/src/USER-OMP/bond_class2_omp.cpp index fdd73c20b0..7d1b693faf 100644 --- a/src/USER-OMP/bond_class2_omp.cpp +++ b/src/USER-OMP/bond_class2_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_fene_expand_omp.cpp b/src/USER-OMP/bond_fene_expand_omp.cpp index a8eec11760..aefae6dcf7 100644 --- a/src/USER-OMP/bond_fene_expand_omp.cpp +++ b/src/USER-OMP/bond_fene_expand_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "error.h" #include "update.h" diff --git a/src/USER-OMP/bond_fene_omp.cpp b/src/USER-OMP/bond_fene_omp.cpp index be7dcd4b49..2b579114ba 100644 --- a/src/USER-OMP/bond_fene_omp.cpp +++ b/src/USER-OMP/bond_fene_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "error.h" #include "update.h" diff --git a/src/USER-OMP/bond_gromos_omp.cpp b/src/USER-OMP/bond_gromos_omp.cpp index 8f0926c0e9..ba23217a1f 100644 --- a/src/USER-OMP/bond_gromos_omp.cpp +++ b/src/USER-OMP/bond_gromos_omp.cpp @@ -20,9 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" - -#include +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/bond_harmonic_omp.cpp b/src/USER-OMP/bond_harmonic_omp.cpp index a3bb69c53c..5515284f9a 100644 --- a/src/USER-OMP/bond_harmonic_omp.cpp +++ b/src/USER-OMP/bond_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp b/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp index 5c16e27a32..a871fa8c04 100644 --- a/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp +++ b/src/USER-OMP/bond_harmonic_shift_cut_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_harmonic_shift_omp.cpp b/src/USER-OMP/bond_harmonic_shift_omp.cpp index 39e957c137..4117da9159 100644 --- a/src/USER-OMP/bond_harmonic_shift_omp.cpp +++ b/src/USER-OMP/bond_harmonic_shift_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_morse_omp.cpp b/src/USER-OMP/bond_morse_omp.cpp index c0203de0d6..e6526dc8dc 100644 --- a/src/USER-OMP/bond_morse_omp.cpp +++ b/src/USER-OMP/bond_morse_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_nonlinear_omp.cpp b/src/USER-OMP/bond_nonlinear_omp.cpp index 8fa3daf8ab..0d1a648415 100644 --- a/src/USER-OMP/bond_nonlinear_omp.cpp +++ b/src/USER-OMP/bond_nonlinear_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/bond_quartic_omp.cpp b/src/USER-OMP/bond_quartic_omp.cpp index fd0ccaf79d..60d3a5601c 100644 --- a/src/USER-OMP/bond_quartic_omp.cpp +++ b/src/USER-OMP/bond_quartic_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "pair.h" #include diff --git a/src/USER-OMP/bond_table_omp.cpp b/src/USER-OMP/bond_table_omp.cpp index 1616988385..8e1e792c73 100644 --- a/src/USER-OMP/bond_table_omp.cpp +++ b/src/USER-OMP/bond_table_omp.cpp @@ -20,7 +20,7 @@ #include "comm.h" #include "force.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include diff --git a/src/USER-OMP/dihedral_charmm_omp.cpp b/src/USER-OMP/dihedral_charmm_omp.cpp index b09863613e..95ad9af6a6 100644 --- a/src/USER-OMP/dihedral_charmm_omp.cpp +++ b/src/USER-OMP/dihedral_charmm_omp.cpp @@ -15,13 +15,12 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include -#include #include "dihedral_charmm_omp.h" +#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "pair.h" #include "update.h" diff --git a/src/USER-OMP/dihedral_class2_omp.cpp b/src/USER-OMP/dihedral_class2_omp.cpp index 03ac9d9bab..6c2bc02ff4 100644 --- a/src/USER-OMP/dihedral_class2_omp.cpp +++ b/src/USER-OMP/dihedral_class2_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp b/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp index c64cad9fc3..d77e9d6b3e 100644 --- a/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp +++ b/src/USER-OMP/dihedral_cosine_shift_exp_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_fourier_omp.cpp b/src/USER-OMP/dihedral_fourier_omp.cpp index 94bdae3795..93dbd773ca 100644 --- a/src/USER-OMP/dihedral_fourier_omp.cpp +++ b/src/USER-OMP/dihedral_fourier_omp.cpp @@ -15,20 +15,18 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "dihedral_fourier_omp.h" +#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" -#include "math_const.h" #include "suffix.h" using namespace LAMMPS_NS; -using namespace MathConst; #define TOLERANCE 0.05 diff --git a/src/USER-OMP/dihedral_harmonic_omp.cpp b/src/USER-OMP/dihedral_harmonic_omp.cpp index 10ccbd3d9f..84aa584d9e 100644 --- a/src/USER-OMP/dihedral_harmonic_omp.cpp +++ b/src/USER-OMP/dihedral_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_helix_omp.cpp b/src/USER-OMP/dihedral_helix_omp.cpp index 8c8e29cac0..51b07754e2 100644 --- a/src/USER-OMP/dihedral_helix_omp.cpp +++ b/src/USER-OMP/dihedral_helix_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "math_const.h" diff --git a/src/USER-OMP/dihedral_multi_harmonic_omp.cpp b/src/USER-OMP/dihedral_multi_harmonic_omp.cpp index 38961e1746..4cb6919a96 100644 --- a/src/USER-OMP/dihedral_multi_harmonic_omp.cpp +++ b/src/USER-OMP/dihedral_multi_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_nharmonic_omp.cpp b/src/USER-OMP/dihedral_nharmonic_omp.cpp index e74238265d..203884531b 100644 --- a/src/USER-OMP/dihedral_nharmonic_omp.cpp +++ b/src/USER-OMP/dihedral_nharmonic_omp.cpp @@ -20,10 +20,10 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "error.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/dihedral_opls_omp.cpp b/src/USER-OMP/dihedral_opls_omp.cpp index 64eaffe6fe..af12bb866e 100644 --- a/src/USER-OMP/dihedral_opls_omp.cpp +++ b/src/USER-OMP/dihedral_opls_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/dihedral_quadratic_omp.cpp b/src/USER-OMP/dihedral_quadratic_omp.cpp index 8df622b847..8cea62aaea 100644 --- a/src/USER-OMP/dihedral_quadratic_omp.cpp +++ b/src/USER-OMP/dihedral_quadratic_omp.cpp @@ -20,10 +20,10 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" #include "force.h" #include "update.h" #include "error.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/dihedral_table_omp.cpp b/src/USER-OMP/dihedral_table_omp.cpp index 792ee90c26..6b10027b9d 100644 --- a/src/USER-OMP/dihedral_table_omp.cpp +++ b/src/USER-OMP/dihedral_table_omp.cpp @@ -15,19 +15,14 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include -#include -#include - #include "dihedral_table_omp.h" +#include #include "atom.h" #include "comm.h" -#include "neighbor.h" #include "domain.h" +#include "neighbor.h" #include "force.h" -#include "update.h" -#include "error.h" - +#include "timer.h" #include "math_const.h" #include "math_extra.h" diff --git a/src/USER-OMP/domain_omp.cpp b/src/USER-OMP/domain_omp.cpp index 584e56b1f0..a18931c551 100644 --- a/src/USER-OMP/domain_omp.cpp +++ b/src/USER-OMP/domain_omp.cpp @@ -15,7 +15,6 @@ Contributing author : Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include "domain.h" #include "accelerator_omp.h" #include "atom.h" diff --git a/src/USER-OMP/ewald_omp.cpp b/src/USER-OMP/ewald_omp.cpp index b56fc25142..aadf63741d 100644 --- a/src/USER-OMP/ewald_omp.cpp +++ b/src/USER-OMP/ewald_omp.cpp @@ -15,15 +15,14 @@ Contributing authors: Roy Pollock (LLNL), Paul Crozier (SNL) ------------------------------------------------------------------------- */ -#include #include "ewald_omp.h" +#include +#include #include "atom.h" #include "comm.h" #include "force.h" #include "memory.h" - -#include - +#include "timer.h" #include "math_const.h" #include "suffix.h" diff --git a/src/USER-OMP/fix_gravity_omp.cpp b/src/USER-OMP/fix_gravity_omp.cpp index eae918ec52..fa6b698821 100644 --- a/src/USER-OMP/fix_gravity_omp.cpp +++ b/src/USER-OMP/fix_gravity_omp.cpp @@ -15,19 +15,12 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "fix_gravity_omp.h" #include "atom.h" #include "update.h" -#include "domain.h" #include "input.h" #include "modify.h" -#include "respa.h" #include "variable.h" -#include "error.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_neigh_history_omp.cpp b/src/USER-OMP/fix_neigh_history_omp.cpp index be03e1d8f2..c2bc8af5e0 100644 --- a/src/USER-OMP/fix_neigh_history_omp.cpp +++ b/src/USER-OMP/fix_neigh_history_omp.cpp @@ -11,19 +11,14 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include #include "fix_neigh_history_omp.h" +#include #include "my_page.h" #include "atom.h" #include "comm.h" -#include "neighbor.h" #include "neigh_list.h" -#include "force.h" #include "pair.h" -#include "update.h" #include "memory.h" -#include "modify.h" #include "error.h" #if defined(_OPENMP) diff --git a/src/USER-OMP/fix_nh_omp.cpp b/src/USER-OMP/fix_nh_omp.cpp index 76a47b71fd..2abd739f71 100644 --- a/src/USER-OMP/fix_nh_omp.cpp +++ b/src/USER-OMP/fix_nh_omp.cpp @@ -16,15 +16,13 @@ ------------------------------------------------------------------------- */ #include "fix_nh_omp.h" +#include #include "atom.h" #include "compute.h" #include "domain.h" #include "error.h" #include "modify.h" -#include -#include - using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_nh_sphere_omp.cpp b/src/USER-OMP/fix_nh_sphere_omp.cpp index a32f0f8b51..64bc536bb0 100644 --- a/src/USER-OMP/fix_nh_sphere_omp.cpp +++ b/src/USER-OMP/fix_nh_sphere_omp.cpp @@ -15,12 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "fix_nh_sphere_omp.h" #include "atom.h" -#include "atom_vec.h" #include "compute.h" -#include "group.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/fix_nve_omp.cpp b/src/USER-OMP/fix_nve_omp.cpp index c61ad7155c..61ed82b16f 100644 --- a/src/USER-OMP/fix_nve_omp.cpp +++ b/src/USER-OMP/fix_nve_omp.cpp @@ -13,7 +13,6 @@ #include "fix_nve_omp.h" #include "atom.h" -#include "force.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_nve_sphere_omp.cpp b/src/USER-OMP/fix_nve_sphere_omp.cpp index 2286120bee..ccdd654874 100644 --- a/src/USER-OMP/fix_nve_sphere_omp.cpp +++ b/src/USER-OMP/fix_nve_sphere_omp.cpp @@ -11,16 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include -#include -#include #include "fix_nve_sphere_omp.h" +#include #include "atom.h" -#include "atom_vec.h" -#include "update.h" -#include "respa.h" #include "force.h" -#include "error.h" #include "math_vector.h" #include "math_extra.h" diff --git a/src/USER-OMP/fix_nvt_sllod_omp.cpp b/src/USER-OMP/fix_nvt_sllod_omp.cpp index e439647c12..208dfb9432 100644 --- a/src/USER-OMP/fix_nvt_sllod_omp.cpp +++ b/src/USER-OMP/fix_nvt_sllod_omp.cpp @@ -15,18 +15,17 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include -#include #include "fix_nvt_sllod_omp.h" +#include #include "math_extra.h" #include "atom.h" -#include "domain.h" #include "group.h" #include "modify.h" #include "fix.h" #include "fix_deform.h" #include "compute.h" #include "error.h" +#include "domain.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_omp.cpp b/src/USER-OMP/fix_omp.cpp index a4587b1c14..1fca1e739b 100644 --- a/src/USER-OMP/fix_omp.cpp +++ b/src/USER-OMP/fix_omp.cpp @@ -24,13 +24,10 @@ #include "neigh_request.h" #include "universe.h" #include "update.h" -#include "integrate.h" -#include "min.h" #include "timer.h" #include "fix_omp.h" #include "thr_data.h" -#include "thr_omp.h" #include "pair_hybrid.h" #include "bond_hybrid.h" @@ -40,8 +37,11 @@ #include "kspace.h" #include -#include -#include + +#if defined(_OPENMP) +#include +#endif + #include "suffix.h" diff --git a/src/USER-OMP/fix_qeq_comb_omp.cpp b/src/USER-OMP/fix_qeq_comb_omp.cpp index 2f0a90a790..b0573dfa97 100644 --- a/src/USER-OMP/fix_qeq_comb_omp.cpp +++ b/src/USER-OMP/fix_qeq_comb_omp.cpp @@ -15,24 +15,20 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_qeq_comb_omp.h" #include #include #include -#include "fix_qeq_comb_omp.h" -#include "fix_omp.h" +#include "pair_comb.h" #include "atom.h" #include "comm.h" #include "force.h" #include "group.h" #include "memory.h" -#include "modify.h" #include "error.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "respa.h" #include "update.h" -#include "pair_comb_omp.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_qeq_reax_omp.cpp b/src/USER-OMP/fix_qeq_reax_omp.cpp index 45da91305d..55e2b73812 100644 --- a/src/USER-OMP/fix_qeq_reax_omp.cpp +++ b/src/USER-OMP/fix_qeq_reax_omp.cpp @@ -31,27 +31,22 @@ High Performance Computing Applications, to appear. ------------------------------------------------------------------------- */ -#include -#include -#include -#include #include "fix_qeq_reax_omp.h" -#include "pair_reaxc_omp.h" +#include +#include +#include "pair_reaxc.h" #include "atom.h" #include "comm.h" -#include "domain.h" -#include "neighbor.h" #include "neigh_list.h" -#include "neigh_request.h" #include "update.h" -#include "force.h" -#include "group.h" -#include "pair.h" -#include "respa.h" #include "memory.h" #include "error.h" #include "reaxc_defs.h" +#if defined(_OPENMP) +#include +#endif + using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-OMP/fix_rigid_nh_omp.cpp b/src/USER-OMP/fix_rigid_nh_omp.cpp index e6a6e065bf..74b2a92775 100644 --- a/src/USER-OMP/fix_rigid_nh_omp.cpp +++ b/src/USER-OMP/fix_rigid_nh_omp.cpp @@ -15,11 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_rigid_nh_omp.h" #include #include - -#include "fix_rigid_nh_omp.h" - #include "atom.h" #include "atom_vec_ellipsoid.h" #include "atom_vec_line.h" @@ -32,6 +30,7 @@ #include "kspace.h" #include "modify.h" #include "update.h" +#include "timer.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/fix_rigid_nph_omp.cpp b/src/USER-OMP/fix_rigid_nph_omp.cpp index 7db45ed9bf..31d53868c8 100644 --- a/src/USER-OMP/fix_rigid_nph_omp.cpp +++ b/src/USER-OMP/fix_rigid_nph_omp.cpp @@ -17,9 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ -#include #include "fix_rigid_nph_omp.h" -#include "domain.h" +#include #include "modify.h" #include "error.h" diff --git a/src/USER-OMP/fix_rigid_npt_omp.cpp b/src/USER-OMP/fix_rigid_npt_omp.cpp index a041706f38..1e7c139d52 100644 --- a/src/USER-OMP/fix_rigid_npt_omp.cpp +++ b/src/USER-OMP/fix_rigid_npt_omp.cpp @@ -17,9 +17,8 @@ Miller et al., J Chem Phys. 116, 8649-8659 (2002) ------------------------------------------------------------------------- */ -#include #include "fix_rigid_npt_omp.h" -#include "domain.h" +#include #include "modify.h" #include "error.h" diff --git a/src/USER-OMP/fix_rigid_omp.cpp b/src/USER-OMP/fix_rigid_omp.cpp index 20478b3ca1..b807ddba7c 100644 --- a/src/USER-OMP/fix_rigid_omp.cpp +++ b/src/USER-OMP/fix_rigid_omp.cpp @@ -15,18 +15,17 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "fix_rigid_omp.h" #include +#include #include - -#include "fix_rigid_omp.h" - #include "atom.h" #include "atom_vec_ellipsoid.h" #include "atom_vec_line.h" #include "atom_vec_tri.h" #include "comm.h" -#include "domain.h" #include "error.h" +#include "domain.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/fix_rigid_small_omp.cpp b/src/USER-OMP/fix_rigid_small_omp.cpp index 1f6173497d..0aa15ee408 100644 --- a/src/USER-OMP/fix_rigid_small_omp.cpp +++ b/src/USER-OMP/fix_rigid_small_omp.cpp @@ -15,10 +15,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include - #include "fix_rigid_small_omp.h" - +#include #include "atom.h" #include "atom_vec_ellipsoid.h" #include "atom_vec_line.h" diff --git a/src/USER-OMP/improper_class2_omp.cpp b/src/USER-OMP/improper_class2_omp.cpp index c2b493f425..3bff179b44 100644 --- a/src/USER-OMP/improper_class2_omp.cpp +++ b/src/USER-OMP/improper_class2_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_cossq_omp.cpp b/src/USER-OMP/improper_cossq_omp.cpp index 3b328e5b78..0f99f2732f 100644 --- a/src/USER-OMP/improper_cossq_omp.cpp +++ b/src/USER-OMP/improper_cossq_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_cvff_omp.cpp b/src/USER-OMP/improper_cvff_omp.cpp index fe1fc45bec..fdc29c74b1 100644 --- a/src/USER-OMP/improper_cvff_omp.cpp +++ b/src/USER-OMP/improper_cvff_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_fourier_omp.cpp b/src/USER-OMP/improper_fourier_omp.cpp index b5af428cb9..b49b895c78 100644 --- a/src/USER-OMP/improper_fourier_omp.cpp +++ b/src/USER-OMP/improper_fourier_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_harmonic_omp.cpp b/src/USER-OMP/improper_harmonic_omp.cpp index 6e02d0968e..32e837fdfe 100644 --- a/src/USER-OMP/improper_harmonic_omp.cpp +++ b/src/USER-OMP/improper_harmonic_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/improper_ring_omp.cpp b/src/USER-OMP/improper_ring_omp.cpp index e198b99337..c8fe685faa 100644 --- a/src/USER-OMP/improper_ring_omp.cpp +++ b/src/USER-OMP/improper_ring_omp.cpp @@ -15,15 +15,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "improper_ring_omp.h" +#include #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" -#include "update.h" -#include "error.h" #include "math_special.h" #include "suffix.h" diff --git a/src/USER-OMP/improper_umbrella_omp.cpp b/src/USER-OMP/improper_umbrella_omp.cpp index ceaca35074..f3fdf4570f 100644 --- a/src/USER-OMP/improper_umbrella_omp.cpp +++ b/src/USER-OMP/improper_umbrella_omp.cpp @@ -20,7 +20,7 @@ #include "atom.h" #include "comm.h" #include "neighbor.h" -#include "domain.h" +#include "timer.h" #include "force.h" #include "update.h" #include "error.h" diff --git a/src/USER-OMP/msm_cg_omp.cpp b/src/USER-OMP/msm_cg_omp.cpp index 8a920e05d5..3c5439db5d 100644 --- a/src/USER-OMP/msm_cg_omp.cpp +++ b/src/USER-OMP/msm_cg_omp.cpp @@ -16,10 +16,10 @@ Original MSM class by: Paul Crozier, Stan Moore, Stephen Bond, (all SNL) ------------------------------------------------------------------------- */ +#include "msm_cg_omp.h" #include #include #include -#include #include #include "atom.h" @@ -29,12 +29,14 @@ #include "force.h" #include "neighbor.h" #include "memory.h" -#include "msm_cg_omp.h" +#include "thr_omp.h" +#include "timer.h" -#include "math_const.h" +#if defined(_OPENMP) +#include +#endif using namespace LAMMPS_NS; -using namespace MathConst; #define OFFSET 16384 #define SMALLQ 0.00001 diff --git a/src/USER-OMP/msm_omp.cpp b/src/USER-OMP/msm_omp.cpp index 74cbb56be7..81f84e8f6f 100644 --- a/src/USER-OMP/msm_omp.cpp +++ b/src/USER-OMP/msm_omp.cpp @@ -16,15 +16,11 @@ ------------------------------------------------------------------------- */ #include "msm_omp.h" -#include "atom.h" +#include #include "comm.h" #include "domain.h" #include "error.h" -#include "force.h" -#include "memory.h" -#include "math_const.h" - -#include +#include "timer.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/npair_full_bin_atomonly_omp.cpp b/src/USER-OMP/npair_full_bin_atomonly_omp.cpp index d9e0fb9297..0f791e204d 100644 --- a/src/USER-OMP/npair_full_bin_atomonly_omp.cpp +++ b/src/USER-OMP/npair_full_bin_atomonly_omp.cpp @@ -13,11 +13,9 @@ #include "npair_full_bin_atomonly_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/npair_full_bin_ghost_omp.cpp b/src/USER-OMP/npair_full_bin_ghost_omp.cpp index b915aca002..d541381143 100644 --- a/src/USER-OMP/npair_full_bin_ghost_omp.cpp +++ b/src/USER-OMP/npair_full_bin_ghost_omp.cpp @@ -13,7 +13,6 @@ #include "npair_full_bin_ghost_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_full_multi_omp.cpp b/src/USER-OMP/npair_full_multi_omp.cpp index 9bc196e17a..57b60f665b 100644 --- a/src/USER-OMP/npair_full_multi_omp.cpp +++ b/src/USER-OMP/npair_full_multi_omp.cpp @@ -13,7 +13,6 @@ #include "npair_full_multi_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_full_nsq_ghost_omp.cpp b/src/USER-OMP/npair_full_nsq_ghost_omp.cpp index b33f76bb22..242c4e300c 100644 --- a/src/USER-OMP/npair_full_nsq_ghost_omp.cpp +++ b/src/USER-OMP/npair_full_nsq_ghost_omp.cpp @@ -13,7 +13,6 @@ #include "npair_full_nsq_ghost_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_full_nsq_omp.cpp b/src/USER-OMP/npair_full_nsq_omp.cpp index 1d0f26d638..08a034d5ab 100644 --- a/src/USER-OMP/npair_full_nsq_omp.cpp +++ b/src/USER-OMP/npair_full_nsq_omp.cpp @@ -13,7 +13,6 @@ #include "npair_full_nsq_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp b/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp index 02d98ff6ab..a69779d96d 100644 --- a/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp +++ b/src/USER-OMP/npair_half_bin_atomonly_newton_omp.cpp @@ -13,12 +13,9 @@ #include "npair_half_bin_atomonly_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "domain.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/npair_half_bin_newtoff_ghost_omp.cpp b/src/USER-OMP/npair_half_bin_newtoff_ghost_omp.cpp index 24fe75ec55..5f8ffdab29 100644 --- a/src/USER-OMP/npair_half_bin_newtoff_ghost_omp.cpp +++ b/src/USER-OMP/npair_half_bin_newtoff_ghost_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_bin_newtoff_ghost_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_bin_newtoff_omp.cpp b/src/USER-OMP/npair_half_bin_newtoff_omp.cpp index ff74b54d7d..35807645cf 100644 --- a/src/USER-OMP/npair_half_bin_newtoff_omp.cpp +++ b/src/USER-OMP/npair_half_bin_newtoff_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_bin_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_bin_newton_omp.cpp b/src/USER-OMP/npair_half_bin_newton_omp.cpp index f7d969ba27..2700d6863b 100644 --- a/src/USER-OMP/npair_half_bin_newton_omp.cpp +++ b/src/USER-OMP/npair_half_bin_newton_omp.cpp @@ -13,11 +13,9 @@ #include "npair_half_bin_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "group.h" #include "molecule.h" #include "domain.h" #include "my_page.h" diff --git a/src/USER-OMP/npair_half_bin_newton_tri_omp.cpp b/src/USER-OMP/npair_half_bin_newton_tri_omp.cpp index c843d623cd..d94845898c 100644 --- a/src/USER-OMP/npair_half_bin_newton_tri_omp.cpp +++ b/src/USER-OMP/npair_half_bin_newton_tri_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_bin_newton_tri_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_multi_newtoff_omp.cpp b/src/USER-OMP/npair_half_multi_newtoff_omp.cpp index 705d1b8d9f..c06737dc1c 100644 --- a/src/USER-OMP/npair_half_multi_newtoff_omp.cpp +++ b/src/USER-OMP/npair_half_multi_newtoff_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_multi_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_multi_newton_omp.cpp b/src/USER-OMP/npair_half_multi_newton_omp.cpp index f16dd027a0..50df756be4 100644 --- a/src/USER-OMP/npair_half_multi_newton_omp.cpp +++ b/src/USER-OMP/npair_half_multi_newton_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_multi_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_halffull_newtoff_omp.cpp b/src/USER-OMP/npair_halffull_newtoff_omp.cpp index 947e4e1ad2..6f90f82752 100644 --- a/src/USER-OMP/npair_halffull_newtoff_omp.cpp +++ b/src/USER-OMP/npair_halffull_newtoff_omp.cpp @@ -18,7 +18,7 @@ #include "atom.h" #include "atom_vec.h" #include "molecule.h" -#include "domain.h" +#include "timer.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/npair_halffull_newton_omp.cpp b/src/USER-OMP/npair_halffull_newton_omp.cpp index 6e158d372d..6cf8ab8ac2 100644 --- a/src/USER-OMP/npair_halffull_newton_omp.cpp +++ b/src/USER-OMP/npair_halffull_newton_omp.cpp @@ -18,7 +18,7 @@ #include "atom.h" #include "atom_vec.h" #include "molecule.h" -#include "domain.h" +#include "timer.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/pair_brownian_omp.cpp b/src/USER-OMP/pair_brownian_omp.cpp index cef9fb0955..6367976c7d 100644 --- a/src/USER-OMP/pair_brownian_omp.cpp +++ b/src/USER-OMP/pair_brownian_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_brownian_omp.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" @@ -26,6 +26,7 @@ #include "random_mars.h" #include "math_const.h" #include "math_special.h" +#include "timer.h" #include "fix_wall.h" diff --git a/src/USER-OMP/pair_brownian_poly_omp.cpp b/src/USER-OMP/pair_brownian_poly_omp.cpp index 239a820242..dcb4124634 100644 --- a/src/USER-OMP/pair_brownian_poly_omp.cpp +++ b/src/USER-OMP/pair_brownian_poly_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_brownian_poly_omp.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp b/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp index d0db6262b1..87d637e80d 100644 --- a/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp +++ b/src/USER-OMP/pair_lj_cut_thole_long_omp.cpp @@ -22,6 +22,7 @@ #include #include "atom.h" #include "comm.h" +#include "domain.h" #include "fix_drude.h" #include "force.h" #include "neighbor.h" @@ -30,7 +31,7 @@ #include "math_const.h" #include "error.h" #include "suffix.h" -#include "domain.h" +#include "timer.h" using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp b/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp index e2c1da1a89..18fc207015 100644 --- a/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp +++ b/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_lj_cut_tip4p_long_omp.h" +#include #include "atom.h" #include "domain.h" #include "comm.h" diff --git a/src/USER-OMP/pair_lubricate_poly_omp.cpp b/src/USER-OMP/pair_lubricate_poly_omp.cpp index 3a5f03364d..04ac59b121 100644 --- a/src/USER-OMP/pair_lubricate_poly_omp.cpp +++ b/src/USER-OMP/pair_lubricate_poly_omp.cpp @@ -12,8 +12,8 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_lubricate_poly_omp.h" +#include #include "atom.h" #include "comm.h" #include "domain.h" diff --git a/src/USER-OMP/pppm_cg_omp.cpp b/src/USER-OMP/pppm_cg_omp.cpp index 2b4619f685..1117979f1f 100644 --- a/src/USER-OMP/pppm_cg_omp.cpp +++ b/src/USER-OMP/pppm_cg_omp.cpp @@ -15,20 +15,20 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_cg_omp.h" +#include #include #include -#include "pppm_cg_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" -#include "error.h" -#include "fix_omp.h" #include "force.h" -#include "neighbor.h" -#include "memory.h" #include "math_const.h" #include "math_special.h" - +#include "timer.h" +#if defined(_OPENMP) +#include +#endif #include "suffix.h" using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/USER-OMP/pppm_disp_omp.cpp b/src/USER-OMP/pppm_disp_omp.cpp index 435341a31c..de902b1a57 100644 --- a/src/USER-OMP/pppm_disp_omp.cpp +++ b/src/USER-OMP/pppm_disp_omp.cpp @@ -16,15 +16,20 @@ Rolf Isele-Holder (RWTH Aachen University) ------------------------------------------------------------------------- */ +#include "pppm_disp_omp.h" +#include #include #include -#include "pppm_disp_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" +#include "error.h" #include "force.h" -#include "memory.h" #include "math_const.h" +#include "timer.h" +#if defined(_OPENMP) +#include +#endif #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pppm_disp_tip4p_omp.cpp b/src/USER-OMP/pppm_disp_tip4p_omp.cpp index a53c5b2ac5..fc9466e395 100644 --- a/src/USER-OMP/pppm_disp_tip4p_omp.cpp +++ b/src/USER-OMP/pppm_disp_tip4p_omp.cpp @@ -15,23 +15,22 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_disp_tip4p_omp.h" +#include #include #include -#include "pppm_disp_tip4p_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" #include "error.h" -#include "fix_omp.h" #include "force.h" -#include "memory.h" #include "math_const.h" -#include "math_special.h" - +#if defined(_OPENMP) +#include +#endif #include "suffix.h" using namespace LAMMPS_NS; using namespace MathConst; -using namespace MathSpecial; #ifdef FFT_SINGLE #define ZEROF 0.0f diff --git a/src/USER-OMP/pppm_omp.cpp b/src/USER-OMP/pppm_omp.cpp index 66190b3f51..3ef3de1ab7 100644 --- a/src/USER-OMP/pppm_omp.cpp +++ b/src/USER-OMP/pppm_omp.cpp @@ -15,18 +15,21 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_omp.h" +#include #include #include -#include "pppm_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" -#include "error.h" -#include "fix_omp.h" #include "force.h" -#include "memory.h" #include "math_const.h" #include "math_special.h" +#include "timer.h" + +#if defined(_OPENMP) +#include +#endif #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pppm_tip4p_omp.cpp b/src/USER-OMP/pppm_tip4p_omp.cpp index 5fe44d2b71..d7c12613d9 100644 --- a/src/USER-OMP/pppm_tip4p_omp.cpp +++ b/src/USER-OMP/pppm_tip4p_omp.cpp @@ -15,18 +15,21 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ +#include "pppm_tip4p_omp.h" +#include #include #include -#include "pppm_tip4p_omp.h" #include "atom.h" #include "comm.h" #include "domain.h" #include "error.h" -#include "fix_omp.h" #include "force.h" -#include "memory.h" #include "math_const.h" #include "math_special.h" +#include "timer.h" +#if defined(_OPENMP) +#include +#endif #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/reaxc_multi_body_omp.cpp b/src/USER-OMP/reaxc_multi_body_omp.cpp index 164999b986..5f4b6d4eb0 100644 --- a/src/USER-OMP/reaxc_multi_body_omp.cpp +++ b/src/USER-OMP/reaxc_multi_body_omp.cpp @@ -27,14 +27,13 @@ ----------------------------------------------------------------------*/ #include "reaxc_multi_body_omp.h" +#include +#include +#include "fix_omp.h" #include #include "pair_reaxc_omp.h" -#include "thr_data.h" #include "reaxc_defs.h" - -#include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" -#include "reaxc_vector.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/reaxc_valence_angles_omp.cpp b/src/USER-OMP/reaxc_valence_angles_omp.cpp index 7fbe87d6e5..104fadbbae 100644 --- a/src/USER-OMP/reaxc_valence_angles_omp.cpp +++ b/src/USER-OMP/reaxc_valence_angles_omp.cpp @@ -27,13 +27,15 @@ ----------------------------------------------------------------------*/ #include "reaxc_valence_angles_omp.h" +#include +#include #include "pair_reaxc_omp.h" -#include "thr_data.h" +#include "fix_omp.h" +#include "error.h" #include "reaxc_defs.h" #include "reaxc_types.h" #include "reaxc_valence_angles.h" -#include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" #include "reaxc_vector.h" diff --git a/src/USER-OMP/respa_omp.cpp b/src/USER-OMP/respa_omp.cpp index 9c8555c66d..5add419253 100644 --- a/src/USER-OMP/respa_omp.cpp +++ b/src/USER-OMP/respa_omp.cpp @@ -15,13 +15,11 @@ Contributing authors: Mark Stevens (SNL), Paul Crozier (SNL) ------------------------------------------------------------------------- */ -#include -#include #include "respa_omp.h" #include "neighbor.h" -#include "domain.h" #include "comm.h" #include "atom.h" +#include "domain.h" #include "force.h" #include "pair.h" #include "bond.h" @@ -32,11 +30,8 @@ #include "output.h" #include "update.h" #include "modify.h" -#include "compute.h" -#include "fix_respa.h" -#include "timer.h" -#include "memory.h" #include "error.h" +#include "timer.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/thr_data.h b/src/USER-OMP/thr_data.h index 3cea1b0018..edff17cad3 100644 --- a/src/USER-OMP/thr_data.h +++ b/src/USER-OMP/thr_data.h @@ -18,10 +18,6 @@ #ifndef LMP_THR_DATA_H #define LMP_THR_DATA_H -#if defined(_OPENMP) -#include -#endif - #include "timer.h" namespace LAMMPS_NS { @@ -35,7 +31,7 @@ class ThrData { public: ThrData(int tid, class Timer *t); - ~ThrData() { delete _timer; _timer = NULL; }; + ~ThrData() { delete _timer; _timer = nullptr; }; void check_tid(int); // thread id consistency check int get_tid() const { return _tid; }; // our thread id. @@ -140,7 +136,7 @@ class ThrData { // disabled default methods private: - ThrData() : _tid(-1), _timer(NULL) {}; + ThrData() : _tid(-1), _timer(nullptr) {}; }; //////////////////////////////////////////////////////////////////////// diff --git a/src/USER-OMP/thr_omp.cpp b/src/USER-OMP/thr_omp.cpp index 22f751e6c0..51030358d3 100644 --- a/src/USER-OMP/thr_omp.cpp +++ b/src/USER-OMP/thr_omp.cpp @@ -22,7 +22,6 @@ #include "comm.h" #include "error.h" #include "force.h" -#include "memory.h" #include "modify.h" #include "neighbor.h" #include "timer.h" @@ -34,7 +33,6 @@ #include "angle.h" #include "dihedral.h" #include "improper.h" -#include "kspace.h" #include "compute.h" #include "math_const.h" diff --git a/src/USER-OMP/thr_omp.h b/src/USER-OMP/thr_omp.h index 87d921290e..062d77bc0e 100644 --- a/src/USER-OMP/thr_omp.h +++ b/src/USER-OMP/thr_omp.h @@ -18,10 +18,13 @@ #ifndef LMP_THR_OMP_H #define LMP_THR_OMP_H +#if defined(_OPENMP) +#include +#endif #include "pointers.h" #include "error.h" -#include "fix_omp.h" -#include "thr_data.h" +#include "fix_omp.h" // IWYU pragma: export +#include "thr_data.h" // IWYU pragma: export namespace LAMMPS_NS { @@ -31,8 +34,6 @@ class Bond; class Angle; class Dihedral; class Improper; -class KSpace; -class Fix; class ThrOMP { diff --git a/src/USER-SMD/pair_smd_tlsph.cpp b/src/USER-SMD/pair_smd_tlsph.cpp index 0dff905962..82b7c8ff9d 100644 --- a/src/USER-SMD/pair_smd_tlsph.cpp +++ b/src/USER-SMD/pair_smd_tlsph.cpp @@ -1776,9 +1776,8 @@ void PairTlsph::init_style() { optional granular history list ------------------------------------------------------------------------- */ -void PairTlsph::init_list(int id, NeighList *ptr) { - if (id == 0) - list = ptr; +void PairTlsph::init_list(int id, class NeighList *ptr) { + if (id == 0) list = ptr; } /* ---------------------------------------------------------------------- @@ -1786,8 +1785,7 @@ void PairTlsph::init_list(int id, NeighList *ptr) { ------------------------------------------------------------------------- */ double PairTlsph::memory_usage() { - - return 118 * nmax * sizeof(double); + return 118.0 * nmax * sizeof(double); } /* ---------------------------------------------------------------------- diff --git a/src/special.cpp b/src/special.cpp index b64aa96e2b..3dd817bc7f 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -19,7 +19,7 @@ #include "comm.h" #include "modify.h" #include "fix.h" -#include "accelerator_kokkos.h" +#include "accelerator_kokkos.h" // IWYU pragma: export #include "atom_masks.h" #include "memory.h" -- GitLab From 2f646150873b170cbbd4318bc937967effc0d195 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 11 Jul 2019 22:31:16 -0400 Subject: [PATCH 244/469] more work on includes in USER-OMP --- src/USER-OMP/npair_full_bin_atomonly_omp.cpp | 2 -- src/USER-OMP/npair_full_bin_ghost_omp.cpp | 1 - src/USER-OMP/npair_full_bin_omp.cpp | 2 -- src/USER-OMP/npair_full_multi_omp.cpp | 1 - src/USER-OMP/npair_full_nsq_ghost_omp.cpp | 1 - src/USER-OMP/npair_full_nsq_omp.cpp | 1 - src/USER-OMP/npair_half_multi_newton_tri_omp.cpp | 1 - src/USER-OMP/npair_half_nsq_newtoff_ghost_omp.cpp | 1 - src/USER-OMP/npair_half_nsq_newtoff_omp.cpp | 1 - src/USER-OMP/npair_half_nsq_newton_omp.cpp | 1 - src/USER-OMP/npair_half_respa_bin_newtoff_omp.cpp | 1 - src/USER-OMP/npair_half_respa_bin_newton_omp.cpp | 1 - src/USER-OMP/npair_half_respa_bin_newton_tri_omp.cpp | 1 - src/USER-OMP/npair_half_respa_nsq_newtoff_omp.cpp | 1 - src/USER-OMP/npair_half_respa_nsq_newton_omp.cpp | 1 - src/USER-OMP/npair_half_size_bin_newtoff_omp.cpp | 2 -- src/USER-OMP/npair_half_size_bin_newton_omp.cpp | 2 -- src/USER-OMP/npair_half_size_bin_newton_tri_omp.cpp | 1 - src/USER-OMP/npair_half_size_nsq_newtoff_omp.cpp | 2 -- src/USER-OMP/npair_half_size_nsq_newton_omp.cpp | 2 -- src/USER-OMP/npair_halffull_newtoff_omp.cpp | 4 ---- src/USER-OMP/npair_halffull_newton_omp.cpp | 3 --- src/USER-OMP/pair_beck_omp.cpp | 4 ++-- src/USER-OMP/pair_born_coul_wolf_omp.cpp | 4 ++-- src/USER-OMP/pair_born_omp.cpp | 4 ++-- src/USER-OMP/pair_buck_omp.cpp | 4 ++-- src/USER-OMP/pair_coul_cut_omp.cpp | 4 ++-- src/USER-OMP/pair_coul_debye_omp.cpp | 4 ++-- src/USER-OMP/pair_coul_dsf_omp.cpp | 5 ++--- src/USER-OMP/pair_coul_wolf_omp.cpp | 4 ++-- src/USER-OMP/pair_dpd_omp.cpp | 4 ++-- 31 files changed, 18 insertions(+), 52 deletions(-) diff --git a/src/USER-OMP/npair_full_bin_atomonly_omp.cpp b/src/USER-OMP/npair_full_bin_atomonly_omp.cpp index 09c4f2d78d..3bda2e4c5a 100644 --- a/src/USER-OMP/npair_full_bin_atomonly_omp.cpp +++ b/src/USER-OMP/npair_full_bin_atomonly_omp.cpp @@ -18,10 +18,8 @@ #include "atom_vec.h" #include "my_page.h" #include "error.h" -#include "timer.h" using namespace LAMMPS_NS; -using namespace NeighConst; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-OMP/npair_full_bin_ghost_omp.cpp b/src/USER-OMP/npair_full_bin_ghost_omp.cpp index d541381143..b0b0070df5 100644 --- a/src/USER-OMP/npair_full_bin_ghost_omp.cpp +++ b/src/USER-OMP/npair_full_bin_ghost_omp.cpp @@ -22,7 +22,6 @@ #include "error.h" using namespace LAMMPS_NS; -using namespace NeighConst; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-OMP/npair_full_bin_omp.cpp b/src/USER-OMP/npair_full_bin_omp.cpp index e1f75c06e2..d3e30b4932 100644 --- a/src/USER-OMP/npair_full_bin_omp.cpp +++ b/src/USER-OMP/npair_full_bin_omp.cpp @@ -13,7 +13,6 @@ #include "npair_full_bin_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" @@ -23,7 +22,6 @@ #include "error.h" using namespace LAMMPS_NS; -using namespace NeighConst; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-OMP/npair_full_multi_omp.cpp b/src/USER-OMP/npair_full_multi_omp.cpp index 57b60f665b..707db2edcf 100644 --- a/src/USER-OMP/npair_full_multi_omp.cpp +++ b/src/USER-OMP/npair_full_multi_omp.cpp @@ -22,7 +22,6 @@ #include "error.h" using namespace LAMMPS_NS; -using namespace NeighConst; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-OMP/npair_full_nsq_ghost_omp.cpp b/src/USER-OMP/npair_full_nsq_ghost_omp.cpp index 242c4e300c..527df58fd6 100644 --- a/src/USER-OMP/npair_full_nsq_ghost_omp.cpp +++ b/src/USER-OMP/npair_full_nsq_ghost_omp.cpp @@ -22,7 +22,6 @@ #include "error.h" using namespace LAMMPS_NS; -using namespace NeighConst; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-OMP/npair_full_nsq_omp.cpp b/src/USER-OMP/npair_full_nsq_omp.cpp index 08a034d5ab..2719f5dc2c 100644 --- a/src/USER-OMP/npair_full_nsq_omp.cpp +++ b/src/USER-OMP/npair_full_nsq_omp.cpp @@ -23,7 +23,6 @@ #include "error.h" using namespace LAMMPS_NS; -using namespace NeighConst; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-OMP/npair_half_multi_newton_tri_omp.cpp b/src/USER-OMP/npair_half_multi_newton_tri_omp.cpp index ce93e85485..8b78b311dd 100644 --- a/src/USER-OMP/npair_half_multi_newton_tri_omp.cpp +++ b/src/USER-OMP/npair_half_multi_newton_tri_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_multi_newton_tri_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_nsq_newtoff_ghost_omp.cpp b/src/USER-OMP/npair_half_nsq_newtoff_ghost_omp.cpp index add4c44d9e..f0eb211425 100644 --- a/src/USER-OMP/npair_half_nsq_newtoff_ghost_omp.cpp +++ b/src/USER-OMP/npair_half_nsq_newtoff_ghost_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_nsq_newtoff_ghost_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_nsq_newtoff_omp.cpp b/src/USER-OMP/npair_half_nsq_newtoff_omp.cpp index 01da73cf1e..55b9f9e512 100644 --- a/src/USER-OMP/npair_half_nsq_newtoff_omp.cpp +++ b/src/USER-OMP/npair_half_nsq_newtoff_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_nsq_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_nsq_newton_omp.cpp b/src/USER-OMP/npair_half_nsq_newton_omp.cpp index 3815b1b85b..223da622e8 100644 --- a/src/USER-OMP/npair_half_nsq_newton_omp.cpp +++ b/src/USER-OMP/npair_half_nsq_newton_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_nsq_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_respa_bin_newtoff_omp.cpp b/src/USER-OMP/npair_half_respa_bin_newtoff_omp.cpp index f094691b71..9bb4d277fe 100644 --- a/src/USER-OMP/npair_half_respa_bin_newtoff_omp.cpp +++ b/src/USER-OMP/npair_half_respa_bin_newtoff_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_respa_bin_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_respa_bin_newton_omp.cpp b/src/USER-OMP/npair_half_respa_bin_newton_omp.cpp index de7ef5f7d5..9ed0ae482d 100644 --- a/src/USER-OMP/npair_half_respa_bin_newton_omp.cpp +++ b/src/USER-OMP/npair_half_respa_bin_newton_omp.cpp @@ -12,7 +12,6 @@ ------------------------------------------------------------------------- */ #include "npair_half_respa_bin_newton_omp.h" -#include "neighbor.h" #include "npair_omp.h" #include "neigh_list.h" #include "atom.h" diff --git a/src/USER-OMP/npair_half_respa_bin_newton_tri_omp.cpp b/src/USER-OMP/npair_half_respa_bin_newton_tri_omp.cpp index f20d101bc9..cd03684940 100644 --- a/src/USER-OMP/npair_half_respa_bin_newton_tri_omp.cpp +++ b/src/USER-OMP/npair_half_respa_bin_newton_tri_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_respa_bin_newton_tri_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_respa_nsq_newtoff_omp.cpp b/src/USER-OMP/npair_half_respa_nsq_newtoff_omp.cpp index 0f726cdd7f..b1e7467ec7 100644 --- a/src/USER-OMP/npair_half_respa_nsq_newtoff_omp.cpp +++ b/src/USER-OMP/npair_half_respa_nsq_newtoff_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_respa_nsq_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_respa_nsq_newton_omp.cpp b/src/USER-OMP/npair_half_respa_nsq_newton_omp.cpp index 2783e1255e..c22965895d 100644 --- a/src/USER-OMP/npair_half_respa_nsq_newton_omp.cpp +++ b/src/USER-OMP/npair_half_respa_nsq_newton_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_respa_nsq_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_size_bin_newtoff_omp.cpp b/src/USER-OMP/npair_half_size_bin_newtoff_omp.cpp index dff2a762d5..1b437482c4 100644 --- a/src/USER-OMP/npair_half_size_bin_newtoff_omp.cpp +++ b/src/USER-OMP/npair_half_size_bin_newtoff_omp.cpp @@ -11,10 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_bin_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_size_bin_newton_omp.cpp b/src/USER-OMP/npair_half_size_bin_newton_omp.cpp index 3053b81594..8e0581d4ce 100644 --- a/src/USER-OMP/npair_half_size_bin_newton_omp.cpp +++ b/src/USER-OMP/npair_half_size_bin_newton_omp.cpp @@ -11,10 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_bin_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_size_bin_newton_tri_omp.cpp b/src/USER-OMP/npair_half_size_bin_newton_tri_omp.cpp index b02bfa345e..38a2c0d61f 100644 --- a/src/USER-OMP/npair_half_size_bin_newton_tri_omp.cpp +++ b/src/USER-OMP/npair_half_size_bin_newton_tri_omp.cpp @@ -13,7 +13,6 @@ #include "npair_half_size_bin_newton_tri_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_size_nsq_newtoff_omp.cpp b/src/USER-OMP/npair_half_size_nsq_newtoff_omp.cpp index 717012b226..d1505e1b2e 100644 --- a/src/USER-OMP/npair_half_size_nsq_newtoff_omp.cpp +++ b/src/USER-OMP/npair_half_size_nsq_newtoff_omp.cpp @@ -11,10 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_nsq_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_half_size_nsq_newton_omp.cpp b/src/USER-OMP/npair_half_size_nsq_newton_omp.cpp index 5a55029d30..9027b0728d 100644 --- a/src/USER-OMP/npair_half_size_nsq_newton_omp.cpp +++ b/src/USER-OMP/npair_half_size_nsq_newton_omp.cpp @@ -11,10 +11,8 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include #include "npair_half_size_nsq_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" diff --git a/src/USER-OMP/npair_halffull_newtoff_omp.cpp b/src/USER-OMP/npair_halffull_newtoff_omp.cpp index 6f90f82752..7d2fe4f109 100644 --- a/src/USER-OMP/npair_halffull_newtoff_omp.cpp +++ b/src/USER-OMP/npair_halffull_newtoff_omp.cpp @@ -13,12 +13,8 @@ #include "npair_halffull_newtoff_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" -#include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "timer.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/npair_halffull_newton_omp.cpp b/src/USER-OMP/npair_halffull_newton_omp.cpp index 6cf8ab8ac2..3fcc8c2e98 100644 --- a/src/USER-OMP/npair_halffull_newton_omp.cpp +++ b/src/USER-OMP/npair_halffull_newton_omp.cpp @@ -13,12 +13,9 @@ #include "npair_halffull_newton_omp.h" #include "npair_omp.h" -#include "neighbor.h" #include "neigh_list.h" #include "atom.h" #include "atom_vec.h" -#include "molecule.h" -#include "timer.h" #include "my_page.h" #include "error.h" diff --git a/src/USER-OMP/pair_beck_omp.cpp b/src/USER-OMP/pair_beck_omp.cpp index 90c3777932..8d0605fae9 100644 --- a/src/USER-OMP/pair_beck_omp.cpp +++ b/src/USER-OMP/pair_beck_omp.cpp @@ -12,14 +12,14 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_beck_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "math_special.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_born_coul_wolf_omp.cpp b/src/USER-OMP/pair_born_coul_wolf_omp.cpp index 567eddc9cb..55da972c4e 100644 --- a/src/USER-OMP/pair_born_coul_wolf_omp.cpp +++ b/src/USER-OMP/pair_born_coul_wolf_omp.cpp @@ -12,14 +12,14 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_born_coul_wolf_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "math_const.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_born_omp.cpp b/src/USER-OMP/pair_born_omp.cpp index fce2013745..35ad4fcb48 100644 --- a/src/USER-OMP/pair_born_omp.cpp +++ b/src/USER-OMP/pair_born_omp.cpp @@ -12,13 +12,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_born_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_buck_omp.cpp b/src/USER-OMP/pair_buck_omp.cpp index cc7e81b9c5..8d5c80513a 100644 --- a/src/USER-OMP/pair_buck_omp.cpp +++ b/src/USER-OMP/pair_buck_omp.cpp @@ -12,13 +12,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_buck_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_coul_cut_omp.cpp b/src/USER-OMP/pair_coul_cut_omp.cpp index 056daf210a..267beeecbd 100644 --- a/src/USER-OMP/pair_coul_cut_omp.cpp +++ b/src/USER-OMP/pair_coul_cut_omp.cpp @@ -12,13 +12,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_coul_cut_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_coul_debye_omp.cpp b/src/USER-OMP/pair_coul_debye_omp.cpp index d202e314bf..4d3f92c495 100644 --- a/src/USER-OMP/pair_coul_debye_omp.cpp +++ b/src/USER-OMP/pair_coul_debye_omp.cpp @@ -12,13 +12,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_coul_debye_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_coul_dsf_omp.cpp b/src/USER-OMP/pair_coul_dsf_omp.cpp index 217fb844c3..bd7f5cfed2 100644 --- a/src/USER-OMP/pair_coul_dsf_omp.cpp +++ b/src/USER-OMP/pair_coul_dsf_omp.cpp @@ -12,14 +12,13 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_coul_dsf_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" - +#include "timer.h" #include "suffix.h" #include "math_const.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_coul_wolf_omp.cpp b/src/USER-OMP/pair_coul_wolf_omp.cpp index 0913a2b188..92d5bd7b15 100644 --- a/src/USER-OMP/pair_coul_wolf_omp.cpp +++ b/src/USER-OMP/pair_coul_wolf_omp.cpp @@ -12,14 +12,14 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_coul_wolf_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "math_const.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; diff --git a/src/USER-OMP/pair_dpd_omp.cpp b/src/USER-OMP/pair_dpd_omp.cpp index 77db3d9183..b7f3a7f4d4 100644 --- a/src/USER-OMP/pair_dpd_omp.cpp +++ b/src/USER-OMP/pair_dpd_omp.cpp @@ -12,15 +12,15 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include #include "pair_dpd_omp.h" +#include #include "atom.h" #include "comm.h" #include "force.h" -#include "neighbor.h" #include "neigh_list.h" #include "update.h" #include "random_mars.h" +#include "timer.h" #include "suffix.h" using namespace LAMMPS_NS; -- GitLab From 08ed046a690ec57e1a045e95584a2dcac5f025a8 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 12 Jul 2019 11:29:14 -0600 Subject: [PATCH 245/469] Removed TEMPLATED_FIX_LANGEVIN ifdef --- src/fix_langevin.cpp | 11 ----------- src/fix_langevin.h | 8 +------- 2 files changed, 1 insertion(+), 18 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 36ea47daf6..3f2ec20db0 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -304,7 +304,6 @@ void FixLangevin::post_force(int /*vflag*/) // this avoids testing them inside inner loop: // TSTYLEATOM, GJF, TALLY, BIAS, RMASS, ZERO -#ifdef TEMPLATED_FIX_LANGEVIN if (tstyle == ATOM) if (gjfflag) if (tallyflag) @@ -431,10 +430,6 @@ void FixLangevin::post_force(int /*vflag*/) else if (zeroflag) post_force_templated<0,0,0,0,0,1>(); else post_force_templated<0,0,0,0,0,0>(); -#else - post_force_untemplated(int(tstyle==ATOM), gjfflag, tallyflag, - int(tbiasflag==BIAS), int(rmass!=NULL), zeroflag); -#endif } /* ---------------------------------------------------------------------- */ @@ -448,15 +443,9 @@ void FixLangevin::post_force_respa(int vflag, int ilevel, int /*iloop*/) modify forces using one of the many Langevin styles ------------------------------------------------------------------------- */ -#ifdef TEMPLATED_FIX_LANGEVIN template < int Tp_TSTYLEATOM, int Tp_GJF, int Tp_TALLY, int Tp_BIAS, int Tp_RMASS, int Tp_ZERO > void FixLangevin::post_force_templated() -#else -void FixLangevin::post_force_untemplated - (int Tp_TSTYLEATOM, int Tp_GJF, int Tp_TALLY, - int Tp_BIAS, int Tp_RMASS, int Tp_ZERO) -#endif { double gamma1,gamma2; diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 024e7a9539..4b5570ac2e 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -72,16 +72,10 @@ class FixLangevin : public Fix { class RanMars *random; int seed; - // comment next line to turn off templating -#define TEMPLATED_FIX_LANGEVIN -#ifdef TEMPLATED_FIX_LANGEVIN template < int Tp_TSTYLEATOM, int Tp_GJF, int Tp_TALLY, int Tp_BIAS, int Tp_RMASS, int Tp_ZERO > void post_force_templated(); -#else - void post_force_untemplated(int, int, int, - int, int, int); -#endif + void omega_thermostat(); void angmom_thermostat(); void compute_target(); -- GitLab From a51479a62b7b3f827e0e537a40c6e6d7245237d3 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 12 Jul 2019 11:53:32 -0600 Subject: [PATCH 246/469] Fix bug in fix_setforce_kokkos --- src/KOKKOS/fix_setforce_kokkos.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/KOKKOS/fix_setforce_kokkos.cpp b/src/KOKKOS/fix_setforce_kokkos.cpp index 5d15b88d76..634bc05ac3 100644 --- a/src/KOKKOS/fix_setforce_kokkos.cpp +++ b/src/KOKKOS/fix_setforce_kokkos.cpp @@ -47,6 +47,7 @@ FixSetForceKokkos::FixSetForceKokkos(LAMMPS *lmp, int narg, char **a memory->destroy(sforce); memoryKK->create_kokkos(k_sforce,sforce,maxatom,3,"setforce:sforce"); + d_sforce = k_sforce.view(); } /* ---------------------------------------------------------------------- */ @@ -103,6 +104,7 @@ void FixSetForceKokkos::post_force(int vflag) maxatom = atom->nmax; memoryKK->destroy_kokkos(k_sforce,sforce); memoryKK->create_kokkos(k_sforce,sforce,maxatom,3,"setforce:sforce"); + d_sforce = k_sforce.view(); } foriginal[0] = foriginal[1] = foriginal[2] = 0.0; -- GitLab From e832b5d50bae37c49f12f652cffb8b421e9dd372 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 12 Jul 2019 15:42:16 -0400 Subject: [PATCH 247/469] make clang++ happy when trying to compile the GPU library --- lib/gpu/lal_answer.cpp | 4 ++-- lib/gpu/lal_atom.cpp | 4 ++-- lib/gpu/lal_base_atomic.cpp | 5 +++-- lib/gpu/lal_base_charge.cpp | 4 ++-- lib/gpu/lal_base_dipole.cpp | 4 ++-- lib/gpu/lal_base_dpd.cpp | 4 ++-- lib/gpu/lal_base_ellipsoid.cpp | 4 ++-- lib/gpu/lal_base_three.cpp | 4 ++-- lib/gpu/lal_beck.cpp | 3 ++- lib/gpu/lal_born.cpp | 3 ++- lib/gpu/lal_born_coul_long.cpp | 3 ++- lib/gpu/lal_born_coul_long_cs.cpp | 3 ++- lib/gpu/lal_born_coul_wolf.cpp | 3 ++- lib/gpu/lal_born_coul_wolf_cs.cpp | 3 ++- lib/gpu/lal_buck.cpp | 3 ++- lib/gpu/lal_buck_coul.cpp | 3 ++- lib/gpu/lal_buck_coul_long.cpp | 3 ++- lib/gpu/lal_charmm_long.cpp | 3 ++- lib/gpu/lal_colloid.cpp | 3 ++- lib/gpu/lal_coul.cpp | 3 ++- lib/gpu/lal_coul_debye.cpp | 3 ++- lib/gpu/lal_coul_dsf.cpp | 3 ++- lib/gpu/lal_coul_long.cpp | 3 ++- lib/gpu/lal_coul_long_cs.cpp | 3 ++- lib/gpu/lal_device.cpp | 5 +++-- lib/gpu/lal_dipole_lj.cpp | 3 ++- lib/gpu/lal_dipole_lj_sf.cpp | 3 ++- lib/gpu/lal_dipole_long_lj.cpp | 3 ++- lib/gpu/lal_dpd.cpp | 3 ++- lib/gpu/lal_eam.cpp | 3 ++- lib/gpu/lal_gauss.cpp | 3 ++- lib/gpu/lal_gayberne.cpp | 4 ++-- lib/gpu/lal_lj.cpp | 3 ++- lib/gpu/lal_lj96.cpp | 3 ++- lib/gpu/lal_lj_class2_long.cpp | 4 ++-- lib/gpu/lal_lj_coul.cpp | 3 ++- lib/gpu/lal_lj_coul_debye.cpp | 3 ++- lib/gpu/lal_lj_coul_long.cpp | 3 ++- lib/gpu/lal_lj_coul_msm.cpp | 3 ++- lib/gpu/lal_lj_cubic.cpp | 3 ++- lib/gpu/lal_lj_dsf.cpp | 3 ++- lib/gpu/lal_lj_expand.cpp | 3 ++- lib/gpu/lal_lj_expand_coul_long.cpp | 3 ++- lib/gpu/lal_lj_gromacs.cpp | 3 ++- lib/gpu/lal_lj_sdk.cpp | 3 ++- lib/gpu/lal_lj_sdk_long.cpp | 3 ++- lib/gpu/lal_mie.cpp | 3 ++- lib/gpu/lal_morse.cpp | 4 ++-- lib/gpu/lal_pppm.cpp | 3 ++- lib/gpu/lal_re_squared.cpp | 4 ++-- lib/gpu/lal_soft.cpp | 3 ++- lib/gpu/lal_sw.cpp | 4 ++-- lib/gpu/lal_table.cpp | 3 ++- lib/gpu/lal_tersoff.cpp | 4 ++-- lib/gpu/lal_tersoff_mod.cpp | 4 ++-- lib/gpu/lal_tersoff_zbl.cpp | 4 ++-- lib/gpu/lal_ufm.cpp | 3 ++- lib/gpu/lal_vashishta.cpp | 4 ++-- lib/gpu/lal_yukawa.cpp | 3 ++- lib/gpu/lal_yukawa_colloid.cpp | 3 ++- lib/gpu/lal_zbl.cpp | 3 ++- 61 files changed, 124 insertions(+), 79 deletions(-) diff --git a/lib/gpu/lal_answer.cpp b/lib/gpu/lal_answer.cpp index bd8c7ef843..aa6d33d334 100644 --- a/lib/gpu/lal_answer.cpp +++ b/lib/gpu/lal_answer.cpp @@ -15,7 +15,7 @@ #include "lal_answer.h" -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define AnswerT Answer template @@ -311,4 +311,4 @@ void AnswerT::cq(const int cq_index) { } template class Answer; - +} diff --git a/lib/gpu/lal_atom.cpp b/lib/gpu/lal_atom.cpp index 222ba0525e..bc25c00d93 100644 --- a/lib/gpu/lal_atom.cpp +++ b/lib/gpu/lal_atom.cpp @@ -15,7 +15,7 @@ #include "lal_atom.h" -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define AtomT Atom template @@ -349,4 +349,4 @@ void AtomT::compile_kernels(UCL_Device &dev) { #endif template class Atom; - +} diff --git a/lib/gpu/lal_base_atomic.cpp b/lib/gpu/lal_base_atomic.cpp index da54f1dca3..4aadd3754c 100644 --- a/lib/gpu/lal_base_atomic.cpp +++ b/lib/gpu/lal_base_atomic.cpp @@ -14,7 +14,8 @@ ***************************************************************************/ #include "lal_base_atomic.h" -using namespace LAMMPS_AL; + +namespace LAMMPS_AL { #define BaseAtomicT BaseAtomic extern Device global_device; @@ -285,4 +286,4 @@ void BaseAtomicT::compile_kernels(UCL_Device &dev, const void *pair_str, } template class BaseAtomic; - +} diff --git a/lib/gpu/lal_base_charge.cpp b/lib/gpu/lal_base_charge.cpp index a3ec710baa..760e759201 100644 --- a/lib/gpu/lal_base_charge.cpp +++ b/lib/gpu/lal_base_charge.cpp @@ -15,7 +15,7 @@ ***************************************************************************/ #include "lal_base_charge.h" -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BaseChargeT BaseCharge extern Device global_device; @@ -302,4 +302,4 @@ void BaseChargeT::compile_kernels(UCL_Device &dev, const void *pair_str, } template class BaseCharge; - +} diff --git a/lib/gpu/lal_base_dipole.cpp b/lib/gpu/lal_base_dipole.cpp index 9fc7e1b235..56dcaf8e12 100644 --- a/lib/gpu/lal_base_dipole.cpp +++ b/lib/gpu/lal_base_dipole.cpp @@ -15,7 +15,7 @@ ***************************************************************************/ #include "lal_base_dipole.h" -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BaseDipoleT BaseDipole extern Device global_device; @@ -311,4 +311,4 @@ void BaseDipoleT::compile_kernels(UCL_Device &dev, const void *pair_str, } template class BaseDipole; - +} diff --git a/lib/gpu/lal_base_dpd.cpp b/lib/gpu/lal_base_dpd.cpp index eb5c2088a6..66c8cf09e9 100644 --- a/lib/gpu/lal_base_dpd.cpp +++ b/lib/gpu/lal_base_dpd.cpp @@ -15,7 +15,7 @@ ***************************************************************************/ #include "lal_base_dpd.h" -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BaseDPDT BaseDPD extern Device global_device; @@ -308,4 +308,4 @@ void BaseDPDT::compile_kernels(UCL_Device &dev, const void *pair_str, } template class BaseDPD; - +} diff --git a/lib/gpu/lal_base_ellipsoid.cpp b/lib/gpu/lal_base_ellipsoid.cpp index eea5344e33..b8d0b7a666 100644 --- a/lib/gpu/lal_base_ellipsoid.cpp +++ b/lib/gpu/lal_base_ellipsoid.cpp @@ -15,7 +15,7 @@ #include "lal_base_ellipsoid.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #if defined(USE_OPENCL) #include "ellipsoid_nbor_cl.h" @@ -488,4 +488,4 @@ void BaseEllipsoidT::compile_kernels(UCL_Device &dev, } template class BaseEllipsoid; - +} diff --git a/lib/gpu/lal_base_three.cpp b/lib/gpu/lal_base_three.cpp index 0510b84d92..dc5678dd24 100644 --- a/lib/gpu/lal_base_three.cpp +++ b/lib/gpu/lal_base_three.cpp @@ -14,7 +14,7 @@ ***************************************************************************/ #include "lal_base_three.h" -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BaseThreeT BaseThree extern Device global_device; @@ -397,4 +397,4 @@ void BaseThreeT::compile_kernels(UCL_Device &dev, const void *pair_str, } template class BaseThree; - +} diff --git a/lib/gpu/lal_beck.cpp b/lib/gpu/lal_beck.cpp index 165a02b71a..be1722c32c 100644 --- a/lib/gpu/lal_beck.cpp +++ b/lib/gpu/lal_beck.cpp @@ -23,7 +23,7 @@ const char *beck=0; #include "lal_beck.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BeckT Beck extern Device device; @@ -150,3 +150,4 @@ void BeckT::loop(const bool _eflag, const bool _vflag) { } template class Beck; +} diff --git a/lib/gpu/lal_born.cpp b/lib/gpu/lal_born.cpp index 7c1ed944d3..4a6b789687 100644 --- a/lib/gpu/lal_born.cpp +++ b/lib/gpu/lal_born.cpp @@ -23,7 +23,7 @@ const char *born=0; #include "lal_born.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BornT Born extern Device device; @@ -179,3 +179,4 @@ void BornT::loop(const bool _eflag, const bool _vflag) { } template class Born; +} diff --git a/lib/gpu/lal_born_coul_long.cpp b/lib/gpu/lal_born_coul_long.cpp index 116d44d58f..1b147395f6 100644 --- a/lib/gpu/lal_born_coul_long.cpp +++ b/lib/gpu/lal_born_coul_long.cpp @@ -23,7 +23,7 @@ const char *born_coul_long=0; #include "lal_born_coul_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BornCoulLongT BornCoulLong extern Device device; @@ -173,3 +173,4 @@ void BornCoulLongT::loop(const bool _eflag, const bool _vflag) { } template class BornCoulLong; +} diff --git a/lib/gpu/lal_born_coul_long_cs.cpp b/lib/gpu/lal_born_coul_long_cs.cpp index e7fb946f14..24de1e3a06 100644 --- a/lib/gpu/lal_born_coul_long_cs.cpp +++ b/lib/gpu/lal_born_coul_long_cs.cpp @@ -23,7 +23,7 @@ const char *born_coul_long_cs=0; #include "lal_born_coul_long_cs.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BornCoulLongCST BornCoulLongCS extern Device device; @@ -93,3 +93,4 @@ int BornCoulLongCST::init(const int ntypes, double **host_cutsq, double **host_r } template class BornCoulLongCS; +} diff --git a/lib/gpu/lal_born_coul_wolf.cpp b/lib/gpu/lal_born_coul_wolf.cpp index c44b841463..1624dd9d50 100644 --- a/lib/gpu/lal_born_coul_wolf.cpp +++ b/lib/gpu/lal_born_coul_wolf.cpp @@ -23,7 +23,7 @@ const char *born_coul_wolf=0; #include "lal_born_coul_wolf.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BornCoulWolfT BornCoulWolf extern Device device; @@ -174,3 +174,4 @@ void BornCoulWolfT::loop(const bool _eflag, const bool _vflag) { } template class BornCoulWolf; +} diff --git a/lib/gpu/lal_born_coul_wolf_cs.cpp b/lib/gpu/lal_born_coul_wolf_cs.cpp index bdb1c31e55..8deceeb1f4 100644 --- a/lib/gpu/lal_born_coul_wolf_cs.cpp +++ b/lib/gpu/lal_born_coul_wolf_cs.cpp @@ -23,7 +23,7 @@ const char *born_coul_wolf_cs=0; #include "lal_born_coul_wolf_cs.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BornCoulWolfCST BornCoulWolfCS extern Device device; @@ -95,3 +95,4 @@ int BornCoulWolfCST::init(const int ntypes, double **host_cutsq, double **host_r } template class BornCoulWolfCS; +} diff --git a/lib/gpu/lal_buck.cpp b/lib/gpu/lal_buck.cpp index 0da4068d51..5a335a1e51 100644 --- a/lib/gpu/lal_buck.cpp +++ b/lib/gpu/lal_buck.cpp @@ -23,7 +23,7 @@ const char *buck=0; #include "lal_buck.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BuckT Buck extern Device device; @@ -168,3 +168,4 @@ void BuckT::loop(const bool _eflag, const bool _vflag) { } template class Buck; +} diff --git a/lib/gpu/lal_buck_coul.cpp b/lib/gpu/lal_buck_coul.cpp index e4f829fc5c..25607eae17 100644 --- a/lib/gpu/lal_buck_coul.cpp +++ b/lib/gpu/lal_buck_coul.cpp @@ -23,7 +23,7 @@ const char *buck_coul=0; #include "lal_buck_coul.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BuckCoulT BuckCoul extern Device device; @@ -161,3 +161,4 @@ void BuckCoulT::loop(const bool _eflag, const bool _vflag) { } template class BuckCoul; +} diff --git a/lib/gpu/lal_buck_coul_long.cpp b/lib/gpu/lal_buck_coul_long.cpp index 81faada116..1c0288c2d8 100644 --- a/lib/gpu/lal_buck_coul_long.cpp +++ b/lib/gpu/lal_buck_coul_long.cpp @@ -23,7 +23,7 @@ const char *buck_coul_long=0; #include "lal_buck_coul_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define BuckCoulLongT BuckCoulLong extern Device device; @@ -166,3 +166,4 @@ void BuckCoulLongT::loop(const bool _eflag, const bool _vflag) { } template class BuckCoulLong; +} diff --git a/lib/gpu/lal_charmm_long.cpp b/lib/gpu/lal_charmm_long.cpp index 9cd032b3c6..a78996a7d5 100644 --- a/lib/gpu/lal_charmm_long.cpp +++ b/lib/gpu/lal_charmm_long.cpp @@ -23,7 +23,7 @@ const char *charmm_long=0; #include "lal_charmm_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CHARMMLongT CHARMMLong extern Device device; @@ -174,3 +174,4 @@ void CHARMMLongT::loop(const bool _eflag, const bool _vflag) { } template class CHARMMLong; +} diff --git a/lib/gpu/lal_colloid.cpp b/lib/gpu/lal_colloid.cpp index fb2b643e5e..c441d50968 100644 --- a/lib/gpu/lal_colloid.cpp +++ b/lib/gpu/lal_colloid.cpp @@ -23,7 +23,7 @@ const char *colloid=0; #include "lal_colloid.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define ColloidT Colloid extern Device device; @@ -179,3 +179,4 @@ void ColloidT::loop(const bool _eflag, const bool _vflag) { } template class Colloid; +} diff --git a/lib/gpu/lal_coul.cpp b/lib/gpu/lal_coul.cpp index a06a29e610..3e29215c91 100644 --- a/lib/gpu/lal_coul.cpp +++ b/lib/gpu/lal_coul.cpp @@ -23,7 +23,7 @@ const char *coul=0; #include "lal_coul.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CoulT Coul extern Device device; @@ -164,3 +164,4 @@ void CoulT::loop(const bool _eflag, const bool _vflag) { } template class Coul; +} diff --git a/lib/gpu/lal_coul_debye.cpp b/lib/gpu/lal_coul_debye.cpp index 9098aeacb1..08ceb99300 100644 --- a/lib/gpu/lal_coul_debye.cpp +++ b/lib/gpu/lal_coul_debye.cpp @@ -23,7 +23,7 @@ const char *coul_debye=0; #include "lal_coul_debye.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CoulDebyeT CoulDebye extern Device device; @@ -165,3 +165,4 @@ void CoulDebyeT::loop(const bool _eflag, const bool _vflag) { } template class CoulDebye; +} diff --git a/lib/gpu/lal_coul_dsf.cpp b/lib/gpu/lal_coul_dsf.cpp index 32c4342fbe..fe1fbfede7 100644 --- a/lib/gpu/lal_coul_dsf.cpp +++ b/lib/gpu/lal_coul_dsf.cpp @@ -23,7 +23,7 @@ const char *coul_dsf=0; #include "lal_coul_dsf.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CoulDSFT CoulDSF extern Device device; @@ -151,3 +151,4 @@ void CoulDSFT::loop(const bool _eflag, const bool _vflag) { } template class CoulDSF; +} diff --git a/lib/gpu/lal_coul_long.cpp b/lib/gpu/lal_coul_long.cpp index b4c6a44d2f..02097a2c61 100644 --- a/lib/gpu/lal_coul_long.cpp +++ b/lib/gpu/lal_coul_long.cpp @@ -23,7 +23,7 @@ const char *coul_long=0; #include "lal_coul_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CoulLongT CoulLong extern Device pair_gpu_device; @@ -156,3 +156,4 @@ void CoulLongT::loop(const bool _eflag, const bool _vflag) { } template class CoulLong; +} diff --git a/lib/gpu/lal_coul_long_cs.cpp b/lib/gpu/lal_coul_long_cs.cpp index 7afa0ae5d2..32b5691610 100644 --- a/lib/gpu/lal_coul_long_cs.cpp +++ b/lib/gpu/lal_coul_long_cs.cpp @@ -23,7 +23,7 @@ const char *coul_long_cs=0; #include "lal_coul_long_cs.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CoulLongCST CoulLongCS extern Device pair_gpu_device; @@ -76,3 +76,4 @@ int CoulLongCST::init(const int ntypes, double **host_scale, } template class CoulLongCS; +} diff --git a/lib/gpu/lal_device.cpp b/lib/gpu/lal_device.cpp index 9410cc5250..5bd306ea5b 100644 --- a/lib/gpu/lal_device.cpp +++ b/lib/gpu/lal_device.cpp @@ -30,7 +30,7 @@ const char *device=0; #include "device_cubin.h" #endif -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define DeviceT Device template @@ -762,7 +762,9 @@ double DeviceT::host_memory_usage() const { template class Device; Device global_device; +} +using namespace LAMMPS_AL; int lmp_init_device(MPI_Comm world, MPI_Comm replica, const int first_gpu, const int last_gpu, const int gpu_mode, const double particle_split, const int nthreads, @@ -781,4 +783,3 @@ double lmp_gpu_forces(double **f, double **tor, double *eatom, double **vatom, double *virial, double &ecoul) { return global_device.fix_gpu(f,tor,eatom,vatom,virial,ecoul); } - diff --git a/lib/gpu/lal_dipole_lj.cpp b/lib/gpu/lal_dipole_lj.cpp index c97b76c820..b0929e2ffb 100644 --- a/lib/gpu/lal_dipole_lj.cpp +++ b/lib/gpu/lal_dipole_lj.cpp @@ -23,7 +23,7 @@ const char *dipole_lj=0; #include "lal_dipole_lj.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define DipoleLJT DipoleLJ extern Device device; @@ -168,3 +168,4 @@ void DipoleLJT::loop(const bool _eflag, const bool _vflag) { } template class DipoleLJ; +} diff --git a/lib/gpu/lal_dipole_lj_sf.cpp b/lib/gpu/lal_dipole_lj_sf.cpp index a33f38084f..dcf95bb126 100644 --- a/lib/gpu/lal_dipole_lj_sf.cpp +++ b/lib/gpu/lal_dipole_lj_sf.cpp @@ -23,7 +23,7 @@ const char *dipole_lj_sf=0; #include "lal_dipole_lj_sf.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define DipoleLJSFT DipoleLJSF extern Device device; @@ -168,3 +168,4 @@ void DipoleLJSFT::loop(const bool _eflag, const bool _vflag) { } template class DipoleLJSF; +} diff --git a/lib/gpu/lal_dipole_long_lj.cpp b/lib/gpu/lal_dipole_long_lj.cpp index 251e1def92..9648e9b15e 100644 --- a/lib/gpu/lal_dipole_long_lj.cpp +++ b/lib/gpu/lal_dipole_long_lj.cpp @@ -23,7 +23,7 @@ const char *dipole_long_lj=0; #include "lal_dipole_long_lj.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define DipoleLongLJT DipoleLongLJ extern Device device; @@ -171,3 +171,4 @@ void DipoleLongLJT::loop(const bool _eflag, const bool _vflag) { } template class DipoleLongLJ; +} diff --git a/lib/gpu/lal_dpd.cpp b/lib/gpu/lal_dpd.cpp index 4f6f2d641f..c5cbc7eb53 100644 --- a/lib/gpu/lal_dpd.cpp +++ b/lib/gpu/lal_dpd.cpp @@ -23,7 +23,7 @@ const char *dpd=0; #include "lal_dpd.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define DPDT DPD extern Device device; @@ -168,3 +168,4 @@ void DPDT::update_coeff(int ntypes, double **host_a0, double **host_gamma, } template class DPD; +} diff --git a/lib/gpu/lal_eam.cpp b/lib/gpu/lal_eam.cpp index b83972f4db..8c81353f36 100644 --- a/lib/gpu/lal_eam.cpp +++ b/lib/gpu/lal_eam.cpp @@ -23,7 +23,7 @@ const char *eam=0; #include "lal_eam.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define EAMT EAM @@ -531,3 +531,4 @@ void EAMT::loop2(const bool _eflag, const bool _vflag) { } template class EAM; +} diff --git a/lib/gpu/lal_gauss.cpp b/lib/gpu/lal_gauss.cpp index 1ef215d7ff..2f965758eb 100644 --- a/lib/gpu/lal_gauss.cpp +++ b/lib/gpu/lal_gauss.cpp @@ -23,7 +23,7 @@ const char *gauss=0; #include "lal_gauss.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define GaussT Gauss extern Device device; @@ -159,3 +159,4 @@ void GaussT::loop(const bool _eflag, const bool _vflag) { } template class Gauss; +} diff --git a/lib/gpu/lal_gayberne.cpp b/lib/gpu/lal_gayberne.cpp index ba15af672e..f17fc50f5f 100644 --- a/lib/gpu/lal_gayberne.cpp +++ b/lib/gpu/lal_gayberne.cpp @@ -26,7 +26,7 @@ const char *gayberne_lj=0; #include "lal_gayberne.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define GayBerneT GayBerne extern Device device; @@ -315,4 +315,4 @@ void GayBerneT::loop(const bool _eflag, const bool _vflag) { } template class GayBerne; - +} diff --git a/lib/gpu/lal_lj.cpp b/lib/gpu/lal_lj.cpp index 978b33e5d7..5bd015e364 100644 --- a/lib/gpu/lal_lj.cpp +++ b/lib/gpu/lal_lj.cpp @@ -23,7 +23,7 @@ const char *lj=0; #include "lal_lj.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJT LJ extern Device device; @@ -168,3 +168,4 @@ void LJT::loop(const bool _eflag, const bool _vflag) { } template class LJ; +} diff --git a/lib/gpu/lal_lj96.cpp b/lib/gpu/lal_lj96.cpp index 191f211ae4..6f74cd0f19 100644 --- a/lib/gpu/lal_lj96.cpp +++ b/lib/gpu/lal_lj96.cpp @@ -23,7 +23,7 @@ const char *lj96=0; #include "lal_lj96.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJ96T LJ96 extern Device device; @@ -152,3 +152,4 @@ void LJ96T::loop(const bool _eflag, const bool _vflag) { } template class LJ96; +} diff --git a/lib/gpu/lal_lj_class2_long.cpp b/lib/gpu/lal_lj_class2_long.cpp index 497e5989ad..24b07212ed 100644 --- a/lib/gpu/lal_lj_class2_long.cpp +++ b/lib/gpu/lal_lj_class2_long.cpp @@ -23,7 +23,7 @@ const char *lj_class2_long=0; #include "lal_lj_class2_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJClass2LongT LJClass2Long @@ -164,4 +164,4 @@ void LJClass2LongT::loop(const bool _eflag, const bool _vflag) { } template class LJClass2Long; - +} diff --git a/lib/gpu/lal_lj_coul.cpp b/lib/gpu/lal_lj_coul.cpp index a8255318bd..59ce9c5e61 100644 --- a/lib/gpu/lal_lj_coul.cpp +++ b/lib/gpu/lal_lj_coul.cpp @@ -23,7 +23,7 @@ const char *lj_coul=0; #include "lal_lj_coul.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJCoulT LJCoul extern Device device; @@ -164,3 +164,4 @@ void LJCoulT::loop(const bool _eflag, const bool _vflag) { } template class LJCoul; +} diff --git a/lib/gpu/lal_lj_coul_debye.cpp b/lib/gpu/lal_lj_coul_debye.cpp index 92167f314f..556a0a5cd3 100644 --- a/lib/gpu/lal_lj_coul_debye.cpp +++ b/lib/gpu/lal_lj_coul_debye.cpp @@ -23,7 +23,7 @@ const char *lj_coul_debye=0; #include "lal_lj_coul_debye.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJCoulDebyeT LJCoulDebye extern Device device; @@ -166,3 +166,4 @@ void LJCoulDebyeT::loop(const bool _eflag, const bool _vflag) { } template class LJCoulDebye; +} diff --git a/lib/gpu/lal_lj_coul_long.cpp b/lib/gpu/lal_lj_coul_long.cpp index 29d648bed2..66897a4aa7 100644 --- a/lib/gpu/lal_lj_coul_long.cpp +++ b/lib/gpu/lal_lj_coul_long.cpp @@ -23,7 +23,7 @@ const char *lj_coul_long=0; #include "lal_lj_coul_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJCoulLongT LJCoulLong extern Device device; @@ -181,3 +181,4 @@ void LJCoulLongT::loop(const bool _eflag, const bool _vflag) { } template class LJCoulLong; +} diff --git a/lib/gpu/lal_lj_coul_msm.cpp b/lib/gpu/lal_lj_coul_msm.cpp index 1358de9ee1..9a17d068ec 100644 --- a/lib/gpu/lal_lj_coul_msm.cpp +++ b/lib/gpu/lal_lj_coul_msm.cpp @@ -23,7 +23,7 @@ const char *lj_coul_msm=0; #include "lal_lj_coul_msm.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJCoulMSMT LJCoulMSM extern Device device; @@ -198,3 +198,4 @@ void LJCoulMSMT::loop(const bool _eflag, const bool _vflag) { } template class LJCoulMSM; +} diff --git a/lib/gpu/lal_lj_cubic.cpp b/lib/gpu/lal_lj_cubic.cpp index 21ea22845c..f8200ec037 100644 --- a/lib/gpu/lal_lj_cubic.cpp +++ b/lib/gpu/lal_lj_cubic.cpp @@ -23,7 +23,7 @@ const char *lj_cubic=0; #include "lal_lj_cubic.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJCubicT LJCubic extern Device device; @@ -157,3 +157,4 @@ void LJCubicT::loop(const bool _eflag, const bool _vflag) { } template class LJCubic; +} diff --git a/lib/gpu/lal_lj_dsf.cpp b/lib/gpu/lal_lj_dsf.cpp index 1efac3e821..b888f33f00 100644 --- a/lib/gpu/lal_lj_dsf.cpp +++ b/lib/gpu/lal_lj_dsf.cpp @@ -23,7 +23,7 @@ const char *lj_dsf=0; #include "lal_lj_dsf.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJDSFT LJDSF extern Device device; @@ -166,3 +166,4 @@ void LJDSFT::loop(const bool _eflag, const bool _vflag) { } template class LJDSF; +} diff --git a/lib/gpu/lal_lj_expand.cpp b/lib/gpu/lal_lj_expand.cpp index 34a4d71c0b..1c58cecfae 100644 --- a/lib/gpu/lal_lj_expand.cpp +++ b/lib/gpu/lal_lj_expand.cpp @@ -23,7 +23,7 @@ const char *lj_expand=0; #include "lal_lj_expand.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJExpandT LJExpand extern Device device; @@ -171,3 +171,4 @@ void LJExpandT::loop(const bool _eflag, const bool _vflag) { } template class LJExpand; +} diff --git a/lib/gpu/lal_lj_expand_coul_long.cpp b/lib/gpu/lal_lj_expand_coul_long.cpp index 32a4f8120e..3e5e00ef6a 100644 --- a/lib/gpu/lal_lj_expand_coul_long.cpp +++ b/lib/gpu/lal_lj_expand_coul_long.cpp @@ -23,7 +23,7 @@ const char *lj_expand_coul_long=0; #include "lal_lj_expand_coul_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJExpandCoulLongT LJExpandCoulLong extern Device device; @@ -181,3 +181,4 @@ void LJExpandCoulLongT::loop(const bool _eflag, const bool _vflag) { } template class LJExpandCoulLong; +} diff --git a/lib/gpu/lal_lj_gromacs.cpp b/lib/gpu/lal_lj_gromacs.cpp index 75f5a41917..0563151ddd 100644 --- a/lib/gpu/lal_lj_gromacs.cpp +++ b/lib/gpu/lal_lj_gromacs.cpp @@ -23,7 +23,7 @@ const char *lj_gromacs=0; #include "lal_lj_gromacs.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define LJGROMACST LJGROMACS extern Device device; @@ -162,3 +162,4 @@ void LJGROMACST::loop(const bool _eflag, const bool _vflag) { } template class LJGROMACS; +} diff --git a/lib/gpu/lal_lj_sdk.cpp b/lib/gpu/lal_lj_sdk.cpp index 618555e38a..c6a282576c 100644 --- a/lib/gpu/lal_lj_sdk.cpp +++ b/lib/gpu/lal_lj_sdk.cpp @@ -23,7 +23,7 @@ const char *lj_sdk=0; #include "lal_lj_sdk.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CGCMMT CGCMM extern Device device; @@ -152,3 +152,4 @@ void CGCMMT::loop(const bool _eflag, const bool _vflag) { } template class CGCMM; +} diff --git a/lib/gpu/lal_lj_sdk_long.cpp b/lib/gpu/lal_lj_sdk_long.cpp index 46caf6bd36..74dbfc40e3 100644 --- a/lib/gpu/lal_lj_sdk_long.cpp +++ b/lib/gpu/lal_lj_sdk_long.cpp @@ -23,7 +23,7 @@ const char *lj_sdk_long=0; #include "lal_lj_sdk_long.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define CGCMMLongT CGCMMLong extern Device device; @@ -164,3 +164,4 @@ void CGCMMLongT::loop(const bool _eflag, const bool _vflag) { } template class CGCMMLong; +} diff --git a/lib/gpu/lal_mie.cpp b/lib/gpu/lal_mie.cpp index 1510275047..394d1f8a2f 100644 --- a/lib/gpu/lal_mie.cpp +++ b/lib/gpu/lal_mie.cpp @@ -23,7 +23,7 @@ const char *mie=0; #include "lal_mie.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define MieT Mie extern Device device; @@ -150,3 +150,4 @@ void MieT::loop(const bool _eflag, const bool _vflag) { } template class Mie; +} diff --git a/lib/gpu/lal_morse.cpp b/lib/gpu/lal_morse.cpp index cbdf928863..09da65d252 100644 --- a/lib/gpu/lal_morse.cpp +++ b/lib/gpu/lal_morse.cpp @@ -23,7 +23,7 @@ const char *morse=0; #include "lal_morse.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define MorseT Morse extern Device device; @@ -150,4 +150,4 @@ void MorseT::loop(const bool _eflag, const bool _vflag) { } template class Morse; - +} diff --git a/lib/gpu/lal_pppm.cpp b/lib/gpu/lal_pppm.cpp index fefa1172ab..8b5012f312 100644 --- a/lib/gpu/lal_pppm.cpp +++ b/lib/gpu/lal_pppm.cpp @@ -25,7 +25,7 @@ const char *pppm_d=0; #include "lal_pppm.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define PPPMT PPPM extern Device global_device; @@ -402,3 +402,4 @@ void PPPMT::compile_kernels(UCL_Device &dev) { template class PPPM; template class PPPM; +} diff --git a/lib/gpu/lal_re_squared.cpp b/lib/gpu/lal_re_squared.cpp index 9513f5a633..81dc3b13a4 100644 --- a/lib/gpu/lal_re_squared.cpp +++ b/lib/gpu/lal_re_squared.cpp @@ -26,7 +26,7 @@ const char *re_squared_lj=0; #include "lal_re_squared.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define RESquaredT RESquared extern Device device; @@ -315,4 +315,4 @@ void RESquaredT::loop(const bool _eflag, const bool _vflag) { } template class RESquared; - +} diff --git a/lib/gpu/lal_soft.cpp b/lib/gpu/lal_soft.cpp index 727b112ea5..8e944fa0a5 100644 --- a/lib/gpu/lal_soft.cpp +++ b/lib/gpu/lal_soft.cpp @@ -23,7 +23,7 @@ const char *soft=0; #include "lal_soft.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define SoftT Soft extern Device device; @@ -158,3 +158,4 @@ void SoftT::loop(const bool _eflag, const bool _vflag) { } template class Soft; +} diff --git a/lib/gpu/lal_sw.cpp b/lib/gpu/lal_sw.cpp index 46b6382a60..5c7bd45c76 100644 --- a/lib/gpu/lal_sw.cpp +++ b/lib/gpu/lal_sw.cpp @@ -23,7 +23,7 @@ const char *sw=0; #include "lal_sw.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define SWT SW extern Device device; @@ -262,4 +262,4 @@ void SWT::loop(const bool _eflag, const bool _vflag, const int evatom) { } template class SW; - +} diff --git a/lib/gpu/lal_table.cpp b/lib/gpu/lal_table.cpp index 0de59c84b2..d07b2716e4 100644 --- a/lib/gpu/lal_table.cpp +++ b/lib/gpu/lal_table.cpp @@ -23,7 +23,7 @@ const char *table=0; #include "lal_table.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define TableT Table #define LOOKUP 0 @@ -337,3 +337,4 @@ void TableT::loop(const bool _eflag, const bool _vflag) { } template class Table; +} diff --git a/lib/gpu/lal_tersoff.cpp b/lib/gpu/lal_tersoff.cpp index ef55b98a2d..27143acb0c 100644 --- a/lib/gpu/lal_tersoff.cpp +++ b/lib/gpu/lal_tersoff.cpp @@ -23,7 +23,7 @@ const char *tersoff=0; #include "lal_tersoff.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define TersoffT Tersoff extern Device device; @@ -329,4 +329,4 @@ void TersoffT::loop(const bool _eflag, const bool _vflag, const int evatom) { } template class Tersoff; - +} diff --git a/lib/gpu/lal_tersoff_mod.cpp b/lib/gpu/lal_tersoff_mod.cpp index 3cbb488cab..182859bdd4 100644 --- a/lib/gpu/lal_tersoff_mod.cpp +++ b/lib/gpu/lal_tersoff_mod.cpp @@ -23,7 +23,7 @@ const char *tersoff_mod=0; #include "lal_tersoff_mod.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define TersoffMT TersoffMod extern Device device; @@ -329,4 +329,4 @@ void TersoffMT::loop(const bool _eflag, const bool _vflag, const int evatom) { } template class TersoffMod; - +} diff --git a/lib/gpu/lal_tersoff_zbl.cpp b/lib/gpu/lal_tersoff_zbl.cpp index ebf67285ed..92db59679e 100644 --- a/lib/gpu/lal_tersoff_zbl.cpp +++ b/lib/gpu/lal_tersoff_zbl.cpp @@ -23,7 +23,7 @@ const char *tersoff_zbl=0; #include "lal_tersoff_zbl.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define TersoffZT TersoffZBL extern Device device; @@ -355,4 +355,4 @@ void TersoffZT::loop(const bool _eflag, const bool _vflag, const int evatom) { } template class TersoffZBL; - +} diff --git a/lib/gpu/lal_ufm.cpp b/lib/gpu/lal_ufm.cpp index c7aa2cca39..9b7d42dec9 100644 --- a/lib/gpu/lal_ufm.cpp +++ b/lib/gpu/lal_ufm.cpp @@ -25,7 +25,7 @@ const char *ufm=0; #include "lal_ufm.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define UFMT UFM extern Device device; @@ -170,3 +170,4 @@ void UFMT::loop(const bool _eflag, const bool _vflag) { } template class UFM; +} diff --git a/lib/gpu/lal_vashishta.cpp b/lib/gpu/lal_vashishta.cpp index 5a01a9bd46..350ae8e8fd 100644 --- a/lib/gpu/lal_vashishta.cpp +++ b/lib/gpu/lal_vashishta.cpp @@ -23,7 +23,7 @@ const char *vashishta=0; #include "lal_vashishta.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define VashishtaT Vashishta extern Device device; @@ -295,4 +295,4 @@ void VashishtaT::loop(const bool _eflag, const bool _vflag, const int evatom) { } template class Vashishta; - +} diff --git a/lib/gpu/lal_yukawa.cpp b/lib/gpu/lal_yukawa.cpp index a316d195ac..453139e537 100644 --- a/lib/gpu/lal_yukawa.cpp +++ b/lib/gpu/lal_yukawa.cpp @@ -23,7 +23,7 @@ const char *yukawa=0; #include "lal_yukawa.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define YukawaT Yukawa extern Device device; @@ -147,3 +147,4 @@ void YukawaT::loop(const bool _eflag, const bool _vflag) { } template class Yukawa; +} diff --git a/lib/gpu/lal_yukawa_colloid.cpp b/lib/gpu/lal_yukawa_colloid.cpp index af29938a68..e71e962ffd 100644 --- a/lib/gpu/lal_yukawa_colloid.cpp +++ b/lib/gpu/lal_yukawa_colloid.cpp @@ -23,7 +23,7 @@ const char *yukawa_colloid=0; #include "lal_yukawa_colloid.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define YukawaColloidT YukawaColloid extern Device device; @@ -289,3 +289,4 @@ void YukawaColloidT::loop(const bool _eflag, const bool _vflag) { } template class YukawaColloid; +} diff --git a/lib/gpu/lal_zbl.cpp b/lib/gpu/lal_zbl.cpp index 77e55a62f9..2bf3369174 100644 --- a/lib/gpu/lal_zbl.cpp +++ b/lib/gpu/lal_zbl.cpp @@ -23,7 +23,7 @@ const char *zbl=0; #include "lal_zbl.h" #include -using namespace LAMMPS_AL; +namespace LAMMPS_AL { #define ZBLT ZBL extern Device device; @@ -157,3 +157,4 @@ void ZBLT::loop(const bool _eflag, const bool _vflag) { } template class ZBL; +} -- GitLab From a1f0c0079de6d0c7d94fc63f6d9cd76e70b5ce2b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 12 Jul 2019 15:40:24 -0400 Subject: [PATCH 248/469] some cleanup for missed steps in previous change sets --- src/KSPACE/pppm.h | 5 +---- src/KSPACE/pppm_disp.h | 5 +---- src/MPIIO/dump_xyz_mpiio.cpp | 1 - src/USER-AWPMD/atom_vec_wavepacket.cpp | 1 - src/USER-AWPMD/fix_nve_awpmd.cpp | 7 +++---- src/USER-AWPMD/fix_nve_awpmd.h | 3 +-- src/USER-AWPMD/pair_awpmd_cut.cpp | 8 ++++++-- src/USER-BOCS/compute_pressure_bocs.cpp | 1 + src/USER-CGSDK/pair_lj_sdk.cpp | 2 -- src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp | 1 - src/USER-DPD/fix_shardlow.cpp | 3 ++- src/USER-OMP/pair_reaxc_omp.cpp | 11 ++++------- src/accelerator_kokkos.h | 16 ++++++++-------- src/finish.cpp | 4 ++-- 14 files changed, 29 insertions(+), 39 deletions(-) diff --git a/src/KSPACE/pppm.h b/src/KSPACE/pppm.h index 1ce1a0d666..b84dfe26c4 100644 --- a/src/KSPACE/pppm.h +++ b/src/KSPACE/pppm.h @@ -20,8 +20,7 @@ KSpaceStyle(pppm,PPPM) #ifndef LMP_PPPM_H #define LMP_PPPM_H -#include "lmptype.h" -#include +#include "kspace.h" #ifdef FFT_SINGLE typedef float FFT_SCALAR; @@ -31,8 +30,6 @@ typedef double FFT_SCALAR; #define MPI_FFT_SCALAR MPI_DOUBLE #endif -#include "kspace.h" - namespace LAMMPS_NS { class PPPM : public KSpace { diff --git a/src/KSPACE/pppm_disp.h b/src/KSPACE/pppm_disp.h index ccbeb60f3c..8582e98acd 100644 --- a/src/KSPACE/pppm_disp.h +++ b/src/KSPACE/pppm_disp.h @@ -20,8 +20,7 @@ KSpaceStyle(pppm/disp,PPPMDisp) #ifndef LMP_PPPM_DISP_H #define LMP_PPPM_DISP_H -#include "lmptype.h" -#include +#include "kspace.h" #ifdef FFT_SINGLE typedef float FFT_SCALAR; @@ -31,8 +30,6 @@ typedef double FFT_SCALAR; #define MPI_FFT_SCALAR MPI_DOUBLE #endif -#include "kspace.h" - namespace LAMMPS_NS { diff --git a/src/MPIIO/dump_xyz_mpiio.cpp b/src/MPIIO/dump_xyz_mpiio.cpp index ee0532399a..f5caab3a9c 100644 --- a/src/MPIIO/dump_xyz_mpiio.cpp +++ b/src/MPIIO/dump_xyz_mpiio.cpp @@ -21,7 +21,6 @@ #include #include "domain.h" #include "update.h" -#include "modify.h" #include "compute.h" #include "memory.h" #include "error.h" diff --git a/src/USER-AWPMD/atom_vec_wavepacket.cpp b/src/USER-AWPMD/atom_vec_wavepacket.cpp index 3dc624e4b8..bce334a7b3 100644 --- a/src/USER-AWPMD/atom_vec_wavepacket.cpp +++ b/src/USER-AWPMD/atom_vec_wavepacket.cpp @@ -16,7 +16,6 @@ ------------------------------------------------------------------------- */ #include "atom_vec_wavepacket.h" -#include #include #include "atom.h" #include "comm.h" diff --git a/src/USER-AWPMD/fix_nve_awpmd.cpp b/src/USER-AWPMD/fix_nve_awpmd.cpp index 57ad17f3e6..a147a11081 100644 --- a/src/USER-AWPMD/fix_nve_awpmd.cpp +++ b/src/USER-AWPMD/fix_nve_awpmd.cpp @@ -16,14 +16,13 @@ ------------------------------------------------------------------------- */ #include "fix_nve_awpmd.h" -#include -#include -#include +#include "pair_awpmd_cut.h" #include "atom.h" #include "force.h" #include "update.h" #include "respa.h" #include "error.h" +#include "utils.h" #include "TCP/wpmd_split.h" @@ -62,7 +61,7 @@ void FixNVEAwpmd::init() dtv = update->dt; dtf = 0.5 * update->dt * force->ftm2v; - if (strstr(update->integrate_style,"respa")) + if (utils::strmatch(update->integrate_style,"^respa")) step_respa = ((Respa *) update->integrate)->step; awpmd_pair=(PairAWPMDCut *)force->pair; diff --git a/src/USER-AWPMD/fix_nve_awpmd.h b/src/USER-AWPMD/fix_nve_awpmd.h index 140d234308..832f5821a3 100644 --- a/src/USER-AWPMD/fix_nve_awpmd.h +++ b/src/USER-AWPMD/fix_nve_awpmd.h @@ -25,7 +25,6 @@ FixStyle(nve/awpmd,FixNVEAwpmd) #define LMP_FIX_NVE_awpmd_H #include "fix.h" -#include "pair_awpmd_cut.h" namespace LAMMPS_NS { @@ -45,7 +44,7 @@ class FixNVEAwpmd : public Fix { double *step_respa; int mass_require; - PairAWPMDCut *awpmd_pair; + class PairAWPMDCut *awpmd_pair; }; } diff --git a/src/USER-AWPMD/pair_awpmd_cut.cpp b/src/USER-AWPMD/pair_awpmd_cut.cpp index ae2fbc59fa..75ebb0e251 100644 --- a/src/USER-AWPMD/pair_awpmd_cut.cpp +++ b/src/USER-AWPMD/pair_awpmd_cut.cpp @@ -16,10 +16,11 @@ ------------------------------------------------------------------------- */ #include "pair_awpmd_cut.h" +#include #include -#include -#include #include +#include +#include #include "atom.h" #include "update.h" #include "min.h" @@ -32,6 +33,9 @@ #include "memory.h" #include "error.h" +#include "logexc.h" +#include "vector_3.h" +#include "TCP/wpmd.h" #include "TCP/wpmd_split.h" using namespace LAMMPS_NS; diff --git a/src/USER-BOCS/compute_pressure_bocs.cpp b/src/USER-BOCS/compute_pressure_bocs.cpp index ee1ad33f88..d0a24b99a3 100644 --- a/src/USER-BOCS/compute_pressure_bocs.cpp +++ b/src/USER-BOCS/compute_pressure_bocs.cpp @@ -16,6 +16,7 @@ #include "compute_pressure_bocs.h" #include +#include #include #include #include "atom.h" diff --git a/src/USER-CGSDK/pair_lj_sdk.cpp b/src/USER-CGSDK/pair_lj_sdk.cpp index 6ad77a6183..1301dc4155 100644 --- a/src/USER-CGSDK/pair_lj_sdk.cpp +++ b/src/USER-CGSDK/pair_lj_sdk.cpp @@ -24,7 +24,6 @@ #include "comm.h" #include "force.h" #include "neigh_list.h" -#include "math_const.h" #include "memory.h" #include "error.h" @@ -32,7 +31,6 @@ #include "lj_sdk_common.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace LJSDKParms; /* ---------------------------------------------------------------------- */ diff --git a/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp b/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp index 1095521de3..f168089fae 100644 --- a/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp +++ b/src/USER-CGSDK/pair_lj_sdk_coul_msm.cpp @@ -23,7 +23,6 @@ #include "force.h" #include "kspace.h" #include "neigh_list.h" -#include "memory.h" #include "error.h" #include "lj_sdk_common.h" diff --git a/src/USER-DPD/fix_shardlow.cpp b/src/USER-DPD/fix_shardlow.cpp index f181436f91..b0efeb634d 100644 --- a/src/USER-DPD/fix_shardlow.cpp +++ b/src/USER-DPD/fix_shardlow.cpp @@ -37,15 +37,16 @@ #include #include #include +#include #include "atom.h" #include "force.h" #include "update.h" #include "error.h" -#include "atom_vec.h" #include "comm.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" +#include "npair.h" #include "memory.h" #include "domain.h" #include "modify.h" diff --git a/src/USER-OMP/pair_reaxc_omp.cpp b/src/USER-OMP/pair_reaxc_omp.cpp index 2f17515130..aedd438066 100644 --- a/src/USER-OMP/pair_reaxc_omp.cpp +++ b/src/USER-OMP/pair_reaxc_omp.cpp @@ -34,6 +34,8 @@ ------------------------------------------------------------------------- */ #include "pair_reaxc_omp.h" +#include +#include #include "atom.h" #include "update.h" #include "force.h" @@ -42,32 +44,27 @@ #include "neigh_list.h" #include "neigh_request.h" #include "modify.h" -#include "fix.h" #include "fix_reaxc.h" #include "citeme.h" #include "memory.h" #include "error.h" #include "timer.h" +#include "reaxc_defs.h" #include "reaxc_types.h" #include "reaxc_allocate.h" -#include "reaxc_control.h" -#include "reaxc_ffield.h" #include "reaxc_forces_omp.h" #include "reaxc_init_md_omp.h" #include "reaxc_io_tools.h" #include "reaxc_list.h" -#include "reaxc_lookup.h" #include "reaxc_reset_tools.h" #include "reaxc_tool_box.h" -#include "reaxc_traj.h" -#include "reaxc_vector.h" -#include "fix_reaxc_bonds.h" #if defined(_OPENMP) #include #endif +#include "suffix.h" using namespace LAMMPS_NS; #ifdef OMP_TIMING diff --git a/src/accelerator_kokkos.h b/src/accelerator_kokkos.h index 74bd470572..a3fff2fe16 100644 --- a/src/accelerator_kokkos.h +++ b/src/accelerator_kokkos.h @@ -19,14 +19,14 @@ #ifdef LMP_KOKKOS -#include "kokkos.h" -#include "atom_kokkos.h" -#include "comm_kokkos.h" -#include "comm_tiled_kokkos.h" -#include "domain_kokkos.h" -#include "neighbor_kokkos.h" -#include "memory_kokkos.h" -#include "modify_kokkos.h" +#include "kokkos.h" // IWYU pragma: export +#include "atom_kokkos.h" // IWYU pragma: export +#include "comm_kokkos.h" // IWYU pragma: export +#include "comm_tiled_kokkos.h" // IWYU pragma: export +#include "domain_kokkos.h" // IWYU pragma: export +#include "neighbor_kokkos.h" // IWYU pragma: export +#include "memory_kokkos.h" // IWYU pragma: export +#include "modify_kokkos.h" // IWYU pragma: export #define LAMMPS_INLINE KOKKOS_INLINE_FUNCTION diff --git a/src/finish.cpp b/src/finish.cpp index bef3ae89eb..9ab97ae410 100644 --- a/src/finish.cpp +++ b/src/finish.cpp @@ -16,8 +16,6 @@ #include #include #include -#include "timer.h" -#include "universe.h" #include "accelerator_kokkos.h" #include "atom.h" #include "atom_vec.h" @@ -32,6 +30,8 @@ #include "neigh_request.h" #include "memory.h" #include "error.h" +#include "timer.h" +#include "universe.h" #ifdef LMP_USER_OMP #include "modify.h" -- GitLab From 3d157e5ab4c7f8481ec2170ff3d557f0bd1b37cc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 12 Jul 2019 18:00:59 -0400 Subject: [PATCH 249/469] more include handling cleanup in USER packages --- src/USER-DRUDE/fix_drude_transform.cpp | 1 + src/USER-DRUDE/fix_langevin_drude.cpp | 1 + src/USER-EFF/compute_temp_eff.cpp | 1 + src/USER-LB/fix_lb_fluid.cpp | 5 ++--- src/USER-LB/fix_lb_momentum.cpp | 5 ++--- src/USER-LB/fix_lb_pc.cpp | 5 +---- src/USER-LB/fix_lb_rigid_pc_sphere.cpp | 7 ++----- src/USER-LB/fix_lb_viscous.cpp | 4 +--- src/USER-MGPT/pair_mgpt.h | 2 -- src/USER-MOLFILE/dump_molfile.cpp | 5 ++--- src/USER-MOLFILE/reader_molfile.cpp | 4 +--- src/USER-OMP/fix_qeq_reax_omp.cpp | 1 + src/USER-OMP/pair_reaxc_omp.h | 1 - src/USER-OMP/reaxc_bond_orders_omp.cpp | 3 +++ src/USER-OMP/reaxc_bonds_omp.cpp | 7 +++---- src/USER-OMP/reaxc_forces_omp.cpp | 7 +++---- src/USER-OMP/reaxc_forces_omp.h | 1 - src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp | 4 +++- src/USER-OMP/reaxc_init_md_omp.cpp | 7 ++----- src/USER-OMP/reaxc_torsion_angles_omp.cpp | 5 ++--- src/USER-PTM/ptm_index.cpp | 1 + src/USER-PTM/ptm_initialize_data.cpp | 4 ++++ src/USER-PTM/ptm_initialize_data.h | 4 ---- 23 files changed, 36 insertions(+), 49 deletions(-) diff --git a/src/USER-DRUDE/fix_drude_transform.cpp b/src/USER-DRUDE/fix_drude_transform.cpp index 8e85f1dffd..4128c508d6 100644 --- a/src/USER-DRUDE/fix_drude_transform.cpp +++ b/src/USER-DRUDE/fix_drude_transform.cpp @@ -13,6 +13,7 @@ /** Fix Drude Transform ******************************************************/ #include "fix_drude_transform.h" +#include #include #include #include "fix_drude.h" diff --git a/src/USER-DRUDE/fix_langevin_drude.cpp b/src/USER-DRUDE/fix_langevin_drude.cpp index 1a16c3df96..d413c31bd7 100644 --- a/src/USER-DRUDE/fix_langevin_drude.cpp +++ b/src/USER-DRUDE/fix_langevin_drude.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include "fix_langevin_drude.h" +#include #include #include #include "fix_drude.h" diff --git a/src/USER-EFF/compute_temp_eff.cpp b/src/USER-EFF/compute_temp_eff.cpp index 8e07e390fa..e9295ea680 100644 --- a/src/USER-EFF/compute_temp_eff.cpp +++ b/src/USER-EFF/compute_temp_eff.cpp @@ -17,6 +17,7 @@ #include "compute_temp_eff.h" #include +#include #include "atom.h" #include "update.h" #include "force.h" diff --git a/src/USER-LB/fix_lb_fluid.cpp b/src/USER-LB/fix_lb_fluid.cpp index 31c54aee76..8ad3dbe33e 100644 --- a/src/USER-LB/fix_lb_fluid.cpp +++ b/src/USER-LB/fix_lb_fluid.cpp @@ -20,15 +20,14 @@ #include #include #include -#include #include +#include +#include #include "comm.h" #include "memory.h" #include "error.h" #include "domain.h" #include "atom.h" -#include -#include #include "group.h" #include "random_mars.h" #include "update.h" diff --git a/src/USER-LB/fix_lb_momentum.cpp b/src/USER-LB/fix_lb_momentum.cpp index df17561380..10fffed018 100644 --- a/src/USER-LB/fix_lb_momentum.cpp +++ b/src/USER-LB/fix_lb_momentum.cpp @@ -18,16 +18,15 @@ Contributing author: Naveen Michaud-Agrawal (Johns Hopkins U) ------------------------------------------------------------------------- */ +#include "fix_lb_momentum.h" +#include #include #include -#include "fix_lb_momentum.h" #include "atom.h" -#include "domain.h" #include "group.h" #include "error.h" #include "fix_lb_fluid.h" #include "modify.h" -#include "comm.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/USER-LB/fix_lb_pc.cpp b/src/USER-LB/fix_lb_pc.cpp index ce6ca0c9a1..d61692419a 100644 --- a/src/USER-LB/fix_lb_pc.cpp +++ b/src/USER-LB/fix_lb_pc.cpp @@ -15,17 +15,14 @@ Contributing authors: Frances Mackay, Santtu Ollila, Colin Denniston (UWO) ------------------------------------------------------------------------- */ +#include "fix_lb_pc.h" #include -#include #include -#include "fix_lb_pc.h" #include "atom.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" #include "memory.h" -#include "comm.h" #include "domain.h" #include "fix_lb_fluid.h" #include "modify.h" diff --git a/src/USER-LB/fix_lb_rigid_pc_sphere.cpp b/src/USER-LB/fix_lb_rigid_pc_sphere.cpp index 83dc751631..af1b01043d 100644 --- a/src/USER-LB/fix_lb_rigid_pc_sphere.cpp +++ b/src/USER-LB/fix_lb_rigid_pc_sphere.cpp @@ -16,21 +16,18 @@ Based on fix_rigid (version from 2008). ------------------------------------------------------------------------- */ +#include "fix_lb_rigid_pc_sphere.h" +#include #include -#include #include #include -#include "fix_lb_rigid_pc_sphere.h" #include "atom.h" -#include "atom_vec.h" #include "domain.h" #include "update.h" -#include "respa.h" #include "modify.h" #include "group.h" #include "comm.h" #include "force.h" -#include "output.h" #include "memory.h" #include "error.h" #include "fix_lb_fluid.h" diff --git a/src/USER-LB/fix_lb_viscous.cpp b/src/USER-LB/fix_lb_viscous.cpp index afe23477be..59fddebd67 100644 --- a/src/USER-LB/fix_lb_viscous.cpp +++ b/src/USER-LB/fix_lb_viscous.cpp @@ -15,10 +15,8 @@ Contributing authors: Frances Mackay, Santtu Ollila, Colin Denniston (UWO) ------------------------------------------------------------------------- */ -#include -#include -#include #include "fix_lb_viscous.h" +#include #include "atom.h" #include "update.h" #include "respa.h" diff --git a/src/USER-MGPT/pair_mgpt.h b/src/USER-MGPT/pair_mgpt.h index 3e861a0198..ff71edc9f3 100644 --- a/src/USER-MGPT/pair_mgpt.h +++ b/src/USER-MGPT/pair_mgpt.h @@ -30,8 +30,6 @@ PairStyle(mgpt,PairMGPT) #ifndef LMP_PAIR_MGPT_H #define LMP_PAIR_MGPT_H -#include -#include #include #include diff --git a/src/USER-MOLFILE/dump_molfile.cpp b/src/USER-MOLFILE/dump_molfile.cpp index 732fea74bd..d9d8ec3c97 100644 --- a/src/USER-MOLFILE/dump_molfile.cpp +++ b/src/USER-MOLFILE/dump_molfile.cpp @@ -15,15 +15,14 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include +#include "dump_molfile.h" +#include #include #include -#include "dump_molfile.h" #include "domain.h" #include "atom.h" #include "comm.h" #include "update.h" -#include "output.h" #include "group.h" #include "memory.h" #include "error.h" diff --git a/src/USER-MOLFILE/reader_molfile.cpp b/src/USER-MOLFILE/reader_molfile.cpp index ca1a61850c..5cff56753b 100644 --- a/src/USER-MOLFILE/reader_molfile.cpp +++ b/src/USER-MOLFILE/reader_molfile.cpp @@ -15,11 +15,9 @@ Contributing author: Axel Kohlmeyer (Temple U) ------------------------------------------------------------------------- */ -#include +#include "reader_molfile.h" #include #include -#include "reader_molfile.h" -#include "atom.h" #include "comm.h" #include "memory.h" #include "error.h" diff --git a/src/USER-OMP/fix_qeq_reax_omp.cpp b/src/USER-OMP/fix_qeq_reax_omp.cpp index 55e2b73812..f7945b5579 100644 --- a/src/USER-OMP/fix_qeq_reax_omp.cpp +++ b/src/USER-OMP/fix_qeq_reax_omp.cpp @@ -42,6 +42,7 @@ #include "memory.h" #include "error.h" #include "reaxc_defs.h" +#include "reaxc_types.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/pair_reaxc_omp.h b/src/USER-OMP/pair_reaxc_omp.h index ad8c368aaf..0cae28f56b 100644 --- a/src/USER-OMP/pair_reaxc_omp.h +++ b/src/USER-OMP/pair_reaxc_omp.h @@ -22,7 +22,6 @@ PairStyle(reax/c/omp,PairReaxCOMP) #include "pair_reaxc.h" #include "thr_omp.h" -#include "suffix.h" namespace LAMMPS_NS { diff --git a/src/USER-OMP/reaxc_bond_orders_omp.cpp b/src/USER-OMP/reaxc_bond_orders_omp.cpp index 17715c6e26..d581819e00 100644 --- a/src/USER-OMP/reaxc_bond_orders_omp.cpp +++ b/src/USER-OMP/reaxc_bond_orders_omp.cpp @@ -27,6 +27,9 @@ ----------------------------------------------------------------------*/ #include "reaxc_bond_orders_omp.h" +#include +#include +#include "fix_omp.h" #include "reaxc_defs.h" #include "pair_reaxc_omp.h" #include "reaxc_types.h" diff --git a/src/USER-OMP/reaxc_bonds_omp.cpp b/src/USER-OMP/reaxc_bonds_omp.cpp index 12ba1dcbfe..b6a76b3f3a 100644 --- a/src/USER-OMP/reaxc_bonds_omp.cpp +++ b/src/USER-OMP/reaxc_bonds_omp.cpp @@ -27,13 +27,12 @@ ----------------------------------------------------------------------*/ #include "reaxc_bonds_omp.h" +#include +#include +#include "fix_omp.h" #include "reaxc_defs.h" -#include "reaxc_bond_orders_omp.h" #include "pair_reaxc_omp.h" - #include "reaxc_list.h" -#include "reaxc_tool_box.h" -#include "reaxc_vector.h" #if defined(_OPENMP) #include diff --git a/src/USER-OMP/reaxc_forces_omp.cpp b/src/USER-OMP/reaxc_forces_omp.cpp index 1ada5e7e71..971667cc2d 100644 --- a/src/USER-OMP/reaxc_forces_omp.cpp +++ b/src/USER-OMP/reaxc_forces_omp.cpp @@ -27,19 +27,18 @@ ----------------------------------------------------------------------*/ #include "reaxc_forces_omp.h" +#include +#include +#include "fix_omp.h" #include "reaxc_defs.h" #include "pair_reaxc_omp.h" -#include "thr_data.h" #include "reaxc_bond_orders_omp.h" #include "reaxc_bonds_omp.h" #include "reaxc_hydrogen_bonds_omp.h" -#include "reaxc_io_tools.h" #include "reaxc_list.h" -#include "reaxc_lookup.h" #include "reaxc_multi_body_omp.h" #include "reaxc_nonbonded_omp.h" -#include "reaxc_tool_box.h" #include "reaxc_torsion_angles_omp.h" #include "reaxc_valence_angles_omp.h" #include "reaxc_vector.h" diff --git a/src/USER-OMP/reaxc_forces_omp.h b/src/USER-OMP/reaxc_forces_omp.h index d1e2a5c65a..6df0288656 100644 --- a/src/USER-OMP/reaxc_forces_omp.h +++ b/src/USER-OMP/reaxc_forces_omp.h @@ -30,7 +30,6 @@ #define __FORCES_OMP_H_ #include "reaxc_types.h" -#include "reaxc_defs.h" void Init_Force_FunctionsOMP( control_params* ); void Compute_ForcesOMP( reax_system*, control_params*, simulation_data*, diff --git a/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp b/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp index e3c034a12e..d06966a92d 100644 --- a/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp +++ b/src/USER-OMP/reaxc_hydrogen_bonds_omp.cpp @@ -27,9 +27,11 @@ ----------------------------------------------------------------------*/ #include "reaxc_hydrogen_bonds_omp.h" +#include +#include +#include "fix_omp.h" #include "pair_reaxc_omp.h" #include "reaxc_defs.h" -#include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" #include "reaxc_valence_angles.h" // To access Calculate_Theta() #include "reaxc_valence_angles_omp.h" // To access Calculate_dCos_ThetaOMP() diff --git a/src/USER-OMP/reaxc_init_md_omp.cpp b/src/USER-OMP/reaxc_init_md_omp.cpp index 847e916666..9d40479ddf 100644 --- a/src/USER-OMP/reaxc_init_md_omp.cpp +++ b/src/USER-OMP/reaxc_init_md_omp.cpp @@ -27,18 +27,15 @@ ----------------------------------------------------------------------*/ #include "reaxc_init_md_omp.h" -#include "pair_reaxc_omp.h" +#include #include "reaxc_defs.h" -#include "reaxc_allocate.h" #include "reaxc_forces.h" #include "reaxc_forces_omp.h" #include "reaxc_io_tools.h" #include "reaxc_list.h" #include "reaxc_lookup.h" -#include "reaxc_reset_tools.h" -#include "reaxc_system_props.h" #include "reaxc_tool_box.h" -#include "reaxc_vector.h" +#include "error.h" // Functions defined in reaxc_init_md.cpp extern int Init_MPI_Datatypes(reax_system*, storage*, mpi_datatypes*, MPI_Comm, char*); diff --git a/src/USER-OMP/reaxc_torsion_angles_omp.cpp b/src/USER-OMP/reaxc_torsion_angles_omp.cpp index 9cd716b594..68bacb7202 100644 --- a/src/USER-OMP/reaxc_torsion_angles_omp.cpp +++ b/src/USER-OMP/reaxc_torsion_angles_omp.cpp @@ -27,14 +27,13 @@ ----------------------------------------------------------------------*/ #include "reaxc_torsion_angles_omp.h" +#include +#include "fix_omp.h" #include "pair_reaxc_omp.h" -#include "thr_data.h" #include "reaxc_defs.h" #include "reaxc_types.h" -#include "reaxc_bond_orders_omp.h" #include "reaxc_list.h" -#include "reaxc_tool_box.h" #include "reaxc_vector.h" #if defined(_OPENMP) diff --git a/src/USER-PTM/ptm_index.cpp b/src/USER-PTM/ptm_index.cpp index b50e5c4333..cedd35126d 100644 --- a/src/USER-PTM/ptm_index.cpp +++ b/src/USER-PTM/ptm_index.cpp @@ -22,6 +22,7 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI #include #include #include +#include static double calculate_interatomic_distance(int type, double scale) { assert(type >= 1 && type <= 8); diff --git a/src/USER-PTM/ptm_initialize_data.cpp b/src/USER-PTM/ptm_initialize_data.cpp index 1f0a5c94af..ff8245fe44 100644 --- a/src/USER-PTM/ptm_initialize_data.cpp +++ b/src/USER-PTM/ptm_initialize_data.cpp @@ -8,6 +8,10 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI */ #include "ptm_initialize_data.h" +#include "ptm_canonical_coloured.h" +#include "ptm_convex_hull_incremental.h" +#include "ptm_graph_tools.h" +#include "ptm_neighbour_ordering.h" #include diff --git a/src/USER-PTM/ptm_initialize_data.h b/src/USER-PTM/ptm_initialize_data.h index 20c9921962..4e7f3e8f0a 100644 --- a/src/USER-PTM/ptm_initialize_data.h +++ b/src/USER-PTM/ptm_initialize_data.h @@ -12,12 +12,8 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI #include "ptm_graph_data.h" -#include "ptm_graph_tools.h" #include "ptm_deformation_gradient.h" #include "ptm_fundamental_mappings.h" -#include "ptm_neighbour_ordering.h" -#include "ptm_canonical_coloured.h" -#include "ptm_convex_hull_incremental.h" #include "ptm_alt_templates.h" -- GitLab From 226e68a784ca00aaa69db53ef91a4a847a877216 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 12 Jul 2019 22:42:23 -0400 Subject: [PATCH 250/469] Rename Pair::pairTensor() => Pair::hessian_twobody() --- src/pair.cpp | 2 +- src/pair.h | 2 +- src/pair_lj_smooth_linear.cpp | 2 +- 3 files changed, 3 insertions(+), 3 deletions(-) diff --git a/src/pair.cpp b/src/pair.cpp index 43fc9bc907..ea2ad9509e 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -1746,7 +1746,7 @@ void Pair::init_bitmap(double inner, double outer, int ntablebits, /* ---------------------------------------------------------------------- */ -void Pair::pairTensor(double fforce, double dfac, double delr[3], double phiTensor[6]) { +void Pair::hessian_twobody(double fforce, double dfac, double delr[3], double phiTensor[6]) { int m = 0; for (int k=0; k<3; k++) { phiTensor[m] = fforce; diff --git a/src/pair.h b/src/pair.h index d85b9af0c3..38772d2f5d 100644 --- a/src/pair.h +++ b/src/pair.h @@ -149,7 +149,7 @@ class Pair : protected Pointers { return 0.0; } - void pairTensor(double fforce, double dfac, double delr[3], double phiTensor[6]); + void hessian_twobody(double fforce, double dfac, double delr[3], double phiTensor[6]); virtual double single_hessian(int, int, int, int, double, double[3], double, double, diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 3ebdda4143..8d77436780 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -368,6 +368,6 @@ double PairLJSmoothLinear::single_hessian(int /*i*/, int /*j*/, int itype, int j + (r-cut[itype][jtype])*dljcut[itype][jtype]; double d2r = factor_lj * r6inv * (13.0*lj1[itype][jtype]*r6inv - 7.0*lj2[itype][jtype])/rsq; - pairTensor(fforce, -(fforce + d2r) / rsq, delr, d2u); + hessian_twobody(fforce, -(fforce + d2r) / rsq, delr, d2u); return factor_lj*philj; } -- GitLab From 2a04e41287dd9b86e5fcce026da8bef296933481 Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Fri, 12 Jul 2019 22:43:05 -0400 Subject: [PATCH 251/469] Add pointers between doc pages for compute hma and dynamical matrix --- doc/src/compute_hma.txt | 6 +++++- doc/src/dynamical_matrix.txt | 3 +++ 2 files changed, 8 insertions(+), 1 deletion(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index 35a92664df..863ee86159 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -159,7 +159,7 @@ scalar value will be in energy "units"_units.html. [Restrictions:] -This compute is distributed as the USER-HMA package. It is only +This compute is part of the USER-MISC package. It is only enabled if LAMMPS was built with that package. See the "Build package"_Build_package.html doc page for more info. @@ -169,6 +169,10 @@ Usage restricted to canonical (NVT) ensemble simulation only. "compute pe"_compute_pe.html, "compute pressure"_compute_pressure.html +"dynamical matrix"_dynamical_matrix.html provides a finite difference +formulation of the hessian provided by Pair's single_hessian, which is used by +this compute. + [Default:] none :line diff --git a/doc/src/dynamical_matrix.txt b/doc/src/dynamical_matrix.txt index a7dc4e442e..6291bdec52 100644 --- a/doc/src/dynamical_matrix.txt +++ b/doc/src/dynamical_matrix.txt @@ -47,6 +47,9 @@ package"_Build_package.html doc page for more info. "fix phonon"_fix_phonon.html +"compute hma"_compute_hma.html uses an analytic formulation of the hessian +provided by Pair's single_hessian. + [Default:] The default settings are file = "dynmat.dyn", binary = no -- GitLab From 2b5a6d3b7fe4cd96240c9970aa0ce089c318f8f5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 15 Jul 2019 18:05:20 -0400 Subject: [PATCH 252/469] clean up (some) includes in KOKKOS package --- src/KOKKOS/fix_dpd_energy_kokkos.cpp | 5 ----- src/KOKKOS/fix_eos_table_rx_kokkos.cpp | 3 --- src/KOKKOS/fix_langevin_kokkos.cpp | 7 ++----- src/KOKKOS/fix_qeq_reax_kokkos.cpp | 7 ------- src/KOKKOS/fix_reaxc_bonds_kokkos.cpp | 13 ------------- src/KOKKOS/fix_reaxc_species_kokkos.cpp | 10 ---------- src/KOKKOS/fix_rx_kokkos.cpp | 2 -- src/KOKKOS/fix_setforce_kokkos.cpp | 4 +--- src/KOKKOS/fix_setforce_kokkos.h | 3 +-- src/KOKKOS/fix_shardlow_kokkos.cpp | 10 +--------- src/KOKKOS/improper_class2_kokkos.cpp | 7 ------- src/KOKKOS/improper_harmonic_kokkos.cpp | 6 ------ src/KOKKOS/nbin_ssa_kokkos.cpp | 3 --- src/KOKKOS/npair_copy_kokkos.cpp | 7 ------- src/KOKKOS/npair_skip_kokkos.cpp | 4 ---- src/KOKKOS/pair_buck_coul_cut_kokkos.cpp | 4 ---- src/KOKKOS/pair_buck_coul_long_kokkos.cpp | 6 ------ src/KOKKOS/pair_buck_kokkos.cpp | 6 ------ src/KOKKOS/pair_coul_cut_kokkos.cpp | 9 --------- src/KOKKOS/pair_coul_debye_kokkos.cpp | 6 ------ src/KOKKOS/pair_coul_dsf_kokkos.cpp | 7 ------- src/KOKKOS/pair_coul_long_kokkos.cpp | 6 ------ src/KOKKOS/pair_coul_wolf_kokkos.cpp | 7 ------- src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp | 6 ------ src/KOKKOS/pair_eam_alloy_kokkos.cpp | 2 -- src/KOKKOS/pair_eam_fs_kokkos.cpp | 2 -- src/KOKKOS/pair_eam_kokkos.cpp | 3 --- src/KOKKOS/pair_exp6_rx_kokkos.cpp | 4 ---- src/KOKKOS/pair_hybrid_kokkos.cpp | 5 ----- src/KOKKOS/pair_hybrid_overlay_kokkos.cpp | 3 --- .../pair_lj_charmm_coul_charmm_implicit_kokkos.cpp | 7 ------- src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp | 5 ----- src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_class2_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp | 4 ---- src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp | 4 ---- src/KOKKOS/pair_lj_cut_kokkos.cpp | 7 ------- src/KOKKOS/pair_lj_expand_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_gromacs_kokkos.cpp | 6 ------ src/KOKKOS/pair_lj_sdk_kokkos.cpp | 5 ----- src/KOKKOS/pair_morse_kokkos.cpp | 4 ---- src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp | 5 ----- src/KOKKOS/pair_reaxc_kokkos.cpp | 5 ----- src/KOKKOS/pair_sw_kokkos.cpp | 4 ---- src/KOKKOS/pair_table_kokkos.cpp | 4 ---- src/KOKKOS/pair_table_rx_kokkos.cpp | 1 - src/KOKKOS/pair_tersoff_kokkos.cpp | 6 ------ src/KOKKOS/pair_tersoff_mod_kokkos.cpp | 6 ------ src/KOKKOS/pair_tersoff_zbl_kokkos.cpp | 4 ---- src/KOKKOS/pair_vashishta_kokkos.cpp | 4 ---- src/KOKKOS/pair_yukawa_kokkos.cpp | 5 ----- src/KOKKOS/pair_zbl_kokkos.cpp | 6 ------ src/KOKKOS/pppm_kokkos.cpp | 5 ----- src/KOKKOS/region_block_kokkos.cpp | 4 ---- src/KOKKOS/verlet_kokkos.cpp | 7 ------- 60 files changed, 5 insertions(+), 318 deletions(-) diff --git a/src/KOKKOS/fix_dpd_energy_kokkos.cpp b/src/KOKKOS/fix_dpd_energy_kokkos.cpp index debad0407a..20579a6dc5 100644 --- a/src/KOKKOS/fix_dpd_energy_kokkos.cpp +++ b/src/KOKKOS/fix_dpd_energy_kokkos.cpp @@ -12,14 +12,9 @@ ------------------------------------------------------------------------- */ #include "fix_dpd_energy_kokkos.h" -#include -#include #include "atom_masks.h" #include "atom_kokkos.h" -#include "force.h" #include "update.h" -#include "respa.h" -#include "modify.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/KOKKOS/fix_eos_table_rx_kokkos.cpp b/src/KOKKOS/fix_eos_table_rx_kokkos.cpp index d0280eeef0..89561c9a92 100644 --- a/src/KOKKOS/fix_eos_table_rx_kokkos.cpp +++ b/src/KOKKOS/fix_eos_table_rx_kokkos.cpp @@ -16,15 +16,12 @@ ------------------------------------------------------------------------- */ #include "fix_eos_table_rx_kokkos.h" -#include -#include #include "atom_kokkos.h" #include "error.h" #include "force.h" #include "memory_kokkos.h" #include "comm.h" #include -#include "modify.h" #include "atom_masks.h" #define MAXLINE 1024 diff --git a/src/KOKKOS/fix_langevin_kokkos.cpp b/src/KOKKOS/fix_langevin_kokkos.cpp index 23a43b38ef..651f790a25 100644 --- a/src/KOKKOS/fix_langevin_kokkos.cpp +++ b/src/KOKKOS/fix_langevin_kokkos.cpp @@ -13,21 +13,18 @@ #include "fix_langevin_kokkos.h" #include -#include -#include #include "atom_masks.h" #include "atom_kokkos.h" #include "force.h" +#include "group.h" #include "update.h" -#include "respa.h" #include "error.h" #include "memory_kokkos.h" -#include "group.h" -#include "random_mars.h" #include "compute.h" #include "comm.h" #include "modify.h" #include "input.h" +#include "region.h" #include "variable.h" using namespace LAMMPS_NS; diff --git a/src/KOKKOS/fix_qeq_reax_kokkos.cpp b/src/KOKKOS/fix_qeq_reax_kokkos.cpp index 6f8392ab16..e51fbacaaf 100644 --- a/src/KOKKOS/fix_qeq_reax_kokkos.cpp +++ b/src/KOKKOS/fix_qeq_reax_kokkos.cpp @@ -18,24 +18,17 @@ #include "fix_qeq_reax_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "atom.h" #include "atom_masks.h" #include "atom_kokkos.h" #include "comm.h" #include "force.h" -#include "group.h" -#include "modify.h" #include "neighbor.h" #include "neigh_list_kokkos.h" #include "neigh_request.h" #include "update.h" #include "integrate.h" -#include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "pair_reaxc_kokkos.h" diff --git a/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp b/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp index 347c477476..51702bc603 100644 --- a/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp +++ b/src/KOKKOS/fix_reaxc_bonds_kokkos.cpp @@ -15,26 +15,13 @@ Contributing author: Stan Moore (Sandia) ------------------------------------------------------------------------- */ -#include "fix_ave_atom.h" -#include -#include #include "fix_reaxc_bonds_kokkos.h" #include "atom.h" -#include "update.h" #include "pair_reaxc_kokkos.h" -#include "modify.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" -#include "comm.h" #include "force.h" #include "compute.h" -#include "input.h" -#include "variable.h" #include "memory_kokkos.h" #include "error.h" -#include "reaxc_list.h" -#include "reaxc_types.h" #include "reaxc_defs.h" #include "atom_masks.h" diff --git a/src/KOKKOS/fix_reaxc_species_kokkos.cpp b/src/KOKKOS/fix_reaxc_species_kokkos.cpp index f32bea2c67..f3bce2f9c0 100644 --- a/src/KOKKOS/fix_reaxc_species_kokkos.cpp +++ b/src/KOKKOS/fix_reaxc_species_kokkos.cpp @@ -16,27 +16,17 @@ ------------------------------------------------------------------------- */ #include "fix_reaxc_species_kokkos.h" -#include -#include #include "atom.h" -#include #include "fix_ave_atom.h" -#include "domain.h" -#include "update.h" #include "reaxc_defs.h" #include "pair_reaxc_kokkos.h" -#include "modify.h" -#include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "comm.h" #include "force.h" -#include "compute.h" #include "input.h" -#include "variable.h" #include "memory_kokkos.h" #include "error.h" -#include "reaxc_list.h" #include "atom_masks.h" using namespace LAMMPS_NS; diff --git a/src/KOKKOS/fix_rx_kokkos.cpp b/src/KOKKOS/fix_rx_kokkos.cpp index 050dda2400..e06fc14585 100644 --- a/src/KOKKOS/fix_rx_kokkos.cpp +++ b/src/KOKKOS/fix_rx_kokkos.cpp @@ -12,14 +12,12 @@ ------------------------------------------------------------------------- */ #include "fix_rx_kokkos.h" -#include #include #include "atom_masks.h" #include "atom_kokkos.h" #include "force.h" #include "memory_kokkos.h" #include "update.h" -#include "respa.h" #include "modify.h" #include "neighbor.h" #include "neigh_list_kokkos.h" diff --git a/src/KOKKOS/fix_setforce_kokkos.cpp b/src/KOKKOS/fix_setforce_kokkos.cpp index 03cfd3afb2..4165b100f5 100644 --- a/src/KOKKOS/fix_setforce_kokkos.cpp +++ b/src/KOKKOS/fix_setforce_kokkos.cpp @@ -13,20 +13,18 @@ #include "fix_setforce_kokkos.h" #include -#include #include "atom_kokkos.h" #include "update.h" #include "modify.h" #include "domain.h" #include "region.h" -#include "respa.h" #include "input.h" #include "variable.h" #include "memory_kokkos.h" #include "error.h" -#include "force.h" #include "atom_masks.h" #include "kokkos_base.h" +#include "region.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/KOKKOS/fix_setforce_kokkos.h b/src/KOKKOS/fix_setforce_kokkos.h index 3cbf3d3720..ecbfd71e36 100644 --- a/src/KOKKOS/fix_setforce_kokkos.h +++ b/src/KOKKOS/fix_setforce_kokkos.h @@ -23,7 +23,6 @@ FixStyle(setforce/kk/host,FixSetForceKokkos) #define LMP_FIX_SET_FORCE_KOKKOS_H #include "fix_setforce.h" -#include "region.h" #include "kokkos_type.h" namespace LAMMPS_NS { @@ -82,7 +81,7 @@ class FixSetForceKokkos : public FixSetForce { typename AT::t_f_array f; typename AT::t_int_1d_randomread mask; - Region* region; + class Region* region; }; } diff --git a/src/KOKKOS/fix_shardlow_kokkos.cpp b/src/KOKKOS/fix_shardlow_kokkos.cpp index 96f67ccb5e..9bd8594341 100644 --- a/src/KOKKOS/fix_shardlow_kokkos.cpp +++ b/src/KOKKOS/fix_shardlow_kokkos.cpp @@ -34,30 +34,22 @@ ------------------------------------------------------------------------- */ #include "fix_shardlow_kokkos.h" -#include +#include #include -#include #include "atom.h" #include "atom_masks.h" #include "atom_kokkos.h" #include "force.h" #include "update.h" -#include "respa.h" #include "error.h" -#include -#include "atom_vec.h" #include "comm.h" #include "neighbor.h" #include "neigh_list_kokkos.h" #include "neigh_request.h" #include "memory_kokkos.h" #include "domain.h" -#include "modify.h" -// #include "pair_dpd_fdt.h" #include "pair_dpd_fdt_energy_kokkos.h" -#include "pair.h" #include "npair_ssa_kokkos.h" -#include "citeme.h" using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/KOKKOS/improper_class2_kokkos.cpp b/src/KOKKOS/improper_class2_kokkos.cpp index 84b721bd2a..defd5e16f5 100644 --- a/src/KOKKOS/improper_class2_kokkos.cpp +++ b/src/KOKKOS/improper_class2_kokkos.cpp @@ -16,22 +16,15 @@ ------------------------------------------------------------------------- */ #include "improper_class2_kokkos.h" -#include #include -#include #include "atom_kokkos.h" -#include "comm.h" #include "neighbor_kokkos.h" -#include "domain.h" #include "force.h" -#include "update.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define TOLERANCE 0.05 #define SMALL 0.001 diff --git a/src/KOKKOS/improper_harmonic_kokkos.cpp b/src/KOKKOS/improper_harmonic_kokkos.cpp index 262ffe7700..7d6437dbf5 100644 --- a/src/KOKKOS/improper_harmonic_kokkos.cpp +++ b/src/KOKKOS/improper_harmonic_kokkos.cpp @@ -16,22 +16,16 @@ ------------------------------------------------------------------------- */ #include "improper_harmonic_kokkos.h" -#include #include -#include #include "atom_kokkos.h" #include "comm.h" #include "neighbor_kokkos.h" -#include "domain.h" #include "force.h" -#include "update.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define TOLERANCE 0.05 #define SMALL 0.001 diff --git a/src/KOKKOS/nbin_ssa_kokkos.cpp b/src/KOKKOS/nbin_ssa_kokkos.cpp index ecf0e08535..0e46f7fc61 100644 --- a/src/KOKKOS/nbin_ssa_kokkos.cpp +++ b/src/KOKKOS/nbin_ssa_kokkos.cpp @@ -19,11 +19,8 @@ #include "nbin_ssa_kokkos.h" #include "neighbor.h" #include "atom_kokkos.h" -#include "group.h" #include "domain.h" -#include "comm.h" #include "update.h" -#include "error.h" #include "atom_masks.h" // #include "memory_kokkos.h" diff --git a/src/KOKKOS/npair_copy_kokkos.cpp b/src/KOKKOS/npair_copy_kokkos.cpp index 7dde05745c..0ce0f4d3ff 100644 --- a/src/KOKKOS/npair_copy_kokkos.cpp +++ b/src/KOKKOS/npair_copy_kokkos.cpp @@ -12,14 +12,7 @@ ------------------------------------------------------------------------- */ #include "npair_copy_kokkos.h" -#include "neighbor.h" #include "neigh_list_kokkos.h" -#include "atom.h" -#include "atom_vec.h" -#include "molecule.h" -#include "domain.h" -#include "my_page.h" -#include "error.h" using namespace LAMMPS_NS; diff --git a/src/KOKKOS/npair_skip_kokkos.cpp b/src/KOKKOS/npair_skip_kokkos.cpp index e614e624c9..bb393c9b95 100644 --- a/src/KOKKOS/npair_skip_kokkos.cpp +++ b/src/KOKKOS/npair_skip_kokkos.cpp @@ -12,13 +12,9 @@ ------------------------------------------------------------------------- */ #include "npair_skip_kokkos.h" -#include "neighbor.h" #include "neigh_list_kokkos.h" #include "atom_kokkos.h" #include "atom_vec.h" -#include "molecule.h" -#include "domain.h" -#include "my_page.h" #include "error.h" #include "atom_masks.h" diff --git a/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp b/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp index e3843262a5..2a72617525 100644 --- a/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_buck_coul_cut_kokkos.cpp @@ -17,18 +17,14 @@ #include "pair_buck_coul_cut_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/pair_buck_coul_long_kokkos.cpp b/src/KOKKOS/pair_buck_coul_long_kokkos.cpp index 7457a0988f..fdf395684a 100644 --- a/src/KOKKOS/pair_buck_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_buck_coul_long_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_buck_coul_long_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_buck_kokkos.cpp b/src/KOKKOS/pair_buck_kokkos.cpp index 131622cac5..375d0dc1ea 100644 --- a/src/KOKKOS/pair_buck_kokkos.cpp +++ b/src/KOKKOS/pair_buck_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_buck_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_coul_cut_kokkos.cpp b/src/KOKKOS/pair_coul_cut_kokkos.cpp index e79f103363..5a1a6eefac 100644 --- a/src/KOKKOS/pair_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_coul_cut_kokkos.cpp @@ -13,26 +13,17 @@ #include "pair_coul_cut_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_coul_debye_kokkos.cpp b/src/KOKKOS/pair_coul_debye_kokkos.cpp index 0fe03af043..8dd7e4f3d2 100644 --- a/src/KOKKOS/pair_coul_debye_kokkos.cpp +++ b/src/KOKKOS/pair_coul_debye_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_coul_debye_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_coul_dsf_kokkos.cpp b/src/KOKKOS/pair_coul_dsf_kokkos.cpp index e94aae4754..836b12ba39 100644 --- a/src/KOKKOS/pair_coul_dsf_kokkos.cpp +++ b/src/KOKKOS/pair_coul_dsf_kokkos.cpp @@ -17,20 +17,13 @@ #include "pair_coul_dsf_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list_kokkos.h" #include "neigh_request.h" #include "memory_kokkos.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "math_const.h" #include "error.h" #include "atom_masks.h" diff --git a/src/KOKKOS/pair_coul_long_kokkos.cpp b/src/KOKKOS/pair_coul_long_kokkos.cpp index 67132e11f6..84b89c6373 100644 --- a/src/KOKKOS/pair_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_coul_long_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_coul_long_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_coul_wolf_kokkos.cpp b/src/KOKKOS/pair_coul_wolf_kokkos.cpp index dbbb865961..3ca8f16a79 100644 --- a/src/KOKKOS/pair_coul_wolf_kokkos.cpp +++ b/src/KOKKOS/pair_coul_wolf_kokkos.cpp @@ -17,19 +17,12 @@ #include "pair_coul_wolf_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list_kokkos.h" #include "neigh_request.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "math_const.h" #include "memory_kokkos.h" #include "error.h" diff --git a/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp b/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp index 27a7a59c2a..21fd32a2c8 100644 --- a/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp +++ b/src/KOKKOS/pair_dpd_fdt_energy_kokkos.cpp @@ -17,20 +17,14 @@ #include "pair_dpd_fdt_energy_kokkos.h" #include -#include -#include -#include #include "atom_kokkos.h" -#include "atom_vec.h" #include "comm.h" #include "update.h" -#include "fix.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "memory_kokkos.h" -#include "modify.h" #include "error.h" #include "atom_masks.h" #include "kokkos.h" diff --git a/src/KOKKOS/pair_eam_alloy_kokkos.cpp b/src/KOKKOS/pair_eam_alloy_kokkos.cpp index aa33d44eee..48bf63386a 100644 --- a/src/KOKKOS/pair_eam_alloy_kokkos.cpp +++ b/src/KOKKOS/pair_eam_alloy_kokkos.cpp @@ -17,8 +17,6 @@ #include "pair_eam_alloy_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "pair_kokkos.h" diff --git a/src/KOKKOS/pair_eam_fs_kokkos.cpp b/src/KOKKOS/pair_eam_fs_kokkos.cpp index 9832a16a73..6536dd745a 100644 --- a/src/KOKKOS/pair_eam_fs_kokkos.cpp +++ b/src/KOKKOS/pair_eam_fs_kokkos.cpp @@ -17,8 +17,6 @@ #include "pair_eam_fs_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "pair_kokkos.h" diff --git a/src/KOKKOS/pair_eam_kokkos.cpp b/src/KOKKOS/pair_eam_kokkos.cpp index 4c6fadfe92..f6eef5b53c 100644 --- a/src/KOKKOS/pair_eam_kokkos.cpp +++ b/src/KOKKOS/pair_eam_kokkos.cpp @@ -17,9 +17,6 @@ #include "pair_eam_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "pair_kokkos.h" #include "atom_kokkos.h" diff --git a/src/KOKKOS/pair_exp6_rx_kokkos.cpp b/src/KOKKOS/pair_exp6_rx_kokkos.cpp index 31a48fe154..8698687377 100644 --- a/src/KOKKOS/pair_exp6_rx_kokkos.cpp +++ b/src/KOKKOS/pair_exp6_rx_kokkos.cpp @@ -17,18 +17,15 @@ #include "pair_exp6_rx_kokkos.h" #include -#include #include #include #include "atom.h" #include "comm.h" #include "force.h" #include "neigh_list.h" -#include "math_const.h" #include "math_special_kokkos.h" #include "memory_kokkos.h" #include "error.h" -#include "modify.h" #include "fix.h" #include #include "atom_masks.h" @@ -41,7 +38,6 @@ #endif using namespace LAMMPS_NS; -using namespace MathConst; using namespace MathSpecialKokkos; #define MAXLINE 1024 diff --git a/src/KOKKOS/pair_hybrid_kokkos.cpp b/src/KOKKOS/pair_hybrid_kokkos.cpp index c767d9f470..b5b0a9d02b 100644 --- a/src/KOKKOS/pair_hybrid_kokkos.cpp +++ b/src/KOKKOS/pair_hybrid_kokkos.cpp @@ -12,19 +12,14 @@ ------------------------------------------------------------------------- */ #include "pair_hybrid_kokkos.h" -#include -#include #include -#include #include "atom_kokkos.h" #include "force.h" #include "pair.h" #include "neighbor.h" #include "neigh_request.h" #include "update.h" -#include "comm.h" #include "memory_kokkos.h" -#include "error.h" #include "respa.h" #include "atom_masks.h" #include "kokkos.h" diff --git a/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp b/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp index cb1389d38e..0cebd79c88 100644 --- a/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp +++ b/src/KOKKOS/pair_hybrid_overlay_kokkos.cpp @@ -12,13 +12,10 @@ ------------------------------------------------------------------------- */ #include "pair_hybrid_overlay_kokkos.h" -#include #include #include #include "atom.h" #include "force.h" -#include "neighbor.h" -#include "neigh_request.h" #include "error.h" using namespace LAMMPS_NS; diff --git a/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp b/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp index b7c3766d5f..ae6cb61b60 100644 --- a/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp +++ b/src/KOKKOS/pair_lj_charmm_coul_charmm_implicit_kokkos.cpp @@ -16,27 +16,20 @@ ------------------------------------------------------------------------- */ #include "pair_lj_charmm_coul_charmm_implicit_kokkos.h" -#include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp b/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp index c6a1e3211d..9cdef267e2 100644 --- a/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp +++ b/src/KOKKOS/pair_lj_charmm_coul_charmm_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_lj_charmm_coul_charmm_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp b/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp index 4ba0651601..441070248d 100644 --- a/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_lj_charmm_coul_long_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_lj_charmm_coul_long_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp b/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp index ef8fe7a128..1f7642e965 100644 --- a/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_lj_class2_coul_cut_kokkos.cpp @@ -13,8 +13,6 @@ #include "pair_lj_class2_coul_cut_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" @@ -24,15 +22,12 @@ #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp b/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp index 5a25d0250b..c88ff9378e 100644 --- a/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_lj_class2_coul_long_kokkos.cpp @@ -13,26 +13,20 @@ #include "pair_lj_class2_coul_long_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_class2_kokkos.cpp b/src/KOKKOS/pair_lj_class2_kokkos.cpp index 6d673b2d01..9900e7361f 100644 --- a/src/KOKKOS/pair_lj_class2_kokkos.cpp +++ b/src/KOKKOS/pair_lj_class2_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_lj_class2_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp index 9201a116b5..1601e4a4b2 100644 --- a/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_cut_kokkos.cpp @@ -13,26 +13,20 @@ #include "pair_lj_cut_coul_cut_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp index 8935333c74..6e7d1eeb8b 100644 --- a/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_debye_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_lj_cut_coul_debye_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp index aea70faec4..b7dc7cc26d 100644 --- a/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_dsf_kokkos.cpp @@ -17,18 +17,14 @@ #include "pair_lj_cut_coul_dsf_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp b/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp index 53d27f2447..122d59af82 100644 --- a/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_coul_long_kokkos.cpp @@ -13,18 +13,14 @@ #include "pair_lj_cut_coul_long_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/pair_lj_cut_kokkos.cpp b/src/KOKKOS/pair_lj_cut_kokkos.cpp index ee29e12322..df750b7524 100644 --- a/src/KOKKOS/pair_lj_cut_kokkos.cpp +++ b/src/KOKKOS/pair_lj_cut_kokkos.cpp @@ -12,27 +12,20 @@ ------------------------------------------------------------------------- */ #include "pair_lj_cut_kokkos.h" -#include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_expand_kokkos.cpp b/src/KOKKOS/pair_lj_expand_kokkos.cpp index 061fc205fb..38bebc364f 100644 --- a/src/KOKKOS/pair_lj_expand_kokkos.cpp +++ b/src/KOKKOS/pair_lj_expand_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_lj_expand_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp b/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp index 4df9fdea9e..a46a5c0441 100644 --- a/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp +++ b/src/KOKKOS/pair_lj_gromacs_coul_gromacs_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_lj_gromacs_coul_gromacs_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_gromacs_kokkos.cpp b/src/KOKKOS/pair_lj_gromacs_kokkos.cpp index 2d395c39d5..23ed5e5595 100644 --- a/src/KOKKOS/pair_lj_gromacs_kokkos.cpp +++ b/src/KOKKOS/pair_lj_gromacs_kokkos.cpp @@ -17,26 +17,20 @@ #include "pair_lj_gromacs_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_lj_sdk_kokkos.cpp b/src/KOKKOS/pair_lj_sdk_kokkos.cpp index 14c53c38bf..25f081d255 100644 --- a/src/KOKKOS/pair_lj_sdk_kokkos.cpp +++ b/src/KOKKOS/pair_lj_sdk_kokkos.cpp @@ -14,19 +14,15 @@ #include "pair_lj_sdk_kokkos.h" #include #include -#include #include #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" #include "force.h" #include "neighbor.h" -#include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" @@ -34,7 +30,6 @@ #include "lj_sdk_common.h" using namespace LAMMPS_NS; -using namespace MathConst; using namespace LJSDKParms; #define KOKKOS_CUDA_MAX_THREADS 256 diff --git a/src/KOKKOS/pair_morse_kokkos.cpp b/src/KOKKOS/pair_morse_kokkos.cpp index d679477321..d3e3042a34 100644 --- a/src/KOKKOS/pair_morse_kokkos.cpp +++ b/src/KOKKOS/pair_morse_kokkos.cpp @@ -17,18 +17,14 @@ #include "pair_morse_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" #include "math_const.h" #include "memory_kokkos.h" diff --git a/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp b/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp index 81a4aa7a82..75247859ed 100644 --- a/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp +++ b/src/KOKKOS/pair_multi_lucy_rx_kokkos.cpp @@ -22,9 +22,7 @@ ------------------------------------------------------------------------------------------- */ #include "pair_multi_lucy_rx_kokkos.h" -#include #include -#include #include #include "math_const.h" #include "atom_kokkos.h" @@ -33,9 +31,6 @@ #include "neigh_list.h" #include "memory_kokkos.h" #include "error.h" -#include "citeme.h" -#include "modify.h" -#include "fix.h" #include "atom_masks.h" #include "neigh_request.h" #include "kokkos.h" diff --git a/src/KOKKOS/pair_reaxc_kokkos.cpp b/src/KOKKOS/pair_reaxc_kokkos.cpp index ca897a377c..d0ad1f1b09 100644 --- a/src/KOKKOS/pair_reaxc_kokkos.cpp +++ b/src/KOKKOS/pair_reaxc_kokkos.cpp @@ -17,7 +17,6 @@ #include "pair_reaxc_kokkos.h" #include -#include #include #include #include "kokkos.h" @@ -27,9 +26,6 @@ #include "neighbor.h" #include "neigh_request.h" #include "neigh_list_kokkos.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "math_const.h" #include "math_special.h" #include "memory_kokkos.h" @@ -38,7 +34,6 @@ #include "reaxc_defs.h" #include "reaxc_lookup.h" #include "reaxc_tool_box.h" -#include "modify.h" #define TEAMSIZE 128 diff --git a/src/KOKKOS/pair_sw_kokkos.cpp b/src/KOKKOS/pair_sw_kokkos.cpp index dbd45747f0..e85afa362f 100644 --- a/src/KOKKOS/pair_sw_kokkos.cpp +++ b/src/KOKKOS/pair_sw_kokkos.cpp @@ -17,9 +17,6 @@ #include "pair_sw_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "pair_kokkos.h" #include "atom_kokkos.h" @@ -30,7 +27,6 @@ #include "memory_kokkos.h" #include "neighbor.h" #include "neigh_list_kokkos.h" -#include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" #include "math_const.h" diff --git a/src/KOKKOS/pair_table_kokkos.cpp b/src/KOKKOS/pair_table_kokkos.cpp index 01966d708a..5ee24ad479 100644 --- a/src/KOKKOS/pair_table_kokkos.cpp +++ b/src/KOKKOS/pair_table_kokkos.cpp @@ -16,14 +16,10 @@ ------------------------------------------------------------------------- */ #include "pair_table_kokkos.h" -#include -#include -#include #include #include "kokkos.h" #include "atom.h" #include "force.h" -#include "comm.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" diff --git a/src/KOKKOS/pair_table_rx_kokkos.cpp b/src/KOKKOS/pair_table_rx_kokkos.cpp index 7c2d20c68d..daebeda8db 100644 --- a/src/KOKKOS/pair_table_rx_kokkos.cpp +++ b/src/KOKKOS/pair_table_rx_kokkos.cpp @@ -18,7 +18,6 @@ #include "pair_table_rx_kokkos.h" #include #include -#include #include #include "kokkos.h" #include "atom.h" diff --git a/src/KOKKOS/pair_tersoff_kokkos.cpp b/src/KOKKOS/pair_tersoff_kokkos.cpp index b68af84425..b360b20ef3 100644 --- a/src/KOKKOS/pair_tersoff_kokkos.cpp +++ b/src/KOKKOS/pair_tersoff_kokkos.cpp @@ -17,9 +17,6 @@ #include "pair_tersoff_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" @@ -27,9 +24,6 @@ #include "neighbor.h" #include "neigh_request.h" #include "neigh_list_kokkos.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "math_const.h" #include "memory_kokkos.h" #include "error.h" diff --git a/src/KOKKOS/pair_tersoff_mod_kokkos.cpp b/src/KOKKOS/pair_tersoff_mod_kokkos.cpp index b6921179c0..81ef486999 100644 --- a/src/KOKKOS/pair_tersoff_mod_kokkos.cpp +++ b/src/KOKKOS/pair_tersoff_mod_kokkos.cpp @@ -17,9 +17,6 @@ #include "pair_tersoff_mod_kokkos.h" #include -#include -#include -#include #include "kokkos.h" #include "atom_kokkos.h" #include "comm.h" @@ -27,9 +24,6 @@ #include "neighbor.h" #include "neigh_request.h" #include "neigh_list_kokkos.h" -#include "update.h" -#include "integrate.h" -#include "respa.h" #include "math_const.h" #include "memory_kokkos.h" #include "error.h" diff --git a/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp b/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp index 60ff0a7269..4593f32e36 100644 --- a/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp +++ b/src/KOKKOS/pair_tersoff_zbl_kokkos.cpp @@ -17,8 +17,6 @@ #include "pair_tersoff_zbl_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "atom_kokkos.h" @@ -28,8 +26,6 @@ #include "neigh_request.h" #include "neigh_list_kokkos.h" #include "update.h" -#include "integrate.h" -#include "respa.h" #include "math_const.h" #include "memory_kokkos.h" #include "error.h" diff --git a/src/KOKKOS/pair_vashishta_kokkos.cpp b/src/KOKKOS/pair_vashishta_kokkos.cpp index febb171c83..614d3334d5 100644 --- a/src/KOKKOS/pair_vashishta_kokkos.cpp +++ b/src/KOKKOS/pair_vashishta_kokkos.cpp @@ -17,8 +17,6 @@ #include "pair_vashishta_kokkos.h" #include -#include -#include #include #include "kokkos.h" #include "pair_kokkos.h" @@ -28,9 +26,7 @@ #include "force.h" #include "comm.h" #include "memory_kokkos.h" -#include "neighbor.h" #include "neigh_list_kokkos.h" -#include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" #include "math_const.h" diff --git a/src/KOKKOS/pair_yukawa_kokkos.cpp b/src/KOKKOS/pair_yukawa_kokkos.cpp index acfeb2fbdc..6dfffd4a54 100644 --- a/src/KOKKOS/pair_yukawa_kokkos.cpp +++ b/src/KOKKOS/pair_yukawa_kokkos.cpp @@ -17,24 +17,19 @@ #include "pair_yukawa_kokkos.h" #include -#include #include "kokkos.h" #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" using namespace LAMMPS_NS; -using namespace MathConst; #define KOKKOS_CUDA_MAX_THREADS 256 #define KOKKOS_CUDA_MIN_BLOCKS 8 diff --git a/src/KOKKOS/pair_zbl_kokkos.cpp b/src/KOKKOS/pair_zbl_kokkos.cpp index 0f21331266..5697dd5b00 100644 --- a/src/KOKKOS/pair_zbl_kokkos.cpp +++ b/src/KOKKOS/pair_zbl_kokkos.cpp @@ -17,19 +17,14 @@ #include "pair_zbl_kokkos.h" #include -#include -#include #include #include "atom_kokkos.h" -#include "comm.h" #include "force.h" #include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" #include "update.h" -#include "integrate.h" #include "respa.h" -#include "math_const.h" #include "memory_kokkos.h" #include "error.h" #include "atom_masks.h" @@ -39,7 +34,6 @@ // "The Stopping and Range of Ions in Matter" volume 1, Pergamon, 1985. using namespace LAMMPS_NS; -using namespace MathConst; using namespace PairZBLConstants; /* ---------------------------------------------------------------------- */ diff --git a/src/KOKKOS/pppm_kokkos.cpp b/src/KOKKOS/pppm_kokkos.cpp index 1842524e23..3e70602f67 100644 --- a/src/KOKKOS/pppm_kokkos.cpp +++ b/src/KOKKOS/pppm_kokkos.cpp @@ -17,9 +17,6 @@ #include "pppm_kokkos.h" #include -#include -#include -#include #include #include "atom_kokkos.h" #include "comm.h" @@ -27,8 +24,6 @@ #include "neighbor.h" #include "force.h" #include "pair.h" -#include "bond.h" -#include "angle.h" #include "domain.h" #include "fft3d_wrap.h" #include "remap_wrap.h" diff --git a/src/KOKKOS/region_block_kokkos.cpp b/src/KOKKOS/region_block_kokkos.cpp index a5734f6ba7..b28230290e 100644 --- a/src/KOKKOS/region_block_kokkos.cpp +++ b/src/KOKKOS/region_block_kokkos.cpp @@ -12,10 +12,6 @@ ------------------------------------------------------------------------- */ #include "region_block_kokkos.h" -#include -#include -#include "domain.h" -#include "force.h" #include "atom_kokkos.h" #include "atom_masks.h" diff --git a/src/KOKKOS/verlet_kokkos.cpp b/src/KOKKOS/verlet_kokkos.cpp index d555b74d23..2d2f0a9815 100644 --- a/src/KOKKOS/verlet_kokkos.cpp +++ b/src/KOKKOS/verlet_kokkos.cpp @@ -12,11 +12,9 @@ ------------------------------------------------------------------------- */ #include "verlet_kokkos.h" -#include #include "neighbor.h" #include "domain.h" #include "comm.h" -#include "atom.h" #include "atom_kokkos.h" #include "atom_masks.h" #include "force.h" @@ -29,15 +27,10 @@ #include "output.h" #include "update.h" #include "modify.h" -#include "compute.h" -#include "fix.h" #include "timer.h" #include "memory_kokkos.h" -#include "error.h" #include "kokkos.h" -#include - using namespace LAMMPS_NS; template -- GitLab From 658cda9b670da84e66a695d4f98364ac5202c4f4 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Tue, 16 Jul 2019 15:02:24 -0500 Subject: [PATCH 253/469] Updated kim_query documentation to new format --- doc/src/kim_commands.txt | 71 +++++++++++++++++++++++++++------------- 1 file changed, 48 insertions(+), 23 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index a6551734f1..46e437a871 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -35,8 +35,7 @@ kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657 kim_interactions C H O kim_init Sim_LAMMPS_IFF_OtherInfo_AuthorList_Year_Species__SM_064312669787_000 real kim_interactions fixed_types -kim_query a0 get_lattice_constant_fcc species=\["Al"\] units=\["angstrom"\] :pre - +kim_query a0 get_lattice_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\["angstrom"\] :pre [Description:] @@ -104,16 +103,12 @@ The URL for the Model Page is constructed from the "extended KIM ID"_https://openkim.org/about-kim-ids/ of the IM: https://openkim.org/id/extended_KIM_ID -or -https://openkim.org/id/short_KIM_ID :pre For example for the Stillinger-Weber potential listed above the Model Page is located at: "https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005"_https://openkim.org/id/SW_StillingerWeber_1985_Si__MO_405512056662_005 -or -"https://openkim.org/id/MO_405512056662_005"_https://openkim.org/id/MO_405512056662_005 :pre See the "current list of KIM PMs and SMs archived in OpenKIM"_https://openkim.org/browse/models/by-species. @@ -354,16 +349,34 @@ of the IM set by {kim_init} for material properties archived in "OpenKIM"_https://openkim.org. The {kim_query} command must be preceded by a {kim_init} command. The result of the query is stored in a "string style variable"_variable.html, the name of which is given as the first -argument of the {kim_query command}. The second required argument -{query_function} is the name of the query function to be called -(e.g. {get_lattice_constant_fcc}). -All following arguments are parameters handed over to the web query -in the format {keyword=value}. The list of supported keywords and -the type and format of their values depend on the query function -used. - -NOTE: The current list of supported query functions is available on the OpenKIM -webpage at "https://query.openkim.org"_https://query.openkim.org/ +argument of the {kim_query command}. (For the case of multiple +return values, the optional {split} keyword can be used after the +variable name to separate the results into multiple variables; see +the "example"_#split_example below.) +The second required argument {query_function} is the name of the +query function to be called (e.g. {get_lattice_constant_cubic}). +All following "arguments"_Commands_parse.html are parameters handed over to +the web query in the format {keyword=value}, where {value} is always +an array of one or more comma-separated items in brackets. +The list of supported keywords and the type and format of their values +depend on the query function used. The current list of query functions +is available on the OpenKIM webpage at +"https://openkim.org/doc/repository/kim-query"_https://openkim.org/doc/repository/kim-query. + +NOTE: All query functions require the {model} keyword, which identifies +the IM whose predictions are being queried. This keyword is automatically +generated by {kim_query} based on the IM set in {kim_init} and must not +be specified as an argument to {kim_query}. + +NOTE: Each {query_function} is associated with a default method (implemented +as a "KIM Test"_https://openkim.org/getting-started/kim-tests/) +used to compute this property. In cases where there are multiple +methods in OpenKIM for computing a property, a {method} keyword can +be provided to select the method of choice. See the +"query documentation"_https://openkim.org/doc/repository/kim-query +to see which methods are available for a given {query function}. + +{kim_query} Usage Examples and Further Clarifications: :h6 The data obtained by {kim_query} commands can be used as part of the setup or analysis phases of LAMMPS simulations. Some examples are given below. @@ -372,7 +385,7 @@ or analysis phases of LAMMPS simulations. Some examples are given below. kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal boundary p p p -kim_query a0 get_lattice_constant_fcc species=\["Al"\] units=\["angstrom"\] +kim_query a0 get_lattice_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\["angstrom"\] lattice fcc $\{a0\} ... :pre @@ -389,11 +402,12 @@ Note that in {unit_conversion_mode} the results obtained from a For example, in the above script, the lattice command would need to be changed to: "lattice fcc $\{a0\}*$\{_u_distance\}". +:link(split_example) [Define an equilibrium hcp crystal] kim_init EAM_Dynamo_Mendelev_2007_Zr__MO_848899341753_000 metal boundary p p p -kim_query latconst split get_lattice_constant_hcp species=\["Zr"\] units=\["angstrom"\] +kim_query latconst split get_lattice_constant_hexagonal crystal=\["hcp"\] species=\["Zr"\] units=\["angstrom"\] variable a0 equal latconst_1 variable c0 equal latconst_2 variable c_to_a equal $\{c0\}/$\{a0\} @@ -414,16 +428,27 @@ the returned values is determined by the type of query performed. kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal boundary p p p -kim_query a0 get_lattice_constant_fcc species=\["Al"\] units=\["angstrom"\] -kim_query alpha get_linear_thermal_expansion_fcc species=\["Al"\] units=\{"1/K"\} +kim_query a0 get_lattice_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\["angstrom"\] +kim_query alpha get_linear_thermal_expansion_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\{"1/K"\} temperature=[293.15] temperature_units=["K"] variable DeltaT equal 300 lattice fcc $\{a0\}*$\{alpha\}*$\{DeltaT\} ... :pre As in the previous example, the equilibrium lattice constant is obtained for the Ercolessi and Adams (1994) potential. However, in this case the -crystal is scaled to the appropriate lattice constant at 300 K by using -the linear thermal expansion coefficient predicted by the potential. +crystal is scaled to the appropriate lattice constant at room temperature +(293.15 K) by using the linear thermal expansion constant predicted by the +potential. + +NOTE: When passing numerical values as arguments (as in the case +of the temperature in the above example) it is also possible to pass a +tolerance indicating how close to the value is considered a match. +If no tolerance is passed a default value is used. If multiple results +are returned (indicating that the tolerance is too large), {kim_query} +will return an error. See the +"query documentation"_https://openkim.org/doc/repository/kim-query +to see which numerical arguments and tolerances are available for a +given {query function}. [Compute defect formation energy] @@ -432,7 +457,7 @@ kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal ... Build fcc crystal containing some defect and compute the total energy ... which is stored in the variable {Etot} ... -kim_query Ec get_cohesive_energy_fcc species=\["Al"\] units=\["eV"\] +kim_query Ec get_cohesive_energy_cubic crystal=\["fcc"\] species=\["Al"\] units=\["eV"\] variable Eform equal $\{Etot\} - count(all)*$\{Ec\} ... :pre -- GitLab From b61b48235b3e3551a6ad71e188995d6532a5a622 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Tue, 16 Jul 2019 15:19:28 -0500 Subject: [PATCH 254/469] Updated openkim.org documentation URLs to new /doc/* locations --- doc/src/kim_commands.txt | 19 ++++++++++--------- 1 file changed, 10 insertions(+), 9 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 46e437a871..7c88fd084a 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -57,17 +57,17 @@ Reliability :h5 All content archived in OpenKIM is reviewed by the "KIM Editor"_https://openkim.org/governance/ for quality. IMs in OpenKIM are archived with full provenance control. Each is associated with a maintainer responsible for the integrity of the content. All changes are tracked and recorded. -IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/getting-started/kim-tests/ that compute a host of material properties, and "KIM Verification Checks"_https://openkim.org/about-verification-checks/ that provide the user with information on various aspects of the IM behavior and coding correctness. This information is displayed on the IM's page accessible through the "OpenKIM browse interface"_https://openkim.org/browse. :ul +IMs in OpenKIM are exhaustively tested using "KIM Tests"_https://openkim.org/doc/evaluation/kim-tests/ that compute a host of material properties, and "KIM Verification Checks"_https://openkim.org/doc/evaluation/kim-verification-checks/ that provide the user with information on various aspects of the IM behavior and coding correctness. This information is displayed on the IM's page accessible through the "OpenKIM browse interface"_https://openkim.org/browse. :ul Reproducibility :h5 -Each IM in OpenKIM is issued a unique identifier ("KIM ID"_https://openkim.org/about-kim-ids/), which includes a version number (last three digits). Any changes that can result in different numerical values lead to a version increment in the KIM ID. This makes it possible to reproduce simulations since the specific version of a specific IM used can be retrieved using its KIM ID. +Each IM in OpenKIM is issued a unique identifier ("KIM ID"_https://openkim.org/doc/schema/kim-ids/), which includes a version number (last three digits). Any changes that can result in different numerical values lead to a version increment in the KIM ID. This makes it possible to reproduce simulations since the specific version of a specific IM used can be retrieved using its KIM ID. OpenKIM is a member organization of "DataCite"_https://datacite.org/ and issues digital object identifiers (DOIs) to all IMs archived in OpenKIM. This makes it possible to cite the IM code used in a simulation in a publications to give credit to the developers and further facilitate reproducibility. :ul Convenience :h5 IMs in OpenKIM are distributed in binary form along with LAMMPS and can be used in a LAMMPS input script simply by providing their KIM ID in the {kim_init} command documented on this page. -The {kim_query} web query tool provides the ability to use the predictions of IMs for supported material properties (computed via "KIM Tests"_https://openkim.org/getting-started/kim-tests/) as part of a LAMMPS input script setup and analysis. +The {kim_query} web query tool provides the ability to use the predictions of IMs for supported material properties (computed via "KIM Tests"_https://openkim.org/doc/evaluation/kim-tests/) as part of a LAMMPS input script setup and analysis. Support is provided for unit conversion between the "unit style"_units.html used in the LAMMPS input script and the units required by the OpenKIM IM. This makes it possible to use a single input script with IMs using different units without change and minimizes the likelihood of errors due to incompatible units. :ul :link(IM_types) @@ -80,10 +80,11 @@ The second type is called a {KIM Simulator Model} (SM). A KIM SM is an IM that i With these two IM types, OpenKIM can archive and test almost all IMs that can be used by LAMMPS. (It is easy to contribute new IMs to OpenKIM, see -the "upload instructions"_https://openkim.org/getting-started/adding-content/.) +the "upload instructions"_https://openkim.org/doc/repository/adding-content/.) OpenKIM IMs are uniquely identified by a -"KIM ID"_https://openkim.org/about-kim-ids/. The extended KIM ID consists of +"KIM ID"_https://openkim.org/doc/schema/kim-ids/. +The extended KIM ID consists of a human-readable prefix identifying the type of IM, authors, publication year, and supported species, separated by two underscores from the KIM ID itself, which begins with an IM code @@ -100,7 +101,7 @@ authorship and citation information, test and verification check results, visualizations of results, a wiki with documentation and user comments, and access to raw files, and other information. The URL for the Model Page is constructed from the -"extended KIM ID"_https://openkim.org/about-kim-ids/ of the IM: +"extended KIM ID"_https://openkim.org/doc/schema/kim-ids/ of the IM: https://openkim.org/id/extended_KIM_ID :pre @@ -141,7 +142,7 @@ would not include {units} and {atom_style} commands. The required arguments of {kim_init} are the {model} name of the IM to be used in the simulation (for an IM archived in OpenKIM this is -its "extended KIM ID"_https://openkim.org/about-kim-ids/), and +its "extended KIM ID"_https://openkim.org/doc/schema/kim-ids/, and the {user_units}, which are the LAMMPS "units style"_units.html used in the input script. (Any dimensioned numerical values in the input script and values read in from files are expected to be in the @@ -219,7 +220,7 @@ _u_density :pre If desired, the input script can be designed to work with these conversion factors so that the script will work without change with any OpenKIM IM. (This approach is used in the -"OpenKIM Testing Framework"_https://openkim.org/getting-started/kim-tests/.) +"OpenKIM Testing Framework"_https://openkim.org/doc/evaluation/kim-tests/.) For example, the script given above for the cohesive energy of fcc Al can be rewritten to work with any IM regardless of units. The following script constructs an fcc lattice with a lattice parameter defined in @@ -369,7 +370,7 @@ generated by {kim_query} based on the IM set in {kim_init} and must not be specified as an argument to {kim_query}. NOTE: Each {query_function} is associated with a default method (implemented -as a "KIM Test"_https://openkim.org/getting-started/kim-tests/) +as a "KIM Test"_https://openkim.org/doc/evaluation/kim-tests/) used to compute this property. In cases where there are multiple methods in OpenKIM for computing a property, a {method} keyword can be provided to select the method of choice. See the -- GitLab From 5b4f77b919b251ba8130abb9b15946999f738faa Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Tue, 16 Jul 2019 16:20:48 -0500 Subject: [PATCH 255/469] kim_query check for explicit 'model=' key in arguments (give error if present). --- src/KIM/kim_query.cpp | 11 +++++++++-- 1 file changed, 9 insertions(+), 2 deletions(-) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index 6e77b8f859..dc8d0544f6 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -113,6 +113,13 @@ void KimQuery::command(int narg, char **arg) narg--; } function = arg[1]; + for (int i = 2; i < narg; ++i) + { + if (0 == strncmp("model=",arg[i], 6)) { + error->all(FLERR,"Illegal 'model' key in kim_query command"); + } + } + #if defined(LMP_KIM_CURL) @@ -258,9 +265,9 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, if (value[0] == '[') { int len = strlen(value)-1; - if (value[len-1] == ']') { + if (value[len] == ']') { retval = new char[len]; - value[len-1] = '\0'; + value[len] = '\0'; strcpy(retval,value+1); } else { retval = new char[len+2]; -- GitLab From 354f4d19fd67094ca50ef83cb627abdf85f9a087 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Tue, 16 Jul 2019 22:11:23 -0500 Subject: [PATCH 256/469] Update to kim-api-2.1.0 release --- cmake/Modules/Packages/KIM.cmake | 6 ++---- 1 file changed, 2 insertions(+), 4 deletions(-) diff --git a/cmake/Modules/Packages/KIM.cmake b/cmake/Modules/Packages/KIM.cmake index 5803ea23c4..5c0b8e2ee8 100644 --- a/cmake/Modules/Packages/KIM.cmake +++ b/cmake/Modules/Packages/KIM.cmake @@ -21,10 +21,8 @@ if(PKG_KIM) enable_language(Fortran) include(ExternalProject) ExternalProject_Add(kim_build - GIT_REPOSITORY https://github.com/openkim/kim-api.git - GIT_TAG SimulatorModels - #URL https://s3.openkim.org/kim-api/kim-api-2.0.2.txz - #URL_MD5 537d9c0abd30f85b875ebb584f9143fa + URL https://s3.openkim.org/kim-api/kim-api-2.1.0.txz + URL_MD5 9ada58e677a545a1987b1ecb98e39d7e BINARY_DIR build CMAKE_ARGS -DCMAKE_C_COMPILER=${CMAKE_C_COMPILER} -DCMAKE_CXX_COMPILER=${CMAKE_CXX_COMPILER} -- GitLab From 06275b03c06f3615d6442ef9243a41ffecbcae19 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 17 Jul 2019 15:46:39 -0400 Subject: [PATCH 257/469] refactor FFT handling in CMake module for KSPACE. This also improves the FFT info output in the PPPM styles --- cmake/CMakeLists.txt | 7 ++++++- cmake/Modules/Packages/KSPACE.cmake | 28 ++++++++++++++++------------ src/KOKKOS/pppm_kokkos.cpp | 10 ++-------- src/KSPACE/pppm.cpp | 10 ++-------- src/KSPACE/pppm.h | 11 +++++++++++ src/KSPACE/pppm_disp.cpp | 10 ++-------- src/KSPACE/pppm_disp.h | 10 ++++++++++ 7 files changed, 49 insertions(+), 37 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index bde36aa896..4b528f280e 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -673,5 +673,10 @@ if(PKG_KOKKOS) message(STATUS "Kokkos Arch: ${KOKKOS_ARCH}") endif() if(PKG_KSPACE) - message(STATUS "Using ${FFT} as FFT") + message(STATUS "Using ${FFT} as primary FFT library") + if(FFT_SINGLE) + message(STATUS "Using single precision FFTs") + else() + message(STATUS "Using double precision FFTs") + endif() endif() diff --git a/cmake/Modules/Packages/KSPACE.cmake b/cmake/Modules/Packages/KSPACE.cmake index 6938a93a36..63c42baf2d 100644 --- a/cmake/Modules/Packages/KSPACE.cmake +++ b/cmake/Modules/Packages/KSPACE.cmake @@ -1,5 +1,5 @@ if(PKG_KSPACE) - option(FFT_SINGLE "Use single precision FFT instead of double" OFF) + option(FFT_SINGLE "Use single precision FFTs instead of double precision FFTs" OFF) set(FFTW "FFTW3") if(FFT_SINGLE) set(FFTW "FFTW3F") @@ -7,26 +7,30 @@ if(PKG_KSPACE) endif() find_package(${FFTW} QUIET) if(${FFTW}_FOUND) - set(FFT "${FFTW}" CACHE STRING "FFT library for KSPACE package") + set(FFT "FFTW3" CACHE STRING "FFT library for KSPACE package") else() set(FFT "KISS" CACHE STRING "FFT library for KSPACE package") endif() - set(FFT_VALUES KISS ${FFTW} MKL) + set(FFT_VALUES KISS FFTW3 MKL) set_property(CACHE FFT PROPERTY STRINGS ${FFT_VALUES}) validate_option(FFT FFT_VALUES) string(TOUPPER ${FFT} FFT) - if(NOT FFT STREQUAL "KISS") - find_package(${FFT} REQUIRED) - if(NOT FFT STREQUAL "FFTW3F") - add_definitions(-DFFT_FFTW) - else() - add_definitions(-DFFT_${FFT}) - endif() - include_directories(${${FFT}_INCLUDE_DIRS}) - list(APPEND LAMMPS_LINK_LIBS ${${FFT}_LIBRARIES}) + + if(FFT STREQUAL "FFTW3") + find_package(${FFTW} REQUIRED) + add_definitions(-DFFT_FFTW3) + include_directories(${${FFTW}_INCLUDE_DIRS}) + list(APPEND LAMMPS_LINK_LIBS ${${FFTW}_LIBRARIES}) + elseif(FFT STREQUAL "MKL") + find_package(MKL REQUIRED) + add_definitions(-DFFT_MKL) + include_directories(${MKL_INCLUDE_DIRS}) + list(APPEND LAMMPS_LINK_LIBS ${MKL_LIBRARIES}) else() + # last option is KISSFFT add_definitions(-DFFT_KISS) endif() + set(FFT_PACK "array" CACHE STRING "Optimization for FFT") set(FFT_PACK_VALUES array pointer memcpy) set_property(CACHE FFT_PACK PROPERTY STRINGS ${FFT_PACK_VALUES}) diff --git a/src/KOKKOS/pppm_kokkos.cpp b/src/KOKKOS/pppm_kokkos.cpp index 7c01adc510..c9c0d6d1d4 100644 --- a/src/KOKKOS/pppm_kokkos.cpp +++ b/src/KOKKOS/pppm_kokkos.cpp @@ -306,12 +306,6 @@ void PPPMKokkos::init() if (me == 0) { -#ifdef FFT_SINGLE - const char fft_prec[] = "single"; -#else - const char fft_prec[] = "double"; -#endif - if (screen) { fprintf(screen," G vector (1/distance) = %g\n",g_ewald); fprintf(screen," grid = %d %d %d\n",nx_pppm,ny_pppm,nz_pppm); @@ -320,7 +314,7 @@ void PPPMKokkos::init() estimated_accuracy); fprintf(screen," estimated relative force accuracy = %g\n", estimated_accuracy/two_charge_force); - fprintf(screen," using %s precision FFTs\n",fft_prec); + fprintf(screen," using " LMP_FFT_PREC " precision " LMP_FFT_LIB "\n"); fprintf(screen," 3d grid and FFT values/proc = %d %d\n", ngrid_max,nfft_both_max); } @@ -332,7 +326,7 @@ void PPPMKokkos::init() estimated_accuracy); fprintf(logfile," estimated relative force accuracy = %g\n", estimated_accuracy/two_charge_force); - fprintf(logfile," using %s precision FFTs\n",fft_prec); + fprintf(logfile," using " LMP_FFT_PREC " precision " LMP_FFT_LIB "\n"); fprintf(logfile," 3d grid and FFT values/proc = %d %d\n", ngrid_max,nfft_both_max); } diff --git a/src/KSPACE/pppm.cpp b/src/KSPACE/pppm.cpp index 53c18804a5..1abb19e947 100644 --- a/src/KSPACE/pppm.cpp +++ b/src/KSPACE/pppm.cpp @@ -350,12 +350,6 @@ void PPPM::init() if (me == 0) { -#ifdef FFT_SINGLE - const char fft_prec[] = "single"; -#else - const char fft_prec[] = "double"; -#endif - if (screen) { fprintf(screen," G vector (1/distance) = %g\n",g_ewald); fprintf(screen," grid = %d %d %d\n",nx_pppm,ny_pppm,nz_pppm); @@ -364,7 +358,7 @@ void PPPM::init() estimated_accuracy); fprintf(screen," estimated relative force accuracy = %g\n", estimated_accuracy/two_charge_force); - fprintf(screen," using %s precision FFTs\n",fft_prec); + fprintf(screen," using " LMP_FFT_PREC " precision " LMP_FFT_LIB "\n"); fprintf(screen," 3d grid and FFT values/proc = %d %d\n", ngrid_max,nfft_both_max); } @@ -376,7 +370,7 @@ void PPPM::init() estimated_accuracy); fprintf(logfile," estimated relative force accuracy = %g\n", estimated_accuracy/two_charge_force); - fprintf(logfile," using %s precision FFTs\n",fft_prec); + fprintf(logfile," using " LMP_FFT_PREC " precision " LMP_FFT_LIB "\n"); fprintf(logfile," 3d grid and FFT values/proc = %d %d\n", ngrid_max,nfft_both_max); } diff --git a/src/KSPACE/pppm.h b/src/KSPACE/pppm.h index 1ce1a0d666..6426b9c22d 100644 --- a/src/KSPACE/pppm.h +++ b/src/KSPACE/pppm.h @@ -23,11 +23,22 @@ KSpaceStyle(pppm,PPPM) #include "lmptype.h" #include +#if defined(FFT_FFTW3) +#define LMP_FFT_LIB "FFTW3" +#elif defined(FFT_MKL) +#define LMP_FFT_LIB "MKL FFT" +#else +#define LMP_FFT_LIB "KISS FFT" +#endif + #ifdef FFT_SINGLE typedef float FFT_SCALAR; +#define LMP_FFT_PREC "single" #define MPI_FFT_SCALAR MPI_FLOAT #else + typedef double FFT_SCALAR; +#define LMP_FFT_PREC "double" #define MPI_FFT_SCALAR MPI_DOUBLE #endif diff --git a/src/KSPACE/pppm_disp.cpp b/src/KSPACE/pppm_disp.cpp index 45dce0895b..ba0e85bbba 100644 --- a/src/KSPACE/pppm_disp.cpp +++ b/src/KSPACE/pppm_disp.cpp @@ -474,12 +474,6 @@ void PPPMDisp::init() MPI_Allreduce(&nfft_both,&nfft_both_max,1,MPI_INT,MPI_MAX,world); if (me == 0) { - #ifdef FFT_SINGLE - const char fft_prec[] = "single"; - #else - const char fft_prec[] = "double"; - #endif - if (screen) { fprintf(screen," Coulomb G vector (1/distance)= %g\n",g_ewald); fprintf(screen," Coulomb grid = %d %d %d\n",nx_pppm,ny_pppm,nz_pppm); @@ -488,7 +482,7 @@ void PPPMDisp::init() acc); fprintf(screen," Coulomb estimated relative force accuracy = %g\n", acc/two_charge_force); - fprintf(screen," using %s precision FFTs\n",fft_prec); + fprintf(screen," using " LMP_FFT_PREC " precision " LMP_FFT_LIB "\n"); fprintf(screen," 3d grid and FFT values/proc = %d %d\n", ngrid_max, nfft_both_max); } @@ -501,7 +495,7 @@ void PPPMDisp::init() acc); fprintf(logfile," Coulomb estimated relative force accuracy = %g\n", acc/two_charge_force); - fprintf(logfile," using %s precision FFTs\n",fft_prec); + fprintf(logfile," using " LMP_FFT_PREC " precision " LMP_FFT_LIB "\n"); fprintf(logfile," 3d grid and FFT values/proc = %d %d\n", ngrid_max, nfft_both_max); } diff --git a/src/KSPACE/pppm_disp.h b/src/KSPACE/pppm_disp.h index ccbeb60f3c..8674669274 100644 --- a/src/KSPACE/pppm_disp.h +++ b/src/KSPACE/pppm_disp.h @@ -23,11 +23,21 @@ KSpaceStyle(pppm/disp,PPPMDisp) #include "lmptype.h" #include +#if defined(FFT_FFTW3) +#define LMP_FFT_LIB "FFTW3" +#elif defined(FFT_MKL) +#define LMP_FFT_LIB "MKL FFT" +#else +#define LMP_FFT_LIB "KISS FFT" +#endif + #ifdef FFT_SINGLE typedef float FFT_SCALAR; +#define LMP_FFT_PREC "single" #define MPI_FFT_SCALAR MPI_FLOAT #else typedef double FFT_SCALAR; +#define LMP_FFT_PREC "double" #define MPI_FFT_SCALAR MPI_DOUBLE #endif -- GitLab From bcf600d7814df4eefe4b73d3de7ac344a8decc16 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 17 Jul 2019 15:47:28 -0400 Subject: [PATCH 258/469] let CMake configuration default to Release with debug settings this way we can more easily get detailed stack traces from people compiling with CMake --- cmake/CMakeLists.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 4b528f280e..0f99cc6274 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -37,7 +37,7 @@ include(PreventInSourceBuilds) if(NOT CMAKE_BUILD_TYPE AND NOT CMAKE_CXX_FLAGS) #release comes with -O3 by default - set(CMAKE_BUILD_TYPE Release CACHE STRING "Choose the type of build, options are: None Debug Release RelWithDebInfo MinSizeRel." FORCE) + set(CMAKE_BUILD_TYPE RelWithDebInfo CACHE STRING "Choose the type of build, options are: None Debug Release RelWithDebInfo MinSizeRel." FORCE) endif(NOT CMAKE_BUILD_TYPE AND NOT CMAKE_CXX_FLAGS) string(TOUPPER "${CMAKE_BUILD_TYPE}" BTYPE) -- GitLab From 02b0fb454f7adbb412ea3d2fd7d324ff5004446b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 17 Jul 2019 16:34:43 -0400 Subject: [PATCH 259/469] include rmass[] in border communication. will otherwise trigger issues with fix shake. --- src/PERI/atom_vec_peri.cpp | 11 ++++++++++- src/atom_vec_ellipsoid.cpp | 11 ++++++++++- 2 files changed, 20 insertions(+), 2 deletions(-) diff --git a/src/PERI/atom_vec_peri.cpp b/src/PERI/atom_vec_peri.cpp index 64ce323a3f..c4fa0bd43b 100644 --- a/src/PERI/atom_vec_peri.cpp +++ b/src/PERI/atom_vec_peri.cpp @@ -55,7 +55,7 @@ AtomVecPeri::AtomVecPeri(LAMMPS *lmp) : AtomVec(lmp) comm_f_only = 1; size_forward = 4; size_reverse = 3; - size_border = 11; + size_border = 12; size_velocity = 3; size_data_atom = 7; size_data_vel = 4; @@ -357,6 +357,7 @@ int AtomVecPeri::pack_border(int n, int *list, double *buf, buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; buf[m++] = vfrac[j]; + buf[m++] = rmass[j]; buf[m++] = s0[j]; buf[m++] = x0[j][0]; buf[m++] = x0[j][1]; @@ -381,6 +382,7 @@ int AtomVecPeri::pack_border(int n, int *list, double *buf, buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; buf[m++] = vfrac[j]; + buf[m++] = rmass[j]; buf[m++] = s0[j]; buf[m++] = x0[j][0]; buf[m++] = x0[j][1]; @@ -414,6 +416,7 @@ int AtomVecPeri::pack_border_vel(int n, int *list, double *buf, buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; buf[m++] = vfrac[j]; + buf[m++] = rmass[j]; buf[m++] = s0[j]; buf[m++] = x0[j][0]; buf[m++] = x0[j][1]; @@ -442,6 +445,7 @@ int AtomVecPeri::pack_border_vel(int n, int *list, double *buf, buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; buf[m++] = vfrac[j]; + buf[m++] = rmass[j]; buf[m++] = s0[j]; buf[m++] = x0[j][0]; buf[m++] = x0[j][1]; @@ -463,6 +467,7 @@ int AtomVecPeri::pack_border_vel(int n, int *list, double *buf, buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; buf[m++] = vfrac[j]; + buf[m++] = rmass[j]; buf[m++] = s0[j]; buf[m++] = x0[j][0]; buf[m++] = x0[j][1]; @@ -497,6 +502,7 @@ int AtomVecPeri::pack_border_hybrid(int n, int *list, double *buf) for (i = 0; i < n; i++) { j = list[i]; buf[m++] = vfrac[j]; + buf[m++] = rmass[j]; buf[m++] = s0[j]; buf[m++] = x0[j][0]; buf[m++] = x0[j][1]; @@ -522,6 +528,7 @@ void AtomVecPeri::unpack_border(int n, int first, double *buf) type[i] = (int) ubuf(buf[m++]).i; mask[i] = (int) ubuf(buf[m++]).i; vfrac[i] = buf[m++]; + rmass[i] = buf[m++]; s0[i] = buf[m++]; x0[i][0] = buf[m++]; x0[i][1] = buf[m++]; @@ -551,6 +558,7 @@ void AtomVecPeri::unpack_border_vel(int n, int first, double *buf) type[i] = (int) ubuf(buf[m++]).i; mask[i] = (int) ubuf(buf[m++]).i; vfrac[i] = buf[m++]; + rmass[i] = buf[m++]; s0[i] = buf[m++]; x0[i][0] = buf[m++]; x0[i][1] = buf[m++]; @@ -576,6 +584,7 @@ int AtomVecPeri::unpack_border_hybrid(int n, int first, double *buf) last = first + n; for (i = first; i < last; i++) { vfrac[i] = buf[m++]; + rmass[i] = buf[m++]; s0[i] = buf[m++]; x0[i][0] = buf[m++]; x0[i][1] = buf[m++]; diff --git a/src/atom_vec_ellipsoid.cpp b/src/atom_vec_ellipsoid.cpp index 455e4f192f..7bb29bd6bc 100644 --- a/src/atom_vec_ellipsoid.cpp +++ b/src/atom_vec_ellipsoid.cpp @@ -41,7 +41,7 @@ AtomVecEllipsoid::AtomVecEllipsoid(LAMMPS *lmp) : AtomVec(lmp) comm_x_only = comm_f_only = 0; size_forward = 7; size_reverse = 6; - size_border = 14; + size_border = 15; size_velocity = 6; size_data_atom = 7; size_data_vel = 7; @@ -544,6 +544,7 @@ int AtomVecEllipsoid::pack_border(int n, int *list, double *buf, buf[m++] = ubuf(tag[j]).d; buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; + buf[m++] = rmass[j]; if (ellipsoid[j] < 0) buf[m++] = ubuf(0).d; else { buf[m++] = ubuf(1).d; @@ -576,6 +577,7 @@ int AtomVecEllipsoid::pack_border(int n, int *list, double *buf, buf[m++] = ubuf(tag[j]).d; buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; + buf[m++] = rmass[j]; if (ellipsoid[j] < 0) buf[m++] = ubuf(0).d; else { buf[m++] = ubuf(1).d; @@ -618,6 +620,7 @@ int AtomVecEllipsoid::pack_border_vel(int n, int *list, double *buf, buf[m++] = ubuf(tag[j]).d; buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; + buf[m++] = rmass[j]; if (ellipsoid[j] < 0) buf[m++] = ubuf(0).d; else { buf[m++] = ubuf(1).d; @@ -657,6 +660,7 @@ int AtomVecEllipsoid::pack_border_vel(int n, int *list, double *buf, buf[m++] = ubuf(tag[j]).d; buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; + buf[m++] = rmass[j]; if (ellipsoid[j] < 0) buf[m++] = ubuf(0).d; else { buf[m++] = ubuf(1).d; @@ -689,6 +693,7 @@ int AtomVecEllipsoid::pack_border_vel(int n, int *list, double *buf, buf[m++] = ubuf(tag[j]).d; buf[m++] = ubuf(type[j]).d; buf[m++] = ubuf(mask[j]).d; + buf[m++] = rmass[j]; if (ellipsoid[j] < 0) buf[m++] = ubuf(0).d; else { buf[m++] = ubuf(1).d; @@ -735,6 +740,7 @@ int AtomVecEllipsoid::pack_border_hybrid(int n, int *list, double *buf) m = 0; for (i = 0; i < n; i++) { j = list[i]; + buf[m++] = rmass[j]; if (ellipsoid[j] < 0) buf[m++] = ubuf(0).d; else { buf[m++] = ubuf(1).d; @@ -769,6 +775,7 @@ void AtomVecEllipsoid::unpack_border(int n, int first, double *buf) tag[i] = (tagint) ubuf(buf[m++]).i; type[i] = (int) ubuf(buf[m++]).i; mask[i] = (int) ubuf(buf[m++]).i; + rmass[i] = buf[m++]; ellipsoid[i] = (int) ubuf(buf[m++]).i; if (ellipsoid[i] == 0) ellipsoid[i] = -1; else { @@ -812,6 +819,7 @@ void AtomVecEllipsoid::unpack_border_vel(int n, int first, double *buf) tag[i] = (tagint) ubuf(buf[m++]).i; type[i] = (int) ubuf(buf[m++]).i; mask[i] = (int) ubuf(buf[m++]).i; + rmass[i] = buf[m++]; ellipsoid[i] = (int) ubuf(buf[m++]).i; if (ellipsoid[i] == 0) ellipsoid[i] = -1; else { @@ -854,6 +862,7 @@ int AtomVecEllipsoid::unpack_border_hybrid(int n, int first, double *buf) m = 0; last = first + n; for (i = first; i < last; i++) { + rmass[i] = buf[m++]; ellipsoid[i] = (int) ubuf(buf[m++]).i; if (ellipsoid[i] == 0) ellipsoid[i] = -1; else { -- GitLab From 856efa28aab9a140f37875a7ed5df96419280ad0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 17 Jul 2019 19:37:08 -0400 Subject: [PATCH 260/469] fix issue #1568 --- src/utils.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/utils.cpp b/src/utils.cpp index bbda22f24c..34e6e6fae6 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -13,6 +13,7 @@ #include #include +#include #include "utils.h" #include "lammps.h" #include "error.h" -- GitLab From 60ebc08d0f6da5b9b74011b9728c069cb6973cee Mon Sep 17 00:00:00 2001 From: julient31 Date: Wed, 17 Jul 2019 21:49:26 -0600 Subject: [PATCH 261/469] Commit JT 071719 - added doc for read_data spin - corrected an error in pack/unpack data hybrid - added mask flags in fix_nve_spin::initial_integrate - removed spin renormalization in min_spin (was causing a bug) --- doc/src/read_data.txt | 3 ++ src/SPIN/atom_vec_spin.cpp | 18 +++++------ src/SPIN/fix_nve_spin.cpp | 66 +++++++++++++++++++++++--------------- src/SPIN/min_spin.cpp | 6 ---- 4 files changed, 53 insertions(+), 40 deletions(-) diff --git a/doc/src/read_data.txt b/doc/src/read_data.txt index 62112ea886..5fb91ba797 100644 --- a/doc/src/read_data.txt +++ b/doc/src/read_data.txt @@ -565,6 +565,7 @@ molecular: atom-ID molecule-ID atom-type x y z peri: atom-ID atom-type volume density x y z smd: atom-ID atom-type molecule volume mass kernel-radius contact-radius x y z sphere: atom-ID atom-type diameter density x y z +spin: atom-ID atom-type sp x y z spx spy spz template: atom-ID molecule-ID template-index template-atom atom-type x y z tri: atom-ID molecule-ID atom-type triangleflag density x y z wavepacket: atom-ID atom-type charge spin eradius etag cs_re cs_im x y z @@ -595,6 +596,8 @@ mux,muy,muz = components of dipole moment of atom (dipole units) q = charge on atom (charge units) rho = density (need units) for SPH particles spin = electron spin (+1/-1), 0 = nuclei, 2 = fixed-core, 3 = pseudo-cores (i.e. ECP) +sp = norm of magnetic spin of atom (in number of Bohr magnetons) +spx,spy,spz = components of magnetic spin of atom (adim normalized vector) template-atom = which atom within a template molecule the atom is template-index = which molecule within the molecule template the atom is part of theta = internal temperature of a DPD particle diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index 5b4173509f..8cc38dbc15 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -263,10 +263,10 @@ int AtomVecSpin::pack_comm_hybrid(int n, int *list, double *buf) m = 0; for (i = 0; i < n; i++) { j = list[i]; + buf[m++] = sp[j][3]; buf[m++] = sp[j][0]; buf[m++] = sp[j][1]; buf[m++] = sp[j][2]; - buf[m++] = sp[j][3]; } return m; } @@ -321,10 +321,10 @@ int AtomVecSpin::unpack_comm_hybrid(int n, int first, double *buf) m = 0; last = first + n; for (i = first; i < last; i++) { + sp[i][3] = buf[m++]; sp[i][0] = buf[m++]; sp[i][1] = buf[m++]; sp[i][2] = buf[m++]; - sp[i][3] = buf[m++]; } return m; } @@ -524,10 +524,10 @@ int AtomVecSpin::pack_border_hybrid(int n, int *list, double *buf) m = 0; for (i = 0; i < n; i++) { j = list[i]; + buf[m++] = sp[j][3]; buf[m++] = sp[j][0]; buf[m++] = sp[j][1]; buf[m++] = sp[j][2]; - buf[m++] = sp[j][3]; } return m; @@ -603,10 +603,10 @@ int AtomVecSpin::unpack_border_hybrid(int n, int first, double *buf) m = 0; last = first + n; for (i = first; i < last; i++) { + sp[i][3] = buf[m++]; sp[i][0] = buf[m++]; sp[i][1] = buf[m++]; sp[i][2] = buf[m++]; - sp[i][3] = buf[m++]; } return m; @@ -894,10 +894,10 @@ void AtomVecSpin::pack_data(double **buf) int AtomVecSpin::pack_data_hybrid(int i, double *buf) { - buf[0] = sp[i][0]; - buf[1] = sp[i][1]; - buf[2] = sp[i][2]; - buf[3] = sp[i][3]; + buf[0] = sp[i][3]; + buf[1] = sp[i][0]; + buf[2] = sp[i][1]; + buf[3] = sp[i][2]; return 4; } @@ -924,7 +924,7 @@ void AtomVecSpin::write_data(FILE *fp, int n, double **buf) int AtomVecSpin::write_data_hybrid(FILE *fp, double *buf) { - fprintf(fp," %-1.16e %-1.16e %-1.16e %-1.16e %-1.16e",buf[0],buf[1],buf[2],buf[3],buf[4]); + fprintf(fp," %-1.16e %-1.16e %-1.16e %-1.16e",buf[0],buf[1],buf[2],buf[3]); return 4; } diff --git a/src/SPIN/fix_nve_spin.cpp b/src/SPIN/fix_nve_spin.cpp index 595ddb0cc2..b992f17cc3 100644 --- a/src/SPIN/fix_nve_spin.cpp +++ b/src/SPIN/fix_nve_spin.cpp @@ -312,29 +312,37 @@ void FixNVESpin::initial_integrate(int /*vflag*/) comm->forward_comm(); int i = stack_foot[j]; while (i >= 0) { - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); - i = forward_stacks[i]; + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + i = forward_stacks[i]; + } } } for (int j = nsectors-1; j >= 0; j--) { // advance quarter s for nlocal comm->forward_comm(); int i = stack_head[j]; while (i >= 0) { - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); - i = backward_stacks[i]; + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + i = backward_stacks[i]; + } } } } else if (sector_flag == 0) { // serial seq. update comm->forward_comm(); // comm. positions of ghost atoms for (int i = 0; i < nlocal; i++){ // advance quarter s for nlocal - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + } } for (int i = nlocal-1; i >= 0; i--){ // advance quarter s for nlocal - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + } } } else error->all(FLERR,"Illegal fix NVE/spin command"); @@ -357,29 +365,37 @@ void FixNVESpin::initial_integrate(int /*vflag*/) comm->forward_comm(); int i = stack_foot[j]; while (i >= 0) { - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); - i = forward_stacks[i]; + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + i = forward_stacks[i]; + } } } for (int j = nsectors-1; j >= 0; j--) { // advance quarter s for nlocal comm->forward_comm(); int i = stack_head[j]; while (i >= 0) { - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); - i = backward_stacks[i]; + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + i = backward_stacks[i]; + } } } } else if (sector_flag == 0) { // serial seq. update comm->forward_comm(); // comm. positions of ghost atoms for (int i = 0; i < nlocal; i++){ // advance quarter s for nlocal-1 - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + } } for (int i = nlocal-1; i >= 0; i--){ // advance quarter s for nlocal-1 - ComputeInteractionsSpin(i); - AdvanceSingleSpin(i); + if (mask[i] & groupbit) { + ComputeInteractionsSpin(i); + AdvanceSingleSpin(i); + } } } else error->all(FLERR,"Illegal fix NVE/spin command"); @@ -613,11 +629,11 @@ void FixNVESpin::AdvanceSingleSpin(int i) // renormalization (check if necessary) - //msq = g[0]*g[0] + g[1]*g[1] + g[2]*g[2]; - //scale = 1.0/sqrt(msq); - //sp[i][0] *= scale; - //sp[i][1] *= scale; - //sp[i][2] *= scale; + // msq = g[0]*g[0] + g[1]*g[1] + g[2]*g[2]; + // scale = 1.0/sqrt(msq); + // sp[i][0] *= scale; + // sp[i][1] *= scale; + // sp[i][2] *= scale; // comm. sp[i] to atoms with same tag (for serial algo) diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 2bddc110e7..dda414ff97 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -287,12 +287,6 @@ void MinSpin::advance_spins(double dts) // renormalization (check if necessary) - msq = g[0]*g[0] + g[1]*g[1] + g[2]*g[2]; - scale = 1.0/sqrt(msq); - sp[i][0] *= scale; - sp[i][1] *= scale; - sp[i][2] *= scale; - // no comm. to atoms with same tag // because no need for simplecticity } -- GitLab From 22b73a316fb59f691660ba2c404b1c36a3ce49bc Mon Sep 17 00:00:00 2001 From: julient31 Date: Wed, 17 Jul 2019 22:15:23 -0600 Subject: [PATCH 262/469] Commit2 JT 071719 - added 'magnetons' to false-positive for doc --- doc/utils/sphinx-config/false_positives.txt | 1 + 1 file changed, 1 insertion(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 9a46983539..da5c869075 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -1521,6 +1521,7 @@ Magdeburg magelec Maginn magneton +magnetons mainboard mainboards makefile -- GitLab From 92518e53f4146abf236a73e5ffed4b5db0b0e37d Mon Sep 17 00:00:00 2001 From: jrgissing Date: Wed, 17 Jul 2019 22:58:40 -0600 Subject: [PATCH 263/469] Revert "spelling: attempt add file paths to false positives" This reverts commit 0c4af8b820f4d6f559d07086db91a2c1dee67a47. --- doc/utils/sphinx-config/conf.py | 3 --- doc/utils/sphinx-config/custom_filters.py | 9 --------- 2 files changed, 12 deletions(-) delete mode 100644 doc/utils/sphinx-config/custom_filters.py diff --git a/doc/utils/sphinx-config/conf.py b/doc/utils/sphinx-config/conf.py index 646fbd2e94..29de3af156 100644 --- a/doc/utils/sphinx-config/conf.py +++ b/doc/utils/sphinx-config/conf.py @@ -312,6 +312,3 @@ if spelling_spec: spelling_lang='en_US' spelling_word_list_filename='false_positives.txt' - - from custom_filters import PathFilter - spelling_filters = [PathFilter] diff --git a/doc/utils/sphinx-config/custom_filters.py b/doc/utils/sphinx-config/custom_filters.py deleted file mode 100644 index 3df26854e4..0000000000 --- a/doc/utils/sphinx-config/custom_filters.py +++ /dev/null @@ -1,9 +0,0 @@ -class PathFilter(Filter): - r"""Filter skipping over simple file paths - """ - _DOC_ERRORS = ["zA"] - _pattern = re.compile(r"\/[^\s].*") - def _skip(self,word): - if self._pattern.match(word): - return True - return False -- GitLab From 8cf1084decf4a5c765ab67b6d94c73aadac6e9e3 Mon Sep 17 00:00:00 2001 From: jrgissing Date: Wed, 17 Jul 2019 23:05:28 -0600 Subject: [PATCH 264/469] bond/react: use Unix path in docs --- doc/src/fix_bond_react.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/fix_bond_react.txt b/doc/src/fix_bond_react.txt index 7310545e1c..37b916cbea 100644 --- a/doc/src/fix_bond_react.txt +++ b/doc/src/fix_bond_react.txt @@ -52,7 +52,7 @@ react = mandatory argument indicating new reaction specification :l [Examples:] -For unabridged example scripts and files, see \examples\USER\misc\bond_react. +For unabridged example scripts and files, see examples/USER/misc/bond_react. molecule mol1 pre_reacted_topology.txt molecule mol2 post_reacted_topology.txt -- GitLab From 87154da7f5c95ed22d3f7085e0d5a40733788dca Mon Sep 17 00:00:00 2001 From: jrgissing Date: Wed, 17 Jul 2019 23:24:12 -0600 Subject: [PATCH 265/469] another Unix path correction --- doc/src/fix_bond_react.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/fix_bond_react.txt b/doc/src/fix_bond_react.txt index 37b916cbea..3f428e2103 100644 --- a/doc/src/fix_bond_react.txt +++ b/doc/src/fix_bond_react.txt @@ -135,7 +135,7 @@ constant-topology parts of your system separately. The dynamic group contains only atoms not involved in a reaction at a given timestep, and therefore should be used by a subsequent system-wide time integrator such as nvt, npt, or nve, as shown in the second example -above (full examples can be found at \examples\USER\misc\bond_react). +above (full examples can be found at examples/USER/misc/bond_react). The time integration command should be placed after the fix bond/react command due to the internal dynamic grouping performed by fix bond/react. -- GitLab From e5fffa59ef5e244f5516415ef5822ce8d645cde6 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 18 Jul 2019 15:29:45 -0600 Subject: [PATCH 266/469] Add optimized version of Kokkos SNAP --- src/KOKKOS/pair_snap_kokkos.h | 48 +- src/KOKKOS/pair_snap_kokkos_impl.h | 431 +++++++++--------- src/KOKKOS/sna_kokkos.h | 97 ++-- src/KOKKOS/sna_kokkos_impl.h | 681 ++++++++++------------------- 4 files changed, 526 insertions(+), 731 deletions(-) diff --git a/src/KOKKOS/pair_snap_kokkos.h b/src/KOKKOS/pair_snap_kokkos.h index 8be0bf9afb..2193e9ff24 100644 --- a/src/KOKKOS/pair_snap_kokkos.h +++ b/src/KOKKOS/pair_snap_kokkos.h @@ -31,10 +31,17 @@ PairStyle(snap/kk/host,PairSNAPKokkos) namespace LAMMPS_NS { template -struct TagPairSNAPCompute{}; +struct TagPairSNAPComputeForce{}; struct TagPairSNAPBeta{}; -struct TagPairSNAPBispectrum{}; +struct TagPairSNAPComputeNeigh{}; +struct TagPairSNAPPreUi{}; +struct TagPairSNAPComputeUi{}; +struct TagPairSNAPComputeZi{}; +struct TagPairSNAPComputeBi{}; +struct TagPairSNAPComputeYi{}; +struct TagPairSNAPComputeDuidrj{}; +struct TagPairSNAPComputeDeidrj{}; template class PairSNAPKokkos : public PairSNAP { @@ -56,17 +63,38 @@ public: template KOKKOS_INLINE_FUNCTION - void operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team) const; + void operator() (TagPairSNAPComputeForce,const typename Kokkos::TeamPolicy >::member_type& team) const; template KOKKOS_INLINE_FUNCTION - void operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT&) const; + void operator() (TagPairSNAPComputeForce,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT&) const; KOKKOS_INLINE_FUNCTION - void operator() (TagPairSNAPBeta,const typename Kokkos::TeamPolicy::member_type& team) const; + void operator() (TagPairSNAPComputeNeigh,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPPreUi,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPComputeUi,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPComputeZi,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPComputeBi,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPComputeYi,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPComputeDuidrj,const typename Kokkos::TeamPolicy::member_type& team) const; + + KOKKOS_INLINE_FUNCTION + void operator() (TagPairSNAPComputeDeidrj,const typename Kokkos::TeamPolicy::member_type& team) const; KOKKOS_INLINE_FUNCTION - void operator() (TagPairSNAPBispectrum,const typename Kokkos::TeamPolicy::member_type& team) const; + void operator() (TagPairSNAPBeta,const typename Kokkos::TeamPolicy::member_type& team) const; template KOKKOS_INLINE_FUNCTION @@ -90,15 +118,10 @@ protected: t_dbvec dbvec; SNAKokkos snaKK; - // How much parallelism to use within an interaction - int vector_length,team_size; - int team_scratch_size; - int thread_scratch_size; + int inum,max_neighs,chunk_offset; int eflag,vflag; - void compute_beta(); - void compute_bispectrum(); void allocate(); //void read_files(char *, char *); /*template @@ -131,6 +154,7 @@ inline double dist2(double* x,double* y); Kokkos::View d_wjelem; // elements weights Kokkos::View d_coeffelem; // element bispectrum coefficients Kokkos::View d_map; // mapping from atom types to elements + Kokkos::View d_ninside; // ninside for all atoms in list Kokkos::View d_beta; // betas for all atoms in list Kokkos::View d_bispectrum; // bispectrum components for all atoms in list diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index 8d72d1fac4..645521a17b 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -57,7 +57,6 @@ PairSNAPKokkos::PairSNAPKokkos(LAMMPS *lmp) : PairSNAP(lmp) datamask_read = EMPTY_MASK; datamask_modify = EMPTY_MASK; - vector_length = 8; k_cutsq = tdual_fparams("PairSNAPKokkos::cutsq",atom->ntypes+1,atom->ntypes+1); auto d_cutsq = k_cutsq.template view(); rnd_cutsq = d_cutsq; @@ -164,7 +163,7 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) d_numneigh = k_list->d_numneigh; d_neighbors = k_list->d_neighbors; d_ilist = k_list->d_ilist; - int inum = list->inum; + inum = list->inum; need_dup = lmp->kokkos->need_dup(); if (need_dup) { @@ -181,70 +180,112 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) const int num_neighs = neighs_i.get_num_neighs(); if (max_neighs(k_list), Kokkos::Experimental::Max(max_neighs)); - snaKK.nmax = max_neighs; - - team_scratch_size = snaKK.size_team_scratch_arrays(); - thread_scratch_size = snaKK.size_thread_scratch_arrays(); - - //printf("Sizes: %i %i\n",team_scratch_size/1024,thread_scratch_size/1024); + int vector_length = 1; + int ui_vector_length = 1; + int team_size = 1; + int yi_team_size = 1; int team_size_max = Kokkos::TeamPolicy::team_size_max(*this); - vector_length = 8; #ifdef KOKKOS_ENABLE_CUDA team_size = 32;//max_neighs; if (team_size*vector_length > team_size_max) team_size = team_size_max/vector_length; -#else - team_size = 1; + + yi_team_size = 256; + if (yi_team_size*vector_length > team_size_max) + yi_team_size = team_size_max/vector_length; + + ui_vector_length = 8; + if (team_size*ui_vector_length > team_size_max) + team_size = team_size_max/ui_vector_length; #endif - if (beta_max < list->inum) { - d_beta = Kokkos::View("PairSNAPKokkos:beta", - list->inum,ncoeff); - d_bispectrum = Kokkos::View("PairSNAPKokkos:bispectrum", - list->inum,ncoeff); - beta_max = list->inum; + if (beta_max < inum) { + beta_max = inum; + d_beta = Kokkos::View("PairSNAPKokkos:beta",inum,ncoeff); + d_ninside = Kokkos::View("PairSNAPKokkos:ninside",inum); } - // compute dE_i/dB_i = beta_i for all i in list + int chunk_size = 2000; + chunk_offset = 0; - if (quadraticflag || eflag) - compute_bispectrum(); - compute_beta(); + snaKK.grow_rij(chunk_size,max_neighs); EV_FLOAT ev; - if (eflag) { - if (neighflag == HALF) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); - Kokkos::parallel_reduce(policy - .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) - .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) - ,*this,ev); - } else if (neighflag == HALFTHREAD) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); - Kokkos::parallel_reduce(policy - .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) - .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) - ,*this,ev); + while (chunk_offset < inum) { // chunk up loop to prevent running out of memory + + EV_FLOAT ev_tmp; + + if (chunk_size > inum - chunk_offset) + chunk_size = inum - chunk_offset; + + //ComputeNeigh + typename Kokkos::TeamPolicy policy_neigh(chunk_size,team_size,vector_length); + Kokkos::parallel_for("ComputeNeigh",policy_neigh,*this); + + //PreUi + typename Kokkos::TeamPolicy policy_preui(chunk_size,team_size,vector_length); + Kokkos::parallel_for("PreUi",policy_preui,*this); + + //ComputeUi + typename Kokkos::TeamPolicy policy_ui(((inum+team_size-1)/team_size)*max_neighs,team_size,ui_vector_length); + Kokkos::parallel_for("ComputeUi",policy_ui,*this); + + //Compute bispectrum + if (quadraticflag || eflag) { + //ComputeZi + typename Kokkos::TeamPolicy policy_zi(chunk_size,team_size,vector_length); + Kokkos::parallel_for("ComputeZi",policy_zi,*this); + + //ComputeBi + typename Kokkos::TeamPolicy policy_bi(chunk_size,team_size,vector_length); + Kokkos::parallel_for("ComputeBi",policy_bi,*this); } - } else { - if (neighflag == HALF) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); - Kokkos::parallel_for(policy - .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) - .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) - ,*this); - } else if (neighflag == HALFTHREAD) { - typename Kokkos::TeamPolicy > policy(inum,team_size,vector_length); - Kokkos::parallel_for(policy - .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) - .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) - ,*this); + + //Compute beta = dE_i/dB_i for all i in list + typename Kokkos::TeamPolicy policy_beta(chunk_size,team_size,vector_length); + Kokkos::parallel_for("ComputeBeta",policy_beta,*this); + + //ComputeYi + typename Kokkos::TeamPolicy policy_yi(chunk_size,yi_team_size,vector_length); + Kokkos::parallel_for("ComputeYi",policy_yi,*this); + + //ComputeDuidrj + typename Kokkos::TeamPolicy policy_duidrj(((inum+team_size-1)/team_size)*max_neighs,team_size,vector_length); + Kokkos::parallel_for("ComputeDuidrj",policy_duidrj,*this); + + //ComputeDeidrj + typename Kokkos::TeamPolicy policy_deidrj(((inum+team_size-1)/team_size)*max_neighs,team_size,vector_length); + Kokkos::parallel_for("ComputeDeidrj",policy_deidrj,*this); + + //ComputeForce + if (eflag) { + if (neighflag == HALF) { + typename Kokkos::TeamPolicy > policy_force(chunk_size,team_size,vector_length); + Kokkos::parallel_reduce(policy_force + ,*this,ev_tmp); + } else if (neighflag == HALFTHREAD) { + typename Kokkos::TeamPolicy > policy_force(chunk_size,team_size,vector_length); + Kokkos::parallel_reduce(policy_force + ,*this,ev_tmp); + } + } else { + if (neighflag == HALF) { + typename Kokkos::TeamPolicy > policy_force(chunk_size,team_size,vector_length); + Kokkos::parallel_for(policy_force + ,*this); + } else if (neighflag == HALFTHREAD) { + typename Kokkos::TeamPolicy > policy_force(chunk_size,team_size,vector_length); + Kokkos::parallel_for(policy_force + ,*this); + } } - } + ev += ev_tmp; + chunk_offset += chunk_size; + } // end while if (need_dup) Kokkos::Experimental::contribute(f, dup_f); @@ -284,32 +325,19 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) } } -/* ---------------------------------------------------------------------- - compute beta -------------------------------------------------------------------------- */ - -template -void PairSNAPKokkos::compute_beta() -{ - // TODO: use RangePolicy instead, or thread over ncoeff? - int inum = list->inum; - typename Kokkos::TeamPolicy policy(inum,team_size,vector_length); - Kokkos::parallel_for(policy - .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) - .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) - ,*this); -} - /* ---------------------------------------------------------------------- */ template KOKKOS_INLINE_FUNCTION void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokkos::TeamPolicy::member_type& team) const { + // TODO: use RangePolicy instead, or thread over ncoeff? const int ii = team.league_rank(); - const int i = d_ilist[ii]; + const int i = d_ilist[ii + chunk_offset]; const int itype = type[i]; const int ielem = d_map[itype]; + SNAKokkos my_sna = snaKK; + Kokkos::View> d_coeffi(d_coeffelem,ielem,Kokkos::ALL); @@ -319,11 +347,11 @@ void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokk if (quadraticflag) { int k = ncoeff+1; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = d_bispectrum(ii,icoeff); + double bveci = my_sna.blist(ii,icoeff); d_beta(ii,icoeff) += d_coeffi[k]*bveci; k++; for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double bvecj = d_bispectrum(ii,jcoeff); + double bvecj = my_sna.blist(ii,jcoeff); d_beta(ii,icoeff) += d_coeffi[k]*bvecj; d_beta(ii,jcoeff) += d_coeffi[k]*bveci; k++; @@ -332,105 +360,6 @@ void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokk } } -/* ---------------------------------------------------------------------- - compute bispectrum -------------------------------------------------------------------------- */ - -template -void PairSNAPKokkos::compute_bispectrum() -{ - int inum = list->inum; - typename Kokkos::TeamPolicy policy(inum,team_size,vector_length); - Kokkos::parallel_for(policy - .set_scratch_size(1,Kokkos::PerThread(thread_scratch_size)) - .set_scratch_size(1,Kokkos::PerTeam(team_scratch_size)) - ,*this); -} - -/* ---------------------------------------------------------------------- */ - -template -KOKKOS_INLINE_FUNCTION -void PairSNAPKokkos::operator() (TagPairSNAPBispectrum,const typename Kokkos::TeamPolicy::member_type& team) const { - - const int ii = team.league_rank(); - const int i = d_ilist[ii]; - SNAKokkos my_sna(snaKK,team); - const double xtmp = x(i,0); - const double ytmp = x(i,1); - const double ztmp = x(i,2); - const int itype = type[i]; - const int ielem = d_map[itype]; - const double radi = d_radelem[ielem]; - - const int num_neighs = d_numneigh[i]; - - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // wj = weights for neighbors of I within cutoff - // rcutij = cutoffs for neighbors of I within cutoff - // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi - - int ninside = 0; - Kokkos::parallel_reduce(Kokkos::TeamThreadRange(team,num_neighs), - [&] (const int jj, int& count) { - Kokkos::single(Kokkos::PerThread(team), [&] (){ - T_INT j = d_neighbors(i,jj); - const F_FLOAT dx = x(j,0) - xtmp; - const F_FLOAT dy = x(j,1) - ytmp; - const F_FLOAT dz = x(j,2) - ztmp; - - const int jtype = type(j); - const F_FLOAT rsq = dx*dx + dy*dy + dz*dz; - const int elem_j = d_map[jtype]; - - if ( rsq < rnd_cutsq(itype,jtype) ) - count++; - }); - },ninside); - - if (team.team_rank() == 0) - Kokkos::parallel_scan(Kokkos::ThreadVectorRange(team,num_neighs), - [&] (const int jj, int& offset, bool final) { - //for (int jj = 0; jj < num_neighs; jj++) { - T_INT j = d_neighbors(i,jj); - const F_FLOAT dx = x(j,0) - xtmp; - const F_FLOAT dy = x(j,1) - ytmp; - const F_FLOAT dz = x(j,2) - ztmp; - - const int jtype = type(j); - const F_FLOAT rsq = dx*dx + dy*dy + dz*dz; - const int elem_j = d_map[jtype]; - - if ( rsq < rnd_cutsq(itype,jtype) ) { - if (final) { - my_sna.rij(offset,0) = dx; - my_sna.rij(offset,1) = dy; - my_sna.rij(offset,2) = dz; - my_sna.inside[offset] = j; - my_sna.wj[offset] = d_wjelem[elem_j]; - my_sna.rcutij[offset] = (radi + d_radelem[elem_j])*rcutfac; - } - offset++; - } - }); - team.team_barrier(); - - // compute Ui, Zi, and Bi for atom I - - my_sna.compute_ui(team,ninside); - team.team_barrier(); - - my_sna.compute_zi(team); - team.team_barrier(); - - my_sna.compute_bi(team); - team.team_barrier(); - - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - d_bispectrum(ii,icoeff) = my_sna.blist[icoeff]; -} - /* ---------------------------------------------------------------------- allocate all arrays ------------------------------------------------------------------------- */ @@ -496,30 +425,21 @@ void PairSNAPKokkos::coeff(int narg, char **arg) Kokkos::deep_copy(d_coeffelem,h_coeffelem); Kokkos::deep_copy(d_map,h_map); - // allocate memory for per OpenMP thread data which - // is wrapped into the sna class - snaKK = SNAKokkos(rfac0,twojmax, rmin0,switchflag,bzeroflag); - snaKK.grow_rij(0); + snaKK.grow_rij(0,0); snaKK.init(); } /* ---------------------------------------------------------------------- */ template -template KOKKOS_INLINE_FUNCTION -void PairSNAPKokkos::operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT& ev) const { - - // The f array is duplicated for OpenMP, atomic for CUDA, and neither for Serial - - auto v_f = ScatterViewHelper::value,decltype(dup_f),decltype(ndup_f)>::get(dup_f,ndup_f); - auto a_f = v_f.template access::value>(); +void PairSNAPKokkos::operator() (TagPairSNAPComputeNeigh,const typename Kokkos::TeamPolicy::member_type& team) const { const int ii = team.league_rank(); - const int i = d_ilist[ii]; - SNAKokkos my_sna(snaKK,team); + const int i = d_ilist[ii + chunk_offset]; + SNAKokkos my_sna = snaKK; const double xtmp = x(i,0); const double ytmp = x(i,1); const double ztmp = x(i,2); @@ -553,6 +473,8 @@ void PairSNAPKokkos::operator() (TagPairSNAPCompute::operator() (TagPairSNAPCompute +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPPreUi,const typename Kokkos::TeamPolicy::member_type& team) const { + const int ii = team.league_rank(); + SNAKokkos my_sna = snaKK; + my_sna.pre_ui(team,ii); +} - my_sna.compute_ui(team,ninside); - team.team_barrier(); +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPComputeUi,const typename Kokkos::TeamPolicy::member_type& team) const { + SNAKokkos my_sna = snaKK; - // for neighbors of I within cutoff: - // compute Fij = dEi/dRj = -dEi/dRi - // add to Fi, subtract from Fj + // Extract the atom number + const int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); + if (ii >= inum) return; - my_sna.compute_yi(team,d_beta,ii); - team.team_barrier(); + // Extract the neighbor number + const int jj = team.league_rank() / ((inum+team.team_size()-1)/team.team_size()); + const int ninside = d_ninside(ii); + if (jj >= ninside) return; - Kokkos::View> - d_coeffi(d_coeffelem,ielem,Kokkos::ALL); + my_sna.compute_ui(team,ii,jj); +} + +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPComputeYi,const typename Kokkos::TeamPolicy::member_type& team) const { + const int ii = team.league_rank(); + SNAKokkos my_sna = snaKK; + my_sna.compute_yi(team,ii,d_beta); +} + +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPComputeZi,const typename Kokkos::TeamPolicy::member_type& team) const { + const int ii = team.league_rank(); + SNAKokkos my_sna = snaKK; + my_sna.compute_zi(team,ii); +} + +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPComputeBi,const typename Kokkos::TeamPolicy::member_type& team) const { + const int ii = team.league_rank(); + SNAKokkos my_sna = snaKK; + my_sna.compute_bi(team,ii); +} + +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPComputeDuidrj,const typename Kokkos::TeamPolicy::member_type& team) const { + SNAKokkos my_sna = snaKK; + + // Extract the atom number + const int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); + if (ii >= inum) return; + + // Extract the neighbor number + const int jj = team.league_rank() / ((inum+team.team_size()-1)/team.team_size()); + const int ninside = d_ninside(ii); + if (jj >= ninside) return; + + my_sna.compute_duidrj(team,ii,jj); +} + +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPComputeDeidrj,const typename Kokkos::TeamPolicy::member_type& team) const { + SNAKokkos my_sna = snaKK; + + // Extract the atom number + const int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); + if (ii >= inum) return; + + // Extract the neighbor number + const int jj = team.league_rank() / ((inum+team.team_size()-1)/team.team_size()); + const int ninside = d_ninside(ii); + if (jj >= ninside) return; + + my_sna.compute_deidrj(team,ii,jj); +} + +template +template +KOKKOS_INLINE_FUNCTION +void PairSNAPKokkos::operator() (TagPairSNAPComputeForce,const typename Kokkos::TeamPolicy >::member_type& team, EV_FLOAT& ev) const { + + // The f array is duplicated for OpenMP, atomic for CUDA, and neither for Serial + + auto v_f = ScatterViewHelper::value,decltype(dup_f),decltype(ndup_f)>::get(dup_f,ndup_f); + auto a_f = v_f.template access::value>(); + + const int ii = team.league_rank(); + const int i = d_ilist[ii + chunk_offset]; + SNAKokkos my_sna = snaKK; + const int ninside = d_ninside(ii); Kokkos::parallel_for (Kokkos::TeamThreadRange(team,ninside), [&] (const int jj) { - //for (int jj = 0; jj < ninside; jj++) { - int j = my_sna.inside[jj]; - - my_sna.compute_duidrj(team,&my_sna.rij(jj,0), - my_sna.wj[jj],my_sna.rcutij[jj],jj); + int j = my_sna.inside(ii,jj); F_FLOAT fij[3]; - my_sna.compute_deidrj(team,fij); + fij[0] = my_sna.dedr(ii,jj,0); + fij[1] = my_sna.dedr(ii,jj,1); + fij[2] = my_sna.dedr(ii,jj,2); Kokkos::single(Kokkos::PerThread(team), [&] (){ a_f(i,0) += fij[0]; @@ -620,8 +623,8 @@ void PairSNAPKokkos::operator() (TagPairSNAPCompute(ev,i,j, fij[0],fij[1],fij[2], - -my_sna.rij(jj,0),-my_sna.rij(jj,1), - -my_sna.rij(jj,2)); + -my_sna.rij(ii,jj,0),-my_sna.rij(ii,jj,1), + -my_sna.rij(ii,jj,2)); } } @@ -633,6 +636,11 @@ void PairSNAPKokkos::operator() (TagPairSNAPCompute> + d_coeffi(d_coeffelem,ielem,Kokkos::ALL); + Kokkos::single(Kokkos::PerTeam(team), [&] () { // evdwl = energy of atom I, sum over coeffs_k * Bi_k @@ -640,21 +648,21 @@ void PairSNAPKokkos::operator() (TagPairSNAPCompute::operator() (TagPairSNAPCompute template KOKKOS_INLINE_FUNCTION -void PairSNAPKokkos::operator() (TagPairSNAPCompute,const typename Kokkos::TeamPolicy >::member_type& team) const { +void PairSNAPKokkos::operator() (TagPairSNAPComputeForce,const typename Kokkos::TeamPolicy >::member_type& team) const { EV_FLOAT ev; - this->template operator()(TagPairSNAPCompute(), team, ev); + this->template operator()(TagPairSNAPComputeForce(), team, ev); } /* ---------------------------------------------------------------------- */ @@ -738,4 +746,5 @@ double PairSNAPKokkos::memory_usage() bytes += snaKK.memory_usage(); return bytes; } + } diff --git a/src/KOKKOS/sna_kokkos.h b/src/KOKKOS/sna_kokkos.h index a53a614229..2dbfdcb47c 100644 --- a/src/KOKKOS/sna_kokkos.h +++ b/src/KOKKOS/sna_kokkos.h @@ -25,6 +25,9 @@ namespace LAMMPS_NS { +typedef double SNAreal; +typedef struct { SNAreal re, im; } SNAcomplex; + struct SNAKK_ZINDICES { int j1, j2, j, ma1min, ma2max, mb1min, mb2max, na, nb, jju; }; @@ -39,12 +42,22 @@ class SNAKokkos { public: typedef Kokkos::View t_sna_1i; typedef Kokkos::View t_sna_1d; - typedef Kokkos::View > t_sna_1d_atomic; - typedef Kokkos::View t_sna_2d; - typedef Kokkos::View t_sna_3d; - typedef Kokkos::View t_sna_4d; - typedef Kokkos::View t_sna_3d3; - typedef Kokkos::View t_sna_5d; + typedef Kokkos::View > t_sna_1d_atomic; + typedef Kokkos::View t_sna_2i; + typedef Kokkos::View t_sna_2d; + typedef Kokkos::View t_sna_3d; + typedef Kokkos::View t_sna_4d; + typedef Kokkos::View t_sna_3d3; + typedef Kokkos::View t_sna_5d; + + typedef Kokkos::View t_sna_1c; + typedef Kokkos::View > t_sna_1c_atomic; + typedef Kokkos::View t_sna_2c; + typedef Kokkos::View t_sna_2c_cpu; + typedef Kokkos::View t_sna_3c; + typedef Kokkos::View t_sna_4c; + typedef Kokkos::View t_sna_3c3; + typedef Kokkos::View t_sna_5c; inline SNAKokkos() {}; @@ -63,36 +76,31 @@ inline inline void init(); // -inline - T_INT size_team_scratch_arrays(); - -inline - T_INT size_thread_scratch_arrays(); - double memory_usage(); int ncoeff; // functions for bispectrum coefficients - KOKKOS_INLINE_FUNCTION - void compute_ui(const typename Kokkos::TeamPolicy::member_type& team, int); // ForceSNAP + void pre_ui(const typename Kokkos::TeamPolicy::member_type& team, int); // ForceSNAP + KOKKOS_INLINE_FUNCTION + void compute_ui(const typename Kokkos::TeamPolicy::member_type& team, int, int); // ForceSNAP + KOKKOS_INLINE_FUNCTION + void compute_ui_orig(const typename Kokkos::TeamPolicy::member_type& team, int, int); // ForceSNAP KOKKOS_INLINE_FUNCTION - void compute_zi(const typename Kokkos::TeamPolicy::member_type& team); // ForceSNAP + void compute_zi(const typename Kokkos::TeamPolicy::member_type& team, int); // ForceSNAP KOKKOS_INLINE_FUNCTION - void compute_yi(const typename Kokkos::TeamPolicy::member_type& team, - const Kokkos::View &beta, const int ii); // ForceSNAP + void compute_yi(const typename Kokkos::TeamPolicy::member_type& team, int, + const Kokkos::View &beta); // ForceSNAP KOKKOS_INLINE_FUNCTION - void compute_bi(const typename Kokkos::TeamPolicy::member_type& team); // ForceSNAP + void compute_bi(const typename Kokkos::TeamPolicy::member_type& team, int); // ForceSNAP // functions for derivatives KOKKOS_INLINE_FUNCTION - void compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, double*, double, double, int); //ForceSNAP + void compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, int, int); //ForceSNAP KOKKOS_INLINE_FUNCTION - void compute_dbidrj(const typename Kokkos::TeamPolicy::member_type& team); //ForceSNAP - KOKKOS_INLINE_FUNCTION - void compute_deidrj(const typename Kokkos::TeamPolicy::member_type& team, double *); // ForceSNAP + void compute_deidrj(const typename Kokkos::TeamPolicy::member_type& team, int, int); // ForceSNAP KOKKOS_INLINE_FUNCTION double compute_sfac(double, double); // add_uarraytot, compute_duarray KOKKOS_INLINE_FUNCTION @@ -109,29 +117,26 @@ inline // Per InFlight Particle - t_sna_2d rij; - t_sna_1i inside; - t_sna_1d wj; - t_sna_1d rcutij; - int nmax; + t_sna_3d rij; + t_sna_2i inside; + t_sna_2d wj; + t_sna_2d rcutij; + t_sna_3d dedr; + int natom, nmax; - void grow_rij(int); + void grow_rij(int, int); int twojmax, diagonalstyle; - // Per InFlight Particle - t_sna_1d blist; - t_sna_1d ulisttot_r, ulisttot_i; - t_sna_1d_atomic ulisttot_r_a, ulisttot_i_a; - t_sna_1d zlist_r, zlist_i; - t_sna_2d ulist_r_ij, ulist_i_ij; + + t_sna_2d blist; + t_sna_2c_cpu ulisttot; + t_sna_2c zlist; - // Per InFlight Interaction - t_sna_1d ulist_r, ulist_i; - t_sna_1d_atomic ylist_r, ylist_i; + t_sna_3c ulist; + t_sna_2c ylist; // derivatives of data - t_sna_2d dulist_r, dulist_i; - t_sna_2d dblist; + t_sna_4c dulist; private: double rmin0, rfac0; @@ -168,14 +173,14 @@ inline inline void init_rootpqarray(); // init() KOKKOS_INLINE_FUNCTION - void zero_uarraytot(const typename Kokkos::TeamPolicy::member_type& team); // compute_ui + void zero_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, int); // compute_ui KOKKOS_INLINE_FUNCTION - void addself_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double); // compute_ui + void addself_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, int, double); // compute_ui KOKKOS_INLINE_FUNCTION - void add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double, double, double, int); // compute_ui + void add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, int, int, double, double, double); // compute_ui KOKKOS_INLINE_FUNCTION - void compute_uarray(const typename Kokkos::TeamPolicy::member_type& team, + void compute_uarray(const typename Kokkos::TeamPolicy::member_type& team, int, int, double, double, double, double, double); // compute_ui inline @@ -184,9 +189,9 @@ inline inline int compute_ncoeff(); // SNAKokkos() KOKKOS_INLINE_FUNCTION - void compute_duarray(const typename Kokkos::TeamPolicy::member_type& team, + void compute_duarray(const typename Kokkos::TeamPolicy::member_type& team, int, int, double, double, double, // compute_duidrj - double, double, double, double, double, int); + double, double, double, double, double); // Sets the style for the switching function // 0 = none @@ -197,7 +202,7 @@ inline double wself; int bzero_flag; // 1 if bzero subtracted from barray - Kokkos::View bzero; // array of B values for isolated atoms + Kokkos::View bzero; // array of B values for isolated atoms }; } diff --git a/src/KOKKOS/sna_kokkos_impl.h b/src/KOKKOS/sna_kokkos_impl.h index f0d45cb5c2..36765e9cd6 100644 --- a/src/KOKKOS/sna_kokkos_impl.h +++ b/src/KOKKOS/sna_kokkos_impl.h @@ -41,8 +41,6 @@ SNAKokkos::SNAKokkos(double rfac0_in, ncoeff = compute_ncoeff(); - //create_twojmax_arrays(); - nmax = 0; build_indexlist(); @@ -63,37 +61,6 @@ SNAKokkos::SNAKokkos(double rfac0_in, } } -template -KOKKOS_INLINE_FUNCTION -SNAKokkos::SNAKokkos(const SNAKokkos& sna, const typename Kokkos::TeamPolicy::member_type& team) { - wself = sna.wself; - - rfac0 = sna.rfac0; - rmin0 = sna.rmin0; - switch_flag = sna.switch_flag; - bzero_flag = sna.bzero_flag; - - twojmax = sna.twojmax; - - ncoeff = sna.ncoeff; - nmax = sna.nmax; - idxz = sna.idxz; - idxb = sna.idxb; - idxcg_max = sna.idxcg_max; - idxu_max = sna.idxu_max; - idxz_max = sna.idxz_max; - idxb_max = sna.idxb_max; - idxcg_block = sna.idxcg_block; - idxu_block = sna.idxu_block; - idxz_block = sna.idxz_block; - idxb_block = sna.idxb_block; - cglist = sna.cglist; - rootpqarray = sna.rootpqarray; - bzero = sna.bzero; - create_team_scratch_arrays(team); - create_thread_scratch_arrays(team); -} - /* ---------------------------------------------------------------------- */ template @@ -245,18 +212,80 @@ void SNAKokkos::init() template inline -void SNAKokkos::grow_rij(int newnmax) +void SNAKokkos::grow_rij(int newnatom, int newnmax) { - if(newnmax <= nmax) return; + if(newnatom <= natom && newnmax <= nmax) return; + natom = newnatom; nmax = newnmax; + + rij = t_sna_3d("sna:rij",natom,nmax,3); + inside = t_sna_2i("sna:inside",natom,nmax); + wj = t_sna_2d("sna:wj",natom,nmax); + rcutij = t_sna_2d("sna:rcutij",natom,nmax); + dedr = t_sna_3d("sna:dedr",natom,nmax,3); + + blist = t_sna_2d("sna:blist",natom,idxb_max); + ulisttot = t_sna_2c_cpu("sna:ulisttot",natom,idxu_max); + zlist = t_sna_2c("sna:zlist",natom,idxz_max); + + ulist = t_sna_3c("sna:ulist",natom,nmax,idxu_max); + ylist = t_sna_2c("sna:ylist",natom,idxu_max); + + dulist = t_sna_4c("sna:dulist",natom,nmax,idxu_max); } + +/* ---------------------------------------------------------------------- + * compute Ui by summing over neighbors j + * ------------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void SNAKokkos::pre_ui(const typename Kokkos::TeamPolicy::member_type& team, int iatom) +{ + if(team.team_rank() == 0) { + zero_uarraytot(team,iatom); + //Kokkos::single(Kokkos::PerThread(team), [&] (){ + addself_uarraytot(team,iatom,wself); + //}); + } + team.team_barrier(); +} + /* ---------------------------------------------------------------------- compute Ui by summing over neighbors j ------------------------------------------------------------------------- */ template KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_ui(const typename Kokkos::TeamPolicy::member_type& team, int jnum) +void SNAKokkos::compute_ui(const typename Kokkos::TeamPolicy::member_type& team, int iatom, int jnbor) +{ + double rsq, r, x, y, z, z0, theta0; + + // utot(j,ma,mb) = 0 for all j,ma,ma + // utot(j,ma,ma) = 1 for all j,ma + // for j in neighbors of i: + // compute r0 = (x,y,z,z0) + // utot(j,ma,mb) += u(r0;j,ma,mb) for all j,ma,mb + + x = rij(iatom,jnbor,0); + y = rij(iatom,jnbor,1); + z = rij(iatom,jnbor,2); + rsq = x * x + y * y + z * z; + r = sqrt(rsq); + + theta0 = (r - rmin0) * rfac0 * MY_PI / (rcutij(iatom,jnbor) - rmin0); + // theta0 = (r - rmin0) * rscale0; + z0 = r / tan(theta0); + + compute_uarray(team, iatom, jnbor, x, y, z, z0, r); + //Kokkos::single(Kokkos::PerThread(team), [&] (){ + add_uarraytot(team, iatom, jnbor, r, wj(iatom,jnbor), rcutij(iatom,jnbor)); + //}); +} + +template +KOKKOS_INLINE_FUNCTION +void SNAKokkos::compute_ui_orig(const typename Kokkos::TeamPolicy::member_type& team, int iatom, int jnum) { double rsq, r, x, y, z, z0, theta0; @@ -267,9 +296,9 @@ void SNAKokkos::compute_ui(const typename Kokkos::TeamPolicy::compute_ui(const typename Kokkos::TeamPolicy::compute_ui(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_zi(const typename Kokkos::TeamPolicy::member_type& team) +void SNAKokkos::compute_zi(const typename Kokkos::TeamPolicy::member_type& team, int iatom) { Kokkos::parallel_for(Kokkos::TeamThreadRange(team,idxz_max), [&] (const int& jjz) { @@ -318,8 +347,8 @@ void SNAKokkos::compute_zi(const typename Kokkos::TeamPolicy::compute_zi(const typename Kokkos::TeamPolicy::compute_zi(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_yi(const typename Kokkos::TeamPolicy::member_type& team, - const Kokkos::View &beta, const int ii) +void SNAKokkos::compute_yi(const typename Kokkos::TeamPolicy::member_type& team, int iatom, + const Kokkos::View &beta) { double betaj; + const int ii = iatom; { - double* const ptr = ylist_r.data(); - Kokkos::parallel_for(Kokkos::TeamThreadRange(team,ylist_r.span()), + Kokkos::parallel_for(Kokkos::TeamThreadRange(team,ylist.extent(1)), [&] (const int& i) { - ptr[i] = 0.0; - }); - } - { - double* const ptr = ylist_i.data(); - Kokkos::parallel_for(Kokkos::TeamThreadRange(team,ylist_i.span()), - [&] (const int& i) { - ptr[i] = 0.0; + ylist(iatom,i).re = 0.0; + ylist(iatom,i).im = 0.0; }); } + //int flopsum = 0; + Kokkos::parallel_for(Kokkos::TeamThreadRange(team,idxz_max), [&] (const int& jjz) { //for(int jjz = 0; jjz < idxz_max; jjz++) { @@ -410,18 +430,15 @@ void SNAKokkos::compute_yi(const typename Kokkos::TeamPolicy::compute_yi(const typename Kokkos::TeamPolicy::compute_yi(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_deidrj(const typename Kokkos::TeamPolicy::member_type& team, double* dedr) +void SNAKokkos::compute_deidrj(const typename Kokkos::TeamPolicy::member_type& team, int iatom, int jnbor) { t_scalar3 sum; @@ -482,9 +501,9 @@ void SNAKokkos::compute_deidrj(const typename Kokkos::TeamPolicy::compute_deidrj(const typename Kokkos::TeamPolicy::compute_deidrj(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_bi(const typename Kokkos::TeamPolicy::member_type& team) +void SNAKokkos::compute_bi(const typename Kokkos::TeamPolicy::member_type& team, int iatom) { // for j1 = 0,...,twojmax // for j2 = 0,twojmax @@ -555,8 +575,8 @@ void SNAKokkos::compute_bi(const typename Kokkos::TeamPolicy::compute_bi(const typename Kokkos::TeamPolicy::compute_bi(const typename Kokkos::TeamPolicy::compute_bi(const typename Kokkos::TeamPolicy -KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_dbidrj(const typename Kokkos::TeamPolicy::member_type& team) -{ - // for j1 = 0,...,twojmax - // for j2 = 0,twojmax - // for j = |j1-j2|,Min(twojmax,j1+j2),2 - // zdb = 0 - // for mb = 0,...,jmid - // for ma = 0,...,j - // zdb += - // Conj(dudr(j,ma,mb))*z(j1,j2,j,ma,mb) - // dbdr(j1,j2,j) += 2*zdb - // zdb = 0 - // for mb1 = 0,...,j1mid - // for ma1 = 0,...,j1 - // zdb += - // Conj(dudr(j1,ma1,mb1))*z(j,j2,j1,ma1,mb1) - // dbdr(j1,j2,j) += 2*zdb*(j+1)/(j1+1) - // zdb = 0 - // for mb2 = 0,...,j2mid - // for ma2 = 0,...,j2 - // zdb += - // Conj(dudr(j2,ma2,mb2))*z(j1,j,j2,ma2,mb2) - // dbdr(j1,j2,j) += 2*zdb*(j+1)/(j2+1) - - - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,idxb_max), - [&] (const int& jjb) { - //for(int jjb = 0; jjb < idxb_max; jjb++) { - const int j1 = idxb[jjb].j1; - const int j2 = idxb[jjb].j2; - const int j = idxb[jjb].j; - -// dbdr = dblist(jjb); -// dbdr[0] = 0.0; -// dbdr[1] = 0.0; -// dbdr[2] = 0.0; - - t_scalar3 dbdr,sumzdu_r; - // Sum terms Conj(dudr(j,ma,mb))*z(j1,j2,j,ma,mb) - - int jjz = idxz_block(j1,j2,j); - int jju = idxu_block[j]; - - for(int mb = 0; 2*mb < j; mb++) - for(int ma = 0; ma <= j; ma++) { - const int jju_index = jju+mb*(j+1)+ma; - const int jjz_index = jjz+mb*(j+1)+ma; - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); - } //end loop over ma mb - - // For j even, handle middle column - - if (j%2 == 0) { - int mb = j/2; - for(int ma = 0; ma <= mb; ma++) { - const int jju_index = jju+(mb-1)*(j+1)+(j+1)+ma; - const int jjz_index = jjz+(mb-1)*(j+1)+(j+1)+ma; - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); - } - int ma = mb; - const int jju_index = jju+(mb-1)*(j+1)+(j+1)+ma; - const int jjz_index = jjz+(mb-1)*(j+1)+(j+1)+ma; - for(int k = 0; k < 3; k++) { - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz] + dulist_i(jju_index,0) * zlist_i[jjz_index])*0.5; - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz] + dulist_i(jju_index,1) * zlist_i[jjz_index])*0.5; - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz] + dulist_i(jju_index,2) * zlist_i[jjz_index])*0.5; - } - } // end if jeven - - dbdr += 2.0*sumzdu_r; - - // Sum over Conj(dudr(j1,ma1,mb1))*z(j,j2,j1,ma1,mb1) - - double j1fac = (j+1)/(j1+1.0); - - jjz = idxz_block(j,j2,j1); - jju = idxu_block[j1]; - - sumzdu_r.x = 0.0; sumzdu_r.y = 0.0; sumzdu_r.z = 0.0; - - for(int mb = 0; 2*mb < j1; mb++) - for(int ma = 0; ma <= j1; ma++) { - const int jju_index = jju+mb*(j1+1)+ma; - const int jjz_index = jjz+mb*(j1+1)+ma; - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); - } //end loop over ma1 mb1 - - // For j1 even, handle middle column - - if (j1%2 == 0) { - const int mb = j1/2; - for(int ma = 0; ma <= mb; ma++) { - const int jju_index = jju+(mb-1)*(j1+1)+(j1+1)+ma; - const int jjz_index = jjz+(mb-1)*(j1+1)+(j1+1)+ma; - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); - } - int ma = mb; - const int jju_index = jju+(mb-1)*(j1+1)+(j1+1)+ma; - const int jjz_index = jjz+(mb-1)*(j1+1)+(j1+1)+ma; - for(int k = 0; k < 3; k++) { - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz] + dulist_i(jju_index,0) * zlist_i[jjz_index])*0.5; - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz] + dulist_i(jju_index,1) * zlist_i[jjz_index])*0.5; - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz] + dulist_i(jju_index,2) * zlist_i[jjz_index])*0.5; - } - } // end if j1even - - dbdr += 2.0*sumzdu_r*j1fac; - - // Sum over Conj(dudr(j2,ma2,mb2))*z(j1,j,j2,ma2,mb2) - - double j2fac = (j+1)/(j2+1.0); - - jjz = idxz_block(j,j1,j2); - jju = idxu_block[j2]; - - sumzdu_r.x = 0.0; sumzdu_r.y = 0.0; sumzdu_r.z = 0.0; - - for(int mb = 0; 2*mb < j2; mb++) - for(int ma = 0; ma <= j2; ma++) { - const int jju_index = jju+mb*(j2+1)+ma; - const int jjz_index = jjz+mb*(j2+1)+ma; - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); - } //end loop over ma2 mb2 - - // For j2 even, handle middle column - - if (j2%2 == 0) { - const int mb = j2/2; - for(int ma = 0; ma <= mb; ma++) { - const int jju_index = jju+(mb-1)*(j2+1)+(j2+1)+ma; - const int jjz_index = jjz+(mb-1)*(j2+1)+(j2+1)+ma; - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz_index] + dulist_i(jju_index,0) * zlist_i[jjz_index]); - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz_index] + dulist_i(jju_index,1) * zlist_i[jjz_index]); - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz_index] + dulist_i(jju_index,2) * zlist_i[jjz_index]); - } - int ma = mb; - const int jju_index = jju+(mb-1)*(j2+1)+(j2+1)+ma; - const int jjz_index = jjz+(mb-1)*(j2+1)+(j2+1)+ma; - for(int k = 0; k < 3; k++) { - sumzdu_r.x += (dulist_r(jju_index,0) * zlist_r[jjz] + dulist_i(jju_index,0) * zlist_i[jjz_index])*0.5; - sumzdu_r.y += (dulist_r(jju_index,1) * zlist_r[jjz] + dulist_i(jju_index,1) * zlist_i[jjz_index])*0.5; - sumzdu_r.z += (dulist_r(jju_index,2) * zlist_r[jjz] + dulist_i(jju_index,2) * zlist_i[jjz_index])*0.5; - } - } // end if j2even - - dbdr += 2.0*sumzdu_r*j2fac; - dblist(jjb,0) = dbdr.x; - dblist(jjb,1) = dbdr.y; - dblist(jjb,2) = dbdr.z; - - }); //end loop over j1 j2 j -} - /* ---------------------------------------------------------------------- calculate derivative of Ui w.r.t. atom j ------------------------------------------------------------------------- */ template KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, - double* rij, double wj, double rcut, int jj) +void SNAKokkos::compute_duidrj(const typename Kokkos::TeamPolicy::member_type& team, int iatom, int jnbor) { double rsq, r, x, y, z, z0, theta0, cs, sn; double dz0dr; - x = rij[0]; - y = rij[1]; - z = rij[2]; + x = rij(iatom,jnbor,0); + y = rij(iatom,jnbor,1); + z = rij(iatom,jnbor,2); rsq = x * x + y * y + z * z; r = sqrt(rsq); - double rscale0 = rfac0 * MY_PI / (rcut - rmin0); + double rscale0 = rfac0 * MY_PI / (rcutij(iatom,jnbor) - rmin0); theta0 = (r - rmin0) * rscale0; cs = cos(theta0); sn = sin(theta0); z0 = r * cs / sn; dz0dr = z0 / r - (r*rscale0) * (rsq + z0 * z0) / rsq; - compute_duarray(team, x, y, z, z0, r, dz0dr, wj, rcut, jj); + compute_duarray(team, iatom, jnbor, x, y, z, z0, r, dz0dr, wj(iatom,jnbor), rcutij(iatom,jnbor)); } /* ---------------------------------------------------------------------- */ template KOKKOS_INLINE_FUNCTION -void SNAKokkos::zero_uarraytot(const typename Kokkos::TeamPolicy::member_type& team) +void SNAKokkos::zero_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, int iatom) { { - double* const ptr = ulisttot_r.data(); - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot_r.span()), - [&] (const int& i) { - ptr[i] = 0.0; - }); - } - { - double* const ptr = ulisttot_i.data(); - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot_i.span()), + Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot.extent(1)), [&] (const int& i) { - ptr[i] = 0.0; + ulisttot(iatom,i).re = 0.0; + ulisttot(iatom,i).im = 0.0; }); } } @@ -822,15 +663,15 @@ void SNAKokkos::zero_uarraytot(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION -void SNAKokkos::addself_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, double wself_in) +void SNAKokkos::addself_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, int iatom, double wself_in) { Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,twojmax+1), [&] (const int& j) { //for (int j = 0; j <= twojmax; j++) int jju = idxu_block[j]; for (int ma = 0; ma <= j; ma++) { - ulisttot_r[jju] = wself_in; - ulisttot_i[jju] = 0.0; + ulisttot(iatom,jju).re = wself_in; + ulisttot(iatom,jju).im = 0.0; jju += j+2; } }); @@ -842,28 +683,15 @@ void SNAKokkos::addself_uarraytot(const typename Kokkos::TeamPolicy< template KOKKOS_INLINE_FUNCTION -void SNAKokkos::add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, - double r, double wj, double rcut, int j) +void SNAKokkos::add_uarraytot(const typename Kokkos::TeamPolicy::member_type& team, int iatom, int jnbor, + double r, double wj, double rcut) { const double sfac = compute_sfac(r, rcut) * wj; - const double* const ptr_r = ulist_r.data(); - const double* const ptr_i = ulist_i.data(); - double* const ptrtot_r = ulisttot_r.data(); - double* const ptrtot_i = ulisttot_i.data(); - - Kokkos::View> - ulist_r_j(ulist_r_ij,j,Kokkos::ALL); - Kokkos::View> - ulist_i_j(ulist_i_ij,j,Kokkos::ALL); - - Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot_r.span()), + Kokkos::parallel_for(Kokkos::ThreadVectorRange(team,ulisttot.extent(1)), [&] (const int& i) { - Kokkos::atomic_add(ptrtot_r+i, sfac * ptr_r[i]); - Kokkos::atomic_add(ptrtot_i+i, sfac * ptr_i[i]); - - ulist_r_j(i) = ulist_r(i); - ulist_i_j(i) = ulist_i(i); + Kokkos::atomic_add(&(ulisttot(iatom,i).re), sfac * ulist(iatom,jnbor,i).re); + Kokkos::atomic_add(&(ulisttot(iatom,i).im), sfac * ulist(iatom,jnbor,i).im); }); } @@ -873,7 +701,7 @@ void SNAKokkos::add_uarraytot(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_uarray(const typename Kokkos::TeamPolicy::member_type& team, +void SNAKokkos::compute_uarray(const typename Kokkos::TeamPolicy::member_type& team, int iatom, int jnbor, double x, double y, double z, double z0, double r) { @@ -891,8 +719,8 @@ void SNAKokkos::compute_uarray(const typename Kokkos::TeamPolicy::compute_uarray(const typename Kokkos::TeamPolicy::compute_uarray(const typename Kokkos::TeamPolicy::compute_uarray(const typename Kokkos::TeamPolicy KOKKOS_INLINE_FUNCTION -void SNAKokkos::compute_duarray(const typename Kokkos::TeamPolicy::member_type& team, +void SNAKokkos::compute_duarray(const typename Kokkos::TeamPolicy::member_type& team, int iatom, int jnbor, double x, double y, double z, double z0, double r, double dz0dr, - double wj, double rcut, int jj) + double wj, double rcut) { double r0inv; double a_r, a_i, b_r, b_i; @@ -1012,17 +840,12 @@ void SNAKokkos::compute_duarray(const typename Kokkos::TeamPolicy> - ulist_r(ulist_r_ij,jj,Kokkos::ALL); - Kokkos::View> - ulist_i(ulist_i_ij,jj,Kokkos::ALL); - - dulist_r(0,0) = 0.0; - dulist_r(0,1) = 0.0; - dulist_r(0,2) = 0.0; - dulist_i(0,0) = 0.0; - dulist_i(0,1) = 0.0; - dulist_i(0,2) = 0.0; + dulist(iatom,jnbor,0,0).re = 0.0; + dulist(iatom,jnbor,0,1).re = 0.0; + dulist(iatom,jnbor,0,2).re = 0.0; + dulist(iatom,jnbor,0,0).im = 0.0; + dulist(iatom,jnbor,0,1).im = 0.0; + dulist(iatom,jnbor,0,2).im = 0.0; for (int j = 1; j <= twojmax; j++) { int jju = idxu_block[j]; @@ -1031,42 +854,42 @@ void SNAKokkos::compute_duarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy::compute_duarray(const typename Kokkos::TeamPolicy -KOKKOS_INLINE_FUNCTION -void SNAKokkos::create_team_scratch_arrays(const typename Kokkos::TeamPolicy::member_type& team) -{ - ulisttot_r_a = ulisttot_r = t_sna_1d(team.team_scratch(1),idxu_max); - ulisttot_i_a = ulisttot_i = t_sna_1d(team.team_scratch(1),idxu_max); - ylist_r = t_sna_1d(team.team_scratch(1),idxu_max); - ylist_i = t_sna_1d(team.team_scratch(1),idxu_max); - zlist_r = t_sna_1d(team.team_scratch(1),idxz_max); - zlist_i = t_sna_1d(team.team_scratch(1),idxz_max); - blist = t_sna_1d(team.team_scratch(1),idxb_max); - - rij = t_sna_2d(team.team_scratch(1),nmax,3); - rcutij = t_sna_1d(team.team_scratch(1),nmax); - wj = t_sna_1d(team.team_scratch(1),nmax); - inside = t_sna_1i(team.team_scratch(1),nmax); - ulist_r_ij = t_sna_2d(team.team_scratch(1),nmax,idxu_max); - ulist_i_ij = t_sna_2d(team.team_scratch(1),nmax,idxu_max); -} - -template -inline -T_INT SNAKokkos::size_team_scratch_arrays() { - T_INT size = 0; - - size += t_sna_1d::shmem_size(idxu_max)*2; // ulisttot - size += t_sna_1d::shmem_size(idxu_max)*2; // ylist - size += t_sna_1d::shmem_size(idxz_max)*2; // zlist - size += t_sna_1d::shmem_size(idxb_max); // blist - - size += t_sna_2d::shmem_size(nmax,3); // rij - size += t_sna_1d::shmem_size(nmax); // rcutij - size += t_sna_1d::shmem_size(nmax); // wj - size += t_sna_1i::shmem_size(nmax); // inside - size += t_sna_2d::shmem_size(nmax,idxu_max)*2; // ulist_ij - - return size; -} - -/* ---------------------------------------------------------------------- */ - -template -KOKKOS_INLINE_FUNCTION -void SNAKokkos::create_thread_scratch_arrays(const typename Kokkos::TeamPolicy::member_type& team) -{ - dblist = t_sna_2d(team.thread_scratch(1),idxb_max,3); - ulist_r = t_sna_1d(team.thread_scratch(1),idxu_max); - ulist_i = t_sna_1d(team.thread_scratch(1),idxu_max); - dulist_r = t_sna_2d(team.thread_scratch(1),idxu_max,3); - dulist_i = t_sna_2d(team.thread_scratch(1),idxu_max,3); -} - -template -inline -T_INT SNAKokkos::size_thread_scratch_arrays() { - T_INT size = 0; - - size += t_sna_2d::shmem_size(idxb_max,3); // dblist - size += t_sna_1d::shmem_size(idxu_max)*2; // ulist - size += t_sna_2d::shmem_size(idxu_max,3)*2; // dulist - return size; -} - /* ---------------------------------------------------------------------- factorial n, wrapper for precomputed table ------------------------------------------------------------------------- */ @@ -1558,14 +1316,13 @@ double SNAKokkos::memory_usage() bytes += jdimpq*jdimpq * sizeof(double); // pqarray bytes += idxcg_max * sizeof(double); // cglist - bytes += idxu_max * sizeof(double) * 2; // ulist - bytes += idxu_max * sizeof(double) * 2; // ulisttot - bytes += idxu_max * 3 * sizeof(double) * 2; // dulist - - bytes += idxz_max * sizeof(double) * 2; // zlist - bytes += idxb_max * sizeof(double); // blist - bytes += idxb_max * 3 * sizeof(double); // dblist - bytes += idxu_max * sizeof(double) * 2; // ylist + bytes += natom * idxu_max * sizeof(double) * 2; // ulist + bytes += natom * idxu_max * sizeof(double) * 2; // ulisttot + bytes += natom * idxu_max * 3 * sizeof(double) * 2; // dulist + + bytes += natom * idxz_max * sizeof(double) * 2; // zlist + bytes += natom * idxb_max * sizeof(double); // blist + bytes += natom * idxu_max * sizeof(double) * 2; // ylist bytes += jdim * jdim * jdim * sizeof(int); // idxcg_block bytes += jdim * sizeof(int); // idxu_block @@ -1577,11 +1334,11 @@ double SNAKokkos::memory_usage() bytes += jdim * sizeof(double); // bzero - bytes += nmax * 3 * sizeof(double); // rij - bytes += nmax * sizeof(int); // inside - bytes += nmax * sizeof(double); // wj - bytes += nmax * sizeof(double); // rcutij - bytes += nmax * idxu_max * sizeof(double) * 2; // ulist_ij + bytes += natom * nmax * 3 * sizeof(double); // rij + bytes += natom * nmax * sizeof(int); // inside + bytes += natom * nmax * sizeof(double); // wj + bytes += natom * nmax * sizeof(double); // rcutij + bytes += natom * nmax * idxu_max * sizeof(double) * 2; // ulist_ij return bytes; } -- GitLab From 3acb09e3b10d81ff26d1cf58996271a6dcaf6991 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 19 Jul 2019 11:09:47 +0100 Subject: [PATCH 267/469] Corrected virial, altered calculation of stacking strength --- doc/src/pair_oxdna.txt | 8 +- doc/src/pair_oxdna2.txt | 12 +- src/USER-CGDNA/bond_oxdna2_fene.cpp | 4 +- src/USER-CGDNA/bond_oxdna2_fene.h | 3 +- src/USER-CGDNA/bond_oxdna_fene.cpp | 98 ++++++++++++++- src/USER-CGDNA/bond_oxdna_fene.h | 4 +- src/USER-CGDNA/pair_oxdna2_coaxstk.cpp | 6 +- src/USER-CGDNA/pair_oxdna2_dh.cpp | 8 +- src/USER-CGDNA/pair_oxdna2_excv.cpp | 4 +- src/USER-CGDNA/pair_oxdna2_excv.h | 2 +- src/USER-CGDNA/pair_oxdna2_stk.cpp | 50 -------- src/USER-CGDNA/pair_oxdna2_stk.h | 53 --------- src/USER-CGDNA/pair_oxdna_coaxstk.cpp | 6 +- src/USER-CGDNA/pair_oxdna_excv.cpp | 44 +++---- src/USER-CGDNA/pair_oxdna_excv.h | 2 +- src/USER-CGDNA/pair_oxdna_hbond.cpp | 6 +- src/USER-CGDNA/pair_oxdna_stk.cpp | 159 ++++++++++++++++++++----- src/USER-CGDNA/pair_oxdna_stk.h | 4 +- src/USER-CGDNA/pair_oxdna_xstk.cpp | 6 +- 19 files changed, 294 insertions(+), 185 deletions(-) delete mode 100644 src/USER-CGDNA/pair_oxdna2_stk.cpp delete mode 100644 src/USER-CGDNA/pair_oxdna2_stk.h diff --git a/doc/src/pair_oxdna.txt b/doc/src/pair_oxdna.txt index b63b5371cf..dfcd93c9a8 100644 --- a/doc/src/pair_oxdna.txt +++ b/doc/src/pair_oxdna.txt @@ -23,9 +23,11 @@ style1 = {hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxs style2 = {oxdna/excv} or {oxdna/stk} or {oxdna/hbond} or {oxdna/xstk} or {oxdna/coaxstk} args = list of arguments for these particular styles :ul - {oxdna/stk} args = seq T 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 + {oxdna/stk} args = seq T xi kappa 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 seq = seqav (for average sequence stacking strength) or seqdep (for sequence-dependent stacking strength) T = temperature (oxDNA units, 0.1 = 300 K) + xi = temperature-independent coefficient in stacking strength + kappa = coefficient of linear temperature dependence in stacking strength {oxdna/hbond} args = seq eps 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 seq = seqav (for average sequence base-pairing strength) or seqdep (for sequence-dependent base-pairing strength) eps = 1.077 (between base pairs A-T and C-G) or 0 (all other pairs) :pre @@ -34,7 +36,7 @@ args = list of arguments for these particular styles :ul pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna/stk seqdep 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/stk seqdep 0.1 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 pair_coeff * * oxdna/hbond seqdep 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 1 4 oxdna/hbond seqdep 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 2 3 oxdna/hbond seqdep 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 @@ -62,7 +64,7 @@ NOTE: These pair styles have to be used together with the related oxDNA bond sty {oxdna/fene} for the connectivity of the phosphate backbone (see also documentation of "bond_style oxdna/fene"_bond_oxdna.html). Most of the coefficients in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. -Exceptions are the first and second coefficient after {oxdna/stk} (seq=seqdep and T=0.1 in the above example) +Exceptions are the first four coefficients after {oxdna/stk} (seq=seqdep, T=0.1, xi=1.3448 and kappa=2.6568 in the above example) and the first coefficient after {oxdna/hbond} (seq=seqdep in the above example). When using a Langevin thermostat, e.g. through "fix langevin"_fix_langevin.html or "fix nve/dotc/langevin"_fix_nve_dotc_langevin.html diff --git a/doc/src/pair_oxdna2.txt b/doc/src/pair_oxdna2.txt index f2963f7b17..3e462f384d 100644 --- a/doc/src/pair_oxdna2.txt +++ b/doc/src/pair_oxdna2.txt @@ -24,10 +24,12 @@ style1 = {hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/ style2 = {oxdna2/excv} or {oxdna2/stk} or {oxdna2/hbond} or {oxdna2/xstk} or {oxdna2/coaxstk} or {oxdna2/dh} args = list of arguments for these particular styles :ul - {oxdna2/stk} args = seq T 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 + {oxdna2/stk} args = seq T xi kappa 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 seq = seqav (for average sequence stacking strength) or seqdep (for sequence-dependent stacking strength) T = temperature (oxDNA units, 0.1 = 300 K) - {oxdna/hbond} args = seq eps 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 + xi = temperature-independent coefficient in stacking strength + kappa = coefficient of linear temperature dependence in stacking strength + {oxdna2/hbond} args = seq eps 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 seq = seqav (for average sequence base-pairing strength) or seqdep (for sequence-dependent base-pairing strength) eps = 1.0678 (between base pairs A-T and C-G) or 0 (all other pairs) {oxdna2/dh} args = T rhos qeff @@ -39,7 +41,7 @@ args = list of arguments for these particular styles :ul pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna2/stk seqdep 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqdep 0.1 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 pair_coeff * * oxdna2/hbond seqdep 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 1 4 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 2 3 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 @@ -68,8 +70,8 @@ NOTE: These pair styles have to be used together with the related oxDNA2 bond st {oxdna2/fene} for the connectivity of the phosphate backbone (see also documentation of "bond_style oxdna2/fene"_bond_oxdna.html). Most of the coefficients in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. -Exceptions are the first and the second coefficient after {oxdna2/stk} (seq=seqdep and T=0.1 in the above example), -the first coefficient after {oxdna/hbond} (seq=seqdep in the above example) and the three coefficients +Exceptions are the first four coefficients after {oxdna2/stk} (seq=seqdep, T=0.1, xi=1.3523 and kappa=2.6717 in the above example), +the first coefficient after {oxdna2/hbond} (seq=seqdep in the above example) and the three coefficients after {oxdna2/dh} (T=0.1, rhos=1.0, qeff=0.815 in the above example). When using a Langevin thermostat e.g. through "fix langevin"_fix_langevin.html or "fix nve/dotc/langevin"_fix_nve_dotc_langevin.html the temperature coefficients have to be matched to the one used in the fix. diff --git a/src/USER-CGDNA/bond_oxdna2_fene.cpp b/src/USER-CGDNA/bond_oxdna2_fene.cpp index 39cbb04f88..557d62aac6 100644 --- a/src/USER-CGDNA/bond_oxdna2_fene.cpp +++ b/src/USER-CGDNA/bond_oxdna2_fene.cpp @@ -37,8 +37,8 @@ BondOxdna2Fene::~BondOxdna2Fene() /* ---------------------------------------------------------------------- compute vector COM-sugar-phosphate backbone interaction site in oxDNA2 ------------------------------------------------------------------------- */ -void BondOxdna2Fene::compute_interaction_sites(double e1[3], - double e2[3], double r[3]) +void BondOxdna2Fene::compute_interaction_sites(double e1[3], double e2[3], + double /*e3*/[3], double r[3]) { double d_cs_x=-0.34, d_cs_y=+0.3408; diff --git a/src/USER-CGDNA/bond_oxdna2_fene.h b/src/USER-CGDNA/bond_oxdna2_fene.h index 0654c37a9c..4bcce337ed 100644 --- a/src/USER-CGDNA/bond_oxdna2_fene.h +++ b/src/USER-CGDNA/bond_oxdna2_fene.h @@ -28,7 +28,8 @@ class BondOxdna2Fene : public BondOxdnaFene { public: BondOxdna2Fene(class LAMMPS *); virtual ~BondOxdna2Fene(); - virtual void compute_interaction_sites(double *, double *, double *); + virtual void compute_interaction_sites(double *, double *, double *, + double *); }; } diff --git a/src/USER-CGDNA/bond_oxdna_fene.cpp b/src/USER-CGDNA/bond_oxdna_fene.cpp index 8271668e3f..9d6453f5a8 100644 --- a/src/USER-CGDNA/bond_oxdna_fene.cpp +++ b/src/USER-CGDNA/bond_oxdna_fene.cpp @@ -55,8 +55,8 @@ BondOxdnaFene::~BondOxdnaFene() /* ---------------------------------------------------------------------- compute vector COM-sugar-phosphate backbone interaction site in oxDNA ------------------------------------------------------------------------- */ -void BondOxdnaFene::compute_interaction_sites(double e1[3], - double /*e2*/[3], double r[3]) +void BondOxdnaFene::compute_interaction_sites(double e1[3], double /*e2*/[3], + double /*e3*/[3], double r[3]) { double d_cs=-0.4; @@ -66,6 +66,90 @@ void BondOxdnaFene::compute_interaction_sites(double e1[3], } +/* ---------------------------------------------------------------------- + tally energy and virial into global and per-atom accumulators +------------------------------------------------------------------------- */ + +void BondOxdnaFene::ev_tally_xyz(int i, int j, int nlocal, int newton_bond, + double ebond, + double fx, double fy, double fz, + double delx, double dely, double delz) +{ + double ebondhalf,v[6]; + + if (eflag_either) { + if (eflag_global) { + if (newton_bond) energy += ebond; + else { + ebondhalf = 0.5*ebond; + if (i < nlocal) energy += ebondhalf; + if (j < nlocal) energy += ebondhalf; + } + } + if (eflag_atom) { + ebondhalf = 0.5*ebond; + if (newton_bond || i < nlocal) eatom[i] += ebondhalf; + if (newton_bond || j < nlocal) eatom[j] += ebondhalf; + } + } + + if (vflag_either) { + v[0] = delx*fx; + v[1] = dely*fy; + v[2] = delz*fz; + v[3] = delx*fy; + v[4] = delx*fz; + v[5] = dely*fz; + + if (vflag_global) { + if (newton_bond) { + virial[0] += v[0]; + virial[1] += v[1]; + virial[2] += v[2]; + virial[3] += v[3]; + virial[4] += v[4]; + virial[5] += v[5]; + } else { + if (i < nlocal) { + virial[0] += 0.5*v[0]; + virial[1] += 0.5*v[1]; + virial[2] += 0.5*v[2]; + virial[3] += 0.5*v[3]; + virial[4] += 0.5*v[4]; + virial[5] += 0.5*v[5]; + } + if (j < nlocal) { + virial[0] += 0.5*v[0]; + virial[1] += 0.5*v[1]; + virial[2] += 0.5*v[2]; + virial[3] += 0.5*v[3]; + virial[4] += 0.5*v[4]; + virial[5] += 0.5*v[5]; + } + } + } + + if (vflag_atom) { + if (newton_bond || i < nlocal) { + vatom[i][0] += 0.5*v[0]; + vatom[i][1] += 0.5*v[1]; + vatom[i][2] += 0.5*v[2]; + vatom[i][3] += 0.5*v[3]; + vatom[i][4] += 0.5*v[4]; + vatom[i][5] += 0.5*v[5]; + } + if (newton_bond || j < nlocal) { + vatom[j][0] += 0.5*v[0]; + vatom[j][1] += 0.5*v[1]; + vatom[j][2] += 0.5*v[2]; + vatom[j][3] += 0.5*v[3]; + vatom[j][4] += 0.5*v[4]; + vatom[j][5] += 0.5*v[5]; + } + } + } +} + /* ---------------------------------------------------------------------- compute function for oxDNA FENE-bond interaction s=sugar-phosphate backbone site, b=base site, st=stacking site @@ -112,8 +196,8 @@ void BondOxdnaFene::compute(int eflag, int vflag) MathExtra::q_to_exyz(qb,bx,by,bz); // vector COM-backbone site a and b - compute_interaction_sites(ax,ay,ra_cs); - compute_interaction_sites(bx,by,rb_cs); + compute_interaction_sites(ax,ay,az,ra_cs); + compute_interaction_sites(bx,by,bz,rb_cs); // vector backbone site b to a delr[0] = x[a][0] + ra_cs[0] - x[b][0] - rb_cs[0]; @@ -182,7 +266,11 @@ void BondOxdnaFene::compute(int eflag, int vflag) } // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_bond,ebond,fbond,delr[0],delr[1],delr[2]); + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_bond,ebond, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); } diff --git a/src/USER-CGDNA/bond_oxdna_fene.h b/src/USER-CGDNA/bond_oxdna_fene.h index 318ac31fc6..0c702d719a 100644 --- a/src/USER-CGDNA/bond_oxdna_fene.h +++ b/src/USER-CGDNA/bond_oxdna_fene.h @@ -28,7 +28,8 @@ class BondOxdnaFene : public Bond { public: BondOxdnaFene(class LAMMPS *); virtual ~BondOxdnaFene(); - virtual void compute_interaction_sites(double *, double *, double *); + virtual void compute_interaction_sites(double *, double *, double *, + double *); virtual void compute(int, int); void coeff(int, char **); void init_style(); @@ -42,6 +43,7 @@ class BondOxdnaFene : public Bond { double *k,*Delta,*r0; // FENE void allocate(); + void ev_tally_xyz(int, int, int, int, double, double, double, double, double, double, double); }; } diff --git a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp index dfea97f0bf..4fde5e37b4 100644 --- a/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp +++ b/src/USER-CGDNA/pair_oxdna2_coaxstk.cpp @@ -383,7 +383,11 @@ void PairOxdna2Coaxstk::compute(int eflag, int vflag) } // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair,evdwl,0.0,fpair,delr_st[0],delr_st[1],delr_st[2]); + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); // pure torques not expressible as r x f diff --git a/src/USER-CGDNA/pair_oxdna2_dh.cpp b/src/USER-CGDNA/pair_oxdna2_dh.cpp index b4afad12db..ca5f44b815 100644 --- a/src/USER-CGDNA/pair_oxdna2_dh.cpp +++ b/src/USER-CGDNA/pair_oxdna2_dh.cpp @@ -223,10 +223,14 @@ void PairOxdna2Dh::compute(int eflag, int vflag) } + // increment energy and virial + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); - if (evflag) ev_tally(a,b,nlocal,newton_pair, - evdwl,0.0,fpair,delr[0],delr[1],delr[2]); } } diff --git a/src/USER-CGDNA/pair_oxdna2_excv.cpp b/src/USER-CGDNA/pair_oxdna2_excv.cpp index 4329fbe071..f2fb77b3b2 100644 --- a/src/USER-CGDNA/pair_oxdna2_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna2_excv.cpp @@ -39,8 +39,8 @@ PairOxdna2Excv::~PairOxdna2Excv() /* ---------------------------------------------------------------------- compute vector COM-excluded volume interaction sites in oxDNA2 ------------------------------------------------------------------------- */ -void PairOxdna2Excv::compute_interaction_sites(double e1[3], - double e2[3], double rs[3], double rb[3]) +void PairOxdna2Excv::compute_interaction_sites(double e1[3], double e2[3], + double /*e3*/[3], double rs[3], double rb[3]) { double d_cs_x=-0.34, d_cs_y=+0.3408, d_cb=+0.4; diff --git a/src/USER-CGDNA/pair_oxdna2_excv.h b/src/USER-CGDNA/pair_oxdna2_excv.h index 33eacbed9c..d61317009b 100644 --- a/src/USER-CGDNA/pair_oxdna2_excv.h +++ b/src/USER-CGDNA/pair_oxdna2_excv.h @@ -28,7 +28,7 @@ class PairOxdna2Excv : public PairOxdnaExcv { public: PairOxdna2Excv(class LAMMPS *); virtual ~PairOxdna2Excv(); - virtual void compute_interaction_sites(double *, + virtual void compute_interaction_sites(double *, double *, double *, double *, double *); }; diff --git a/src/USER-CGDNA/pair_oxdna2_stk.cpp b/src/USER-CGDNA/pair_oxdna2_stk.cpp deleted file mode 100644 index f479572aa6..0000000000 --- a/src/USER-CGDNA/pair_oxdna2_stk.cpp +++ /dev/null @@ -1,50 +0,0 @@ -/* ---------------------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ -/* ---------------------------------------------------------------------- - Contributing author: Oliver Henrich (University of Strathclyde, Glasgow) -------------------------------------------------------------------------- */ - -#include -#include -#include -#include -#include "pair_oxdna2_stk.h" - -using namespace LAMMPS_NS; - -/* ---------------------------------------------------------------------- */ - -PairOxdna2Stk::PairOxdna2Stk(LAMMPS *lmp) : PairOxdnaStk(lmp) -{ - -} - -/* ---------------------------------------------------------------------- */ - -PairOxdna2Stk::~PairOxdna2Stk() -{ - -} - -/* ---------------------------------------------------------------------- - return temperature dependent oxDNA2 stacking strength -------------------------------------------------------------------------- */ - -double PairOxdna2Stk::stacking_strength(double T) -{ - double eps; - - eps = 1.3523 + 2.6717 * T; - - return eps; -} diff --git a/src/USER-CGDNA/pair_oxdna2_stk.h b/src/USER-CGDNA/pair_oxdna2_stk.h deleted file mode 100644 index 7654e5db2f..0000000000 --- a/src/USER-CGDNA/pair_oxdna2_stk.h +++ /dev/null @@ -1,53 +0,0 @@ -/* -*- c++ -*- ---------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#ifdef PAIR_CLASS - -PairStyle(oxdna2/stk,PairOxdna2Stk) - -#else - -#ifndef LMP_PAIR_OXDNA2_STK_H -#define LMP_PAIR_OXDNA2_STK_H - -#include "pair_oxdna_stk.h" - -namespace LAMMPS_NS { - -class PairOxdna2Stk : public PairOxdnaStk { - public: - PairOxdna2Stk(class LAMMPS *); - virtual ~PairOxdna2Stk(); - - protected: - virtual double stacking_strength(double); -}; - -} - -#endif -#endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -E: Incorrect args for pair coefficients - -Self-explanatory. Check the input script or data file. - -*/ diff --git a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp index 6f3fa4fa4e..6b10117f91 100644 --- a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp +++ b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp @@ -450,7 +450,11 @@ void PairOxdnaCoaxstk::compute(int eflag, int vflag) } // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair,evdwl,0.0,fpair,delr_st[0],delr_st[1],delr_st[2]); + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); // pure torques not expressible as r x f diff --git a/src/USER-CGDNA/pair_oxdna_excv.cpp b/src/USER-CGDNA/pair_oxdna_excv.cpp index 82af5ed1c7..ddfe32946c 100644 --- a/src/USER-CGDNA/pair_oxdna_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna_excv.cpp @@ -91,8 +91,8 @@ PairOxdnaExcv::~PairOxdnaExcv() /* ---------------------------------------------------------------------- compute vector COM-excluded volume interaction sites in oxDNA ------------------------------------------------------------------------- */ -void PairOxdnaExcv::compute_interaction_sites(double e1[3], - double /*e2*/[3], double rs[3], double rb[3]) +void PairOxdnaExcv::compute_interaction_sites(double e1[3], double /*e2*/[3], + double /*e3*/[3], double rs[3], double rb[3]) { double d_cs=-0.4, d_cb=+0.4; @@ -162,7 +162,7 @@ void PairOxdnaExcv::compute(int eflag, int vflag) MathExtra::q_to_exyz(qa,ax,ay,az); // vector COM - backbone and base site a - compute_interaction_sites(ax,ay,ra_cs,ra_cb); + compute_interaction_sites(ax,ay,az,ra_cs,ra_cb); rtmp_s[0] = x[a][0] + ra_cs[0]; rtmp_s[1] = x[a][1] + ra_cs[1]; @@ -187,7 +187,7 @@ void PairOxdnaExcv::compute(int eflag, int vflag) MathExtra::q_to_exyz(qb,bx,by,bz); // vector COM - backbone and base site b - compute_interaction_sites(bx,by,rb_cs,rb_cb); + compute_interaction_sites(bx,by,bz,rb_cs,rb_cb); // vector backbone site b to a delr_ss[0] = rtmp_s[0] - (x[b][0] + rb_cs[0]); @@ -225,14 +225,17 @@ void PairOxdnaExcv::compute(int eflag, int vflag) fpair *= factor_lj; evdwl *= factor_lj; - // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair, - evdwl,0.0,fpair,delr_ss[0],delr_ss[1],delr_ss[2]); - delf[0] = delr_ss[0]*fpair; delf[1] = delr_ss[1]*fpair; delf[2] = delr_ss[2]*fpair; + // increment energy and virial + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); + f[a][0] += delf[0]; f[a][1] += delf[1]; f[a][2] += delf[2]; @@ -259,21 +262,20 @@ void PairOxdnaExcv::compute(int eflag, int vflag) } - // backbone-base if (rsq_sb < cutsq_sb_c[atype][btype]) { evdwl = F3(rsq_sb,cutsq_sb_ast[atype][btype],cut_sb_c[atype][btype],lj1_sb[atype][btype], lj2_sb[atype][btype],epsilon_sb[atype][btype],b_sb[atype][btype],fpair); - // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair, - evdwl,0.0,fpair,delr_sb[0],delr_sb[1],delr_sb[2]); - delf[0] = delr_sb[0]*fpair; delf[1] = delr_sb[1]*fpair; delf[2] = delr_sb[2]*fpair; + // increment energy and virial + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); + f[a][0] += delf[0]; f[a][1] += delf[1]; f[a][2] += delf[2]; @@ -306,14 +308,14 @@ void PairOxdnaExcv::compute(int eflag, int vflag) evdwl = F3(rsq_bs,cutsq_sb_ast[atype][btype],cut_sb_c[atype][btype],lj1_sb[atype][btype], lj2_sb[atype][btype],epsilon_sb[atype][btype],b_sb[atype][btype],fpair); - // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair, - evdwl,0.0,fpair,delr_bs[0],delr_bs[1],delr_bs[2]); - delf[0] = delr_bs[0]*fpair; delf[1] = delr_bs[1]*fpair; delf[2] = delr_bs[2]*fpair; + // increment energy and virial + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); + f[a][0] += delf[0]; f[a][1] += delf[1]; f[a][2] += delf[2]; @@ -346,14 +348,14 @@ void PairOxdnaExcv::compute(int eflag, int vflag) evdwl = F3(rsq_bb,cutsq_bb_ast[atype][btype],cut_bb_c[atype][btype],lj1_bb[atype][btype], lj2_bb[atype][btype],epsilon_bb[atype][btype],b_bb[atype][btype],fpair); - // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair, - evdwl,0.0,fpair,delr_bb[0],delr_bb[1],delr_bb[2]); - delf[0] = delr_bb[0]*fpair; delf[1] = delr_bb[1]*fpair; delf[2] = delr_bb[2]*fpair; + // increment energy and virial + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); + f[a][0] += delf[0]; f[a][1] += delf[1]; f[a][2] += delf[2]; diff --git a/src/USER-CGDNA/pair_oxdna_excv.h b/src/USER-CGDNA/pair_oxdna_excv.h index 9cae6ac528..c80a112fec 100644 --- a/src/USER-CGDNA/pair_oxdna_excv.h +++ b/src/USER-CGDNA/pair_oxdna_excv.h @@ -28,7 +28,7 @@ class PairOxdnaExcv : public Pair { public: PairOxdnaExcv(class LAMMPS *); virtual ~PairOxdnaExcv(); - virtual void compute_interaction_sites(double *, double *, + virtual void compute_interaction_sites(double *, double *, double *, double *, double *); virtual void compute(int, int); void settings(int, char **); diff --git a/src/USER-CGDNA/pair_oxdna_hbond.cpp b/src/USER-CGDNA/pair_oxdna_hbond.cpp index 8cd28f10c8..03e83e1324 100644 --- a/src/USER-CGDNA/pair_oxdna_hbond.cpp +++ b/src/USER-CGDNA/pair_oxdna_hbond.cpp @@ -410,7 +410,11 @@ void PairOxdnaHbond::compute(int eflag, int vflag) } // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair,evdwl,0.0,fpair,delr_hb[0],delr_hb[1],delr_hb[2]); + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); // pure torques not expressible as r x f diff --git a/src/USER-CGDNA/pair_oxdna_stk.cpp b/src/USER-CGDNA/pair_oxdna_stk.cpp index 93c65979ac..3c7a3f05bc 100644 --- a/src/USER-CGDNA/pair_oxdna_stk.cpp +++ b/src/USER-CGDNA/pair_oxdna_stk.cpp @@ -106,6 +106,94 @@ PairOxdnaStk::~PairOxdnaStk() } } +/* ---------------------------------------------------------------------- + tally energy and virial into global and per-atom accumulators + + NOTE: Although this is a pair style interaction, the algorithm below + follows the virial incrementation of the bond style. This is because + the bond topology is used in the main compute loop. +------------------------------------------------------------------------- */ + +void PairOxdnaStk::ev_tally_xyz(int i, int j, int nlocal, int newton_bond, + double evdwl, + double fx, double fy, double fz, + double delx, double dely, double delz) +{ + double evdwlhalf,v[6]; + + if (eflag_either) { + if (eflag_global) { + if (newton_bond) eng_vdwl += evdwl; + else { + evdwlhalf = 0.5*evdwl; + if (i < nlocal) eng_vdwl += evdwlhalf; + if (j < nlocal) eng_vdwl += evdwlhalf; + } + } + if (eflag_atom) { + evdwlhalf = 0.5*evdwl; + if (newton_bond || i < nlocal) eatom[i] += evdwlhalf; + if (newton_bond || j < nlocal) eatom[j] += evdwlhalf; + } + } + + if (vflag_either) { + v[0] = delx*fx; + v[1] = dely*fy; + v[2] = delz*fz; + v[3] = delx*fy; + v[4] = delx*fz; + v[5] = dely*fz; + + if (vflag_global) { + if (newton_bond) { + virial[0] += v[0]; + virial[1] += v[1]; + virial[2] += v[2]; + virial[3] += v[3]; + virial[4] += v[4]; + virial[5] += v[5]; + } else { + if (i < nlocal) { + virial[0] += 0.5*v[0]; + virial[1] += 0.5*v[1]; + virial[2] += 0.5*v[2]; + virial[3] += 0.5*v[3]; + virial[4] += 0.5*v[4]; + virial[5] += 0.5*v[5]; + } + if (j < nlocal) { + virial[0] += 0.5*v[0]; + virial[1] += 0.5*v[1]; + virial[2] += 0.5*v[2]; + virial[3] += 0.5*v[3]; + virial[4] += 0.5*v[4]; + virial[5] += 0.5*v[5]; + } + } + } + + if (vflag_atom) { + if (newton_bond || i < nlocal) { + vatom[i][0] += 0.5*v[0]; + vatom[i][1] += 0.5*v[1]; + vatom[i][2] += 0.5*v[2]; + vatom[i][3] += 0.5*v[3]; + vatom[i][4] += 0.5*v[4]; + vatom[i][5] += 0.5*v[5]; + } + if (newton_bond || j < nlocal) { + vatom[j][0] += 0.5*v[0]; + vatom[j][1] += 0.5*v[1]; + vatom[j][2] += 0.5*v[2]; + vatom[j][3] += 0.5*v[3]; + vatom[j][4] += 0.5*v[4]; + vatom[j][5] += 0.5*v[5]; + } + } + } +} + /* ---------------------------------------------------------------------- compute function for oxDNA pair interactions s=sugar-phosphate backbone site, b=base site, st=stacking site @@ -295,9 +383,6 @@ void PairOxdnaStk::compute(int eflag, int vflag) // early rejection criterium if (evdwl) { - // increment energy - if (evflag) ev_tally(a,b,nlocal,newton_bond,evdwl,0.0,0.0,0.0,0.0,0.0); - df1 = DF1(r_st, epsilon_st[atype][btype], a_st[atype][btype], cut_st_0[atype][btype], cut_st_lc[atype][btype], cut_st_hc[atype][btype], cut_st_lo[atype][btype], cut_st_hi[atype][btype], b_st_lo[atype][btype], b_st_hi[atype][btype]); @@ -366,7 +451,7 @@ void PairOxdnaStk::compute(int eflag, int vflag) } - // increment forces, torques and virial + // increment forces and torques if (newton_bond || a < nlocal) { @@ -402,7 +487,12 @@ void PairOxdnaStk::compute(int eflag, int vflag) } - if (evflag) ev_tally(a,b,nlocal,newton_bond,0.0,0.0,fpair,delr_st[0],delr_st[1],delr_st[2]); + // increment energy and virial + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_bond,evdwl, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); // force, torque and virial contribution for forces between backbone sites @@ -444,7 +534,7 @@ void PairOxdnaStk::compute(int eflag, int vflag) } - // increment forces, torques and virial + // increment forces and torques if (newton_bond || a < nlocal) { @@ -480,8 +570,9 @@ void PairOxdnaStk::compute(int eflag, int vflag) } - if (evflag) ev_tally(a,b,nlocal,newton_bond,0.0,0.0,fpair,delr_ss[0],delr_ss[1],delr_ss[2]); - + // increment virial only + if (evflag) ev_tally_xyz(a,b,nlocal,newton_bond,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); // pure torques not expressible as r x f @@ -656,11 +747,11 @@ void PairOxdnaStk::settings(int narg, char **/*arg*/) return temperature dependent oxDNA stacking strength ------------------------------------------------------------------------- */ -double PairOxdnaStk::stacking_strength(double T) +double PairOxdnaStk::stacking_strength(double xi_st, double kappa_st, double T) { double eps; - eps = 1.3448 + 2.6568 * T; + eps = xi_st + kappa_st * T; return eps; } @@ -673,7 +764,7 @@ void PairOxdnaStk::coeff(int narg, char **arg) { int count; - if (narg != 22) error->all(FLERR,"Incorrect args for pair coefficients in oxdna/stk"); + if (narg != 24) error->all(FLERR,"Incorrect args for pair coefficients in oxdna/stk"); if (!allocated) allocate(); int ilo,ihi,jlo,jhi; @@ -683,7 +774,7 @@ void PairOxdnaStk::coeff(int narg, char **arg) // stacking interaction count = 0; - double T, epsilon_st_one, a_st_one, b_st_lo_one, b_st_hi_one; + double T, epsilon_st_one, xi_st_one, kappa_st_one, a_st_one, b_st_lo_one, b_st_hi_one; double cut_st_0_one, cut_st_c_one, cut_st_lo_one, cut_st_hi_one; double cut_st_lc_one, cut_st_hc_one, tmp, shift_st_one; @@ -706,27 +797,29 @@ void PairOxdnaStk::coeff(int narg, char **arg) if (strcmp(arg[2],"seqdep") == 0) seqdepflag = 1; T = force->numeric(FLERR,arg[3]); - epsilon_st_one = stacking_strength(T); - - a_st_one = force->numeric(FLERR,arg[4]); - cut_st_0_one = force->numeric(FLERR,arg[5]); - cut_st_c_one = force->numeric(FLERR,arg[6]); - cut_st_lo_one = force->numeric(FLERR,arg[7]); - cut_st_hi_one = force->numeric(FLERR,arg[8]); - - a_st4_one = force->numeric(FLERR,arg[9]); - theta_st4_0_one = force->numeric(FLERR,arg[10]); - dtheta_st4_ast_one = force->numeric(FLERR,arg[11]); - a_st5_one = force->numeric(FLERR,arg[12]); - theta_st5_0_one = force->numeric(FLERR,arg[13]); - dtheta_st5_ast_one = force->numeric(FLERR,arg[14]); - a_st6_one = force->numeric(FLERR,arg[15]); - theta_st6_0_one = force->numeric(FLERR,arg[16]); - dtheta_st6_ast_one = force->numeric(FLERR,arg[17]); - a_st1_one = force->numeric(FLERR,arg[18]); - cosphi_st1_ast_one = force->numeric(FLERR,arg[19]); - a_st2_one = force->numeric(FLERR,arg[20]); - cosphi_st2_ast_one = force->numeric(FLERR,arg[21]); + xi_st_one = force->numeric(FLERR,arg[4]); + kappa_st_one = force->numeric(FLERR,arg[5]); + epsilon_st_one = stacking_strength(xi_st_one, kappa_st_one, T); + + a_st_one = force->numeric(FLERR,arg[6]); + cut_st_0_one = force->numeric(FLERR,arg[7]); + cut_st_c_one = force->numeric(FLERR,arg[8]); + cut_st_lo_one = force->numeric(FLERR,arg[9]); + cut_st_hi_one = force->numeric(FLERR,arg[10]); + + a_st4_one = force->numeric(FLERR,arg[11]); + theta_st4_0_one = force->numeric(FLERR,arg[12]); + dtheta_st4_ast_one = force->numeric(FLERR,arg[13]); + a_st5_one = force->numeric(FLERR,arg[14]); + theta_st5_0_one = force->numeric(FLERR,arg[15]); + dtheta_st5_ast_one = force->numeric(FLERR,arg[16]); + a_st6_one = force->numeric(FLERR,arg[17]); + theta_st6_0_one = force->numeric(FLERR,arg[18]); + dtheta_st6_ast_one = force->numeric(FLERR,arg[19]); + a_st1_one = force->numeric(FLERR,arg[20]); + cosphi_st1_ast_one = force->numeric(FLERR,arg[21]); + a_st2_one = force->numeric(FLERR,arg[22]); + cosphi_st2_ast_one = force->numeric(FLERR,arg[23]); b_st_lo_one = 2*a_st_one*exp(-a_st_one*(cut_st_lo_one-cut_st_0_one))* 2*a_st_one*exp(-a_st_one*(cut_st_lo_one-cut_st_0_one))* diff --git a/src/USER-CGDNA/pair_oxdna_stk.h b/src/USER-CGDNA/pair_oxdna_stk.h index 74a9a6bf68..581e87f4b2 100644 --- a/src/USER-CGDNA/pair_oxdna_stk.h +++ b/src/USER-CGDNA/pair_oxdna_stk.h @@ -14,6 +14,7 @@ #ifdef PAIR_CLASS PairStyle(oxdna/stk,PairOxdnaStk) +PairStyle(oxdna2/stk,PairOxdnaStk) #else @@ -44,7 +45,7 @@ class PairOxdnaStk : public Pair { protected: // stacking interaction - virtual double stacking_strength(double); + double stacking_strength(double, double, double); double **epsilon_st, **a_st, **cut_st_0, **cut_st_c; double **cut_st_lo, **cut_st_hi; double **cut_st_lc, **cut_st_hc, **b_st_lo, **b_st_hi, **shift_st; @@ -61,6 +62,7 @@ class PairOxdnaStk : public Pair { int seqdepflag; virtual void allocate(); + void ev_tally_xyz(int, int, int, int, double, double, double, double, double, double, double); }; } diff --git a/src/USER-CGDNA/pair_oxdna_xstk.cpp b/src/USER-CGDNA/pair_oxdna_xstk.cpp index 1365d0d2b2..d5248937ca 100644 --- a/src/USER-CGDNA/pair_oxdna_xstk.cpp +++ b/src/USER-CGDNA/pair_oxdna_xstk.cpp @@ -422,7 +422,11 @@ void PairOxdnaXstk::compute(int eflag, int vflag) } // increment energy and virial - if (evflag) ev_tally(a,b,nlocal,newton_pair,evdwl,0.0,fpair,delr_hb[0],delr_hb[1],delr_hb[2]); + // NOTE: The virial is calculated on the 'molecular' basis. + // (see G. Ciccotti and J.P. Ryckaert, Comp. Phys. Rep. 4, 345-392 (1986)) + + if (evflag) ev_tally_xyz(a,b,nlocal,newton_pair,evdwl,0.0, + delf[0],delf[1],delf[2],x[a][0]-x[b][0],x[a][1]-x[b][1],x[a][2]-x[b][2]); // pure torques not expressible as r x f -- GitLab From 7bf97577551dd496f8dca8aa7b9cdb00d1bd6c91 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 19 Jul 2019 11:57:58 +0100 Subject: [PATCH 268/469] Updated input and log files, amended comment in data files --- .../cgdna/examples/oxDNA/duplex1/data.duplex1 | 2 +- .../cgdna/examples/oxDNA/duplex1/in.duplex1 | 9 +- .../oxDNA/duplex1/log.18Jun19.duplex1.g++.1 | 1165 ++++++++++++++++ .../oxDNA/duplex1/log.18Jun19.duplex1.g++.4 | 1165 ++++++++++++++++ .../oxDNA/duplex1/log.27Nov18.duplex1.g++.1 | 172 --- .../oxDNA/duplex1/log.27Nov18.duplex1.g++.4 | 172 --- .../cgdna/examples/oxDNA/duplex2/data.duplex2 | 2 +- .../cgdna/examples/oxDNA/duplex2/in.duplex2 | 9 +- .../oxDNA/duplex2/log.18Jun19.duplex2.g++.1 | 1167 ++++++++++++++++ .../oxDNA/duplex2/log.18Jun19.duplex2.g++.4 | 1167 ++++++++++++++++ .../oxDNA/duplex2/log.27Nov18.duplex2.g++.1 | 172 --- .../oxDNA/duplex2/log.27Nov18.duplex2.g++.4 | 172 --- .../examples/oxDNA2/duplex1/data.duplex1 | 2 +- .../cgdna/examples/oxDNA2/duplex1/in.duplex1 | 11 +- .../oxDNA2/duplex1/log.18Jun19.duplex1.g++.1 | 1172 ++++++++++++++++ .../oxDNA2/duplex1/log.18Jun19.duplex1.g++.4 | 1172 ++++++++++++++++ .../oxDNA2/duplex1/log.27Nov18.duplex1.g++.1 | 178 --- .../oxDNA2/duplex1/log.27Nov18.duplex1.g++.4 | 178 --- .../examples/oxDNA2/duplex2/data.duplex2 | 2 +- .../cgdna/examples/oxDNA2/duplex2/in.duplex2 | 12 +- .../oxDNA2/duplex2/log.18Jun19.duplex2.g++.1 | 1173 +++++++++++++++++ .../oxDNA2/duplex2/log.18Jun19.duplex2.g++.4 | 1173 +++++++++++++++++ .../oxDNA2/duplex2/log.27Nov18.duplex2.g++.1 | 178 --- .../oxDNA2/duplex2/log.27Nov18.duplex2.g++.4 | 178 --- .../examples/oxDNA2/duplex3/data.duplex3 | 73 + .../cgdna/examples/oxDNA2/duplex3/in.duplex3 | 79 ++ .../oxDNA2/duplex3/log.18Jun19.duplex3.g++.1 | 1172 ++++++++++++++++ .../oxDNA2/duplex3/log.18Jun19.duplex3.g++.4 | 1172 ++++++++++++++++ 28 files changed, 11876 insertions(+), 1423 deletions(-) create mode 100644 examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.1 create mode 100644 examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.4 delete mode 100644 examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.1 delete mode 100644 examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.4 create mode 100644 examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.1 create mode 100644 examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.4 delete mode 100644 examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.1 delete mode 100644 examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.4 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.1 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.4 delete mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.1 delete mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.4 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.1 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.4 delete mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.1 delete mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.4 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex3/data.duplex3 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.1 create mode 100644 examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.4 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex1/data.duplex1 b/examples/USER/cgdna/examples/oxDNA/duplex1/data.duplex1 index 6aee3233dd..0ef671c603 100644 --- a/examples/USER/cgdna/examples/oxDNA/duplex1/data.duplex1 +++ b/examples/USER/cgdna/examples/oxDNA/duplex1/data.duplex1 @@ -32,7 +32,7 @@ Atoms 9 3 4.860249842674775e-01 3.518234140414733e-01 3.897628551303121e-01 2 1 1 10 4 5.999999999999996e-01 -1.332267629550188e-16 -1.110223024625157e-16 2 1 1 -# Atom-ID, translational, rotational velocity +# Atom-ID, translational velocity, angular momentum Velocities 1 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex1/in.duplex1 b/examples/USER/cgdna/examples/oxDNA/duplex1/in.duplex1 index 6485312731..34e17380af 100644 --- a/examples/USER/cgdna/examples/oxDNA/duplex1/in.duplex1 +++ b/examples/USER/cgdna/examples/oxDNA/duplex1/in.duplex1 @@ -1,6 +1,7 @@ variable number equal 1 variable ofreq equal 1000 variable efreq equal 1000 +variable T equal 0.1 units lj @@ -30,7 +31,7 @@ bond_coeff * 2.0 0.25 0.7525 # oxDNA pair interactions pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/stk seqav ${T} 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 @@ -39,9 +40,9 @@ pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1 # NVE ensemble fix 1 all nve/dot -#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 #fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 timestep 1e-5 @@ -72,6 +73,6 @@ fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${e #dump_modify out sort id #dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" -run 10000 +run 1000000 #write_restart config.${number}.* diff --git a/examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.1 b/examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.1 new file mode 100644 index 0000000000..8b1c5c3807 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.1 @@ -0,0 +1,1165 @@ +LAMMPS (18 Jun 2019) +variable number equal 1 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex1 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 10 atoms + reading velocities ... + 10 velocities + 10 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 8 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 2 = max # of 1-4 neighbors + 4 = max # of special neighbors + special bonds CPU = 5e-05 secs + read_data CPU = 0.001522 secs + +set atom * mass 3.1575 + 10 settings made for mass + +group all type 1 4 +10 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna/fene +bond_coeff * 2.0 0.25 0.7525 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk +pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna/stk seqav ${T} 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/stk seqav 0.1 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 + +# NVE ensemble +fix 1 all nve/dot +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.92828 + ghost atom cutoff = 1.92828 + binsize = 0.964142, bins = 42 42 42 + 5 neighbor lists, perpetual/occasional/extra = 5 0 0 + (1) pair oxdna/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 2.859 | 2.859 | 2.859 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.4711818 0.0069384985 -1.4642433 2.5836586e-06 +1000 ekin = 0.00113448721737003 | erot = 0.00413455947734281 | epot = -14.6477022915193 | etot = -14.6424332448246 +2000 ekin = 0.00449927223902336 | erot = 0.0164446434455805 | epot = -14.6633771605337 | etot = -14.6424332448491 +3000 ekin = 0.00997964450841065 | erot = 0.0366523356056461 | epot = -14.6890652250033 | etot = -14.6424332448892 +4000 ekin = 0.0173888111295073 | erot = 0.0643039804300224 | epot = -14.7241260365031 | etot = -14.6424332449436 +5000 ekin = 0.0264744514136619 | erot = 0.0987844033142069 | epot = -14.7676920997383 | etot = -14.6424332450104 +6000 ekin = 0.0369277948556079 | erot = 0.139336571052566 | epot = -14.8186976109956 | etot = -14.6424332450875 +7000 ekin = 0.04839505571915 | erot = 0.185086295692081 | epot = -14.8759145965832 | etot = -14.642433245172 +8000 ekin = 0.0604909336920643 | erot = 0.235071307523532 | epot = -14.9379954864767 | etot = -14.6424332452611 +9000 ekin = 0.0728137406440561 | erot = 0.288273694501538 | epot = -15.003520680497 | etot = -14.6424332453514 +10000 ekin = 0.0849615563085878 | erot = 0.343654369293473 | epot = -15.0710491710418 | etot = -14.6424332454398 +11000 ekin = 0.0965486715045649 | erot = 0.400187932108223 | epot = -15.1391698491357 | etot = -14.6424332455229 +12000 ekin = 0.10722146628289 | erot = 0.456896095459165 | epot = -15.20655080734 | etot = -14.642433245598 +13000 ekin = 0.116672809719548 | erot = 0.512877765427643 | epot = -15.2719838208099 | etot = -14.6424332456627 +14000 ekin = 0.12465407373104 | erot = 0.567333962045116 | epot = -15.3344212814913 | etot = -14.6424332457151 +15000 ekin = 0.13098393968427 | erot = 0.619586028256667 | epot = -15.3930032136954 | etot = -14.6424332457544 +16000 ekin = 0.135553354544872 | erot = 0.669086028489761 | epot = -15.447072628815 | etot = -14.6424332457804 +17000 ekin = 0.138326263958247 | erot = 0.715418858085449 | epot = -15.4961783678372 | etot = -14.6424332457935 +18000 ekin = 0.139336096664052 | erot = 0.758296324627745 | epot = -15.5400656670872 | etot = -14.6424332457954 +19000 ekin = 0.138678360045177 | erot = 0.797544234275864 | epot = -15.5786558401088 | etot = -14.6424332457878 +20000 ekin = 0.136500074655373 | erot = 0.83308420441103 | epot = -15.6120175248394 | etot = -14.642433245773 +21000 ekin = 0.132987065285671 | erot = 0.864912408452581 | epot = -15.6403327194916 | etot = -14.6424332457533 +22000 ekin = 0.128350288213556 | erot = 0.893077649557994 | epot = -15.6638611835027 | etot = -14.6424332457311 +23000 ekin = 0.122812385135508 | erot = 0.917661024683964 | epot = -15.6829066555277 | etot = -14.6424332457083 +24000 ekin = 0.116595521408284 | erot = 0.938759014332096 | epot = -15.6977877814267 | etot = -14.6424332456863 +25000 ekin = 0.109911323474816 | erot = 0.956471207347236 | epot = -15.7088157764882 | etot = -14.6424332456662 +26000 ekin = 0.102953426207644 | erot = 0.970893163953198 | epot = -15.7162798358091 | etot = -14.6424332456483 +27000 ekin = 0.0958928250746637 | erot = 0.982114250194049 | epot = -15.7204403209013 | etot = -14.6424332456326 +28000 ekin = 0.0888759410950343 | erot = 0.990219731539835 | epot = -15.7215289182535 | etot = -14.6424332456186 +29000 ekin = 0.0820250748773376 | erot = 0.995296041202909 | epot = -15.719754361686 | etot = -14.6424332456058 +30000 ekin = 0.0754407616839748 | erot = 0.997437949320991 | epot = -15.7153119565981 | etot = -14.6424332455932 +31000 ekin = 0.0692054432610605 | erot = 0.996756332762285 | epot = -15.7083950216035 | etot = -14.6424332455802 +32000 ekin = 0.0633878377978472 | erot = 0.993385345349211 | epot = -15.699206428713 | etot = -14.6424332455659 +33000 ekin = 0.0580474070871663 | erot = 0.987487973309961 | epot = -15.6879686259471 | etot = -14.64243324555 +34000 ekin = 0.0532383791888181 | erot = 0.979259192921736 | epot = -15.6749308176426 | etot = -14.642433245532 +35000 ekin = 0.0490128758307997 | erot = 0.968926197407215 | epot = -15.66037231875 | etot = -14.642433245512 +36000 ekin = 0.0454228081410747 | erot = 0.95674540962595 | epot = -15.6446014632576 | etot = -14.6424332454906 +37000 ekin = 0.0425203357176436 | erot = 0.942996238000708 | epot = -15.6279498191869 | etot = -14.6424332454685 +38000 ekin = 0.0403568280949567 | erot = 0.92797176661665 | epot = -15.6107618401582 | etot = -14.6424332454466 +39000 ekin = 0.0389804214212708 | erot = 0.911966804110001 | epot = -15.5933804709572 | etot = -14.642433245426 +40000 ekin = 0.0384324238856422 | erot = 0.8952639595629 | epot = -15.5761296288567 | etot = -14.6424332454081 +41000 ekin = 0.0387429860408521 | erot = 0.878118672838247 | epot = -15.5592949042733 | etot = -14.6424332453942 +42000 ekin = 0.0399266053637504 | erot = 0.860744395135471 | epot = -15.5431042458848 | etot = -14.6424332453856 +43000 ekin = 0.0419781561011205 | erot = 0.843299365355946 | epot = -15.52771076684 | etot = -14.6424332453829 +44000 ekin = 0.0448701894086706 | erot = 0.825876603312506 | epot = -15.5131800381079 | etot = -14.6424332453867 +45000 ekin = 0.0485521857411509 | erot = 0.808498758184836 | epot = -15.4994841893228 | etot = -14.6424332453969 +46000 ekin = 0.0529522094031963 | erot = 0.791119212186772 | epot = -15.4865046670025 | etot = -14.6424332454125 +47000 ekin = 0.0579809824236739 | erot = 0.773630265882115 | epot = -15.4740444937379 | etot = -14.6424332454321 +48000 ekin = 0.063537784649307 | erot = 0.755878310836066 | epot = -15.4618493409392 | etot = -14.6424332454538 +49000 ekin = 0.0695169124457283 | erot = 0.737684732482629 | epot = -15.4496348904038 | etot = -14.6424332454754 +50000 ekin = 0.0758129058454745 | erot = 0.718870126218063 | epot = -15.4371162775588 | etot = -14.6424332454952 +51000 ekin = 0.082322663864191 | erot = 0.69927859951883 | epot = -15.4240345088949 | etot = -14.6424332455119 +52000 ekin = 0.0889431481334984 | erot = 0.67879880709845 | epot = -15.4101752007568 | etot = -14.6424332455248 +53000 ekin = 0.0955646689255781 | erot = 0.657379086769954 | epot = -15.3953770012299 | etot = -14.6424332455344 +54000 ekin = 0.102061477509349 | erot = 0.635035489168609 | epot = -15.3795302122192 | etot = -14.6424332455412 +55000 ekin = 0.108282960174 | erot = 0.611853171347129 | epot = -15.3625693770671 | etot = -14.6424332455459 +56000 ekin = 0.114049426281782 | erot = 0.58798294592476 | epot = -15.3444656177551 | etot = -14.6424332455485 +57000 ekin = 0.119155806186856 | erot = 0.563635255923989 | epot = -15.3252243076595 | etot = -14.6424332455486 +58000 ekin = 0.123384552305436 | erot = 0.539073355224011 | epot = -15.3048911530747 | etot = -14.6424332455453 +59000 ekin = 0.126526300954942 | erot = 0.514606324860975 | epot = -15.2835658713528 | etot = -14.6424332455369 +60000 ekin = 0.128404399836505 | erot = 0.490581338842491 | epot = -15.2614189842015 | etot = -14.6424332455225 +61000 ekin = 0.128898142362338 | erot = 0.46737389240369 | epot = -15.2387052802676 | etot = -14.6424332455016 +62000 ekin = 0.127959880290304 | erot = 0.445374820089083 | epot = -15.2157679458544 | etot = -14.642433245475 +63000 ekin = 0.125622870624957 | erot = 0.424973765390021 | epot = -15.1930298814589 | etot = -14.6424332454439 +64000 ekin = 0.121999044843205 | erot = 0.406539918574829 | epot = -15.1709722088285 | etot = -14.6424332454105 +65000 ekin = 0.117268056619305 | erot = 0.390401831022814 | epot = -15.1501031330194 | etot = -14.6424332453773 +66000 ekin = 0.111660385257246 | erot = 0.376828594080988 | epot = -15.1309222246848 | etot = -14.6424332453465 +67000 ekin = 0.105437746905138 | erot = 0.366014539812675 | epot = -15.1138855320384 | etot = -14.6424332453205 +68000 ekin = 0.0988737375607886 | erot = 0.3580690141562 | epot = -15.0993759970177 | etot = -14.6424332453007 +69000 ekin = 0.0922368286502271 | erot = 0.353011948772473 | epot = -15.0876820227105 | etot = -14.6424332452878 +70000 ekin = 0.085776901527448 | erot = 0.350775174164851 | epot = -15.0789853209745 | etot = -14.6424332452822 +71000 ekin = 0.0797156921642142 | erot = 0.351208844244805 | epot = -15.0733577816926 | etot = -14.6424332452835 +72000 ekin = 0.0742409440406418 | erot = 0.354092037745935 | epot = -15.0707662270776 | etot = -14.6424332452911 +73000 ekin = 0.0695037498701448 | erot = 0.359146526959505 | epot = -15.0710835221334 | etot = -14.6424332453038 +74000 ekin = 0.0656184497423043 | erot = 0.366052769876549 | epot = -15.0741044649392 | etot = -14.6424332453204 +75000 ekin = 0.0626644690389266 | erot = 0.374467290031506 | epot = -15.07956500441 | etot = -14.6424332453396 +76000 ekin = 0.0606895535086054 | erot = 0.384040683400738 | epot = -15.0871634822693 | etot = -14.64243324536 +77000 ekin = 0.0597139401235012 | erot = 0.394435495890075 | epot = -15.0965826813934 | etot = -14.6424332453798 +78000 ekin = 0.059735062986913 | erot = 0.405343151479082 | epot = -15.1075114598642 | etot = -14.6424332453982 +79000 ekin = 0.0607324264355555 | erot = 0.416499017639937 | epot = -15.1196646894892 | etot = -14.6424332454137 +80000 ekin = 0.06267229049498 | erot = 0.427694630236126 | epot = -15.1328001661568 | etot = -14.6424332454257 +81000 ekin = 0.0655118235328765 | erot = 0.438786127846728 | epot = -15.1467311968131 | etot = -14.6424332454335 +82000 ekin = 0.0692024020835893 | erot = 0.449698113828473 | epot = -15.1613337613493 | etot = -14.6424332454372 +83000 ekin = 0.0736917936906618 | erot = 0.460422490738957 | epot = -15.1765475298665 | etot = -14.6424332454369 +84000 ekin = 0.0789250526546722 | erot = 0.471012272293582 | epot = -15.1923705703818 | etot = -14.6424332454336 +85000 ekin = 0.0848440878750035 | erot = 0.481570908649162 | epot = -15.2088482419522 | etot = -14.642433245428 +86000 ekin = 0.0913860133254624 | erot = 0.492238169205216 | epot = -15.2260574279521 | etot = -14.6424332454214 +87000 ekin = 0.0984805441200046 | erot = 0.503174014616525 | epot = -15.2440878041518 | etot = -14.6424332454153 +88000 ekin = 0.106046830304297 | erot = 0.514542076496056 | epot = -15.263022152211 | etot = -14.6424332454106 +89000 ekin = 0.113990204127984 | erot = 0.526494309539207 | epot = -15.2829177590758 | etot = -14.6424332454087 +90000 ekin = 0.122199339151894 | erot = 0.539158097285698 | epot = -15.3037906818477 | etot = -14.6424332454101 +91000 ekin = 0.130544275971403 | erot = 0.552626637865723 | epot = -15.3256041592524 | etot = -14.6424332454152 +92000 ekin = 0.138875666148815 | erot = 0.566952900962156 | epot = -15.3482618125355 | etot = -14.6424332454245 +93000 ekin = 0.147025440614642 | erot = 0.582146933737432 | epot = -15.3716056197897 | etot = -14.6424332454376 +94000 ekin = 0.154808946847822 | erot = 0.598175891801207 | epot = -15.3954180841032 | etot = -14.6424332454542 +95000 ekin = 0.162028449602152 | erot = 0.614965942453837 | epot = -15.4194276375299 | etot = -14.6424332454739 +96000 ekin = 0.168477779667818 | erot = 0.632405154082029 | epot = -15.4433161792459 | etot = -14.642433245496 +97000 ekin = 0.17394786302672 | erot = 0.650346631628325 | epot = -15.4667277401752 | etot = -14.6424332455201 +98000 ekin = 0.178232875004242 | erot = 0.668611435745948 | epot = -15.4892775562957 | etot = -14.6424332455455 +99000 ekin = 0.181136831926353 | erot = 0.686991165056211 | epot = -15.5105612425543 | etot = -14.6424332455718 +100000 ekin = 0.182480533643598 | erot = 0.705250413407778 | epot = -15.5301641926495 | etot = -14.6424332455981 +101000 ekin = 0.182108871451935 | erot = 0.723129571003179 | epot = -15.547671688079 | etot = -14.6424332456239 +102000 ekin = 0.179898581170268 | erot = 0.740348571090314 | epot = -15.5626803979088 | etot = -14.6424332456482 +103000 ekin = 0.175766517608084 | erot = 0.756612167825837 | epot = -15.5748119311039 | etot = -14.64243324567 +104000 ekin = 0.169678431535445 | erot = 0.771617166851602 | epot = -15.5837288440751 | etot = -14.6424332456881 +105000 ekin = 0.161658036036865 | erot = 0.785061742962005 | epot = -15.5891530247 | etot = -14.6424332457012 +106000 ekin = 0.151795867650478 | erot = 0.796656613424597 | epot = -15.5908857267829 | etot = -14.6424332457078 +107000 ekin = 0.140257112952727 | erot = 0.806137449197231 | epot = -15.5888278078568 | etot = -14.6424332457068 +108000 ekin = 0.127287240201241 | erot = 0.813277564481104 | epot = -15.5829980503796 | etot = -14.6424332456973 +109000 ekin = 0.113214025490917 | erot = 0.817899691734432 | epot = -15.573546962904 | etot = -14.6424332456787 +110000 ekin = 0.0984444823805213 | erot = 0.819885578053921 | epot = -15.5607633060856 | etot = -14.6424332456512 +111000 ekin = 0.0834553769364569 | erot = 0.819182262545785 | epot = -15.545070885098 | etot = -14.6424332456157 +112000 ekin = 0.0687764915871027 | erot = 0.815804215094415 | epot = -15.5270139522555 | etot = -14.642433245574 +113000 ekin = 0.0549665904028903 | erot = 0.809830999844441 | epot = -15.5072308357759 | etot = -14.6424332455285 +114000 ekin = 0.0425830583120619 | erot = 0.801400700350953 | epot = -15.4864170041452 | etot = -14.6424332454821 +115000 ekin = 0.032147280213263 | erot = 0.790699910049051 | epot = -15.4652804357003 | etot = -14.642433245438 +116000 ekin = 0.024108778034577 | erot = 0.777951546674724 | epot = -15.4444935701085 | etot = -14.6424332453992 +117000 ekin = 0.0188117102728931 | erot = 0.763402004774069 | epot = -15.4246469604154 | etot = -14.6424332453684 +118000 ekin = 0.0164673894159043 | erot = 0.747309167856945 | epot = -15.4062098026203 | etot = -14.6424332453474 +119000 ekin = 0.0171359296532898 | erot = 0.729932564575393 | epot = -15.3895017395657 | etot = -14.642433245337 +120000 ekin = 0.0207190822430497 | erot = 0.711526526250247 | epot = -15.3746788538305 | etot = -14.6424332453372 +121000 ekin = 0.0269649552319816 | erot = 0.692336677373422 | epot = -15.3617348779522 | etot = -14.6424332453468 +122000 ekin = 0.0354839220297736 | erot = 0.672599570214091 | epot = -15.3505167376079 | etot = -14.642433245364 +123000 ekin = 0.0457738626451366 | erot = 0.652544850165416 | epot = -15.3407519581971 | etot = -14.6424332453865 +124000 ekin = 0.0572521324296466 | erot = 0.632399068066114 | epot = -15.3320844459074 | etot = -14.6424332454117 +125000 ekin = 0.0692913736002564 | erot = 0.612390156186006 | epot = -15.324114775223 | etot = -14.6424332454368 +126000 ekin = 0.0812564128172846 | erot = 0.592751635109578 | epot = -15.3164412933862 | etot = -14.6424332454593 +127000 ekin = 0.0925398817823717 | erot = 0.573725774407888 | epot = -15.3086989016675 | etot = -14.6424332454772 +128000 ekin = 0.102594692018529 | erot = 0.55556513894369 | epot = -15.3005930764509 | etot = -14.6424332454887 +129000 ekin = 0.110961953873462 | erot = 0.538532171478003 | epot = -15.291927370844 | etot = -14.6424332454925 +130000 ekin = 0.117293279472125 | erot = 0.52289666445339 | epot = -15.2826231894136 | etot = -14.642433245488 +131000 ekin = 0.121366644774014 | erot = 0.508931150171021 | epot = -15.2727310404203 | etot = -14.6424332454752 +132000 ekin = 0.123095155538848 | erot = 0.49690439090507 | epot = -15.2624327918984 | etot = -14.6424332454545 +133000 ekin = 0.122528239670491 | erot = 0.487073282996463 | epot = -15.2520347680938 | etot = -14.6424332454268 +134000 ekin = 0.119845042600695 | erot = 0.47967360116923 | epot = -15.2419518891638 | etot = -14.6424332453939 +135000 ekin = 0.115340171966309 | erot = 0.474910093714588 | epot = -15.2326835110385 | etot = -14.6424332453576 +136000 ekin = 0.10940241928465 | erot = 0.472946484072521 | epot = -15.2247821486777 | etot = -14.6424332453205 +137000 ekin = 0.102487634021818 | erot = 0.473895929917005 | epot = -15.2188168092237 | etot = -14.6424332452849 +138000 ekin = 0.0950874634047233 | erot = 0.477812435582745 | epot = -15.2153331442409 | etot = -14.6424332452534 +139000 ekin = 0.0876961121512815 | erot = 0.484683617748011 | epot = -15.2148129751279 | etot = -14.6424332452286 +140000 ekin = 0.0807775418431626 | erot = 0.494425108537478 | epot = -15.2176358955931 | etot = -14.6424332452125 +141000 ekin = 0.0747355681577817 | erot = 0.50687677080795 | epot = -15.2240455841725 | etot = -14.6424332452068 +142000 ekin = 0.0698891098450116 | erot = 0.521800821238808 | epot = -15.2341231762965 | etot = -14.6424332452127 +143000 ekin = 0.0664544171866063 | erot = 0.538881922424094 | epot = -15.2477695848413 | etot = -14.6424332452306 +144000 ekin = 0.0645355104692083 | erot = 0.557729316020225 | epot = -15.2646980717496 | etot = -14.6424332452602 +145000 ekin = 0.0641233595162911 | erot = 0.577881111412627 | epot = -15.2844377162297 | etot = -14.6424332453008 +146000 ekin = 0.0651036077515188 | erot = 0.598810893851628 | epot = -15.3063477469538 | etot = -14.6424332453507 +147000 ekin = 0.0672719578973601 | erot = 0.619936843681753 | epot = -15.3296420469868 | etot = -14.6424332454077 +148000 ekin = 0.0703557492692045 | erot = 0.640633538190902 | epot = -15.3534225329294 | etot = -14.6424332454693 +149000 ekin = 0.0740398128642427 | erot = 0.660246523237691 | epot = -15.3767195816347 | etot = -14.6424332455328 +150000 ekin = 0.0779944201058678 | erot = 0.678109590376156 | epot = -15.398537256077 | etot = -14.642433245595 +151000 ekin = 0.0819030604172323 | erot = 0.693564488648094 | epot = -15.4179007947185 | etot = -14.6424332456531 +152000 ekin = 0.0854878938552624 | erot = 0.705982563003889 | epot = -15.4339037025634 | etot = -14.6424332457043 +153000 ekin = 0.0885310147328532 | erot = 0.714787575382088 | epot = -15.4457518358609 | etot = -14.6424332457459 +154000 ekin = 0.0908901012887555 | erot = 0.719478762727528 | epot = -15.4528021097924 | etot = -14.6424332457761 +155000 ekin = 0.092507570371455 | erot = 0.719653046097721 | epot = -15.4545938622626 | etot = -14.6424332457934 +156000 ekin = 0.0934129479728847 | erot = 0.715025243753982 | epot = -15.4508714375239 | etot = -14.642433245797 +157000 ekin = 0.0937187435779626 | erot = 0.705445163946324 | epot = -15.4415971533109 | etot = -14.6424332457866 +158000 ekin = 0.0936106185393401 | erot = 0.690910554325706 | epot = -15.4269544186278 | etot = -14.6424332457627 +159000 ekin = 0.0933330174010987 | erot = 0.671575051659785 | epot = -15.4073413147871 | etot = -14.6424332457262 +160000 ekin = 0.0931716565242322 | erot = 0.647750492120645 | epot = -15.3833553943234 | etot = -14.6424332456785 +161000 ekin = 0.0934343296231438 | erot = 0.619903194016586 | epot = -15.3557707692612 | etot = -14.6424332456215 +162000 ekin = 0.0944314104804186 | erot = 0.588644098979611 | epot = -15.3255087550173 | etot = -14.6424332455572 +163000 ekin = 0.0964572425739502 | erot = 0.55471294345392 | epot = -15.2936034315161 | etot = -14.6424332454882 +164000 ekin = 0.0997733472806136 | erot = 0.518956918561936 | epot = -15.2611635112594 | etot = -14.6424332454169 +165000 ekin = 0.104594102019911 | erot = 0.482304549422426 | epot = -15.2293318967882 | etot = -14.6424332453459 +166000 ekin = 0.11107527651625 | erot = 0.445735768512381 | epot = -15.1992442903065 | etot = -14.6424332452778 +167000 ekin = 0.11930559751358 | erot = 0.410249354728318 | epot = -15.1719881974571 | etot = -14.6424332452152 +168000 ekin = 0.129301354725086 | erot = 0.37682904617874 | epot = -15.1485636460642 | etot = -14.6424332451604 +169000 ekin = 0.14100396578975 | erot = 0.346409702527097 | epot = -15.1298469134321 | etot = -14.6424332451152 +170000 ekin = 0.154280377439942 | erot = 0.319844892417961 | epot = -15.1165585149394 | etot = -14.6424332450815 +171000 ekin = 0.168926178621544 | erot = 0.297877221606916 | epot = -15.109236645289 | etot = -14.6424332450606 +172000 ekin = 0.184671319364511 | erot = 0.281112611137243 | epot = -15.108217175555 | etot = -14.6424332450532 +173000 ekin = 0.201188345437118 | erot = 0.269999595570268 | epot = -15.1136211860672 | etot = -14.6424332450598 +174000 ekin = 0.218103052207035 | erot = 0.264814547402982 | epot = -15.12535084469 | etot = -14.6424332450799 +175000 ekin = 0.235007413035623 | erot = 0.265653545950115 | epot = -15.1430942040986 | etot = -14.6424332451129 +176000 ekin = 0.251474534267915 | erot = 0.272431389432266 | epot = -15.1663391688573 | etot = -14.6424332451571 +177000 ekin = 0.267075225143436 | erot = 0.284887984978803 | epot = -15.1943964553329 | etot = -14.6424332452107 +178000 ekin = 0.281395553895287 | erot = 0.302602030915412 | epot = -15.2264308300819 | etot = -14.6424332452712 +179000 ekin = 0.294054514411866 | erot = 0.325011526057904 | epot = -15.2614992858055 | etot = -14.6424332453358 +180000 ekin = 0.304720692896942 | erot = 0.351440214935852 | epot = -15.2985941532343 | etot = -14.6424332454015 +181000 ekin = 0.313126658918426 | erot = 0.381128639602688 | epot = -15.3366885439866 | etot = -14.6424332454655 +182000 ekin = 0.319079775823621 | erot = 0.413268071114152 | epot = -15.374781092463 | etot = -14.6424332455252 +183000 ekin = 0.322468290005762 | erot = 0.447035301736728 | epot = -15.4119368373208 | etot = -14.6424332455783 +184000 ekin = 0.323261947554671 | erot = 0.48162615508044 | epot = -15.4473213482583 | etot = -14.6424332456231 +185000 ekin = 0.321506983530827 | erot = 0.516285658867815 | epot = -15.4802258880574 | etot = -14.6424332456588 +186000 ekin = 0.317316057633682 | erot = 0.550333132629112 | epot = -15.5100824359478 | etot = -14.642433245685 +187000 ekin = 0.310854440590084 | erot = 0.583180936761968 | epot = -15.5364686230541 | etot = -14.642433245702 +188000 ekin = 0.302324329763947 | erot = 0.614346238385429 | epot = -15.55910381386 | etot = -14.6424332457106 +189000 ekin = 0.291949445197116 | erot = 0.64345577901281 | epot = -15.5778384699217 | etot = -14.6424332457118 +190000 ekin = 0.279961942768254 | erot = 0.67024418570442 | epot = -15.5926393741794 | etot = -14.6424332457067 +191000 ekin = 0.266593185653664 | erot = 0.694546781233348 | epot = -15.6035732125832 | etot = -14.6424332456962 +192000 ekin = 0.252069141623363 | erot = 0.716288088786984 | epot = -15.6107904760917 | etot = -14.6424332456814 +193000 ekin = 0.236610293254145 | erot = 0.735467302242536 | epot = -15.6145108411597 | etot = -14.642433245663 +194000 ekin = 0.22043514940511 | erot = 0.75214194302714 | epot = -15.615010338074 | etot = -14.6424332456418 +195000 ekin = 0.20376588009334 | erot = 0.76641079902996 | epot = -15.6126099247417 | etot = -14.6424332456184 +196000 ekin = 0.186834339037366 | erot = 0.778397083250806 | epot = -15.6076646678817 | etot = -14.6424332455935 +197000 ekin = 0.169886782294183 | erot = 0.788232586070618 | epot = -15.6005526139326 | etot = -14.6424332455678 +198000 ekin = 0.153185871077985 | erot = 0.796043434538987 | epot = -15.5916625511591 | etot = -14.6424332455421 +199000 ekin = 0.137008972987403 | erot = 0.801937915798979 | epot = -15.581380134304 | etot = -14.6424332455176 +200000 ekin = 0.121642272364804 | erot = 0.805996673261661 | epot = -15.5700721911217 | etot = -14.6424332454953 +201000 ekin = 0.107370722656483 | erot = 0.808265456806726 | epot = -15.5580694249396 | etot = -14.6424332454764 +202000 ekin = 0.0944644042392164 | erot = 0.808750524310001 | epot = -15.5456481740113 | etot = -14.6424332454621 +203000 ekin = 0.0831623790893979 | erot = 0.807416772443554 | epot = -15.5330123969865 | etot = -14.6424332454535 +204000 ekin = 0.0736556272335549 | erot = 0.80418872541979 | epot = -15.5202775981049 | etot = -14.6424332454516 +205000 ekin = 0.0660710401675949 | erot = 0.79895460735586 | epot = -15.50745889298 | etot = -14.6424332454565 +206000 ekin = 0.0604586317681684 | erot = 0.791573809424189 | epot = -15.4944656866607 | etot = -14.6424332454683 +207000 ekin = 0.0567840026883034 | erot = 0.781888054798422 | epot = -15.4811053029728 | etot = -14.642433245486 +208000 ekin = 0.0549275971601569 | erot = 0.769736381379661 | epot = -15.4670972240478 | etot = -14.642433245508 +209000 ekin = 0.054691444753805 | erot = 0.754973659533912 | epot = -15.4520983498196 | etot = -14.6424332455319 +210000 ekin = 0.055813012677523 | erot = 0.737491764374765 | epot = -15.4357380226072 | etot = -14.6424332455549 +211000 ekin = 0.0579847210238433 | erot = 0.717241838880031 | epot = -15.417659805478 | etot = -14.6424332455742 +212000 ekin = 0.0608768356205362 | erot = 0.694255492639193 | epot = -15.3975655738466 | etot = -14.6424332455869 +213000 ekin = 0.06416104270831 | erot = 0.668662476163316 | epot = -15.3752567644624 | etot = -14.6424332455907 +214000 ekin = 0.0675321043587428 | erot = 0.64070249551798 | epot = -15.3506678454611 | etot = -14.6424332455844 +215000 ekin = 0.070725533636788 | erot = 0.610729417267909 | epot = -15.3238881964721 | etot = -14.6424332455674 +216000 ekin = 0.0735300437834057 | erot = 0.579207054837054 | epot = -15.2951703441606 | etot = -14.6424332455401 +217000 ekin = 0.0757943994895767 | erot = 0.546696813208958 | epot = -15.2649244582023 | etot = -14.6424332455037 +218000 ekin = 0.0774290394184473 | erot = 0.513838451215592 | epot = -15.2337007360942 | etot = -14.6424332454601 +219000 ekin = 0.0784033323161932 | erot = 0.481325894960063 | epot = -15.2021624726878 | etot = -14.6424332454116 +220000 ekin = 0.0787395495628362 | erot = 0.449880299616975 | epot = -15.1710530945401 | etot = -14.6424332453603 +221000 ekin = 0.0785046319692606 | erot = 0.420222425154575 | epot = -15.1411603024325 | etot = -14.6424332453087 +222000 ekin = 0.0778006814288784 | erot = 0.393045972165179 | epot = -15.1132798988531 | etot = -14.642433245259 +223000 ekin = 0.0767549035403029 | erot = 0.368992968905302 | epot = -15.0881811176588 | etot = -14.6424332452132 +224000 ekin = 0.0755095293719489 | erot = 0.348631757026569 | epot = -15.0665745315716 | etot = -14.6424332451731 +225000 ekin = 0.0742120885680923 | erot = 0.332437700423116 | epot = -15.0490830341315 | etot = -14.6424332451403 +226000 ekin = 0.0730063028703669 | erot = 0.320776497496383 | epot = -15.0362160454828 | etot = -14.6424332451161 +227000 ekin = 0.072023814088989 | erot = 0.313889923623787 | epot = -15.0283469828147 | etot = -14.642433245102 +228000 ekin = 0.0713769419944175 | erot = 0.31188394524302 | epot = -15.025694132336 | etot = -14.6424332450985 +229000 ekin = 0.0711526728859894 | erot = 0.314719386436074 | epot = -15.0283053044287 | etot = -14.6424332451066 +230000 ekin = 0.0714080974064438 | erot = 0.322205638587393 | epot = -15.0360469811206 | etot = -14.6424332451268 +231000 ekin = 0.0721675361185073 | erot = 0.333998222200335 | epot = -15.0485990034776 | etot = -14.6424332451588 +232000 ekin = 0.073421602289788 | erot = 0.349601270465542 | epot = -15.0654561179573 | etot = -14.6424332452019 +233000 ekin = 0.0751284397495051 | erot = 0.368376135876568 | epot = -15.0859378208814 | etot = -14.6424332452553 +234000 ekin = 0.0772173235430231 | erot = 0.389557254435346 | epot = -15.1092078232955 | etot = -14.6424332453172 +235000 ekin = 0.0795947059788063 | erot = 0.412276079792834 | epot = -15.1343040311561 | etot = -14.6424332453845 +236000 ekin = 0.0821526186131156 | erot = 0.435593295650787 | epot = -15.1601791597182 | etot = -14.6424332454543 +237000 ekin = 0.084779101422344 | erot = 0.458538653868273 | epot = -15.1857510008135 | etot = -14.6424332455229 +238000 ekin = 0.0873700423841441 | erot = 0.480156759890549 | epot = -15.2099600478608 | etot = -14.6424332455861 +239000 ekin = 0.0898415153120331 | erot = 0.499556095556538 | epot = -15.2318308565087 | etot = -14.6424332456401 +240000 ekin = 0.0921414623518645 | erot = 0.515957735404849 | epot = -15.2505324434381 | etot = -14.6424332456814 +241000 ekin = 0.0942594490127862 | erot = 0.528739776890127 | epot = -15.2654324716098 | etot = -14.6424332457069 +242000 ekin = 0.0962332805866192 | erot = 0.537473606139427 | epot = -15.276140132441 | etot = -14.6424332457149 +243000 ekin = 0.0981515319325858 | erot = 0.541948785982857 | epot = -15.2825335636204 | etot = -14.642433245705 +244000 ekin = 0.100151482350114 | erot = 0.542184479376275 | epot = -15.2847692074041 | etot = -14.6424332456777 +245000 ekin = 0.102412491094951 | erot = 0.538426702319034 | epot = -15.2832724390489 | etot = -14.642433245635 +246000 ekin = 0.105145395544293 | erot = 0.531132085866979 | epot = -15.2787107269906 | etot = -14.6424332455793 +247000 ekin = 0.108578961411821 | erot = 0.52093999420686 | epot = -15.271952201133 | etot = -14.6424332455143 +248000 ekin = 0.112944688754725 | erot = 0.50863565229471 | epot = -15.2640135864931 | etot = -14.6424332454436 +249000 ekin = 0.118461348905719 | erot = 0.495107336752391 | epot = -15.2560019310293 | etot = -14.6424332453712 +250000 ekin = 0.125320510714173 | erot = 0.481300713195434 | epot = -15.2490544692103 | etot = -14.6424332453007 +251000 ekin = 0.133674056956427 | erot = 0.468173145421896 | epot = -15.2442804476139 | etot = -14.6424332452356 +252000 ekin = 0.143624355874461 | erot = 0.456650355971834 | epot = -15.2427079570251 | etot = -14.6424332451788 +253000 ekin = 0.155217400156353 | erot = 0.447587277163379 | epot = -15.2452379224523 | etot = -14.6424332451326 +254000 ekin = 0.168438906846637 | erot = 0.441734376015244 | epot = -15.2526065279605 | etot = -14.6424332450987 +255000 ekin = 0.183213121646734 | erot = 0.439710227351439 | epot = -15.2653565940763 | etot = -14.6424332450781 +256000 ekin = 0.199403908834921 | erot = 0.441980689731424 | epot = -15.283817843638 | etot = -14.6424332450717 +257000 ekin = 0.216817638464824 | erot = 0.448844730303074 | epot = -15.3080956138475 | etot = -14.6424332450796 +258000 ekin = 0.235207399038843 | erot = 0.460426746273175 | epot = -15.3380673904137 | etot = -14.6424332451017 +259000 ekin = 0.254278151369354 | erot = 0.476675120646266 | epot = -15.3733865171527 | etot = -14.6424332451371 +260000 ekin = 0.273692576680278 | erot = 0.497366691704049 | epot = -15.4134925135692 | etot = -14.6424332451849 +261000 ekin = 0.293077534076593 | erot = 0.522116767902341 | epot = -15.4576275472227 | etot = -14.6424332452438 +262000 ekin = 0.312031202024041 | erot = 0.550394247117889 | epot = -15.5048586944538 | etot = -14.6424332453119 +263000 ekin = 0.330131107619666 | erot = 0.58154128199589 | epot = -15.5541056350029 | etot = -14.6424332453873 +264000 ekin = 0.346943319973835 | erot = 0.614796773442864 | epot = -15.6041733388843 | etot = -14.6424332454676 +265000 ekin = 0.36203307825833 | erot = 0.649322794992431 | epot = -15.6537891188012 | etot = -14.6424332455505 +266000 ekin = 0.374977027500473 | erot = 0.684232889055386 | epot = -15.7016431621889 | etot = -14.6424332456331 +267000 ekin = 0.385377045185273 | erot = 0.718621072058621 | epot = -15.7464313629566 | etot = -14.6424332457127 +268000 ekin = 0.392875374680177 | erot = 0.751590369461549 | epot = -15.7868989899282 | etot = -14.6424332457865 +269000 ekin = 0.397170471139152 | erot = 0.782279784272065 | epot = -15.8218835012632 | etot = -14.6424332458519 +270000 ekin = 0.398032662028036 | erot = 0.809888771673587 | epot = -15.8503546796086 | etot = -14.642433245907 +271000 ekin = 0.395318487598681 | erot = 0.833698516709737 | epot = -15.8714502502579 | etot = -14.6424332459495 +272000 ekin = 0.388982474352113 | erot = 0.853089551908481 | epot = -15.8845052722386 | etot = -14.642433245978 +273000 ekin = 0.379085147931406 | erot = 0.867555470405084 | epot = -15.8890738643282 | etot = -14.6424332459917 +274000 ekin = 0.36579632219322 | erot = 0.876712662629334 | epot = -15.8849422308128 | etot = -14.6424332459903 +275000 ekin = 0.349393082921511 | erot = 0.880306121913819 | epot = -15.8721324508092 | etot = -14.6424332459739 +276000 ekin = 0.330252358905648 | erot = 0.878211432148985 | epot = -15.8508970369982 | etot = -14.6424332459435 +277000 ekin = 0.308838461220188 | erot = 0.870433084876957 | epot = -15.8217047919976 | etot = -14.6424332459005 +278000 ekin = 0.285686394604086 | erot = 0.857099294885159 | epot = -15.7852189353358 | etot = -14.6424332458466 +279000 ekin = 0.261382042766412 | erot = 0.838453513181032 | epot = -15.7422688017312 | etot = -14.6424332457837 +280000 ekin = 0.23654047332595 | erot = 0.814842890587961 | epot = -15.6938166096284 | etot = -14.6424332457145 +281000 ekin = 0.211783602608016 | erot = 0.78670403285839 | epot = -15.6409208811076 | etot = -14.6424332456411 +282000 ekin = 0.187718337271894 | erot = 0.754546508157669 | epot = -15.5846980909958 | etot = -14.6424332455662 +283000 ekin = 0.164916115090795 | erot = 0.718934708845181 | epot = -15.5262840694281 | etot = -14.6424332454921 +284000 ekin = 0.143894549221715 | erot = 0.680468811939352 | epot = -15.4667966065823 | etot = -14.6424332454213 +285000 ekin = 0.125101678372295 | erot = 0.639765701847641 | epot = -15.4073006255757 | etot = -14.6424332453557 +286000 ekin = 0.108903164107394 | erot = 0.597440790010453 | epot = -15.3487771994148 | etot = -14.6424332452969 +287000 ekin = 0.0955726645551815 | erot = 0.554091668604978 | epot = -15.2920975784066 | etot = -14.6424332452464 +288000 ekin = 0.0852855448006968 | erot = 0.510284456822097 | epot = -15.2380032468277 | etot = -14.6424332452049 +289000 ekin = 0.07811604131029 | erot = 0.466543535623142 | epot = -15.1870928221065 | etot = -14.6424332451731 +290000 ekin = 0.0740379578618433 | erot = 0.423345127589082 | epot = -15.1398163306018 | etot = -14.6424332451509 +291000 ekin = 0.072928910063375 | erot = 0.381114879437431 | epot = -15.0964770346385 | etot = -14.6424332451377 +292000 ekin = 0.0745780357927571 | erot = 0.340229271737873 | epot = -15.0572405526631 | etot = -14.6424332451325 +293000 ekin = 0.0786969407539254 | erot = 0.301020346548472 | epot = -15.0221505324365 | etot = -14.6424332451341 +294000 ekin = 0.0849334564702411 | erot = 0.263782947588667 | epot = -14.9911496491996 | etot = -14.6424332451407 +295000 ekin = 0.0928875723607584 | erot = 0.228783448806939 | epot = -14.9641042663184 | etot = -14.6424332451507 +296000 ekin = 0.102128697507195 | erot = 0.19626884038738 | epot = -14.9408307830571 | etot = -14.6424332451625 +297000 ekin = 0.112213252496717 | erot = 0.166475068218863 | epot = -14.9211215658901 | etot = -14.6424332451745 +298000 ekin = 0.122701527066801 | erot = 0.139633685446912 | epot = -14.9047684576991 | etot = -14.6424332451854 +299000 ekin = 0.13317279291057 | erot = 0.115976150690173 | epot = -14.8915821887951 | etot = -14.6424332451943 +300000 ekin = 0.143237839707087 | erot = 0.0957354521215326 | epot = -14.8814065370293 | etot = -14.6424332452007 +301000 ekin = 0.152548387988438 | erot = 0.0791450908732747 | epot = -14.8741267240661 | etot = -14.6424332452044 +302000 ekin = 0.160803184299453 | erot = 0.0664357608561943 | epot = -14.8696721903613 | etot = -14.6424332452057 +303000 ekin = 0.167750948486611 | erot = 0.0578302677257495 | epot = -14.868014461417 | etot = -14.6424332452046 +304000 ekin = 0.173190665587053 | erot = 0.0535373136372916 | epot = -14.8691612244265 | etot = -14.6424332452022 +305000 ekin = 0.176969952948865 | erot = 0.0537447402909072 | epot = -14.8731479384385 | etot = -14.6424332451988 +306000 ekin = 0.178982363290529 | erot = 0.0586126977876584 | epot = -14.8800283062732 | etot = -14.642433245195 +307000 ekin = 0.179164502944002 | erot = 0.0682670321056827 | epot = -14.8898647802413 | etot = -14.6424332451916 +308000 ekin = 0.177493763288021 | erot = 0.0827930029186529 | epot = -14.9027200113955 | etot = -14.6424332451889 +309000 ekin = 0.173987301150961 | erot = 0.102229291870645 | epot = -14.9186498382089 | etot = -14.6424332451873 +310000 ekin = 0.168702678647172 | erot = 0.126562162216051 | epot = -14.9376980860502 | etot = -14.642433245187 +311000 ekin = 0.16174029700891 | erot = 0.155719593406526 | epot = -14.9598931356034 | etot = -14.642433245188 +312000 ekin = 0.15324744012492 | erot = 0.189565237977728 | epot = -14.985245923293 | etot = -14.6424332451904 +313000 ekin = 0.14342338999696 | erot = 0.227892126760383 | epot = -15.0137487619518 | etot = -14.6424332451944 +314000 ekin = 0.132524706018464 | erot = 0.270416174780403 | epot = -15.0453741259986 | etot = -14.6424332451998 +315000 ekin = 0.120869409552541 | erot = 0.31676970828902 | epot = -15.0800723630488 | etot = -14.6424332452072 +316000 ekin = 0.108838546104728 | erot = 0.366495437994318 | epot = -15.1177672293161 | etot = -14.642433245217 +317000 ekin = 0.0968734934277246 | erot = 0.419041536809129 | epot = -15.1583482754668 | etot = -14.6424332452299 +318000 ekin = 0.0854675378549793 | erot = 0.47375872576408 | epot = -15.2016595088657 | etot = -14.6424332452467 +319000 ekin = 0.0751507271451901 | erot = 0.529900497448216 | epot = -15.247484469862 | etot = -14.6424332452686 +320000 ekin = 0.0664678443364345 | erot = 0.586627760739854 | epot = -15.2955288503729 | etot = -14.6424332452966 +321000 ekin = 0.0599504590563252 | erot = 0.643019202691537 | epot = -15.3454029070798 | etot = -14.6424332453319 +322000 ekin = 0.0560852142800011 | erot = 0.698088453267024 | epot = -15.3966069129217 | etot = -14.6424332453747 +323000 ekin = 0.0552815181248971 | erot = 0.750808639916102 | epot = -15.4485234034659 | etot = -14.6424332454249 +324000 ekin = 0.057842325520568 | erot = 0.800144112657426 | epot = -15.5004196836595 | etot = -14.6424332454815 +325000 ekin = 0.0639414864634492 | erot = 0.845088070114938 | epot = -15.5514628021208 | etot = -14.6424332455424 +326000 ekin = 0.0736101694210054 | erot = 0.884703689967212 | epot = -15.6007471049934 | etot = -14.6424332456052 +327000 ekin = 0.0867333560896964 | erot = 0.91816541981297 | epot = -15.6473320215697 | etot = -14.642433245667 +328000 ekin = 0.103055779603987 | erot = 0.944796600223873 | epot = -15.6902856255527 | etot = -14.6424332457249 +329000 ekin = 0.12219544617078 | erot = 0.964099781594463 | epot = -15.7287284735416 | etot = -14.6424332457764 +330000 ekin = 0.143662406710238 | erot = 0.975776996237359 | epot = -15.7618726487672 | etot = -14.6424332458196 +331000 ekin = 0.166880785133575 | erot = 0.979738667517989 | epot = -15.7890526985047 | etot = -14.6424332458532 +332000 ekin = 0.191212923969923 | erot = 0.976101405902871 | epot = -15.8097475757491 | etot = -14.6424332458763 +333000 ekin = 0.215985355319577 | erot = 0.965176233539036 | epot = -15.8235948347474 | etot = -14.6424332458887 +334000 ekin = 0.240516656831147 | erot = 0.947449485112495 | epot = -15.8303993878336 | etot = -14.64243324589 +335000 ekin = 0.264146896086235 | erot = 0.923558676868035 | epot = -15.8301388188342 | etot = -14.6424332458799 +336000 ekin = 0.286267467754231 | erot = 0.894265184760612 | epot = -15.8229658983734 | etot = -14.6424332458586 +337000 ekin = 0.306349134750088 | erot = 0.860424939336672 | epot = -15.809207319913 | etot = -14.6424332458262 +338000 ekin = 0.323965497674696 | erot = 0.822957838322753 | epot = -15.7893565817813 | etot = -14.6424332457838 +339000 ekin = 0.338809250788985 | erot = 0.782816380150479 | epot = -15.7640588766724 | etot = -14.6424332457329 +340000 ekin = 0.35069944423374 | erot = 0.740954141303117 | epot = -15.7340868312125 | etot = -14.6424332456757 +341000 ekin = 0.359579293536495 | erot = 0.698295027831847 | epot = -15.700307566983 | etot = -14.6424332456147 +342000 ekin = 0.365505462154926 | erot = 0.655704542034982 | epot = -15.6636432497426 | etot = -14.6424332455527 +343000 ekin = 0.368630832661383 | erot = 0.613964463465552 | epot = -15.6250285416195 | etot = -14.6424332454926 +344000 ekin = 0.369183369589215 | erot = 0.573752273080787 | epot = -15.5853688881069 | etot = -14.6424332454369 +345000 ekin = 0.367443732824289 | erot = 0.535626361233146 | epot = -15.5455033394448 | etot = -14.6424332453874 +346000 ekin = 0.36372393313177 | erot = 0.500017626276193 | epot = -15.5061748047535 | etot = -14.6424332453455 +347000 ekin = 0.358348705277679 | erot = 0.467227585427262 | epot = -15.4680095360169 | etot = -14.642433245312 +348000 ekin = 0.351640582954838 | erot = 0.437432666908102 | epot = -15.4315064951499 | etot = -14.642433245287 +349000 ekin = 0.343909024694815 | erot = 0.410693986169929 | epot = -15.3970362561344 | etot = -14.6424332452696 +350000 ekin = 0.335443435968793 | erot = 0.386971649880727 | epot = -15.3648483311092 | etot = -14.6424332452597 +351000 ekin = 0.326509584093778 | erot = 0.366142474251511 | epot = -15.3350853036005 | etot = -14.6424332452552 +352000 ekin = 0.317348699022207 | erot = 0.34801993040111 | epot = -15.3078018746784 | etot = -14.6424332452551 +353000 ekin = 0.30817846664876 | erot = 0.332375117501944 | epot = -15.2829868294085 | etot = -14.6424332452578 +354000 ekin = 0.299195119854399 | erot = 0.318957598139001 | epot = -15.2605859632553 | etot = -14.6424332452619 +355000 ekin = 0.290575888248862 | erot = 0.307515001370356 | epot = -15.2405241348854 | etot = -14.6424332452662 +356000 ekin = 0.282481160312497 | erot = 0.29781040621721 | epot = -15.2227248117992 | etot = -14.6424332452695 +357000 ekin = 0.275055828993789 | erot = 0.289636664277857 | epot = -15.2071257385429 | etot = -14.6424332452713 +358000 ekin = 0.26842942725494 | erot = 0.282827006912222 | epot = -15.1936896794383 | etot = -14.6424332452711 +359000 ekin = 0.262714810201762 | erot = 0.277261507858003 | epot = -15.1824095633288 | etot = -14.642433245269 +360000 ekin = 0.258005302569436 | erot = 0.272869227748658 | epot = -15.1733077755836 | etot = -14.6424332452655 +361000 ekin = 0.254370400621781 | erot = 0.269626137802017 | epot = -15.1664297836851 | etot = -14.6424332452613 +362000 ekin = 0.251850290178651 | erot = 0.267549186087959 | epot = -15.1618327215239 | etot = -14.6424332452573 +363000 ekin = 0.250449609862751 | erot = 0.266687109597485 | epot = -15.159569964715 | etot = -14.6424332452548 +364000 ekin = 0.250131041863336 | erot = 0.267108788857729 | epot = -15.1596730759762 | etot = -14.6424332452551 +365000 ekin = 0.250809442162066 | erot = 0.268890073928026 | epot = -15.1621327613494 | etot = -14.6424332452593 +366000 ekin = 0.25234731876335 | erot = 0.272100073006091 | epot = -15.1668806370379 | etot = -14.6424332452684 +367000 ekin = 0.254552520178511 | erot = 0.276787886819413 | epot = -15.1737736522811 | etot = -14.6424332452832 +368000 ekin = 0.257178996153298 | erot = 0.282970699523766 | epot = -15.1825829409812 | etot = -14.6424332453042 +369000 ekin = 0.259931424908708 | erot = 0.29062401114344 | epot = -15.1929886813832 | etot = -14.642433245331 +370000 ekin = 0.262474349326632 | erot = 0.299674631814998 | epot = -15.2045822265049 | etot = -14.6424332453633 +371000 ekin = 0.264446209428301 | erot = 0.309996869297344 | epot = -15.2168763241253 | etot = -14.6424332453996 +372000 ekin = 0.265478281861433 | erot = 0.321412142686654 | epot = -15.2293236699864 | etot = -14.6424332454383 +373000 ekin = 0.265218028290041 | erot = 0.333692059448718 | epot = -15.2413433332161 | etot = -14.6424332454774 +374000 ekin = 0.26335572124772 | erot = 0.346564809671271 | epot = -15.2523537764331 | etot = -14.6424332455141 +375000 ekin = 0.259652497500777 | erot = 0.359724567998165 | epot = -15.2618103110451 | etot = -14.6424332455462 +376000 ekin = 0.253967268934319 | erot = 0.372843454384699 | epot = -15.2692439688902 | etot = -14.6424332455711 +377000 ekin = 0.246279333497663 | erot = 0.385585491299193 | epot = -15.2742980703837 | etot = -14.6424332455868 +378000 ekin = 0.236703249874173 | erot = 0.397621906702965 | epot = -15.2767584021691 | etot = -14.642433245592 +379000 ekin = 0.22549275694072 | erot = 0.408647066936832 | epot = -15.2765730694637 | etot = -14.6424332455862 +380000 ekin = 0.213031377534934 | erot = 0.418394279001949 | epot = -15.2738589021069 | etot = -14.64243324557 +381000 ekin = 0.19980887731166 | erot = 0.426650676217107 | epot = -15.2688927990735 | etot = -14.6424332455448 +382000 ekin = 0.186384809014969 | erot = 0.433270396060972 | epot = -15.2620884505889 | etot = -14.642433245513 +383000 ekin = 0.173342616140343 | erot = 0.4381852790555 | epot = -15.2539611406731 | etot = -14.6424332454773 +384000 ekin = 0.161239700828087 | erot = 0.441412371407271 | epot = -15.2450853176757 | etot = -14.6424332454403 +385000 ekin = 0.15055995464474 | erot = 0.443057612556821 | epot = -15.2360508126064 | etot = -14.6424332454049 +386000 ekin = 0.141675129696877 | erot = 0.443315241526503 | epot = -15.2274236165962 | etot = -14.6424332453728 +387000 ekin = 0.134820015696259 | erot = 0.442462667351556 | epot = -15.2197159283931 | etot = -14.6424332453452 +388000 ekin = 0.130083976412379 | erot = 0.44085081351593 | epot = -15.2133680352507 | etot = -14.6424332453224 +389000 ekin = 0.12741857023722 | erot = 0.43889024628032 | epot = -15.2087420618216 | etot = -14.6424332453041 +390000 ekin = 0.126658423092956 | erot = 0.43703370208669 | epot = -15.2061253704692 | etot = -14.6424332452895 +391000 ekin = 0.127550804261056 | erot = 0.435755902066133 | epot = -15.2057399516053 | etot = -14.6424332452781 +392000 ekin = 0.129788752936039 | erot = 0.435531744058152 | epot = -15.2077537422634 | etot = -14.6424332452692 +393000 ekin = 0.133043055316541 | erot = 0.43681406507717 | epot = -15.2122903656559 | etot = -14.6424332452622 +394000 ekin = 0.136989561466299 | erot = 0.440012156509965 | epot = -15.2194349632336 | etot = -14.6424332452574 +395000 ekin = 0.141329833042564 | erot = 0.445472096884898 | epot = -15.2292351751821 | etot = -14.6424332452547 +396000 ekin = 0.145804542777373 | erot = 0.45345976764831 | epot = -15.2416975556805 | etot = -14.6424332452548 +397000 ekin = 0.150200153188676 | erot = 0.464147173461378 | epot = -15.2567805719085 | etot = -14.6424332452585 +398000 ekin = 0.154350089766152 | erot = 0.477602441558481 | epot = -15.2743857765906 | etot = -14.642433245266 +399000 ekin = 0.158131920622366 | erot = 0.493783661155649 | epot = -15.2943488270562 | etot = -14.6424332452782 +400000 ekin = 0.161462056173796 | erot = 0.512536568006325 | epot = -15.3164318694755 | etot = -14.6424332452953 +401000 ekin = 0.164289301181072 | erot = 0.533595989002473 | epot = -15.3403185355012 | etot = -14.6424332453177 +402000 ekin = 0.166588323050693 | erot = 0.556590928839834 | epot = -15.3656124972355 | etot = -14.642433245345 +403000 ekin = 0.168353810379696 | erot = 0.581053183644485 | epot = -15.3918402394011 | etot = -14.6424332453769 +404000 ekin = 0.169595821301193 | erot = 0.606429376023291 | epot = -15.4184584427372 | etot = -14.6424332454127 +405000 ekin = 0.170336578562018 | erot = 0.63209629254071 | epot = -15.444866116554 | etot = -14.6424332454513 +406000 ekin = 0.170608761978812 | erot = 0.65737934451496 | epot = -15.4704213519851 | etot = -14.6424332454913 +407000 ekin = 0.170455178567329 | erot = 0.681573854094723 | epot = -15.4944622781935 | etot = -14.6424332455315 +408000 ekin = 0.169929554809759 | erot = 0.703968692151394 | epot = -15.5163314925311 | etot = -14.64243324557 +409000 ekin = 0.169098093451394 | erot = 0.723871579521683 | epot = -15.5354029185781 | etot = -14.6424332456051 +410000 ekin = 0.168041369040759 | erot = 0.740635137248624 | epot = -15.5511097519242 | etot = -14.6424332456348 +411000 ekin = 0.166856102809036 | erot = 0.753682569971393 | epot = -15.5629719184382 | etot = -14.6424332456577 +412000 ekin = 0.165656359033239 | erot = 0.762531725093238 | epot = -15.5706213297988 | etot = -14.6424332456724 +413000 ekin = 0.164573741711749 | erot = 0.766816218739624 | epot = -15.5738232061291 | etot = -14.6424332456777 +414000 ekin = 0.163756240957875 | erot = 0.766302377571564 | epot = -15.5724918642026 | etot = -14.6424332456732 +415000 ekin = 0.163365479945837 | erot = 0.76090092022446 | epot = -15.5666996458289 | etot = -14.6424332456586 +416000 ekin = 0.16357224009456 | erot = 0.750672586698944 | epot = -15.556678072428 | etot = -14.6424332456345 +417000 ekin = 0.164550286199954 | erot = 0.7358272978906 | epot = -15.5428108296923 | etot = -14.6424332456018 +418000 ekin = 0.166468663393413 | erot = 0.716716857299939 | epot = -15.5256187662552 | etot = -14.6424332455618 +419000 ekin = 0.169482781127082 | erot = 0.693821649098591 | epot = -15.5057376757421 | etot = -14.6424332455164 +420000 ekin = 0.173724722667737 | erot = 0.66773219168281 | epot = -15.4838901598182 | etot = -14.6424332454677 +421000 ekin = 0.179293310761201 | erot = 0.639126725581016 | epot = -15.4608532817598 | etot = -14.6424332454176 +422000 ekin = 0.18624451452154 | erot = 0.608746211198834 | epot = -15.437423971089 | etot = -14.6424332453687 +423000 ekin = 0.194582798147166 | erot = 0.577368165576623 | epot = -15.4143842090466 | etot = -14.6424332453228 +424000 ekin = 0.204253993032127 | erot = 0.545780680985215 | epot = -15.3924679192995 | etot = -14.6424332452822 +425000 ekin = 0.215140228919709 | erot = 0.514757766830984 | epot = -15.3723312409989 | etot = -14.6424332452482 +426000 ekin = 0.227057395200028 | erot = 0.485036881514174 | epot = -15.354527521936 | etot = -14.6424332452218 +427000 ekin = 0.239755526228602 | erot = 0.457299221560653 | epot = -15.3394879929934 | etot = -14.6424332452042 +428000 ekin = 0.252922416271923 | erot = 0.432153058134052 | epot = -15.3275087196016 | etot = -14.6424332451956 +429000 ekin = 0.266190667181531 | erot = 0.410120192007372 | epot = -15.3187441043849 | etot = -14.642433245196 +430000 ekin = 0.279148248287616 | erot = 0.391625457761957 | epot = -15.3132069512549 | etot = -14.6424332452053 +431000 ekin = 0.291352495295092 | erot = 0.376989149810484 | epot = -15.3107748903279 | etot = -14.6424332452223 +432000 ekin = 0.302347287571197 | erot = 0.366422254466197 | epot = -15.311202787284 | etot = -14.6424332452466 +433000 ekin = 0.311682921771834 | erot = 0.360024429012416 | epot = -15.3141405960599 | etot = -14.6424332452756 +434000 ekin = 0.318937954387398 | erot = 0.357784738270779 | epot = -15.3191559379664 | etot = -14.6424332453082 +435000 ekin = 0.323742037714837 | erot = 0.359585207272863 | epot = -15.3257604903308 | etot = -14.6424332453431 +436000 ekin = 0.325798554031316 | erot = 0.365207245305789 | epot = -15.3334390447156 | etot = -14.6424332453785 +437000 ekin = 0.324905697097303 | erot = 0.374340922349983 | epot = -15.3416798648586 | etot = -14.6424332454113 +438000 ekin = 0.320974589858357 | erot = 0.386596930160468 | epot = -15.3500047654588 | etot = -14.64243324544 +439000 ekin = 0.314043077746361 | erot = 0.401520852185505 | epot = -15.3579971753956 | etot = -14.6424332454637 +440000 ekin = 0.304283988020539 | erot = 0.41860913221399 | epot = -15.3653263657148 | etot = -14.6424332454802 +441000 ekin = 0.292006859111611 | erot = 0.437325916193047 | epot = -15.3717660207934 | etot = -14.6424332454888 +442000 ekin = 0.277652365815072 | erot = 0.457119792518877 | epot = -15.3772054038232 | etot = -14.6424332454893 +443000 ekin = 0.261778853590747 | erot = 0.477439412175799 | epot = -15.3816515112488 | etot = -14.6424332454822 +444000 ekin = 0.245040553434245 | erot = 0.497747053376455 | epot = -15.3852208522799 | etot = -14.6424332454692 +445000 ekin = 0.22815726042029 | erot = 0.517529408202492 | epot = -15.3881199140742 | etot = -14.6424332454515 +446000 ekin = 0.211875681729375 | erot = 0.536305196856599 | epot = -15.3906141240179 | etot = -14.6424332454319 +447000 ekin = 0.196923472681452 | erot = 0.553629632753464 | epot = -15.3929863508487 | etot = -14.6424332454138 +448000 ekin = 0.183958277880794 | erot = 0.569096233371 | epot = -15.3954877566523 | etot = -14.6424332454005 +449000 ekin = 0.173515771313211 | erot = 0.582336947151656 | epot = -15.3982859638601 | etot = -14.6424332453953 +450000 ekin = 0.16596236119942 | erot = 0.593021970145928 | epot = -15.4014175767459 | etot = -14.6424332454006 +451000 ekin = 0.161459280835239 | erot = 0.600860851249481 | epot = -15.4047533775022 | etot = -14.6424332454175 +452000 ekin = 0.159944578253891 | erot = 0.605606408076383 | epot = -15.4079842317757 | etot = -14.6424332454454 +453000 ekin = 0.161137653115343 | erot = 0.607062496368097 | epot = -15.410633394965 | etot = -14.6424332454815 +454000 ekin = 0.164567591513362 | erot = 0.605095779306141 | epot = -15.4120966163413 | etot = -14.6424332455218 +455000 ekin = 0.169622334209561 | erot = 0.599650455421321 | epot = -15.4117060351916 | etot = -14.6424332455607 +456000 ekin = 0.175611802350685 | erot = 0.590763702894581 | epot = -15.4088087508385 | etot = -14.6424332455932 +457000 ekin = 0.181835621982265 | erot = 0.578578749363229 | epot = -15.40284761696 | etot = -14.6424332456146 +458000 ekin = 0.187645727030889 | erot = 0.563352302649372 | epot = -15.3934312753016 | etot = -14.6424332456214 +459000 ekin = 0.192495880384907 | erot = 0.54545371714964 | epot = -15.380382843147 | etot = -14.6424332456124 +460000 ekin = 0.195973381637234 | erot = 0.525354597712022 | epot = -15.3637612249374 | etot = -14.6424332455881 +461000 ekin = 0.197811920991222 | erot = 0.503609203464283 | epot = -15.3438543700064 | etot = -14.6424332455509 +462000 ekin = 0.197887724919133 | erot = 0.480827560284776 | epot = -15.3211485307076 | etot = -14.6424332455037 +463000 ekin = 0.196203198485172 | erot = 0.457644248439133 | epot = -15.2962806923751 | etot = -14.6424332454508 +464000 ekin = 0.192863034125905 | erot = 0.434686220431894 | epot = -15.2699824999537 | etot = -14.6424332453959 +465000 ekin = 0.188047435822221 | erot = 0.412542760094015 | epot = -15.2430234412586 | etot = -14.6424332453423 +466000 ekin = 0.181986107552773 | erot = 0.39174001067487 | epot = -15.2161593635207 | etot = -14.642433245293 +467000 ekin = 0.174935400197984 | erot = 0.372721626737719 | epot = -15.1900902721857 | etot = -14.64243324525 +468000 ekin = 0.167159826102143 | erot = 0.355836258353913 | epot = -15.1654293296704 | etot = -14.6424332452144 +469000 ekin = 0.158918218022589 | erot = 0.34133189076746 | epot = -15.1426833539768 | etot = -14.6424332451868 +470000 ekin = 0.150454185653206 | erot = 0.329356584635659 | epot = -15.1222440154559 | etot = -14.642433245167 +471000 ekin = 0.141990180749416 | erot = 0.319964871778407 | epot = -15.1043882976824 | etot = -14.6424332451545 +472000 ekin = 0.13372435386821 | erot = 0.313128906246327 | epot = -15.089286505263 | etot = -14.6424332451484 +473000 ekin = 0.12582939810187 | erot = 0.308753392325055 | epot = -15.0770160355743 | etot = -14.6424332451474 +474000 ekin = 0.118452666363187 | erot = 0.306693264414364 | epot = -15.0675791759277 | etot = -14.6424332451502 +475000 ekin = 0.111716976218892 | erot = 0.306773053291038 | epot = -15.0609232746652 | etot = -14.6424332451553 +476000 ekin = 0.105721655633223 | erot = 0.308806833537935 | epot = -15.0569617343327 | etot = -14.6424332451616 +477000 ekin = 0.100543523675713 | erot = 0.312617617130682 | epot = -15.055594385974 | etot = -14.6424332451676 +478000 ekin = 0.0962376398644524 | erot = 0.31805505563592 | epot = -15.0567259406729 | etot = -14.6424332451726 +479000 ekin = 0.0928377950023796 | erot = 0.325010357031072 | epot = -15.0602813972091 | etot = -14.6424332451757 +480000 ekin = 0.0903568546344123 | erot = 0.333427427764652 | epot = -15.0662175275756 | etot = -14.6424332451766 +481000 ekin = 0.0887871989354825 | erot = 0.343309423711621 | epot = -15.074529867822 | etot = -14.6424332451749 +482000 ekin = 0.0881016191313879 | erot = 0.354720133059457 | epot = -15.085254997362 | etot = -14.6424332451711 +483000 ekin = 0.0882551127429667 | erot = 0.367779908275293 | epot = -15.0984682661837 | etot = -14.6424332451655 +484000 ekin = 0.0891880440123837 | erot = 0.382656193510863 | epot = -15.1142774826819 | etot = -14.6424332451586 +485000 ekin = 0.0908310739090695 | erot = 0.399549033149904 | epot = -15.1328133522102 | etot = -14.6424332451512 +486000 ekin = 0.0931120890965809 | erot = 0.418672269926982 | epot = -15.1542176041678 | etot = -14.6424332451442 +487000 ekin = 0.0959650526362282 | erot = 0.440231422324969 | epot = -15.1786297200997 | etot = -14.6424332451385 +488000 ekin = 0.09934026138313 | erot = 0.464399451388414 | epot = -15.2061729579063 | etot = -14.6424332451348 +489000 ekin = 0.103214957393528 | erot = 0.491291775407016 | epot = -15.2369399779348 | etot = -14.6424332451343 +490000 ekin = 0.107602676592561 | erot = 0.520941965501655 | epot = -15.2709778872321 | etot = -14.6424332451379 +491000 ekin = 0.112559247659633 | erot = 0.553279563919971 | epot = -15.3082720567263 | etot = -14.6424332451467 +492000 ekin = 0.118183136718381 | erot = 0.588111425310919 | epot = -15.3487278071915 | etot = -14.6424332451622 +493000 ekin = 0.124608040121107 | erot = 0.625107908280808 | epot = -15.3921491935878 | etot = -14.6424332451858 +494000 ekin = 0.131986393307421 | erot = 0.663795156036237 | epot = -15.4382147945631 | etot = -14.6424332452194 +495000 ekin = 0.140463823895351 | erot = 0.703554605722113 | epot = -15.4864516748821 | etot = -14.6424332452647 +496000 ekin = 0.150146408031555 | erot = 0.743630741562816 | epot = -15.5362103949171 | etot = -14.6424332453228 +497000 ekin = 0.161064579067727 | erot = 0.783147917316502 | epot = -15.5866457417786 | etot = -14.6424332453944 +498000 ekin = 0.173139219154636 | erot = 0.821136754971001 | epot = -15.6367092196045 | etot = -14.6424332454789 +499000 ekin = 0.186156317831577 | erot = 0.856570103854305 | epot = -15.6851596672597 | etot = -14.6424332455738 +500000 ekin = 0.199756195068125 | erot = 0.888407758271075 | epot = -15.7305971990145 | etot = -14.6424332456753 +501000 ekin = 0.213441517837528 | erot = 0.915648078729389 | epot = -15.7715228423447 | etot = -14.6424332457778 +502000 ekin = 0.226605416599141 | erot = 0.93738343364528 | epot = -15.8064220961188 | etot = -14.6424332458744 +503000 ekin = 0.238577508979596 | erot = 0.952855183120654 | epot = -15.833865938058 | etot = -14.6424332459578 +504000 ekin = 0.24868234701908 | erot = 0.961503066783773 | epot = -15.852618659824 | etot = -14.6424332460212 +505000 ekin = 0.256302488972939 | erot = 0.96300365636181 | epot = -15.8617393913938 | etot = -14.6424332460591 +506000 ekin = 0.26093758314799 | erot = 0.957293217915516 | epot = -15.8606640471316 | etot = -14.6424332460681 +507000 ekin = 0.262251679303339 | erot = 0.944571918253385 | epot = -15.8492568436041 | etot = -14.6424332460474 +508000 ekin = 0.260103184115661 | erot = 0.92528856492912 | epot = -15.8278249950432 | etot = -14.6424332459984 +509000 ekin = 0.254554875284732 | erot = 0.900107536932478 | epot = -15.7970956581425 | etot = -14.6424332459253 +510000 ekin = 0.245864483352381 | erot = 0.86986171798002 | epot = -15.7581594471659 | etot = -14.6424332458335 +511000 ekin = 0.234458914530907 | erot = 0.835496660121178 | epot = -15.7123888203816 | etot = -14.6424332457296 +512000 ekin = 0.220896820243755 | erot = 0.798011684060757 | epot = -15.6613417499247 | etot = -14.6424332456202 +513000 ekin = 0.205824805091356 | erot = 0.758403224573394 | epot = -15.6066612751765 | etot = -14.6424332455118 +514000 ekin = 0.189932244119312 | erot = 0.717614706855625 | epot = -15.5499801963846 | etot = -14.6424332454096 +515000 ekin = 0.173908748202557 | erot = 0.676495918868222 | epot = -15.4928379123889 | etot = -14.6424332453181 +516000 ekin = 0.158407108511411 | erot = 0.63577351602134 | epot = -15.4366138697731 | etot = -14.6424332452404 +517000 ekin = 0.144013350185933 | erot = 0.596033149114553 | epot = -15.3824797444789 | etot = -14.6424332451784 +518000 ekin = 0.131224514119668 | erot = 0.55771282568585 | epot = -15.3313705849382 | etot = -14.6424332451327 +519000 ekin = 0.120434042407116 | erot = 0.521106495595107 | epot = -15.2839737831051 | etot = -14.6424332451028 +520000 ekin = 0.111924165177635 | erot = 0.486376443197646 | epot = -15.240733853463 | etot = -14.6424332450877 +521000 ekin = 0.105864424816456 | erot = 0.453572806058813 | epot = -15.2018704759605 | etot = -14.6424332450853 +522000 ekin = 0.102315362067633 | erot = 0.422658367130362 | epot = -15.1674069742913 | etot = -14.6424332450933 +523000 ekin = 0.101236366465094 | erot = 0.393536647096269 | epot = -15.1372062586706 | etot = -14.6424332451092 +524000 ekin = 0.102496717236358 | erot = 0.366081244307823 | epot = -15.1110112066744 | etot = -14.6424332451302 +525000 ekin = 0.105888887335355 | erot = 0.340164343214516 | epot = -15.0884864757035 | etot = -14.6424332451536 +526000 ekin = 0.111143247849968 | erot = 0.315682368378613 | epot = -15.0692588614059 | etot = -14.6424332451774 +527000 ekin = 0.117943398961207 | erot = 0.292576937806905 | epot = -15.0529535819675 | etot = -14.6424332451994 +528000 ekin = 0.125941474254371 | erot = 0.270849598243589 | epot = -15.0392243177162 | etot = -14.6424332452183 +529000 ekin = 0.134772916008756 | erot = 0.250569317238961 | epot = -15.0277754784808 | etot = -14.642433245233 +530000 ekin = 0.144070383401965 | erot = 0.231872340651302 | epot = -15.0183759692967 | etot = -14.6424332452434 +531000 ekin = 0.153476601968781 | erot = 0.214954741433939 | epot = -15.0108645886523 | etot = -14.6424332452495 +532000 ekin = 0.162656054076991 | erot = 0.200058697647332 | epot = -15.0051479969763 | etot = -14.642433245252 +533000 ekin = 0.171305419079578 | erot = 0.18745414318241 | epot = -15.0011928075133 | etot = -14.6424332452513 +534000 ekin = 0.179162595538559 | erot = 0.177417842692309 | epot = -14.9990136834797 | etot = -14.6424332452488 +535000 ekin = 0.186014006484955 | erot = 0.17021209444076 | epot = -14.9986593461708 | etot = -14.6424332452451 +536000 ekin = 0.191699759238898 | erot = 0.166065149224471 | epot = -15.0001981537044 | etot = -14.642433245241 +537000 ekin = 0.196116169930243 | erot = 0.165155084977473 | epot = -15.003704500145 | etot = -14.6424332452373 +538000 ekin = 0.199215220532696 | erot = 0.167598364569312 | epot = -15.0092468303365 | etot = -14.6424332452345 +539000 ekin = 0.20100070966893 | erot = 0.173443713615195 | epot = -15.0168776685174 | etot = -14.6424332452333 +540000 ekin = 0.201521164037735 | erot = 0.182671367030132 | epot = -15.0266257763018 | etot = -14.6424332452339 +541000 ekin = 0.200859940141596 | erot = 0.195197211440065 | epot = -15.0384903968184 | etot = -14.6424332452368 +542000 ekin = 0.199123298889485 | erot = 0.210880936221535 | epot = -15.0524374803529 | etot = -14.6424332452419 +543000 ekin = 0.196427519384798 | erot = 0.229537017788165 | epot = -15.0683977824221 | etot = -14.6424332452492 +544000 ekin = 0.192886294946265 | erot = 0.25094720200201 | epot = -15.0862667422075 | etot = -14.6424332452593 +545000 ekin = 0.188599710888656 | erot = 0.274873110236005 | epot = -15.1059060663961 | etot = -14.6424332452715 +546000 ekin = 0.18364604524401 | erot = 0.301067663120887 | epot = -15.1271469536507 | etot = -14.6424332452858 +547000 ekin = 0.178077473819964 | erot = 0.329284179376543 | epot = -15.1497948984983 | etot = -14.6424332453018 +548000 ekin = 0.171920510268456 | erot = 0.359282253787671 | epot = -15.1736360093753 | etot = -14.6424332453191 +549000 ekin = 0.165181670578856 | erot = 0.390829837836003 | epot = -15.1984447537518 | etot = -14.6424332453369 +550000 ekin = 0.15785840865594 | erot = 0.423701326923092 | epot = -15.2239929809337 | etot = -14.6424332453547 +551000 ekin = 0.149954809005835 | erot = 0.457671882722257 | epot = -15.2500599370996 | etot = -14.6424332453715 +552000 ekin = 0.141500835822419 | erot = 0.492508662666464 | epot = -15.2764427438757 | etot = -14.6424332453869 +553000 ekin = 0.132573145480449 | erot = 0.527960055130273 | epot = -15.3029664460107 | etot = -14.6424332453999 +554000 ekin = 0.123314645146749 | erot = 0.563744383275372 | epot = -15.3294922738325 | etot = -14.6424332454104 +555000 ekin = 0.113949270900195 | erot = 0.599539792628959 | epot = -15.3559223089471 | etot = -14.642433245418 +556000 ekin = 0.104788088804118 | erot = 0.634977129568407 | epot = -15.3821984637958 | etot = -14.6424332454232 +557000 ekin = 0.0962230654738397 | erot = 0.669637513728588 | epot = -15.4082938246296 | etot = -14.6424332454272 +558000 ekin = 0.0887059614381524 | erot = 0.703055990484034 | epot = -15.4341951973535 | etot = -14.6424332454313 +559000 ekin = 0.0827118847692362 | erot = 0.734732129426798 | epot = -15.4598772596337 | etot = -14.6424332454377 +560000 ekin = 0.0786899547209647 | erot = 0.764147748400966 | epot = -15.4852709485704 | etot = -14.6424332454485 +561000 ekin = 0.0770067720584792 | erot = 0.790791153077553 | epot = -15.5102311706015 | etot = -14.6424332454654 +562000 ekin = 0.0778911706718854 | erot = 0.814186471630276 | epot = -15.5345108877916 | etot = -14.6424332454895 +563000 ekin = 0.0813901113631692 | erot = 0.833925925483943 | epot = -15.5577492823672 | etot = -14.6424332455201 +564000 ekin = 0.0873448530183735 | erot = 0.849702302566485 | epot = -15.5794804011401 | etot = -14.6424332455553 +565000 ekin = 0.0953935152513606 | erot = 0.861338569497979 | epot = -15.5991653303409 | etot = -14.6424332455915 +566000 ekin = 0.105001366117363 | erot = 0.868811531658242 | epot = -15.6162461434002 | etot = -14.6424332456246 +567000 ekin = 0.11551478920907 | erot = 0.872266750929345 | epot = -15.6302147857879 | etot = -14.6424332456494 +568000 ekin = 0.126230320989268 | erot = 0.872022546762513 | epot = -15.6406861134138 | etot = -14.642433245662 +569000 ekin = 0.13646757520452 | erot = 0.868561781939776 | epot = -15.6474626028035 | etot = -14.6424332456592 +570000 ekin = 0.145634823228517 | erot = 0.862511177264942 | epot = -15.6505792461335 | etot = -14.6424332456401 +571000 ekin = 0.153278250259444 | erot = 0.85460899135856 | epot = -15.6503204872235 | etot = -14.6424332456055 +572000 ekin = 0.159109636953228 | erot = 0.845662918619192 | epot = -15.6472058011307 | etot = -14.6424332455583 +573000 ekin = 0.163011362016512 | erot = 0.836500892322368 | epot = -15.6419454998419 | etot = -14.642433245503 +574000 ekin = 0.165021239079037 | erot = 0.827918058207513 | epot = -15.6353725427317 | etot = -14.6424332454451 +575000 ekin = 0.165302195907189 | erot = 0.820623479706097 | epot = -15.6283589210035 | etot = -14.6424332453902 +576000 ekin = 0.164102988099436 | erot = 0.815190165400348 | epot = -15.6217263988437 | etot = -14.642433245344 +577000 ekin = 0.161716152385033 | erot = 0.812011817945282 | epot = -15.6161612156414 | etot = -14.6424332453111 +578000 ekin = 0.158438569369342 | erot = 0.811269345694562 | epot = -15.6121411603589 | etot = -14.642433245295 +579000 ekin = 0.154538688866582 | erot = 0.812909695779756 | epot = -15.609881629944 | etot = -14.6424332452977 +580000 ekin = 0.150232988451456 | erot = 0.816638977239882 | epot = -15.6093052110108 | etot = -14.6424332453195 +581000 ekin = 0.145672809811769 | erot = 0.821931135408107 | epot = -15.610037190579 | etot = -14.6424332453591 +582000 ekin = 0.140941476788221 | erot = 0.828052590347089 | epot = -15.6114273125489 | etot = -14.6424332454136 +583000 ekin = 0.136060602595884 | erot = 0.834102246891801 | epot = -15.6125960949663 | etot = -14.6424332454786 +584000 ekin = 0.131003759893416 | erot = 0.839065139153076 | epot = -15.6125021445954 | etot = -14.6424332455489 +585000 ekin = 0.125715216480047 | erot = 0.841876757443314 | epot = -15.610025219542 | etot = -14.6424332456187 +586000 ekin = 0.120131224766283 | erot = 0.841493945660697 | epot = -15.6040584161089 | etot = -14.6424332456819 +587000 ekin = 0.114201380569862 | erot = 0.836967317747552 | epot = -15.5936019440503 | etot = -14.6424332457329 +588000 ekin = 0.107907808224941 | erot = 0.82750959597709 | epot = -15.577850649969 | etot = -14.642433245767 +589000 ekin = 0.101280337908465 | erot = 0.812554260667714 | epot = -15.5562678443569 | etot = -14.6424332457808 +590000 ekin = 0.0944063548781498 | erot = 0.791799488415112 | epot = -15.5286390890655 | etot = -14.6424332457722 +591000 ekin = 0.0874345511051164 | erot = 0.765233519218438 | epot = -15.4951013160648 | etot = -14.6424332457413 +592000 ekin = 0.0805723392090151 | erot = 0.733139214281057 | epot = -15.4561447991796 | etot = -14.6424332456895 +593000 ekin = 0.0740771594091624 | erot = 0.696077455345293 | epot = -15.4125878603745 | etot = -14.6424332456201 +594000 ekin = 0.0682423089615835 | erot = 0.654850963355498 | epot = -15.3655265178546 | etot = -14.6424332455375 +595000 ekin = 0.0633782539035135 | erot = 0.610451848321739 | epot = -15.3162633476725 | etot = -14.6424332454472 +596000 ekin = 0.0597906540673872 | erot = 0.563997548399991 | epot = -15.2662214478226 | etot = -14.6424332453552 +597000 ekin = 0.0577565493651072 | erot = 0.516660644083797 | epot = -15.2168504387165 | etot = -14.6424332452676 +598000 ekin = 0.0575003158564822 | erot = 0.469598294353737 | epot = -15.1695318554 | etot = -14.6424332451897 +599000 ekin = 0.0591710965315271 | erot = 0.423886769451641 | epot = -15.1254911111098 | etot = -14.6424332451266 +600000 ekin = 0.0628234356919084 | erot = 0.380465849282374 | epot = -15.085722530056 | etot = -14.6424332450817 +601000 ekin = 0.0684027903404234 | erot = 0.340096852290236 | epot = -15.0509328876879 | etot = -14.6424332450572 +602000 ekin = 0.0757374499151454 | erot = 0.303336891510158 | epot = -15.0215075864789 | etot = -14.6424332450536 +603000 ekin = 0.0845381560125067 | erot = 0.270530726253859 | epot = -14.9975021273365 | etot = -14.6424332450701 +604000 ekin = 0.0944063594091286 | erot = 0.241820347964902 | epot = -14.9786599524778 | etot = -14.6424332451038 +605000 ekin = 0.10485156246129 | erot = 0.217171224792453 | epot = -14.9644560324042 | etot = -14.6424332451505 +606000 ekin = 0.115317556389963 | erot = 0.19641293035746 | epot = -14.9541637319522 | etot = -14.6424332452047 +607000 ekin = 0.125216580352814 | erot = 0.179290709848685 | epot = -14.9469405354619 | etot = -14.6424332452604 +608000 ekin = 0.133969542489555 | erot = 0.165523445158836 | epot = -14.9419262329593 | etot = -14.6424332453109 +609000 ekin = 0.141049537027034 | erot = 0.154862582266178 | epot = -14.9383453646431 | etot = -14.6424332453499 +610000 ekin = 0.146025095174092 | erot = 0.1471460408894 | epot = -14.9356043814358 | etot = -14.6424332453723 +611000 ekin = 0.148599079333654 | erot = 0.142341118194537 | epot = -14.9333734429025 | etot = -14.6424332453743 +612000 ekin = 0.148639027540038 | erot = 0.140571068728109 | epot = -14.9316433416225 | etot = -14.6424332453543 +613000 ekin = 0.146195193891189 | erot = 0.14212144139606 | epot = -14.9307498806004 | etot = -14.6424332453132 +614000 ekin = 0.141503544703117 | erot = 0.147424293659367 | epot = -14.9313610836164 | etot = -14.6424332452539 +615000 ekin = 0.134972482667994 | erot = 0.157020849768205 | epot = -14.9344265776182 | etot = -14.642433245182 +616000 ekin = 0.127153892886345 | erot = 0.171505679771382 | epot = -14.9410928177621 | etot = -14.6424332451044 +617000 ekin = 0.118700960496639 | erot = 0.191457667913243 | epot = -14.9525918734392 | etot = -14.6424332450293 +618000 ekin = 0.110316794781978 | erot = 0.217364584488656 | epot = -14.9701146242355 | etot = -14.6424332449648 +619000 ekin = 0.102698942666746 | erot = 0.249548776229802 | epot = -14.9946809638153 | etot = -14.6424332449188 +620000 ekin = 0.0964852203328029 | erot = 0.28810131748882 | epot = -15.0270197827189 | etot = -14.6424332448972 +621000 ekin = 0.0922059091543824 | erot = 0.332831044361685 | epot = -15.0674701984207 | etot = -14.6424332449047 +622000 ekin = 0.0902463647122828 | erot = 0.383233451857076 | epot = -15.1159130615124 | etot = -14.6424332449431 +623000 ekin = 0.0908226920728038 | erot = 0.438482716259981 | epot = -15.1717386533448 | etot = -14.642433245012 +624000 ekin = 0.0939716062548715 | erot = 0.497448307331879 | epot = -15.2338531586956 | etot = -14.6424332451088 +625000 ekin = 0.0995541611252495 | erot = 0.55873588677621 | epot = -15.3007232931297 | etot = -14.6424332452283 +626000 ekin = 0.107271859328467 | erot = 0.620750477447864 | epot = -15.37045558214 | etot = -14.6424332453637 +627000 ekin = 0.116692826740179 | erot = 0.681778220892588 | epot = -15.4409042931397 | etot = -14.642433245507 +628000 ekin = 0.127285245275851 | erot = 0.740081431761277 | epot = -15.5097999226863 | etot = -14.6424332456492 +629000 ekin = 0.138455039155779 | erot = 0.794000196762996 | epot = -15.5748884817003 | etot = -14.6424332457815 +630000 ekin = 0.14958484293864 | erot = 0.842052640233787 | epot = -15.6340707290682 | etot = -14.6424332458958 +631000 ekin = 0.160071499854153 | erot = 0.883025442872994 | epot = -15.6855301887124 | etot = -14.6424332459852 +632000 ekin = 0.169359720293479 | erot = 0.916046503422886 | epot = -15.7278394697615 | etot = -14.6424332460451 +633000 ekin = 0.176970053692838 | erot = 0.940632922938759 | epot = -15.7600362227044 | etot = -14.6424332460728 +634000 ekin = 0.18251996128985 | erot = 0.956709735133355 | epot = -15.7816629424915 | etot = -14.6424332460683 +635000 ekin = 0.185737466035171 | erot = 0.964597760207225 | epot = -15.7927684722762 | etot = -14.6424332460338 +636000 ekin = 0.186467519302491 | erot = 0.964972204258569 | epot = -15.7938729695347 | etot = -14.6424332459737 +637000 ekin = 0.184671774603369 | erot = 0.958796660379843 | epot = -15.7859016808768 | etot = -14.6424332458936 +638000 ekin = 0.18042282577668 | erot = 0.947239527077098 | epot = -15.770095598654 | etot = -14.6424332458002 +639000 ekin = 0.173894119063272 | erot = 0.931581224200833 | epot = -15.7479085889646 | etot = -14.6424332457005 +640000 ekin = 0.165346701826059 | erot = 0.913120838758217 | epot = -15.720900786185 | etot = -14.6424332456007 +641000 ekin = 0.155113786101867 | erot = 0.893090060094414 | epot = -15.6906370917029 | etot = -14.6424332455066 +642000 ekin = 0.143583869242346 | erot = 0.872580710310524 | epot = -15.6585978249756 | etot = -14.6424332454227 +643000 ekin = 0.131182953687712 | erot = 0.85249016805802 | epot = -15.626106367098 | etot = -14.6424332453522 +644000 ekin = 0.118356305759397 | erot = 0.833486853993089 | epot = -15.5942764050497 | etot = -14.6424332452972 +645000 ekin = 0.105550209083444 | erot = 0.815995971214604 | epot = -15.5639794255564 | etot = -14.6424332452583 +646000 ekin = 0.0931942744180207 | erot = 0.800204061931992 | epot = -15.5358315815853 | etot = -14.6424332452353 +647000 ekin = 0.0816850001788838 | erot = 0.786079744440617 | epot = -15.5101979898464 | etot = -14.6424332452269 +648000 ekin = 0.0713713598428998 | erot = 0.773407243191854 | epot = -15.4872118482658 | etot = -14.6424332452311 +649000 ekin = 0.0625431628711437 | erot = 0.761828976528577 | epot = -15.466805384645 | etot = -14.6424332452453 +650000 ekin = 0.0554227735501042 | erot = 0.750893453411344 | epot = -15.4487494722283 | etot = -14.6424332452669 +651000 ekin = 0.0501605027659902 | erot = 0.740104978445366 | epot = -15.4326987265041 | etot = -14.6424332452927 +652000 ekin = 0.0468336713668948 | erot = 0.728972100417369 | epot = -15.4182390171042 | etot = -14.64243324532 +653000 ekin = 0.0454490492583012 | erot = 0.71705228594169 | epot = -15.4049345805459 | etot = -14.6424332453459 +654000 ekin = 0.0459481524956013 | erot = 0.703990869780751 | epot = -15.3923722676445 | etot = -14.6424332453682 +655000 ekin = 0.0482147495301563 | erot = 0.689552835103781 | epot = -15.3802008300186 | etot = -14.6424332453846 +656000 ekin = 0.052083876127999 | erot = 0.6736463327468 | epot = -15.3681634542687 | etot = -14.6424332453939 +657000 ekin = 0.0573516620867098 | erot = 0.656337023113139 | epot = -15.3561219305948 | etot = -14.6424332453949 +658000 ekin = 0.0637853134946659 | erot = 0.637852348218005 | epot = -15.3440709071003 | etot = -14.6424332453876 +659000 ekin = 0.0711326702887129 | erot = 0.618574815847064 | epot = -15.3321407315083 | etot = -14.6424332453725 +660000 ekin = 0.0791308828116024 | erot = 0.599023454708815 | epot = -15.3205875828713 | etot = -14.6424332453509 +661000 ekin = 0.0875139366244679 | erot = 0.579822939748233 | epot = -15.3097701216978 | etot = -14.6424332453251 +662000 ekin = 0.0960190004205311 | erot = 0.561660610348993 | epot = -15.3001128560677 | etot = -14.6424332452982 +663000 ekin = 0.104391848885269 | erot = 0.54523274605647 | epot = -15.2920578402154 | etot = -14.6424332452737 +664000 ekin = 0.112391863389534 | erot = 0.531182949320087 | epot = -15.286008057965 | etot = -14.6424332452554 +665000 ekin = 0.119797262719802 | erot = 0.520037124798746 | epot = -15.2822676327654 | etot = -14.6424332452468 +666000 ekin = 0.126411190061237 | erot = 0.512141060962394 | epot = -15.2809854962748 | etot = -14.6424332452511 +667000 ekin = 0.132069035722096 | erot = 0.507607681730268 | epot = -15.2821099627224 | etot = -14.64243324527 +668000 ekin = 0.13664691453854 | erot = 0.506281315754884 | epot = -15.2853614755972 | etot = -14.6424332453038 +669000 ekin = 0.140070616008884 | erot = 0.507725566171511 | epot = -15.2902294275315 | etot = -14.6424332453511 +670000 ekin = 0.142323740902266 | erot = 0.511239425097731 | epot = -15.2959964114084 | etot = -14.6424332454084 +671000 ekin = 0.143453306298606 | erot = 0.515903234043229 | epot = -15.3017897858128 | etot = -14.642433245471 +672000 ekin = 0.143571012728166 | erot = 0.520652256715664 | epot = -15.3066565149767 | etot = -14.6424332455328 +673000 ekin = 0.142848733833156 | erot = 0.52437156335394 | epot = -15.3096535427749 | etot = -14.6424332455878 +674000 ekin = 0.1415076132746 | erot = 0.526002362927187 | epot = -15.3099432218319 | etot = -14.6424332456301 +675000 ekin = 0.13980130282334 | erot = 0.524647629020819 | epot = -15.3068821774991 | etot = -14.6424332456549 +676000 ekin = 0.137995095209388 | erot = 0.519664439037725 | epot = -15.3000927799067 | etot = -14.6424332456596 +677000 ekin = 0.136343677284998 | erot = 0.510732098514415 | epot = -15.2895090214424 | etot = -14.642433245643 +678000 ekin = 0.135070664123473 | erot = 0.497888575253319 | epot = -15.2753924849829 | etot = -14.6424332456061 +679000 ekin = 0.134352810446714 | erot = 0.481532294129922 | epot = -15.2583183501282 | etot = -14.6424332455516 +680000 ekin = 0.134310862658442 | erot = 0.462390968603332 | epot = -15.2391350767452 | etot = -14.6424332454834 +681000 ekin = 0.135007638926465 | erot = 0.441462941783532 | epot = -15.2189038261164 | etot = -14.6424332454064 +682000 ekin = 0.136452461528359 | erot = 0.419938865037162 | epot = -15.1988245718911 | etot = -14.6424332453256 +683000 ekin = 0.138609887401901 | erot = 0.399112293315355 | epot = -15.1801554259633 | etot = -14.642433245246 +684000 ekin = 0.141410065652158 | erot = 0.380287181762659 | epot = -15.1641304925878 | etot = -14.642433245173 +685000 ekin = 0.144758102725849 | erot = 0.364688846299896 | epot = -15.1518801941367 | etot = -14.6424332451109 +686000 ekin = 0.148540467122542 | erot = 0.353383275614958 | epot = -15.1443569878014 | etot = -14.6424332450639 +687000 ekin = 0.152627512101174 | erot = 0.347208212231079 | epot = -15.1422689693677 | etot = -14.6424332450355 +688000 ekin = 0.156872371009907 | erot = 0.346718408270883 | epot = -15.1460240243093 | etot = -14.6424332450285 +689000 ekin = 0.161107527975576 | erot = 0.352146941114484 | epot = -15.1556877141346 | etot = -14.6424332450445 +690000 ekin = 0.165141087380535 | erot = 0.363384304940302 | epot = -15.1709586374048 | etot = -14.642433245084 +691000 ekin = 0.16875504264806 | erot = 0.379976931153832 | epot = -15.1911652189475 | etot = -14.6424332451456 +692000 ekin = 0.171707649701815 | erot = 0.401146558394006 | epot = -15.2152874533222 | etot = -14.6424332452264 +693000 ekin = 0.173741393440444 | erot = 0.425831232783773 | epot = -15.2420058715459 | etot = -14.6424332453217 +694000 ekin = 0.174597110621473 | erot = 0.452747528134232 | epot = -15.2697778841809 | etot = -14.6424332454252 +695000 ekin = 0.174033757468432 | erot = 0.480471830915669 | epot = -15.2969388339132 | etot = -14.6424332455291 +696000 ekin = 0.171852263360605 | erot = 0.507536398150921 | epot = -15.3218219071368 | etot = -14.6424332456253 +697000 ekin = 0.167921065286616 | erot = 0.532533688685243 | epot = -15.3428879996772 | etot = -14.6424332457054 +698000 ekin = 0.162200409472727 | erot = 0.55422061991701 | epot = -15.3588542751519 | etot = -14.6424332457621 +699000 ekin = 0.15476241571153 | erot = 0.5716133610199 | epot = -15.3688090225212 | etot = -14.6424332457897 +700000 ekin = 0.14580423000504 | erot = 0.584063387080082 | epot = -15.3723008628698 | etot = -14.6424332457847 +701000 ekin = 0.135652269555348 | erot = 0.591306922713837 | epot = -15.3693924380155 | etot = -14.6424332457463 +702000 ekin = 0.124756460204831 | erot = 0.59348246434204 | epot = -15.3606721702235 | etot = -14.6424332456766 +703000 ekin = 0.113674325949313 | erot = 0.591114401850656 | epot = -15.3472219733804 | etot = -14.6424332455805 +704000 ekin = 0.10304567594439 | erot = 0.585064323190966 | epot = -15.3305432446002 | etot = -14.6424332454648 +705000 ekin = 0.0935593581958762 | erot = 0.576454826529771 | epot = -15.3124474300639 | etot = -14.6424332453383 +706000 ekin = 0.0859140824287833 | erot = 0.566573150252444 | epot = -15.2949204778916 | etot = -14.6424332452103 +707000 ekin = 0.0807756759567746 | erot = 0.556763427605772 | epot = -15.2799723486536 | etot = -14.642433245091 +708000 ekin = 0.0787333622616091 | erot = 0.548316855287971 | epot = -15.2694834625388 | etot = -14.6424332449892 +709000 ekin = 0.0802577669172368 | erot = 0.542368667950884 | epot = -15.2650596797811 | etot = -14.642433244913 +710000 ekin = 0.0856633545554253 | erot = 0.539809747046289 | epot = -15.2679063464703 | etot = -14.6424332448686 +711000 ekin = 0.0950778519056264 | erot = 0.541219180888341 | epot = -15.2787302776541 | etot = -14.6424332448601 +712000 ekin = 0.108420876625267 | erot = 0.546822307908336 | epot = -15.2976764294225 | etot = -14.6424332448889 +713000 ekin = 0.125393451698069 | erot = 0.556476834654442 | epot = -15.3243035313066 | etot = -14.642433244954 +714000 ekin = 0.145479367624701 | erot = 0.569687600115953 | epot = -15.3576002127927 | etot = -14.642433245052 +715000 ekin = 0.167958541120038 | erot = 0.585648522299648 | epot = -15.3960403085969 | etot = -14.6424332451773 +716000 ekin = 0.191931735854292 | erot = 0.603308292527993 | epot = -15.4376732737045 | etot = -14.6424332453222 +717000 ekin = 0.216355400179768 | erot = 0.621454592033853 | epot = -15.4802432376918 | etot = -14.6424332454782 +718000 ekin = 0.240085056513064 | erot = 0.638810139728766 | epot = -15.5213284418775 | etot = -14.6424332456357 +719000 ekin = 0.261925698577658 | erot = 0.654132895983949 | epot = -15.5584918403468 | etot = -14.6424332457852 +720000 ekin = 0.280687969313511 | erot = 0.666312379865697 | epot = -15.5894335950967 | etot = -14.6424332459175 +721000 ekin = 0.295249345590605 | erot = 0.674454385927248 | epot = -15.6121369775423 | etot = -14.6424332460244 +722000 ekin = 0.304619886334631 | erot = 0.677947410255691 | epot = -15.625000542689 | etot = -14.6424332460987 +723000 ekin = 0.308011983728238 | erot = 0.676505724572098 | epot = -15.626950954435 | etot = -14.6424332461346 +724000 ekin = 0.304912667283913 | erot = 0.670186105902335 | epot = -15.6175320193145 | etot = -14.6424332461282 +725000 ekin = 0.295155116710332 | erot = 0.659377522493187 | epot = -15.5969658852808 | etot = -14.6424332460772 +726000 ekin = 0.278983134898071 | erot = 0.644765363163033 | epot = -15.5661817440431 | etot = -14.642433245982 +727000 ekin = 0.257098790791563 | erot = 0.627273860368268 | epot = -15.5268058970054 | etot = -14.6424332458455 +728000 ekin = 0.230680158271426 | erot = 0.607992016186298 | epot = -15.4811054201321 | etot = -14.6424332456743 +729000 ekin = 0.201354496272596 | erot = 0.588089464040467 | epot = -15.431877205792 | etot = -14.6424332454789 +730000 ekin = 0.171114103974836 | erot = 0.568729214721698 | epot = -15.3822765639703 | etot = -14.6424332452738 +731000 ekin = 0.142168923907651 | erot = 0.550984135076315 | epot = -15.3355863040605 | etot = -14.6424332450765 +732000 ekin = 0.116742007096091 | erot = 0.535763349049021 | epot = -15.2949386010514 | etot = -14.6424332449063 +733000 ekin = 0.0968293027534119 | erot = 0.523753647326195 | epot = -15.2630161948611 | etot = -14.6424332447815 +734000 ekin = 0.0839596135584089 | erot = 0.515379592342255 | epot = -15.2417724506168 | etot = -14.6424332447161 +735000 ekin = 0.0789983701762997 | erot = 0.510784464198618 | epot = -15.2322160790924 | etot = -14.6424332447175 +736000 ekin = 0.0820355551921124 | erot = 0.509832642267912 | epot = -15.2343014422445 | etot = -14.6424332447845 +737000 ekin = 0.092382712385484 | erot = 0.512132550856022 | epot = -15.246948508149 | etot = -14.6424332449075 +738000 ekin = 0.108680448513128 | erot = 0.517077971027173 | epot = -15.2681916646103 | etot = -14.64243324507 +739000 ekin = 0.129093715682691 | erot = 0.523904364925655 | epot = -15.2954313258603 | etot = -14.642433245252 +740000 ekin = 0.151555277793326 | erot = 0.531755895778055 | epot = -15.3257444190045 | etot = -14.6424332454331 +741000 ekin = 0.174012721806035 | erot = 0.539758083451399 | epot = -15.3562040508525 | etot = -14.6424332455951 +742000 ekin = 0.194640916830793 | erot = 0.547090549697037 | epot = -15.384164712252 | etot = -14.6424332457242 +743000 ekin = 0.211995737397977 | erot = 0.553054125335024 | epot = -15.4074831085446 | etot = -14.6424332458116 +744000 ekin = 0.225100508722008 | erot = 0.557126762307225 | epot = -15.4246605168831 | etot = -14.6424332458539 +745000 ekin = 0.233469424485825 | erot = 0.559003260236789 | epot = -15.4349059305745 | etot = -14.6424332458519 +746000 ekin = 0.23707991346408 | erot = 0.558614810498058 | epot = -15.4381279697723 | etot = -14.6424332458102 +747000 ekin = 0.236308652983949 | erot = 0.556125790081372 | epot = -15.4348676888016 | etot = -14.6424332457363 +748000 ekin = 0.231845097886983 | erot = 0.551907079329025 | epot = -15.4261854228555 | etot = -14.6424332456395 +749000 ekin = 0.224593843483339 | erot = 0.546487360028757 | epot = -15.4135144490424 | etot = -14.6424332455303 +750000 ekin = 0.215574369391403 | erot = 0.540486233484167 | epot = -15.3984938482956 | etot = -14.64243324542 +751000 ekin = 0.205824583426058 | erot = 0.534535356763698 | epot = -15.382793185509 | etot = -14.6424332453192 +752000 ekin = 0.196313335741561 | erot = 0.52919581521731 | epot = -15.3679423961964 | etot = -14.6424332452375 +753000 ekin = 0.187866475787076 | erot = 0.524881252730185 | epot = -15.3551809736995 | etot = -14.6424332451822 +754000 ekin = 0.181110613625657 | erot = 0.521796491095279 | epot = -15.345340349879 | etot = -14.6424332451581 +755000 ekin = 0.176438042203778 | erot = 0.519900210803623 | epot = -15.3387714981735 | etot = -14.6424332451661 +756000 ekin = 0.173994962646486 | erot = 0.518897676280608 | epot = -15.3353258841311 | etot = -14.642433245204 +757000 ekin = 0.173693190270073 | erot = 0.518265706177119 | epot = -15.3343921417132 | etot = -14.642433245266 +758000 ekin = 0.175243155014324 | erot = 0.517307659815294 | epot = -15.3349840601735 | etot = -14.6424332453439 +759000 ekin = 0.178203703092602 | erot = 0.515231902157482 | epot = -15.3358688506779 | etot = -14.6424332454278 +760000 ekin = 0.182042463548487 | erot = 0.51124383794149 | epot = -15.3357195469977 | etot = -14.6424332455077 +761000 ekin = 0.186199747761053 | erot = 0.50463982554006 | epot = -15.3332728188755 | etot = -14.6424332455744 +762000 ekin = 0.190149235945104 | erot = 0.494891409026585 | epot = -15.3274738905921 | etot = -14.6424332456204 +763000 ekin = 0.193449921094625 | erot = 0.481710238280476 | epot = -15.3175934050158 | etot = -14.6424332456407 +764000 ekin = 0.195785552426496 | erot = 0.465087294345703 | epot = -15.3033060924053 | etot = -14.6424332456331 +765000 ekin = 0.196989678184872 | erot = 0.445303873487263 | epot = -15.2847267972702 | etot = -14.6424332455981 +766000 ekin = 0.197055919182987 | erot = 0.422915440288454 | epot = -15.2624046050099 | etot = -14.6424332455385 +767000 ekin = 0.19613407649406 | erot = 0.398712320920584 | epot = -15.2372796428736 | etot = -14.6424332454589 +768000 ekin = 0.194513096652813 | erot = 0.37366293895697 | epot = -15.2106092809754 | etot = -14.6424332453656 +769000 ekin = 0.192592017627635 | erot = 0.348845887484862 | epot = -15.183871150378 | etot = -14.6424332452655 +770000 ekin = 0.190840163686923 | erot = 0.325376840212478 | epot = -15.1586502490658 | etot = -14.6424332451664 +771000 ekin = 0.189748397228249 | erot = 0.304335529900872 | epot = -15.1365171722054 | etot = -14.6424332450763 +772000 ekin = 0.18977434185156 | erot = 0.286697153922422 | epot = -15.1189047407765 | etot = -14.6424332450026 +773000 ekin = 0.191286034501482 | erot = 0.273271857838015 | epot = -15.1069911372911 | etot = -14.6424332449516 +774000 ekin = 0.194510000609465 | erot = 0.264655458971731 | epot = -15.1015987045099 | etot = -14.6424332449287 +775000 ekin = 0.199490639679827 | erot = 0.261194193157327 | epot = -15.1031180777734 | etot = -14.6424332449363 +776000 ekin = 0.206067477065984 | erot = 0.26296580393673 | epot = -15.1114665259772 | etot = -14.6424332449745 +777000 ekin = 0.213875019086146 | erot = 0.269778568413633 | epot = -15.1260868325404 | etot = -14.6424332450407 +778000 ekin = 0.222366868965164 | erot = 0.281188790676632 | epot = -15.1459889047712 | etot = -14.6424332451294 +779000 ekin = 0.230862102268941 | erot = 0.2965359441758 | epot = -15.1698312916782 | etot = -14.6424332452334 +780000 ekin = 0.238608567019415 | erot = 0.314993169090579 | epot = -15.1960349814538 | etot = -14.6424332453438 +781000 ekin = 0.244855557741695 | erot = 0.335629445234049 | epot = -15.222918248427 | etot = -14.6424332454513 +782000 ekin = 0.248927612478521 | erot = 0.357478674283205 | epot = -15.2488395323088 | etot = -14.642433245547 +783000 ekin = 0.250291897529516 | erot = 0.379610269023755 | epot = -15.2723354121766 | etot = -14.6424332456234 +784000 ekin = 0.248613283253053 | erot = 0.401195731117637 | epot = -15.2922422600447 | etot = -14.642433245674 +785000 ekin = 0.243793133450592 | erot = 0.421566090460737 | epot = -15.3077924696064 | etot = -14.6424332456951 +786000 ekin = 0.23598950185229 | erot = 0.440255905200772 | epot = -15.3186786527377 | etot = -14.6424332456846 +787000 ekin = 0.225617610784087 | erot = 0.457030673426299 | epot = -15.3250815298539 | etot = -14.6424332456436 +788000 ekin = 0.213330260901152 | erot = 0.471895861690097 | epot = -15.3276593681662 | etot = -14.642433245575 +789000 ekin = 0.19997849967651 | erot = 0.485087183877581 | epot = -15.3274989290384 | etot = -14.6424332454844 +790000 ekin = 0.186553834702627 | erot = 0.497043141237974 | epot = -15.3260302213197 | etot = -14.6424332453791 +791000 ekin = 0.174114766792028 | erot = 0.508362048565589 | epot = -15.3249100606257 | etot = -14.6424332452681 +792000 ekin = 0.163702420431615 | erot = 0.519746739177318 | epot = -15.3258824047698 | etot = -14.6424332451609 +793000 ekin = 0.156252224966357 | erot = 0.531940822986537 | epot = -15.3306262930203 | etot = -14.6424332450674 +794000 ekin = 0.152510350035351 | erot = 0.545660777312736 | epot = -15.3406043723442 | etot = -14.6424332449961 +795000 ekin = 0.152964251158983 | erot = 0.561528326979184 | epot = -15.3569258230923 | etot = -14.6424332449541 +796000 ekin = 0.157795747358379 | erot = 0.58000757877651 | epot = -15.3802365710807 | etot = -14.6424332449459 +797000 ekin = 0.166862457859208 | erot = 0.601351255568297 | epot = -15.4106469584007 | etot = -14.6424332449732 +798000 ekin = 0.179709603433377 | erot = 0.625560121844245 | epot = -15.4477029703127 | etot = -14.642433245035 +799000 ekin = 0.195609966062416 | erot = 0.65235924717518 | epot = -15.4904024583651 | etot = -14.6424332451275 +800000 ekin = 0.213626158791744 | erot = 0.681194021872009 | epot = -15.5372534259083 | etot = -14.6424332452445 +801000 ekin = 0.232687040193829 | erot = 0.711247726384584 | epot = -15.5863680119569 | etot = -14.6424332453785 +802000 ekin = 0.251669429106226 | erot = 0.741480919833726 | epot = -15.6355835944605 | etot = -14.6424332455205 +803000 ekin = 0.269477067858271 | erot = 0.77069100841835 | epot = -15.6826013219381 | etot = -14.6424332456615 +804000 ekin = 0.2851105414574 | erot = 0.797588259155217 | epot = -15.7251320464048 | etot = -14.6424332457922 +805000 ekin = 0.297723982505655 | erot = 0.82088252879607 | epot = -15.7610397572062 | etot = -14.6424332459044 +806000 ekin = 0.306666387686443 | erot = 0.839373432909784 | epot = -15.7884730665875 | etot = -14.6424332459913 +807000 ekin = 0.311506975554881 | erot = 0.852035914442116 | epot = -15.8059761360445 | etot = -14.6424332460475 +808000 ekin = 0.31204517625202 | erot = 0.858093398524567 | epot = -15.8125718208467 | etot = -14.6424332460701 +809000 ekin = 0.308306642386009 | erot = 0.857071970755237 | epot = -15.8078118591995 | etot = -14.6424332460582 +810000 ekin = 0.3005272205585 | erot = 0.848831113925777 | epot = -15.7917915804977 | etot = -14.6424332460134 +811000 ekin = 0.289127204417746 | erot = 0.83356913861968 | epot = -15.7651295889766 | etot = -14.6424332459392 +812000 ekin = 0.274678427598231 | erot = 0.811804116491095 | epot = -15.7289157899298 | etot = -14.6424332458404 +813000 ekin = 0.257866835579171 | erot = 0.784333459541309 | epot = -15.684633540844 | etot = -14.6424332457235 +814000 ekin = 0.23945308058907 | erot = 0.752176980195558 | epot = -15.63406330638 | etot = -14.6424332455953 +815000 ekin = 0.220233415146299 | erot = 0.716509170266206 | epot = -15.5791758308753 | etot = -14.6424332454628 +816000 ekin = 0.201002751041202 | erot = 0.678586569747871 | epot = -15.5220225661217 | etot = -14.6424332453326 +817000 ekin = 0.18252126107488 | erot = 0.639675603864852 | epot = -15.4646301101504 | etot = -14.6424332452107 +818000 ekin = 0.165485401522705 | erot = 0.600985363831257 | epot = -15.4089040104563 | etot = -14.6424332451023 +819000 ekin = 0.150503789775637 | erot = 0.563608719248849 | epot = -15.356545754036 | etot = -14.6424332450115 +820000 ekin = 0.138078032174191 | erot = 0.528474068971486 | epot = -15.3089853460871 | etot = -14.6424332449414 +821000 ekin = 0.128588386726458 | erot = 0.496309093116269 | epot = -15.2673307247368 | etot = -14.6424332448941 +822000 ekin = 0.122284066133841 | erot = 0.467617125513468 | epot = -15.2323344365177 | etot = -14.6424332448704 +823000 ekin = 0.119278020922153 | erot = 0.442666228475553 | epot = -15.2043774942682 | etot = -14.6424332448705 +824000 ekin = 0.119546158602336 | erot = 0.421490682734476 | epot = -15.1834700862298 | etot = -14.642433244893 +825000 ekin = 0.122931110514093 | erot = 0.403904342218594 | epot = -15.1692686976687 | etot = -14.6424332449361 +826000 ekin = 0.129150803764777 | erot = 0.389525074993895 | epot = -15.1611091237552 | etot = -14.6424332449966 +827000 ekin = 0.137812176400527 | erot = 0.377809252263535 | epot = -15.1580546737348 | etot = -14.6424332450707 +828000 ekin = 0.148430331610601 | erot = 0.368094906955077 | epot = -15.1589584837195 | etot = -14.6424332451538 +829000 ekin = 0.160453205764727 | erot = 0.359651737503703 | epot = -15.1625381885089 | etot = -14.6424332452404 +830000 ekin = 0.173291382900529 | erot = 0.351735589536635 | epot = -15.1674602177621 | etot = -14.642433245325 +831000 ekin = 0.186352012967339 | erot = 0.343644456321088 | epot = -15.17242971469 | etot = -14.6424332454015 +832000 ekin = 0.199074924610278 | erot = 0.334772487912379 | epot = -15.1762806579876 | etot = -14.6424332454649 +833000 ekin = 0.210968084885577 | erot = 0.324658115180513 | epot = -15.1780594455764 | etot = -14.6424332455103 +834000 ekin = 0.22163875726204 | erot = 0.313022323434694 | epot = -15.1770943262316 | etot = -14.6424332455348 +835000 ekin = 0.230816330006794 | erot = 0.299793483319765 | epot = -15.1730430588635 | etot = -14.6424332455369 +836000 ekin = 0.238363132178559 | erot = 0.285116039954826 | epot = -15.1659124176508 | etot = -14.6424332455174 +837000 ekin = 0.244270841534548 | erot = 0.269341751254572 | epot = -15.1560458382684 | etot = -14.6424332454793 +838000 ekin = 0.248642320238245 | erot = 0.253003904099761 | epot = -15.144079469765 | etot = -14.642433245427 +839000 ekin = 0.251661569328948 | erot = 0.236776758984022 | epot = -15.1308715736795 | etot = -14.6424332453665 +840000 ekin = 0.253557306828097 | erot = 0.221424057159249 | epot = -15.1174146092912 | etot = -14.6424332453038 +841000 ekin = 0.254567562695129 | erot = 0.20774147574213 | epot = -15.1047422836817 | etot = -14.6424332452444 +842000 ekin = 0.254912814680555 | erot = 0.196498262353486 | epot = -15.0938443222266 | etot = -14.6424332451926 +843000 ekin = 0.25478313076125 | erot = 0.188382921786766 | epot = -15.0855992976989 | etot = -14.6424332451509 +844000 ekin = 0.254340789692162 | erot = 0.183956927272162 | epot = -15.0807309620847 | etot = -14.6424332451204 +845000 ekin = 0.253734932885183 | erot = 0.183619247980868 | epot = -15.0797874259671 | etot = -14.6424332451011 +846000 ekin = 0.253120504189248 | erot = 0.187583282240197 | epot = -15.0831370315218 | etot = -14.6424332450923 +847000 ekin = 0.252671650081459 | erot = 0.195866742639432 | epot = -15.0909716378146 | etot = -14.6424332450937 +848000 ekin = 0.252580915304066 | erot = 0.208294222463377 | epot = -15.103308382873 | etot = -14.6424332451056 +849000 ekin = 0.253039966843089 | erot = 0.224511555531961 | epot = -15.1199847675035 | etot = -14.6424332451285 +850000 ekin = 0.254204001794782 | erot = 0.244010590097847 | epot = -15.1406478370558 | etot = -14.6424332451632 +851000 ekin = 0.256148339024743 | erot = 0.266162563602639 | epot = -15.1647441478372 | etot = -14.6424332452098 +852000 ekin = 0.258829686440357 | erot = 0.290257858698255 | epot = -15.1915207904057 | etot = -14.6424332452671 +853000 ekin = 0.262064657830147 | erot = 0.315549558167899 | epot = -15.2200474613301 | etot = -14.642433245332 +854000 ekin = 0.265534116125842 | erot = 0.341297947736774 | epot = -15.2492653092626 | etot = -14.6424332454 +855000 ekin = 0.268815174658127 | erot = 0.36681300443161 | epot = -15.2780614245547 | etot = -14.642433245465 +856000 ekin = 0.271435486960143 | erot = 0.391492007902569 | epot = -15.3053607403836 | etot = -14.6424332455209 +857000 ekin = 0.272939108069131 | erot = 0.414849750475003 | epot = -15.3302221041064 | etot = -14.6424332455623 +858000 ekin = 0.272951155046072 | erot = 0.436539390690098 | epot = -15.3519237913214 | etot = -14.6424332455852 +859000 ekin = 0.271229880682515 | erot = 0.456362750061876 | epot = -15.3700258763321 | etot = -14.6424332455877 +860000 ekin = 0.267698633839345 | erot = 0.474269718463609 | epot = -15.3844015978732 | etot = -14.6424332455702 +861000 ekin = 0.262455001757423 | erot = 0.490347316011031 | epot = -15.3952355633033 | etot = -14.6424332455349 +862000 ekin = 0.255758797180063 | erot = 0.504799761302306 | epot = -15.4029918039677 | etot = -14.6424332454854 +863000 ekin = 0.248003564343451 | erot = 0.517921532815844 | epot = -15.4083583425857 | etot = -14.6424332454264 +864000 ekin = 0.239677655585439 | erot = 0.530065823506495 | epot = -15.412176724455 | etot = -14.642433245363 +865000 ekin = 0.23132088944446 | erot = 0.541610953536998 | epot = -15.4153650882816 | etot = -14.6424332453002 +866000 ekin = 0.223481813673878 | erot = 0.552927233334005 | epot = -15.41884229225 | etot = -14.6424332452421 +867000 ekin = 0.216679174488124 | erot = 0.564346499433549 | epot = -15.4234589191144 | etot = -14.6424332451927 +868000 ekin = 0.211369750013082 | erot = 0.576136138939065 | epot = -15.4299391341069 | etot = -14.6424332451547 +869000 ekin = 0.207923502302006 | erot = 0.588478941150607 | epot = -15.4388356885827 | etot = -14.64243324513 +870000 ekin = 0.206606152993159 | erot = 0.601459626888393 | epot = -15.4504990250012 | etot = -14.6424332451197 +871000 ekin = 0.207568796750574 | erot = 0.615058451102447 | epot = -15.4650604929769 | etot = -14.6424332451239 +872000 ekin = 0.210843969893514 | erot = 0.629151875755212 | epot = -15.4824290907906 | etot = -14.6424332451419 +873000 ekin = 0.216347593110671 | erot = 0.643519970828197 | epot = -15.5023008091114 | etot = -14.6424332451726 +874000 ekin = 0.223886305134761 | erot = 0.65785990972427 | epot = -15.5241794600729 | etot = -14.6424332452139 +875000 ekin = 0.233169807544781 | erot = 0.671804662203727 | epot = -15.5474077150118 | etot = -14.6424332452633 +876000 ekin = 0.243827877955837 | erot = 0.684945735792129 | epot = -15.5712068590658 | etot = -14.6424332453179 +877000 ekin = 0.255431632539029 | erot = 0.69685856734628 | epot = -15.5947234452596 | etot = -14.6424332453743 +878000 ekin = 0.267518408507424 | erot = 0.707128927380235 | epot = -15.6170805813169 | etot = -14.6424332454292 +879000 ekin = 0.279619300254511 | erot = 0.715378495712557 | epot = -15.6374310414462 | etot = -14.6424332454792 +880000 ekin = 0.291287955017456 | erot = 0.721287639190631 | epot = -15.6550088397293 | etot = -14.6424332455213 +881000 ekin = 0.302128778463176 | erot = 0.724613422802369 | epot = -15.6691754468184 | etot = -14.6424332455529 +882000 ekin = 0.311822304069024 | erot = 0.725201068168812 | epot = -15.6794566178103 | etot = -14.6424332455725 +883000 ekin = 0.320145243789556 | erot = 0.722987481096488 | epot = -15.6855659704653 | etot = -14.6424332455793 +884000 ekin = 0.326982762202337 | erot = 0.717996120151906 | epot = -15.6874121279283 | etot = -14.642433245574 +885000 ekin = 0.332330882217347 | erot = 0.710323349665211 | epot = -15.6850874774409 | etot = -14.6424332455584 +886000 ekin = 0.336287673337102 | erot = 0.700117442969765 | epot = -15.6788383618422 | etot = -14.6424332455353 +887000 ekin = 0.33903296415872 | erot = 0.687552454430858 | epot = -15.6690186640981 | etot = -14.6424332455086 +888000 ekin = 0.340797654552155 | erot = 0.67280010093964 | epot = -15.6560310009741 | etot = -14.6424332454823 +889000 ekin = 0.341825106167166 | erot = 0.656003407096678 | epot = -15.6402617587246 | etot = -14.6424332454608 +890000 ekin = 0.342328347583419 | erot = 0.637256013160556 | epot = -15.6220176061914 | etot = -14.6424332454474 +891000 ekin = 0.342447730500021 | erot = 0.616590618565289 | epot = -15.6014715945102 | etot = -14.6424332454449 +892000 ekin = 0.342214057419104 | erot = 0.593979026501831 | epot = -15.5786263293753 | etot = -14.6424332454543 +893000 ekin = 0.34152200491664 | erot = 0.569344767729407 | epot = -15.5533000181212 | etot = -14.6424332454752 +894000 ekin = 0.340117934122997 | erot = 0.542587519912816 | epot = -15.525138699541 | etot = -14.6424332455052 +895000 ekin = 0.337605044786637 | erot = 0.513616778977938 | epot = -15.4936550693051 | etot = -14.6424332455405 +896000 ekin = 0.333467462875054 | erot = 0.48239077517223 | epot = -15.4582914836235 | etot = -14.6424332455762 +897000 ekin = 0.327113397523327 | erot = 0.448955709001807 | epot = -15.4185023521314 | etot = -14.6424332456062 +898000 ekin = 0.317936017621265 | erot = 0.413480165458539 | epot = -15.3738494287041 | etot = -14.6424332456243 +899000 ekin = 0.305389123795979 | erot = 0.376280077469313 | epot = -15.3241024468894 | etot = -14.6424332456241 +900000 ekin = 0.289072881395148 | erot = 0.337830752319287 | epot = -15.2693368793143 | etot = -14.6424332455999 +901000 ekin = 0.268822686259622 | erot = 0.298764046957452 | epot = -15.2100199787646 | etot = -14.6424332455475 +902000 ekin = 0.244791653968919 | erot = 0.259850521118035 | epot = -15.1470754205513 | etot = -14.6424332454644 +903000 ekin = 0.217514571462472 | erot = 0.221968047210473 | epot = -15.0819158640236 | etot = -14.6424332453507 +904000 ekin = 0.187939204411346 | erot = 0.186059692012592 | epot = -15.0164321416341 | etot = -14.6424332452102 +905000 ekin = 0.157410847731204 | erot = 0.153084564883822 | epot = -14.9529286576653 | etot = -14.6424332450503 +906000 ekin = 0.127599356271268 | erot = 0.123965703545286 | epot = -14.8939983046991 | etot = -14.6424332448825 +907000 ekin = 0.100365589130667 | erot = 0.0995389863896931 | epot = -14.8423378202422 | etot = -14.6424332447218 +908000 ekin = 0.0775759855945855 | erot = 0.0805066337401435 | epot = -14.800515863919 | etot = -14.6424332445842 +909000 ekin = 0.0608876950034 | erot = 0.0673982354567511 | epot = -14.7707191749454 | etot = -14.6424332444853 +910000 ekin = 0.0515382922989042 | erot = 0.0605415547706379 | epot = -14.7545130915067 | etot = -14.6424332444371 +911000 ekin = 0.0501789452911252 | erot = 0.0600446989620123 | epot = -14.7526568886991 | etot = -14.642433244446 +912000 ekin = 0.0567846925755769 | erot = 0.0657906450221707 | epot = -14.7650085821085 | etot = -14.6424332445108 +913000 ekin = 0.0706603747975489 | erot = 0.0774445361855688 | epot = -14.790538155607 | etot = -14.6424332446239 +914000 ekin = 0.0905398584143666 | erot = 0.0944735694282315 | epot = -14.8274466726145 | etot = -14.6424332447719 +915000 ekin = 0.114756144633904 | erot = 0.116178630204502 | epot = -14.8733680197774 | etot = -14.642433244939 +916000 ekin = 0.141447043407684 | erot = 0.141736093135102 | epot = -14.9256163816514 | etot = -14.6424332451087 +917000 ekin = 0.168758535424836 | erot = 0.170247440483737 | epot = -14.9814392211754 | etot = -14.6424332452668 +918000 ekin = 0.195014913443954 | erot = 0.200793639362701 | epot = -15.0382417982093 | etot = -14.6424332454026 +919000 ekin = 0.218837422087121 | erot = 0.232490666329554 | epot = -15.0937613339258 | etot = -14.6424332455091 +920000 ekin = 0.239206641026195 | erot = 0.264542267085039 | epot = -15.1461821536945 | etot = -14.6424332455832 +921000 ekin = 0.25547457715008 | erot = 0.296286050795184 | epot = -15.1941938735701 | etot = -14.6424332456248 +922000 ekin = 0.267338631216139 | erot = 0.327229363198297 | epot = -15.2370012400506 | etot = -14.6424332456361 +923000 ekin = 0.274791412213564 | erot = 0.357072039930916 | epot = -15.2742966977653 | etot = -14.6424332456208 +924000 ekin = 0.278059017514789 | erot = 0.385714059426418 | epot = -15.306206322525 | etot = -14.6424332455838 +925000 ekin = 0.277537405165931 | erot = 0.413247220089643 | epot = -15.333217870786 | etot = -14.6424332455304 +926000 ekin = 0.273733135235124 | erot = 0.439931173656047 | epot = -15.3560975543575 | etot = -14.6424332454664 +927000 ekin = 0.267211859637652 | erot = 0.466155363877246 | epot = -15.3758004689123 | etot = -14.6424332453974 +928000 ekin = 0.258555847531632 | erot = 0.492389553497958 | epot = -15.3933786463587 | etot = -14.6424332453291 +929000 ekin = 0.248330567886967 | erot = 0.519126582977394 | epot = -15.4098903961312 | etot = -14.6424332452668 +930000 ekin = 0.23705974716086 | erot = 0.546821711627624 | epot = -15.4263147040038 | etot = -14.6424332452153 +931000 ekin = 0.225208144800234 | erot = 0.575833282919438 | epot = -15.4434746728981 | etot = -14.6424332451784 +932000 ekin = 0.213171319360063 | erot = 0.606369490847652 | epot = -15.4619740553666 | etot = -14.6424332451589 +933000 ekin = 0.201271722990057 | erot = 0.638445690374705 | epot = -15.4821506585231 | etot = -14.6424332451583 +934000 ekin = 0.189760460104366 | erot = 0.67185600669489 | epot = -15.5040497119762 | etot = -14.6424332451769 +935000 ekin = 0.178823941832753 | erot = 0.706161996583042 | epot = -15.5274191836291 | etot = -14.6424332452133 +936000 ekin = 0.168594479109611 | erot = 0.74069986583281 | epot = -15.5517275902074 | etot = -14.642433245265 +937000 ekin = 0.159163635629916 | erot = 0.774606336201627 | epot = -15.5762032171597 | etot = -14.6424332453281 +938000 ekin = 0.150596971910416 | erot = 0.806861786791798 | epot = -15.5998920041003 | etot = -14.6424332453981 +939000 ekin = 0.142948711628538 | erot = 0.83634788352242 | epot = -15.6217298406206 | etot = -14.6424332454696 +940000 ekin = 0.136274889167971 | erot = 0.861915676024924 | epot = -15.6406238107303 | etot = -14.6424332455374 +941000 ekin = 0.130643703196498 | erot = 0.882459199117052 | epot = -15.6555361479098 | etot = -14.6424332455962 +942000 ekin = 0.126142088159105 | erot = 0.896989065169274 | epot = -15.66556439897 | etot = -14.6424332456417 +943000 ekin = 0.122877886109369 | erot = 0.904700444356692 | epot = -15.6700115761362 | etot = -14.6424332456702 +944000 ekin = 0.120977407412015 | erot = 0.905030230235472 | epot = -15.6684408833271 | etot = -14.6424332456797 +945000 ekin = 0.120578563691314 | erot = 0.897699054744981 | epot = -15.6607108641056 | etot = -14.6424332456693 +946000 ekin = 0.121820103594724 | erot = 0.882735070928503 | epot = -15.646988420163 | etot = -14.6424332456398 +947000 ekin = 0.124827761130805 | erot = 0.860477935596992 | epot = -15.6277389423211 | etot = -14.6424332455933 +948000 ekin = 0.129698334170726 | erot = 0.831563037038998 | epot = -15.6036946167428 | etot = -14.642433245533 +949000 ekin = 0.136482857560392 | erot = 0.796887554723542 | epot = -15.5758036577472 | etot = -14.6424332454633 +950000 ekin = 0.145170138933426 | erot = 0.757561255989732 | epot = -15.5451646403121 | etot = -14.642433245389 +951000 ekin = 0.155672002997215 | erot = 0.714845916095059 | epot = -15.5129511644075 | etot = -14.6424332453152 +952000 ekin = 0.167811650837965 | erot = 0.67008783325118 | epot = -15.480332729336 | etot = -14.6424332452469 +953000 ekin = 0.181316579472455 | erot = 0.624648095212333 | epot = -15.4483979198734 | etot = -14.6424332451886 +954000 ekin = 0.195817500701693 | erot = 0.579835080695355 | epot = -15.4180858265408 | etot = -14.6424332451437 +955000 ekin = 0.210854606876419 | erot = 0.536843219767442 | epot = -15.3901310717585 | etot = -14.6424332451147 +956000 ekin = 0.22589229983617 | erot = 0.496701376789191 | epot = -15.3650269217278 | etot = -14.6424332451025 +957000 ekin = 0.240343066496498 | erot = 0.460233438090612 | epot = -15.3430097496938 | etot = -14.6424332451067 +958000 ekin = 0.253600493836355 | erot = 0.428032849889929 | epot = -15.3240665888515 | etot = -14.6424332451252 +959000 ekin = 0.265080433744447 | erot = 0.400452005453988 | epot = -15.3079656843532 | etot = -14.6424332451548 +960000 ekin = 0.274268068126047 | erot = 0.37760654944402 | epot = -15.294307862761 | etot = -14.6424332451909 +961000 ekin = 0.280767177998564 | erot = 0.359393861243516 | epot = -15.2825942844706 | etot = -14.6424332452285 +962000 ekin = 0.284346484058158 | erot = 0.34552419881024 | epot = -15.2723039281308 | etot = -14.6424332452624 +963000 ekin = 0.284976816084592 | erot = 0.335562232322765 | epot = -15.2629722936953 | etot = -14.6424332452879 +964000 ekin = 0.282852494243092 | erot = 0.328975986490651 | epot = -15.2542617260353 | etot = -14.6424332453015 +965000 ekin = 0.278391086611333 | erot = 0.325189577593016 | epot = -15.2460139095058 | etot = -14.6424332453015 +966000 ekin = 0.272207924676324 | erot = 0.323635640145639 | epot = -15.2382768101098 | etot = -14.6424332452879 +967000 ekin = 0.265065367868708 | erot = 0.323803079983033 | epot = -15.2313016931144 | etot = -14.6424332452627 +968000 ekin = 0.257801293713459 | erot = 0.325275872287221 | epot = -15.2255104112304 | etot = -14.6424332452297 +969000 ekin = 0.251245661475255 | erot = 0.327759142573571 | epot = -15.2214380492424 | etot = -14.6424332451936 +970000 ekin = 0.246137008995617 | erot = 0.331089781179348 | epot = -15.2196600353345 | etot = -14.6424332451595 +971000 ekin = 0.243051319619918 | erot = 0.335230325664218 | epot = -15.220714890416 | etot = -14.6424332451318 +972000 ekin = 0.242353409643632 | erot = 0.340246678804405 | epot = -15.2250333335622 | etot = -14.6424332451142 +973000 ekin = 0.2441763381681 | erot = 0.346272190710886 | epot = -15.2328817739879 | etot = -14.642433245109 +974000 ekin = 0.248428661663904 | erot = 0.353462430362299 | epot = -15.2443243371435 | etot = -14.6424332451173 +975000 ekin = 0.254824314808745 | erot = 0.361946299431111 | epot = -15.2592038593792 | etot = -14.6424332451394 +976000 ekin = 0.26292684882563 | erot = 0.371779749930331 | epot = -15.2771398439303 | etot = -14.6424332451743 +977000 ekin = 0.27219923533505 | erot = 0.382908123264369 | epot = -15.29754060382 | etot = -14.6424332452206 +978000 ekin = 0.282052066854694 | erot = 0.395142048097406 | epot = -15.3196273602282 | etot = -14.6424332452761 +979000 ekin = 0.291885751915604 | erot = 0.408150081470976 | epot = -15.3424690787245 | etot = -14.6424332453379 +980000 ekin = 0.301125083790157 | erot = 0.421469125221772 | epot = -15.3650274544147 | etot = -14.6424332454028 +981000 ekin = 0.309246535916217 | erot = 0.434531423655031 | epot = -15.3862112050381 | etot = -14.6424332454669 +982000 ekin = 0.315799497488439 | erot = 0.446704965614828 | epot = -15.4049377086292 | etot = -14.642433245526 +983000 ekin = 0.320422573217629 | erot = 0.457342632741568 | epot = -15.4201984515353 | etot = -14.6424332455761 +984000 ekin = 0.322855465254252 | erot = 0.465834622596749 | epot = -15.4311233334646 | etot = -14.6424332456136 +985000 ekin = 0.322946302470394 | erot = 0.47165859097122 | epot = -15.4370381390773 | etot = -14.6424332456357 +986000 ekin = 0.320653917800696 | erot = 0.474422556587648 | epot = -15.437509720029 | etot = -14.6424332456406 +987000 ekin = 0.31604462735714 | erot = 0.473896755512796 | epot = -15.4323746284979 | etot = -14.642433245628 +988000 ekin = 0.309283477263999 | erot = 0.470032116942454 | epot = -15.4217488398048 | etot = -14.6424332455984 +989000 ekin = 0.300620522164939 | erot = 0.462964620619315 | epot = -15.406018388338 | etot = -14.6424332455537 +990000 ekin = 0.290373280687637 | erot = 0.453006262992374 | epot = -15.3858127891766 | etot = -14.6424332454965 +991000 ekin = 0.278906915702925 | erot = 0.440624526216757 | epot = -15.3619646873499 | etot = -14.6424332454302 +992000 ekin = 0.266613826413316 | erot = 0.42641300688875 | epot = -15.3354600786602 | etot = -14.6424332453582 +993000 ekin = 0.253894212445666 | erot = 0.411056197521998 | epot = -15.3073836552517 | etot = -14.6424332452841 +994000 ekin = 0.241138837000196 | erot = 0.395291372385701 | epot = -15.2788634545969 | etot = -14.642433245211 +995000 ekin = 0.228714768908018 | erot = 0.379870207852185 | epot = -15.2510182219023 | etot = -14.6424332451421 +996000 ekin = 0.216954417472331 | erot = 0.365522282703969 | epot = -15.2249099452561 | etot = -14.6424332450798 +997000 ekin = 0.206147766458768 | erot = 0.352922066134627 | epot = -15.2015030776195 | etot = -14.6424332450261 +998000 ekin = 0.196537413161314 | erot = 0.34266049598664 | epot = -15.1816311541306 | etot = -14.6424332449827 +999000 ekin = 0.188315843917132 | erot = 0.335221830000276 | epot = -15.1659709188677 | etot = -14.6424332449503 +1000000 ekin = 0.181624323072266 | erot = 0.330966139643081 | epot = -15.1550237076453 | etot = -14.6424332449299 + 1000000 0.013453654 -1.5270261 0.011523695 -1.4973399 -8.4815516e-05 +Loop time of 18.9591 on 1 procs for 1000000 steps with 10 atoms + +Performance: 45571.887 tau/day, 52745.239 timesteps/s +98.5% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 15.272 | 15.272 | 15.272 | 0.0 | 80.55 +Bond | 0.58511 | 0.58511 | 0.58511 | 0.0 | 3.09 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.19027 | 0.19027 | 0.19027 | 0.0 | 1.00 +Output | 8e-06 | 8e-06 | 8e-06 | 0.0 | 0.00 +Modify | 2.6225 | 2.6225 | 2.6225 | 0.0 | 13.83 +Other | | 0.2893 | | | 1.53 + +Nlocal: 10 ave 10 max 10 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 43 ave 43 max 43 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 43 +Ave neighs/atom = 4.3 +Ave special neighs/atom = 3.6 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:18 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.4 b/examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.4 new file mode 100644 index 0000000000..59800043d3 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA/duplex1/log.18Jun19.duplex1.g++.4 @@ -0,0 +1,1165 @@ +LAMMPS (18 Jun 2019) +variable number equal 1 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex1 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 10 atoms + reading velocities ... + 10 velocities + 10 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 8 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 2 = max # of 1-4 neighbors + 4 = max # of special neighbors + special bonds CPU = 0.000462 secs + read_data CPU = 0.004857 secs + +set atom * mass 3.1575 + 10 settings made for mass + +group all type 1 4 +10 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna/fene +bond_coeff * 2.0 0.25 0.7525 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk +pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna/stk seqav ${T} 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/stk seqav 0.1 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 + +# NVE ensemble +fix 1 all nve/dot +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.92828 + ghost atom cutoff = 1.92828 + binsize = 0.964142, bins = 42 42 42 + 5 neighbor lists, perpetual/occasional/extra = 5 0 0 + (1) pair oxdna/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.341 | 7.523 | 7.705 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.4711818 0.0069384985 -1.4642433 2.5836586e-06 +1000 ekin = 0.00113448721737009 | erot = 0.0041345594773427 | epot = -14.6477022915193 | etot = -14.6424332448246 +2000 ekin = 0.00449927223902292 | erot = 0.0164446434455803 | epot = -14.6633771605337 | etot = -14.6424332448491 +3000 ekin = 0.00997964450840756 | erot = 0.0366523356056466 | epot = -14.6890652250033 | etot = -14.6424332448892 +4000 ekin = 0.017388811129498 | erot = 0.0643039804300251 | epot = -14.7241260365031 | etot = -14.6424332449436 +5000 ekin = 0.0264744514136422 | erot = 0.0987844033142134 | epot = -14.7676920997383 | etot = -14.6424332450104 +6000 ekin = 0.0369277948555727 | erot = 0.13933657105258 | epot = -14.8186976109956 | etot = -14.6424332450875 +7000 ekin = 0.0483950557190949 | erot = 0.18508629569211 | epot = -14.8759145965832 | etot = -14.642433245172 +8000 ekin = 0.0604909336919856 | erot = 0.235071307523581 | epot = -14.9379954864767 | etot = -14.6424332452611 +9000 ekin = 0.0728137406439518 | erot = 0.288273694501614 | epot = -15.003520680497 | etot = -14.6424332453514 +10000 ekin = 0.0849615563084574 | erot = 0.343654369293588 | epot = -15.0710491710418 | etot = -14.6424332454398 +11000 ekin = 0.0965486715044103 | erot = 0.400187932108392 | epot = -15.1391698491357 | etot = -14.6424332455229 +12000 ekin = 0.107221466282716 | erot = 0.456896095459393 | epot = -15.2065508073401 | etot = -14.642433245598 +13000 ekin = 0.116672809719361 | erot = 0.512877765427946 | epot = -15.27198382081 | etot = -14.6424332456627 +14000 ekin = 0.124654073730849 | erot = 0.567333962045503 | epot = -15.3344212814915 | etot = -14.6424332457151 +15000 ekin = 0.130983939684084 | erot = 0.619586028257146 | epot = -15.3930032136957 | etot = -14.6424332457544 +16000 ekin = 0.135553354544703 | erot = 0.66908602849033 | epot = -15.4470726288154 | etot = -14.6424332457804 +17000 ekin = 0.138326263958104 | erot = 0.715418858086103 | epot = -15.4961783678378 | etot = -14.6424332457936 +18000 ekin = 0.139336096663942 | erot = 0.758296324628468 | epot = -15.5400656670878 | etot = -14.6424332457954 +19000 ekin = 0.138678360045107 | erot = 0.797544234276629 | epot = -15.5786558401095 | etot = -14.6424332457878 +20000 ekin = 0.136500074655344 | erot = 0.83308420441182 | epot = -15.6120175248401 | etot = -14.642433245773 +21000 ekin = 0.13298706528568 | erot = 0.864912408453368 | epot = -15.6403327194924 | etot = -14.6424332457533 +22000 ekin = 0.128350288213599 | erot = 0.893077649558725 | epot = -15.6638611835035 | etot = -14.6424332457311 +23000 ekin = 0.122812385135574 | erot = 0.917661024684598 | epot = -15.6829066555285 | etot = -14.6424332457083 +24000 ekin = 0.116595521408358 | erot = 0.938759014332585 | epot = -15.6977877814273 | etot = -14.6424332456863 +25000 ekin = 0.109911323474882 | erot = 0.95647120734756 | epot = -15.7088157764886 | etot = -14.6424332456662 +26000 ekin = 0.102953426207684 | erot = 0.970893163953299 | epot = -15.7162798358093 | etot = -14.6424332456483 +27000 ekin = 0.0958928250746602 | erot = 0.982114250193902 | epot = -15.7204403209011 | etot = -14.6424332456326 +28000 ekin = 0.08887594109497 | erot = 0.990219731539409 | epot = -15.721528918253 | etot = -14.6424332456186 +29000 ekin = 0.0820250748771992 | erot = 0.995296041202176 | epot = -15.7197543616852 | etot = -14.6424332456058 +30000 ekin = 0.0754407616837525 | erot = 0.997437949319921 | epot = -15.7153119565969 | etot = -14.6424332455933 +31000 ekin = 0.0692054432607511 | erot = 0.996756332760935 | epot = -15.708395021602 | etot = -14.6424332455803 +32000 ekin = 0.0633878377974532 | erot = 0.993385345347625 | epot = -15.6992064287111 | etot = -14.6424332455661 +33000 ekin = 0.0580474070866977 | erot = 0.987487973308193 | epot = -15.6879686259451 | etot = -14.6424332455502 +34000 ekin = 0.0532383791882916 | erot = 0.979259192919847 | epot = -15.6749308176403 | etot = -14.6424332455322 +35000 ekin = 0.0490128758302373 | erot = 0.96892619740531 | epot = -15.6603723187477 | etot = -14.6424332455122 +36000 ekin = 0.0454228081405034 | erot = 0.956745409624112 | epot = -15.6446014632554 | etot = -14.6424332454908 +37000 ekin = 0.0425203357170931 | erot = 0.942996237999014 | epot = -15.6279498191848 | etot = -14.6424332454687 +38000 ekin = 0.0403568280944582 | erot = 0.927971766615185 | epot = -15.6107618401563 | etot = -14.6424332454467 +39000 ekin = 0.0389804214208553 | erot = 0.911966804108842 | epot = -15.5933804709559 | etot = -14.6424332454262 +40000 ekin = 0.0384324238853386 | erot = 0.89526395956212 | epot = -15.5761296288558 | etot = -14.6424332454083 +41000 ekin = 0.0387429860406854 | erot = 0.878118672837898 | epot = -15.559294904273 | etot = -14.6424332453944 +42000 ekin = 0.0399266053637397 | erot = 0.860744395135588 | epot = -15.543104245885 | etot = -14.6424332453857 +43000 ekin = 0.041978156101278 | erot = 0.84329936535652 | epot = -15.5277107668409 | etot = -14.6424332453831 +44000 ekin = 0.044870189409001 | erot = 0.825876603313516 | epot = -15.5131800381094 | etot = -14.6424332453868 +45000 ekin = 0.0485521857416513 | erot = 0.808498758186241 | epot = -15.4994841893249 | etot = -14.642433245397 +46000 ekin = 0.0529522094038552 | erot = 0.791119212188506 | epot = -15.486504667005 | etot = -14.6424332454127 +47000 ekin = 0.0579809824244721 | erot = 0.773630265884098 | epot = -15.4740444937409 | etot = -14.6424332454323 +48000 ekin = 0.0635377846502182 | erot = 0.755878310838203 | epot = -15.4618493409424 | etot = -14.6424332454539 +49000 ekin = 0.0695169124467202 | erot = 0.737684732484798 | epot = -15.4496348904071 | etot = -14.6424332454756 +50000 ekin = 0.0758129058465097 | erot = 0.718870126220151 | epot = -15.437116277562 | etot = -14.6424332454953 +51000 ekin = 0.0823226638652294 | erot = 0.699278599520714 | epot = -15.424034508898 | etot = -14.642433245512 +52000 ekin = 0.0889431481344998 | erot = 0.67879880710002 | epot = -15.4101752007595 | etot = -14.642433245525 +53000 ekin = 0.0955646689265025 | erot = 0.657379086771117 | epot = -15.3953770012321 | etot = -14.6424332455345 +54000 ekin = 0.10206147751016 | erot = 0.635035489169276 | epot = -15.3795302122208 | etot = -14.6424332455414 +55000 ekin = 0.108282960174665 | erot = 0.611853171347244 | epot = -15.362569377068 | etot = -14.6424332455461 +56000 ekin = 0.114049426282277 | erot = 0.587982945924297 | epot = -15.3444656177552 | etot = -14.6424332455486 +57000 ekin = 0.119155806187163 | erot = 0.563635255922951 | epot = -15.3252243076589 | etot = -14.6424332455488 +58000 ekin = 0.123384552305545 | erot = 0.539073355222428 | epot = -15.3048911530734 | etot = -14.6424332455454 +59000 ekin = 0.126526300954853 | erot = 0.514606324858911 | epot = -15.2835658713509 | etot = -14.6424332455371 +60000 ekin = 0.128404399836229 | erot = 0.490581338840044 | epot = -15.261418984199 | etot = -14.6424332455227 +61000 ekin = 0.128898142361897 | erot = 0.467373892400972 | epot = -15.2387052802646 | etot = -14.6424332455018 +62000 ekin = 0.127959880289726 | erot = 0.445374820086222 | epot = -15.2157679458511 | etot = -14.6424332454752 +63000 ekin = 0.125622870624277 | erot = 0.424973765387148 | epot = -15.1930298814554 | etot = -14.642433245444 +64000 ekin = 0.121999044842466 | erot = 0.406539918572074 | epot = -15.1709722088251 | etot = -14.6424332454105 +65000 ekin = 0.117268056618551 | erot = 0.390401831020312 | epot = -15.1501031330161 | etot = -14.6424332453772 +66000 ekin = 0.11166038525652 | erot = 0.376828594078856 | epot = -15.1309222246818 | etot = -14.6424332453464 +67000 ekin = 0.105437746904482 | erot = 0.366014539811009 | epot = -15.1138855320359 | etot = -14.6424332453204 +68000 ekin = 0.0988737375602389 | erot = 0.358069014155077 | epot = -15.0993759970158 | etot = -14.6424332453005 +69000 ekin = 0.0922368286498126 | erot = 0.353011948771943 | epot = -15.0876820227093 | etot = -14.6424332452876 +70000 ekin = 0.0857769015271899 | erot = 0.350775174164931 | epot = -15.078985320974 | etot = -14.6424332452819 +71000 ekin = 0.0797156921641249 | erot = 0.351208844245481 | epot = -15.0733577816927 | etot = -14.6424332452831 +72000 ekin = 0.0742409440407228 | erot = 0.354092037747166 | epot = -15.0707662270784 | etot = -14.6424332452906 +73000 ekin = 0.069503749870388 | erot = 0.359146526961232 | epot = -15.0710835221349 | etot = -14.6424332453033 +74000 ekin = 0.065618449742691 | erot = 0.366052769878692 | epot = -15.0741044649412 | etot = -14.6424332453199 +75000 ekin = 0.0626644690394284 | erot = 0.374467290033975 | epot = -15.0795650044124 | etot = -14.642433245339 +76000 ekin = 0.0606895535091863 | erot = 0.384040683403432 | epot = -15.087163482272 | etot = -14.6424332453594 +77000 ekin = 0.0597139401241188 | erot = 0.394435495892894 | epot = -15.0965826813962 | etot = -14.6424332453792 +78000 ekin = 0.0597350629875199 | erot = 0.405343151481916 | epot = -15.107511459867 | etot = -14.6424332453975 +79000 ekin = 0.0607324264361021 | erot = 0.4164990176427 | epot = -15.1196646894919 | etot = -14.6424332454131 +80000 ekin = 0.0626722904954161 | erot = 0.427694630238743 | epot = -15.1328001661592 | etot = -14.6424332454251 +81000 ekin = 0.0655118235331528 | erot = 0.438786127849131 | epot = -15.1467311968152 | etot = -14.6424332454329 +82000 ekin = 0.0692024020836604 | erot = 0.449698113830624 | epot = -15.1613337613509 | etot = -14.6424332454366 +83000 ekin = 0.0736917936904884 | erot = 0.460422490740831 | epot = -15.1765475298676 | etot = -14.6424332454363 +84000 ekin = 0.0789250526542207 | erot = 0.471012272295187 | epot = -15.1923705703823 | etot = -14.6424332454329 +85000 ekin = 0.0848440878742484 | erot = 0.481570908650517 | epot = -15.2088482419521 | etot = -14.6424332454273 +86000 ekin = 0.0913860133243867 | erot = 0.492238169206351 | epot = -15.2260574279515 | etot = -14.6424332454207 +87000 ekin = 0.0984805441186007 | erot = 0.503174014617495 | epot = -15.2440878041506 | etot = -14.6424332454146 +88000 ekin = 0.106046830302566 | erot = 0.514542076496893 | epot = -15.2630221522094 | etot = -14.6424332454099 +89000 ekin = 0.113990204125935 | erot = 0.526494309539958 | epot = -15.2829177590739 | etot = -14.642433245408 +90000 ekin = 0.122199339149549 | erot = 0.539158097286396 | epot = -15.3037906818453 | etot = -14.6424332454094 +91000 ekin = 0.130544275968789 | erot = 0.552626637866402 | epot = -15.3256041592497 | etot = -14.6424332454146 +92000 ekin = 0.138875666145969 | erot = 0.566952900962838 | epot = -15.3482618125326 | etot = -14.6424332454238 +93000 ekin = 0.14702544061161 | erot = 0.582146933738122 | epot = -15.3716056197866 | etot = -14.6424332454369 +94000 ekin = 0.154808946844654 | erot = 0.598175891801918 | epot = -15.3954180841001 | etot = -14.6424332454535 +95000 ekin = 0.162028449598908 | erot = 0.614965942454569 | epot = -15.4194276375267 | etot = -14.6424332454732 +96000 ekin = 0.168477779664562 | erot = 0.632405154082769 | epot = -15.4433161792427 | etot = -14.6424332454953 +97000 ekin = 0.173947863023519 | erot = 0.650346631629065 | epot = -15.466727740172 | etot = -14.6424332455194 +98000 ekin = 0.178232875001165 | erot = 0.668611435746703 | epot = -15.4892775562927 | etot = -14.6424332455449 +99000 ekin = 0.181136831923469 | erot = 0.686991165056991 | epot = -15.5105612425515 | etot = -14.6424332455711 +100000 ekin = 0.182480533640974 | erot = 0.705250413408614 | epot = -15.530164192647 | etot = -14.6424332455974 +101000 ekin = 0.182108871449632 | erot = 0.723129571004103 | epot = -15.5476716880769 | etot = -14.6424332456232 +102000 ekin = 0.179898581168339 | erot = 0.740348571091352 | epot = -15.5626803979071 | etot = -14.6424332456474 +103000 ekin = 0.17576651760657 | erot = 0.756612167827034 | epot = -15.5748119311029 | etot = -14.6424332456693 +104000 ekin = 0.169678431534372 | erot = 0.771617166852996 | epot = -15.5837288440748 | etot = -14.6424332456874 +105000 ekin = 0.161658036036246 | erot = 0.785061742963598 | epot = -15.5891530247003 | etot = -14.6424332457005 +106000 ekin = 0.151795867650305 | erot = 0.796656613426427 | epot = -15.5908857267839 | etot = -14.6424332457071 +107000 ekin = 0.140257112952978 | erot = 0.806137449199291 | epot = -15.5888278078584 | etot = -14.6424332457061 +108000 ekin = 0.127287240201874 | erot = 0.813277564483374 | epot = -15.5829980503819 | etot = -14.6424332456966 +109000 ekin = 0.113214025491877 | erot = 0.817899691736857 | epot = -15.5735469629067 | etot = -14.642433245678 +110000 ekin = 0.0984444823817425 | erot = 0.819885578056442 | epot = -15.5607633060887 | etot = -14.6424332456505 +111000 ekin = 0.0834553769378644 | erot = 0.819182262548316 | epot = -15.5450708851012 | etot = -14.6424332456151 +112000 ekin = 0.0687764915886182 | erot = 0.815804215096852 | epot = -15.5270139522588 | etot = -14.6424332455734 +113000 ekin = 0.0549665904044371 | erot = 0.809830999846678 | epot = -15.507230835779 | etot = -14.6424332455279 +114000 ekin = 0.04258305831357 | erot = 0.801400700352889 | epot = -15.486417004148 | etot = -14.6424332454815 +115000 ekin = 0.0321472802146729 | erot = 0.790699910050576 | epot = -15.4652804357026 | etot = -14.6424332454374 +116000 ekin = 0.0241087780358441 | erot = 0.77795154667576 | epot = -15.4444935701102 | etot = -14.6424332453986 +117000 ekin = 0.0188117102739907 | erot = 0.763402004774545 | epot = -15.4246469604164 | etot = -14.6424332453678 +118000 ekin = 0.0164673894168237 | erot = 0.747309167856841 | epot = -15.4062098026205 | etot = -14.6424332453468 +119000 ekin = 0.0171359296540399 | erot = 0.72993256457469 | epot = -15.3895017395652 | etot = -14.6424332453364 +120000 ekin = 0.0207190822436548 | erot = 0.711526526248979 | epot = -15.3746788538292 | etot = -14.6424332453366 +121000 ekin = 0.0269649552324778 | erot = 0.692336677371657 | epot = -15.3617348779503 | etot = -14.6424332453462 +122000 ekin = 0.0354839220302051 | erot = 0.672599570211917 | epot = -15.3505167376055 | etot = -14.6424332453634 +123000 ekin = 0.0457738626455503 | erot = 0.652544850162978 | epot = -15.3407519581944 | etot = -14.6424332453859 +124000 ekin = 0.0572521324300892 | erot = 0.632399068063538 | epot = -15.3320844459047 | etot = -14.6424332454111 +125000 ekin = 0.0692913736007693 | erot = 0.612390156183436 | epot = -15.3241147752204 | etot = -14.6424332454362 +126000 ekin = 0.0812564128179015 | erot = 0.592751635107163 | epot = -15.3164412933838 | etot = -14.6424332454587 +127000 ekin = 0.0925398817831139 | erot = 0.573725774405781 | epot = -15.3086989016655 | etot = -14.6424332454766 +128000 ekin = 0.102594692019405 | erot = 0.555565138942023 | epot = -15.3005930764495 | etot = -14.6424332454881 +129000 ekin = 0.110961953874467 | erot = 0.538532171476875 | epot = -15.2919273708433 | etot = -14.6424332454919 +130000 ekin = 0.117293279473242 | erot = 0.52289666445288 | epot = -15.2826231894136 | etot = -14.6424332454874 +131000 ekin = 0.121366644775211 | erot = 0.508931150171171 | epot = -15.272731040421 | etot = -14.6424332454746 +132000 ekin = 0.123095155540088 | erot = 0.496904390905875 | epot = -15.2624327918998 | etot = -14.6424332454539 +133000 ekin = 0.122528239671731 | erot = 0.487073282997897 | epot = -15.2520347680959 | etot = -14.6424332454262 +134000 ekin = 0.119845042601891 | erot = 0.47967360117123 | epot = -15.2419518891664 | etot = -14.6424332453933 +135000 ekin = 0.115340171967418 | erot = 0.474910093717058 | epot = -15.2326835110415 | etot = -14.642433245357 +136000 ekin = 0.109402419285639 | erot = 0.472946484075354 | epot = -15.2247821486809 | etot = -14.6424332453199 +137000 ekin = 0.102487634022662 | erot = 0.473895929920083 | epot = -15.218816809227 | etot = -14.6424332452843 +138000 ekin = 0.0950874634054098 | erot = 0.477812435585943 | epot = -15.2153331442442 | etot = -14.6424332452528 +139000 ekin = 0.0876961121518108 | erot = 0.484683617751208 | epot = -15.2148129751311 | etot = -14.6424332452281 +140000 ekin = 0.0807775418435451 | erot = 0.494425108540545 | epot = -15.217635895596 | etot = -14.6424332452119 +141000 ekin = 0.0747355681580393 | erot = 0.506876770810791 | epot = -15.2240455841751 | etot = -14.6424332452063 +142000 ekin = 0.0698891098451726 | erot = 0.521800821241339 | epot = -15.2341231762987 | etot = -14.6424332452121 +143000 ekin = 0.0664544171867034 | erot = 0.538881922426252 | epot = -15.247769584843 | etot = -14.64243324523 +144000 ekin = 0.064535510469277 | erot = 0.557729316021967 | epot = -15.2646980717509 | etot = -14.6424332452596 +145000 ekin = 0.0641233595163659 | erot = 0.577881111413926 | epot = -15.2844377162305 | etot = -14.6424332453002 +146000 ekin = 0.065103607751629 | erot = 0.598810893852487 | epot = -15.3063477469542 | etot = -14.6424332453501 +147000 ekin = 0.0672719578975296 | erot = 0.619936843682188 | epot = -15.3296420469869 | etot = -14.6424332454072 +148000 ekin = 0.0703557492694474 | erot = 0.64063353819095 | epot = -15.3534225329292 | etot = -14.6424332454688 +149000 ekin = 0.0740398128645644 | erot = 0.660246523237392 | epot = -15.3767195816342 | etot = -14.6424332455323 +150000 ekin = 0.0779944201062649 | erot = 0.67810959037558 | epot = -15.3985372560763 | etot = -14.6424332455945 +151000 ekin = 0.0819030604176924 | erot = 0.693564488647308 | epot = -15.4179007947176 | etot = -14.6424332456526 +152000 ekin = 0.0854878938557652 | erot = 0.705982563002958 | epot = -15.4339037025624 | etot = -14.6424332457037 +153000 ekin = 0.0885310147333713 | erot = 0.714787575381071 | epot = -15.4457518358598 | etot = -14.6424332457454 +154000 ekin = 0.0908901012892559 | erot = 0.719478762726488 | epot = -15.4528021097913 | etot = -14.6424332457756 +155000 ekin = 0.0925075703719017 | erot = 0.719653046096719 | epot = -15.4545938622615 | etot = -14.6424332457929 +156000 ekin = 0.0934129479732407 | erot = 0.715025243753081 | epot = -15.4508714375228 | etot = -14.6424332457965 +157000 ekin = 0.0937187435781918 | erot = 0.70544516394557 | epot = -15.4415971533099 | etot = -14.6424332457861 +158000 ekin = 0.093610618539412 | erot = 0.690910554325135 | epot = -15.4269544186267 | etot = -14.6424332457622 +159000 ekin = 0.093333017400989 | erot = 0.671575051659432 | epot = -15.4073413147861 | etot = -14.6424332457257 +160000 ekin = 0.0931716565239226 | erot = 0.647750492120542 | epot = -15.3833553943224 | etot = -14.642433245678 +161000 ekin = 0.0934343296226242 | erot = 0.619903194016743 | epot = -15.3557707692603 | etot = -14.6424332456209 +162000 ekin = 0.0944314104796886 | erot = 0.588644098980031 | epot = -15.3255087550164 | etot = -14.6424332455567 +163000 ekin = 0.0964572425730171 | erot = 0.554712943454593 | epot = -15.2936034315153 | etot = -14.6424332454877 +164000 ekin = 0.0997733472794941 | erot = 0.518956918562839 | epot = -15.2611635112587 | etot = -14.6424332454164 +165000 ekin = 0.10459410201863 | erot = 0.482304549423526 | epot = -15.2293318967876 | etot = -14.6424332453454 +166000 ekin = 0.111075276514836 | erot = 0.445735768513645 | epot = -15.1992442903058 | etot = -14.6424332452774 +167000 ekin = 0.119305597512064 | erot = 0.410249354729672 | epot = -15.1719881974565 | etot = -14.6424332452148 +168000 ekin = 0.129301354723501 | erot = 0.376829046180125 | epot = -15.1485636460635 | etot = -14.6424332451599 +169000 ekin = 0.141003965788129 | erot = 0.346409702528434 | epot = -15.1298469134313 | etot = -14.6424332451147 +170000 ekin = 0.154280377438315 | erot = 0.319844892419163 | epot = -15.1165585149384 | etot = -14.642433245081 +171000 ekin = 0.168926178619937 | erot = 0.297877221607912 | epot = -15.1092366452878 | etot = -14.64243324506 +172000 ekin = 0.184671319362945 | erot = 0.281112611137957 | epot = -15.1082171755535 | etot = -14.6424332450526 +173000 ekin = 0.201188345435608 | erot = 0.269999595570643 | epot = -15.1136211860654 | etot = -14.6424332450591 +174000 ekin = 0.218103052205593 | erot = 0.264814547402958 | epot = -15.1253508446879 | etot = -14.6424332450793 +175000 ekin = 0.235007413034248 | erot = 0.26565354594967 | epot = -15.1430942040961 | etot = -14.6424332451122 +176000 ekin = 0.251474534266605 | erot = 0.272431389431399 | epot = -15.1663391688545 | etot = -14.6424332451565 +177000 ekin = 0.267075225142185 | erot = 0.284887984977542 | epot = -15.1943964553297 | etot = -14.64243324521 +178000 ekin = 0.281395553894086 | erot = 0.302602030913814 | epot = -15.2264308300784 | etot = -14.6424332452705 +179000 ekin = 0.294054514410706 | erot = 0.325011526056047 | epot = -15.2614992858018 | etot = -14.642433245335 +180000 ekin = 0.304720692895809 | erot = 0.351440214933843 | epot = -15.2985941532305 | etot = -14.6424332454008 +181000 ekin = 0.31312665891731 | erot = 0.381128639600658 | epot = -15.3366885439828 | etot = -14.6424332454648 +182000 ekin = 0.319079775822511 | erot = 0.413268071112237 | epot = -15.3747810924591 | etot = -14.6424332455244 +183000 ekin = 0.322468290004652 | erot = 0.447035301735071 | epot = -15.4119368373172 | etot = -14.6424332455774 +184000 ekin = 0.323261947553553 | erot = 0.481626155079182 | epot = -15.447321348255 | etot = -14.6424332456223 +185000 ekin = 0.321506983529694 | erot = 0.516285658867092 | epot = -15.4802258880547 | etot = -14.6424332456579 +186000 ekin = 0.317316057632528 | erot = 0.55033313262905 | epot = -15.5100824359457 | etot = -14.6424332456841 +187000 ekin = 0.310854440588901 | erot = 0.583180936762646 | epot = -15.5364686230527 | etot = -14.6424332457011 +188000 ekin = 0.302324329762727 | erot = 0.614346238386904 | epot = -15.5591038138593 | etot = -14.6424332457097 +189000 ekin = 0.291949445195851 | erot = 0.643455779015123 | epot = -15.5778384699218 | etot = -14.6424332457108 +190000 ekin = 0.279961942766932 | erot = 0.670244185707557 | epot = -15.5926393741802 | etot = -14.6424332457057 +191000 ekin = 0.266593185652274 | erot = 0.694546781237238 | epot = -15.6035732125847 | etot = -14.6424332456952 +192000 ekin = 0.252069141621898 | erot = 0.716288088791539 | epot = -15.6107904760939 | etot = -14.6424332456804 +193000 ekin = 0.236610293252604 | erot = 0.735467302247627 | epot = -15.6145108411624 | etot = -14.6424332456621 +194000 ekin = 0.220435149403497 | erot = 0.752141943032621 | epot = -15.615010338077 | etot = -14.6424332456409 +195000 ekin = 0.203765880091669 | erot = 0.766410799035668 | epot = -15.6126099247448 | etot = -14.6424332456175 +196000 ekin = 0.18683433903566 | erot = 0.778397083256566 | epot = -15.6076646678848 | etot = -14.6424332455926 +197000 ekin = 0.169886782292475 | erot = 0.788232586076231 | epot = -15.6005526139356 | etot = -14.6424332455669 +198000 ekin = 0.153185871076313 | erot = 0.796043434544288 | epot = -15.5916625511618 | etot = -14.6424332455412 +199000 ekin = 0.137008972985806 | erot = 0.801937915803797 | epot = -15.5813801343063 | etot = -14.6424332455167 +200000 ekin = 0.121642272363325 | erot = 0.805996673265862 | epot = -15.5700721911235 | etot = -14.6424332454943 +201000 ekin = 0.107370722655158 | erot = 0.80826545681021 | epot = -15.5580694249408 | etot = -14.6424332454755 +202000 ekin = 0.0944644042380686 | erot = 0.808750524312687 | epot = -15.5456481740119 | etot = -14.6424332454612 +203000 ekin = 0.0831623790884404 | erot = 0.807416772445398 | epot = -15.5330123969864 | etot = -14.6424332454526 +204000 ekin = 0.0736556272327849 | erot = 0.80418872542083 | epot = -15.5202775981042 | etot = -14.6424332454506 +205000 ekin = 0.066071040166992 | erot = 0.798954607356127 | epot = -15.5074588929787 | etot = -14.6424332454556 +206000 ekin = 0.0604586317676969 | erot = 0.791573809423779 | epot = -15.4944656866589 | etot = -14.6424332454674 +207000 ekin = 0.0567840026879154 | erot = 0.781888054797448 | epot = -15.4811053029705 | etot = -14.6424332454851 +208000 ekin = 0.0549275971597956 | erot = 0.769736381378278 | epot = -15.4670972240452 | etot = -14.6424332455071 +209000 ekin = 0.0546914447534107 | erot = 0.754973659532307 | epot = -15.4520983498168 | etot = -14.642433245531 +210000 ekin = 0.0558130126770382 | erot = 0.737491764373139 | epot = -15.4357380226042 | etot = -14.642433245554 +211000 ekin = 0.0579847210232175 | erot = 0.717241838878594 | epot = -15.4176598054751 | etot = -14.6424332455733 +212000 ekin = 0.0608768356197291 | erot = 0.694255492638144 | epot = -15.3975655738438 | etot = -14.642433245586 +213000 ekin = 0.0641610427072956 | erot = 0.668662476162839 | epot = -15.37525676446 | etot = -14.6424332455898 +214000 ekin = 0.06753210435751 | erot = 0.640702495518234 | epot = -15.3506678454592 | etot = -14.6424332455835 +215000 ekin = 0.0707255336353407 | erot = 0.610729417269012 | epot = -15.3238881964708 | etot = -14.6424332455665 +216000 ekin = 0.0735300437817614 | erot = 0.579207054839078 | epot = -15.2951703441601 | etot = -14.6424332455392 +217000 ekin = 0.0757943994877656 | erot = 0.546696813211925 | epot = -15.2649244582025 | etot = -14.6424332455028 +218000 ekin = 0.0774290394165114 | erot = 0.51383845121948 | epot = -15.2337007360952 | etot = -14.6424332454592 +219000 ekin = 0.0784033323141814 | erot = 0.481325894964792 | epot = -15.2021624726897 | etot = -14.6424332454107 +220000 ekin = 0.0787395495608023 | erot = 0.449880299622429 | epot = -15.1710530945426 | etot = -14.6424332453594 +221000 ekin = 0.0785046319672615 | erot = 0.420222425160601 | epot = -15.1411603024356 | etot = -14.6424332453078 +222000 ekin = 0.0778006814269721 | erot = 0.39304597217159 | epot = -15.1132798988567 | etot = -14.6424332452581 +223000 ekin = 0.0767549035385447 | erot = 0.368992968911897 | epot = -15.0881811176628 | etot = -14.6424332452123 +224000 ekin = 0.0755095293703893 | erot = 0.348631757033145 | epot = -15.0665745315757 | etot = -14.6424332451722 +225000 ekin = 0.0742120885667742 | erot = 0.332437700429458 | epot = -15.0490830341357 | etot = -14.6424332451395 +226000 ekin = 0.073006302869323 | erot = 0.320776497502283 | epot = -15.0362160454868 | etot = -14.6424332451152 +227000 ekin = 0.0720238140882433 | erot = 0.313889923629061 | epot = -15.0283469828184 | etot = -14.6424332451011 +228000 ekin = 0.0713769419939847 | erot = 0.311883945247506 | epot = -15.0256941323392 | etot = -14.6424332450977 +229000 ekin = 0.0711526728858743 | erot = 0.314719386439641 | epot = -15.0283053044313 | etot = -14.6424332451058 +230000 ekin = 0.0714080974066408 | erot = 0.322205638589943 | epot = -15.0360469811226 | etot = -14.642433245126 +231000 ekin = 0.0721675361190023 | erot = 0.333998222201819 | epot = -15.0485990034788 | etot = -14.642433245158 +232000 ekin = 0.0734216022905603 | erot = 0.349601270465958 | epot = -15.0654561179576 | etot = -14.6424332452011 +233000 ekin = 0.0751284397505271 | erot = 0.368376135875951 | epot = -15.085937820881 | etot = -14.6424332452545 +234000 ekin = 0.0772173235442621 | erot = 0.389557254433776 | epot = -15.1092078232944 | etot = -14.6424332453164 +235000 ekin = 0.0795947059802265 | erot = 0.412276079790441 | epot = -15.1343040311543 | etot = -14.6424332453836 +236000 ekin = 0.0821526186146775 | erot = 0.43559329564772 | epot = -15.160179159716 | etot = -14.6424332454536 +237000 ekin = 0.0847791014240061 | erot = 0.458538653864716 | epot = -15.1857510008108 | etot = -14.6424332455221 +238000 ekin = 0.0873700423858637 | erot = 0.480156759886701 | epot = -15.2099600478579 | etot = -14.6424332455853 +239000 ekin = 0.0898415153137649 | erot = 0.499556095552604 | epot = -15.2318308565057 | etot = -14.6424332456393 +240000 ekin = 0.0921414623535621 | erot = 0.515957735401017 | epot = -15.2505324434351 | etot = -14.6424332456806 +241000 ekin = 0.0942594490144011 | erot = 0.528739776886579 | epot = -15.2654324716071 | etot = -14.6424332457061 +242000 ekin = 0.0962332805881029 | erot = 0.537473606136305 | epot = -15.2761401324386 | etot = -14.6424332457142 +243000 ekin = 0.0981515319338902 | erot = 0.541948785980292 | epot = -15.2825335636184 | etot = -14.6424332457042 +244000 ekin = 0.100151482351193 | erot = 0.542184479374338 | epot = -15.2847692074024 | etot = -14.6424332456769 +245000 ekin = 0.102412491095761 | erot = 0.538426702317763 | epot = -15.2832724390477 | etot = -14.6424332456342 +246000 ekin = 0.105145395544795 | erot = 0.531132085866374 | epot = -15.2787107269897 | etot = -14.6424332455785 +247000 ekin = 0.108578961411983 | erot = 0.520939994206881 | epot = -15.2719522011324 | etot = -14.6424332455135 +248000 ekin = 0.112944688754523 | erot = 0.508635652295277 | epot = -15.2640135864926 | etot = -14.6424332454428 +249000 ekin = 0.11846134890514 | erot = 0.495107336753422 | epot = -15.2560019310289 | etot = -14.6424332453704 +250000 ekin = 0.125320510713214 | erot = 0.48130071319683 | epot = -15.2490544692099 | etot = -14.6424332452999 +251000 ekin = 0.133674056955099 | erot = 0.468173145423569 | epot = -15.2442804476134 | etot = -14.6424332452347 +252000 ekin = 0.143624355872782 | erot = 0.456650355973676 | epot = -15.2427079570244 | etot = -14.6424332451779 +253000 ekin = 0.155217400154351 | erot = 0.447587277165331 | epot = -15.2452379224514 | etot = -14.6424332451318 +254000 ekin = 0.168438906844348 | erot = 0.441734376017242 | epot = -15.2526065279594 | etot = -14.6424332450978 +255000 ekin = 0.183213121644194 | erot = 0.43971022735347 | epot = -15.2653565940749 | etot = -14.6424332450772 +256000 ekin = 0.199403908832166 | erot = 0.441980689733479 | epot = -15.2838178436365 | etot = -14.6424332450708 +257000 ekin = 0.216817638461889 | erot = 0.448844730305189 | epot = -15.3080956138459 | etot = -14.6424332450788 +258000 ekin = 0.235207399035754 | erot = 0.460426746275392 | epot = -15.338067390412 | etot = -14.6424332451008 +259000 ekin = 0.254278151366129 | erot = 0.476675120648644 | epot = -15.373386517151 | etot = -14.6424332451362 +260000 ekin = 0.273692576676924 | erot = 0.49736669170667 | epot = -15.4134925135676 | etot = -14.642433245184 +261000 ekin = 0.293077534073102 | erot = 0.522116767905281 | epot = -15.4576275472213 | etot = -14.6424332452429 +262000 ekin = 0.312031202020399 | erot = 0.550394247121215 | epot = -15.5048586944527 | etot = -14.642433245311 +263000 ekin = 0.330131107615849 | erot = 0.581541281999657 | epot = -15.554105635002 | etot = -14.6424332453865 +264000 ekin = 0.346943319969814 | erot = 0.614796773447099 | epot = -15.6041733388837 | etot = -14.6424332454667 +265000 ekin = 0.362033078254078 | erot = 0.64932279499714 | epot = -15.6537891188008 | etot = -14.6424332455496 +266000 ekin = 0.374977027495969 | erot = 0.684232889060528 | epot = -15.7016431621888 | etot = -14.6424332456323 +267000 ekin = 0.385377045180505 | erot = 0.718621072064159 | epot = -15.7464313629565 | etot = -14.6424332457118 +268000 ekin = 0.392875374675151 | erot = 0.75159036946739 | epot = -15.7868989899282 | etot = -14.6424332457857 +269000 ekin = 0.397170471133891 | erot = 0.782279784278107 | epot = -15.8218835012631 | etot = -14.6424332458511 +270000 ekin = 0.398032662022584 | erot = 0.809888771679725 | epot = -15.8503546796085 | etot = -14.6424332459062 +271000 ekin = 0.395318487593106 | erot = 0.833698516715849 | epot = -15.8714502502576 | etot = -14.6424332459487 +272000 ekin = 0.3889824743465 | erot = 0.853089551914417 | epot = -15.8845052722381 | etot = -14.6424332459772 +273000 ekin = 0.379085147925856 | erot = 0.867555470410714 | epot = -15.8890738643275 | etot = -14.6424332459909 +274000 ekin = 0.365796322187845 | erot = 0.876712662634537 | epot = -15.8849422308118 | etot = -14.6424332459894 +275000 ekin = 0.349393082916426 | erot = 0.880306121918472 | epot = -15.872132450808 | etot = -14.6424332459731 +276000 ekin = 0.330252358900968 | erot = 0.878211432153003 | epot = -15.8508970369967 | etot = -14.6424332459427 +277000 ekin = 0.308838461216024 | erot = 0.870433084880285 | epot = -15.821704791996 | etot = -14.6424332458996 +278000 ekin = 0.285686394600537 | erot = 0.857099294887754 | epot = -15.785218935334 | etot = -14.6424332458457 +279000 ekin = 0.261382042763559 | erot = 0.838453513182875 | epot = -15.7422688017293 | etot = -14.6424332457829 +280000 ekin = 0.236540473323853 | erot = 0.814842890589049 | epot = -15.6938166096265 | etot = -14.6424332457136 +281000 ekin = 0.211783602606715 | erot = 0.786704032858738 | epot = -15.6409208811057 | etot = -14.6424332456403 +282000 ekin = 0.187718337271409 | erot = 0.754546508157302 | epot = -15.5846980909941 | etot = -14.6424332455654 +283000 ekin = 0.16491611509112 | erot = 0.718934708844168 | epot = -15.5262840694266 | etot = -14.6424332454913 +284000 ekin = 0.143894549222822 | erot = 0.680468811937736 | epot = -15.466796606581 | etot = -14.6424332454204 +285000 ekin = 0.125101678374138 | erot = 0.639765701845489 | epot = -15.4073006255745 | etot = -14.6424332453549 +286000 ekin = 0.108903164109909 | erot = 0.597440790007828 | epot = -15.3487771994138 | etot = -14.6424332452961 +287000 ekin = 0.0955726645582895 | erot = 0.554091668601936 | epot = -15.2920975784057 | etot = -14.6424332452455 +288000 ekin = 0.0852855448043095 | erot = 0.510284456818714 | epot = -15.2380032468271 | etot = -14.6424332452041 +289000 ekin = 0.0781160413143099 | erot = 0.466543535619487 | epot = -15.187092822106 | etot = -14.6424332451722 +290000 ekin = 0.0740379578661698 | erot = 0.423345127585219 | epot = -15.1398163306013 | etot = -14.6424332451499 +291000 ekin = 0.0729289100679055 | erot = 0.38111487943343 | epot = -15.0964770346381 | etot = -14.6424332451368 +292000 ekin = 0.07457803579739 | erot = 0.340229271733799 | epot = -15.0572405526628 | etot = -14.6424332451316 +293000 ekin = 0.0786969407585632 | erot = 0.301020346544403 | epot = -15.0221505324361 | etot = -14.6424332451332 +294000 ekin = 0.0849334564747931 | erot = 0.263782947584683 | epot = -14.9911496491992 | etot = -14.6424332451397 +295000 ekin = 0.0928875723651433 | erot = 0.228783448803118 | epot = -14.964104266318 | etot = -14.6424332451498 +296000 ekin = 0.102128697511344 | erot = 0.196268840383812 | epot = -14.9408307830567 | etot = -14.6424332451616 +297000 ekin = 0.112213252500573 | erot = 0.166475068215632 | epot = -14.9211215658898 | etot = -14.6424332451736 +298000 ekin = 0.122701527070322 | erot = 0.139633685444096 | epot = -14.9047684576989 | etot = -14.6424332451845 +299000 ekin = 0.133172792913731 | erot = 0.115976150687847 | epot = -14.891582188795 | etot = -14.6424332451934 +300000 ekin = 0.143237839709879 | erot = 0.0957354521197614 | epot = -14.8814065370294 | etot = -14.6424332451998 +301000 ekin = 0.152548387990868 | erot = 0.079145090872109 | epot = -14.8741267240665 | etot = -14.6424332452036 +302000 ekin = 0.160803184301541 | erot = 0.0664357608556664 | epot = -14.869672190362 | etot = -14.6424332452048 +303000 ekin = 0.167750948488392 | erot = 0.0578302677258683 | epot = -14.8680144614181 | etot = -14.6424332452038 +304000 ekin = 0.173190665588574 | erot = 0.053537313638039 | epot = -14.869161224428 | etot = -14.6424332452014 +305000 ekin = 0.17696995295018 | erot = 0.0537447402922378 | epot = -14.8731479384404 | etot = -14.642433245198 +306000 ekin = 0.178982363291699 | erot = 0.0586126977894969 | epot = -14.8800283062755 | etot = -14.6424332451943 +307000 ekin = 0.179164502945091 | erot = 0.0682670321079287 | epot = -14.8898647802439 | etot = -14.6424332451908 +308000 ekin = 0.177493763289092 | erot = 0.0827930029211812 | epot = -14.9027200113984 | etot = -14.6424332451881 +309000 ekin = 0.173987301152073 | erot = 0.102229291873313 | epot = -14.9186498382119 | etot = -14.6424332451865 +310000 ekin = 0.168702678648375 | erot = 0.126562162218708 | epot = -14.9376980860533 | etot = -14.6424332451862 +311000 ekin = 0.161740297010248 | erot = 0.155719593409014 | epot = -14.9598931356065 | etot = -14.6424332451872 +312000 ekin = 0.153247440126422 | erot = 0.189565237979898 | epot = -14.985245923296 | etot = -14.6424332451897 +313000 ekin = 0.143423389998644 | erot = 0.227892126762103 | epot = -15.0137487619544 | etot = -14.6424332451937 +314000 ekin = 0.132524706020331 | erot = 0.270416174781571 | epot = -15.0453741260009 | etot = -14.642433245199 +315000 ekin = 0.120869409554577 | erot = 0.316769708289568 | epot = -15.0800723630506 | etot = -14.6424332452064 +316000 ekin = 0.1088385461069 | erot = 0.366495437994219 | epot = -15.1177672293174 | etot = -14.6424332452162 +317000 ekin = 0.0968734934299854 | erot = 0.419041536808397 | epot = -15.1583482754675 | etot = -14.6424332452291 +318000 ekin = 0.0854675378572642 | erot = 0.473758725762781 | epot = -15.2016595088659 | etot = -14.6424332452459 +319000 ekin = 0.0751507271474209 | erot = 0.529900497446471 | epot = -15.2474844698617 | etot = -14.6424332452678 +320000 ekin = 0.0664678443385232 | erot = 0.586627760737817 | epot = -15.2955288503722 | etot = -14.6424332452959 +321000 ekin = 0.0599504590581789 | erot = 0.643019202689382 | epot = -15.3454029070786 | etot = -14.6424332453311 +322000 ekin = 0.0560852142815269 | erot = 0.698088453264983 | epot = -15.3966069129204 | etot = -14.6424332453739 +323000 ekin = 0.0552815181260071 | erot = 0.750808639914411 | epot = -15.4485234034645 | etot = -14.6424332454241 +324000 ekin = 0.057842325521187 | erot = 0.800144112656294 | epot = -15.5004196836582 | etot = -14.6424332454807 +325000 ekin = 0.063941486463515 | erot = 0.845088070114582 | epot = -15.5514628021197 | etot = -14.6424332455416 +326000 ekin = 0.0736101694204757 | erot = 0.8847036899678 | epot = -15.6007471049927 | etot = -14.6424332456044 +327000 ekin = 0.0867333560885493 | erot = 0.918165419814647 | epot = -15.6473320215694 | etot = -14.6424332456662 +328000 ekin = 0.103055779602218 | erot = 0.944796600226722 | epot = -15.690285625553 | etot = -14.642433245724 +329000 ekin = 0.122195446168401 | erot = 0.964099781598492 | epot = -15.7287284735425 | etot = -14.6424332457756 +330000 ekin = 0.143662406707274 | erot = 0.97577699624252 | epot = -15.7618726487685 | etot = -14.6424332458188 +331000 ekin = 0.166880785130066 | erot = 0.979738667524184 | epot = -15.7890526985066 | etot = -14.6424332458523 +332000 ekin = 0.191212923965916 | erot = 0.976101405909932 | epot = -15.8097475757513 | etot = -14.6424332458755 +333000 ekin = 0.215985355315126 | erot = 0.96517623354676 | epot = -15.8235948347498 | etot = -14.6424332458879 +334000 ekin = 0.240516656826312 | erot = 0.947449485120633 | epot = -15.8303993878361 | etot = -14.6424332458891 +335000 ekin = 0.264146896081082 | erot = 0.923558676876312 | epot = -15.8301388188364 | etot = -14.642433245879 +336000 ekin = 0.286267467748831 | erot = 0.894265184768772 | epot = -15.8229658983753 | etot = -14.6424332458577 +337000 ekin = 0.306349134744516 | erot = 0.86042493934443 | epot = -15.8092073199143 | etot = -14.6424332458253 +338000 ekin = 0.323965497669028 | erot = 0.822957838329898 | epot = -15.7893565817819 | etot = -14.642433245783 +339000 ekin = 0.338809250783309 | erot = 0.782816380156821 | epot = -15.7640588766722 | etot = -14.6424332457321 +340000 ekin = 0.350699444228147 | erot = 0.740954141308479 | epot = -15.7340868312114 | etot = -14.6424332456748 +341000 ekin = 0.359579293531077 | erot = 0.698295027836124 | epot = -15.700307566981 | etot = -14.6424332456138 +342000 ekin = 0.365505462149771 | erot = 0.65570454203815 | epot = -15.6636432497397 | etot = -14.6424332455518 +343000 ekin = 0.368630832656574 | erot = 0.613964463467596 | epot = -15.6250285416159 | etot = -14.6424332454917 +344000 ekin = 0.369183369584824 | erot = 0.573752273081762 | epot = -15.5853688881025 | etot = -14.6424332454359 +345000 ekin = 0.367443732820381 | erot = 0.535626361233121 | epot = -15.5455033394399 | etot = -14.6424332453864 +346000 ekin = 0.363723933128391 | erot = 0.500017626275295 | epot = -15.5061748047483 | etot = -14.6424332453446 +347000 ekin = 0.358348705274855 | erot = 0.467227585425635 | epot = -15.4680095360116 | etot = -14.6424332453111 +348000 ekin = 0.351640582952574 | erot = 0.437432666905905 | epot = -15.4315064951445 | etot = -14.642433245286 +349000 ekin = 0.343909024693095 | erot = 0.41069398616735 | epot = -15.3970362561291 | etot = -14.6424332452687 +350000 ekin = 0.335443435967589 | erot = 0.386971649877954 | epot = -15.3648483311043 | etot = -14.6424332452587 +351000 ekin = 0.326509584093047 | erot = 0.366142474248719 | epot = -15.335085303596 | etot = -14.6424332452542 +352000 ekin = 0.31734869902189 | erot = 0.348019930398469 | epot = -15.3078018746744 | etot = -14.642433245254 +353000 ekin = 0.308178466648795 | erot = 0.332375117499601 | epot = -15.2829868294052 | etot = -14.6424332452568 +354000 ekin = 0.299195119854714 | erot = 0.318957598137068 | epot = -15.2605859632527 | etot = -14.6424332452609 +355000 ekin = 0.290575888249386 | erot = 0.307515001368932 | epot = -15.2405241348834 | etot = -14.6424332452651 +356000 ekin = 0.282481160313163 | erot = 0.297810406216367 | epot = -15.222724811798 | etot = -14.6424332452684 +357000 ekin = 0.275055828994536 | erot = 0.289636664277623 | epot = -15.2071257385424 | etot = -14.6424332452702 +358000 ekin = 0.268429427255716 | erot = 0.2828270069126 | epot = -15.1936896794383 | etot = -14.64243324527 +359000 ekin = 0.262714810202527 | erot = 0.277261507858961 | epot = -15.1824095633294 | etot = -14.6424332452679 +360000 ekin = 0.258005302570158 | erot = 0.272869227750137 | epot = -15.1733077755847 | etot = -14.6424332452644 +361000 ekin = 0.254370400622446 | erot = 0.269626137803926 | epot = -15.1664297836866 | etot = -14.6424332452602 +362000 ekin = 0.251850290179257 | erot = 0.267549186090192 | epot = -15.1618327215256 | etot = -14.6424332452562 +363000 ekin = 0.250449609863309 | erot = 0.266687109599918 | epot = -15.1595699647169 | etot = -14.6424332452537 +364000 ekin = 0.250131041863869 | erot = 0.267108788860229 | epot = -15.1596730759781 | etot = -14.642433245254 +365000 ekin = 0.250809442162608 | erot = 0.268890073930453 | epot = -15.1621327613513 | etot = -14.6424332452583 +366000 ekin = 0.252347318763942 | erot = 0.272100073008303 | epot = -15.1668806370396 | etot = -14.6424332452674 +367000 ekin = 0.254552520179202 | erot = 0.276787886821285 | epot = -15.1737736522826 | etot = -14.6424332452822 +368000 ekin = 0.257178996154138 | erot = 0.282970699525187 | epot = -15.1825829409824 | etot = -14.6424332453031 +369000 ekin = 0.259931424909754 | erot = 0.290624011144305 | epot = -15.192988681384 | etot = -14.64243324533 +370000 ekin = 0.262474349327938 | erot = 0.299674631815232 | epot = -15.2045822265054 | etot = -14.6424332453622 +371000 ekin = 0.264446209429919 | erot = 0.30999686929688 | epot = -15.2168763241253 | etot = -14.6424332453985 +372000 ekin = 0.265478281863403 | erot = 0.321412142685467 | epot = -15.2293236699861 | etot = -14.6424332454372 +373000 ekin = 0.265218028292392 | erot = 0.333692059446794 | epot = -15.2413433332155 | etot = -14.6424332454763 +374000 ekin = 0.263355721250465 | erot = 0.346564809668633 | epot = -15.2523537764321 | etot = -14.642433245513 +375000 ekin = 0.259652497503914 | erot = 0.35972456799486 | epot = -15.2618103110439 | etot = -14.6424332455451 +376000 ekin = 0.253967268937827 | erot = 0.372843454380799 | epot = -15.2692439688887 | etot = -14.6424332455701 +377000 ekin = 0.246279333501497 | erot = 0.385585491294786 | epot = -15.274298070382 | etot = -14.6424332455857 +378000 ekin = 0.236703249878266 | erot = 0.397621906698155 | epot = -15.2767584021673 | etot = -14.6424332455909 +379000 ekin = 0.225492756944983 | erot = 0.408647066931749 | epot = -15.2765730694618 | etot = -14.6424332455851 +380000 ekin = 0.213031377539262 | erot = 0.418394278996725 | epot = -15.2738589021049 | etot = -14.6424332455689 +381000 ekin = 0.199808877315933 | erot = 0.42665067621188 | epot = -15.2688927990715 | etot = -14.6424332455437 +382000 ekin = 0.186384809019062 | erot = 0.433270396055884 | epot = -15.2620884505868 | etot = -14.6424332455119 +383000 ekin = 0.173342616144133 | erot = 0.438185279050674 | epot = -15.2539611406711 | etot = -14.6424332454762 +384000 ekin = 0.161239700831467 | erot = 0.441412371402834 | epot = -15.2450853176736 | etot = -14.6424332454393 +385000 ekin = 0.15055995464762 | erot = 0.44305761255288 | epot = -15.2360508126044 | etot = -14.6424332454039 +386000 ekin = 0.1416751296992 | erot = 0.443315241523152 | epot = -15.2274236165942 | etot = -14.6424332453718 +387000 ekin = 0.134820015698004 | erot = 0.442462667348858 | epot = -15.2197159283911 | etot = -14.6424332453442 +388000 ekin = 0.130083976413563 | erot = 0.440850813513923 | epot = -15.2133680352489 | etot = -14.6424332453214 +389000 ekin = 0.127418570237896 | erot = 0.438890246279034 | epot = -15.20874206182 | etot = -14.6424332453031 +390000 ekin = 0.126658423093211 | erot = 0.437033702086108 | epot = -15.2061253704679 | etot = -14.6424332452886 +391000 ekin = 0.127550804261002 | erot = 0.435755902066214 | epot = -15.2057399516043 | etot = -14.6424332452771 +392000 ekin = 0.129788752935804 | erot = 0.435531744058807 | epot = -15.2077537422628 | etot = -14.6424332452682 +393000 ekin = 0.13304305531626 | erot = 0.436814065078312 | epot = -15.2122903656558 | etot = -14.6424332452612 +394000 ekin = 0.136989561466103 | erot = 0.440012156511487 | epot = -15.2194349632339 | etot = -14.6424332452563 +395000 ekin = 0.14132983304257 | erot = 0.44547209688668 | epot = -15.2292351751828 | etot = -14.6424332452536 +396000 ekin = 0.145804542777681 | erot = 0.453459767650225 | epot = -15.2416975556816 | etot = -14.6424332452537 +397000 ekin = 0.150200153189366 | erot = 0.464147173463303 | epot = -15.25678057191 | etot = -14.6424332452573 +398000 ekin = 0.154350089767278 | erot = 0.477602441560288 | epot = -15.2743857765924 | etot = -14.6424332452648 +399000 ekin = 0.158131920623957 | erot = 0.49378366115725 | epot = -15.2943488270583 | etot = -14.6424332452771 +400000 ekin = 0.161462056175852 | erot = 0.512536568007638 | epot = -15.3164318694777 | etot = -14.6424332452942 +401000 ekin = 0.164289301183564 | erot = 0.533595989003432 | epot = -15.3403185355036 | etot = -14.6424332453166 +402000 ekin = 0.16658832305357 | erot = 0.556590928840415 | epot = -15.3656124972378 | etot = -14.6424332453438 +403000 ekin = 0.168353810382888 | erot = 0.581053183644666 | epot = -15.3918402394033 | etot = -14.6424332453758 +404000 ekin = 0.169595821304612 | erot = 0.606429376023098 | epot = -15.4184584427392 | etot = -14.6424332454115 +405000 ekin = 0.170336578565562 | erot = 0.63209629254019 | epot = -15.4448661165559 | etot = -14.6424332454501 +406000 ekin = 0.170608761982373 | erot = 0.657379344514174 | epot = -15.4704213519868 | etot = -14.6424332454903 +407000 ekin = 0.170455178570794 | erot = 0.681573854093766 | epot = -15.494462278195 | etot = -14.6424332455304 +408000 ekin = 0.169929554813017 | erot = 0.703968692150334 | epot = -15.5163314925322 | etot = -14.6424332455689 +409000 ekin = 0.169098093454334 | erot = 0.723871579520639 | epot = -15.5354029185788 | etot = -14.6424332456039 +410000 ekin = 0.168041369043284 | erot = 0.740635137247676 | epot = -15.5511097519246 | etot = -14.6424332456336 +411000 ekin = 0.16685610281106 | erot = 0.753682569970645 | epot = -15.5629719184382 | etot = -14.6424332456565 +412000 ekin = 0.165656359034691 | erot = 0.762531725092763 | epot = -15.5706213297985 | etot = -14.6424332456711 +413000 ekin = 0.16457374171258 | erot = 0.766816218739503 | epot = -15.5738232061285 | etot = -14.6424332456764 +414000 ekin = 0.163756240958051 | erot = 0.766302377571847 | epot = -15.5724918642017 | etot = -14.6424332456718 +415000 ekin = 0.163365479945346 | erot = 0.760900920225164 | epot = -15.5666996458277 | etot = -14.6424332456572 +416000 ekin = 0.16357224009341 | erot = 0.75067258670007 | epot = -15.5566780724265 | etot = -14.642433245633 +417000 ekin = 0.164550286198177 | erot = 0.735827297892157 | epot = -15.5428108296905 | etot = -14.6424332456002 +418000 ekin = 0.166468663391054 | erot = 0.71671685730188 | epot = -15.5256187662531 | etot = -14.6424332455602 +419000 ekin = 0.169482781124205 | erot = 0.69382164910088 | epot = -15.5057376757398 | etot = -14.6424332455147 +420000 ekin = 0.17372472266442 | erot = 0.667732191685371 | epot = -15.4838901598156 | etot = -14.6424332454658 +421000 ekin = 0.179293310757533 | erot = 0.639126725583772 | epot = -15.460853281757 | etot = -14.6424332454157 +422000 ekin = 0.18624451451762 | erot = 0.608746211201687 | epot = -15.437423971086 | etot = -14.6424332453667 +423000 ekin = 0.194582798143094 | erot = 0.577368165579487 | epot = -15.4143842090434 | etot = -14.6424332453208 +424000 ekin = 0.204253993028008 | erot = 0.545780680988006 | epot = -15.392467919296 | etot = -14.64243324528 +425000 ekin = 0.215140228915644 | erot = 0.514757766833632 | epot = -15.3723312409951 | etot = -14.6424332452459 +426000 ekin = 0.22705739519611 | erot = 0.485036881516617 | epot = -15.3545275219322 | etot = -14.6424332452194 +427000 ekin = 0.239755526224917 | erot = 0.457299221562847 | epot = -15.3394879929896 | etot = -14.6424332452018 +428000 ekin = 0.252922416268543 | erot = 0.432153058135964 | epot = -15.3275087195978 | etot = -14.6424332451933 +429000 ekin = 0.266190667178511 | erot = 0.410120192008996 | epot = -15.3187441043811 | etot = -14.6424332451936 +430000 ekin = 0.279148248284993 | erot = 0.391625457763317 | epot = -15.3132069512512 | etot = -14.6424332452029 +431000 ekin = 0.291352495292879 | erot = 0.376989149811629 | epot = -15.3107748903245 | etot = -14.64243324522 +432000 ekin = 0.302347287569384 | erot = 0.366422254467196 | epot = -15.3112027872808 | etot = -14.6424332452442 +433000 ekin = 0.311682921770386 | erot = 0.360024429013363 | epot = -15.314140596057 | etot = -14.6424332452733 +434000 ekin = 0.318937954386255 | erot = 0.357784738271778 | epot = -15.3191559379639 | etot = -14.6424332453059 +435000 ekin = 0.323742037713914 | erot = 0.359585207274041 | epot = -15.3257604903287 | etot = -14.6424332453407 +436000 ekin = 0.325798554030506 | erot = 0.365207245307274 | epot = -15.3334390447139 | etot = -14.6424332453761 +437000 ekin = 0.324905697096481 | erot = 0.374340922351912 | epot = -15.3416798648573 | etot = -14.642433245409 +438000 ekin = 0.320974589857387 | erot = 0.38659693016297 | epot = -15.350004765458 | etot = -14.6424332454377 +439000 ekin = 0.314043077745106 | erot = 0.401520852188694 | epot = -15.3579971753951 | etot = -14.6424332454613 +440000 ekin = 0.304283988018871 | erot = 0.418609132217954 | epot = -15.3653263657147 | etot = -14.6424332454779 +441000 ekin = 0.292006859109421 | erot = 0.437325916197858 | epot = -15.3717660207937 | etot = -14.6424332454864 +442000 ekin = 0.277652365812285 | erot = 0.457119792524558 | epot = -15.3772054038237 | etot = -14.6424332454869 +443000 ekin = 0.261778853587334 | erot = 0.477439412182338 | epot = -15.3816515112496 | etot = -14.6424332454799 +444000 ekin = 0.245040553430229 | erot = 0.497747053383812 | epot = -15.3852208522809 | etot = -14.6424332454669 +445000 ekin = 0.228157260415745 | erot = 0.517529408210577 | epot = -15.3881199140755 | etot = -14.6424332454491 +446000 ekin = 0.211875681724426 | erot = 0.536305196865301 | epot = -15.3906141240194 | etot = -14.6424332454296 +447000 ekin = 0.196923472676264 | erot = 0.553629632762624 | epot = -15.3929863508503 | etot = -14.6424332454114 +448000 ekin = 0.183958277875564 | erot = 0.569096233380439 | epot = -15.3954877566541 | etot = -14.6424332453981 +449000 ekin = 0.173515771308145 | erot = 0.582336947161166 | epot = -15.3982859638623 | etot = -14.6424332453929 +450000 ekin = 0.165962361194716 | erot = 0.593021970155278 | epot = -15.4014175767483 | etot = -14.6424332453983 +451000 ekin = 0.161459280831071 | erot = 0.600860851258448 | epot = -15.4047533775048 | etot = -14.6424332454152 +452000 ekin = 0.159944578250394 | erot = 0.605606408084745 | epot = -15.4079842317782 | etot = -14.6424332454431 +453000 ekin = 0.161137653112604 | erot = 0.607062496375647 | epot = -15.4106333949675 | etot = -14.6424332454792 +454000 ekin = 0.164567591511419 | erot = 0.605095779312697 | epot = -15.4120966163436 | etot = -14.6424332455194 +455000 ekin = 0.169622334208404 | erot = 0.599650455426745 | epot = -15.4117060351936 | etot = -14.6424332455584 +456000 ekin = 0.175611802350263 | erot = 0.590763702898767 | epot = -15.4088087508399 | etot = -14.6424332455909 +457000 ekin = 0.181835621982496 | erot = 0.578578749366124 | epot = -15.4028476169608 | etot = -14.6424332456122 +458000 ekin = 0.18764572703167 | erot = 0.563352302650977 | epot = -15.3934312753017 | etot = -14.6424332456191 +459000 ekin = 0.192495880386128 | erot = 0.545453717150014 | epot = -15.3803828431463 | etot = -14.6424332456101 +460000 ekin = 0.19597338163879 | erot = 0.525354597711273 | epot = -15.3637612249358 | etot = -14.6424332455858 +461000 ekin = 0.197811920993009 | erot = 0.503609203462558 | epot = -15.3438543700042 | etot = -14.6424332455486 +462000 ekin = 0.19788772492106 | erot = 0.480827560282267 | epot = -15.3211485307047 | etot = -14.6424332455014 +463000 ekin = 0.196203198487162 | erot = 0.457644248436047 | epot = -15.2962806923717 | etot = -14.6424332454485 +464000 ekin = 0.192863034127886 | erot = 0.434686220428428 | epot = -15.2699824999498 | etot = -14.6424332453935 +465000 ekin = 0.188047435824139 | erot = 0.412542760090385 | epot = -15.2430234412545 | etot = -14.64243324534 +466000 ekin = 0.181986107554585 | erot = 0.391740010671268 | epot = -15.2161593635165 | etot = -14.6424332452907 +467000 ekin = 0.174935400199653 | erot = 0.372721626734306 | epot = -15.1900902721816 | etot = -14.6424332452476 +468000 ekin = 0.167159826103645 | erot = 0.355836258350829 | epot = -15.1654293296665 | etot = -14.642433245212 +469000 ekin = 0.158918218023908 | erot = 0.341331890764793 | epot = -15.1426833539731 | etot = -14.6424332451844 +470000 ekin = 0.15045418565433 | erot = 0.32935658463347 | epot = -15.1222440154524 | etot = -14.6424332451646 +471000 ekin = 0.141990180750341 | erot = 0.319964871776709 | epot = -15.1043882976792 | etot = -14.6424332451522 +472000 ekin = 0.133724353868939 | erot = 0.313128906245089 | epot = -15.08928650526 | etot = -14.642433245146 +473000 ekin = 0.125829398102414 | erot = 0.308753392324214 | epot = -15.0770160355716 | etot = -14.642433245145 +474000 ekin = 0.118452666363562 | erot = 0.306693264413826 | epot = -15.0675791759251 | etot = -14.6424332451477 +475000 ekin = 0.111716976219122 | erot = 0.306773053290683 | epot = -15.0609232746627 | etot = -14.6424332451529 +476000 ekin = 0.10572165563334 | erot = 0.308806833537627 | epot = -15.0569617343301 | etot = -14.6424332451591 +477000 ekin = 0.100543523675759 | erot = 0.312617617130285 | epot = -15.0555943859712 | etot = -14.6424332451652 +478000 ekin = 0.0962376398644792 | erot = 0.31805505563531 | epot = -15.0567259406699 | etot = -14.6424332451701 +479000 ekin = 0.0928377950024481 | erot = 0.325010357030128 | epot = -15.0602813972058 | etot = -14.6424332451732 +480000 ekin = 0.0903568546345918 | erot = 0.33342742776329 | epot = -15.066217527572 | etot = -14.6424332451741 +481000 ekin = 0.0887871989358495 | erot = 0.343309423709778 | epot = -15.0745298678181 | etot = -14.6424332451725 +482000 ekin = 0.0881016191320247 | erot = 0.354720133057113 | epot = -15.0852549973578 | etot = -14.6424332451687 +483000 ekin = 0.0882551127439553 | erot = 0.367779908272464 | epot = -15.0984682661794 | etot = -14.642433245163 +484000 ekin = 0.0891880440138003 | erot = 0.382656193507601 | epot = -15.1142774826776 | etot = -14.6424332451562 +485000 ekin = 0.0908310739109808 | erot = 0.399549033146284 | epot = -15.1328133522061 | etot = -14.6424332451488 +486000 ekin = 0.0931120890990374 | erot = 0.418672269923129 | epot = -15.1542176041639 | etot = -14.6424332451417 +487000 ekin = 0.0959650526392593 | erot = 0.440231422321011 | epot = -15.1786297200963 | etot = -14.642433245136 +488000 ekin = 0.0993402613867364 | erot = 0.464399451384487 | epot = -15.2061729579036 | etot = -14.6424332451324 +489000 ekin = 0.103214957397678 | erot = 0.491291775403258 | epot = -15.2369399779328 | etot = -14.6424332451318 +490000 ekin = 0.107602676597184 | erot = 0.520941965498208 | epot = -15.2709778872308 | etot = -14.6424332451354 +491000 ekin = 0.112559247664622 | erot = 0.553279563916956 | epot = -15.3082720567259 | etot = -14.6424332451443 +492000 ekin = 0.118183136723597 | erot = 0.588111425308452 | epot = -15.3487278071918 | etot = -14.6424332451598 +493000 ekin = 0.12460804012638 | erot = 0.62510790827898 | epot = -15.3921491935888 | etot = -14.6424332451834 +494000 ekin = 0.131986393312561 | erot = 0.663795156035111 | epot = -15.4382147945646 | etot = -14.6424332452169 +495000 ekin = 0.140463823900159 | erot = 0.703554605721736 | epot = -15.4864516748841 | etot = -14.6424332452622 +496000 ekin = 0.15014640803584 | erot = 0.743630741563187 | epot = -15.5362103949193 | etot = -14.6424332453203 +497000 ekin = 0.161064579071316 | erot = 0.783147917317585 | epot = -15.5866457417809 | etot = -14.642433245392 +498000 ekin = 0.173139219157384 | erot = 0.821136754972775 | epot = -15.6367092196065 | etot = -14.6424332454764 +499000 ekin = 0.186156317833383 | erot = 0.856570103856722 | epot = -15.6851596672614 | etot = -14.6424332455713 +500000 ekin = 0.199756195068936 | erot = 0.888407758274067 | epot = -15.7305971990159 | etot = -14.6424332456729 +501000 ekin = 0.21344151783734 | erot = 0.915648078732879 | epot = -15.7715228423456 | etot = -14.6424332457754 +502000 ekin = 0.226605416598004 | erot = 0.937383433649205 | epot = -15.8064220961192 | etot = -14.642433245872 +503000 ekin = 0.238577508977599 | erot = 0.952855183124955 | epot = -15.833865938058 | etot = -14.6424332459554 +504000 ekin = 0.248682347016341 | erot = 0.961503066788411 | epot = -15.8526186598236 | etot = -14.6424332460188 +505000 ekin = 0.256302488969601 | erot = 0.963003656366721 | epot = -15.8617393913931 | etot = -14.6424332460567 +506000 ekin = 0.260937583144201 | erot = 0.957293217920631 | epot = -15.8606640471306 | etot = -14.6424332460658 +507000 ekin = 0.262251679299254 | erot = 0.944571918258648 | epot = -15.8492568436029 | etot = -14.642433246045 +508000 ekin = 0.260103184111419 | erot = 0.925288564934488 | epot = -15.827824995042 | etot = -14.6424332459961 +509000 ekin = 0.254554875280464 | erot = 0.90010753693787 | epot = -15.7970956581413 | etot = -14.642433245923 +510000 ekin = 0.245864483348196 | erot = 0.869861717985383 | epot = -15.7581594471648 | etot = -14.6424332458312 +511000 ekin = 0.234458914526896 | erot = 0.835496660126456 | epot = -15.7123888203806 | etot = -14.6424332457273 +512000 ekin = 0.22089682023999 | erot = 0.798011684065881 | epot = -15.6613417499238 | etot = -14.642433245618 +513000 ekin = 0.205824805087888 | erot = 0.758403224578321 | epot = -15.6066612751757 | etot = -14.6424332455095 +514000 ekin = 0.189932244116178 | erot = 0.717614706860286 | epot = -15.5499801963839 | etot = -14.6424332454074 +515000 ekin = 0.17390874819978 | erot = 0.676495918872563 | epot = -15.4928379123882 | etot = -14.6424332453159 +516000 ekin = 0.158407108509004 | erot = 0.635773516025323 | epot = -15.4366138697724 | etot = -14.6424332452381 +517000 ekin = 0.1440133501839 | erot = 0.596033149118113 | epot = -15.3824797444781 | etot = -14.6424332451761 +518000 ekin = 0.131224514118008 | erot = 0.557712825688944 | epot = -15.3313705849373 | etot = -14.6424332451304 +519000 ekin = 0.120434042405821 | erot = 0.521106495597703 | epot = -15.283973783104 | etot = -14.6424332451005 +520000 ekin = 0.111924165176696 | erot = 0.48637644319974 | epot = -15.2407338534618 | etot = -14.6424332450854 +521000 ekin = 0.105864424815862 | erot = 0.453572806060421 | epot = -15.2018704759592 | etot = -14.6424332450829 +522000 ekin = 0.102315362067372 | erot = 0.422658367131508 | epot = -15.1674069742899 | etot = -14.642433245091 +523000 ekin = 0.101236366465152 | erot = 0.393536647097 | epot = -15.137206258669 | etot = -14.6424332451069 +524000 ekin = 0.102496717236721 | erot = 0.366081244308229 | epot = -15.1110112066728 | etot = -14.6424332451279 +525000 ekin = 0.105888887336008 | erot = 0.340164343214705 | epot = -15.088486475702 | etot = -14.6424332451513 +526000 ekin = 0.111143247850893 | erot = 0.315682368378702 | epot = -15.0692588614046 | etot = -14.642433245175 +527000 ekin = 0.117943398962381 | erot = 0.292576937807028 | epot = -15.0529535819665 | etot = -14.6424332451971 +528000 ekin = 0.125941474255768 | erot = 0.270849598243881 | epot = -15.0392243177156 | etot = -14.6424332452159 +529000 ekin = 0.134772916010344 | erot = 0.250569317239541 | epot = -15.0277754784805 | etot = -14.6424332452306 +530000 ekin = 0.144070383403707 | erot = 0.231872340652279 | epot = -15.0183759692969 | etot = -14.6424332452409 +531000 ekin = 0.153476601970632 | erot = 0.214954741435395 | epot = -15.010864588653 | etot = -14.642433245247 +532000 ekin = 0.1626560540789 | erot = 0.200058697649321 | epot = -15.0051479969777 | etot = -14.6424332452495 +533000 ekin = 0.171305419081489 | erot = 0.187454143184939 | epot = -15.0011928075153 | etot = -14.6424332452489 +534000 ekin = 0.179162595540411 | erot = 0.177417842695355 | epot = -14.9990136834822 | etot = -14.6424332452464 +535000 ekin = 0.186014006486684 | erot = 0.170212094444257 | epot = -14.9986593461736 | etot = -14.6424332452427 +536000 ekin = 0.191699759240443 | erot = 0.166065149228308 | epot = -15.0001981537074 | etot = -14.6424332452386 +537000 ekin = 0.196116169931545 | erot = 0.165155084981508 | epot = -15.0037045001479 | etot = -14.6424332452349 +538000 ekin = 0.199215220533704 | erot = 0.167598364573368 | epot = -15.0092468303392 | etot = -14.6424332452321 +539000 ekin = 0.201000709669604 | erot = 0.173443713619075 | epot = -15.0168776685195 | etot = -14.6424332452308 +540000 ekin = 0.201521164038046 | erot = 0.182671367033628 | epot = -15.026625776303 | etot = -14.6424332452313 +541000 ekin = 0.200859940141535 | erot = 0.195197211442984 | epot = -15.0384903968185 | etot = -14.642433245234 +542000 ekin = 0.199123298889063 | erot = 0.210880936223687 | epot = -15.0524374803519 | etot = -14.6424332452391 +543000 ekin = 0.196427519384046 | erot = 0.2295370177894 | epot = -15.0683977824198 | etot = -14.6424332452464 +544000 ekin = 0.192886294945241 | erot = 0.25094720200222 | epot = -15.0862667422039 | etot = -14.6424332452565 +545000 ekin = 0.188599710887441 | erot = 0.274873110235132 | epot = -15.1059060663912 | etot = -14.6424332452687 +546000 ekin = 0.183646045242704 | erot = 0.301067663118917 | epot = -15.1271469536446 | etot = -14.642433245283 +547000 ekin = 0.178077473818685 | erot = 0.329284179373518 | epot = -15.1497948984912 | etot = -14.642433245299 +548000 ekin = 0.171920510267331 | erot = 0.359282253783689 | epot = -15.1736360093672 | etot = -14.6424332453162 +549000 ekin = 0.165181670578021 | erot = 0.390829837831202 | epot = -15.1984447537431 | etot = -14.6424332453339 +550000 ekin = 0.157858408655527 | erot = 0.423701326917663 | epot = -15.2239929809248 | etot = -14.6424332453516 +551000 ekin = 0.149954809005965 | erot = 0.457671882716405 | epot = -15.2500599370908 | etot = -14.6424332453685 +552000 ekin = 0.141500835823196 | erot = 0.492508662660419 | epot = -15.2764427438674 | etot = -14.6424332453838 +553000 ekin = 0.132573145481942 | erot = 0.527960055124252 | epot = -15.3029664460031 | etot = -14.6424332453969 +554000 ekin = 0.123314645148993 | erot = 0.563744383269579 | epot = -15.329492273826 | etot = -14.6424332454074 +555000 ekin = 0.11394927090318 | erot = 0.599539792623581 | epot = -15.3559223089418 | etot = -14.642433245415 +556000 ekin = 0.104788088807789 | erot = 0.634977129563578 | epot = -15.3821984637916 | etot = -14.6424332454203 +557000 ekin = 0.0962230654780937 | erot = 0.669637513724418 | epot = -15.4082938246266 | etot = -14.6424332454241 +558000 ekin = 0.0887059614428439 | erot = 0.703055990480566 | epot = -15.4341951973516 | etot = -14.6424332454282 +559000 ekin = 0.0827118847741871 | erot = 0.734732129424035 | epot = -15.4598772596329 | etot = -14.6424332454346 +560000 ekin = 0.0786899547259807 | erot = 0.764147748398847 | epot = -15.4852709485702 | etot = -14.6424332454454 +561000 ekin = 0.0770067720633659 | erot = 0.790791153075989 | epot = -15.5102311706017 | etot = -14.6424332454624 +562000 ekin = 0.0778911706764631 | erot = 0.814186471629129 | epot = -15.534510887792 | etot = -14.6424332454864 +563000 ekin = 0.0813901113672907 | erot = 0.833925925483065 | epot = -15.5577492823675 | etot = -14.6424332455171 +564000 ekin = 0.0873448530219359 | erot = 0.849702302565726 | epot = -15.57948040114 | etot = -14.6424332455523 +565000 ekin = 0.0953935152543113 | erot = 0.861338569497175 | epot = -15.5991653303401 | etot = -14.6424332455886 +566000 ekin = 0.105001366119702 | erot = 0.868811531657282 | epot = -15.6162461433985 | etot = -14.6424332456215 +567000 ekin = 0.115514789210848 | erot = 0.872266750928135 | epot = -15.6302147857853 | etot = -14.6424332456464 +568000 ekin = 0.126230320990576 | erot = 0.872022546760986 | epot = -15.6406861134105 | etot = -14.6424332456589 +569000 ekin = 0.136467575205475 | erot = 0.868561781937934 | epot = -15.6474626027995 | etot = -14.6424332456561 +570000 ekin = 0.145634823229257 | erot = 0.862511177262809 | epot = -15.650579246129 | etot = -14.642433245637 +571000 ekin = 0.153278250260102 | erot = 0.854608991356203 | epot = -15.6503204872187 | etot = -14.6424332456024 +572000 ekin = 0.159109636953932 | erot = 0.845662918616737 | epot = -15.6472058011258 | etot = -14.6424332455552 +573000 ekin = 0.163011362017374 | erot = 0.836500892319944 | epot = -15.6419454998372 | etot = -14.6424332454999 +574000 ekin = 0.165021239080146 | erot = 0.82791805820528 | epot = -15.6353725427274 | etot = -14.642433245442 +575000 ekin = 0.165302195908609 | erot = 0.820623479704234 | epot = -15.628358921 | etot = -14.6424332453872 +576000 ekin = 0.164102988101204 | erot = 0.815190165399022 | epot = -15.6217263988411 | etot = -14.6424332453409 +577000 ekin = 0.16171615238716 | erot = 0.812011817944629 | epot = -15.6161612156398 | etot = -14.642433245308 +578000 ekin = 0.158438569371814 | erot = 0.811269345694708 | epot = -15.6121411603584 | etot = -14.6424332452919 +579000 ekin = 0.154538688869361 | erot = 0.812909695780807 | epot = -15.6098816299448 | etot = -14.6424332452946 +580000 ekin = 0.150232988454484 | erot = 0.816638977241892 | epot = -15.6093052110128 | etot = -14.6424332453164 +581000 ekin = 0.145672809814972 | erot = 0.821931135411058 | epot = -15.610037190582 | etot = -14.642433245356 +582000 ekin = 0.140941476791515 | erot = 0.828052590350937 | epot = -15.6114273125529 | etot = -14.6424332454104 +583000 ekin = 0.136060602599172 | erot = 0.834102246896438 | epot = -15.6125960949711 | etot = -14.6424332454755 +584000 ekin = 0.131003759896596 | erot = 0.839065139158377 | epot = -15.6125021446008 | etot = -14.6424332455458 +585000 ekin = 0.125715216483019 | erot = 0.841876757449112 | epot = -15.6100252195477 | etot = -14.6424332456156 +586000 ekin = 0.120131224768949 | erot = 0.841493945666844 | epot = -15.6040584161145 | etot = -14.6424332456787 +587000 ekin = 0.114201380572134 | erot = 0.836967317753832 | epot = -15.5936019440557 | etot = -14.6424332457297 +588000 ekin = 0.107907808226742 | erot = 0.827509595983301 | epot = -15.5778506499739 | etot = -14.6424332457638 +589000 ekin = 0.101280337909734 | erot = 0.81255426067366 | epot = -15.5562678443609 | etot = -14.6424332457776 +590000 ekin = 0.0944063548788447 | erot = 0.791799488420614 | epot = -15.5286390890685 | etot = -14.642433245769 +591000 ekin = 0.0874345511052151 | erot = 0.76523351922336 | epot = -15.4951013160666 | etot = -14.642433245738 +592000 ekin = 0.0805723392085189 | erot = 0.733139214285282 | epot = -15.45614479918 | etot = -14.6424332456862 +593000 ekin = 0.0740771594080953 | erot = 0.696077455348749 | epot = -15.4125878603736 | etot = -14.6424332456168 +594000 ekin = 0.0682423089599914 | erot = 0.654850963358167 | epot = -15.3655265178524 | etot = -14.6424332455342 +595000 ekin = 0.0633782539014622 | erot = 0.610451848323624 | epot = -15.316263347669 | etot = -14.6424332454439 +596000 ekin = 0.0597906540649622 | erot = 0.563997548401124 | epot = -15.266221447818 | etot = -14.6424332453519 +597000 ekin = 0.0577565493624107 | erot = 0.516660644084268 | epot = -15.2168504387109 | etot = -14.6424332452643 +598000 ekin = 0.0575003158536292 | erot = 0.46959829435364 | epot = -15.1695318553937 | etot = -14.6424332451864 +599000 ekin = 0.0591710965286411 | erot = 0.423886769451092 | epot = -15.125491111103 | etot = -14.6424332451233 +600000 ekin = 0.0628234356891151 | erot = 0.380465849281473 | epot = -15.085722530049 | etot = -14.6424332450784 +601000 ekin = 0.0684027903378462 | erot = 0.340096852289088 | epot = -15.0509328876808 | etot = -14.6424332450539 +602000 ekin = 0.0757374499128992 | erot = 0.303336891508859 | epot = -15.0215075864721 | etot = -14.6424332450503 +603000 ekin = 0.0845381560106908 | erot = 0.270530726252483 | epot = -14.9975021273299 | etot = -14.6424332450667 +604000 ekin = 0.0944063594078219 | erot = 0.241820347963514 | epot = -14.9786599524718 | etot = -14.6424332451004 +605000 ekin = 0.104851562460546 | erot = 0.217171224791095 | epot = -14.9644560323987 | etot = -14.6424332451471 +606000 ekin = 0.115317556389809 | erot = 0.196412930356164 | epot = -14.9541637319473 | etot = -14.6424332452013 +607000 ekin = 0.125216580353243 | erot = 0.179290709847465 | epot = -14.9469405354577 | etot = -14.6424332452569 +608000 ekin = 0.133969542490526 | erot = 0.165523445157702 | epot = -14.9419262329557 | etot = -14.6424332453075 +609000 ekin = 0.141049537028475 | erot = 0.154862582265136 | epot = -14.9383453646401 | etot = -14.6424332453465 +610000 ekin = 0.146025095175903 | erot = 0.147146040888474 | epot = -14.9356043814332 | etot = -14.6424332453689 +611000 ekin = 0.148599079335708 | erot = 0.142341118193759 | epot = -14.9333734429004 | etot = -14.6424332453709 +612000 ekin = 0.148639027542189 | erot = 0.140571068727531 | epot = -14.9316433416207 | etot = -14.6424332453509 +613000 ekin = 0.146195193893286 | erot = 0.142121441395761 | epot = -14.9307498805988 | etot = -14.6424332453097 +614000 ekin = 0.141503544705005 | erot = 0.147424293659447 | epot = -14.931361083615 | etot = -14.6424332452505 +615000 ekin = 0.134972482669537 | erot = 0.157020849768784 | epot = -14.9344265776169 | etot = -14.6424332451786 +616000 ekin = 0.127153892887427 | erot = 0.171505679772597 | epot = -14.941092817761 | etot = -14.642433245101 +617000 ekin = 0.11870096049717 | erot = 0.191457667915229 | epot = -14.9525918734383 | etot = -14.6424332450259 +618000 ekin = 0.110316794781908 | erot = 0.217364584491545 | epot = -14.9701146242349 | etot = -14.6424332449614 +619000 ekin = 0.102698942666063 | erot = 0.24954877623369 | epot = -14.9946809638151 | etot = -14.6424332449153 +620000 ekin = 0.0964852203315362 | erot = 0.288101317493775 | epot = -15.0270197827191 | etot = -14.6424332448938 +621000 ekin = 0.0922059091525968 | erot = 0.332831044367712 | epot = -15.0674701984216 | etot = -14.6424332449013 +622000 ekin = 0.0902463647100715 | erot = 0.38323345186412 | epot = -15.1159130615138 | etot = -14.6424332449397 +623000 ekin = 0.0908226920702821 | erot = 0.438482716267927 | epot = -15.1717386533468 | etot = -14.6424332450086 +624000 ekin = 0.0939716062521676 | erot = 0.497448307340542 | epot = -15.2338531586981 | etot = -14.6424332451054 +625000 ekin = 0.0995541611224928 | erot = 0.558735886785353 | epot = -15.3007232931327 | etot = -14.6424332452249 +626000 ekin = 0.10727185932578 | erot = 0.620750477457182 | epot = -15.3704555821433 | etot = -14.6424332453603 +627000 ekin = 0.11669282673767 | erot = 0.681778220901769 | epot = -15.440904293143 | etot = -14.6424332455036 +628000 ekin = 0.127285245273611 | erot = 0.740081431769978 | epot = -15.5097999226894 | etot = -14.6424332456458 +629000 ekin = 0.138455039153878 | erot = 0.794000196770909 | epot = -15.574888481703 | etot = -14.6424332457782 +630000 ekin = 0.149584842937125 | erot = 0.842052640240603 | epot = -15.6340707290701 | etot = -14.6424332458924 +631000 ekin = 0.16007149985305 | erot = 0.883025442878479 | epot = -15.6855301887134 | etot = -14.6424332459819 +632000 ekin = 0.169359720292797 | erot = 0.916046503426873 | epot = -15.7278394697614 | etot = -14.6424332460418 +633000 ekin = 0.17697005369257 | erot = 0.940632922941154 | epot = -15.7600362227032 | etot = -14.6424332460695 +634000 ekin = 0.182519961289978 | erot = 0.956709735134137 | epot = -15.781662942489 | etot = -14.6424332460649 +635000 ekin = 0.185737466035669 | erot = 0.964597760206484 | epot = -15.7927684722726 | etot = -14.6424332460304 +636000 ekin = 0.186467519303327 | erot = 0.964972204256472 | epot = -15.7938729695301 | etot = -14.6424332459703 +637000 ekin = 0.184671774604503 | erot = 0.958796660376594 | epot = -15.7859016808714 | etot = -14.6424332458903 +638000 ekin = 0.180422825778069 | erot = 0.947239527072976 | epot = -15.770095598648 | etot = -14.6424332457969 +639000 ekin = 0.173894119064868 | erot = 0.931581224196161 | epot = -15.7479085889582 | etot = -14.6424332456971 +640000 ekin = 0.165346701827808 | erot = 0.913120838753317 | epot = -15.7209007861785 | etot = -14.6424332455974 +641000 ekin = 0.155113786103713 | erot = 0.893090060089577 | epot = -15.6906370916966 | etot = -14.6424332455033 +642000 ekin = 0.143583869244232 | erot = 0.872580710306069 | epot = -15.6585978249697 | etot = -14.6424332454194 +643000 ekin = 0.131182953689577 | erot = 0.852490168054228 | epot = -15.6261063670927 | etot = -14.6424332453489 +644000 ekin = 0.11835630576118 | erot = 0.833486853990155 | epot = -15.5942764050452 | etot = -14.6424332452939 +645000 ekin = 0.105550209085084 | erot = 0.815995971212681 | epot = -15.5639794255528 | etot = -14.642433245255 +646000 ekin = 0.093194274419463 | erot = 0.800204061931152 | epot = -15.5358315815826 | etot = -14.642433245232 +647000 ekin = 0.0816850001800759 | erot = 0.786079744440879 | epot = -15.5101979898445 | etot = -14.6424332452235 +648000 ekin = 0.0713713598437969 | erot = 0.773407243193161 | epot = -15.4872118482646 | etot = -14.6424332452277 +649000 ekin = 0.0625431628717073 | erot = 0.761828976530834 | epot = -15.4668053846445 | etot = -14.642433245242 +650000 ekin = 0.0554227735503065 | erot = 0.750893453414394 | epot = -15.4487494722282 | etot = -14.6424332452635 +651000 ekin = 0.0501605027658154 | erot = 0.740104978449003 | epot = -15.4326987265042 | etot = -14.6424332452894 +652000 ekin = 0.0468336713663407 | erot = 0.728972100421355 | epot = -15.4182390171044 | etot = -14.6424332453167 +653000 ekin = 0.0454490492573823 | erot = 0.717052285945779 | epot = -15.4049345805458 | etot = -14.6424332453426 +654000 ekin = 0.0459481524943509 | erot = 0.70399086978471 | epot = -15.392372267644 | etot = -14.6424332453649 +655000 ekin = 0.0482147495286276 | erot = 0.689552835107397 | epot = -15.3802008300174 | etot = -14.6424332453814 +656000 ekin = 0.0520838761262644 | erot = 0.673646332749874 | epot = -15.3681634542669 | etot = -14.6424332453908 +657000 ekin = 0.0573516620848622 | erot = 0.656337023115527 | epot = -15.3561219305923 | etot = -14.6424332453919 +658000 ekin = 0.0637853134928166 | erot = 0.637852348219607 | epot = -15.344070907097 | etot = -14.6424332453846 +659000 ekin = 0.0711326702869886 | erot = 0.618574815847844 | epot = -15.3321407315043 | etot = -14.6424332453694 +660000 ekin = 0.0791308828101371 | erot = 0.599023454708784 | epot = -15.3205875828668 | etot = -14.6424332453479 +661000 ekin = 0.0875139366233974 | erot = 0.57982293974748 | epot = -15.309770121693 | etot = -14.6424332453222 +662000 ekin = 0.0960190004199823 | erot = 0.561660610347651 | epot = -15.3001128560629 | etot = -14.6424332452952 +663000 ekin = 0.104391848885353 | erot = 0.545232746054702 | epot = -15.2920578402108 | etot = -14.6424332452707 +664000 ekin = 0.112391863390337 | erot = 0.531182949318112 | epot = -15.2860080579609 | etot = -14.6424332452524 +665000 ekin = 0.119797262721372 | erot = 0.520037124796779 | epot = -15.2822676327621 | etot = -14.6424332452439 +666000 ekin = 0.126411190063575 | erot = 0.512141060960667 | epot = -15.2809854962725 | etot = -14.6424332452483 +667000 ekin = 0.132069035725156 | erot = 0.50760768172899 | epot = -15.2821099627212 | etot = -14.6424332452671 +668000 ekin = 0.136646914542223 | erot = 0.506281315754211 | epot = -15.2853614755972 | etot = -14.6424332453008 +669000 ekin = 0.140070616013037 | erot = 0.507725566171581 | epot = -15.2902294275325 | etot = -14.6424332453479 +670000 ekin = 0.142323740906691 | erot = 0.511239425098608 | epot = -15.2959964114102 | etot = -14.6424332454049 +671000 ekin = 0.143453306303075 | erot = 0.515903234044913 | epot = -15.3017897858151 | etot = -14.6424332454671 +672000 ekin = 0.143571012732429 | erot = 0.520652256718095 | epot = -15.3066565149792 | etot = -14.6424332455287 +673000 ekin = 0.142848733836965 | erot = 0.524371563356991 | epot = -15.3096535427773 | etot = -14.6424332455833 +674000 ekin = 0.141507613277731 | erot = 0.526002362930676 | epot = -15.3099432218337 | etot = -14.6424332456253 +675000 ekin = 0.139801302825604 | erot = 0.524647629024546 | epot = -15.3068821775003 | etot = -14.6424332456501 +676000 ekin = 0.137995095210655 | erot = 0.519664439041476 | epot = -15.3000927799068 | etot = -14.6424332456546 +677000 ekin = 0.136343677285201 | erot = 0.510732098517963 | epot = -15.2895090214411 | etot = -14.6424332456379 +678000 ekin = 0.135070664122621 | erot = 0.497888575256477 | epot = -15.2753924849801 | etot = -14.642433245601 +679000 ekin = 0.134352810444884 | erot = 0.481532294132544 | epot = -15.2583183501238 | etot = -14.6424332455464 +680000 ekin = 0.134310862655773 | erot = 0.462390968605323 | epot = -15.2391350767392 | etot = -14.6424332454781 +681000 ekin = 0.135007638923145 | erot = 0.441462941784857 | epot = -15.218903826109 | etot = -14.642433245401 +682000 ekin = 0.13645246152461 | erot = 0.419938865037855 | epot = -15.1988245718826 | etot = -14.6424332453201 +683000 ekin = 0.138609887397967 | erot = 0.399112293315506 | epot = -15.180155425954 | etot = -14.6424332452405 +684000 ekin = 0.141410065648281 | erot = 0.38028718176242 | epot = -15.164130492578 | etot = -14.6424332451673 +685000 ekin = 0.144758102722259 | erot = 0.364688846299456 | epot = -15.1518801941268 | etot = -14.6424332451051 +686000 ekin = 0.148540467119441 | erot = 0.353383275614529 | epot = -15.1443569877921 | etot = -14.6424332450581 +687000 ekin = 0.152627512098729 | erot = 0.347208212230897 | epot = -15.1422689693592 | etot = -14.6424332450296 +688000 ekin = 0.156872371008247 | erot = 0.346718408271177 | epot = -15.1460240243021 | etot = -14.6424332450226 +689000 ekin = 0.161107527974783 | erot = 0.35214694111545 | epot = -15.1556877141289 | etot = -14.6424332450387 +690000 ekin = 0.165141087380649 | erot = 0.36338430494212 | epot = -15.1709586374008 | etot = -14.6424332450781 +691000 ekin = 0.168755042649078 | erot = 0.379976931156632 | epot = -15.1911652189454 | etot = -14.6424332451396 +692000 ekin = 0.171707649703689 | erot = 0.401146558397852 | epot = -15.215287453322 | etot = -14.6424332452204 +693000 ekin = 0.173741393443089 | erot = 0.42583123278867 | epot = -15.2420058715475 | etot = -14.6424332453157 +694000 ekin = 0.174597110624771 | erot = 0.452747528140126 | epot = -15.2697778841841 | etot = -14.6424332454192 +695000 ekin = 0.174033757472238 | erot = 0.480471830922422 | epot = -15.2969388339178 | etot = -14.6424332455232 +696000 ekin = 0.171852263364757 | erot = 0.507536398158356 | epot = -15.3218219071425 | etot = -14.6424332456194 +697000 ekin = 0.167921065290933 | erot = 0.532533688693164 | epot = -15.3428879996837 | etot = -14.6424332456996 +698000 ekin = 0.162200409477029 | erot = 0.554220619925199 | epot = -15.3588542751586 | etot = -14.6424332457564 +699000 ekin = 0.154762415715643 | erot = 0.571613361028106 | epot = -15.3688090225278 | etot = -14.642433245784 +700000 ekin = 0.145804230008803 | erot = 0.584063387088072 | epot = -15.3723008628759 | etot = -14.6424332457791 +701000 ekin = 0.135652269558616 | erot = 0.591306922721422 | epot = -15.3693924380207 | etot = -14.6424332457407 +702000 ekin = 0.124756460207487 | erot = 0.593482464349051 | epot = -15.3606721702277 | etot = -14.6424332456711 +703000 ekin = 0.113674325951271 | erot = 0.591114401856995 | epot = -15.3472219733833 | etot = -14.642433245575 +704000 ekin = 0.1030456759456 | erot = 0.585064323196589 | epot = -15.3305432446015 | etot = -14.6424332454593 +705000 ekin = 0.0935593581963262 | erot = 0.576454826534689 | epot = -15.3124474300639 | etot = -14.6424332453329 +706000 ekin = 0.0859140824284925 | erot = 0.566573150256724 | epot = -15.2949204778902 | etot = -14.642433245205 +707000 ekin = 0.0807756759557919 | erot = 0.556763427609511 | epot = -15.279972348651 | etot = -14.6424332450857 +708000 ekin = 0.0787333622600079 | erot = 0.548316855291324 | epot = -15.2694834625352 | etot = -14.6424332449839 +709000 ekin = 0.0802577669151073 | erot = 0.542368667954005 | epot = -15.2650596797768 | etot = -14.6424332449077 +710000 ekin = 0.0856633545528672 | erot = 0.539809747049325 | epot = -15.2679063464655 | etot = -14.6424332448633 +711000 ekin = 0.095077851902745 | erot = 0.541219180891425 | epot = -15.278730277649 | etot = -14.6424332448548 +712000 ekin = 0.108420876622167 | erot = 0.546822307911541 | epot = -15.2976764294173 | etot = -14.6424332448836 +713000 ekin = 0.125393451694849 | erot = 0.556476834657793 | epot = -15.3243035313014 | etot = -14.6424332449487 +714000 ekin = 0.145479367621451 | erot = 0.56968760011942 | epot = -15.3576002127876 | etot = -14.6424332450467 +715000 ekin = 0.167958541116837 | erot = 0.585648522303156 | epot = -15.396040308592 | etot = -14.642433245172 +716000 ekin = 0.191931735851211 | erot = 0.603308292531433 | epot = -15.4376732736996 | etot = -14.6424332453169 +717000 ekin = 0.216355400176877 | erot = 0.621454592037058 | epot = -15.4802432376869 | etot = -14.6424332454729 +718000 ekin = 0.24008505651043 | erot = 0.638810139731555 | epot = -15.5213284418724 | etot = -14.6424332456304 +719000 ekin = 0.261925698575348 | erot = 0.654132895986132 | epot = -15.5584918403414 | etot = -14.6424332457799 +720000 ekin = 0.280687969311602 | erot = 0.6663123798671 | epot = -15.5894335950909 | etot = -14.6424332459122 +721000 ekin = 0.295249345589177 | erot = 0.674454385927726 | epot = -15.612136977536 | etot = -14.6424332460191 +722000 ekin = 0.304619886333769 | erot = 0.677947410255128 | epot = -15.6250005426823 | etot = -14.6424332460934 +723000 ekin = 0.308011983728025 | erot = 0.676505724570436 | epot = -15.6269509544278 | etot = -14.6424332461294 +724000 ekin = 0.304912667284422 | erot = 0.670186105899586 | epot = -15.617532019307 | etot = -14.642433246123 +725000 ekin = 0.295155116711621 | erot = 0.659377522489412 | epot = -15.596965885273 | etot = -14.642433246072 +726000 ekin = 0.278983134900163 | erot = 0.644765363158375 | epot = -15.5661817440352 | etot = -14.6424332459767 +727000 ekin = 0.257098790794435 | erot = 0.627273860362892 | epot = -15.5268058969976 | etot = -14.6424332458402 +728000 ekin = 0.230680158274999 | erot = 0.607992016180427 | epot = -15.4811054201245 | etot = -14.6424332456691 +729000 ekin = 0.201354496276734 | erot = 0.588089464034349 | epot = -15.4318772057847 | etot = -14.6424332454737 +730000 ekin = 0.171114103979347 | erot = 0.56872921471559 | epot = -15.3822765639634 | etot = -14.6424332452685 +731000 ekin = 0.142168923912302 | erot = 0.55098413507048 | epot = -15.335586304054 | etot = -14.6424332450712 +732000 ekin = 0.116742007100633 | erot = 0.535763349043665 | epot = -15.2949386010453 | etot = -14.642433244901 +733000 ekin = 0.09682930275761 | erot = 0.523753647321524 | epot = -15.2630161948552 | etot = -14.6424332447761 +734000 ekin = 0.0839596135620733 | erot = 0.515379592338451 | epot = -15.2417724506113 | etot = -14.6424332447107 +735000 ekin = 0.0789983701793142 | erot = 0.510784464195818 | epot = -15.2322160790872 | etot = -14.6424332447121 +736000 ekin = 0.0820355551944443 | erot = 0.509832642266179 | epot = -15.2343014422398 | etot = -14.6424332447791 +737000 ekin = 0.0923827123871823 | erot = 0.512132550855379 | epot = -15.2469485081446 | etot = -14.642433244902 +738000 ekin = 0.10868044851431 | erot = 0.517077971027559 | epot = -15.2681916646065 | etot = -14.6424332450646 +739000 ekin = 0.129093715683514 | erot = 0.523904364926965 | epot = -15.2954313258571 | etot = -14.6424332452466 +740000 ekin = 0.151555277793959 | erot = 0.531755895780137 | epot = -15.3257444190018 | etot = -14.6424332454277 +741000 ekin = 0.174012721806636 | erot = 0.539758083454087 | epot = -15.3562040508504 | etot = -14.6424332455896 +742000 ekin = 0.194640916831482 | erot = 0.54709054970013 | epot = -15.3841647122503 | etot = -14.6424332457187 +743000 ekin = 0.211995737398838 | erot = 0.553054125338314 | epot = -15.4074831085433 | etot = -14.6424332458062 +744000 ekin = 0.225100508723079 | erot = 0.557126762310524 | epot = -15.424660516882 | etot = -14.6424332458484 +745000 ekin = 0.233469424487108 | erot = 0.559003260239957 | epot = -15.4349059305735 | etot = -14.6424332458464 +746000 ekin = 0.237079913465558 | erot = 0.558614810500983 | epot = -15.4381279697713 | etot = -14.6424332458048 +747000 ekin = 0.236308652985589 | erot = 0.556125790084016 | epot = -15.4348676888005 | etot = -14.6424332457309 +748000 ekin = 0.231845097888752 | erot = 0.55190707933143 | epot = -15.4261854228542 | etot = -14.642433245634 +749000 ekin = 0.224593843485221 | erot = 0.546487360031015 | epot = -15.4135144490412 | etot = -14.6424332455249 +750000 ekin = 0.215574369393402 | erot = 0.540486233486425 | epot = -15.3984938482944 | etot = -14.6424332454146 +751000 ekin = 0.205824583428198 | erot = 0.534535356766148 | epot = -15.3827931855081 | etot = -14.6424332453138 +752000 ekin = 0.196313335743884 | erot = 0.52919581522017 | epot = -15.3679423961961 | etot = -14.642433245232 +753000 ekin = 0.187866475789629 | erot = 0.524881252733656 | epot = -15.3551809737001 | etot = -14.6424332451768 +754000 ekin = 0.181110613628486 | erot = 0.521796491099562 | epot = -15.3453403498807 | etot = -14.6424332451526 +755000 ekin = 0.176438042206913 | erot = 0.519900210808863 | epot = -15.3387714981765 | etot = -14.6424332451607 +756000 ekin = 0.173994962649932 | erot = 0.518897676286876 | epot = -15.3353258841353 | etot = -14.6424332451985 +757000 ekin = 0.173693190273803 | erot = 0.518265706184404 | epot = -15.3343921417187 | etot = -14.6424332452605 +758000 ekin = 0.175243155018275 | erot = 0.517307659823502 | epot = -15.3349840601801 | etot = -14.6424332453383 +759000 ekin = 0.178203703096672 | erot = 0.515231902166426 | epot = -15.3358688506853 | etot = -14.6424332454222 +760000 ekin = 0.182042463552542 | erot = 0.511243837950911 | epot = -15.3357195470056 | etot = -14.6424332455021 +761000 ekin = 0.186199747764937 | erot = 0.504639825549636 | epot = -15.3332728188833 | etot = -14.6424332455687 +762000 ekin = 0.190149235948647 | erot = 0.494891409035961 | epot = -15.3274738905993 | etot = -14.6424332456147 +763000 ekin = 0.193449921097656 | erot = 0.48171023828929 | epot = -15.3175934050219 | etot = -14.642433245635 +764000 ekin = 0.195785552428858 | erot = 0.465087294353624 | epot = -15.3033060924099 | etot = -14.6424332456274 +765000 ekin = 0.196989678186435 | erot = 0.445303873494018 | epot = -15.2847267972728 | etot = -14.6424332455924 +766000 ekin = 0.197055919183657 | erot = 0.422915440293833 | epot = -15.2624046050103 | etot = -14.6424332455328 +767000 ekin = 0.196134076493791 | erot = 0.398712320924463 | epot = -15.2372796428714 | etot = -14.6424332454532 +768000 ekin = 0.19451309665161 | erot = 0.373662938959324 | epot = -15.2106092809708 | etot = -14.6424332453598 +769000 ekin = 0.192592017625545 | erot = 0.348845887485747 | epot = -15.183871150371 | etot = -14.6424332452597 +770000 ekin = 0.190840163684042 | erot = 0.325376840212043 | epot = -15.1586502490567 | etot = -14.6424332451606 +771000 ekin = 0.189748397224706 | erot = 0.304335529899335 | epot = -15.1365171721945 | etot = -14.6424332450705 +772000 ekin = 0.189774341847512 | erot = 0.286697153920059 | epot = -15.1189047407643 | etot = -14.6424332449968 +773000 ekin = 0.191286034497103 | erot = 0.273271857835136 | epot = -15.1069911372781 | etot = -14.6424332449458 +774000 ekin = 0.194510000604928 | erot = 0.264655458968671 | epot = -15.1015987044965 | etot = -14.6424332449229 +775000 ekin = 0.1994906396753 | erot = 0.261194193154413 | epot = -15.1031180777602 | etot = -14.6424332449305 +776000 ekin = 0.20606747706162 | erot = 0.262965803934266 | epot = -15.1114665259645 | etot = -14.6424332449687 +777000 ekin = 0.213875019082075 | erot = 0.269778568411878 | epot = -15.1260868325288 | etot = -14.6424332450348 +778000 ekin = 0.222366868961501 | erot = 0.281188790675803 | epot = -15.1459889047609 | etot = -14.6424332451236 +779000 ekin = 0.23086210226578 | erot = 0.296535944176041 | epot = -15.1698312916694 | etot = -14.6424332452276 +780000 ekin = 0.238608567016832 | erot = 0.314993169091967 | epot = -15.1960349814467 | etot = -14.6424332453379 +781000 ekin = 0.244855557739749 | erot = 0.335629445236581 | epot = -15.2229182484218 | etot = -14.6424332454454 +782000 ekin = 0.24892761247725 | erot = 0.357478674286814 | epot = -15.2488395323052 | etot = -14.6424332455412 +783000 ekin = 0.250291897528933 | erot = 0.379610269028307 | epot = -15.2723354121746 | etot = -14.6424332456174 +784000 ekin = 0.248613283253142 | erot = 0.401195731122951 | epot = -15.2922422600441 | etot = -14.642433245668 +785000 ekin = 0.243793133451306 | erot = 0.421566090466591 | epot = -15.307792469607 | etot = -14.6424332456891 +786000 ekin = 0.235989501853544 | erot = 0.440255905206922 | epot = -15.3186786527391 | etot = -14.6424332456787 +787000 ekin = 0.225617610785755 | erot = 0.457030673432498 | epot = -15.3250815298558 | etot = -14.6424332456375 +788000 ekin = 0.213330260903068 | erot = 0.471895861696116 | epot = -15.3276593681681 | etot = -14.6424332455689 +789000 ekin = 0.199978499678474 | erot = 0.485087183883212 | epot = -15.3274989290401 | etot = -14.6424332454784 +790000 ekin = 0.186553834704413 | erot = 0.497043141243068 | epot = -15.3260302213206 | etot = -14.6424332453731 +791000 ekin = 0.174114766793401 | erot = 0.508362048570016 | epot = -15.3249100606255 | etot = -14.6424332452621 +792000 ekin = 0.163702420432354 | erot = 0.519746739181041 | epot = -15.3258824047684 | etot = -14.642433245155 +793000 ekin = 0.156252224966272 | erot = 0.531940822989567 | epot = -15.3306262930174 | etot = -14.6424332450615 +794000 ekin = 0.152510350034305 | erot = 0.545660777315136 | epot = -15.3406043723396 | etot = -14.6424332449902 +795000 ekin = 0.15296425115691 | erot = 0.561528326981077 | epot = -15.3569258230862 | etot = -14.6424332449482 +796000 ekin = 0.157795747355293 | erot = 0.58000757877803 | epot = -15.3802365710733 | etot = -14.64243324494 +797000 ekin = 0.166862457855209 | erot = 0.601351255569628 | epot = -15.4106469583921 | etot = -14.6424332449673 +798000 ekin = 0.179709603428639 | erot = 0.625560121845548 | epot = -15.4477029703033 | etot = -14.6424332450291 +799000 ekin = 0.195609966057174 | erot = 0.652359247176621 | epot = -15.4904024583554 | etot = -14.6424332451216 +800000 ekin = 0.213626158786275 | erot = 0.681194021873727 | epot = -15.5372534258987 | etot = -14.6424332452387 +801000 ekin = 0.23268704018842 | erot = 0.711247726386662 | epot = -15.5863680119477 | etot = -14.6424332453727 +802000 ekin = 0.251669429101161 | erot = 0.74148091983623 | epot = -15.6355835944521 | etot = -14.6424332455147 +803000 ekin = 0.269477067853805 | erot = 0.77069100842129 | epot = -15.6826013219308 | etot = -14.6424332456557 +804000 ekin = 0.285110541453744 | erot = 0.797588259158567 | epot = -15.7251320463987 | etot = -14.6424332457864 +805000 ekin = 0.297723982502972 | erot = 0.820882528799733 | epot = -15.7610397572013 | etot = -14.6424332458986 +806000 ekin = 0.306666387684833 | erot = 0.839373432913609 | epot = -15.7884730665839 | etot = -14.6424332459854 +807000 ekin = 0.31150697555439 | erot = 0.852035914445983 | epot = -15.805976136042 | etot = -14.6424332460416 +808000 ekin = 0.312045176252642 | erot = 0.858093398528306 | epot = -15.8125718208452 | etot = -14.6424332460642 +809000 ekin = 0.308306642387692 | erot = 0.857071970758726 | epot = -15.8078118591988 | etot = -14.6424332460524 +810000 ekin = 0.300527220561155 | erot = 0.848831113928873 | epot = -15.7917915804976 | etot = -14.6424332460076 +811000 ekin = 0.289127204421254 | erot = 0.833569138622274 | epot = -15.7651295889768 | etot = -14.6424332459333 +812000 ekin = 0.274678427602453 | erot = 0.81180411649313 | epot = -15.7289157899302 | etot = -14.6424332458346 +813000 ekin = 0.25786683558395 | erot = 0.784333459542784 | epot = -15.6846335408444 | etot = -14.6424332457177 +814000 ekin = 0.239453080594243 | erot = 0.752176980196514 | epot = -15.6340633063802 | etot = -14.6424332455895 +815000 ekin = 0.220233415151703 | erot = 0.716509170266734 | epot = -15.5791758308754 | etot = -14.642433245457 +816000 ekin = 0.201002751046678 | erot = 0.678586569748113 | epot = -15.5220225661216 | etot = -14.6424332453268 +817000 ekin = 0.182521261080269 | erot = 0.639675603864976 | epot = -15.4646301101501 | etot = -14.6424332452049 +818000 ekin = 0.16548540152786 | erot = 0.600985363831456 | epot = -15.4089040104558 | etot = -14.6424332450964 +819000 ekin = 0.15050378978042 | erot = 0.563608719249299 | epot = -15.3565457540354 | etot = -14.6424332450057 +820000 ekin = 0.138078032178478 | erot = 0.528474068972393 | epot = -15.3089853460865 | etot = -14.6424332449356 +821000 ekin = 0.128588386730135 | erot = 0.496309093117806 | epot = -15.2673307247362 | etot = -14.6424332448883 +822000 ekin = 0.122284066136812 | erot = 0.467617125515789 | epot = -15.2323344365172 | etot = -14.6424332448646 +823000 ekin = 0.119278020924339 | erot = 0.44266622847877 | epot = -15.2043774942677 | etot = -14.6424332448646 +824000 ekin = 0.119546158603677 | erot = 0.421490682738665 | epot = -15.1834700862295 | etot = -14.6424332448872 +825000 ekin = 0.122931110514549 | erot = 0.403904342223771 | epot = -15.1692686976685 | etot = -14.6424332449302 +826000 ekin = 0.129150803764327 | erot = 0.389525075000029 | epot = -15.161109123755 | etot = -14.6424332449907 +827000 ekin = 0.137812176399179 | erot = 0.377809252270532 | epot = -15.1580546737345 | etot = -14.6424332450648 +828000 ekin = 0.148430331608382 | erot = 0.368094906962796 | epot = -15.1589584837191 | etot = -14.6424332451479 +829000 ekin = 0.160453205761696 | erot = 0.359651737511967 | epot = -15.1625381885082 | etot = -14.6424332452346 +830000 ekin = 0.17329138289678 | erot = 0.351735589545236 | epot = -15.1674602177611 | etot = -14.6424332453191 +831000 ekin = 0.186352012962992 | erot = 0.343644456329796 | epot = -15.1724297146884 | etot = -14.6424332453957 +832000 ekin = 0.19907492460549 | erot = 0.334772487920949 | epot = -15.1762806579855 | etot = -14.642433245459 +833000 ekin = 0.21096808488054 | erot = 0.324658115188717 | epot = -15.1780594455737 | etot = -14.6424332455044 +834000 ekin = 0.22163875725698 | erot = 0.313022323442326 | epot = -15.1770943262282 | etot = -14.6424332455289 +835000 ekin = 0.230816330001966 | erot = 0.299793483326653 | epot = -15.1730430588596 | etot = -14.642433245531 +836000 ekin = 0.238363132174234 | erot = 0.28511603996084 | epot = -15.1659124176466 | etot = -14.6424332455115 +837000 ekin = 0.244270841530998 | erot = 0.269341751259632 | epot = -15.1560458382641 | etot = -14.6424332454734 +838000 ekin = 0.248642320235733 | erot = 0.25300390410384 | epot = -15.1440794697607 | etot = -14.6424332454212 +839000 ekin = 0.251661569327697 | erot = 0.23677675898714 | epot = -15.1308715736755 | etot = -14.6424332453607 +840000 ekin = 0.253557306828274 | erot = 0.221424057161473 | epot = -15.1174146092878 | etot = -14.642433245298 +841000 ekin = 0.254567562696821 | erot = 0.207741475743574 | epot = -15.104742283679 | etot = -14.6424332452386 +842000 ekin = 0.254912814683751 | erot = 0.196498262354278 | epot = -15.0938443222248 | etot = -14.6424332451868 +843000 ekin = 0.254783130765828 | erot = 0.188382921787058 | epot = -15.085599297698 | etot = -14.6424332451451 +844000 ekin = 0.254340789697888 | erot = 0.183956927272106 | epot = -15.0807309620847 | etot = -14.6424332451147 +845000 ekin = 0.253734932891713 | erot = 0.183619247980611 | epot = -15.0797874259676 | etot = -14.6424332450953 +846000 ekin = 0.253120504196155 | erot = 0.187583282239862 | epot = -15.0831370315226 | etot = -14.6424332450866 +847000 ekin = 0.252671650088266 | erot = 0.195866742639111 | epot = -15.0909716378154 | etot = -14.642433245088 +848000 ekin = 0.25258091531028 | erot = 0.20829422246314 | epot = -15.1033083828732 | etot = -14.6424332450998 +849000 ekin = 0.253039966848252 | erot = 0.224511555531826 | epot = -15.1199847675027 | etot = -14.6424332451227 +850000 ekin = 0.254204001798515 | erot = 0.244010590097797 | epot = -15.1406478370536 | etot = -14.6424332451573 +851000 ekin = 0.256148339026787 | erot = 0.26616256360263 | epot = -15.1647441478333 | etot = -14.6424332452039 +852000 ekin = 0.258829686440588 | erot = 0.290257858698213 | epot = -15.1915207904 | etot = -14.6424332452612 +853000 ekin = 0.262064657828587 | erot = 0.315549558167727 | epot = -15.2200474613225 | etot = -14.6424332453262 +854000 ekin = 0.265534116122648 | erot = 0.341297947736379 | epot = -15.2492653092531 | etot = -14.6424332453941 +855000 ekin = 0.26881517465358 | erot = 0.366813004430893 | epot = -15.2780614245436 | etot = -14.6424332454591 +856000 ekin = 0.271435486954603 | erot = 0.391492007901445 | epot = -15.305360740371 | etot = -14.642433245515 +857000 ekin = 0.272939108063008 | erot = 0.414849750473414 | epot = -15.3302221040928 | etot = -14.6424332455564 +858000 ekin = 0.272951155039785 | erot = 0.436539390688027 | epot = -15.3519237913071 | etot = -14.6424332455793 +859000 ekin = 0.271229880676472 | erot = 0.456362750059341 | epot = -15.3700258763176 | etot = -14.6424332455817 +860000 ekin = 0.267698633833911 | erot = 0.474269718460682 | epot = -15.3844015978589 | etot = -14.6424332455643 +861000 ekin = 0.262455001752904 | erot = 0.490347316007815 | epot = -15.3952355632896 | etot = -14.6424332455289 +862000 ekin = 0.255758797176706 | erot = 0.504799761298941 | epot = -15.402991803955 | etot = -14.6424332454794 +863000 ekin = 0.248003564341433 | erot = 0.517921532812514 | epot = -15.4083583425743 | etot = -14.6424332454204 +864000 ekin = 0.23967765558487 | erot = 0.5300658235034 | epot = -15.4121767244453 | etot = -14.642433245357 +865000 ekin = 0.23132088944539 | erot = 0.541610953534341 | epot = -15.4153650882739 | etot = -14.6424332452941 +866000 ekin = 0.223481813676297 | erot = 0.552927233331988 | epot = -15.4188422922445 | etot = -14.6424332452362 +867000 ekin = 0.216679174491969 | erot = 0.564346499432351 | epot = -15.4234589191111 | etot = -14.6424332451867 +868000 ekin = 0.211369750018244 | erot = 0.57613613893885 | epot = -15.4299391341058 | etot = -14.6424332451487 +869000 ekin = 0.207923502308331 | erot = 0.588478941151472 | epot = -15.4388356885839 | etot = -14.6424332451241 +870000 ekin = 0.206606153000455 | erot = 0.601459626890416 | epot = -15.4504990250046 | etot = -14.6424332451137 +871000 ekin = 0.207568796758621 | erot = 0.615058451105655 | epot = -15.4650604929822 | etot = -14.6424332451179 +872000 ekin = 0.210843969902065 | erot = 0.62915187575959 | epot = -15.4824290907976 | etot = -14.642433245136 +873000 ekin = 0.216347593119461 | erot = 0.643519970833663 | epot = -15.5023008091198 | etot = -14.6424332451666 +874000 ekin = 0.223886305143511 | erot = 0.65785990973072 | epot = -15.5241794600822 | etot = -14.6424332452079 +875000 ekin = 0.233169807553207 | erot = 0.67180466221101 | epot = -15.5474077150216 | etot = -14.6424332452574 +876000 ekin = 0.243827877963662 | erot = 0.684945735800061 | epot = -15.5712068590757 | etot = -14.642433245312 +877000 ekin = 0.255431632545988 | erot = 0.696858567354671 | epot = -15.5947234452691 | etot = -14.6424332453684 +878000 ekin = 0.267518408513276 | erot = 0.707128927388885 | epot = -15.6170805813255 | etot = -14.6424332454234 +879000 ekin = 0.279619300259048 | erot = 0.71537849572129 | epot = -15.6374310414537 | etot = -14.6424332454734 +880000 ekin = 0.291287955020511 | erot = 0.721287639199272 | epot = -15.6550088397353 | etot = -14.6424332455155 +881000 ekin = 0.30212877846463 | erot = 0.724613422810775 | epot = -15.6691754468226 | etot = -14.6424332455472 +882000 ekin = 0.311822304068824 | erot = 0.725201068176889 | epot = -15.6794566178125 | etot = -14.6424332455668 +883000 ekin = 0.320145243787706 | erot = 0.722987481104172 | epot = -15.6855659704655 | etot = -14.6424332455736 +884000 ekin = 0.326982762198909 | erot = 0.717996120159159 | epot = -15.6874121279265 | etot = -14.6424332455684 +885000 ekin = 0.332330882212481 | erot = 0.710323349672059 | epot = -15.6850874774374 | etot = -14.6424332455528 +886000 ekin = 0.33628767333099 | erot = 0.700117442976239 | epot = -15.678838361837 | etot = -14.6424332455298 +887000 ekin = 0.339032964151614 | erot = 0.687552454437006 | epot = -15.6690186640916 | etot = -14.642433245503 +888000 ekin = 0.340797654544347 | erot = 0.67280010094551 | epot = -15.6560310009666 | etot = -14.6424332454768 +889000 ekin = 0.341825106158976 | erot = 0.656003407102339 | epot = -15.6402617587166 | etot = -14.6424332454552 +890000 ekin = 0.342328347575176 | erot = 0.63725601316603 | epot = -15.6220176061831 | etot = -14.6424332454419 +891000 ekin = 0.342447730492056 | erot = 0.616590618570594 | epot = -15.601471594502 | etot = -14.6424332454393 +892000 ekin = 0.342214057411724 | erot = 0.593979026506924 | epot = -15.5786263293674 | etot = -14.6424332454488 +893000 ekin = 0.341522004910123 | erot = 0.569344767734232 | epot = -15.5533000181139 | etot = -14.6424332454695 +894000 ekin = 0.340117934117577 | erot = 0.542587519917294 | epot = -15.5251386995343 | etot = -14.6424332454994 +895000 ekin = 0.337605044782497 | erot = 0.51361677898196 | epot = -15.4936550692992 | etot = -14.6424332455348 +896000 ekin = 0.333467462872322 | erot = 0.482390775175684 | epot = -15.4582914836184 | etot = -14.6424332455704 +897000 ekin = 0.327113397522066 | erot = 0.448955709004578 | epot = -15.418502352127 | etot = -14.6424332456003 +898000 ekin = 0.317936017621476 | erot = 0.413480165460528 | epot = -15.3738494287003 | etot = -14.6424332456182 +899000 ekin = 0.305389123797598 | erot = 0.376280077470489 | epot = -15.3241024468861 | etot = -14.642433245618 +900000 ekin = 0.289072881398049 | erot = 0.337830752319602 | epot = -15.2693368793114 | etot = -14.6424332455938 +901000 ekin = 0.268822686263612 | erot = 0.298764046956934 | epot = -15.2100199787618 | etot = -14.6424332455413 +902000 ekin = 0.244791653973738 | erot = 0.259850521116738 | epot = -15.1470754205486 | etot = -14.6424332454581 +903000 ekin = 0.217514571467803 | erot = 0.221968047208507 | epot = -15.0819158640206 | etot = -14.6424332453443 +904000 ekin = 0.187939204416829 | erot = 0.186059692010109 | epot = -15.0164321416307 | etot = -14.6424332452037 +905000 ekin = 0.157410847736455 | erot = 0.153084564881008 | epot = -14.9529286576612 | etot = -14.6424332450437 +906000 ekin = 0.127599356275899 | erot = 0.123965703542346 | epot = -14.8939983046941 | etot = -14.6424332448759 +907000 ekin = 0.100365589134322 | erot = 0.0995389863868474 | epot = -14.8423378202363 | etot = -14.6424332447151 +908000 ekin = 0.077575985596966 | erot = 0.0805066337376087 | epot = -14.800515863912 | etot = -14.6424332445775 +909000 ekin = 0.0608876950043041 | erot = 0.0673982354547353 | epot = -14.7707191749375 | etot = -14.6424332444784 +910000 ekin = 0.0515382922982525 | erot = 0.0605415547693243 | epot = -14.7545130914978 | etot = -14.6424332444302 +911000 ekin = 0.0501789452889699 | erot = 0.0600446989615507 | epot = -14.7526568886895 | etot = -14.642433244439 +912000 ekin = 0.0567846925720978 | erot = 0.065790645022677 | epot = -14.7650085820984 | etot = -14.6424332445036 +913000 ekin = 0.0706603747930292 | erot = 0.0774445361871137 | epot = -14.7905381555968 | etot = -14.6424332446166 +914000 ekin = 0.0905398584091615 | erot = 0.0944735694308371 | epot = -14.8274466726047 | etot = -14.6424332447647 +915000 ekin = 0.114756144628398 | erot = 0.116178630208142 | epot = -14.8733680197681 | etot = -14.6424332449316 +916000 ekin = 0.141447043402251 | erot = 0.141736093139704 | epot = -14.9256163816432 | etot = -14.6424332451012 +917000 ekin = 0.168758535419812 | erot = 0.170247440489189 | epot = -14.9814392211683 | etot = -14.6424332452593 +918000 ekin = 0.195014913439607 | erot = 0.200793639368855 | epot = -15.0382417982036 | etot = -14.6424332453951 +919000 ekin = 0.218837422083647 | erot = 0.232490666336242 | epot = -15.0937613339215 | etot = -14.6424332455016 +920000 ekin = 0.239206641023718 | erot = 0.264542267092076 | epot = -15.1461821536915 | etot = -14.6424332455757 +921000 ekin = 0.255474577148654 | erot = 0.296286050802385 | epot = -15.1941938735684 | etot = -14.6424332456174 +922000 ekin = 0.267338631215765 | erot = 0.327229363205489 | epot = -15.2370012400499 | etot = -14.6424332456286 +923000 ekin = 0.274791412214202 | erot = 0.357072039937939 | epot = -15.2742966977655 | etot = -14.6424332456134 +924000 ekin = 0.278059017516371 | erot = 0.385714059433155 | epot = -15.3062063225259 | etot = -14.6424332455763 +925000 ekin = 0.277537405168372 | erot = 0.41324722009601 | epot = -15.3332178707874 | etot = -14.642433245523 +926000 ekin = 0.273733135238329 | erot = 0.439931173662005 | epot = -15.3560975543592 | etot = -14.6424332454589 +927000 ekin = 0.267211859641524 | erot = 0.466155363882809 | epot = -15.3758004689143 | etot = -14.6424332453899 +928000 ekin = 0.258555847536078 | erot = 0.492389553503158 | epot = -15.3933786463609 | etot = -14.6424332453217 +929000 ekin = 0.248330567891891 | erot = 0.519126582982283 | epot = -15.4098903961336 | etot = -14.6424332452594 +930000 ekin = 0.237059747166165 | erot = 0.546821711632301 | epot = -15.4263147040064 | etot = -14.6424332452079 +931000 ekin = 0.22520814480582 | erot = 0.575833282923993 | epot = -15.4434746729008 | etot = -14.6424332451709 +932000 ekin = 0.213171319365827 | erot = 0.606369490852174 | epot = -15.4619740553694 | etot = -14.6424332451514 +933000 ekin = 0.201271722995889 | erot = 0.63844569037927 | epot = -15.482150658526 | etot = -14.6424332451508 +934000 ekin = 0.189760460110152 | erot = 0.671856006699522 | epot = -15.5040497119791 | etot = -14.6424332451694 +935000 ekin = 0.178823941838377 | erot = 0.706161996587761 | epot = -15.527419183632 | etot = -14.6424332452058 +936000 ekin = 0.168594479114955 | erot = 0.740699865837585 | epot = -15.55172759021 | etot = -14.6424332452575 +937000 ekin = 0.159163635634861 | erot = 0.774606336206385 | epot = -15.5762032171619 | etot = -14.6424332453207 +938000 ekin = 0.150596971914849 | erot = 0.806861786796458 | epot = -15.5998920041019 | etot = -14.6424332453906 +939000 ekin = 0.142948711632359 | erot = 0.836347883526831 | epot = -15.6217298406214 | etot = -14.6424332454622 +940000 ekin = 0.136274889171099 | erot = 0.861915676028948 | epot = -15.64062381073 | etot = -14.6424332455299 +941000 ekin = 0.130643703198872 | erot = 0.882459199120565 | epot = -15.6555361479082 | etot = -14.6424332455888 +942000 ekin = 0.126142088160694 | erot = 0.896989065172162 | epot = -15.6655643989671 | etot = -14.6424332456342 +943000 ekin = 0.122877886110172 | erot = 0.904700444358873 | epot = -15.6700115761318 | etot = -14.6424332456628 +944000 ekin = 0.120977407412063 | erot = 0.905030230236876 | epot = -15.6684408833212 | etot = -14.6424332456723 +945000 ekin = 0.120578563690669 | erot = 0.897699054745604 | epot = -15.6607108640983 | etot = -14.642433245662 +946000 ekin = 0.12182010359348 | erot = 0.882735070928404 | epot = -15.6469884201544 | etot = -14.6424332456325 +947000 ekin = 0.124827761129084 | erot = 0.86047793559626 | epot = -15.6277389423113 | etot = -14.642433245586 +948000 ekin = 0.129698334168674 | erot = 0.831563037037796 | epot = -15.6036946167321 | etot = -14.6424332455257 +949000 ekin = 0.13648285755817 | erot = 0.796887554722047 | epot = -15.5758036577362 | etot = -14.6424332454559 +950000 ekin = 0.14517013893121 | erot = 0.757561255988166 | epot = -15.545164640301 | etot = -14.6424332453816 +951000 ekin = 0.155672002995183 | erot = 0.71484591609363 | epot = -15.5129511643966 | etot = -14.6424332453078 +952000 ekin = 0.167811650836291 | erot = 0.670087833250127 | epot = -15.480332729326 | etot = -14.6424332452396 +953000 ekin = 0.181316579471303 | erot = 0.624648095211848 | epot = -15.4483979198644 | etot = -14.6424332451812 +954000 ekin = 0.195817500701208 | erot = 0.579835080695611 | epot = -15.4180858265331 | etot = -14.6424332451363 +955000 ekin = 0.21085460687672 | erot = 0.536843219768569 | epot = -15.3901310717525 | etot = -14.6424332451072 +956000 ekin = 0.225892299837344 | erot = 0.496701376791255 | epot = -15.3650269217236 | etot = -14.642433245095 +957000 ekin = 0.240343066498587 | erot = 0.460233438093626 | epot = -15.3430097496914 | etot = -14.6424332450992 +958000 ekin = 0.253600493839353 | erot = 0.428032849893872 | epot = -15.324066588851 | etot = -14.6424332451178 +959000 ekin = 0.265080433748287 | erot = 0.400452005458765 | epot = -15.3079656843544 | etot = -14.6424332451473 +960000 ekin = 0.274268068130606 | erot = 0.377606549449485 | epot = -15.2943078627635 | etot = -14.6424332451834 +961000 ekin = 0.280767178003658 | erot = 0.359393861249483 | epot = -15.2825942844742 | etot = -14.642433245221 +962000 ekin = 0.284346484063545 | erot = 0.345524198816493 | epot = -15.2723039281349 | etot = -14.6424332452549 +963000 ekin = 0.28497681608998 | erot = 0.33556223232907 | epot = -15.2629722936994 | etot = -14.6424332452804 +964000 ekin = 0.282852494248157 | erot = 0.328975986496775 | epot = -15.2542617260389 | etot = -14.642433245294 +965000 ekin = 0.278391086615737 | erot = 0.325189577598745 | epot = -15.2460139095084 | etot = -14.6424332452939 +966000 ekin = 0.272207924679743 | erot = 0.323635640150781 | epot = -15.2382768101107 | etot = -14.6424332452802 +967000 ekin = 0.265065367870864 | erot = 0.323803079987444 | epot = -15.2313016931133 | etot = -14.642433245255 +968000 ekin = 0.25780129371415 | erot = 0.325275872290811 | epot = -15.2255104112269 | etot = -14.6424332452219 +969000 ekin = 0.251245661474385 | erot = 0.327759142576306 | epot = -15.2214380492365 | etot = -14.6424332451859 +970000 ekin = 0.246137008993216 | erot = 0.331089781181249 | epot = -15.2196600353262 | etot = -14.6424332451517 +971000 ekin = 0.243051319616145 | erot = 0.33523032566537 | epot = -15.2207148904055 | etot = -14.642433245124 +972000 ekin = 0.242353409638764 | erot = 0.340246678804933 | epot = -15.2250333335501 | etot = -14.6424332451064 +973000 ekin = 0.244176338162503 | erot = 0.346272190710957 | epot = -15.2328817739746 | etot = -14.6424332451011 +974000 ekin = 0.248428661658007 | erot = 0.353462430362089 | epot = -15.2443243371296 | etot = -14.6424332451095 +975000 ekin = 0.254824314802991 | erot = 0.361946299430811 | epot = -15.2592038593653 | etot = -14.6424332451315 +976000 ekin = 0.262926848820441 | erot = 0.371779749930123 | epot = -15.277139843917 | etot = -14.6424332451665 +977000 ekin = 0.272199235330791 | erot = 0.382908123264411 | epot = -15.2975406038079 | etot = -14.6424332452127 +978000 ekin = 0.282052066851645 | erot = 0.395142048097818 | epot = -15.3196273602177 | etot = -14.6424332452682 +979000 ekin = 0.291885751913936 | erot = 0.408150081471835 | epot = -15.3424690787158 | etot = -14.6424332453301 +980000 ekin = 0.301125083789936 | erot = 0.421469125223117 | epot = -15.365027454408 | etot = -14.642433245395 +981000 ekin = 0.309246535917406 | erot = 0.434531423656849 | epot = -15.3862112050333 | etot = -14.642433245459 +982000 ekin = 0.315799497490907 | erot = 0.446704965617073 | epot = -15.4049377086261 | etot = -14.6424332455181 +983000 ekin = 0.320422573221183 | erot = 0.457342632744156 | epot = -15.4201984515336 | etot = -14.6424332455683 +984000 ekin = 0.322855465258642 | erot = 0.465834622599602 | epot = -15.431123333464 | etot = -14.6424332456058 +985000 ekin = 0.322946302475343 | erot = 0.471658590974231 | epot = -15.4370381390774 | etot = -14.6424332456279 +986000 ekin = 0.320653917805922 | erot = 0.474422556590712 | epot = -15.4375097200295 | etot = -14.6424332456328 +987000 ekin = 0.316044627362369 | erot = 0.473896755515841 | epot = -15.4323746284984 | etot = -14.6424332456202 +988000 ekin = 0.309283477268975 | erot = 0.470032116945433 | epot = -15.421748839805 | etot = -14.6424332455906 +989000 ekin = 0.300620522169441 | erot = 0.462964620622199 | epot = -15.4060183883375 | etot = -14.6424332455459 +990000 ekin = 0.290373280691476 | erot = 0.45300626299518 | epot = -15.3858127891754 | etot = -14.6424332454887 +991000 ekin = 0.278906915705959 | erot = 0.440624526219509 | epot = -15.3619646873478 | etot = -14.6424332454224 +992000 ekin = 0.266613826415441 | erot = 0.426413006891514 | epot = -15.3354600786573 | etot = -14.6424332453503 +993000 ekin = 0.253894212446822 | erot = 0.411056197524864 | epot = -15.3073836552479 | etot = -14.6424332452762 +994000 ekin = 0.241138837000364 | erot = 0.395291372388786 | epot = -15.2788634545923 | etot = -14.6424332452032 +995000 ekin = 0.228714768907212 | erot = 0.379870207855612 | epot = -15.2510182218971 | etot = -14.6424332451343 +996000 ekin = 0.2169544174706 | erot = 0.365522282707863 | epot = -15.2249099452504 | etot = -14.642433245072 +997000 ekin = 0.206147766456188 | erot = 0.352922066139109 | epot = -15.2015030776136 | etot = -14.6424332450183 +998000 ekin = 0.196537413157987 | erot = 0.342660495991805 | epot = -15.1816311541246 | etot = -14.6424332449748 +999000 ekin = 0.188315843913178 | erot = 0.335221830006205 | epot = -15.1659709188618 | etot = -14.6424332449424 +1000000 ekin = 0.181624323067817 | erot = 0.330966139649826 | epot = -15.1550237076397 | etot = -14.642433244922 + 1000000 0.013453654 -1.5270261 0.011523695 -1.4973399 -8.4815516e-05 +Loop time of 29.1595 on 4 procs for 1000000 steps with 10 atoms + +Performance: 29630.171 tau/day, 34294.179 timesteps/s +96.5% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.8549 | 9.7585 | 17.369 | 226.0 | 33.47 +Bond | 0.12382 | 0.38401 | 0.60938 | 32.9 | 1.32 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 2.9104 | 3.7862 | 4.6404 | 31.7 | 12.98 +Output | 2e-05 | 2.775e-05 | 3.1e-05 | 0.0 | 0.00 +Modify | 0.27411 | 1.1629 | 1.994 | 64.7 | 3.99 +Other | | 14.07 | | | 48.24 + +Nlocal: 2.5 ave 5 max 0 min +Histogram: 1 0 1 0 0 0 0 0 1 1 +Nghost: 7.5 ave 10 max 5 min +Histogram: 1 0 1 0 0 0 0 0 1 1 +Neighs: 17.5 ave 33 max 0 min +Histogram: 1 0 1 0 0 0 0 0 1 1 + +Total # of neighbors = 70 +Ave neighs/atom = 7 +Ave special neighs/atom = 3.6 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:29 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.1 b/examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.1 deleted file mode 100644 index abbd917f05..0000000000 --- a/examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.1 +++ /dev/null @@ -1,172 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 1 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex1 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 10 atoms - reading velocities ... - 10 velocities - 10 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 8 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 2 = max # of 1-4 neighbors - 4 = max # of special neighbors - -set atom * mass 3.1575 - 10 settings made for mass - -group all type 1 4 -10 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna/fene -bond_coeff * 2.0 0.25 0.7525 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk -pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 - -# NVE ensemble -fix 1 all nve/dot -#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 1.92828 - ghost atom cutoff = 1.92828 - binsize = 0.964142, bins = 42 42 42 - 5 neighbor lists, perpetual/occasional/extra = 5 0 0 - (1) pair oxdna/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 2.859 | 2.859 | 2.859 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.4711818 0.0069384985 -1.4642433 -6.2745089e-05 -1000 ekin = 0.00113448721737003 | erot = 0.00413455947734281 | epot = -14.6477022915193 | etot = -14.6424332448246 -2000 ekin = 0.00449927223902336 | erot = 0.0164446434455805 | epot = -14.6633771605337 | etot = -14.6424332448491 -3000 ekin = 0.00997964450841065 | erot = 0.0366523356056461 | epot = -14.6890652250033 | etot = -14.6424332448892 -4000 ekin = 0.0173888111295073 | erot = 0.0643039804300221 | epot = -14.7241260365031 | etot = -14.6424332449436 -5000 ekin = 0.0264744514136619 | erot = 0.0987844033142066 | epot = -14.7676920997383 | etot = -14.6424332450104 -6000 ekin = 0.0369277948556079 | erot = 0.139336571052565 | epot = -14.8186976109956 | etot = -14.6424332450875 -7000 ekin = 0.04839505571915 | erot = 0.18508629569208 | epot = -14.8759145965832 | etot = -14.642433245172 -8000 ekin = 0.0604909336920643 | erot = 0.23507130752353 | epot = -14.9379954864767 | etot = -14.6424332452611 -9000 ekin = 0.0728137406440561 | erot = 0.288273694501537 | epot = -15.003520680497 | etot = -14.6424332453514 -10000 ekin = 0.0849615563085879 | erot = 0.343654369293472 | epot = -15.0710491710418 | etot = -14.6424332454398 - 10000 0.0062934486 -1.5138305 0.0067255788 -1.4986088 -9.9021593e-05 -Loop time of 0.141929 on 1 procs for 10000 steps with 10 atoms - -Performance: 60875.649 tau/day, 70457.927 timesteps/s -99.9% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.11467 | 0.11467 | 0.11467 | 0.0 | 80.79 -Bond | 0.0050094 | 0.0050094 | 0.0050094 | 0.0 | 3.53 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0013616 | 0.0013616 | 0.0013616 | 0.0 | 0.96 -Output | 4.0531e-06 | 4.0531e-06 | 4.0531e-06 | 0.0 | 0.00 -Modify | 0.017901 | 0.017901 | 0.017901 | 0.0 | 12.61 -Other | | 0.002982 | | | 2.10 - -Nlocal: 10 ave 10 max 10 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 43 ave 43 max 43 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 43 -Ave neighs/atom = 4.3 -Ave special neighs/atom = 3.6 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.4 b/examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.4 deleted file mode 100644 index 78712bf913..0000000000 --- a/examples/USER/cgdna/examples/oxDNA/duplex1/log.27Nov18.duplex1.g++.4 +++ /dev/null @@ -1,172 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 1 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex1 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 10 atoms - reading velocities ... - 10 velocities - 10 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 8 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 2 = max # of 1-4 neighbors - 4 = max # of special neighbors - -set atom * mass 3.1575 - 10 settings made for mass - -group all type 1 4 -10 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna/fene -bond_coeff * 2.0 0.25 0.7525 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk -pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 - -# NVE ensemble -fix 1 all nve/dot -#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 1.92828 - ghost atom cutoff = 1.92828 - binsize = 0.964142, bins = 42 42 42 - 5 neighbor lists, perpetual/occasional/extra = 5 0 0 - (1) pair oxdna/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 7.341 | 7.523 | 7.705 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.4711818 0.0069384985 -1.4642433 -6.2745089e-05 -1000 ekin = 0.00113448721737009 | erot = 0.0041345594773427 | epot = -14.6477022915193 | etot = -14.6424332448246 -2000 ekin = 0.00449927223902292 | erot = 0.0164446434455803 | epot = -14.6633771605337 | etot = -14.6424332448491 -3000 ekin = 0.00997964450840756 | erot = 0.0366523356056465 | epot = -14.6890652250033 | etot = -14.6424332448892 -4000 ekin = 0.017388811129498 | erot = 0.0643039804300254 | epot = -14.7241260365031 | etot = -14.6424332449436 -5000 ekin = 0.0264744514136422 | erot = 0.098784403314214 | epot = -14.7676920997383 | etot = -14.6424332450104 -6000 ekin = 0.0369277948555727 | erot = 0.139336571052581 | epot = -14.8186976109956 | etot = -14.6424332450875 -7000 ekin = 0.0483950557190949 | erot = 0.185086295692111 | epot = -14.8759145965832 | etot = -14.642433245172 -8000 ekin = 0.0604909336919856 | erot = 0.235071307523583 | epot = -14.9379954864767 | etot = -14.6424332452611 -9000 ekin = 0.0728137406439517 | erot = 0.288273694501617 | epot = -15.003520680497 | etot = -14.6424332453514 -10000 ekin = 0.0849615563084573 | erot = 0.34365436929359 | epot = -15.0710491710418 | etot = -14.6424332454398 - 10000 0.0062934486 -1.5138305 0.0067255788 -1.4986088 -0.00010196899 -Loop time of 0.134536 on 4 procs for 10000 steps with 10 atoms - -Performance: 64220.659 tau/day, 74329.466 timesteps/s -97.3% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.0030077 | 0.052212 | 0.093066 | 17.4 | 38.81 -Bond | 0.00061846 | 0.00234 | 0.0039451 | 2.8 | 1.74 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.013431 | 0.014091 | 0.014596 | 0.4 | 10.47 -Output | 5.0783e-05 | 5.1141e-05 | 5.1498e-05 | 0.0 | 0.04 -Modify | 0.0011578 | 0.0059478 | 0.010331 | 4.8 | 4.42 -Other | | 0.05989 | | | 44.52 - -Nlocal: 2.5 ave 5 max 0 min -Histogram: 1 0 1 0 0 0 0 0 1 1 -Nghost: 7.5 ave 10 max 5 min -Histogram: 1 0 1 0 0 0 0 0 1 1 -Neighs: 17.5 ave 33 max 0 min -Histogram: 1 0 1 0 0 0 0 0 1 1 - -Total # of neighbors = 70 -Ave neighs/atom = 7 -Ave special neighs/atom = 3.6 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex2/data.duplex2 b/examples/USER/cgdna/examples/oxDNA/duplex2/data.duplex2 index 6547def910..72872d431a 100644 --- a/examples/USER/cgdna/examples/oxDNA/duplex2/data.duplex2 +++ b/examples/USER/cgdna/examples/oxDNA/duplex2/data.duplex2 @@ -38,7 +38,7 @@ Atoms 15 3 4.860249842674773e-01 3.518234140414733e-01 3.897628551303119e-01 2 1 1 16 4 5.999999999999995e-01 -3.330669073875470e-17 -3.330669073875470e-16 2 1 1 -# Atom-ID, translational, rotational velocity +# Atom-ID, translational velocity, angular momentum Velocities 1 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex2/in.duplex2 b/examples/USER/cgdna/examples/oxDNA/duplex2/in.duplex2 index a5a09af9f4..d80e7bbc0e 100644 --- a/examples/USER/cgdna/examples/oxDNA/duplex2/in.duplex2 +++ b/examples/USER/cgdna/examples/oxDNA/duplex2/in.duplex2 @@ -1,6 +1,7 @@ variable number equal 2 variable ofreq equal 1000 variable efreq equal 1000 +variable T equal 0.1 units lj @@ -30,7 +31,7 @@ bond_coeff * 2.0 0.25 0.7525 # oxDNA pair interactions pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/stk seqav ${T} 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 @@ -39,9 +40,9 @@ pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1 # NVE ensemble #fix 1 all nve/dot -fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 #fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 timestep 1e-5 @@ -72,6 +73,6 @@ fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${e #dump_modify out sort id #dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" -run 10000 +run 1000000 #write_restart config.${number}.* diff --git a/examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.1 b/examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.1 new file mode 100644 index 0000000000..29eaec2dab --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.1 @@ -0,0 +1,1167 @@ +LAMMPS (18 Jun 2019) +variable number equal 2 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex2 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 16 atoms + reading velocities ... + 16 velocities + 16 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 13 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 4 = max # of 1-4 neighbors + 6 = max # of special neighbors + special bonds CPU = 0.000135 secs + read_data CPU = 0.002118 secs + +set atom * mass 3.1575 + 16 settings made for mass + +group all type 1 4 +16 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna/fene +bond_coeff * 2.0 0.25 0.7525 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk +pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna/stk seqav ${T} 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/stk seqav 0.1 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 + +# NVE ensemble +#fix 1 all nve/dot +fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.92828 + ghost atom cutoff = 1.92828 + binsize = 0.964142, bins = 42 42 42 + 5 neighbor lists, perpetual/occasional/extra = 5 0 0 + (1) pair oxdna/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 2.861 | 2.861 | 2.861 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.5402493 0.0070469125 -1.5332024 6.0760034e-06 +1000 ekin = 1.54234964773389 | erot = 1.71563526070267 | epot = -24.5477045187653 | etot = -21.2897196103287 +2000 ekin = 1.85988866919215 | erot = 1.9424302796508 | epot = -24.4843044999595 | etot = -20.6819855511165 +3000 ekin = 2.68354339452998 | erot = 2.14216528317607 | epot = -24.4019350693561 | etot = -19.57622639165 +4000 ekin = 2.04461800191989 | erot = 1.49015219763161 | epot = -24.2959428773347 | etot = -20.7611726777832 +5000 ekin = 1.76794859210155 | erot = 2.54289684465819 | epot = -24.2337587736863 | etot = -19.9229133369266 +6000 ekin = 3.1106424806079 | erot = 2.04409805200893 | epot = -24.1585729744133 | etot = -19.0038324417964 +7000 ekin = 3.21360097519306 | erot = 2.71941303605722 | epot = -24.0566262531609 | etot = -18.1236122419107 +8000 ekin = 2.82489935901743 | erot = 2.66790555575695 | epot = -24.0194805097633 | etot = -18.526675594989 +9000 ekin = 2.69381302856378 | erot = 2.59107820129446 | epot = -23.9216126050554 | etot = -18.6367213751972 +10000 ekin = 2.65765007662471 | erot = 1.95562671446597 | epot = -23.7978334881241 | etot = -19.1845566970334 +11000 ekin = 2.33860420545645 | erot = 2.067780391377 | epot = -23.6589739475584 | etot = -19.2525893507249 +12000 ekin = 2.71377849618258 | erot = 2.08757199120023 | epot = -23.5483571834756 | etot = -18.7470066960928 +13000 ekin = 2.62930153930326 | erot = 2.36926332727578 | epot = -23.4509629615768 | etot = -18.4523980949977 +14000 ekin = 3.08200416316113 | erot = 2.52340746291244 | epot = -23.3378147651053 | etot = -17.7324031390317 +15000 ekin = 2.98008664779269 | erot = 1.871644860882 | epot = -23.1940665570191 | etot = -18.3423350483444 +16000 ekin = 2.18422481774796 | erot = 2.13029325858584 | epot = -23.0709946755646 | etot = -18.7564765992308 +17000 ekin = 1.86029951221073 | erot = 2.30856215831156 | epot = -22.9148241979648 | etot = -18.7459625274425 +18000 ekin = 2.26757205264074 | erot = 1.23282183419698 | epot = -22.7667657090377 | etot = -19.2663718222 +19000 ekin = 2.39717301992408 | erot = 2.43814713185077 | epot = -22.6249045514987 | etot = -17.7895843997239 +20000 ekin = 2.4972090427325 | erot = 2.14695469209109 | epot = -22.4687873897505 | etot = -17.824623654927 +21000 ekin = 2.97591775854817 | erot = 2.40996811711195 | epot = -22.580475447988 | etot = -17.1945895723278 +22000 ekin = 3.04727168578733 | erot = 1.83825256427932 | epot = -22.6695853833015 | etot = -17.7840611332348 +23000 ekin = 2.64835731773193 | erot = 2.22162785501705 | epot = -22.6565689169972 | etot = -17.7865837442483 +24000 ekin = 2.64866576787001 | erot = 2.80157082833922 | epot = -22.6222797420052 | etot = -17.172043145796 +25000 ekin = 2.29527970143855 | erot = 2.22049811939069 | epot = -22.6228421013006 | etot = -18.1070642804714 +26000 ekin = 1.6242512251805 | erot = 2.52390475262917 | epot = -22.6746055892862 | etot = -18.5264496114765 +27000 ekin = 1.74746467550781 | erot = 3.7138606202505 | epot = -22.7150312690973 | etot = -17.253705973339 +28000 ekin = 2.26500128280479 | erot = 2.34791343563183 | epot = -22.7926648585827 | etot = -18.179750140146 +29000 ekin = 2.04774074424512 | erot = 1.86347261547111 | epot = -22.8081204933408 | etot = -18.8969071336246 +30000 ekin = 2.41140146125466 | erot = 1.86296915421469 | epot = -22.7764612164305 | etot = -18.5020906009612 +31000 ekin = 2.76447800297261 | erot = 2.7393253404681 | epot = -22.7808698156252 | etot = -17.2770664721845 +32000 ekin = 2.08103539953574 | erot = 2.81216171106146 | epot = -22.8081908465747 | etot = -17.9149937359775 +33000 ekin = 2.08672340074227 | erot = 3.65510023442519 | epot = -22.7575363468642 | etot = -17.0157127116967 +34000 ekin = 2.34180742039869 | erot = 3.10027175201874 | epot = -22.6657421559553 | etot = -17.2236629835378 +35000 ekin = 2.32430602395272 | erot = 2.01607522370048 | epot = -22.5813705492547 | etot = -18.2409893016015 +36000 ekin = 1.91917507775106 | erot = 1.97289747304336 | epot = -22.481118994336 | etot = -18.5890464435416 +37000 ekin = 1.57560528527468 | erot = 2.63029511887642 | epot = -22.4456699464305 | etot = -18.2397695422794 +38000 ekin = 2.20652731867584 | erot = 2.89671984141264 | epot = -22.3965902387972 | etot = -17.2933430787087 +39000 ekin = 2.54765822667968 | erot = 2.47352619735437 | epot = -22.3525131983352 | etot = -17.3313287743012 +40000 ekin = 2.24172560748699 | erot = 1.87314319107769 | epot = -22.3791956830638 | etot = -18.2643268844991 +41000 ekin = 2.45176361826215 | erot = 2.49992612251747 | epot = -22.4441192111887 | etot = -17.492429470409 +42000 ekin = 2.68254780786499 | erot = 2.04382131696989 | epot = -22.4352265851614 | etot = -17.7088574603266 +43000 ekin = 2.39383336858508 | erot = 1.66587291396325 | epot = -22.4337243898148 | etot = -18.3740181072664 +44000 ekin = 2.30758870966958 | erot = 2.39381816537748 | epot = -22.4636201484766 | etot = -17.7622132734295 +45000 ekin = 1.84308929771583 | erot = 2.25880380151546 | epot = -22.5697712917435 | etot = -18.4678781925122 +46000 ekin = 1.98608215049724 | erot = 3.02136983211363 | epot = -22.5606085774834 | etot = -17.5531565948725 +47000 ekin = 1.31457586857024 | erot = 1.99780932836913 | epot = -22.5522289127255 | etot = -19.2398437157862 +48000 ekin = 2.59855199680394 | erot = 1.90772345027383 | epot = -22.5972680906756 | etot = -18.0909926435978 +49000 ekin = 2.32140483916261 | erot = 2.72932938830521 | epot = -22.6070371995253 | etot = -17.5563029720575 +50000 ekin = 2.48248035385828 | erot = 3.42713570109107 | epot = -22.5294064222472 | etot = -16.6197903672979 +51000 ekin = 2.73677705777971 | erot = 1.43285265191038 | epot = -22.4272695862992 | etot = -18.2576398766091 +52000 ekin = 3.03746109762767 | erot = 1.97878223690383 | epot = -22.4105817052324 | etot = -17.3943383707009 +53000 ekin = 2.4689045601064 | erot = 4.26434186327668 | epot = -22.4059567857723 | etot = -15.6727103623892 +54000 ekin = 2.48025904071626 | erot = 2.36957879662632 | epot = -22.4049729842648 | etot = -17.5551351469222 +55000 ekin = 2.28269445417385 | erot = 1.92149293107792 | epot = -22.4643082993723 | etot = -18.2601209141205 +56000 ekin = 2.36225428889468 | erot = 2.21818002425493 | epot = -22.5516502452859 | etot = -17.9712159321363 +57000 ekin = 2.5222034650231 | erot = 2.87044520913643 | epot = -22.6517599833465 | etot = -17.259111309187 +58000 ekin = 2.50677816066749 | erot = 2.80087142998998 | epot = -22.7046490897181 | etot = -17.3969994990606 +59000 ekin = 2.7442153349817 | erot = 2.17375311266844 | epot = -22.7630968852437 | etot = -17.8451284375935 +60000 ekin = 3.28881699963202 | erot = 1.98491245229834 | epot = -22.7493813857704 | etot = -17.47565193384 +61000 ekin = 2.42749732003947 | erot = 1.80500042748845 | epot = -22.6954080097403 | etot = -18.4629102622124 +62000 ekin = 2.82051548232979 | erot = 1.69220614985812 | epot = -22.5840860651657 | etot = -18.0713644329778 +63000 ekin = 3.66818847100113 | erot = 1.91510536540651 | epot = -22.4235299160084 | etot = -16.8402360796008 +64000 ekin = 3.60192162647095 | erot = 3.02302140162941 | epot = -22.4028966408394 | etot = -15.777953612739 +65000 ekin = 3.37797300912952 | erot = 3.90646944425564 | epot = -22.3508227873685 | etot = -15.0663803339833 +66000 ekin = 2.90796062513305 | erot = 2.46538835419998 | epot = -22.2656130116827 | etot = -16.8922640323497 +67000 ekin = 2.57641483706472 | erot = 2.1063925708314 | epot = -22.1586423836372 | etot = -17.4758349757411 +68000 ekin = 2.5516902727465 | erot = 2.46870040285813 | epot = -22.1454741588102 | etot = -17.1250834832056 +69000 ekin = 2.42897294997603 | erot = 2.86774435615082 | epot = -22.1788582092806 | etot = -16.8821409031537 +70000 ekin = 3.08406596014674 | erot = 2.51171720098584 | epot = -22.2680651617951 | etot = -16.6722820006626 +71000 ekin = 2.55052721315253 | erot = 2.49486492124423 | epot = -22.3940848075589 | etot = -17.3486926731621 +72000 ekin = 1.77666138705941 | erot = 2.52301579845699 | epot = -22.4956655989824 | etot = -18.195988413466 +73000 ekin = 1.86857924146303 | erot = 2.33110810852355 | epot = -22.5401005215029 | etot = -18.3404131715163 +74000 ekin = 3.14875320805144 | erot = 2.12002807961601 | epot = -22.5354282257998 | etot = -17.2666469381323 +75000 ekin = 2.60566180511119 | erot = 2.16421143606062 | epot = -22.5109742574449 | etot = -17.7411010162731 +76000 ekin = 1.94500512300058 | erot = 1.94681992806367 | epot = -22.5134561384461 | etot = -18.6216310873819 +77000 ekin = 2.09005510206219 | erot = 2.13354294429721 | epot = -22.5157248384152 | etot = -18.2921267920558 +78000 ekin = 2.48381695181472 | erot = 2.49598603867482 | epot = -22.449809286019 | etot = -17.4700062955295 +79000 ekin = 3.09582217320064 | erot = 2.46630074007712 | epot = -22.3464652405845 | etot = -16.7843423273068 +80000 ekin = 2.51380629427529 | erot = 1.89207626467031 | epot = -22.2775752521275 | etot = -17.8716926931819 +81000 ekin = 2.32322780911516 | erot = 2.24954513249787 | epot = -22.2655235360186 | etot = -17.6927505944055 +82000 ekin = 1.54779729878415 | erot = 2.01487148845307 | epot = -22.2126473128098 | etot = -18.6499785255726 +83000 ekin = 2.24267653112482 | erot = 3.34721522119025 | epot = -22.2063282117648 | etot = -16.6164364594498 +84000 ekin = 2.86948852339533 | erot = 2.11915315181827 | epot = -22.2055386975617 | etot = -17.2168970223481 +85000 ekin = 3.13802387827786 | erot = 2.93900498543376 | epot = -22.2240733080824 | etot = -16.1470444443708 +86000 ekin = 3.46160079449538 | erot = 2.80798287444336 | epot = -22.2732645073155 | etot = -16.0036808383767 +87000 ekin = 3.63139446909085 | erot = 2.3166794204513 | epot = -22.2567856660101 | etot = -16.308711776468 +88000 ekin = 3.15348314879937 | erot = 2.2785763709033 | epot = -22.2154422326699 | etot = -16.7833827129672 +89000 ekin = 3.30271147105659 | erot = 1.80791256125564 | epot = -22.1564153597823 | etot = -17.04579132747 +90000 ekin = 2.42655906518194 | erot = 2.24507038389518 | epot = -21.9481188512569 | etot = -17.2764894021798 +91000 ekin = 1.89051217909395 | erot = 2.51049066719493 | epot = -21.7877769537306 | etot = -17.3867741074417 +92000 ekin = 2.07833668466679 | erot = 2.218324246302 | epot = -21.6997103074282 | etot = -17.4030493764594 +93000 ekin = 1.94321435585196 | erot = 2.99473985773914 | epot = -21.6748650469777 | etot = -16.7369108333866 +94000 ekin = 2.07878576812463 | erot = 3.37631892101902 | epot = -21.7659932416399 | etot = -16.3108885524963 +95000 ekin = 2.10517721407769 | erot = 2.08345895044788 | epot = -21.8951718799354 | etot = -17.7065357154098 +96000 ekin = 2.68821593238919 | erot = 1.86988637992409 | epot = -21.9622848400866 | etot = -17.4041825277733 +97000 ekin = 1.95061152706206 | erot = 2.81054215683073 | epot = -22.0229813258884 | etot = -17.2618276419957 +98000 ekin = 1.98463063611221 | erot = 2.05732763357977 | epot = -22.0930102039112 | etot = -18.0510519342192 +99000 ekin = 2.51292852217217 | erot = 3.54194472638845 | epot = -22.199088757298 | etot = -16.1442155087374 +100000 ekin = 1.8757570387949 | erot = 2.3690785580876 | epot = -22.348409587438 | etot = -18.1035739905555 +101000 ekin = 1.66160772204006 | erot = 3.59766032223856 | epot = -22.3604908173889 | etot = -17.1012227731103 +102000 ekin = 1.62075182718474 | erot = 3.3442006848817 | epot = -22.3063629504087 | etot = -17.3414104383422 +103000 ekin = 2.00871148652538 | erot = 2.33677124900284 | epot = -22.275557852692 | etot = -17.9300751171637 +104000 ekin = 2.04513709976292 | erot = 2.74664593650967 | epot = -22.2818713634637 | etot = -17.4900883271911 +105000 ekin = 1.87027868596139 | erot = 1.98922389218239 | epot = -22.223503909299 | etot = -18.3640013311552 +106000 ekin = 1.71540784443942 | erot = 1.9177953110688 | epot = -22.2562839843324 | etot = -18.6230808288242 +107000 ekin = 2.61024905591622 | erot = 1.57446439985464 | epot = -22.3171357124015 | etot = -18.1324222566306 +108000 ekin = 2.13751756724178 | erot = 2.18822458113098 | epot = -22.2268794585969 | etot = -17.9011373102241 +109000 ekin = 2.24408198608307 | erot = 2.11438299352724 | epot = -22.076564108576 | etot = -17.7180991289657 +110000 ekin = 1.66706562020821 | erot = 2.50986066169373 | epot = -22.0833343008135 | etot = -17.9064080189116 +111000 ekin = 2.30463895640872 | erot = 2.24982560856989 | epot = -22.0940837732696 | etot = -17.539619208291 +112000 ekin = 2.63019524472749 | erot = 2.43696110420532 | epot = -22.0953344558745 | etot = -17.0281781069417 +113000 ekin = 2.42282638113981 | erot = 3.06190927482913 | epot = -22.1061661458173 | etot = -16.6214304898484 +114000 ekin = 2.34214572325658 | erot = 2.31899235523686 | epot = -22.0941430549288 | etot = -17.4330049764353 +115000 ekin = 1.70336449422736 | erot = 3.10166879044198 | epot = -22.1252095896431 | etot = -17.3201763049738 +116000 ekin = 1.51705870113214 | erot = 2.21425252709695 | epot = -22.1823772627204 | etot = -18.4510660344913 +117000 ekin = 1.70129809180508 | erot = 2.34142425076372 | epot = -22.2067668262467 | etot = -18.1640444836779 +118000 ekin = 2.20482827236051 | erot = 2.3179714809504 | epot = -22.1855414590757 | etot = -17.6627417057647 +119000 ekin = 2.54272629601484 | erot = 2.46528921750297 | epot = -22.2113175246519 | etot = -17.2033020111341 +120000 ekin = 1.76640390552554 | erot = 2.16116304616032 | epot = -22.1536331723646 | etot = -18.2260662206787 +121000 ekin = 2.81281157959688 | erot = 2.31761005518346 | epot = -22.1492969323239 | etot = -17.0188752975435 +122000 ekin = 3.25156823587966 | erot = 3.31679050874322 | epot = -22.2050361016166 | etot = -15.6366773569938 +123000 ekin = 2.87462309654081 | erot = 3.25604816714397 | epot = -22.1785374359393 | etot = -16.0478661722546 +124000 ekin = 2.18213410260632 | erot = 2.77182209342785 | epot = -22.0161464482698 | etot = -17.0621902522356 +125000 ekin = 1.85317252616068 | erot = 1.36623599567638 | epot = -21.8721650279344 | etot = -18.6527565060973 +126000 ekin = 2.47747071965844 | erot = 3.09909384826334 | epot = -21.8840309142636 | etot = -16.3074663463419 +127000 ekin = 2.42177426273027 | erot = 2.35209644429656 | epot = -21.8861939604609 | etot = -17.1123232534341 +128000 ekin = 2.76000040231245 | erot = 1.8231678837239 | epot = -21.8538456680958 | etot = -17.2706773820595 +129000 ekin = 2.78355536315491 | erot = 2.88851981621501 | epot = -21.9251039267855 | etot = -16.2530287474156 +130000 ekin = 3.26834278926799 | erot = 2.56228354573336 | epot = -22.0546105678549 | etot = -16.2239842328536 +131000 ekin = 2.64714688907849 | erot = 2.51107513446137 | epot = -22.0961160192681 | etot = -16.9378939957282 +132000 ekin = 2.61847248883524 | erot = 3.38899164334156 | epot = -22.1218916777659 | etot = -16.1144275455891 +133000 ekin = 2.03408861514006 | erot = 2.87401070790187 | epot = -22.0785989417621 | etot = -17.1704996187202 +134000 ekin = 1.64140897264888 | erot = 1.66986416585675 | epot = -22.0323643102285 | etot = -18.7210911717228 +135000 ekin = 2.46650096367446 | erot = 2.111120611107 | epot = -21.9976572593399 | etot = -17.4200356845585 +136000 ekin = 2.32880805911731 | erot = 3.05940125193231 | epot = -21.8983392007847 | etot = -16.5101298897351 +137000 ekin = 2.7601019905106 | erot = 2.47443779429795 | epot = -21.752125264204 | etot = -16.5175854793954 +138000 ekin = 3.30162084678948 | erot = 1.73084735415554 | epot = -21.7423849642075 | etot = -16.7099167632625 +139000 ekin = 2.76669064053124 | erot = 1.72642745910431 | epot = -21.8898577306654 | etot = -17.3967396310298 +140000 ekin = 2.73595287215366 | erot = 2.46891829250481 | epot = -21.9884857831833 | etot = -16.7836146185249 +141000 ekin = 2.79316289615844 | erot = 2.46753088695597 | epot = -22.0064855648443 | etot = -16.7457917817299 +142000 ekin = 3.51694745558129 | erot = 3.49862438784827 | epot = -21.9623193335451 | etot = -14.9467474901156 +143000 ekin = 2.58689934548697 | erot = 2.04008576044027 | epot = -21.9563338194557 | etot = -17.3293487135285 +144000 ekin = 3.72611917000993 | erot = 3.04855733322793 | epot = -21.9536376487796 | etot = -15.1789611455417 +145000 ekin = 3.61191106831147 | erot = 2.71915407989904 | epot = -21.870542665333 | etot = -15.5394775171225 +146000 ekin = 3.85060594912677 | erot = 2.47210219931339 | epot = -21.8285858153921 | etot = -15.505877666952 +147000 ekin = 3.26481933196161 | erot = 2.06864347299802 | epot = -21.6752809049183 | etot = -16.3418180999587 +148000 ekin = 2.47977997895053 | erot = 1.65169267241014 | epot = -21.4172781734276 | etot = -17.2858055220669 +149000 ekin = 2.70771685463074 | erot = 2.28028425953227 | epot = -21.2324293178539 | etot = -16.2444282036909 +150000 ekin = 2.60726181496431 | erot = 2.88955230103659 | epot = -21.126549406853 | etot = -15.6297352908521 +151000 ekin = 2.06865005733849 | erot = 2.13537039813292 | epot = -21.0304193709383 | etot = -16.8263989154669 +152000 ekin = 2.41210154812787 | erot = 2.60104053370075 | epot = -20.8967777045302 | etot = -15.8836356227016 +153000 ekin = 2.12406231442824 | erot = 2.25444655142795 | epot = -20.9199278716094 | etot = -16.5414190057532 +154000 ekin = 2.34622678455546 | erot = 2.58439374093403 | epot = -21.0040588663533 | etot = -16.0734383408638 +155000 ekin = 2.08240965570452 | erot = 3.02621505767145 | epot = -21.0204738431416 | etot = -15.9118491297656 +156000 ekin = 2.04576145796301 | erot = 3.17151405834467 | epot = -20.8558463949479 | etot = -15.6385708786402 +157000 ekin = 2.36459548410747 | erot = 1.89207417055424 | epot = -20.8025485082277 | etot = -16.545878853566 +158000 ekin = 2.16996178916575 | erot = 2.46547727482113 | epot = -20.8673070433024 | etot = -16.2318679793155 +159000 ekin = 2.86272730849306 | erot = 2.27590841865057 | epot = -20.9710387207245 | etot = -15.8324029935809 +160000 ekin = 2.19288173853782 | erot = 2.36312829884111 | epot = -21.0403123366075 | etot = -16.4843022992286 +161000 ekin = 2.14059248149909 | erot = 2.4287283799048 | epot = -21.1333683100403 | etot = -16.5640474486365 +162000 ekin = 1.76077466564934 | erot = 2.66561836368342 | epot = -21.1782130850259 | etot = -16.7518200556931 +163000 ekin = 2.23068698955417 | erot = 2.02664945757243 | epot = -21.3281780197228 | etot = -17.0708415725963 +164000 ekin = 2.75358320318999 | erot = 1.43717365990088 | epot = -21.4675480212853 | etot = -17.2767911581945 +165000 ekin = 2.65171600986478 | erot = 2.29632253260765 | epot = -21.493178025826 | etot = -16.5451394833536 +166000 ekin = 3.27298673277591 | erot = 2.41252396730596 | epot = -21.4477711984927 | etot = -15.7622604984108 +167000 ekin = 3.02574105268454 | erot = 2.02770436019795 | epot = -21.5236773217566 | etot = -16.4702319088741 +168000 ekin = 3.14659813654158 | erot = 1.8374607941321 | epot = -21.5547269116736 | etot = -16.5706679809999 +169000 ekin = 2.22493755697302 | erot = 2.67175500860652 | epot = -21.4662206077311 | etot = -16.5695280421515 +170000 ekin = 2.41921977325643 | erot = 2.49142716001801 | epot = -21.3123035293873 | etot = -16.4016565961128 +171000 ekin = 1.89798915040775 | erot = 2.39492100285877 | epot = -21.2153991969519 | etot = -16.9224890436853 +172000 ekin = 2.86894215563086 | erot = 3.22914449693158 | epot = -21.1827352206441 | etot = -15.0846485680816 +173000 ekin = 2.74888252418688 | erot = 2.13556434483052 | epot = -21.2166792789418 | etot = -16.3322324099244 +174000 ekin = 2.45887587066864 | erot = 2.23682521338056 | epot = -21.2633056658561 | etot = -16.5676045818069 +175000 ekin = 2.84703517745999 | erot = 2.39381254916381 | epot = -21.2430876358358 | etot = -16.002239909212 +176000 ekin = 2.14025231000119 | erot = 1.89894722702466 | epot = -21.3238321496633 | etot = -17.2846326126375 +177000 ekin = 2.5795061901144 | erot = 2.75365074391219 | epot = -21.3022195274207 | etot = -15.9690625933941 +178000 ekin = 1.83122028490793 | erot = 2.59468068841507 | epot = -21.2483113201278 | etot = -16.8224103468048 +179000 ekin = 2.50706581632049 | erot = 2.3918046623687 | epot = -21.3152464598324 | etot = -16.4163759811432 +180000 ekin = 1.88211034410738 | erot = 2.47063835849692 | epot = -21.4741119346399 | etot = -17.1213632320356 +181000 ekin = 1.74209654097779 | erot = 3.05723824722444 | epot = -21.4808621715442 | etot = -16.681527383342 +182000 ekin = 1.55789914013104 | erot = 2.05767448814763 | epot = -21.423526482018 | etot = -17.8079528537394 +183000 ekin = 2.00937540548925 | erot = 2.80898978674436 | epot = -21.491360735728 | etot = -16.6729955434944 +184000 ekin = 2.69285960778353 | erot = 2.42969439668747 | epot = -21.6024209898208 | etot = -16.4798669853498 +185000 ekin = 3.01326925127938 | erot = 3.19083239326424 | epot = -21.6730258967931 | etot = -15.4689242522495 +186000 ekin = 3.2083067153638 | erot = 2.42899016869201 | epot = -21.7143665695974 | etot = -16.0770696855416 +187000 ekin = 2.672906100919 | erot = 3.41560404715603 | epot = -21.6726605039613 | etot = -15.5841503558862 +188000 ekin = 2.89349337388582 | erot = 3.06258669113775 | epot = -21.6216664732832 | etot = -15.6655864082597 +189000 ekin = 2.65435973176118 | erot = 1.82043381700644 | epot = -21.5604872976485 | etot = -17.0856937488809 +190000 ekin = 2.21855159698309 | erot = 1.84826944038784 | epot = -21.5263477340278 | etot = -17.4595266966569 +191000 ekin = 2.26980616064111 | erot = 2.05944589507645 | epot = -21.4543005141097 | etot = -17.1250484583921 +192000 ekin = 2.27219103053707 | erot = 3.11210788791052 | epot = -21.4899273087562 | etot = -16.1056283903086 +193000 ekin = 1.95008147026928 | erot = 1.89648921534019 | epot = -21.4843079374128 | etot = -17.6377372518033 +194000 ekin = 2.45477671526091 | erot = 2.0272304242676 | epot = -21.3709228769337 | etot = -16.8889157374052 +195000 ekin = 3.09567411006595 | erot = 2.10081767143638 | epot = -21.3012041149762 | etot = -16.1047123334739 +196000 ekin = 2.67423122149492 | erot = 2.50738189755519 | epot = -21.2164124023053 | etot = -16.0347992832552 +197000 ekin = 2.50338730962556 | erot = 2.07349764616723 | epot = -21.041867486922 | etot = -16.4649825311292 +198000 ekin = 2.66945928982616 | erot = 1.79012921820209 | epot = -21.0169215356766 | etot = -16.5573330276483 +199000 ekin = 2.53947964790256 | erot = 2.33176467953655 | epot = -21.0171165577067 | etot = -16.1458722302676 +200000 ekin = 2.90451062704866 | erot = 1.42170066957004 | epot = -21.0113804229743 | etot = -16.6851691263556 +201000 ekin = 2.68927776239674 | erot = 1.56650335894554 | epot = -21.0245916399581 | etot = -16.7688105186158 +202000 ekin = 2.2601329351618 | erot = 2.25401443373177 | epot = -20.9769308007641 | etot = -16.4627834318706 +203000 ekin = 2.12073487355488 | erot = 2.03553028991747 | epot = -20.919035946492 | etot = -16.7627707830197 +204000 ekin = 2.11829086582788 | erot = 1.89731962488617 | epot = -20.9376264283538 | etot = -16.9220159376397 +205000 ekin = 1.30964171332167 | erot = 2.12770406224885 | epot = -20.9991335630718 | etot = -17.5617877875013 +206000 ekin = 1.39940057572522 | erot = 2.24496791209126 | epot = -20.963919219062 | etot = -17.3195507312455 +207000 ekin = 1.8871608804017 | erot = 1.79849326266382 | epot = -21.0552898160204 | etot = -17.3696356729549 +208000 ekin = 1.81558541079753 | erot = 3.24210836817276 | epot = -21.3060144768834 | etot = -16.2483206979131 +209000 ekin = 2.79588064252181 | erot = 2.3467149173832 | epot = -21.4301997554495 | etot = -16.2876041955445 +210000 ekin = 3.17544887511567 | erot = 3.12704516116654 | epot = -21.5100449360932 | etot = -15.2075508998109 +211000 ekin = 2.47442327377226 | erot = 2.0990867711376 | epot = -21.6455723047062 | etot = -17.0720622597963 +212000 ekin = 2.36672302145397 | erot = 1.93445871446419 | epot = -21.7283038297487 | etot = -17.4271220938306 +213000 ekin = 1.91045426241161 | erot = 2.52535628540462 | epot = -21.8158508544504 | etot = -17.3800403066341 +214000 ekin = 1.99794025866061 | erot = 2.49896939492127 | epot = -21.8606548137084 | etot = -17.3637451601266 +215000 ekin = 1.97741561009525 | erot = 3.17667494473254 | epot = -21.8701701582032 | etot = -16.7160796033754 +216000 ekin = 1.88829990821377 | erot = 1.87402623825167 | epot = -21.8343889393413 | etot = -18.0720627928759 +217000 ekin = 2.10000293878932 | erot = 1.95052404495887 | epot = -21.8965404786646 | etot = -17.8460134949164 +218000 ekin = 2.34753598782339 | erot = 1.69695019504401 | epot = -21.8560027679962 | etot = -17.8115165851288 +219000 ekin = 2.497223564463 | erot = 2.20999914485705 | epot = -21.8797649478059 | etot = -17.1725422384859 +220000 ekin = 1.75274593087921 | erot = 3.03992746556406 | epot = -21.8491595252171 | etot = -17.0564861287739 +221000 ekin = 1.78874686645809 | erot = 2.79359542964647 | epot = -21.869798634642 | etot = -17.2874563385375 +222000 ekin = 2.63608430516661 | erot = 2.86817933637385 | epot = -21.8351218383832 | etot = -16.3308581968427 +223000 ekin = 3.02706758581511 | erot = 1.93888641555348 | epot = -21.8582453001765 | etot = -16.8922912988079 +224000 ekin = 2.71704451339112 | erot = 2.42079327531441 | epot = -21.8188420875657 | etot = -16.6810042988601 +225000 ekin = 2.04245190508395 | erot = 3.38216222891907 | epot = -21.8232190868647 | etot = -16.3986049528616 +226000 ekin = 2.37968015829255 | erot = 2.38384696857065 | epot = -21.8913549487127 | etot = -17.1278278218495 +227000 ekin = 2.73883397024414 | erot = 2.62491632372019 | epot = -21.9496900700867 | etot = -16.5859397761223 +228000 ekin = 2.06833362780412 | erot = 2.25049628751225 | epot = -21.9946760345141 | etot = -17.6758461191977 +229000 ekin = 1.78618617304217 | erot = 1.80509591500329 | epot = -22.0671964085329 | etot = -18.4759143204874 +230000 ekin = 2.76967283780387 | erot = 2.22492545317995 | epot = -22.0913590121729 | etot = -17.0967607211891 +231000 ekin = 3.15653922952316 | erot = 2.77099247609325 | epot = -22.0635255129442 | etot = -16.1359938073278 +232000 ekin = 1.86633326635991 | erot = 1.70672288688982 | epot = -22.0959715052869 | etot = -18.5229153520371 +233000 ekin = 1.75856846080021 | erot = 1.55694263125625 | epot = -22.0729289884755 | etot = -18.7574178964191 +234000 ekin = 2.32322575892498 | erot = 2.05793864740336 | epot = -21.9849429433607 | etot = -17.6037785370324 +235000 ekin = 1.95327191686568 | erot = 2.52519338885861 | epot = -21.9357201856672 | etot = -17.4572548799429 +236000 ekin = 2.25952484966859 | erot = 1.90005304846995 | epot = -21.9422471368741 | etot = -17.7826692387355 +237000 ekin = 2.49082301609303 | erot = 2.65327564887437 | epot = -22.0049130762794 | etot = -16.860814411312 +238000 ekin = 2.21076048871751 | erot = 2.74154862479023 | epot = -22.0553236426831 | etot = -17.1030145291754 +239000 ekin = 2.71464884454142 | erot = 2.48739530580561 | epot = -22.0661894571024 | etot = -16.8641453067554 +240000 ekin = 3.08961933821573 | erot = 2.17857064931927 | epot = -21.9596599475175 | etot = -16.6914699599825 +241000 ekin = 3.04172562407922 | erot = 2.64442433974962 | epot = -21.872950064824 | etot = -16.1868001009951 +242000 ekin = 2.21355627539455 | erot = 2.33429157450905 | epot = -21.7850463200938 | etot = -17.2371984701902 +243000 ekin = 1.52065138183895 | erot = 2.81375224845254 | epot = -21.724672004357 | etot = -17.3902683740655 +244000 ekin = 1.90352576583831 | erot = 2.43821138840079 | epot = -21.6320468184555 | etot = -17.2903096642164 +245000 ekin = 1.96342069667742 | erot = 2.61760141174562 | epot = -21.509789944958 | etot = -16.928767836535 +246000 ekin = 2.05478829283868 | erot = 2.42643933263093 | epot = -21.4781109635143 | etot = -16.9968833380447 +247000 ekin = 1.54618395739204 | erot = 2.28537401295509 | epot = -21.4411828355572 | etot = -17.6096248652101 +248000 ekin = 1.83924983769609 | erot = 2.55904554412921 | epot = -21.4587985205918 | etot = -17.0605031387665 +249000 ekin = 1.78703007063825 | erot = 2.03411349475431 | epot = -21.516607560139 | etot = -17.6954639947464 +250000 ekin = 1.69317901626952 | erot = 3.382620023581 | epot = -21.5380480709889 | etot = -16.4622490311384 +251000 ekin = 2.13799462687096 | erot = 3.25868442484789 | epot = -21.5254595658408 | etot = -16.1287805141219 +252000 ekin = 2.04357045453396 | erot = 2.53079336098227 | epot = -21.5456931883614 | etot = -16.9713293728452 +253000 ekin = 1.63287738205387 | erot = 3.20992823373492 | epot = -21.5622010587548 | etot = -16.719395442966 +254000 ekin = 2.31269246359595 | erot = 3.10766702207071 | epot = -21.5505863172024 | etot = -16.1302268315358 +255000 ekin = 2.50767926641465 | erot = 2.76631276495167 | epot = -21.5288449153183 | etot = -16.254852883952 +256000 ekin = 1.97163698305487 | erot = 2.61682132599931 | epot = -21.5273539828767 | etot = -16.9388956738225 +257000 ekin = 2.21091422886157 | erot = 3.2624387389365 | epot = -21.5385504601779 | etot = -16.0651974923798 +258000 ekin = 2.0351730783025 | erot = 1.84693461512361 | epot = -21.6544556001779 | etot = -17.7723479067518 +259000 ekin = 2.85718947138204 | erot = 2.78701165242275 | epot = -21.7587237542941 | etot = -16.1145226304893 +260000 ekin = 2.90387286634678 | erot = 2.18817434737477 | epot = -21.8080383126913 | etot = -16.7159910989698 +261000 ekin = 2.76190440948559 | erot = 2.33968169215532 | epot = -21.8592909726424 | etot = -16.7577048710015 +262000 ekin = 3.50919242681178 | erot = 1.76925994550144 | epot = -21.8779228441577 | etot = -16.5994704718445 +263000 ekin = 3.07696270254058 | erot = 2.41477320555763 | epot = -21.8078566004281 | etot = -16.3161206923299 +264000 ekin = 2.26633389925754 | erot = 2.04161743361595 | epot = -21.8372928128571 | etot = -17.5293414799836 +265000 ekin = 1.95747124461577 | erot = 2.5081300879884 | epot = -21.8490876266416 | etot = -17.3834862940375 +266000 ekin = 2.34517905801099 | erot = 3.31486209922478 | epot = -21.8287737874741 | etot = -16.1687326302383 +267000 ekin = 1.74030193361906 | erot = 2.23366459528059 | epot = -21.699850097441 | etot = -17.7258835685413 +268000 ekin = 2.04858677018814 | erot = 3.28744422098426 | epot = -21.6459408923623 | etot = -16.3099099011899 +269000 ekin = 1.93146929709294 | erot = 2.79280735598121 | epot = -21.549773802712 | etot = -16.8254971496378 +270000 ekin = 2.19788894271016 | erot = 2.64563279687103 | epot = -21.4165389672397 | etot = -16.5730172276585 +271000 ekin = 2.21923220579694 | erot = 3.10768708967444 | epot = -21.2197121954353 | etot = -15.8927928999639 +272000 ekin = 2.54992061853163 | erot = 2.29721880581853 | epot = -21.0816515756819 | etot = -16.2345121513317 +273000 ekin = 1.914618407838 | erot = 2.01420401968473 | epot = -21.0503637141725 | etot = -17.1215412866498 +274000 ekin = 1.89671513770876 | erot = 2.24334386161735 | epot = -21.0967103438301 | etot = -16.9566513445039 +275000 ekin = 1.78930707116537 | erot = 3.09754687865994 | epot = -21.1385700371941 | etot = -16.2517160873688 +276000 ekin = 3.37110328153971 | erot = 2.41957324257529 | epot = -21.0908388312033 | etot = -15.3001623070883 +277000 ekin = 2.38921825148496 | erot = 1.50604988822737 | epot = -21.034620883997 | etot = -17.1393527442847 +278000 ekin = 2.51997301930638 | erot = 2.14026171776896 | epot = -21.0117379332914 | etot = -16.351503196216 +279000 ekin = 1.88315206280857 | erot = 2.37342905263994 | epot = -20.9993757709145 | etot = -16.742794655466 +280000 ekin = 2.33534713190787 | erot = 3.58626468287222 | epot = -20.8573252930133 | etot = -14.9357134782332 +281000 ekin = 1.75252641954511 | erot = 1.7907930540809 | epot = -20.9036528826792 | etot = -17.3603334090531 +282000 ekin = 2.26373977259215 | erot = 3.04032073608633 | epot = -20.8497513702237 | etot = -15.5456908615452 +283000 ekin = 2.1783387139443 | erot = 2.20833158301333 | epot = -20.8002776734785 | etot = -16.4136073765209 +284000 ekin = 1.9148667268656 | erot = 2.21521993135969 | epot = -20.8277491648056 | etot = -16.6976625065804 +285000 ekin = 3.15634443167765 | erot = 1.80033231604849 | epot = -21.0046435881196 | etot = -16.0479668403934 +286000 ekin = 3.84877574957331 | erot = 1.82969969667577 | epot = -21.1628555811447 | etot = -15.4843801348956 +287000 ekin = 3.60615742824732 | erot = 2.91608688151215 | epot = -21.2126952882302 | etot = -14.6904509784708 +288000 ekin = 3.19613259393802 | erot = 1.67736393077137 | epot = -21.1713552834963 | etot = -16.297858758787 +289000 ekin = 2.45584885114799 | erot = 2.77781979747336 | epot = -21.1669115721543 | etot = -15.9332429235329 +290000 ekin = 2.74570408981357 | erot = 2.40443247852242 | epot = -21.1874427766533 | etot = -16.0373062083173 +291000 ekin = 2.10295274468233 | erot = 2.37092484671539 | epot = -21.2419107014544 | etot = -16.7680331100567 +292000 ekin = 2.36118713930732 | erot = 2.05558127949017 | epot = -21.3137361602548 | etot = -16.8969677414573 +293000 ekin = 2.2786196308825 | erot = 2.35874555054765 | epot = -21.4302415460533 | etot = -16.7928763646231 +294000 ekin = 2.93315982813019 | erot = 2.90313008187785 | epot = -21.5210917917479 | etot = -15.6848018817399 +295000 ekin = 2.66360761710434 | erot = 2.28100565751945 | epot = -21.6885021477336 | etot = -16.7438888731098 +296000 ekin = 2.18767827164471 | erot = 2.90589885547353 | epot = -21.7355037190159 | etot = -16.6419265918977 +297000 ekin = 2.15987738107365 | erot = 3.29819575592636 | epot = -21.7177655658756 | etot = -16.2596924288756 +298000 ekin = 2.92956976611296 | erot = 2.36377210613469 | epot = -21.6748271071566 | etot = -16.3814852349089 +299000 ekin = 3.19167138064488 | erot = 2.23480811780853 | epot = -21.8042612344918 | etot = -16.3777817360384 +300000 ekin = 3.3133572846982 | erot = 1.38932157247169 | epot = -21.8799906137235 | etot = -17.1773117565536 +301000 ekin = 2.39061971962408 | erot = 3.30110260608963 | epot = -21.8919200817915 | etot = -16.2001977560778 +302000 ekin = 2.954460706029 | erot = 3.2304815881765 | epot = -21.8557645140423 | etot = -15.6708222198368 +303000 ekin = 2.44700205353933 | erot = 2.60676303242282 | epot = -21.8414046718167 | etot = -16.7876395858546 +304000 ekin = 2.23578509140697 | erot = 2.68770420047938 | epot = -21.7680601199659 | etot = -16.8445708280796 +305000 ekin = 2.35505207220215 | erot = 2.3823003115585 | epot = -21.7344089784493 | etot = -16.9970565946887 +306000 ekin = 1.91790567526689 | erot = 2.90107494003232 | epot = -21.7170004822351 | etot = -16.8980198669359 +307000 ekin = 2.48241777758708 | erot = 2.0836708009946 | epot = -21.6510481218459 | etot = -17.0849595432642 +308000 ekin = 2.77531620706104 | erot = 2.63103510715158 | epot = -21.6349123878086 | etot = -16.2285610735959 +309000 ekin = 2.30440955942791 | erot = 2.1249829765834 | epot = -21.5927938975113 | etot = -17.1634013615 +310000 ekin = 2.50879527040005 | erot = 3.21338829421535 | epot = -21.6043932917725 | etot = -15.8822097271571 +311000 ekin = 2.31939145866558 | erot = 3.03649241514151 | epot = -21.6247503351754 | etot = -16.2688664613683 +312000 ekin = 1.78383134659847 | erot = 3.26262247889992 | epot = -21.4948144284683 | etot = -16.4483606029699 +313000 ekin = 1.6465994694839 | erot = 2.08133087588833 | epot = -21.4920309735611 | etot = -17.7641006281889 +314000 ekin = 2.2552391830868 | erot = 2.55077633299239 | epot = -21.5103692936944 | etot = -16.7043537776152 +315000 ekin = 2.5352734391515 | erot = 2.13089997124613 | epot = -21.5923709217299 | etot = -16.9261975113323 +316000 ekin = 1.99944427781285 | erot = 1.80072924409704 | epot = -21.6039893771529 | etot = -17.803815855243 +317000 ekin = 2.11848744585804 | erot = 2.01459693810075 | epot = -21.5948976630665 | etot = -17.4618132791077 +318000 ekin = 2.29013024301854 | erot = 1.92405818620914 | epot = -21.5643695946921 | etot = -17.3501811654644 +319000 ekin = 1.97314693278018 | erot = 1.67996578959134 | epot = -21.4554808400841 | etot = -17.8023681177126 +320000 ekin = 2.45681719546631 | erot = 3.07835144499744 | epot = -21.3924125538101 | etot = -15.8572439133463 +321000 ekin = 1.85729238455498 | erot = 2.67083565671245 | epot = -21.433818829251 | etot = -16.9056907879836 +322000 ekin = 1.96132292396412 | erot = 3.36792274118279 | epot = -21.3663490830085 | etot = -16.0371034178616 +323000 ekin = 1.94437285233567 | erot = 2.09558156605687 | epot = -21.4151250968679 | etot = -17.3751706784754 +324000 ekin = 2.229181524904 | erot = 2.4674418745061 | epot = -21.532385908563 | etot = -16.8357625091529 +325000 ekin = 2.74582842770392 | erot = 2.36717454305098 | epot = -21.6443544237971 | etot = -16.5313514530422 +326000 ekin = 1.91124551133375 | erot = 1.93084217743114 | epot = -21.7077957426602 | etot = -17.8657080538953 +327000 ekin = 3.05627483509655 | erot = 1.67325209460963 | epot = -21.7948818019128 | etot = -17.0653548722066 +328000 ekin = 2.73933273476856 | erot = 1.92380912803777 | epot = -21.8364014823586 | etot = -17.1732596195523 +329000 ekin = 2.95907896099514 | erot = 3.15654168356681 | epot = -21.898199971646 | etot = -15.7825793270841 +330000 ekin = 2.90795110595274 | erot = 2.01765890034968 | epot = -21.9037795505258 | etot = -16.9781695442234 +331000 ekin = 2.27446048340228 | erot = 2.03754878634056 | epot = -21.8760842049291 | etot = -17.5640749351863 +332000 ekin = 2.43262938612094 | erot = 3.19219171897213 | epot = -21.9305186945662 | etot = -16.3056975894732 +333000 ekin = 2.47357651298171 | erot = 2.70061045814697 | epot = -22.0416691323271 | etot = -16.8674821611985 +334000 ekin = 2.38171387374892 | erot = 3.00424927873366 | epot = -22.0746318522988 | etot = -16.6886686998162 +335000 ekin = 2.10465470910016 | erot = 3.57382014016833 | epot = -22.1175420615632 | etot = -16.4390672122947 +336000 ekin = 2.61374577374183 | erot = 2.13386927281299 | epot = -22.08988251196 | etot = -17.3422674654052 +337000 ekin = 2.72124526751511 | erot = 2.74800480481403 | epot = -22.0768537131621 | etot = -16.607603640833 +338000 ekin = 1.83524121485421 | erot = 2.24338894827196 | epot = -22.1591955034455 | etot = -18.0805653403194 +339000 ekin = 1.54928432997334 | erot = 2.49812246084905 | epot = -22.202239883467 | etot = -18.1548330926446 +340000 ekin = 1.44405714940632 | erot = 4.0451327092417 | epot = -22.1149458734013 | etot = -16.6257560147533 +341000 ekin = 1.67447392575555 | erot = 2.77749751745982 | epot = -22.0760831546714 | etot = -17.624111711456 +342000 ekin = 1.9825676117275 | erot = 2.71655566521084 | epot = -22.1563522566984 | etot = -17.45722897976 +343000 ekin = 2.68213676683887 | erot = 3.16686462846914 | epot = -22.2498477633288 | etot = -16.4008463680208 +344000 ekin = 1.77905771753907 | erot = 2.19153667254074 | epot = -22.2907212723871 | etot = -18.3201268823073 +345000 ekin = 1.5460499615042 | erot = 1.85960255696712 | epot = -22.3447003428977 | etot = -18.9390478244264 +346000 ekin = 1.71554664484034 | erot = 1.79880968736714 | epot = -22.3117022609055 | etot = -18.797345928698 +347000 ekin = 1.38672912049481 | erot = 2.61484473767931 | epot = -22.332503239512 | etot = -18.3309293813379 +348000 ekin = 2.15015924850684 | erot = 2.86300326453563 | epot = -22.3337312775957 | etot = -17.3205687645532 +349000 ekin = 1.83066085453602 | erot = 1.9844132649487 | epot = -22.3967822584585 | etot = -18.5817081389738 +350000 ekin = 1.83318738252649 | erot = 2.56907029661254 | epot = -22.4577827539416 | etot = -18.0555250748026 +351000 ekin = 1.72790505260219 | erot = 2.87456274671834 | epot = -22.5159555107051 | etot = -17.9134877113846 +352000 ekin = 2.80786740016944 | erot = 2.08750448125769 | epot = -22.6549834386892 | etot = -17.7596115572621 +353000 ekin = 3.5492801472091 | erot = 1.42584537334883 | epot = -22.6849212734238 | etot = -17.7097957528659 +354000 ekin = 3.49129244374804 | erot = 2.25156548638802 | epot = -22.604182620693 | etot = -16.861324690557 +355000 ekin = 2.06248783371663 | erot = 2.92733565233054 | epot = -22.5494488364627 | etot = -17.5596253504155 +356000 ekin = 2.13415426306312 | erot = 3.32668319049641 | epot = -22.6122425286523 | etot = -17.1514050750927 +357000 ekin = 2.75897049849731 | erot = 2.51843165594436 | epot = -22.6042888591885 | etot = -17.3268867047468 +358000 ekin = 2.51778220496547 | erot = 2.28374144764325 | epot = -22.5654155469984 | etot = -17.7638918943897 +359000 ekin = 3.2037278512604 | erot = 2.5552016027623 | epot = -22.6749569097326 | etot = -16.91602745571 +360000 ekin = 2.52669169359923 | erot = 1.97563796824025 | epot = -22.7314557612254 | etot = -18.229126099386 +361000 ekin = 2.60424632123629 | erot = 2.51068088850826 | epot = -22.7715023743751 | etot = -17.6565751646306 +362000 ekin = 2.43350156723209 | erot = 3.84566788758402 | epot = -22.7352151098034 | etot = -16.4560456549873 +363000 ekin = 2.91069717970492 | erot = 1.99710098714122 | epot = -22.6302259934474 | etot = -17.7224278266013 +364000 ekin = 2.2553832868325 | erot = 1.87832387363455 | epot = -22.5083625296191 | etot = -18.374655369152 +365000 ekin = 2.04575884197224 | erot = 2.797742068412 | epot = -22.332262738426 | etot = -17.4887618280417 +366000 ekin = 2.26894187965217 | erot = 1.94379382552235 | epot = -22.2788727984906 | etot = -18.0661370933161 +367000 ekin = 2.82509630766737 | erot = 2.50361468767084 | epot = -22.3209381619452 | etot = -16.992227166607 +368000 ekin = 2.81542036602322 | erot = 2.18733627644489 | epot = -22.4297259451244 | etot = -17.4269693026563 +369000 ekin = 2.30426035796382 | erot = 2.85653411706989 | epot = -22.4923286665588 | etot = -17.3315341915251 +370000 ekin = 2.67871033327547 | erot = 2.11464921695177 | epot = -22.578069860797 | etot = -17.7847103105697 +371000 ekin = 2.19281044135007 | erot = 3.60165960664287 | epot = -22.6424730832337 | etot = -16.8480030352407 +372000 ekin = 1.77481259468411 | erot = 3.406547444381 | epot = -22.7147683829008 | etot = -17.5334083438357 +373000 ekin = 2.15551547517191 | erot = 2.7877825236183 | epot = -22.7559497214321 | etot = -17.8126517226419 +374000 ekin = 2.71938368055486 | erot = 3.58127823243842 | epot = -22.9084433694729 | etot = -16.6077814564796 +375000 ekin = 2.42759321485976 | erot = 2.9742127178716 | epot = -22.9740378563778 | etot = -17.5722319236464 +376000 ekin = 3.39126830110572 | erot = 3.24733797625004 | epot = -22.9874015798135 | etot = -16.3487953024578 +377000 ekin = 3.20966733323472 | erot = 2.65934060364476 | epot = -22.9452111216365 | etot = -17.076203184757 +378000 ekin = 1.56095946168131 | erot = 2.66159033944991 | epot = -22.9575870308253 | etot = -18.7350372296941 +379000 ekin = 1.9498568748538 | erot = 2.54085216255828 | epot = -22.9834751642939 | etot = -18.4927661268818 +380000 ekin = 2.65820438237073 | erot = 2.88045867212573 | epot = -22.9984703542083 | etot = -17.4598072997118 +381000 ekin = 2.97084599252829 | erot = 2.18892549461574 | epot = -23.0341895570111 | etot = -17.8744180698671 +382000 ekin = 2.61355176942653 | erot = 2.02938704043227 | epot = -23.00841197151 | etot = -18.3654731616512 +383000 ekin = 2.03830671072154 | erot = 2.50516194855525 | epot = -23.0393965606452 | etot = -18.4959279013684 +384000 ekin = 2.1060608733416 | erot = 2.2184025045895 | epot = -23.0602182522593 | etot = -18.7357548743282 +385000 ekin = 1.89114918519107 | erot = 1.63701051320103 | epot = -23.0834434146806 | etot = -19.5552837162885 +386000 ekin = 1.55124380123707 | erot = 1.36147797265396 | epot = -23.1300518396949 | etot = -20.2173300658039 +387000 ekin = 2.19627825752355 | erot = 1.75751396098972 | epot = -23.1280875332419 | etot = -19.1742953147287 +388000 ekin = 1.96387084539616 | erot = 1.95852585326804 | epot = -23.0327752892415 | etot = -19.1103785905773 +389000 ekin = 2.50801560941705 | erot = 2.32519825784836 | epot = -23.0011464671235 | etot = -18.1679325998581 +390000 ekin = 2.03596866068489 | erot = 1.88295618907177 | epot = -22.8810338311575 | etot = -18.9621089814009 +391000 ekin = 1.8098591016452 | erot = 2.39622167162874 | epot = -22.81955664632 | etot = -18.613475873046 +392000 ekin = 2.17725370142733 | erot = 2.87094426544089 | epot = -22.7839731045438 | etot = -17.7357751376756 +393000 ekin = 2.14224634181997 | erot = 3.17242974303658 | epot = -22.8435025538357 | etot = -17.5288264689792 +394000 ekin = 1.97769550804367 | erot = 2.16375300420729 | epot = -22.8342667825711 | etot = -18.6928182703201 +395000 ekin = 2.03687268736298 | erot = 2.49567469731651 | epot = -22.8892034986303 | etot = -18.3566561139508 +396000 ekin = 2.16189109047463 | erot = 1.95308746486161 | epot = -22.9781386034885 | etot = -18.8631600481523 +397000 ekin = 2.41744222422408 | erot = 1.65310699287476 | epot = -23.0900453292844 | etot = -19.0194961121856 +398000 ekin = 3.58905654436294 | erot = 2.51930256503331 | epot = -23.2070733343384 | etot = -17.0987142249422 +399000 ekin = 2.65051654249497 | erot = 1.78138450529865 | epot = -23.3040478764215 | etot = -18.8721468286279 +400000 ekin = 2.49402752614129 | erot = 2.10290777432183 | epot = -23.3608759462318 | etot = -18.7639406457687 +401000 ekin = 2.04176177605462 | erot = 2.154995213856 | epot = -23.4039603394011 | etot = -19.2072033494905 +402000 ekin = 2.44505875861459 | erot = 2.11318097973378 | epot = -23.3975262709888 | etot = -18.8392865326404 +403000 ekin = 2.54858079745147 | erot = 2.81138206601919 | epot = -23.476064698677 | etot = -18.1161018352063 +404000 ekin = 2.21063952462117 | erot = 2.64710865829565 | epot = -23.574696037266 | etot = -18.7169478543492 +405000 ekin = 2.47328118101332 | erot = 2.40933750599425 | epot = -23.5927917139469 | etot = -18.7101730269393 +406000 ekin = 2.24891173527799 | erot = 2.23777884116047 | epot = -23.6086191890417 | etot = -19.1219286126032 +407000 ekin = 2.0107940045037 | erot = 2.78642832526904 | epot = -23.5246032469978 | etot = -18.727380917225 +408000 ekin = 2.59464051790823 | erot = 2.59123578102097 | epot = -23.4198302602656 | etot = -18.2339539613364 +409000 ekin = 2.37170880608734 | erot = 2.26136902851213 | epot = -23.317258193724 | etot = -18.6841803591245 +410000 ekin = 1.99754661347185 | erot = 1.95523998485755 | epot = -23.2950402043273 | etot = -19.3422536059979 +411000 ekin = 1.8693657058423 | erot = 2.63899492681176 | epot = -23.2490367633041 | etot = -18.74067613065 +412000 ekin = 1.98214047746227 | erot = 2.68315820775202 | epot = -23.1987357483281 | etot = -18.5334370631139 +413000 ekin = 2.39078873487373 | erot = 2.65589562872907 | epot = -23.1435198518627 | etot = -18.0968354882599 +414000 ekin = 2.40821090859775 | erot = 1.75574324408225 | epot = -23.0725048141377 | etot = -18.9085506614577 +415000 ekin = 2.74601981183015 | erot = 2.43675176686816 | epot = -23.1211711904486 | etot = -17.9383996117503 +416000 ekin = 2.08828454200993 | erot = 2.76783506526218 | epot = -23.1383119239965 | etot = -18.2821923167244 +417000 ekin = 2.01455344430628 | erot = 1.95306265456051 | epot = -23.1433633505287 | etot = -19.1757472516619 +418000 ekin = 2.42716528853985 | erot = 2.57642821145486 | epot = -23.127531797131 | etot = -18.1239382971363 +419000 ekin = 3.04095103685797 | erot = 2.58427576972734 | epot = -23.0602279332617 | etot = -17.4350011266764 +420000 ekin = 2.6360746280152 | erot = 2.44478111019393 | epot = -22.982092315172 | etot = -17.9012365769629 +421000 ekin = 2.53019765722915 | erot = 1.78389585255477 | epot = -22.9707435541329 | etot = -18.6566500443489 +422000 ekin = 2.72457425772367 | erot = 1.67768634886349 | epot = -22.9542997027495 | etot = -18.5520390961623 +423000 ekin = 2.11402997037893 | erot = 2.55034580375608 | epot = -22.8263851956497 | etot = -18.1620094215147 +424000 ekin = 1.8895880210325 | erot = 2.31332431343561 | epot = -22.772666888172 | etot = -18.5697545537039 +425000 ekin = 2.3595116370971 | erot = 1.95762380637298 | epot = -22.7752082759346 | etot = -18.4580728324645 +426000 ekin = 2.23706657164627 | erot = 2.60016134755148 | epot = -22.7844114251539 | etot = -17.9471835059562 +427000 ekin = 1.88801598248841 | erot = 2.12415782350886 | epot = -22.9416586386639 | etot = -18.9294848326666 +428000 ekin = 1.92849031333042 | erot = 2.44097902588716 | epot = -23.0611368174399 | etot = -18.6916674782223 +429000 ekin = 1.70536802258415 | erot = 2.14916257389792 | epot = -23.0556586745393 | etot = -19.2011280780572 +430000 ekin = 2.30226095973205 | erot = 2.14689932813604 | epot = -23.0606502516208 | etot = -18.6114899637527 +431000 ekin = 2.45988288454318 | erot = 2.42278380298657 | epot = -23.0729777223881 | etot = -18.1903110348583 +432000 ekin = 2.80869332724974 | erot = 2.19954129490925 | epot = -23.0939746542044 | etot = -18.0857400320454 +433000 ekin = 2.21130556188282 | erot = 1.62882156110628 | epot = -23.1534080352157 | etot = -19.3132809122266 +434000 ekin = 2.60574953870752 | erot = 2.36088790768803 | epot = -23.1901717047879 | etot = -18.2235342583923 +435000 ekin = 2.30377529593091 | erot = 2.53917715731259 | epot = -23.1716983948432 | etot = -18.3287459415997 +436000 ekin = 2.42707603554825 | erot = 2.75234181061924 | epot = -23.2197996577197 | etot = -18.0403818115522 +437000 ekin = 1.65090540276074 | erot = 3.25345231298367 | epot = -23.2216366145388 | etot = -18.3172788987944 +438000 ekin = 1.56145302974407 | erot = 2.60950810563796 | epot = -23.1303770792278 | etot = -18.9594159438458 +439000 ekin = 2.30955439722234 | erot = 1.94011743371103 | epot = -23.1353170794497 | etot = -18.8856452485163 +440000 ekin = 2.53037674867674 | erot = 3.0652704286103 | epot = -23.196858945292 | etot = -17.601211768005 +441000 ekin = 2.80107707952534 | erot = 2.53664155736544 | epot = -23.1712373428919 | etot = -17.8335187060011 +442000 ekin = 2.92536323090713 | erot = 2.88384500930017 | epot = -23.1123001627208 | etot = -17.3030919225135 +443000 ekin = 1.96543935969482 | erot = 1.753449631552 | epot = -23.0380529084377 | etot = -19.3191639171909 +444000 ekin = 2.00309477401363 | erot = 2.23897509587739 | epot = -22.9472103119533 | etot = -18.7051404420623 +445000 ekin = 2.20302071819722 | erot = 2.06928381371828 | epot = -22.7775434364172 | etot = -18.5052389045017 +446000 ekin = 2.43487889302299 | erot = 2.37751556007798 | epot = -22.6838190597697 | etot = -17.8714246066687 +447000 ekin = 2.2620819636031 | erot = 2.41400188145197 | epot = -22.7082516636546 | etot = -18.0321678185995 +448000 ekin = 2.16184472791984 | erot = 1.93539407204278 | epot = -22.8144859493263 | etot = -18.7172471493637 +449000 ekin = 2.21107967973114 | erot = 2.34659682978741 | epot = -22.9059503054159 | etot = -18.3482737958974 +450000 ekin = 2.74677740004439 | erot = 1.97222921372039 | epot = -22.860755926716 | etot = -18.1417493129513 +451000 ekin = 2.2050889378155 | erot = 2.13042736119389 | epot = -22.8862608894796 | etot = -18.5507445904702 +452000 ekin = 2.52760608607095 | erot = 2.34006815636601 | epot = -22.9138111972133 | etot = -18.0461369547763 +453000 ekin = 2.23448825172916 | erot = 1.77834418215733 | epot = -22.8879238301791 | etot = -18.8750913962926 +454000 ekin = 2.4343851915949 | erot = 2.59700848533281 | epot = -22.8184361849036 | etot = -17.7870425079759 +455000 ekin = 2.04195793930991 | erot = 2.79639043747681 | epot = -22.6032980500354 | etot = -17.7649496732487 +456000 ekin = 2.00799933710202 | erot = 2.53653815407518 | epot = -22.4355596266522 | etot = -17.891022135475 +457000 ekin = 2.60426208759883 | erot = 2.46609612876191 | epot = -22.3409120082078 | etot = -17.270553791847 +458000 ekin = 2.01368468059037 | erot = 1.9961381624531 | epot = -22.2549400327205 | etot = -18.2451171896771 +459000 ekin = 1.73688781588865 | erot = 2.48572034306896 | epot = -22.2282088298767 | etot = -18.0056006709191 +460000 ekin = 1.91682575775988 | erot = 2.08308677023944 | epot = -22.2211874714416 | etot = -18.2212749434423 +461000 ekin = 1.54933673126938 | erot = 1.29454502815255 | epot = -22.1945151049368 | etot = -19.3506333455148 +462000 ekin = 2.44160489340629 | erot = 1.34721473707676 | epot = -22.284671307697 | etot = -18.495851677214 +463000 ekin = 2.63165365707667 | erot = 2.08143760128039 | epot = -22.4004513395625 | etot = -17.6873600812055 +464000 ekin = 2.67929276186416 | erot = 3.72563793061087 | epot = -22.5200042545289 | etot = -16.1150735620538 +465000 ekin = 1.94880111369479 | erot = 2.23148844819348 | epot = -22.685554296329 | etot = -18.5052647344407 +466000 ekin = 2.13853049638891 | erot = 2.95056624305957 | epot = -22.7822881705531 | etot = -17.6931914311046 +467000 ekin = 2.46452767169615 | erot = 2.1077848077008 | epot = -22.9485753844866 | etot = -18.3762629050896 +468000 ekin = 1.98589158006998 | erot = 1.62816092182055 | epot = -23.0180008829524 | etot = -19.4039483810618 +469000 ekin = 2.498810820967 | erot = 2.6361546272592 | epot = -23.0547833968841 | etot = -17.9198179486579 +470000 ekin = 2.91491361681313 | erot = 3.19115611298998 | epot = -23.0448741101699 | etot = -16.9388043803668 +471000 ekin = 2.37554627514204 | erot = 1.71739792236247 | epot = -22.9932329645513 | etot = -18.9002887670468 +472000 ekin = 2.18486807923518 | erot = 2.00687069908099 | epot = -22.9563182572702 | etot = -18.764579478954 +473000 ekin = 2.36185345820899 | erot = 2.86259041401023 | epot = -22.9161024426125 | etot = -17.6916585703933 +474000 ekin = 2.17077693495272 | erot = 2.59376596740919 | epot = -22.7894018760352 | etot = -18.0248589736733 +475000 ekin = 2.37844153079293 | erot = 2.01112751381907 | epot = -22.6793191497969 | etot = -18.2897501051849 +476000 ekin = 2.0876367643964 | erot = 2.59647624455221 | epot = -22.6700039875052 | etot = -17.9858909785566 +477000 ekin = 2.52249432714936 | erot = 3.55251934739867 | epot = -22.6424099194916 | etot = -16.5673962449436 +478000 ekin = 2.40424947791157 | erot = 2.7323911725861 | epot = -22.544776325228 | etot = -17.4081356747303 +479000 ekin = 1.27637524434413 | erot = 2.99749792697945 | epot = -22.4994949498981 | etot = -18.2256217785745 +480000 ekin = 1.81374950293817 | erot = 2.14389317135939 | epot = -22.4678405170784 | etot = -18.5101978427809 +481000 ekin = 2.39496774186199 | erot = 3.18299441824521 | epot = -22.4930736763177 | etot = -16.9151115162105 +482000 ekin = 3.21051763720184 | erot = 2.40962326270833 | epot = -22.4479376181304 | etot = -16.8277967182202 +483000 ekin = 3.06081116762377 | erot = 2.49856996934407 | epot = -22.4288948733283 | etot = -16.8695137363604 +484000 ekin = 2.7452293328759 | erot = 2.53012629993099 | epot = -22.483756332919 | etot = -17.2084007001121 +485000 ekin = 3.33103095180521 | erot = 2.42091818181918 | epot = -22.4922555047182 | etot = -16.7403063710938 +486000 ekin = 1.99323479363108 | erot = 1.76127718142275 | epot = -22.5432098594131 | etot = -18.7886978843593 +487000 ekin = 2.64825718911654 | erot = 2.50204426232017 | epot = -22.6407366935241 | etot = -17.4904352420874 +488000 ekin = 1.76385891719471 | erot = 2.64266555173498 | epot = -22.6990728058786 | etot = -18.2925483369489 +489000 ekin = 2.10357630534276 | erot = 2.95613916443127 | epot = -22.7877124402073 | etot = -17.7279969704332 +490000 ekin = 2.33515649128314 | erot = 2.32995416999058 | epot = -22.7920703811403 | etot = -18.1269597198666 +491000 ekin = 2.48752587426647 | erot = 2.58310949760555 | epot = -22.7834811495388 | etot = -17.7128457776668 +492000 ekin = 3.29820665204489 | erot = 2.18682924183924 | epot = -22.7674519489923 | etot = -17.2824160551082 +493000 ekin = 3.40238156707506 | erot = 2.35717041222451 | epot = -22.7149408840448 | etot = -16.9553889047452 +494000 ekin = 3.59348050162499 | erot = 2.23182460532058 | epot = -22.7081682295491 | etot = -16.8828631226035 +495000 ekin = 2.52030309238562 | erot = 2.16229430067423 | epot = -22.6973031832711 | etot = -18.0147057902113 +496000 ekin = 1.96100991422337 | erot = 3.58581695215166 | epot = -22.7342002900882 | etot = -17.1873734237132 +497000 ekin = 2.2228647925968 | erot = 2.49495319949133 | epot = -22.752706201593 | etot = -18.0348882095048 +498000 ekin = 1.71033952564695 | erot = 2.41331591511584 | epot = -22.7131621100867 | etot = -18.589506669324 +499000 ekin = 2.41919864300729 | erot = 2.82349519531821 | epot = -22.7304918052927 | etot = -17.4877979669672 +500000 ekin = 2.76271068346558 | erot = 2.22796445937143 | epot = -22.810945568044 | etot = -17.820270425207 +501000 ekin = 2.97642553987186 | erot = 1.97769778889399 | epot = -22.8306304048616 | etot = -17.8765070760957 +502000 ekin = 2.96175345860856 | erot = 1.80859086419487 | epot = -22.8525538190094 | etot = -18.082209496206 +503000 ekin = 2.51126831088417 | erot = 2.88572311841927 | epot = -22.8673362278446 | etot = -17.4703447985412 +504000 ekin = 2.84611165351303 | erot = 2.67626783872459 | epot = -22.784891957601 | etot = -17.2625124653634 +505000 ekin = 2.96124584448914 | erot = 2.59100575301934 | epot = -22.8251284225258 | etot = -17.2728768250174 +506000 ekin = 2.19858217910528 | erot = 1.97142936872076 | epot = -22.8530995461462 | etot = -18.6830879983201 +507000 ekin = 2.27398115142402 | erot = 2.68837996151517 | epot = -22.8141163798141 | etot = -17.8517552668749 +508000 ekin = 2.64439339973837 | erot = 2.04756467869449 | epot = -22.8146247157345 | etot = -18.1226666373017 +509000 ekin = 2.96023637315629 | erot = 2.90549934754532 | epot = -22.8719625385967 | etot = -17.0062268178951 +510000 ekin = 2.26067558634546 | erot = 2.80864918519521 | epot = -22.9774448292236 | etot = -17.9081200576829 +511000 ekin = 2.88512738978599 | erot = 2.15263877534437 | epot = -23.086672848248 | etot = -18.0489066831176 +512000 ekin = 2.17783748155516 | erot = 2.31389139764186 | epot = -23.1520181882638 | etot = -18.6602893090668 +513000 ekin = 1.69717952556151 | erot = 2.88265468656805 | epot = -23.1640284548407 | etot = -18.5841942427111 +514000 ekin = 1.72432024724117 | erot = 2.32742209152174 | epot = -23.1602225830814 | etot = -19.1084802443185 +515000 ekin = 2.00525337522086 | erot = 1.80102864435032 | epot = -23.1548763180746 | etot = -19.3485942985034 +516000 ekin = 3.04706172157038 | erot = 1.54171785431326 | epot = -23.1202751246552 | etot = -18.5314955487716 +517000 ekin = 2.47323892251936 | erot = 2.10799615007355 | epot = -23.0942246440307 | etot = -18.5129895714378 +518000 ekin = 2.03556879740597 | erot = 2.51531294708502 | epot = -23.01998934344 | etot = -18.4691075989491 +519000 ekin = 1.59255614728459 | erot = 1.63520468579907 | epot = -22.9787913166931 | etot = -19.7510304836094 +520000 ekin = 2.17210761761845 | erot = 1.8975366735392 | epot = -22.9877149955356 | etot = -18.918070704378 +521000 ekin = 1.98466680078867 | erot = 2.09219045542651 | epot = -23.0348541858322 | etot = -18.9579969296171 +522000 ekin = 2.72098469914434 | erot = 2.19565658619456 | epot = -23.1001210576502 | etot = -18.1834797723113 +523000 ekin = 2.26033454380754 | erot = 1.67112114369622 | epot = -23.1475509854345 | etot = -19.2160952979307 +524000 ekin = 2.34603831546138 | erot = 2.1054661011949 | epot = -23.1746761633773 | etot = -18.723171746721 +525000 ekin = 2.13671314300235 | erot = 2.07172081705863 | epot = -23.241177743004 | etot = -19.032743782943 +526000 ekin = 2.50849953901566 | erot = 2.27662230434506 | epot = -23.3179050583979 | etot = -18.5327832150372 +527000 ekin = 3.04322527932213 | erot = 1.8128057083239 | epot = -23.3977373118239 | etot = -18.5417063241779 +528000 ekin = 2.572303182379 | erot = 2.54386055260816 | epot = -23.4208428708383 | etot = -18.3046791358511 +529000 ekin = 2.39361269633634 | erot = 1.91637577362227 | epot = -23.3966015599491 | etot = -19.0866130899905 +530000 ekin = 3.3562937907424 | erot = 3.41683815876463 | epot = -23.2977853851852 | etot = -16.5246534356781 +531000 ekin = 2.52741741752381 | erot = 2.34075342407645 | epot = -23.1721175623278 | etot = -18.3039467207275 +532000 ekin = 2.78397051305127 | erot = 1.78575123294094 | epot = -23.2171711834401 | etot = -18.6474494374479 +533000 ekin = 2.27408274334042 | erot = 2.01427501035043 | epot = -23.2885684059727 | etot = -19.0002106522818 +534000 ekin = 2.54998010491125 | erot = 2.0164545364507 | epot = -23.340767920006 | etot = -18.7743332786441 +535000 ekin = 2.49595662250557 | erot = 2.09586427439366 | epot = -23.3878755759449 | etot = -18.7960546790457 +536000 ekin = 2.47717157546008 | erot = 1.92116873587364 | epot = -23.3847675210095 | etot = -18.9864272096758 +537000 ekin = 1.75235621440219 | erot = 2.11852052216092 | epot = -23.4590860280326 | etot = -19.5882092914695 +538000 ekin = 2.19317209186629 | erot = 2.75191518419657 | epot = -23.5517834707225 | etot = -18.6066961946597 +539000 ekin = 2.16135327665114 | erot = 2.25935011393788 | epot = -23.5718250119029 | etot = -19.1511216213139 +540000 ekin = 2.35701554620647 | erot = 1.6449529057333 | epot = -23.5490867129451 | etot = -19.5471182610054 +541000 ekin = 2.61451212811978 | erot = 2.52550284426682 | epot = -23.5334576350385 | etot = -18.3934426626519 +542000 ekin = 2.78909215024063 | erot = 2.09346850400965 | epot = -23.5754619290989 | etot = -18.6929012748486 +543000 ekin = 2.77024528778678 | erot = 1.84116991183092 | epot = -23.4849560716084 | etot = -18.8735408719907 +544000 ekin = 2.15807529188369 | erot = 1.50139575300257 | epot = -23.4530822422947 | etot = -19.7936111974084 +545000 ekin = 1.72860204886329 | erot = 2.56468335549414 | epot = -23.4524953434144 | etot = -19.159209939057 +546000 ekin = 2.38494138419348 | erot = 1.87772638427254 | epot = -23.4950389557033 | etot = -19.2323711872372 +547000 ekin = 2.44871634556835 | erot = 2.44464466893214 | epot = -23.544915775382 | etot = -18.6515547608815 +548000 ekin = 2.36962922994878 | erot = 2.40235228488721 | epot = -23.5548428056052 | etot = -18.7828612907692 +549000 ekin = 2.57958168249614 | erot = 2.04930779813674 | epot = -23.5565149978683 | etot = -18.9276255172355 +550000 ekin = 1.9793136647427 | erot = 1.85207468704394 | epot = -23.5614067919063 | etot = -19.7300184401196 +551000 ekin = 2.4121774327081 | erot = 2.0348936886299 | epot = -23.5115216908382 | etot = -19.0644505695002 +552000 ekin = 2.6621149390197 | erot = 1.41279265378133 | epot = -23.3450678435402 | etot = -19.2701602507391 +553000 ekin = 1.76359346131444 | erot = 2.63019210822711 | epot = -23.1435570943958 | etot = -18.7497715248542 +554000 ekin = 2.29840754300073 | erot = 2.34424452982823 | epot = -23.1114395278817 | etot = -18.4687874550527 +555000 ekin = 3.29672420152566 | erot = 1.64146930698359 | epot = -23.0891292168918 | etot = -18.1509357083825 +556000 ekin = 2.92076699655596 | erot = 2.59602967895818 | epot = -23.0268314200472 | etot = -17.5100347445331 +557000 ekin = 2.90322014804994 | erot = 3.16052668894921 | epot = -23.0146480567181 | etot = -16.950901219719 +558000 ekin = 2.78018761002222 | erot = 2.59826947006759 | epot = -22.7877399275349 | etot = -17.4092828474451 +559000 ekin = 2.48661596771862 | erot = 3.22596665511856 | epot = -22.8226574327834 | etot = -17.1100748099462 +560000 ekin = 2.34942852601698 | erot = 2.32773162877396 | epot = -22.8255608134696 | etot = -18.1484006586786 +561000 ekin = 2.0520192544917 | erot = 2.90306975046936 | epot = -22.8488516051139 | etot = -17.8937626001529 +562000 ekin = 2.18821919117372 | erot = 3.66499439159819 | epot = -22.7618817506902 | etot = -16.9086681679183 +563000 ekin = 3.11505518852414 | erot = 2.28057725990564 | epot = -22.791430640287 | etot = -17.3957981918572 +564000 ekin = 2.45343120006931 | erot = 2.36321638506708 | epot = -22.75807077839 | etot = -17.9414231932536 +565000 ekin = 2.77835835502221 | erot = 2.07073547186409 | epot = -22.7486053888412 | etot = -17.8995115619549 +566000 ekin = 2.43655641927934 | erot = 2.19832280178868 | epot = -22.7227654505166 | etot = -18.0878862294486 +567000 ekin = 2.71233133108494 | erot = 2.01281091173405 | epot = -22.8839744455115 | etot = -18.1588322026925 +568000 ekin = 3.12450796157708 | erot = 1.93520150351061 | epot = -22.9625972279254 | etot = -17.9028877628377 +569000 ekin = 3.72714267701977 | erot = 2.06562452789051 | epot = -22.9814174117752 | etot = -17.1886502068649 +570000 ekin = 2.68808623045676 | erot = 2.36042122391805 | epot = -22.998959026692 | etot = -17.9504515723172 +571000 ekin = 1.97223467321356 | erot = 2.85558181274648 | epot = -22.9369001315648 | etot = -18.1090836456047 +572000 ekin = 2.4182049732123 | erot = 2.40910077907643 | epot = -22.934930836907 | etot = -18.1076250846182 +573000 ekin = 1.76702714285012 | erot = 2.31739567602694 | epot = -22.9768902017483 | etot = -18.8924673828712 +574000 ekin = 2.08740259214111 | erot = 2.59288012722136 | epot = -23.0518321557917 | etot = -18.3715494364293 +575000 ekin = 2.34020490338786 | erot = 2.78500973557001 | epot = -23.106579446946 | etot = -17.9813648079881 +576000 ekin = 2.15506609467459 | erot = 3.3045287538029 | epot = -23.1521162771299 | etot = -17.6925214286524 +577000 ekin = 2.45698150895878 | erot = 2.31876672704204 | epot = -23.1781917242715 | etot = -18.4024434882707 +578000 ekin = 2.59353106592521 | erot = 2.33790294336519 | epot = -23.2101395643707 | etot = -18.2787055550803 +579000 ekin = 2.58102015460712 | erot = 1.71748063175117 | epot = -23.1865014452815 | etot = -18.8880006589232 +580000 ekin = 2.30361750578347 | erot = 2.87410564379621 | epot = -23.2045008793077 | etot = -18.026777729728 +581000 ekin = 2.45915247103344 | erot = 2.59640238490727 | epot = -23.1882783600354 | etot = -18.1327235040947 +582000 ekin = 2.33801590725494 | erot = 3.19256035650617 | epot = -23.2501410058056 | etot = -17.7195647420445 +583000 ekin = 1.95982078382855 | erot = 2.81944051586213 | epot = -23.4085593869414 | etot = -18.6292980872508 +584000 ekin = 2.00358327245437 | erot = 1.7126727026301 | epot = -23.4960310960901 | etot = -19.7797751210056 +585000 ekin = 2.28859150562676 | erot = 2.06309046911262 | epot = -23.5306230166998 | etot = -19.1789410419604 +586000 ekin = 2.21858454582016 | erot = 1.97776854350186 | epot = -23.4873397268816 | etot = -19.2909866375596 +587000 ekin = 3.70065233550663 | erot = 1.82187748311298 | epot = -23.4652388428899 | etot = -17.9427090242702 +588000 ekin = 3.49447328534893 | erot = 2.31981981591506 | epot = -23.3985567739262 | etot = -17.5842636726622 +589000 ekin = 2.66144502802388 | erot = 3.02756546370717 | epot = -23.2783756079917 | etot = -17.5893651162607 +590000 ekin = 1.52141257336428 | erot = 2.09874614600563 | epot = -23.1290158071881 | etot = -19.5088570878182 +591000 ekin = 1.82897193042274 | erot = 1.75592223095374 | epot = -23.0622736076073 | etot = -19.4773794462309 +592000 ekin = 2.49491276892191 | erot = 2.5482988197852 | epot = -23.054885494985 | etot = -18.0116739062779 +593000 ekin = 2.36845716276159 | erot = 1.78503341410575 | epot = -23.005264310194 | etot = -18.8517737333267 +594000 ekin = 2.07907010887474 | erot = 2.14563658430187 | epot = -22.9611396232755 | etot = -18.7364329300989 +595000 ekin = 2.62736231723874 | erot = 2.0397582574453 | epot = -22.9495489717352 | etot = -18.2824283970512 +596000 ekin = 2.58985967531625 | erot = 2.12449830164849 | epot = -22.9908505579803 | etot = -18.2764925810155 +597000 ekin = 3.02540042664856 | erot = 3.14256707367048 | epot = -22.9740991012936 | etot = -16.8061316009746 +598000 ekin = 3.44397104083287 | erot = 2.8605790839857 | epot = -23.0035411551228 | etot = -16.6989910303042 +599000 ekin = 2.13932500926498 | erot = 3.49187029024979 | epot = -22.9657391359988 | etot = -17.334543836484 +600000 ekin = 2.19758597945326 | erot = 2.49610822362376 | epot = -22.9452235009931 | etot = -18.2515292979161 +601000 ekin = 2.80918982916752 | erot = 2.81768433603376 | epot = -22.8970508934525 | etot = -17.2701767282513 +602000 ekin = 2.30031523379463 | erot = 2.40907304500534 | epot = -22.8523950981499 | etot = -18.1430068193499 +603000 ekin = 1.91335501396421 | erot = 1.99518053980753 | epot = -22.7884152302358 | etot = -18.879879676464 +604000 ekin = 2.5976715095492 | erot = 3.14351403383687 | epot = -22.7430641975849 | etot = -17.0018786541988 +605000 ekin = 2.63203298717972 | erot = 2.07906613894389 | epot = -22.7307949909783 | etot = -18.0196958648547 +606000 ekin = 2.94678399289781 | erot = 2.03982213630799 | epot = -22.6555302524726 | etot = -17.6689241232668 +607000 ekin = 2.85272606479019 | erot = 2.36693467257681 | epot = -22.6318548820144 | etot = -17.4121941446474 +608000 ekin = 3.6642968125636 | erot = 2.46706737589234 | epot = -22.5724662590778 | etot = -16.4411020706219 +609000 ekin = 2.69343886620625 | erot = 2.25873504143679 | epot = -22.6007364465805 | etot = -17.6485625389374 +610000 ekin = 2.99904616523658 | erot = 2.13621966615343 | epot = -22.5973658485054 | etot = -17.4621000171154 +611000 ekin = 3.86832985948944 | erot = 2.12096644577641 | epot = -22.5702925425382 | etot = -16.5809962372724 +612000 ekin = 2.88515301824618 | erot = 2.45910554524357 | epot = -22.4848584522585 | etot = -17.1405998887688 +613000 ekin = 2.9367425327116 | erot = 2.14436169371533 | epot = -22.465526703267 | etot = -17.3844224768401 +614000 ekin = 2.79116462876301 | erot = 2.024409539648 | epot = -22.5207406301148 | etot = -17.7051664617038 +615000 ekin = 2.29338048298908 | erot = 2.38828872470982 | epot = -22.6082782403584 | etot = -17.9266090326595 +616000 ekin = 1.78195169789474 | erot = 2.45334803626968 | epot = -22.6887534547644 | etot = -18.4534537206 +617000 ekin = 2.57505808534158 | erot = 2.55345758187858 | epot = -22.701463839496 | etot = -17.5729481722758 +618000 ekin = 2.29561379442387 | erot = 2.68043259355499 | epot = -22.629958627306 | etot = -17.6539122393272 +619000 ekin = 1.94323313590202 | erot = 2.00964911157699 | epot = -22.56819110474 | etot = -18.6153088572609 +620000 ekin = 2.92263589097657 | erot = 2.15657756066215 | epot = -22.6264664894927 | etot = -17.547253037854 +621000 ekin = 2.90437881656455 | erot = 1.70649555848315 | epot = -22.665419447573 | etot = -18.0545450725253 +622000 ekin = 2.03426149564846 | erot = 2.51826459248401 | epot = -22.6086250578043 | etot = -18.0560989696718 +623000 ekin = 1.98348786592096 | erot = 3.08484972830227 | epot = -22.6234743341759 | etot = -17.5551367399527 +624000 ekin = 2.08463083558977 | erot = 2.64004606903047 | epot = -22.6266529328942 | etot = -17.901976028274 +625000 ekin = 2.52963490334089 | erot = 2.37033264022622 | epot = -22.6750436783156 | etot = -17.7750761347485 +626000 ekin = 2.73147680333726 | erot = 2.07051651598004 | epot = -22.7272383647964 | etot = -17.9252450454791 +627000 ekin = 2.23447399123207 | erot = 2.35288557052269 | epot = -22.7136740507756 | etot = -18.1263144890208 +628000 ekin = 2.28933754695897 | erot = 2.29676268895054 | epot = -22.6176528573237 | etot = -18.0315526214142 +629000 ekin = 2.5355466362136 | erot = 1.92082543033528 | epot = -22.5693331526924 | etot = -18.1129610861435 +630000 ekin = 3.11700824717166 | erot = 2.51611049765935 | epot = -22.5144695759915 | etot = -16.8813508311605 +631000 ekin = 2.38844807455604 | erot = 3.31601650504458 | epot = -22.5190998334878 | etot = -16.8146352538871 +632000 ekin = 2.59939587493746 | erot = 2.51496212358955 | epot = -22.4711049664696 | etot = -17.3567469679426 +633000 ekin = 2.45338619933597 | erot = 1.89874016257143 | epot = -22.4394257686937 | etot = -18.0872994067863 +634000 ekin = 2.23819111967047 | erot = 1.98305652730466 | epot = -22.3433365860708 | etot = -18.1220889390957 +635000 ekin = 2.22438000857702 | erot = 1.95893208021227 | epot = -22.2877959440852 | etot = -18.1044838552959 +636000 ekin = 2.26938644192167 | erot = 2.77816773779856 | epot = -22.304696935737 | etot = -17.2571427560168 +637000 ekin = 1.97799147515645 | erot = 2.59610837639352 | epot = -22.3353238115758 | etot = -17.7612239600258 +638000 ekin = 2.54901279963355 | erot = 3.14232301833368 | epot = -22.3113570318407 | etot = -16.6200212138734 +639000 ekin = 2.38194254982011 | erot = 2.49468098011844 | epot = -22.2696251856514 | etot = -17.3930016557128 +640000 ekin = 2.07438054408915 | erot = 2.20336226777045 | epot = -22.1673693230788 | etot = -17.8896265112192 +641000 ekin = 2.49150296422893 | erot = 3.53882164550033 | epot = -22.047323387435 | etot = -16.0169987777057 +642000 ekin = 3.37964058409635 | erot = 2.18458831029801 | epot = -21.9324522713976 | etot = -16.3682233770032 +643000 ekin = 2.80862431007863 | erot = 2.40815089193716 | epot = -21.8726014240441 | etot = -16.6558262220283 +644000 ekin = 2.952235016065 | erot = 1.92776262379328 | epot = -21.826057423183 | etot = -16.9460597833247 +645000 ekin = 4.10488984334312 | erot = 1.89062109330214 | epot = -21.7981661301139 | etot = -15.8026551934687 +646000 ekin = 2.50234872105284 | erot = 2.00205075040523 | epot = -21.7221642434957 | etot = -17.2177647720377 +647000 ekin = 2.52267281239589 | erot = 2.19481558810105 | epot = -21.7438885460027 | etot = -17.0264001455058 +648000 ekin = 2.99344241657584 | erot = 2.11139263207284 | epot = -21.7373240000025 | etot = -16.6324889513538 +649000 ekin = 2.55027365085816 | erot = 3.20350991793738 | epot = -21.7192481424448 | etot = -15.9654645736493 +650000 ekin = 3.75163896052813 | erot = 2.44189212282279 | epot = -21.6756681314987 | etot = -15.4821370481478 +651000 ekin = 3.29740056237165 | erot = 2.36780448747275 | epot = -21.5372361691658 | etot = -15.8720311193214 +652000 ekin = 2.54645886055823 | erot = 2.99097829596978 | epot = -21.4549655298412 | etot = -15.9175283733132 +653000 ekin = 2.88682688109756 | erot = 2.53633970608342 | epot = -21.4696471597398 | etot = -16.0464805725588 +654000 ekin = 2.28614085804932 | erot = 2.12026601708473 | epot = -21.5642684321318 | etot = -17.1578615569978 +655000 ekin = 2.20709609517087 | erot = 2.10729950549551 | epot = -21.5349466292622 | etot = -17.2205510285959 +656000 ekin = 2.40310876229413 | erot = 2.09663823500903 | epot = -21.5631924595209 | etot = -17.0634454622178 +657000 ekin = 2.7886551346751 | erot = 2.19608839827219 | epot = -21.794507747247 | etot = -16.8097642142998 +658000 ekin = 3.1025713807162 | erot = 2.59154293692773 | epot = -21.96675599421 | etot = -16.2726416765661 +659000 ekin = 2.88891106020275 | erot = 3.47010878893494 | epot = -22.0542552611187 | etot = -15.695235411981 +660000 ekin = 2.90074521854052 | erot = 1.62850743298554 | epot = -22.1003034196589 | etot = -17.5710507681328 +661000 ekin = 3.26666543815737 | erot = 1.86223225384175 | epot = -22.202664217118 | etot = -17.0737665251189 +662000 ekin = 3.1558491019044 | erot = 2.16868634291728 | epot = -22.3049478747805 | etot = -16.9804124299588 +663000 ekin = 1.94349853674083 | erot = 2.45687952722591 | epot = -22.3908978754178 | etot = -17.990519811451 +664000 ekin = 1.45445820960401 | erot = 1.37641815749115 | epot = -22.5088813854798 | etot = -19.6780050183846 +665000 ekin = 1.57568561901953 | erot = 2.30379312359823 | epot = -22.5957949572927 | etot = -18.7163162146749 +666000 ekin = 2.46162449261636 | erot = 1.76978614573263 | epot = -22.7431602236664 | etot = -18.5117495853174 +667000 ekin = 2.82410423268351 | erot = 2.3383666365949 | epot = -22.9350563238978 | etot = -17.7725854546194 +668000 ekin = 2.73717686116191 | erot = 3.18779777915035 | epot = -23.0188768131827 | etot = -17.0939021728704 +669000 ekin = 3.41035672635339 | erot = 2.45479601777612 | epot = -23.0718232403886 | etot = -17.2066704962591 +670000 ekin = 2.54649164859505 | erot = 1.99520979169172 | epot = -23.0246775830826 | etot = -18.4829761427959 +671000 ekin = 2.3802025684166 | erot = 3.00742736998541 | epot = -23.0023479116088 | etot = -17.6147179732068 +672000 ekin = 3.0126952152146 | erot = 2.55297219144565 | epot = -22.9947723733502 | etot = -17.4291049666899 +673000 ekin = 3.39486270740071 | erot = 2.3808700262033 | epot = -22.9033457919095 | etot = -17.1276130583054 +674000 ekin = 3.13698489626099 | erot = 2.10609113054063 | epot = -22.8089270617647 | etot = -17.5658510349631 +675000 ekin = 2.32294130821675 | erot = 1.5285851482073 | epot = -22.6840603385672 | etot = -18.8325338821432 +676000 ekin = 2.43564726401376 | erot = 2.26860623636408 | epot = -22.6133446272028 | etot = -17.909091126825 +677000 ekin = 2.75162757613842 | erot = 1.94219014743457 | epot = -22.7039380847023 | etot = -18.0101203611293 +678000 ekin = 2.86321973687601 | erot = 1.66387788364136 | epot = -22.7223510604726 | etot = -18.1952534399553 +679000 ekin = 2.35079208772869 | erot = 2.70386328048641 | epot = -22.7977445343495 | etot = -17.7430891661344 +680000 ekin = 2.48449675729004 | erot = 2.90645575582477 | epot = -22.8559375688936 | etot = -17.4649850557788 +681000 ekin = 1.91581136662333 | erot = 2.58179603882022 | epot = -22.7891325966099 | etot = -18.2915251911664 +682000 ekin = 2.10466427353705 | erot = 2.69470735868807 | epot = -22.6959043279182 | etot = -17.896532695693 +683000 ekin = 2.34504535409021 | erot = 2.11592035700791 | epot = -22.5718670441909 | etot = -18.1109013330928 +684000 ekin = 2.87198876498958 | erot = 2.65732173958706 | epot = -22.4986977268025 | etot = -16.9693872222258 +685000 ekin = 3.03375238110975 | erot = 2.18190577381518 | epot = -22.4634189289575 | etot = -17.2477607740326 +686000 ekin = 2.46248931777656 | erot = 2.43025710170918 | epot = -22.4079029677658 | etot = -17.5151565482801 +687000 ekin = 2.74662486817896 | erot = 1.79609152562411 | epot = -22.3360381567114 | etot = -17.7933217629083 +688000 ekin = 1.81703718003042 | erot = 2.06511603415635 | epot = -22.3083758541198 | etot = -18.426222639933 +689000 ekin = 2.84202633430564 | erot = 1.92033962884777 | epot = -22.3752571185822 | etot = -17.6128911554288 +690000 ekin = 2.07525448405017 | erot = 2.46342632176817 | epot = -22.4633535431152 | etot = -17.9246727372969 +691000 ekin = 2.12558517800138 | erot = 2.52961097164 | epot = -22.483426266766 | etot = -17.8282301171246 +692000 ekin = 2.86720433292881 | erot = 2.65102150657025 | epot = -22.4003374064863 | etot = -16.8821115669873 +693000 ekin = 2.30143055084864 | erot = 2.52290946383361 | epot = -22.2859681228792 | etot = -17.4616281081969 +694000 ekin = 2.88400701080875 | erot = 2.34320802755437 | epot = -22.206318584282 | etot = -16.9791035459189 +695000 ekin = 2.93184722112895 | erot = 2.22933507376834 | epot = -22.2348177906806 | etot = -17.0736354957833 +696000 ekin = 2.63173546326796 | erot = 2.34275369570833 | epot = -22.274597219839 | etot = -17.3001080608627 +697000 ekin = 1.87084079501972 | erot = 1.78050094908734 | epot = -22.2730387150935 | etot = -18.6216969709865 +698000 ekin = 2.19791428580687 | erot = 2.82883581756349 | epot = -22.2819378523405 | etot = -17.2551877489701 +699000 ekin = 2.34279295545267 | erot = 2.07514436344563 | epot = -22.2061425261575 | etot = -17.7882052072592 +700000 ekin = 2.576803119019 | erot = 2.32167543064962 | epot = -22.1658685747825 | etot = -17.2673900251139 +701000 ekin = 2.9943865807539 | erot = 1.89982533986206 | epot = -22.2191193266439 | etot = -17.324907406028 +702000 ekin = 2.68548464757459 | erot = 2.65050744453208 | epot = -22.2547415922757 | etot = -16.918749500169 +703000 ekin = 2.01996957402024 | erot = 2.04032822241737 | epot = -22.3253693056515 | etot = -18.2650715092139 +704000 ekin = 1.58871069317829 | erot = 1.64014270467762 | epot = -22.3617232281452 | etot = -19.1328698302893 +705000 ekin = 2.3089415754982 | erot = 1.90252913035993 | epot = -22.4307958564623 | etot = -18.2193251506042 +706000 ekin = 2.61729186445574 | erot = 3.21879868039103 | epot = -22.5603358780911 | etot = -16.7242453332443 +707000 ekin = 2.60797107906866 | erot = 2.31455039977396 | epot = -22.7102471053997 | etot = -17.7877256265571 +708000 ekin = 1.81633850341999 | erot = 2.3482257566942 | epot = -22.841408787855 | etot = -18.6768445277408 +709000 ekin = 1.83541322105378 | erot = 2.51792380003796 | epot = -23.0137235815795 | etot = -18.6603865604878 +710000 ekin = 2.2142058326246 | erot = 1.92378721690473 | epot = -23.1433453130909 | etot = -19.0053522635615 +711000 ekin = 2.06744054454467 | erot = 2.3981170935319 | epot = -23.1532717948855 | etot = -18.687714156809 +712000 ekin = 2.1727947270635 | erot = 1.75362175342097 | epot = -23.0479262273955 | etot = -19.121509746911 +713000 ekin = 2.87118830138474 | erot = 1.54943993787555 | epot = -22.8430575230906 | etot = -18.4224292838303 +714000 ekin = 2.0107946674397 | erot = 1.87510988392751 | epot = -22.9212969433221 | etot = -19.0353923919549 +715000 ekin = 2.4992182958927 | erot = 1.91934008289236 | epot = -22.9679126658062 | etot = -18.5493542870211 +716000 ekin = 2.94666510633353 | erot = 2.18714442405523 | epot = -23.033997097429 | etot = -17.9001875670402 +717000 ekin = 3.07404079722085 | erot = 2.46628262765133 | epot = -23.1869721551174 | etot = -17.6466487302452 +718000 ekin = 3.47060078371109 | erot = 2.28206620506093 | epot = -23.2524492340768 | etot = -17.4997822453048 +719000 ekin = 4.08343792096552 | erot = 3.10429377075217 | epot = -23.2448292181926 | etot = -16.0570975264749 +720000 ekin = 2.52774819763971 | erot = 1.92867508904585 | epot = -23.1435084559682 | etot = -18.6870851692826 +721000 ekin = 2.58294244811584 | erot = 2.0383053178033 | epot = -23.0601633758883 | etot = -18.4389156099691 +722000 ekin = 1.9445888545086 | erot = 2.32008660802523 | epot = -22.9811929404572 | etot = -18.7165174779234 +723000 ekin = 2.41998340576259 | erot = 2.12369728979369 | epot = -23.0570939793876 | etot = -18.5134132838314 +724000 ekin = 1.90406371300861 | erot = 1.97533505769876 | epot = -23.1267629042383 | etot = -19.247364133531 +725000 ekin = 2.14287056473422 | erot = 2.79289687450022 | epot = -23.1695632046138 | etot = -18.2337957653794 +726000 ekin = 2.26423317099721 | erot = 2.55343019202652 | epot = -23.2432909083709 | etot = -18.4256275453472 +727000 ekin = 1.69816397656716 | erot = 2.64011919415556 | epot = -23.298837689321 | etot = -18.9605545185982 +728000 ekin = 2.23000862561934 | erot = 3.58521470578671 | epot = -23.3528245832467 | etot = -17.5376012518407 +729000 ekin = 2.70076566380343 | erot = 1.73367306410751 | epot = -23.3971276122796 | etot = -18.9626888843686 +730000 ekin = 2.54818673802759 | erot = 2.77394958410256 | epot = -23.3988686964744 | etot = -18.0767323743443 +731000 ekin = 2.69782550956093 | erot = 2.04855826523075 | epot = -23.4310969813891 | etot = -18.6847132065974 +732000 ekin = 2.79613002753752 | erot = 1.87867430486715 | epot = -23.4885161441653 | etot = -18.8137118117607 +733000 ekin = 2.20346728125046 | erot = 2.64365594749975 | epot = -23.5261309431819 | etot = -18.6790077144317 +734000 ekin = 1.69780111261443 | erot = 2.30917909560787 | epot = -23.5188046470475 | etot = -19.5118244388252 +735000 ekin = 2.18402736165936 | erot = 2.72051620230871 | epot = -23.4712689506938 | etot = -18.5667253867257 +736000 ekin = 2.26138696009404 | erot = 1.17083930058803 | epot = -23.4348107178754 | etot = -20.0025844571934 +737000 ekin = 2.22219419044796 | erot = 3.14114682990362 | epot = -23.3869288757725 | etot = -18.0235878554209 +738000 ekin = 1.75464981631084 | erot = 2.28485941478058 | epot = -23.2709893028052 | etot = -19.2314800717138 +739000 ekin = 1.41806378584362 | erot = 2.16714034112821 | epot = -23.2213775300889 | etot = -19.636173403117 +740000 ekin = 1.90901017596351 | erot = 2.27102763422491 | epot = -23.1829198366046 | etot = -19.0028820264162 +741000 ekin = 1.9930994487751 | erot = 2.73523269523399 | epot = -23.1169670577824 | etot = -18.3886349137733 +742000 ekin = 1.99876411117685 | erot = 1.89882876917754 | epot = -23.0300825800851 | etot = -19.1324896997307 +743000 ekin = 1.96472814667687 | erot = 2.79504722629174 | epot = -22.8990488521609 | etot = -18.1392734791923 +744000 ekin = 2.02442646092311 | erot = 2.35044838626024 | epot = -22.8186526150799 | etot = -18.4437777678966 +745000 ekin = 1.65344231988822 | erot = 1.87919095141018 | epot = -22.7624827109091 | etot = -19.2298494396107 +746000 ekin = 2.1034668185472 | erot = 2.03078530569663 | epot = -22.743454277698 | etot = -18.6092021534542 +747000 ekin = 3.06690414848489 | erot = 1.6754029786949 | epot = -22.7625979159322 | etot = -18.0202907887524 +748000 ekin = 3.06965414483401 | erot = 1.86014593098643 | epot = -22.8118567150739 | etot = -17.8820566392535 +749000 ekin = 2.53718696167217 | erot = 2.02710579059033 | epot = -22.8431046011969 | etot = -18.2788118489344 +750000 ekin = 2.75657354808099 | erot = 2.34953156046291 | epot = -22.9548205390759 | etot = -17.848715430532 +751000 ekin = 2.52290020835147 | erot = 2.34873763599977 | epot = -23.0238691402084 | etot = -18.1522312958572 +752000 ekin = 2.47222247869325 | erot = 1.68679846444683 | epot = -22.9958559112491 | etot = -18.8368349681091 +753000 ekin = 2.48263277172423 | erot = 1.54669382815742 | epot = -23.0858212396418 | etot = -19.0564946397602 +754000 ekin = 2.54806257410878 | erot = 2.26636466676163 | epot = -23.1896472696842 | etot = -18.3752200288138 +755000 ekin = 1.53168409517921 | erot = 2.22665478278013 | epot = -23.2059118234918 | etot = -19.4475729455324 +756000 ekin = 2.10751715527953 | erot = 2.40525774326678 | epot = -23.114150245375 | etot = -18.6013753468287 +757000 ekin = 2.93395895491028 | erot = 2.05821177584909 | epot = -23.0783355599275 | etot = -18.0861648291682 +758000 ekin = 2.38307945406232 | erot = 2.50598165375058 | epot = -22.9691152621287 | etot = -18.0800541543158 +759000 ekin = 2.60292884338835 | erot = 2.36916677072548 | epot = -22.7987274767845 | etot = -17.8266318626707 +760000 ekin = 3.2284318196987 | erot = 2.73822716520638 | epot = -22.6756147646272 | etot = -16.7089557797221 +761000 ekin = 3.41868727786494 | erot = 1.68975765213408 | epot = -22.5638952547581 | etot = -17.4554503247591 +762000 ekin = 3.43033946346107 | erot = 2.5283975140253 | epot = -22.3549032489322 | etot = -16.3961662714458 +763000 ekin = 2.65773094814485 | erot = 1.83975133975562 | epot = -22.234833339183 | etot = -17.7373510512825 +764000 ekin = 2.3815484472129 | erot = 2.70684992442147 | epot = -22.0890752688231 | etot = -17.0006768971887 +765000 ekin = 2.23212803588897 | erot = 1.94868597739427 | epot = -21.9918715237933 | etot = -17.81105751051 +766000 ekin = 2.49097891886066 | erot = 1.96764603993156 | epot = -21.8443436680801 | etot = -17.3857187092879 +767000 ekin = 2.3457921497675 | erot = 2.64636009163513 | epot = -21.7634962034012 | etot = -16.7713439619986 +768000 ekin = 1.87671147825106 | erot = 2.05549869178485 | epot = -21.7324638416528 | etot = -17.8002536716169 +769000 ekin = 3.05058687860239 | erot = 2.66104171022372 | epot = -21.66792195987 | etot = -15.9562933710439 +770000 ekin = 2.44115683640633 | erot = 1.97554932479751 | epot = -21.6448820664751 | etot = -17.2281759052712 +771000 ekin = 2.23687464004429 | erot = 2.55040970708789 | epot = -21.5811924169692 | etot = -16.793908069837 +772000 ekin = 2.76529680592008 | erot = 1.97873499811185 | epot = -21.6543448952384 | etot = -16.9103130912064 +773000 ekin = 2.14632888240094 | erot = 2.41330587525514 | epot = -21.7728828090228 | etot = -17.2132480513667 +774000 ekin = 2.19848545803079 | erot = 1.9765131024719 | epot = -21.8398858604883 | etot = -17.6648872999856 +775000 ekin = 2.52300137989083 | erot = 2.80935365273515 | epot = -22.0219985274259 | etot = -16.6896434947999 +776000 ekin = 3.15842485269274 | erot = 2.47066157093645 | epot = -22.183029096161 | etot = -16.5539426725319 +777000 ekin = 1.91784338934576 | erot = 1.76045300517081 | epot = -22.2259652888115 | etot = -18.547668894295 +778000 ekin = 2.93738066043324 | erot = 2.29457842490289 | epot = -22.2339481852394 | etot = -17.0019890999032 +779000 ekin = 3.09847206114319 | erot = 2.0455771700605 | epot = -22.240438366259 | etot = -17.0963891350553 +780000 ekin = 2.86127568397807 | erot = 3.12055135138658 | epot = -22.1865692766137 | etot = -16.204742241249 +781000 ekin = 2.36069914420785 | erot = 3.53186431088487 | epot = -22.1210563364352 | etot = -16.2284928813425 +782000 ekin = 2.31592690319261 | erot = 2.85730598644035 | epot = -22.0302855151548 | etot = -16.8570526255218 +783000 ekin = 1.86647729944746 | erot = 3.03450246093099 | epot = -21.886014367949 | etot = -16.9850346075705 +784000 ekin = 2.04055627573201 | erot = 2.26047908607293 | epot = -21.7534271639393 | etot = -17.4523918021343 +785000 ekin = 2.02248469828703 | erot = 2.13950421850547 | epot = -21.6318967501918 | etot = -17.4699078333993 +786000 ekin = 2.34211746551602 | erot = 2.34838133643265 | epot = -21.5890308210084 | etot = -16.8985320190598 +787000 ekin = 2.74971447554938 | erot = 2.24123553296042 | epot = -21.5192132515563 | etot = -16.5282632430465 +788000 ekin = 2.14142056672039 | erot = 2.27008574684965 | epot = -21.4982362621714 | etot = -17.0867299486013 +789000 ekin = 1.98580913341303 | erot = 2.00702444041791 | epot = -21.5235331659838 | etot = -17.5306995921529 +790000 ekin = 1.68578263083924 | erot = 1.43485602862151 | epot = -21.6440081593601 | etot = -18.5233694998993 +791000 ekin = 2.13583938840528 | erot = 2.5373009545894 | epot = -21.7916440698418 | etot = -17.1185037268471 +792000 ekin = 1.71937483898028 | erot = 2.19563804216011 | epot = -21.8794946709408 | etot = -17.9644817898004 +793000 ekin = 3.15868943755338 | erot = 1.94575875708421 | epot = -22.0398145404617 | etot = -16.9353663458242 +794000 ekin = 2.45478602538954 | erot = 3.00825554959563 | epot = -22.0843165283013 | etot = -16.6212749533161 +795000 ekin = 2.87760320917193 | erot = 3.06920266633565 | epot = -22.1595628991904 | etot = -16.2127570236829 +796000 ekin = 2.29816690595058 | erot = 1.61510864654315 | epot = -22.1869705548184 | etot = -18.2736950023247 +797000 ekin = 2.1901525606721 | erot = 3.65734446008353 | epot = -22.1432608090644 | etot = -16.2957637883088 +798000 ekin = 2.12018787925578 | erot = 2.92822258455555 | epot = -22.1311312789224 | etot = -17.0827208151111 +799000 ekin = 2.49416140154829 | erot = 2.73328283280216 | epot = -22.0825726051882 | etot = -16.8551283708378 +800000 ekin = 2.18932007838552 | erot = 2.97640731559393 | epot = -21.979362152191 | etot = -16.8136347582115 +801000 ekin = 2.58827112124838 | erot = 2.7440442483726 | epot = -21.9108490336924 | etot = -16.5785336640714 +802000 ekin = 3.07870342348167 | erot = 2.87961505564287 | epot = -21.822560433681 | etot = -15.8642419545565 +803000 ekin = 2.2398624368064 | erot = 2.50525058807596 | epot = -21.72759408181 | etot = -16.9824810569277 +804000 ekin = 2.91885860068426 | erot = 1.57889040451428 | epot = -21.6896376725624 | etot = -17.1918886673638 +805000 ekin = 2.68277363980193 | erot = 3.05527868915738 | epot = -21.6710764398127 | etot = -15.9330241108534 +806000 ekin = 2.77769607049014 | erot = 2.1888727690908 | epot = -21.6314833902337 | etot = -16.6649145506527 +807000 ekin = 2.12673239079668 | erot = 2.86003407600806 | epot = -21.7295924017744 | etot = -16.7428259349697 +808000 ekin = 1.89599614774678 | erot = 2.29237053227662 | epot = -21.7511361510417 | etot = -17.5627694710183 +809000 ekin = 1.96405066221971 | erot = 1.92110393348368 | epot = -21.7075506883706 | etot = -17.8223960926672 +810000 ekin = 2.01518137594275 | erot = 2.60119247286596 | epot = -21.6788385874729 | etot = -17.0624647386642 +811000 ekin = 2.31084800889289 | erot = 1.75270367309064 | epot = -21.6837819033719 | etot = -17.6202302213883 +812000 ekin = 2.5770103100209 | erot = 2.34932304073588 | epot = -21.7246716033188 | etot = -16.798338252562 +813000 ekin = 2.87706904926076 | erot = 2.35686610624154 | epot = -21.8375922236049 | etot = -16.6036570681026 +814000 ekin = 2.89908405023866 | erot = 2.31423299883226 | epot = -21.8379261473901 | etot = -16.6246090983192 +815000 ekin = 2.54050064212256 | erot = 2.82732568868829 | epot = -21.6068952707049 | etot = -16.2390689398941 +816000 ekin = 2.17040404256387 | erot = 2.53711088209172 | epot = -21.5560322071983 | etot = -16.8485172825427 +817000 ekin = 1.7842696071831 | erot = 2.67810959410576 | epot = -21.8738878035325 | etot = -17.4115086022437 +818000 ekin = 2.29659398017838 | erot = 2.63718862373664 | epot = -22.164277271391 | etot = -17.230494667476 +819000 ekin = 2.15801167884062 | erot = 2.62095572928877 | epot = -22.1816109590116 | etot = -17.4026435508822 +820000 ekin = 1.94384548213955 | erot = 2.28597987799275 | epot = -22.0986187375022 | etot = -17.8687933773699 +821000 ekin = 2.10513194007576 | erot = 2.38698175569219 | epot = -22.1146754444785 | etot = -17.6225617487105 +822000 ekin = 2.24819716786441 | erot = 2.15258805680875 | epot = -22.0539472940486 | etot = -17.6531620693754 +823000 ekin = 2.26584952085583 | erot = 2.60619852526611 | epot = -22.0924201800579 | etot = -17.220372133936 +824000 ekin = 1.65187935478514 | erot = 1.48703119037228 | epot = -22.1682955997986 | etot = -19.0293850546412 +825000 ekin = 1.60213094818648 | erot = 1.98592524368393 | epot = -22.1687104063708 | etot = -18.5806542145004 +826000 ekin = 1.97430720107255 | erot = 2.19175014677159 | epot = -22.1061881978655 | etot = -17.9401308500213 +827000 ekin = 2.1793755983405 | erot = 2.44975419075935 | epot = -21.9704586607304 | etot = -17.3413288716305 +828000 ekin = 1.90399088418588 | erot = 2.72532994798816 | epot = -21.9585923270583 | etot = -17.3292714948842 +829000 ekin = 2.06478103068884 | erot = 2.9658303540259 | epot = -21.9849402038682 | etot = -16.9543288191534 +830000 ekin = 1.98920675238979 | erot = 2.15331250444996 | epot = -22.0339146439702 | etot = -17.8913953871305 +831000 ekin = 2.33567462674689 | erot = 2.36888807413497 | epot = -22.1271573756461 | etot = -17.4225946747643 +832000 ekin = 2.0119470999192 | erot = 1.94769143293625 | epot = -22.2038482709588 | etot = -18.2442097381034 +833000 ekin = 2.26025933495881 | erot = 2.16012558191462 | epot = -22.2882501045414 | etot = -17.867865187668 +834000 ekin = 2.11529426445865 | erot = 1.52405523315358 | epot = -22.3075608649826 | etot = -18.6682113673703 +835000 ekin = 2.8992075090551 | erot = 2.73801081751029 | epot = -22.3942491248321 | etot = -16.7570307982667 +836000 ekin = 3.33069528982658 | erot = 2.4277126780786 | epot = -22.4321737300744 | etot = -16.6737657621692 +837000 ekin = 2.74831774333782 | erot = 2.31991750378628 | epot = -22.4290234552872 | etot = -17.3607882081631 +838000 ekin = 3.13714871682188 | erot = 3.21601751721777 | epot = -22.4642383906451 | etot = -16.1110721566054 +839000 ekin = 2.73358272751807 | erot = 2.60144488190506 | epot = -22.4062682687368 | etot = -17.0712406593137 +840000 ekin = 2.96121930874637 | erot = 1.42725942278118 | epot = -22.3293755621294 | etot = -17.9408968306018 +841000 ekin = 2.95134811170866 | erot = 2.67666861874608 | epot = -22.2936348151224 | etot = -16.6656180846677 +842000 ekin = 2.15783928636401 | erot = 2.30287195796693 | epot = -22.2978011147172 | etot = -17.8370898703863 +843000 ekin = 2.84565152669617 | erot = 2.0510801477514 | epot = -22.3162908719779 | etot = -17.4195591975303 +844000 ekin = 2.99645803669157 | erot = 1.50433298006521 | epot = -22.3768320579304 | etot = -17.8760410411736 +845000 ekin = 3.20248025697125 | erot = 2.27246140825564 | epot = -22.3985708422076 | etot = -16.9236291769807 +846000 ekin = 3.35773945734322 | erot = 2.54074745551552 | epot = -22.4144833015876 | etot = -16.5159963887289 +847000 ekin = 2.17779203733109 | erot = 2.73817581188461 | epot = -22.3524825149514 | etot = -17.4365146657357 +848000 ekin = 2.51627348417144 | erot = 2.81170686694717 | epot = -22.2066307862469 | etot = -16.8786504351283 +849000 ekin = 1.99679455190557 | erot = 2.56855846773092 | epot = -22.0763062134929 | etot = -17.5109531938564 +850000 ekin = 2.05799123916876 | erot = 1.80888056240785 | epot = -22.0665032506706 | etot = -18.1996314490939 +851000 ekin = 2.0888979376792 | erot = 1.86172181790289 | epot = -22.0629711763889 | etot = -18.1123514208068 +852000 ekin = 1.68990805178902 | erot = 1.42763535981882 | epot = -22.002100112701 | etot = -18.8845567010931 +853000 ekin = 1.99310886654811 | erot = 3.05226969048292 | epot = -22.0306903552278 | etot = -16.9853117981968 +854000 ekin = 2.98378700534986 | erot = 2.2310274524054 | epot = -22.1115820238811 | etot = -16.8967675661258 +855000 ekin = 2.17087415585277 | erot = 2.8378147226879 | epot = -22.1115106395971 | etot = -17.1028217610564 +856000 ekin = 2.42228475387308 | erot = 1.53328604594478 | epot = -22.0841888628209 | etot = -18.128618063003 +857000 ekin = 2.50431566526894 | erot = 2.80498769176516 | epot = -21.9881235267534 | etot = -16.6788201697193 +858000 ekin = 2.17333686672378 | erot = 2.8259111550717 | epot = -21.9093201368614 | etot = -16.9100721150659 +859000 ekin = 2.29930070497243 | erot = 2.32417368939061 | epot = -21.8849849636104 | etot = -17.2615105692473 +860000 ekin = 1.99153024057672 | erot = 1.94674638600151 | epot = -21.8998709373217 | etot = -17.9615943107434 +861000 ekin = 2.69177523559624 | erot = 2.23997750036373 | epot = -21.8915522194994 | etot = -16.9597994835394 +862000 ekin = 2.86117050047984 | erot = 2.41530060322761 | epot = -21.876687883023 | etot = -16.6002167793156 +863000 ekin = 2.59841547044276 | erot = 3.3501705008543 | epot = -21.8162649771437 | etot = -15.8676790058467 +864000 ekin = 2.92496272611018 | erot = 2.30350236144453 | epot = -21.7820358973268 | etot = -16.5535708097721 +865000 ekin = 1.94718216128952 | erot = 2.16572180916633 | epot = -21.7000823492195 | etot = -17.5871783787636 +866000 ekin = 1.99006127871689 | erot = 1.65011901234952 | epot = -21.6190182409268 | etot = -17.9788379498604 +867000 ekin = 1.76250718110787 | erot = 3.37958608370307 | epot = -21.5401486584561 | etot = -16.3980553936452 +868000 ekin = 1.845623450314 | erot = 2.78812196028616 | epot = -21.5771917352235 | etot = -16.9434463246234 +869000 ekin = 2.39300849969205 | erot = 2.38301618173176 | epot = -21.6710790825578 | etot = -16.895054401134 +870000 ekin = 1.91899243212541 | erot = 3.22222440717393 | epot = -21.6734733803871 | etot = -16.5322565410878 +871000 ekin = 3.10255827845531 | erot = 2.95454268850896 | epot = -21.5913249106744 | etot = -15.5342239437101 +872000 ekin = 2.94582883077842 | erot = 1.38261935263093 | epot = -21.4597055547833 | etot = -17.1312573713739 +873000 ekin = 2.72830997927423 | erot = 2.23223699637274 | epot = -21.3657566950046 | etot = -16.4052097193577 +874000 ekin = 2.41464704842015 | erot = 2.10351476791496 | epot = -21.2635161734954 | etot = -16.7453543571603 +875000 ekin = 2.99468455803482 | erot = 2.72761242382524 | epot = -21.2488881289381 | etot = -15.526591147078 +876000 ekin = 2.13382009818493 | erot = 2.23152059294678 | epot = -21.2388603913311 | etot = -16.8735197001994 +877000 ekin = 1.839391763993 | erot = 1.607279977226 | epot = -21.2015948102408 | etot = -17.7549230690218 +878000 ekin = 2.01267175782178 | erot = 2.73109796378376 | epot = -21.2125253160263 | etot = -16.4687555944208 +879000 ekin = 1.42911941081343 | erot = 2.17371661448622 | epot = -21.1345316334464 | etot = -17.5316956081468 +880000 ekin = 2.10605339224633 | erot = 2.5884751778913 | epot = -21.0787246891645 | etot = -16.3841961190269 +881000 ekin = 1.54924791070118 | erot = 2.0068513915418 | epot = -21.1356465207066 | etot = -17.5795472184637 +882000 ekin = 2.199643157135 | erot = 2.65509097106007 | epot = -21.2389026935677 | etot = -16.3841685653726 +883000 ekin = 2.20850404171077 | erot = 2.22833605977577 | epot = -21.3067394383395 | etot = -16.869899336853 +884000 ekin = 2.76978562647275 | erot = 2.10395845939756 | epot = -21.3429618615585 | etot = -16.4692177756882 +885000 ekin = 1.93339807672781 | erot = 1.77156241344967 | epot = -21.3858074096933 | etot = -17.6808469195158 +886000 ekin = 2.00408769971894 | erot = 3.10736267931439 | epot = -21.3935346347812 | etot = -16.2820842557479 +887000 ekin = 1.96987943750801 | erot = 2.82035886899744 | epot = -21.3967073105593 | etot = -16.6064690040538 +888000 ekin = 1.91464371566411 | erot = 2.33371232948867 | epot = -21.4767119016419 | etot = -17.2283558564891 +889000 ekin = 1.88227414130201 | erot = 2.45915914930408 | epot = -21.5790392436829 | etot = -17.2376059530768 +890000 ekin = 1.84515176532447 | erot = 2.24992378831499 | epot = -21.6747594004542 | etot = -17.5796838468148 +891000 ekin = 2.6016566869706 | erot = 2.34500453305753 | epot = -21.8016735536793 | etot = -16.8550123336512 +892000 ekin = 2.71287751886859 | erot = 2.69544224573131 | epot = -21.9063749565585 | etot = -16.4980551919586 +893000 ekin = 2.17862714611329 | erot = 2.98452123742221 | epot = -21.9155556335137 | etot = -16.7524072499782 +894000 ekin = 2.52079948361477 | erot = 2.46355933674925 | epot = -21.915110079455 | etot = -16.930751259091 +895000 ekin = 2.53566097944338 | erot = 2.4513045444294 | epot = -21.947786087834 | etot = -16.9608205639612 +896000 ekin = 1.84455393639213 | erot = 2.77499090684945 | epot = -21.9167554809878 | etot = -17.2972106377463 +897000 ekin = 2.38519326880694 | erot = 2.019802873173 | epot = -21.8644918203993 | etot = -17.4594956784193 +898000 ekin = 2.14354914407572 | erot = 1.89196669459414 | epot = -21.7953104274974 | etot = -17.7597945888276 +899000 ekin = 2.65485657727374 | erot = 2.3237456003819 | epot = -21.6964754705568 | etot = -16.7178732929012 +900000 ekin = 2.1437154528087 | erot = 2.28119066740275 | epot = -21.6934954112434 | etot = -17.2685892910319 +901000 ekin = 1.93965814946881 | erot = 1.81495571440908 | epot = -21.7369092433376 | etot = -17.9822953794597 +902000 ekin = 2.60993957981555 | erot = 2.50321386623391 | epot = -21.6842517568354 | etot = -16.571098310786 +903000 ekin = 1.87484955546757 | erot = 2.17008893987962 | epot = -21.6383913984978 | etot = -17.5934529031506 +904000 ekin = 1.87454064845764 | erot = 2.32484081519398 | epot = -21.5866637125315 | etot = -17.3872822488799 +905000 ekin = 2.31407473814844 | erot = 2.15094868542391 | epot = -21.5154415841816 | etot = -17.0504181606093 +906000 ekin = 2.49583383758853 | erot = 2.25091096848461 | epot = -21.5170853902294 | etot = -16.7703405841563 +907000 ekin = 4.19798796104344 | erot = 2.5030532322807 | epot = -21.5976736513859 | etot = -14.8966324580618 +908000 ekin = 3.26730891548756 | erot = 2.11222217905481 | epot = -21.7526644402476 | etot = -16.3731333457052 +909000 ekin = 2.64106561110374 | erot = 1.92197432194202 | epot = -21.8748043207924 | etot = -17.3117643877467 +910000 ekin = 2.61805562731904 | erot = 2.90737422678703 | epot = -21.9709470207745 | etot = -16.4455171666685 +911000 ekin = 2.62012718860141 | erot = 4.35318528241844 | epot = -22.0282478750366 | etot = -15.0549354040167 +912000 ekin = 3.07628909273118 | erot = 3.69371809788395 | epot = -22.0511180009901 | etot = -15.281110810375 +913000 ekin = 2.82956898268831 | erot = 2.17078429141201 | epot = -22.0149543706266 | etot = -17.0146010965263 +914000 ekin = 2.16386655780066 | erot = 1.22303673036133 | epot = -21.9243495493208 | etot = -18.5374462611589 +915000 ekin = 1.59447095066509 | erot = 2.95966391292002 | epot = -21.8264580452026 | etot = -17.2723231816175 +916000 ekin = 2.58365539107523 | erot = 3.75147270955029 | epot = -21.8922962938608 | etot = -15.5571681932352 +917000 ekin = 3.01643029206973 | erot = 2.88035639021004 | epot = -21.9150526568514 | etot = -16.0182659745717 +918000 ekin = 2.89929776900147 | erot = 2.64137394041291 | epot = -21.9078998623094 | etot = -16.367228152895 +919000 ekin = 3.20476671865012 | erot = 2.76036957969153 | epot = -21.8878055443404 | etot = -15.9226692459988 +920000 ekin = 2.28949350558683 | erot = 2.38558870046816 | epot = -21.8659406759967 | etot = -17.1908584699418 +921000 ekin = 2.39158312157105 | erot = 2.44959700788167 | epot = -21.8638974869225 | etot = -17.0227173574697 +922000 ekin = 2.30678787768012 | erot = 2.42145678067298 | epot = -21.8218369909645 | etot = -17.0935923326114 +923000 ekin = 2.49697778842282 | erot = 2.66565493744118 | epot = -21.8078634464733 | etot = -16.6452307206093 +924000 ekin = 1.55676047489501 | erot = 2.97115254541007 | epot = -21.7829722234117 | etot = -17.2550592031067 +925000 ekin = 1.86603413909288 | erot = 1.96274861601779 | epot = -21.7288604040749 | etot = -17.9000776489642 +926000 ekin = 1.36993364395821 | erot = 2.11749584641399 | epot = -21.7083442855147 | etot = -18.2209147951426 +927000 ekin = 2.55718977538496 | erot = 2.08109095048881 | epot = -21.7242353526192 | etot = -17.0859546267455 +928000 ekin = 2.0974272910786 | erot = 2.73922911267236 | epot = -21.7673808868819 | etot = -16.9307244831309 +929000 ekin = 1.85550591174834 | erot = 1.84990976935039 | epot = -21.8639426090857 | etot = -18.158526927987 +930000 ekin = 1.99594723517184 | erot = 2.09151231016387 | epot = -21.8461015073053 | etot = -17.7586419619696 +931000 ekin = 2.45331651079283 | erot = 1.86703658018613 | epot = -21.7382799817762 | etot = -17.4179268907972 +932000 ekin = 2.76909250526759 | erot = 2.34990175754269 | epot = -21.7639792890094 | etot = -16.6449850261991 +933000 ekin = 3.04747366335481 | erot = 2.52740756503515 | epot = -21.6783727845496 | etot = -16.1034915561597 +934000 ekin = 2.93463275640818 | erot = 2.48893095891026 | epot = -21.5784996926914 | etot = -16.1549359773729 +935000 ekin = 2.77799347567549 | erot = 2.1392935841225 | epot = -21.5334239467005 | etot = -16.6161368869025 +936000 ekin = 2.96529953690398 | erot = 2.07095365726714 | epot = -21.5249249864244 | etot = -16.4886717922533 +937000 ekin = 3.0485053770175 | erot = 2.32432162998051 | epot = -21.4386642161072 | etot = -16.0658372091092 +938000 ekin = 2.9926262850536 | erot = 2.35224559307843 | epot = -21.3457080466208 | etot = -16.0008361684887 +939000 ekin = 2.61238181353703 | erot = 2.26780356837292 | epot = -21.3079422537804 | etot = -16.4277568718705 +940000 ekin = 2.65930112044942 | erot = 2.75497479722395 | epot = -21.2170493356504 | etot = -15.802773417977 +941000 ekin = 2.27574261339217 | erot = 2.61419196501686 | epot = -21.1297657597673 | etot = -16.2398311813583 +942000 ekin = 1.89172011891055 | erot = 2.82029488513784 | epot = -21.0410099256114 | etot = -16.328994921563 +943000 ekin = 2.47643464476757 | erot = 2.34737109151876 | epot = -21.046668772798 | etot = -16.2228630365117 +944000 ekin = 2.13883995897326 | erot = 1.92577316206138 | epot = -21.0114219746514 | etot = -16.9468088536167 +945000 ekin = 2.57768697869113 | erot = 2.21470136124069 | epot = -21.0634624131725 | etot = -16.2710740732407 +946000 ekin = 2.36420709243625 | erot = 2.89647330776424 | epot = -21.088814693033 | etot = -15.8281342928325 +947000 ekin = 2.07104171538467 | erot = 1.86575631327232 | epot = -21.1004860950452 | etot = -17.1636880663882 +948000 ekin = 1.85532958802997 | erot = 1.36952834086551 | epot = -21.1364231315616 | etot = -17.9115652026661 +949000 ekin = 1.76206591178366 | erot = 2.31737328558629 | epot = -21.1463744779337 | etot = -17.0669352805638 +950000 ekin = 1.72021033353108 | erot = 2.24191394295309 | epot = -21.1376324866856 | etot = -17.1755082102014 +951000 ekin = 1.96140007830504 | erot = 2.32248863487758 | epot = -21.1955927656813 | etot = -16.9117040524987 +952000 ekin = 2.93256201500608 | erot = 2.74550490827503 | epot = -21.234781024541 | etot = -15.5567141012599 +953000 ekin = 2.95031285986317 | erot = 2.39822873263993 | epot = -21.252609183133 | etot = -15.9040675906299 +954000 ekin = 3.09579074538114 | erot = 1.98159252445734 | epot = -21.1641538136742 | etot = -16.0867705438357 +955000 ekin = 3.59360323486038 | erot = 2.06789679071821 | epot = -21.0522880782498 | etot = -15.3907880526712 +956000 ekin = 2.97416074498497 | erot = 3.66953591785751 | epot = -20.9097603766373 | etot = -14.2660637137948 +957000 ekin = 3.03140562067951 | erot = 2.66078083760708 | epot = -20.741905867784 | etot = -15.0497194094974 +958000 ekin = 2.68913434704072 | erot = 2.94057112873834 | epot = -20.5488384129041 | etot = -14.9191329371251 +959000 ekin = 1.93264217407773 | erot = 2.45198406257092 | epot = -20.468781161493 | etot = -16.0841549248444 +960000 ekin = 1.49632279167952 | erot = 3.13346348599987 | epot = -20.4844974178568 | etot = -15.8547111401774 +961000 ekin = 1.96353429663481 | erot = 2.07553358516994 | epot = -20.4805590123497 | etot = -16.441491130545 +962000 ekin = 2.02830196392007 | erot = 1.88908496389356 | epot = -20.5374211599971 | etot = -16.6200342321835 +963000 ekin = 1.80829526034561 | erot = 2.46258345726267 | epot = -20.5841835730967 | etot = -16.3133048554884 +964000 ekin = 2.79449124937198 | erot = 2.42527551362846 | epot = -20.623880544448 | etot = -15.4041137814476 +965000 ekin = 2.53493670506137 | erot = 2.27804362684503 | epot = -20.6549300812151 | etot = -15.8419497493087 +966000 ekin = 2.0920817650402 | erot = 2.27478990703181 | epot = -20.704473904241 | etot = -16.337602232169 +967000 ekin = 1.55562260797661 | erot = 3.55543363172458 | epot = -20.739375276301 | etot = -15.6283190365998 +968000 ekin = 1.93439891222236 | erot = 2.37295903815892 | epot = -20.7189229543385 | etot = -16.4115650039572 +969000 ekin = 2.16199728898303 | erot = 2.4601205252494 | epot = -20.6747113173023 | etot = -16.0525935030699 +970000 ekin = 1.84926216722517 | erot = 2.96951777569267 | epot = -20.6011599981509 | etot = -15.7823800552331 +971000 ekin = 1.93656411083027 | erot = 3.08724923997924 | epot = -20.5835250734812 | etot = -15.5597117226717 +972000 ekin = 1.90452783927713 | erot = 2.5823076678316 | epot = -20.5782905980209 | etot = -16.0914550909122 +973000 ekin = 2.1922712122506 | erot = 2.92686386394502 | epot = -20.5868173702649 | etot = -15.4676822940693 +974000 ekin = 2.53094641465528 | erot = 2.69271305556795 | epot = -20.5382547781502 | etot = -15.314595307927 +975000 ekin = 3.41187201669925 | erot = 2.32917219553093 | epot = -20.5109803919917 | etot = -14.7699361797616 +976000 ekin = 2.88156114272554 | erot = 3.10474521611246 | epot = -20.5158119249461 | etot = -14.5295055661081 +977000 ekin = 2.73962881168093 | erot = 2.50884169958543 | epot = -20.4964590297999 | etot = -15.2479885185336 +978000 ekin = 1.79682802545478 | erot = 2.06924041504343 | epot = -20.4730821934977 | etot = -16.6070137529995 +979000 ekin = 1.86521389998383 | erot = 2.22151626929011 | epot = -20.4069392895634 | etot = -16.3202091202894 +980000 ekin = 1.92383169177414 | erot = 1.56425965548877 | epot = -20.3533353734708 | etot = -16.8652440262079 +981000 ekin = 1.55110199282939 | erot = 2.05381225133935 | epot = -20.3970890782076 | etot = -16.7921748340389 +982000 ekin = 1.85559395816058 | erot = 1.96991369841493 | epot = -20.499354149896 | etot = -16.6738464933205 +983000 ekin = 2.75061857015333 | erot = 1.7944840218308 | epot = -20.5241519929378 | etot = -15.9790494009537 +984000 ekin = 3.65069712553537 | erot = 2.64237329124733 | epot = -20.6374699142712 | etot = -14.3443994974885 +985000 ekin = 2.9563732193106 | erot = 2.18846412126773 | epot = -20.8122975273334 | etot = -15.6674601867551 +986000 ekin = 2.87072902054599 | erot = 2.18810434250119 | epot = -20.9390290724605 | etot = -15.8801957094134 +987000 ekin = 3.37463328642758 | erot = 2.5371366667467 | epot = -21.0098323012658 | etot = -15.0980623480916 +988000 ekin = 3.45107854450338 | erot = 3.23625536313169 | epot = -21.0554260480417 | etot = -14.3680921404067 +989000 ekin = 2.83591404363756 | erot = 2.20564156324817 | epot = -21.19499265416 | etot = -16.1534370472743 +990000 ekin = 2.79864389348437 | erot = 1.83178426663539 | epot = -21.1880268304373 | etot = -16.5575986703175 +991000 ekin = 3.14781925181036 | erot = 3.2078247180891 | epot = -21.1115234865128 | etot = -14.7558795166133 +992000 ekin = 3.30033725309946 | erot = 2.62749912694387 | epot = -21.0030296251662 | etot = -15.0751932451229 +993000 ekin = 3.07374297249949 | erot = 2.22697230616356 | epot = -20.9385586572609 | etot = -15.6378433785979 +994000 ekin = 3.21461776403449 | erot = 2.80599707993708 | epot = -20.8790524582442 | etot = -14.8584376142727 +995000 ekin = 3.25071478747345 | erot = 1.73415439498321 | epot = -20.8037804714002 | etot = -15.8189112889436 +996000 ekin = 3.07999632962569 | erot = 3.18107550500824 | epot = -20.7805295335828 | etot = -14.5194576989488 +997000 ekin = 2.97118118001025 | erot = 3.14046656474894 | epot = -20.7334885248756 | etot = -14.6218407801164 +998000 ekin = 3.09169861594907 | erot = 1.99060706981745 | epot = -20.6553134096535 | etot = -15.573007723887 +999000 ekin = 2.07498130576584 | erot = 2.75045972766921 | epot = -20.616091526295 | etot = -15.79065049286 +1000000 ekin = 2.07851119592057 | erot = 2.11869313853035 | epot = -20.4539417072875 | etot = -16.2567373728366 + 1000000 0.092378275 -1.3359709 0.057599499 -1.1484644 2.8477973e-05 +Loop time of 38.201 on 1 procs for 1000000 steps with 16 atoms + +Performance: 22617.237 tau/day, 26177.358 timesteps/s +98.6% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 27.344 | 27.344 | 27.344 | 0.0 | 71.58 +Bond | 0.88043 | 0.88043 | 0.88043 | 0.0 | 2.30 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.2073 | 0.2073 | 0.2073 | 0.0 | 0.54 +Output | 7e-06 | 7e-06 | 7e-06 | 0.0 | 0.00 +Modify | 9.4379 | 9.4379 | 9.4379 | 0.0 | 24.71 +Other | | 0.331 | | | 0.87 + +Nlocal: 16 ave 16 max 16 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 88 ave 88 max 88 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 88 +Ave neighs/atom = 5.5 +Ave special neighs/atom = 3.75 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:38 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.4 b/examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.4 new file mode 100644 index 0000000000..3010570379 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA/duplex2/log.18Jun19.duplex2.g++.4 @@ -0,0 +1,1167 @@ +LAMMPS (18 Jun 2019) +variable number equal 2 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex2 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 16 atoms + reading velocities ... + 16 velocities + 16 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 13 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 4 = max # of 1-4 neighbors + 6 = max # of special neighbors + special bonds CPU = 0.000189 secs + read_data CPU = 0.003505 secs + +set atom * mass 3.1575 + 16 settings made for mass + +group all type 1 4 +16 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna/fene +bond_coeff * 2.0 0.25 0.7525 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk +pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna/stk seqav ${T} 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/stk seqav 0.1 1.3448 2.6568 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 + +# NVE ensemble +#fix 1 all nve/dot +fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.92828 + ghost atom cutoff = 1.92828 + binsize = 0.964142, bins = 42 42 42 + 5 neighbor lists, perpetual/occasional/extra = 5 0 0 + (1) pair oxdna/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.466 | 7.648 | 7.83 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.5402493 0.0070469125 -1.5332024 6.0760034e-06 +1000 ekin = 1.34565986428024 | erot = 2.31051421234078 | epot = -24.5061991591502 | etot = -20.8500250825292 +2000 ekin = 2.15911766687235 | erot = 2.16031365874706 | epot = -24.4723177103698 | etot = -20.1528863847504 +3000 ekin = 3.26561948796015 | erot = 2.75651822936605 | epot = -24.412573068346 | etot = -18.3904353510198 +4000 ekin = 1.92438809241066 | erot = 2.12016940074985 | epot = -24.3496233970111 | etot = -20.3050659038505 +5000 ekin = 1.35986357015476 | erot = 1.99413493074226 | epot = -24.2789445616949 | etot = -20.9249460607979 +6000 ekin = 2.19432475124593 | erot = 1.74281260409078 | epot = -24.2128064295788 | etot = -20.2756690742421 +7000 ekin = 2.65619274477635 | erot = 1.74094257048458 | epot = -24.1673462333493 | etot = -19.7702109180883 +8000 ekin = 2.51333548501169 | erot = 2.34649854571052 | epot = -24.0812769481836 | etot = -19.2214429174614 +9000 ekin = 2.24506493169711 | erot = 2.0652555461504 | epot = -23.9906736063989 | etot = -19.6803531285514 +10000 ekin = 2.36632635249862 | erot = 1.79592471761529 | epot = -23.9002627850602 | etot = -19.7380117149463 +11000 ekin = 2.03296432220126 | erot = 1.687070009478 | epot = -23.8527188138995 | etot = -20.1326844822202 +12000 ekin = 2.65352743446956 | erot = 2.50226345616878 | epot = -23.8480805937578 | etot = -18.6922897031194 +13000 ekin = 1.89067421214403 | erot = 2.35043092595414 | epot = -23.7714712440931 | etot = -19.5303661059949 +14000 ekin = 1.90680463918722 | erot = 2.127459870274 | epot = -23.7545354032947 | etot = -19.7202708938335 +15000 ekin = 2.40428667481004 | erot = 2.06172433796653 | epot = -23.6726347642127 | etot = -19.2066237514361 +16000 ekin = 2.7510166356243 | erot = 1.18896277635345 | epot = -23.5745121257654 | etot = -19.6345327137876 +17000 ekin = 2.44090826892662 | erot = 2.38166706806442 | epot = -23.5888433865641 | etot = -18.766268049573 +18000 ekin = 2.16977970545217 | erot = 2.46915729098831 | epot = -23.6023194416344 | etot = -18.9633824451939 +19000 ekin = 2.19378610033861 | erot = 2.45183819484608 | epot = -23.5449084745393 | etot = -18.8992841793546 +20000 ekin = 2.07734013817241 | erot = 1.81448496219961 | epot = -23.5782673056894 | etot = -19.6864422053173 +21000 ekin = 2.27781532351243 | erot = 2.76369118136087 | epot = -23.5986545956161 | etot = -18.5571480907428 +22000 ekin = 2.69375785791379 | erot = 1.86436952967315 | epot = -23.5521083325077 | etot = -18.9939809449208 +23000 ekin = 1.99952884103097 | erot = 2.28032953163858 | epot = -23.4448504933921 | etot = -19.1649921207226 +24000 ekin = 2.19993258930349 | erot = 2.97916455146846 | epot = -23.365299008021 | etot = -18.1862018672491 +25000 ekin = 2.28089469652686 | erot = 2.97627567077201 | epot = -23.2873526827526 | etot = -18.0301823154537 +26000 ekin = 1.99390998801618 | erot = 2.79250495479073 | epot = -23.1859723519608 | etot = -18.3995574091539 +27000 ekin = 2.00992865272585 | erot = 2.66533768693446 | epot = -23.0781687640813 | etot = -18.402902424421 +28000 ekin = 2.00322172723407 | erot = 2.36418499091004 | epot = -23.0032647032354 | etot = -18.6358579850913 +29000 ekin = 2.52361436071784 | erot = 2.06140753694879 | epot = -22.9685706338047 | etot = -18.383548736138 +30000 ekin = 1.94969919616482 | erot = 2.13601590002587 | epot = -22.8657664932105 | etot = -18.7800513970198 +31000 ekin = 1.81286761012387 | erot = 2.31717861791922 | epot = -22.8372197907213 | etot = -18.7071735626782 +32000 ekin = 1.88389491638451 | erot = 2.00512246825909 | epot = -22.9321024454487 | etot = -19.0430850608051 +33000 ekin = 1.78524470387102 | erot = 1.83154598239148 | epot = -22.9538943248059 | etot = -19.3371036385434 +34000 ekin = 2.28023843988047 | erot = 3.11357086039976 | epot = -23.0617618407572 | etot = -17.6679525404769 +35000 ekin = 2.88795920533174 | erot = 1.81662227096288 | epot = -23.1342233361349 | etot = -18.4296418598403 +36000 ekin = 2.40018487148211 | erot = 2.59182059399979 | epot = -23.2153198761915 | etot = -18.2233144107096 +37000 ekin = 2.22699211630433 | erot = 1.73889017332476 | epot = -23.2291614908027 | etot = -19.2632792011736 +38000 ekin = 2.13593461964592 | erot = 3.07590136326317 | epot = -23.1607724763685 | etot = -17.9489364934594 +39000 ekin = 2.08839393640823 | erot = 2.80471150509565 | epot = -23.1352878747759 | etot = -18.242182433272 +40000 ekin = 2.94982054413846 | erot = 2.19484102372242 | epot = -23.1842229043853 | etot = -18.0395613365244 +41000 ekin = 2.47855373480178 | erot = 3.46795094832273 | epot = -23.1698888629099 | etot = -17.2233841797854 +42000 ekin = 2.57225931171306 | erot = 3.11160980977123 | epot = -23.0914425999525 | etot = -17.4075734784682 +43000 ekin = 2.16695829201326 | erot = 2.67063324875933 | epot = -22.9841690345739 | etot = -18.1465774938013 +44000 ekin = 2.3251045436594 | erot = 3.31069456451417 | epot = -22.9099977707014 | etot = -17.2741986625278 +45000 ekin = 1.8593572517472 | erot = 3.48256913429863 | epot = -22.7853293556222 | etot = -17.4434029695763 +46000 ekin = 2.59906260222482 | erot = 2.2320785378511 | epot = -22.67184319375 | etot = -17.8407020536741 +47000 ekin = 1.9041935097682 | erot = 3.39352467596442 | epot = -22.5624536061979 | etot = -17.2647354204653 +48000 ekin = 2.46191536162938 | erot = 2.50024189038396 | epot = -22.5888330081063 | etot = -17.626675756093 +49000 ekin = 3.18008619674965 | erot = 2.18329398142911 | epot = -22.6110647388653 | etot = -17.2476845606865 +50000 ekin = 2.92380640638808 | erot = 1.5483538313346 | epot = -22.6682279672282 | etot = -18.1960677295055 +51000 ekin = 2.86729503225236 | erot = 2.67529217516738 | epot = -22.6748886664557 | etot = -17.132301459036 +52000 ekin = 2.30283827457731 | erot = 1.82645474029553 | epot = -22.6607030819086 | etot = -18.5314100670358 +53000 ekin = 3.18697616339313 | erot = 1.67211265049679 | epot = -22.7158951183044 | etot = -17.8568063044145 +54000 ekin = 2.63274995193146 | erot = 1.96664130685844 | epot = -22.7877787224364 | etot = -18.1883874636465 +55000 ekin = 3.18311630681888 | erot = 2.85127254864952 | epot = -22.8390589862477 | etot = -16.8046701307793 +56000 ekin = 2.55275960671527 | erot = 3.05720384772627 | epot = -22.8187750450683 | etot = -17.2088115906267 +57000 ekin = 2.43682051944963 | erot = 3.45782031837861 | epot = -22.7770565571277 | etot = -16.8824157192995 +58000 ekin = 1.93888380963701 | erot = 2.51321017005842 | epot = -22.7135987564736 | etot = -18.2615047767781 +59000 ekin = 2.5584899615086 | erot = 3.52166542523796 | epot = -22.6623202639297 | etot = -16.5821648771831 +60000 ekin = 2.80661395039301 | erot = 2.89055248290059 | epot = -22.5801959967487 | etot = -16.8830295634551 +61000 ekin = 2.68598657973729 | erot = 2.54741083070049 | epot = -22.4806361765055 | etot = -17.2472387660677 +62000 ekin = 2.74493324548126 | erot = 2.23648307303268 | epot = -22.4129547813458 | etot = -17.4315384628319 +63000 ekin = 2.65627195091608 | erot = 2.46107949280746 | epot = -22.3986334001314 | etot = -17.2812819564079 +64000 ekin = 2.12379240032878 | erot = 2.79203441675508 | epot = -22.3495990435982 | etot = -17.4337722265143 +65000 ekin = 1.86782238979936 | erot = 2.70277079938775 | epot = -22.3710220966341 | etot = -17.800428907447 +66000 ekin = 2.74983103317414 | erot = 1.93532287297328 | epot = -22.3642892005435 | etot = -17.6791352943961 +67000 ekin = 2.51092055125345 | erot = 2.46618624666164 | epot = -22.3997780561407 | etot = -17.4226712582257 +68000 ekin = 2.95469759114172 | erot = 1.97026833535316 | epot = -22.465077041847 | etot = -17.5401111153521 +69000 ekin = 2.60179538487173 | erot = 2.27022574694886 | epot = -22.4013876082186 | etot = -17.529366476398 +70000 ekin = 2.38624525335423 | erot = 2.82124637267728 | epot = -22.3329612644329 | etot = -17.1254696384013 +71000 ekin = 2.62641919853461 | erot = 2.89332429923839 | epot = -22.3324946257813 | etot = -16.8127511280083 +72000 ekin = 2.93199679301318 | erot = 2.83600213853038 | epot = -22.4418753486332 | etot = -16.6738764170897 +73000 ekin = 2.20521324648382 | erot = 3.0506384171445 | epot = -22.5078076718832 | etot = -17.2519560082549 +74000 ekin = 2.16594519672766 | erot = 2.82993872672918 | epot = -22.5187768617569 | etot = -17.5228929383001 +75000 ekin = 1.52753824412461 | erot = 1.91758574309003 | epot = -22.6434864113427 | etot = -19.198362424128 +76000 ekin = 1.89477517532868 | erot = 2.83145375092217 | epot = -22.7507099037207 | etot = -18.0244809774699 +77000 ekin = 2.84722966394523 | erot = 3.20523918524771 | epot = -22.8263123696514 | etot = -16.7738435204585 +78000 ekin = 2.44900478430451 | erot = 2.80964787966682 | epot = -22.8119237303111 | etot = -17.5532710663397 +79000 ekin = 2.16549328835506 | erot = 1.67531288307153 | epot = -22.8278994273521 | etot = -18.9870932559255 +80000 ekin = 2.38929173610466 | erot = 2.58355997375491 | epot = -22.7453472674483 | etot = -17.7724955575887 +81000 ekin = 2.74182188148999 | erot = 1.92580771183151 | epot = -22.6872721828913 | etot = -18.0196425895698 +82000 ekin = 1.90254633515813 | erot = 1.70958501101745 | epot = -22.5904815431895 | etot = -18.9783501970139 +83000 ekin = 1.63862423461032 | erot = 1.87668722448406 | epot = -22.5030898166236 | etot = -18.9877783575292 +84000 ekin = 1.65768128899531 | erot = 2.10186039233844 | epot = -22.4199436013011 | etot = -18.6604019199674 +85000 ekin = 2.40787065796921 | erot = 2.04965431830703 | epot = -22.3401854879212 | etot = -17.882660511645 +86000 ekin = 2.51073542405177 | erot = 1.79768841940749 | epot = -22.3948638623201 | etot = -18.0864400188608 +87000 ekin = 2.13729284484532 | erot = 1.97886338867606 | epot = -22.4457225556767 | etot = -18.3295663221553 +88000 ekin = 1.7511616822056 | erot = 2.36434608342924 | epot = -22.4232555875236 | etot = -18.3077478218887 +89000 ekin = 1.85498863251071 | erot = 3.29466014836527 | epot = -22.4615925106509 | etot = -17.3119437297749 +90000 ekin = 2.22730928223451 | erot = 2.36761183779185 | epot = -22.5498488806969 | etot = -17.9549277606706 +91000 ekin = 2.40026068010467 | erot = 3.1312454261103 | epot = -22.5445138059197 | etot = -17.0130076997047 +92000 ekin = 2.69184894487886 | erot = 3.01111638487596 | epot = -22.5488335054242 | etot = -16.8458681756693 +93000 ekin = 3.04452081584098 | erot = 3.0289315825034 | epot = -22.4857514998612 | etot = -16.4122991015169 +94000 ekin = 3.21054020599498 | erot = 1.87554208928457 | epot = -22.58235617796 | etot = -17.4962738826805 +95000 ekin = 3.49164555041805 | erot = 2.89107259754101 | epot = -22.651746211573 | etot = -16.2690280636139 +96000 ekin = 2.8961145983777 | erot = 2.38403691628048 | epot = -22.6376886129393 | etot = -17.3575370982811 +97000 ekin = 1.94001816357315 | erot = 2.09603205774619 | epot = -22.6212143095229 | etot = -18.5851640882036 +98000 ekin = 2.21812472183551 | erot = 3.66512951907029 | epot = -22.5400207863669 | etot = -16.6567665454611 +99000 ekin = 1.96304801418099 | erot = 2.78092002528644 | epot = -22.4500077741119 | etot = -17.7060397346444 +100000 ekin = 1.78146596589238 | erot = 2.66087063973067 | epot = -22.3806285021859 | etot = -17.9382918965629 +101000 ekin = 2.13576431486591 | erot = 2.39189697670582 | epot = -22.3671198416411 | etot = -17.8394585500694 +102000 ekin = 1.54265458925823 | erot = 2.31301627489861 | epot = -22.3596033820568 | etot = -18.5039325179 +103000 ekin = 1.6493299781162 | erot = 2.82700146777614 | epot = -22.4044472055819 | etot = -17.9281157596895 +104000 ekin = 1.88425130865015 | erot = 3.36695629589132 | epot = -22.4614117565727 | etot = -17.2102041520312 +105000 ekin = 2.0873628063424 | erot = 1.99902589912497 | epot = -22.4857870795246 | etot = -18.3993983740572 +106000 ekin = 2.85192200005481 | erot = 1.96124421177818 | epot = -22.4885148263279 | etot = -17.6753486144949 +107000 ekin = 2.27699301124082 | erot = 1.54572940373457 | epot = -22.4328687856414 | etot = -18.610146370666 +108000 ekin = 2.43341212242248 | erot = 1.7101452395327 | epot = -22.4750159709763 | etot = -18.3314586090212 +109000 ekin = 2.3240302459673 | erot = 2.92730273400661 | epot = -22.4544447404649 | etot = -17.203111760491 +110000 ekin = 2.75939007795593 | erot = 2.3726124845783 | epot = -22.4066316113363 | etot = -17.2746290488021 +111000 ekin = 2.30202775259985 | erot = 2.09098171366697 | epot = -22.340628179725 | etot = -17.9476187134581 +112000 ekin = 2.89672803093986 | erot = 1.84536318388285 | epot = -22.189229344937 | etot = -17.4471381301143 +113000 ekin = 2.802868120203 | erot = 1.68317583122193 | epot = -22.1739192926257 | etot = -17.6878753412008 +114000 ekin = 3.41134331362353 | erot = 2.66279011393036 | epot = -22.2993892060878 | etot = -16.2252557785339 +115000 ekin = 3.04096848543598 | erot = 1.72164164793761 | epot = -22.3101669297006 | etot = -17.547556796327 +116000 ekin = 3.18249263106367 | erot = 3.21872780579631 | epot = -22.3766120310369 | etot = -15.975391594177 +117000 ekin = 3.04033644338918 | erot = 2.4163277414929 | epot = -22.3406101341932 | etot = -16.8839459493111 +118000 ekin = 3.2297663279461 | erot = 1.46870208555873 | epot = -22.262910646297 | etot = -17.5644422327922 +119000 ekin = 2.35815331598994 | erot = 3.07464675916892 | epot = -22.21629705762 | etot = -16.7834969824611 +120000 ekin = 1.93901604028919 | erot = 2.21087803685818 | epot = -22.1596747789505 | etot = -18.0097807018031 +121000 ekin = 1.94791988346889 | erot = 3.06697908719322 | epot = -22.1473490758084 | etot = -17.1324501051462 +122000 ekin = 1.69642311218451 | erot = 1.71065948591522 | epot = -22.235021693017 | etot = -18.8279390949172 +123000 ekin = 1.74537927001903 | erot = 2.31042772730644 | epot = -22.3250546948603 | etot = -18.2692476975348 +124000 ekin = 2.74229806685692 | erot = 1.94346011848795 | epot = -22.3376426377462 | etot = -17.6518844524013 +125000 ekin = 2.77628031613761 | erot = 1.95737420539167 | epot = -22.3561899601979 | etot = -17.6225354386686 +126000 ekin = 2.05898577806786 | erot = 1.47493157618749 | epot = -22.3918669376121 | etot = -18.8579495833568 +127000 ekin = 1.88620727578863 | erot = 1.58698481884328 | epot = -22.3753405588623 | etot = -18.9021484642304 +128000 ekin = 1.65027256647601 | erot = 1.87589048163674 | epot = -22.3576574967822 | etot = -18.8314944486694 +129000 ekin = 2.51771860981078 | erot = 2.38745668871875 | epot = -22.3622404512641 | etot = -17.4570651527346 +130000 ekin = 1.60778116741171 | erot = 2.81983062254802 | epot = -22.3043401463426 | etot = -17.8767283563829 +131000 ekin = 2.27966529707091 | erot = 2.29465997580789 | epot = -22.1860056729234 | etot = -17.6116804000446 +132000 ekin = 2.94605151024306 | erot = 2.34727265039698 | epot = -22.1004107829512 | etot = -16.8070866223112 +133000 ekin = 2.00184520718143 | erot = 2.13597622566089 | epot = -22.0860804435183 | etot = -17.948259010676 +134000 ekin = 1.54536260297594 | erot = 2.86019181856985 | epot = -22.0324797134652 | etot = -17.6269252919194 +135000 ekin = 1.7899169229158 | erot = 2.40585579784188 | epot = -22.0564792277569 | etot = -17.8607065069992 +136000 ekin = 1.63315069688348 | erot = 2.13968964990471 | epot = -22.0645410751455 | etot = -18.2917007283573 +137000 ekin = 2.36475220491125 | erot = 1.93075105476848 | epot = -22.101884847306 | etot = -17.8063815876262 +138000 ekin = 2.9554682114977 | erot = 1.58329215843879 | epot = -22.158920719349 | etot = -17.6201603494125 +139000 ekin = 3.18559985564368 | erot = 2.24978247982886 | epot = -22.2766713145625 | etot = -16.84128897909 +140000 ekin = 2.25331500051846 | erot = 3.04264261269698 | epot = -22.4413209794807 | etot = -17.1453633662653 +141000 ekin = 1.8939664036255 | erot = 3.12730191483887 | epot = -22.6943708703895 | etot = -17.6731025519251 +142000 ekin = 2.48698722341786 | erot = 2.50204475841097 | epot = -22.8022645411412 | etot = -17.8132325593124 +143000 ekin = 2.39031114354901 | erot = 2.72027514737474 | epot = -22.7789363640121 | etot = -17.6683500730884 +144000 ekin = 1.93009742932803 | erot = 2.68112648713777 | epot = -22.6600942975092 | etot = -18.0488703810434 +145000 ekin = 1.81543048110687 | erot = 1.73927524532866 | epot = -22.6290694904769 | etot = -19.0743637640413 +146000 ekin = 2.4125202126428 | erot = 2.0856902293417 | epot = -22.560764077018 | etot = -18.0625536350335 +147000 ekin = 1.44642974398304 | erot = 1.86921415702345 | epot = -22.4437745695725 | etot = -19.128130668566 +148000 ekin = 1.94224767107089 | erot = 2.57935525538892 | epot = -22.4110987100046 | etot = -17.8894957835448 +149000 ekin = 2.03195649040454 | erot = 3.31786202502786 | epot = -22.312227106758 | etot = -16.9624085913256 +150000 ekin = 2.47792894576431 | erot = 2.68612874200302 | epot = -22.1392843642772 | etot = -16.9752266765099 +151000 ekin = 2.75692645092955 | erot = 1.88122565848133 | epot = -21.9329416416722 | etot = -17.2947895322613 +152000 ekin = 2.7753834344323 | erot = 1.78115734250796 | epot = -21.745072490984 | etot = -17.1885317140438 +153000 ekin = 3.09316888168833 | erot = 1.80744228044955 | epot = -21.6451473427313 | etot = -16.7445361805934 +154000 ekin = 2.31433640945477 | erot = 2.19304386678896 | epot = -21.5946356595636 | etot = -17.0872553833199 +155000 ekin = 1.94169881401553 | erot = 2.67959698479411 | epot = -21.6941053409436 | etot = -17.0728095421339 +156000 ekin = 2.69151609119638 | erot = 2.25048211983205 | epot = -21.7610571974251 | etot = -16.8190589863966 +157000 ekin = 3.89507004263776 | erot = 2.74501587672577 | epot = -21.8157728797742 | etot = -15.1756869604107 +158000 ekin = 2.88173407476086 | erot = 2.69702262693026 | epot = -21.8854957137509 | etot = -16.3067390120597 +159000 ekin = 3.15173323195919 | erot = 2.61743473710129 | epot = -21.8245251626835 | etot = -16.055357193623 +160000 ekin = 2.54983562435716 | erot = 3.26037467643908 | epot = -21.8527884226329 | etot = -16.0425781218366 +161000 ekin = 2.47569624391789 | erot = 2.44418416527208 | epot = -21.7973550812186 | etot = -16.8774746720287 +162000 ekin = 2.9422872213738 | erot = 2.59784970938383 | epot = -21.7813251561028 | etot = -16.2411882253452 +163000 ekin = 3.25812805712343 | erot = 2.2523933100784 | epot = -21.820089307521 | etot = -16.3095679403192 +164000 ekin = 3.52786799143084 | erot = 2.22392713421413 | epot = -21.7646946348872 | etot = -16.0128995092422 +165000 ekin = 2.47839548873417 | erot = 2.58744140761171 | epot = -21.679095294504 | etot = -16.6132583981582 +166000 ekin = 2.14435847552791 | erot = 3.04732688845808 | epot = -21.6219995979976 | etot = -16.4303142340116 +167000 ekin = 2.77664659649902 | erot = 2.89037999868329 | epot = -21.5339928834654 | etot = -15.8669662882831 +168000 ekin = 1.74464407802389 | erot = 2.78052653338967 | epot = -21.4288999288374 | etot = -16.9037293174239 +169000 ekin = 1.80689129093329 | erot = 2.46391033708927 | epot = -21.4128285618694 | etot = -17.1420269338468 +170000 ekin = 1.6949814594151 | erot = 2.88911238881154 | epot = -21.4319269866203 | etot = -16.8478331383937 +171000 ekin = 2.15326316196645 | erot = 1.61346547801869 | epot = -21.2861470779283 | etot = -17.5194184379432 +172000 ekin = 1.67904916339532 | erot = 2.36509147316375 | epot = -21.1250864759441 | etot = -17.080945839385 +173000 ekin = 2.05349972960735 | erot = 2.1886466510775 | epot = -21.0744450592631 | etot = -16.8322986785782 +174000 ekin = 2.49402795941962 | erot = 3.10392317000879 | epot = -20.9332609664624 | etot = -15.335309837034 +175000 ekin = 2.60611029063986 | erot = 2.90993176119182 | epot = -20.8533230180668 | etot = -15.3372809662352 +176000 ekin = 2.14535974511637 | erot = 2.67710511021539 | epot = -20.8508037764829 | etot = -16.0283389211511 +177000 ekin = 2.82654664242577 | erot = 2.80647819657321 | epot = -20.9303681620826 | etot = -15.2973433230836 +178000 ekin = 3.17006270723388 | erot = 1.88204403688962 | epot = -21.0665744865168 | etot = -16.0144677423933 +179000 ekin = 2.33834827123178 | erot = 2.84870047825869 | epot = -21.1082901606943 | etot = -15.9212414112039 +180000 ekin = 2.39362550925045 | erot = 2.94575326168227 | epot = -21.1089731290028 | etot = -15.7695943580701 +181000 ekin = 2.78703231260152 | erot = 3.29998898392537 | epot = -21.0761138110654 | etot = -14.9890925145385 +182000 ekin = 3.02338391239199 | erot = 2.32533107462881 | epot = -21.0444377426861 | etot = -15.6957227556653 +183000 ekin = 2.44126401356994 | erot = 2.19853056632819 | epot = -20.8846280234405 | etot = -16.2448334435424 +184000 ekin = 2.56448211253962 | erot = 2.77267067014066 | epot = -20.6657911214549 | etot = -15.3286383387746 +185000 ekin = 2.16427057092672 | erot = 1.95880146934286 | epot = -20.5647658775173 | etot = -16.4416938372477 +186000 ekin = 2.06536030915311 | erot = 3.14593463137772 | epot = -20.4537584304771 | etot = -15.2424634899463 +187000 ekin = 2.43846121057803 | erot = 1.93593042270703 | epot = -20.4775765627296 | etot = -16.1031849294445 +188000 ekin = 2.28827356508696 | erot = 2.89699235589217 | epot = -20.6028880527163 | etot = -15.4176221317372 +189000 ekin = 1.67206333515898 | erot = 3.05807378739729 | epot = -20.6184572736204 | etot = -15.8883201510642 +190000 ekin = 1.96995062226968 | erot = 2.94301967439401 | epot = -20.6150380630742 | etot = -15.7020677664105 +191000 ekin = 2.31558303301195 | erot = 2.65062200614568 | epot = -20.5845049099943 | etot = -15.6182998708367 +192000 ekin = 3.58105122568799 | erot = 2.89866835149675 | epot = -20.555036456006 | etot = -14.0753168788213 +193000 ekin = 2.69738971383614 | erot = 3.08390984677749 | epot = -20.5718609412494 | etot = -14.7905613806358 +194000 ekin = 2.65963556416735 | erot = 2.28486501061268 | epot = -20.4488832942326 | etot = -15.5043827194526 +195000 ekin = 1.85289053427901 | erot = 2.65318671222087 | epot = -20.3816844231208 | etot = -15.8756071766209 +196000 ekin = 2.28257181147918 | erot = 2.31175601065462 | epot = -20.4051132325268 | etot = -15.810785410393 +197000 ekin = 2.49770460330585 | erot = 2.55587879440511 | epot = -20.4716020539923 | etot = -15.4180186562814 +198000 ekin = 2.01700960777427 | erot = 1.51922008609382 | epot = -20.4907970823156 | etot = -16.9545673884475 +199000 ekin = 1.50027537520987 | erot = 2.19604462463446 | epot = -20.5138434458212 | etot = -16.8175234459769 +200000 ekin = 1.64850512926723 | erot = 2.4596633548257 | epot = -20.4934420686449 | etot = -16.385273584552 +201000 ekin = 2.62997533994907 | erot = 2.61637339049483 | epot = -20.5569645618355 | etot = -15.3106158313916 +202000 ekin = 2.3089517547524 | erot = 2.5565329388766 | epot = -20.6262537118088 | etot = -15.7607690181798 +203000 ekin = 1.64768887888551 | erot = 2.11556417528285 | epot = -20.6617888215465 | etot = -16.8985357673782 +204000 ekin = 2.01924097320136 | erot = 1.97748949636931 | epot = -20.7002685556682 | etot = -16.7035380860975 +205000 ekin = 2.97656554045711 | erot = 3.25408007971553 | epot = -20.9425038008424 | etot = -14.7118581806698 +206000 ekin = 2.56613069661945 | erot = 2.21624244224461 | epot = -21.0621833598182 | etot = -16.2798102209542 +207000 ekin = 3.44850636848559 | erot = 2.48816050856267 | epot = -21.2038849430867 | etot = -15.2672180660384 +208000 ekin = 2.54208934028226 | erot = 2.22605232144502 | epot = -21.3476404533667 | etot = -16.5794987916394 +209000 ekin = 3.84151461096732 | erot = 2.16534559513903 | epot = -21.4932373455843 | etot = -15.486377139478 +210000 ekin = 3.06873591712904 | erot = 2.24760815652574 | epot = -21.6427793540355 | etot = -16.3264352803807 +211000 ekin = 1.64176280869923 | erot = 2.17721976802011 | epot = -21.8130439048272 | etot = -17.9940613281078 +212000 ekin = 2.5985934050661 | erot = 2.41520703335869 | epot = -21.9964648294563 | etot = -16.9826643910315 +213000 ekin = 2.51136104390039 | erot = 1.99503544560738 | epot = -22.161492842604 | etot = -17.6550963530962 +214000 ekin = 2.77089845962619 | erot = 3.17247228684199 | epot = -22.208715104286 | etot = -16.2653443578179 +215000 ekin = 2.53408528186206 | erot = 1.84963848601798 | epot = -22.1148567901871 | etot = -17.7311330223071 +216000 ekin = 2.52671619876928 | erot = 2.77873014449688 | epot = -22.1370884570131 | etot = -16.8316421137469 +217000 ekin = 2.50171921508545 | erot = 1.89238935467003 | epot = -22.226079201001 | etot = -17.8319706312455 +218000 ekin = 2.43936294263937 | erot = 2.41974828067303 | epot = -22.2447049583244 | etot = -17.385593735012 +219000 ekin = 2.30221269367205 | erot = 2.65120674162376 | epot = -22.2807164841742 | etot = -17.3272970488784 +220000 ekin = 1.70065256620687 | erot = 2.34758543213915 | epot = -22.2809933538228 | etot = -18.2327553554768 +221000 ekin = 2.09298237125575 | erot = 2.47886481595909 | epot = -22.267957001012 | etot = -17.6961098137972 +222000 ekin = 1.58469709510937 | erot = 2.14490786301286 | epot = -22.1867412404881 | etot = -18.4571362823659 +223000 ekin = 1.83926923346352 | erot = 1.89456034969536 | epot = -22.131893392038 | etot = -18.3980638088791 +224000 ekin = 2.59583657132575 | erot = 2.93869915115497 | epot = -22.1425986650605 | etot = -16.6080629425798 +225000 ekin = 3.29351563254165 | erot = 2.8433953581414 | epot = -22.12757310355 | etot = -15.9906621128669 +226000 ekin = 3.03135339447922 | erot = 2.08293143143602 | epot = -22.15283624886 | etot = -17.0385514229448 +227000 ekin = 2.50176282992082 | erot = 3.15084128846394 | epot = -22.2250438959744 | etot = -16.5724397775897 +228000 ekin = 2.32013498351673 | erot = 2.67554406359439 | epot = -22.3177515383563 | etot = -17.3220724912452 +229000 ekin = 2.89545450975319 | erot = 2.90735055857068 | epot = -22.4361496683348 | etot = -16.6333446000109 +230000 ekin = 2.28321229485933 | erot = 3.48420465632866 | epot = -22.548785995051 | etot = -16.781369043863 +231000 ekin = 2.0778632375453 | erot = 3.10673973696436 | epot = -22.5896609633152 | etot = -17.4050579888055 +232000 ekin = 2.1202374109541 | erot = 1.98747810033065 | epot = -22.5738924334392 | etot = -18.4661769221544 +233000 ekin = 2.33571877855589 | erot = 2.83585090202738 | epot = -22.5402065195541 | etot = -17.3686368389708 +234000 ekin = 2.10578223747154 | erot = 2.07381218733635 | epot = -22.5507693150833 | etot = -18.3711748902754 +235000 ekin = 2.44321041214394 | erot = 2.80846352304318 | epot = -22.5606929563186 | etot = -17.3090190211315 +236000 ekin = 2.93630791731799 | erot = 3.0631591853173 | epot = -22.4860653874722 | etot = -16.4865982848369 +237000 ekin = 3.21264879506079 | erot = 3.26866508478298 | epot = -22.3683553437862 | etot = -15.8870414639424 +238000 ekin = 2.46595539123277 | erot = 2.32502019506664 | epot = -22.3144456769666 | etot = -17.5234700906672 +239000 ekin = 2.10325864915823 | erot = 2.47631139904042 | epot = -22.3011392921811 | etot = -17.7215692439825 +240000 ekin = 1.77270999777839 | erot = 2.60141429112664 | epot = -22.2344206081543 | etot = -17.8602963192493 +241000 ekin = 1.94952922244078 | erot = 1.39715216866764 | epot = -22.2207225048761 | etot = -18.8740411137677 +242000 ekin = 3.05687991591411 | erot = 2.00862394928705 | epot = -22.2213200390944 | etot = -17.1558161738932 +243000 ekin = 2.86735711945299 | erot = 1.79948118674678 | epot = -22.2697610280427 | etot = -17.6029227218429 +244000 ekin = 2.00525854269389 | erot = 2.36445341214555 | epot = -22.2726788994494 | etot = -17.90296694461 +245000 ekin = 2.28011102404838 | erot = 2.787005205328 | epot = -22.2995433574618 | etot = -17.2324271280854 +246000 ekin = 2.06819738789813 | erot = 2.24624952782285 | epot = -22.2551680110138 | etot = -17.9407210952928 +247000 ekin = 1.69964711256213 | erot = 3.22260619239827 | epot = -22.1916408256116 | etot = -17.2693875206512 +248000 ekin = 1.92997585194759 | erot = 3.61155944514373 | epot = -22.0096484177853 | etot = -16.4681131206939 +249000 ekin = 2.16278530892653 | erot = 3.27771891456709 | epot = -21.8856058980727 | etot = -16.4451016745791 +250000 ekin = 2.32204054211024 | erot = 2.46317574116847 | epot = -21.8028762710592 | etot = -17.0176599877804 +251000 ekin = 1.23768964067254 | erot = 2.24150533762101 | epot = -21.763065707404 | etot = -18.2838707291104 +252000 ekin = 1.79818833522214 | erot = 2.12556386664128 | epot = -21.7586349357285 | etot = -17.8348827338651 +253000 ekin = 2.12809689846393 | erot = 2.59685639208402 | epot = -21.7226495687758 | etot = -16.9976962782278 +254000 ekin = 2.46813261968532 | erot = 2.00391812662869 | epot = -21.7113918037362 | etot = -17.2393410574222 +255000 ekin = 2.3156672908729 | erot = 2.03619058028117 | epot = -21.7265453183257 | etot = -17.3746874471716 +256000 ekin = 2.87223929491326 | erot = 2.61790933826624 | epot = -21.659332511914 | etot = -16.1691838787345 +257000 ekin = 2.85756762932927 | erot = 2.081746739162 | epot = -21.6161821054731 | etot = -16.6768677369819 +258000 ekin = 2.06111021157734 | erot = 2.32748664972428 | epot = -21.5132485706727 | etot = -17.124651709371 +259000 ekin = 2.23305784057759 | erot = 2.88843859953735 | epot = -21.5040039667855 | etot = -16.3825075266705 +260000 ekin = 2.49862397932476 | erot = 2.38336885848389 | epot = -21.488210637319 | etot = -16.6062177995103 +261000 ekin = 2.09280296934734 | erot = 2.39632540029205 | epot = -21.4325331777953 | etot = -16.9434048081559 +262000 ekin = 2.33576913564289 | erot = 2.67273419354397 | epot = -21.3832241450035 | etot = -16.3747208158166 +263000 ekin = 2.20536189489354 | erot = 2.71530627040565 | epot = -21.4329409070981 | etot = -16.5122727417989 +264000 ekin = 2.2858247573423 | erot = 2.76839346219664 | epot = -21.39310844316 | etot = -16.338890223621 +265000 ekin = 1.70928536820409 | erot = 1.79395423442894 | epot = -21.2682341921474 | etot = -17.7649945895144 +266000 ekin = 2.48721735474525 | erot = 2.08745460533224 | epot = -21.1746995817337 | etot = -16.6000276216562 +267000 ekin = 2.69283567987773 | erot = 2.10301910407211 | epot = -21.1705161290062 | etot = -16.3746613450564 +268000 ekin = 3.00000233743719 | erot = 2.80954585635721 | epot = -21.164752112651 | etot = -15.3552039188566 +269000 ekin = 3.50713810468527 | erot = 2.35763817348003 | epot = -21.1537110688984 | etot = -15.2889347907331 +270000 ekin = 3.50686942248863 | erot = 1.86462765875888 | epot = -21.1925508822801 | etot = -15.8210538010326 +271000 ekin = 3.57026082273992 | erot = 2.08172467795384 | epot = -21.2775817182941 | etot = -15.6255962176003 +272000 ekin = 2.4484752533773 | erot = 3.08466485039761 | epot = -21.3619851902072 | etot = -15.8288450864322 +273000 ekin = 2.39748176307241 | erot = 3.13355050446718 | epot = -21.4386234252579 | etot = -15.9075911577183 +274000 ekin = 2.48208144431863 | erot = 2.00552494041967 | epot = -21.4476232953882 | etot = -16.9600169106499 +275000 ekin = 2.48721081149369 | erot = 3.05413598233603 | epot = -21.4713984309062 | etot = -15.9300516370765 +276000 ekin = 2.82709589676966 | erot = 2.88384306577856 | epot = -21.4434590118161 | etot = -15.7325200492679 +277000 ekin = 2.23479555963313 | erot = 2.20310851955638 | epot = -21.3883073251199 | etot = -16.9504032459304 +278000 ekin = 2.81418916407429 | erot = 3.24537052192613 | epot = -21.3155364074003 | etot = -15.2559767213999 +279000 ekin = 2.57366525203699 | erot = 1.81705578305929 | epot = -21.2862101233851 | etot = -16.8954890882888 +280000 ekin = 2.41063464320149 | erot = 1.76282693004731 | epot = -21.2549625280961 | etot = -17.0815009548473 +281000 ekin = 2.58126226070487 | erot = 2.29258221702166 | epot = -21.306394928225 | etot = -16.4325504504985 +282000 ekin = 3.02016903398222 | erot = 2.43094523890341 | epot = -21.4340900724633 | etot = -15.9829757995777 +283000 ekin = 2.59269149790331 | erot = 2.11330689541033 | epot = -21.6296517079942 | etot = -16.9236533146806 +284000 ekin = 2.51704243107537 | erot = 3.13156683036761 | epot = -21.7452694753527 | etot = -16.0966602139097 +285000 ekin = 2.4236537221525 | erot = 1.77228258125507 | epot = -21.8557019037769 | etot = -17.6597656003693 +286000 ekin = 1.9446719552166 | erot = 2.0366097411672 | epot = -21.901435736722 | etot = -17.9201540403382 +287000 ekin = 2.56319670376172 | erot = 2.60867050510166 | epot = -21.90675099349 | etot = -16.7348837846266 +288000 ekin = 2.19574207425738 | erot = 1.69805542160023 | epot = -21.8143855675961 | etot = -17.9205880717385 +289000 ekin = 2.35326278833027 | erot = 1.65840109676146 | epot = -21.6976038565284 | etot = -17.6859399714367 +290000 ekin = 2.3519456177505 | erot = 1.99444238353744 | epot = -21.6551012116075 | etot = -17.3087132103195 +291000 ekin = 1.48585281531715 | erot = 2.66475825861554 | epot = -21.56036793472 | etot = -17.4097568607873 +292000 ekin = 2.10739944756451 | erot = 2.42809824662638 | epot = -21.4451596117638 | etot = -16.9096619175729 +293000 ekin = 2.11618090223716 | erot = 1.86694554151198 | epot = -21.3593625692767 | etot = -17.3762361255276 +294000 ekin = 2.06078090566332 | erot = 2.13941873359476 | epot = -21.2326233100941 | etot = -17.032423670836 +295000 ekin = 2.11467178034793 | erot = 2.3267343667518 | epot = -21.1123588667461 | etot = -16.6709527196464 +296000 ekin = 1.53087058859331 | erot = 2.94008409149153 | epot = -21.2112197533848 | etot = -16.7402650732999 +297000 ekin = 2.52732986791196 | erot = 2.18380855337858 | epot = -21.1955190508786 | etot = -16.4843806295881 +298000 ekin = 1.89033945823196 | erot = 2.02521913176001 | epot = -21.2593750718296 | etot = -17.3438164818376 +299000 ekin = 1.87142873048436 | erot = 1.66404563221549 | epot = -21.2919162310488 | etot = -17.7564418683489 +300000 ekin = 2.23872615546788 | erot = 1.50807257618897 | epot = -21.3339204593826 | etot = -17.5871217277258 +301000 ekin = 1.99965506724558 | erot = 2.00145094516844 | epot = -21.4707589194325 | etot = -17.4696529070184 +302000 ekin = 1.76370349732521 | erot = 2.23787708901487 | epot = -21.5675275978257 | etot = -17.5659470114856 +303000 ekin = 2.69610887251788 | erot = 1.6995722142974 | epot = -21.5563765448092 | etot = -17.1606954579939 +304000 ekin = 2.55447143501921 | erot = 2.02060813090349 | epot = -21.5692327321341 | etot = -16.9941531662114 +305000 ekin = 2.38230604232717 | erot = 2.31489374428114 | epot = -21.5335950166329 | etot = -16.8363952300246 +306000 ekin = 2.07785475765118 | erot = 2.4523066068597 | epot = -21.4550895345847 | etot = -16.9249281700738 +307000 ekin = 3.17130424567278 | erot = 3.29574614566806 | epot = -21.4151535289883 | etot = -14.9481031376474 +308000 ekin = 3.40959217051674 | erot = 2.68389483402973 | epot = -21.4778643688409 | etot = -15.3843773642944 +309000 ekin = 2.36068264180093 | erot = 2.91715332823342 | epot = -21.5794336507741 | etot = -16.3015976807398 +310000 ekin = 2.4995235722922 | erot = 2.36028950896138 | epot = -21.5982142524176 | etot = -16.738401171164 +311000 ekin = 2.53288726180906 | erot = 2.29596940545851 | epot = -21.6418553661547 | etot = -16.8129986988871 +312000 ekin = 2.05123272208704 | erot = 2.92023923411834 | epot = -21.7377547517075 | etot = -16.7662827955022 +313000 ekin = 1.80834719374888 | erot = 2.29357283142125 | epot = -21.7993116362532 | etot = -17.6973916110831 +314000 ekin = 2.30684015099018 | erot = 2.20859462712272 | epot = -21.8029398081388 | etot = -17.2875050300259 +315000 ekin = 1.86413924486173 | erot = 2.14748794238475 | epot = -21.8550418960799 | etot = -17.8434147088335 +316000 ekin = 2.20558056533516 | erot = 3.03447287931582 | epot = -21.8868412075709 | etot = -16.6467877629199 +317000 ekin = 2.47820931125479 | erot = 3.56870099099487 | epot = -21.9902146748519 | etot = -15.9433043726022 +318000 ekin = 2.36582343801679 | erot = 3.01887804681552 | epot = -22.1178732891163 | etot = -16.733171804284 +319000 ekin = 2.40464629760758 | erot = 3.15910789488741 | epot = -22.2289401281565 | etot = -16.6651859356615 +320000 ekin = 1.80206494109346 | erot = 2.83527990295434 | epot = -22.3120263401861 | etot = -17.6746814961383 +321000 ekin = 2.91146951948762 | erot = 2.25772268449837 | epot = -22.3029455835947 | etot = -17.1337533796087 +322000 ekin = 2.8226351296685 | erot = 2.67950826833977 | epot = -22.3041650189947 | etot = -16.8020216209865 +323000 ekin = 2.067323568424 | erot = 2.319752847753 | epot = -22.3338840353559 | etot = -17.9468076191789 +324000 ekin = 2.6012747278288 | erot = 2.58351861537749 | epot = -22.3215168526944 | etot = -17.1367235094881 +325000 ekin = 3.45560055552843 | erot = 2.50162515355505 | epot = -22.1825527777624 | etot = -16.2253270686789 +326000 ekin = 3.51422890604519 | erot = 2.84426061018012 | epot = -22.0201095272525 | etot = -15.6616200110272 +327000 ekin = 2.63551490316295 | erot = 2.20570805472231 | epot = -21.9384479867007 | etot = -17.0972250288154 +328000 ekin = 1.8043914440792 | erot = 2.37599512200968 | epot = -21.861980397642 | etot = -17.6815938315531 +329000 ekin = 2.15766181563134 | erot = 2.45286496267961 | epot = -21.8518523862112 | etot = -17.2413256079002 +330000 ekin = 1.8483425992464 | erot = 2.03367429366601 | epot = -21.768409525242 | etot = -17.8863926323296 +331000 ekin = 2.3531484336258 | erot = 1.80165819621476 | epot = -21.7197009414848 | etot = -17.5648943116443 +332000 ekin = 1.67855936307207 | erot = 2.5334121965131 | epot = -21.7336434355881 | etot = -17.5216718760029 +333000 ekin = 1.60376334688456 | erot = 2.14058675025446 | epot = -21.835637958395 | etot = -18.091287861256 +334000 ekin = 2.26551990081779 | erot = 2.62486254825415 | epot = -21.8794971078471 | etot = -16.9891146587751 +335000 ekin = 2.91208137486081 | erot = 3.11052870452009 | epot = -21.9161692767172 | etot = -15.8935591973363 +336000 ekin = 2.73132973682385 | erot = 2.56213100489412 | epot = -21.8312488568505 | etot = -16.5377881151325 +337000 ekin = 3.15411918141902 | erot = 3.87512819831194 | epot = -21.9061152574783 | etot = -14.8768678777473 +338000 ekin = 2.33141760424507 | erot = 2.13211945089677 | epot = -21.913746111238 | etot = -17.4502090560962 +339000 ekin = 1.71915361945719 | erot = 2.31270220754042 | epot = -21.904207477372 | etot = -17.8723516503744 +340000 ekin = 1.62199393011804 | erot = 3.16990972384471 | epot = -21.8898233676232 | etot = -17.0979197136604 +341000 ekin = 1.71588704296646 | erot = 3.17642860992459 | epot = -21.8345558128149 | etot = -16.9422401599239 +342000 ekin = 1.82178091247658 | erot = 2.58875985611024 | epot = -21.7161502950573 | etot = -17.3056095264705 +343000 ekin = 3.08559255942693 | erot = 2.94813449265471 | epot = -21.7030445300997 | etot = -15.669317478018 +344000 ekin = 2.95985387154984 | erot = 3.1154751585035 | epot = -21.6815483295521 | etot = -15.6062192994987 +345000 ekin = 2.33428072266864 | erot = 2.88044431283017 | epot = -21.6567075042343 | etot = -16.4419824687355 +346000 ekin = 2.02077664062698 | erot = 3.45936833964707 | epot = -21.5877268821218 | etot = -16.1075819018478 +347000 ekin = 2.34924784800441 | erot = 1.93056350805623 | epot = -21.4896151766055 | etot = -17.2098038205448 +348000 ekin = 2.79839267202794 | erot = 2.79408776517963 | epot = -21.4682057474678 | etot = -15.8757253102602 +349000 ekin = 2.33820470114614 | erot = 3.12966318670513 | epot = -21.5603039389198 | etot = -16.0924360510685 +350000 ekin = 2.22383234890832 | erot = 2.38886870388011 | epot = -21.5375784703117 | etot = -16.9248774175233 +351000 ekin = 2.33329735253339 | erot = 2.84447430695179 | epot = -21.5078106306152 | etot = -16.33003897113 +352000 ekin = 2.74923373919408 | erot = 2.76796181793625 | epot = -21.5537134920816 | etot = -16.0365179349512 +353000 ekin = 1.76111836153717 | erot = 2.12255592617518 | epot = -21.5037017999955 | etot = -17.6200275122832 +354000 ekin = 2.29967358188085 | erot = 2.37615363620183 | epot = -21.559257977819 | etot = -16.8834307597364 +355000 ekin = 2.32956787601564 | erot = 2.41406261152025 | epot = -21.5311925684016 | etot = -16.7875620808657 +356000 ekin = 2.99536507165417 | erot = 3.0133786789017 | epot = -21.461213826164 | etot = -15.4524700756081 +357000 ekin = 1.79487551861702 | erot = 2.14781775756832 | epot = -21.4425100027869 | etot = -17.4998167266016 +358000 ekin = 2.06856992699964 | erot = 1.9158505155371 | epot = -21.4597512525557 | etot = -17.475330810019 +359000 ekin = 2.03457633089973 | erot = 2.13725650388114 | epot = -21.434584367242 | etot = -17.2627515324611 +360000 ekin = 2.64289898809605 | erot = 2.45722294398598 | epot = -21.3798303659973 | etot = -16.2797084339152 +361000 ekin = 2.44681633772951 | erot = 2.40323525392197 | epot = -21.4535746870958 | etot = -16.6035230954443 +362000 ekin = 2.27284400709389 | erot = 2.04866562998477 | epot = -21.4444048899961 | etot = -17.1228952529175 +363000 ekin = 3.23945885057604 | erot = 1.79247859381387 | epot = -21.4992698914106 | etot = -16.4673324470207 +364000 ekin = 3.01124200487831 | erot = 2.16495867321708 | epot = -21.5330648567406 | etot = -16.3568641786452 +365000 ekin = 2.51472285580867 | erot = 2.29864111879035 | epot = -21.6252096459669 | etot = -16.8118456713679 +366000 ekin = 2.59356655410022 | erot = 2.21031948632573 | epot = -21.6397726115723 | etot = -16.8358865711464 +367000 ekin = 2.23422490605626 | erot = 1.85375489374336 | epot = -21.7036464131406 | etot = -17.615666613341 +368000 ekin = 2.47747707853682 | erot = 2.36511710555106 | epot = -21.7442459693683 | etot = -16.9016517852804 +369000 ekin = 2.03854183495619 | erot = 2.80790943599038 | epot = -21.829546112742 | etot = -16.9830948417954 +370000 ekin = 2.08495509326204 | erot = 2.15717784784087 | epot = -21.8579547558588 | etot = -17.6158218147559 +371000 ekin = 2.1649158804987 | erot = 2.10731342711637 | epot = -21.750730287247 | etot = -17.4785009796319 +372000 ekin = 1.83416420958724 | erot = 1.90082367490453 | epot = -21.6784224725519 | etot = -17.9434345880602 +373000 ekin = 1.97176482573297 | erot = 1.77796007890949 | epot = -21.6393712386778 | etot = -17.8896463340354 +374000 ekin = 2.89940710658305 | erot = 1.91194262525378 | epot = -21.5337545453636 | etot = -16.7224048135267 +375000 ekin = 2.32339676163341 | erot = 1.92362318361284 | epot = -21.4217091025191 | etot = -17.1746891572728 +376000 ekin = 2.59047552311153 | erot = 2.32394149083979 | epot = -21.4139727856534 | etot = -16.4995557717021 +377000 ekin = 2.24598863840517 | erot = 1.65770205797294 | epot = -21.3405339068232 | etot = -17.4368432104451 +378000 ekin = 2.38351514056703 | erot = 2.54156262207207 | epot = -21.3122380587448 | etot = -16.3871602961057 +379000 ekin = 2.08457212928958 | erot = 2.11819645676889 | epot = -21.2663127721437 | etot = -17.0635441860853 +380000 ekin = 2.62168026009058 | erot = 2.36576073073357 | epot = -21.2469701231192 | etot = -16.259529132295 +381000 ekin = 2.42554871977308 | erot = 2.21588725182519 | epot = -21.2594018196931 | etot = -16.6179658480948 +382000 ekin = 2.04454090532126 | erot = 3.35199327879852 | epot = -21.3507561156204 | etot = -15.9542219315006 +383000 ekin = 2.57756769789846 | erot = 1.58356833947095 | epot = -21.4206473136967 | etot = -17.2595112763272 +384000 ekin = 2.32411392435712 | erot = 2.07034159075996 | epot = -21.425401700327 | etot = -17.03094618521 +385000 ekin = 1.93815279071873 | erot = 3.29970374476252 | epot = -21.4993838182002 | etot = -16.2615272827189 +386000 ekin = 2.10645704249442 | erot = 2.94380940917572 | epot = -21.5050572923383 | etot = -16.4547908406681 +387000 ekin = 2.28625118399721 | erot = 2.404880226949 | epot = -21.4350466670762 | etot = -16.74391525613 +388000 ekin = 2.84183807689895 | erot = 2.72440789072405 | epot = -21.448767296848 | etot = -15.882521329225 +389000 ekin = 3.39750799106372 | erot = 3.08194517695386 | epot = -21.6559630447603 | etot = -15.1765098767427 +390000 ekin = 2.82211920760115 | erot = 2.04880343622589 | epot = -21.7229608878358 | etot = -16.8520382440088 +391000 ekin = 2.25113345866117 | erot = 2.45876014532077 | epot = -21.7793475672488 | etot = -17.0694539632668 +392000 ekin = 2.6777973992177 | erot = 2.75278604715789 | epot = -21.9200377033298 | etot = -16.4894542569542 +393000 ekin = 2.07336639249413 | erot = 1.66102921524042 | epot = -22.0500496423094 | etot = -18.3156540345748 +394000 ekin = 2.1138614951422 | erot = 2.4065490584156 | epot = -22.0647062581752 | etot = -17.5442957046174 +395000 ekin = 2.46967791557607 | erot = 2.46187607744978 | epot = -22.0113006362931 | etot = -17.0797466432672 +396000 ekin = 3.17858061422168 | erot = 1.60030928107608 | epot = -21.9570022338792 | etot = -17.1781123385814 +397000 ekin = 2.37483507726776 | erot = 2.17387816921976 | epot = -21.8769234701935 | etot = -17.3282102237059 +398000 ekin = 2.29815779154461 | erot = 2.2014862703049 | epot = -21.8293641014529 | etot = -17.3297200396034 +399000 ekin = 2.66620669497936 | erot = 2.78316441348845 | epot = -21.7420307764657 | etot = -16.2926596679979 +400000 ekin = 1.8196142363994 | erot = 2.77573291920477 | epot = -21.7225828560707 | etot = -17.1272357004666 +401000 ekin = 2.39347596566753 | erot = 3.11237720134102 | epot = -21.7632198127751 | etot = -16.2573666457665 +402000 ekin = 4.01379092525261 | erot = 3.58756310879361 | epot = -21.6952307126456 | etot = -14.0938766785994 +403000 ekin = 3.64238723358271 | erot = 3.44210139074533 | epot = -21.6932224157202 | etot = -14.6087337913922 +404000 ekin = 2.52116102522202 | erot = 2.99286839639893 | epot = -21.7395466120138 | etot = -16.2255171903929 +405000 ekin = 2.80514548558626 | erot = 3.09807228440149 | epot = -21.809681120553 | etot = -15.9064633505653 +406000 ekin = 2.32696376764902 | erot = 2.03572639782902 | epot = -21.9111381639248 | etot = -17.5484479984468 +407000 ekin = 2.33504128016395 | erot = 1.91320949168965 | epot = -21.9359478399848 | etot = -17.6876970681312 +408000 ekin = 1.90942025822265 | erot = 2.20375631379574 | epot = -21.9849314014528 | etot = -17.8717548294344 +409000 ekin = 1.98818542800297 | erot = 1.95540808206523 | epot = -22.0378349759701 | etot = -18.0942414659019 +410000 ekin = 1.59823476401333 | erot = 1.91272967852491 | epot = -22.0830507565096 | etot = -18.5720863139714 +411000 ekin = 1.87320182179615 | erot = 2.46575148951076 | epot = -22.1911106440468 | etot = -17.8521573327399 +412000 ekin = 2.51909186028136 | erot = 2.65534868642724 | epot = -22.281680067606 | etot = -17.1072395208974 +413000 ekin = 2.80929435327118 | erot = 3.19888285052217 | epot = -22.1907679968741 | etot = -16.1825907930808 +414000 ekin = 2.79014519733558 | erot = 2.7251519541093 | epot = -22.144863024243 | etot = -16.6295658727981 +415000 ekin = 2.46789019087319 | erot = 2.24891720770208 | epot = -22.1977268949425 | etot = -17.4809194963672 +416000 ekin = 3.30766536008866 | erot = 1.55878918639505 | epot = -22.1694878213559 | etot = -17.3030332748722 +417000 ekin = 3.95074944679108 | erot = 2.44780201516577 | epot = -22.1018895242095 | etot = -15.7033380622526 +418000 ekin = 2.77340936693415 | erot = 2.68993840817536 | epot = -21.977327562767 | etot = -16.5139797876575 +419000 ekin = 2.38275203991917 | erot = 2.97769109273478 | epot = -21.9010102007429 | etot = -16.5405670680889 +420000 ekin = 1.80397709765343 | erot = 1.82715488758969 | epot = -21.8849019003165 | etot = -18.2537699150734 +421000 ekin = 1.35294173647286 | erot = 1.7746327595132 | epot = -21.8324727162455 | etot = -18.7048982202595 +422000 ekin = 1.39101035408781 | erot = 2.74626781088313 | epot = -21.8922044238521 | etot = -17.7549262588811 +423000 ekin = 1.58313118355036 | erot = 3.0798858727609 | epot = -21.9303489156376 | etot = -17.2673318593263 +424000 ekin = 2.38308976422853 | erot = 2.0290563283423 | epot = -22.0003513420112 | etot = -17.5882052494403 +425000 ekin = 2.32292982636642 | erot = 2.54472792699355 | epot = -22.0461884305753 | etot = -17.1785306772154 +426000 ekin = 2.07274921207622 | erot = 3.12068562025985 | epot = -21.9899604929779 | etot = -16.7965256606419 +427000 ekin = 2.16499158921497 | erot = 2.43609860560844 | epot = -21.883756502818 | etot = -17.2826663079946 +428000 ekin = 1.81001230881454 | erot = 1.6518491031194 | epot = -21.8651168729134 | etot = -18.4032554609795 +429000 ekin = 1.67080799563552 | erot = 2.55829004033943 | epot = -21.823203822061 | etot = -17.5941057860861 +430000 ekin = 2.68658781224627 | erot = 2.8591925337156 | epot = -21.8545360487503 | etot = -16.3087557027885 +431000 ekin = 2.77334901985549 | erot = 1.57746917070686 | epot = -21.8360353910944 | etot = -17.485217200532 +432000 ekin = 2.50244674166436 | erot = 1.60779258881598 | epot = -21.7381087453319 | etot = -17.6278694148516 +433000 ekin = 1.85649371322473 | erot = 2.4917335891794 | epot = -21.7919912827364 | etot = -17.4437639803323 +434000 ekin = 2.89302367450635 | erot = 2.7989004560269 | epot = -21.923157505168 | etot = -16.2312333746348 +435000 ekin = 3.67647442700572 | erot = 1.38588132381276 | epot = -22.1019777057281 | etot = -17.0396219549097 +436000 ekin = 3.05510329104703 | erot = 2.00142902882896 | epot = -22.1034257027066 | etot = -17.0468933828306 +437000 ekin = 3.2334117289381 | erot = 1.78346855436481 | epot = -22.1137020887251 | etot = -17.0968218054222 +438000 ekin = 2.86378458795303 | erot = 1.84588842157479 | epot = -22.072414124752 | etot = -17.3627411152242 +439000 ekin = 2.41407153953135 | erot = 2.70066632790346 | epot = -22.0535011599236 | etot = -16.9387632924888 +440000 ekin = 2.22110309163132 | erot = 3.0167468581899 | epot = -22.0773629228072 | etot = -16.839512972986 +441000 ekin = 2.8952003347941 | erot = 2.87911130379518 | epot = -22.2098492363511 | etot = -16.4355375977618 +442000 ekin = 2.05598301233622 | erot = 1.73562369066667 | epot = -22.2689079268812 | etot = -18.4773012238783 +443000 ekin = 1.86650631344267 | erot = 2.00816178040311 | epot = -22.3072964279925 | etot = -18.4326283341467 +444000 ekin = 2.06088560705618 | erot = 2.15265011198712 | epot = -22.3186686701219 | etot = -18.1051329510786 +445000 ekin = 2.10029110633057 | erot = 2.2800331405132 | epot = -22.3739249314238 | etot = -17.9936006845801 +446000 ekin = 2.42121462246176 | erot = 2.85365097104764 | epot = -22.4030820729314 | etot = -17.128216479422 +447000 ekin = 2.19905370994782 | erot = 2.98216231903379 | epot = -22.4760062523442 | etot = -17.2947902233625 +448000 ekin = 2.35344530580996 | erot = 2.94496431571713 | epot = -22.4927466941727 | etot = -17.1943370726456 +449000 ekin = 2.39032460069844 | erot = 2.92889137252356 | epot = -22.5027878081879 | etot = -17.1835718349659 +450000 ekin = 1.87543018481826 | erot = 1.69603328668916 | epot = -22.4562462785528 | etot = -18.8847828070454 +451000 ekin = 2.01850498861611 | erot = 1.92812989993404 | epot = -22.4817672986218 | etot = -18.5351324100716 +452000 ekin = 1.36652609658347 | erot = 1.87105620810406 | epot = -22.4501755877893 | etot = -19.2125932831018 +453000 ekin = 2.0599225820261 | erot = 2.56027964608567 | epot = -22.2765869721545 | etot = -17.6563847440428 +454000 ekin = 1.47421749728914 | erot = 2.19120144206327 | epot = -22.1381671023588 | etot = -18.4727481630064 +455000 ekin = 1.65550022307771 | erot = 2.72165814308168 | epot = -21.9904394751434 | etot = -17.613281108984 +456000 ekin = 2.34827062603187 | erot = 2.00722438151074 | epot = -21.9105114729144 | etot = -17.5550164653718 +457000 ekin = 2.01338249991754 | erot = 2.37170378033695 | epot = -21.8819790372449 | etot = -17.4968927569904 +458000 ekin = 1.72815421955305 | erot = 2.26329746701056 | epot = -21.9116044050661 | etot = -17.9201527185024 +459000 ekin = 2.48347398227002 | erot = 2.32376196929941 | epot = -21.9949404038568 | etot = -17.1877044522874 +460000 ekin = 2.18770854699575 | erot = 2.00081662918322 | epot = -21.9585322440375 | etot = -17.7700070678586 +461000 ekin = 2.27716435663744 | erot = 2.9019565626907 | epot = -21.8877682177659 | etot = -16.7086472984378 +462000 ekin = 2.61244889701715 | erot = 1.79757533309513 | epot = -21.9143949779912 | etot = -17.5043707478789 +463000 ekin = 2.55684814656524 | erot = 3.31200610027657 | epot = -21.8497749242034 | etot = -15.9809206773616 +464000 ekin = 2.15312235839157 | erot = 2.38947690136822 | epot = -21.7825241097983 | etot = -17.2399248500385 +465000 ekin = 2.5257577253008 | erot = 3.61331808321477 | epot = -21.70727052519 | etot = -15.5681947166744 +466000 ekin = 1.97943618964772 | erot = 2.88688528337621 | epot = -21.7222514097774 | etot = -16.8559299367535 +467000 ekin = 1.62882257493983 | erot = 2.60892282315519 | epot = -21.8080861041928 | etot = -17.5703407060978 +468000 ekin = 1.09823854644375 | erot = 3.35073251937299 | epot = -21.8523811012329 | etot = -17.4034100354162 +469000 ekin = 1.70229597385131 | erot = 2.7588984072639 | epot = -21.8665756757502 | etot = -17.405381294635 +470000 ekin = 1.85844768422772 | erot = 2.8706546217625 | epot = -21.9036130079376 | etot = -17.1745107019474 +471000 ekin = 2.74399539924327 | erot = 2.34943354955083 | epot = -21.9543989717239 | etot = -16.8609700229298 +472000 ekin = 2.7182617922689 | erot = 2.13581917182001 | epot = -22.0449294707038 | etot = -17.1908485066149 +473000 ekin = 2.29380642077304 | erot = 2.07595163501546 | epot = -22.0706135180041 | etot = -17.7008554622156 +474000 ekin = 2.22690782122656 | erot = 2.1647059901395 | epot = -22.0704871162386 | etot = -17.6788733048726 +475000 ekin = 2.4978679533329 | erot = 2.09510196885223 | epot = -22.0509742163569 | etot = -17.4580042941718 +476000 ekin = 2.20264299239668 | erot = 1.76757923556403 | epot = -21.9427521555982 | etot = -17.9725299276375 +477000 ekin = 2.45872237399503 | erot = 2.38426997478539 | epot = -21.9051474088983 | etot = -17.0621550601178 +478000 ekin = 1.89905964030889 | erot = 2.04864356713722 | epot = -21.9114508304737 | etot = -17.9637476230276 +479000 ekin = 2.27133902137491 | erot = 3.08755197682257 | epot = -21.8872829373266 | etot = -16.5283919391291 +480000 ekin = 1.67015605151468 | erot = 2.76560365045837 | epot = -21.8968158425889 | etot = -17.4610561406158 +481000 ekin = 1.81882995680354 | erot = 2.94136105971067 | epot = -21.8571304925407 | etot = -17.0969394760265 +482000 ekin = 2.15305069632653 | erot = 2.07327897823918 | epot = -21.8152992914385 | etot = -17.5889696168728 +483000 ekin = 1.50004535981758 | erot = 1.99364343935404 | epot = -21.7843644990947 | etot = -18.2906756999231 +484000 ekin = 1.85234844255529 | erot = 2.34000231202781 | epot = -21.8614293841666 | etot = -17.6690786295835 +485000 ekin = 1.64682178328831 | erot = 2.50437862576679 | epot = -21.8969405008956 | etot = -17.7457400918405 +486000 ekin = 1.86104257115938 | erot = 2.15995925522771 | epot = -21.8879397421696 | etot = -17.8669379157825 +487000 ekin = 2.34639026339217 | erot = 3.11622773972825 | epot = -21.9707194220382 | etot = -16.5081014189178 +488000 ekin = 2.27484994031488 | erot = 3.28147617368226 | epot = -21.9426475486812 | etot = -16.3863214346841 +489000 ekin = 2.38811933287365 | erot = 2.56070014238266 | epot = -21.8600861168089 | etot = -16.9112666415526 +490000 ekin = 2.12976254880773 | erot = 3.54525746010289 | epot = -21.7617637919249 | etot = -16.0867437830143 +491000 ekin = 2.20850764560417 | erot = 2.48919239454317 | epot = -21.6468680069132 | etot = -16.9491679667658 +492000 ekin = 2.43957739853024 | erot = 2.76323186690378 | epot = -21.6230951653168 | etot = -16.4202858998828 +493000 ekin = 1.79391622496105 | erot = 2.29052518470042 | epot = -21.6945975278841 | etot = -17.6101561182226 +494000 ekin = 2.11542949642227 | erot = 3.01313865872481 | epot = -21.7637004472039 | etot = -16.6351322920568 +495000 ekin = 2.1568591957283 | erot = 2.49005677705245 | epot = -21.8783556810053 | etot = -17.2314397082246 +496000 ekin = 2.06037552826019 | erot = 2.60698629104699 | epot = -21.9276220332962 | etot = -17.260260213989 +497000 ekin = 2.52228141248763 | erot = 1.710130192768 | epot = -21.8769629373864 | etot = -17.6445513321307 +498000 ekin = 2.15394500805411 | erot = 1.78777085700022 | epot = -21.8243748366056 | etot = -17.8826589715513 +499000 ekin = 3.01296343053108 | erot = 1.73934813146708 | epot = -21.8392632680439 | etot = -17.0869517060458 +500000 ekin = 2.76642119718551 | erot = 2.50182215373002 | epot = -21.830671988603 | etot = -16.5624286376875 +501000 ekin = 2.69367571720338 | erot = 2.99042817784739 | epot = -21.7039103667138 | etot = -16.0198064716631 +502000 ekin = 1.91666556639459 | erot = 3.89815239299714 | epot = -21.5845300715443 | etot = -15.7697121121525 +503000 ekin = 1.80513448090424 | erot = 2.94463129244922 | epot = -21.408846856306 | etot = -16.6590810829525 +504000 ekin = 1.70082883689617 | erot = 3.04312463877848 | epot = -21.3315058298563 | etot = -16.5875523541817 +505000 ekin = 2.75953000022913 | erot = 2.14635942194519 | epot = -21.3525103549444 | etot = -16.4466209327701 +506000 ekin = 2.29728093923375 | erot = 2.04403144683579 | epot = -21.3794572010067 | etot = -17.0381448149372 +507000 ekin = 3.17636857959624 | erot = 2.42164349794529 | epot = -21.4731108320934 | etot = -15.8750987545519 +508000 ekin = 2.53590109429522 | erot = 2.52790695399208 | epot = -21.6300410847596 | etot = -16.5662330364723 +509000 ekin = 2.12748393236722 | erot = 2.83071060777933 | epot = -21.7781347526393 | etot = -16.8199402124927 +510000 ekin = 2.16138023827908 | erot = 1.44739524871434 | epot = -21.8661383228762 | etot = -18.2573628358828 +511000 ekin = 2.5432337386743 | erot = 2.77108674378182 | epot = -21.9670096484361 | etot = -16.65268916598 +512000 ekin = 2.32820226144235 | erot = 2.8042493163404 | epot = -22.0177071813425 | etot = -16.8852556035598 +513000 ekin = 2.47700215188743 | erot = 2.17127792631492 | epot = -22.0110285387343 | etot = -17.3627484605319 +514000 ekin = 2.76651136580707 | erot = 2.55680467976047 | epot = -22.0909970005814 | etot = -16.7676809550138 +515000 ekin = 2.5202331965388 | erot = 1.82499891391154 | epot = -22.1712715169565 | etot = -17.8260394065062 +516000 ekin = 2.81741012640848 | erot = 2.22255273815334 | epot = -22.2621950124766 | etot = -17.2222321479148 +517000 ekin = 2.03287831599844 | erot = 2.04932227860395 | epot = -22.2794486174447 | etot = -18.1972480228423 +518000 ekin = 2.18753527424292 | erot = 2.76011341951323 | epot = -22.2667176836093 | etot = -17.3190689898532 +519000 ekin = 2.23127004412533 | erot = 2.23036422155453 | epot = -22.3641437250361 | etot = -17.9025094593562 +520000 ekin = 1.88835704965194 | erot = 2.20137678015021 | epot = -22.4547788180201 | etot = -18.365044988218 +521000 ekin = 2.57911594310157 | erot = 1.87216207270883 | epot = -22.6071563154982 | etot = -18.1558782996878 +522000 ekin = 3.47551915105823 | erot = 1.7762374523623 | epot = -22.6852629490162 | etot = -17.4335063455956 +523000 ekin = 2.84545293485784 | erot = 2.47507537559667 | epot = -22.727728352182 | etot = -17.4072000417275 +524000 ekin = 2.40278895519472 | erot = 2.37529684497552 | epot = -22.6643160930411 | etot = -17.8862302928709 +525000 ekin = 1.59507033575009 | erot = 2.61508341973268 | epot = -22.5633164974795 | etot = -18.3531627419968 +526000 ekin = 1.67007684014044 | erot = 1.59545284095808 | epot = -22.511319978416 | etot = -19.2457902973175 +527000 ekin = 2.19667533945247 | erot = 1.93330231246752 | epot = -22.4181345854017 | etot = -18.2881569334817 +528000 ekin = 2.6386695788743 | erot = 2.84200507572115 | epot = -22.4271496272375 | etot = -16.946474972642 +529000 ekin = 2.71685924097597 | erot = 3.01195511036354 | epot = -22.4607209136928 | etot = -16.7319065623533 +530000 ekin = 2.59646038482582 | erot = 2.1317692819235 | epot = -22.3209630404852 | etot = -17.5927333737358 +531000 ekin = 2.96818211550215 | erot = 2.35836906019033 | epot = -22.2240561584028 | etot = -16.8975049827103 +532000 ekin = 2.54400448114086 | erot = 2.32266423688292 | epot = -22.2383323718678 | etot = -17.3716636538441 +533000 ekin = 2.47235456553948 | erot = 2.96337386592411 | epot = -22.2434312615742 | etot = -16.8077028301106 +534000 ekin = 2.104894788263 | erot = 2.03894640697441 | epot = -22.2624131617689 | etot = -18.1185719665315 +535000 ekin = 3.76811893478762 | erot = 2.64694643296526 | epot = -22.2342741399369 | etot = -15.819208772184 +536000 ekin = 2.78932048770646 | erot = 1.95046774407585 | epot = -22.1710588414062 | etot = -17.4312706096239 +537000 ekin = 2.84547413963846 | erot = 2.6235440651257 | epot = -22.0792539675812 | etot = -16.610235762817 +538000 ekin = 2.67615418297317 | erot = 2.08962546790895 | epot = -21.9560559397441 | etot = -17.190276288862 +539000 ekin = 2.73041224389434 | erot = 2.35761678189143 | epot = -22.0360310245606 | etot = -16.9480019987748 +540000 ekin = 2.45513520817505 | erot = 2.4980712479617 | epot = -22.1997448500024 | etot = -17.2465383938656 +541000 ekin = 3.48268229748523 | erot = 2.77797330372245 | epot = -22.2939060084685 | etot = -16.0332504072608 +542000 ekin = 2.48960436886327 | erot = 2.87332479229809 | epot = -22.3004887690915 | etot = -16.9375596079301 +543000 ekin = 2.34699181381528 | erot = 2.86167842257193 | epot = -22.3027783678197 | etot = -17.0941081314325 +544000 ekin = 2.22918134297116 | erot = 1.4682792461716 | epot = -22.2757921511235 | etot = -18.5783315619807 +545000 ekin = 2.45393652663684 | erot = 2.14178562937392 | epot = -22.2696521197313 | etot = -17.6739299637206 +546000 ekin = 1.98434977645849 | erot = 2.24144093113159 | epot = -22.232171992891 | etot = -18.0063812853009 +547000 ekin = 2.56230350196472 | erot = 1.8957462591202 | epot = -22.2013923967025 | etot = -17.7433426356176 +548000 ekin = 1.72907614338158 | erot = 1.64127030305735 | epot = -22.1897325934373 | etot = -18.8193861469984 +549000 ekin = 1.95696682165776 | erot = 2.64539988943055 | epot = -22.3281210018679 | etot = -17.7257542907796 +550000 ekin = 1.80672944936439 | erot = 1.58554489058937 | epot = -22.4379557312283 | etot = -19.0456813912745 +551000 ekin = 2.19785864069661 | erot = 2.26344341600386 | epot = -22.4944444264338 | etot = -18.0331423697333 +552000 ekin = 2.074442528674 | erot = 2.49246441473273 | epot = -22.5313734934249 | etot = -17.9644665500182 +553000 ekin = 2.94841939583913 | erot = 2.1230978630074 | epot = -22.5870982488507 | etot = -17.5155809900042 +554000 ekin = 2.86687820100223 | erot = 1.9428729838172 | epot = -22.755332978123 | etot = -17.9455817933036 +555000 ekin = 2.43102414091851 | erot = 2.28708167460996 | epot = -22.8409516497233 | etot = -18.1228458341949 +556000 ekin = 2.31020008885682 | erot = 2.55815314755913 | epot = -22.8777743355338 | etot = -18.0094210991179 +557000 ekin = 2.81359485404958 | erot = 1.42586137655665 | epot = -22.93912738 | etot = -18.6996711493938 +558000 ekin = 2.7970970853355 | erot = 1.99545051650404 | epot = -22.9823826800611 | etot = -18.1898350782216 +559000 ekin = 3.34842854089643 | erot = 2.30939572175805 | epot = -23.0558646505447 | etot = -17.3980403878902 +560000 ekin = 3.12583165184862 | erot = 2.33613566970363 | epot = -23.0537007225862 | etot = -17.591733401034 +561000 ekin = 2.9127609673679 | erot = 2.07459481236913 | epot = -22.982260765434 | etot = -17.994904985697 +562000 ekin = 3.33017095598494 | erot = 2.52215992853225 | epot = -22.8889363116257 | etot = -17.0366054271086 +563000 ekin = 2.70200701416854 | erot = 1.64770113379199 | epot = -22.8712722594835 | etot = -18.521564111523 +564000 ekin = 2.82953631474813 | erot = 2.52900560163798 | epot = -22.8387855460795 | etot = -17.4802436296934 +565000 ekin = 2.67999888917708 | erot = 2.05091800967453 | epot = -22.7937507048715 | etot = -18.0628338060199 +566000 ekin = 2.32986557500305 | erot = 2.16379904557213 | epot = -22.8028233873669 | etot = -18.3091587667917 +567000 ekin = 1.92319601586312 | erot = 2.83258522428556 | epot = -22.7588270107033 | etot = -18.0030457705546 +568000 ekin = 2.1767237164987 | erot = 2.23391201707386 | epot = -22.7857243432792 | etot = -18.3750886097066 +569000 ekin = 2.44197408396629 | erot = 2.6515953630557 | epot = -22.7197314796374 | etot = -17.6261620326154 +570000 ekin = 2.43177406209051 | erot = 1.89764945519458 | epot = -22.6963472615904 | etot = -18.3669237443054 +571000 ekin = 2.86160521289847 | erot = 2.96804382024775 | epot = -22.6961835038031 | etot = -16.8665344706569 +572000 ekin = 1.92662919536387 | erot = 3.79135909534691 | epot = -22.6587081618987 | etot = -16.940719871188 +573000 ekin = 2.40137439242946 | erot = 2.29982613356341 | epot = -22.6365074046858 | etot = -17.935306878693 +574000 ekin = 1.68882589350908 | erot = 2.3209740449249 | epot = -22.6783832960445 | etot = -18.6685833576105 +575000 ekin = 1.85490665091732 | erot = 1.8564080891142 | epot = -22.7444448136904 | etot = -19.0331300736588 +576000 ekin = 3.24775679594035 | erot = 2.9556926821431 | epot = -22.6991990620437 | etot = -16.4957495839603 +577000 ekin = 2.89423151645282 | erot = 2.87486712706735 | epot = -22.628436560802 | etot = -16.8593379172818 +578000 ekin = 2.4046091667757 | erot = 2.78216711024699 | epot = -22.4348874817265 | etot = -17.2481112047039 +579000 ekin = 2.40580528046576 | erot = 1.9955781448253 | epot = -22.288913673667 | etot = -17.887530248376 +580000 ekin = 2.69817090358906 | erot = 1.94741864170502 | epot = -22.1754486864787 | etot = -17.5298591411846 +581000 ekin = 2.06309668646281 | erot = 2.97621367011722 | epot = -22.0670098600828 | etot = -17.0276995035027 +582000 ekin = 2.33869527454826 | erot = 3.07898324506955 | epot = -21.9478320300713 | etot = -16.5301535104535 +583000 ekin = 2.23428959741495 | erot = 2.68476693088864 | epot = -21.837983720672 | etot = -16.9189271923684 +584000 ekin = 2.94321016295282 | erot = 2.59995039730549 | epot = -21.7517635625832 | etot = -16.2086030023248 +585000 ekin = 2.36063475490835 | erot = 2.49112677628938 | epot = -21.7173359488816 | etot = -16.8655744176839 +586000 ekin = 3.56583702163525 | erot = 2.02487858259688 | epot = -21.7707868137138 | etot = -16.1800712094817 +587000 ekin = 3.53727585853243 | erot = 1.9725893265202 | epot = -21.7665121756112 | etot = -16.2566469905585 +588000 ekin = 2.82339556293757 | erot = 1.59340504807046 | epot = -21.7545319340972 | etot = -17.3377313230892 +589000 ekin = 2.31627310139818 | erot = 2.20582604523299 | epot = -21.8199173705563 | etot = -17.2978182239252 +590000 ekin = 2.57616671531331 | erot = 1.72768273328208 | epot = -21.8427138199642 | etot = -17.5388643713688 +591000 ekin = 1.91473306171853 | erot = 3.80604384238379 | epot = -21.9351393124187 | etot = -16.2143624083164 +592000 ekin = 2.11222958764659 | erot = 2.84208333850205 | epot = -21.9639458839076 | etot = -17.0096329577589 +593000 ekin = 1.66462149590471 | erot = 2.46217253451014 | epot = -21.9921445323971 | etot = -17.8653505019822 +594000 ekin = 1.86314045588476 | erot = 2.37275936142268 | epot = -22.1149191228505 | etot = -17.879019305543 +595000 ekin = 1.6397125755004 | erot = 2.1497024679856 | epot = -22.2960530768755 | etot = -18.5066380333895 +596000 ekin = 1.86247376576131 | erot = 1.5693809542787 | epot = -22.4014957466218 | etot = -18.9696410265818 +597000 ekin = 2.210739014067 | erot = 2.3087175693751 | epot = -22.4599242604733 | etot = -17.9404676770312 +598000 ekin = 1.8660134932493 | erot = 3.02311727399809 | epot = -22.5165298316334 | etot = -17.627399064386 +599000 ekin = 2.86271635930755 | erot = 2.19928854437227 | epot = -22.536599708025 | etot = -17.4745948043452 +600000 ekin = 2.65062163067179 | erot = 2.14533898812782 | epot = -22.4620537969303 | etot = -17.6660931781307 +601000 ekin = 2.97018864875202 | erot = 3.19824090103877 | epot = -22.3271949752462 | etot = -16.1587654254554 +602000 ekin = 2.93416893709001 | erot = 2.68627449040958 | epot = -22.2245183728173 | etot = -16.6040749453177 +603000 ekin = 2.5987545006459 | erot = 2.71301833029982 | epot = -22.1705323477201 | etot = -16.8587595167744 +604000 ekin = 1.79059859762797 | erot = 2.11515305424796 | epot = -22.1931056020217 | etot = -18.2873539501458 +605000 ekin = 1.82914051863723 | erot = 2.27656979248766 | epot = -22.2183915784731 | etot = -18.1126812673482 +606000 ekin = 2.33864125390345 | erot = 2.204164937778 | epot = -22.1617656383863 | etot = -17.6189594467048 +607000 ekin = 2.72666217259876 | erot = 2.97710334336218 | epot = -22.1572786906588 | etot = -16.4535131746978 +608000 ekin = 2.45226937954678 | erot = 2.41232790919959 | epot = -22.1263051367364 | etot = -17.2617078479901 +609000 ekin = 1.91032127854288 | erot = 2.62712516529567 | epot = -22.0127581830193 | etot = -17.4753117391807 +610000 ekin = 3.01319055031108 | erot = 2.17098104720965 | epot = -21.930499629869 | etot = -16.7463280323483 +611000 ekin = 2.44410994437293 | erot = 2.75159061185424 | epot = -21.9258193850468 | etot = -16.7301188288197 +612000 ekin = 2.50271115837174 | erot = 2.16817640692169 | epot = -21.9676183236645 | etot = -17.2967307583711 +613000 ekin = 3.01842230632868 | erot = 2.12784419676567 | epot = -22.0277467117807 | etot = -16.8814802086864 +614000 ekin = 2.25331711369829 | erot = 2.99334048390158 | epot = -22.0701464667307 | etot = -16.8234888691309 +615000 ekin = 1.66376443031995 | erot = 2.63613776051569 | epot = -21.9985978951916 | etot = -17.698695704356 +616000 ekin = 1.89454248699046 | erot = 2.87318355169532 | epot = -22.0041678369046 | etot = -17.2364417982189 +617000 ekin = 2.14789714287838 | erot = 2.51249074123957 | epot = -22.0251474680604 | etot = -17.3647595839425 +618000 ekin = 3.11174934178844 | erot = 2.74374306269141 | epot = -21.980284295602 | etot = -16.1247918911221 +619000 ekin = 3.41036213968179 | erot = 2.10616794159728 | epot = -21.9557959924962 | etot = -16.4392659112171 +620000 ekin = 4.28430989238205 | erot = 2.19572475327593 | epot = -21.9033881020935 | etot = -15.4233534564355 +621000 ekin = 3.095687767491 | erot = 2.55794040804605 | epot = -21.8286763731363 | etot = -16.1750481975993 +622000 ekin = 2.76030419206697 | erot = 2.60754397958254 | epot = -21.7459002641757 | etot = -16.3780520925262 +623000 ekin = 2.87269212022169 | erot = 2.90401311950186 | epot = -21.5853226709315 | etot = -15.8086174312079 +624000 ekin = 2.01889500087932 | erot = 3.41825755609791 | epot = -21.4095311686242 | etot = -15.972378611647 +625000 ekin = 2.87966631754697 | erot = 2.69115421564283 | epot = -21.2859406043045 | etot = -15.7151200711147 +626000 ekin = 2.56087279949319 | erot = 2.15801254335177 | epot = -21.2329175358055 | etot = -16.5140321929606 +627000 ekin = 2.30197939613517 | erot = 2.40176668957967 | epot = -21.2932794652839 | etot = -16.589533379569 +628000 ekin = 2.23988628353727 | erot = 2.75332535542195 | epot = -21.4558642198861 | etot = -16.4626525809268 +629000 ekin = 2.20891060851904 | erot = 1.97036896055006 | epot = -21.6109313731644 | etot = -17.4316518040953 +630000 ekin = 2.48711004105954 | erot = 2.14055508379566 | epot = -21.6286281269545 | etot = -17.0009630020993 +631000 ekin = 2.05035510102044 | erot = 1.78519131042561 | epot = -21.633635046353 | etot = -17.798088634907 +632000 ekin = 1.65439924450982 | erot = 3.28310987077496 | epot = -21.6999899301469 | etot = -16.7624808148621 +633000 ekin = 2.34657988531209 | erot = 2.34109631044869 | epot = -21.8317647703271 | etot = -17.1440885745664 +634000 ekin = 2.31570267703931 | erot = 2.471293173825 | epot = -21.8814211467029 | etot = -17.0944252958386 +635000 ekin = 1.99068848818427 | erot = 3.35493927676214 | epot = -21.9111632351734 | etot = -16.565535470227 +636000 ekin = 2.5015676385862 | erot = 2.48847742334419 | epot = -21.8752689055209 | etot = -16.8852238435905 +637000 ekin = 2.76558055064046 | erot = 2.80410341825293 | epot = -21.7874464522772 | etot = -16.2177624833838 +638000 ekin = 2.45488734924466 | erot = 2.81516363335622 | epot = -21.897362338598 | etot = -16.6273113559971 +639000 ekin = 1.89221088715375 | erot = 2.13319565970052 | epot = -21.932098303477 | etot = -17.9066917566227 +640000 ekin = 2.12173400886946 | erot = 3.32302167857403 | epot = -21.8808288554836 | etot = -16.4360731680401 +641000 ekin = 2.09554541112562 | erot = 2.23098450754968 | epot = -21.9203390995502 | etot = -17.5938091808749 +642000 ekin = 2.28696138506763 | erot = 2.67378976619349 | epot = -21.9723604262128 | etot = -17.0116092749517 +643000 ekin = 2.74450005384908 | erot = 2.20403941809548 | epot = -21.9235240791533 | etot = -16.9749846072088 +644000 ekin = 2.87909523138453 | erot = 3.40688779630214 | epot = -21.9417833997402 | etot = -15.6558003720535 +645000 ekin = 2.38284095628021 | erot = 2.10846397463902 | epot = -21.8306349073152 | etot = -17.339329976396 +646000 ekin = 2.68568471833193 | erot = 1.8085210536706 | epot = -21.6853054888873 | etot = -17.1910997168848 +647000 ekin = 2.44462012552757 | erot = 2.00446720103467 | epot = -21.4974635292911 | etot = -17.0483762027288 +648000 ekin = 2.22150753159449 | erot = 1.69679185313772 | epot = -21.5947311257684 | etot = -17.6764317410362 +649000 ekin = 2.55943952639507 | erot = 1.77203724563615 | epot = -22.016770390185 | etot = -17.6852936181538 +650000 ekin = 2.7234725572106 | erot = 2.20418229003755 | epot = -22.1594214535889 | etot = -17.2317666063407 +651000 ekin = 2.25383373914402 | erot = 3.26326768595798 | epot = -22.2274805933885 | etot = -16.7103791682865 +652000 ekin = 2.35810253390822 | erot = 2.29591208392313 | epot = -22.2332195197311 | etot = -17.5792049018997 +653000 ekin = 2.06421004499471 | erot = 2.1417184547457 | epot = -22.2265612208312 | etot = -18.0206327210908 +654000 ekin = 2.30460304373657 | erot = 1.85567946278894 | epot = -22.2521914868228 | etot = -18.0919089802973 +655000 ekin = 2.11188824015111 | erot = 1.79072614414006 | epot = -22.2262193909715 | etot = -18.3236050066803 +656000 ekin = 2.44561836830367 | erot = 2.32567811025775 | epot = -22.1872376286341 | etot = -17.4159411500727 +657000 ekin = 2.45751083141108 | erot = 2.86439216413734 | epot = -22.1805503246548 | etot = -16.8586473291064 +658000 ekin = 2.49955432693124 | erot = 2.85472680235227 | epot = -22.1390040132353 | etot = -16.7847228839518 +659000 ekin = 3.37980090980363 | erot = 2.77552992994233 | epot = -21.9898923341708 | etot = -15.8345614944249 +660000 ekin = 2.6941462621918 | erot = 1.99094454704574 | epot = -21.839770569098 | etot = -17.1546797598605 +661000 ekin = 2.21049176877594 | erot = 2.52393650500608 | epot = -21.6857326790217 | etot = -16.9513044052397 +662000 ekin = 2.06962867519899 | erot = 2.53976085175021 | epot = -21.6239147287108 | etot = -17.0145252017616 +663000 ekin = 2.27770295544224 | erot = 2.30124717941155 | epot = -21.5870186127932 | etot = -17.0080684779394 +664000 ekin = 2.39061717453214 | erot = 1.87616423363735 | epot = -21.4930500427881 | etot = -17.2262686346187 +665000 ekin = 2.66924405123179 | erot = 2.29240983153227 | epot = -21.4402310096658 | etot = -16.4785771269017 +666000 ekin = 1.66318176263893 | erot = 2.30827907651666 | epot = -21.3477804932103 | etot = -17.3763196540548 +667000 ekin = 1.65573830146343 | erot = 2.8261361193353 | epot = -21.2651811028886 | etot = -16.7833066820899 +668000 ekin = 2.50126196238916 | erot = 3.29062396521939 | epot = -21.1310768281354 | etot = -15.3391909005269 +669000 ekin = 1.61008562219097 | erot = 2.65727107854378 | epot = -21.0513800034042 | etot = -16.7840233026694 +670000 ekin = 2.21851826153844 | erot = 2.60770568109394 | epot = -20.9727942140714 | etot = -16.146570271439 +671000 ekin = 2.25905318343359 | erot = 2.15965495575029 | epot = -20.920836534986 | etot = -16.5021283958021 +672000 ekin = 1.93426342346647 | erot = 1.65365047668441 | epot = -20.8333028169839 | etot = -17.245388916833 +673000 ekin = 1.880896686753 | erot = 2.07483128120029 | epot = -20.79952620348 | etot = -16.8437982355267 +674000 ekin = 2.06783468057301 | erot = 2.16234064938726 | epot = -20.8176950919606 | etot = -16.5875197620003 +675000 ekin = 2.03952283590142 | erot = 2.48129689359269 | epot = -20.8297865902612 | etot = -16.3089668607671 +676000 ekin = 2.44687523374789 | erot = 2.77932995735251 | epot = -20.8513819036485 | etot = -15.6251767125481 +677000 ekin = 2.18851088067448 | erot = 2.6192892566419 | epot = -20.8589021998565 | etot = -16.0511020625401 +678000 ekin = 2.13451298865477 | erot = 2.78742961560772 | epot = -20.7380850837789 | etot = -15.8161424795164 +679000 ekin = 2.15556981522704 | erot = 2.17593910434841 | epot = -20.629255081746 | etot = -16.2977461621706 +680000 ekin = 2.0771745141444 | erot = 2.68436897198806 | epot = -20.6512705044545 | etot = -15.889727018322 +681000 ekin = 2.16836766753576 | erot = 1.82666294843077 | epot = -20.7392652191906 | etot = -16.744234603224 +682000 ekin = 3.01810965188601 | erot = 2.39774897550361 | epot = -20.7185667085479 | etot = -15.3027080811583 +683000 ekin = 2.84169666492797 | erot = 2.09885122074905 | epot = -20.7261705834808 | etot = -15.7856226978037 +684000 ekin = 1.9625035286937 | erot = 2.99543980855394 | epot = -20.7697045673731 | etot = -15.8117612301254 +685000 ekin = 1.50086016290167 | erot = 2.04478648729578 | epot = -20.7788952528481 | etot = -17.2332486026506 +686000 ekin = 2.3009298353038 | erot = 2.55442118756325 | epot = -20.7673358731011 | etot = -15.9119848502341 +687000 ekin = 1.86053862979306 | erot = 2.84846934037481 | epot = -20.7009117540898 | etot = -15.9919037839219 +688000 ekin = 2.56859020075852 | erot = 2.23263295871676 | epot = -20.6563366249257 | etot = -15.8551134654504 +689000 ekin = 2.7493014170063 | erot = 2.68327386026116 | epot = -20.8092642099637 | etot = -15.3766889326963 +690000 ekin = 2.67477310841297 | erot = 2.52397256899153 | epot = -21.0730303416649 | etot = -15.8742846642604 +691000 ekin = 2.28465281003006 | erot = 2.52273866559282 | epot = -21.2401157605126 | etot = -16.4327242848897 +692000 ekin = 2.42087744380444 | erot = 3.24812320332686 | epot = -21.2665776826931 | etot = -15.5975770355618 +693000 ekin = 2.37642605279041 | erot = 2.99546830568891 | epot = -21.3330277418611 | etot = -15.9611333833818 +694000 ekin = 2.69750178365984 | erot = 2.53085866970816 | epot = -21.521485598392 | etot = -16.293125145024 +695000 ekin = 2.49230316198816 | erot = 1.18105864485318 | epot = -21.6959912399269 | etot = -18.0226294330856 +696000 ekin = 1.86075498586631 | erot = 1.46501529683133 | epot = -21.6808441671222 | etot = -18.3550738844245 +697000 ekin = 2.40460770445908 | erot = 2.10461647488794 | epot = -21.7143559347048 | etot = -17.2051317553578 +698000 ekin = 2.32098148261586 | erot = 1.91506962097515 | epot = -21.7787361369849 | etot = -17.5426850333939 +699000 ekin = 2.44943497732062 | erot = 2.56143482106644 | epot = -21.7638026578475 | etot = -16.7529328594605 +700000 ekin = 2.13119890669415 | erot = 2.28802336161954 | epot = -21.6714710604343 | etot = -17.2522487921206 +701000 ekin = 2.15013169314239 | erot = 2.18565847708907 | epot = -21.5488216255628 | etot = -17.2130314553313 +702000 ekin = 1.57482438035702 | erot = 1.99931097090508 | epot = -21.5047640382371 | etot = -17.930628686975 +703000 ekin = 2.08829522236785 | erot = 2.17557396869524 | epot = -21.5242713758434 | etot = -17.2604021847803 +704000 ekin = 2.82144699483839 | erot = 1.94479401958833 | epot = -21.5462466947694 | etot = -16.7800056803427 +705000 ekin = 2.81019786745821 | erot = 2.16662483548889 | epot = -21.497690476826 | etot = -16.5208677738789 +706000 ekin = 1.97639068263159 | erot = 2.31468002405233 | epot = -21.494117475981 | etot = -17.2030467692971 +707000 ekin = 1.90740387464487 | erot = 2.04436544372037 | epot = -21.5505486138142 | etot = -17.5987792954489 +708000 ekin = 2.4927128838246 | erot = 2.15829540621563 | epot = -21.5728746117359 | etot = -16.9218663216957 +709000 ekin = 2.89296518644075 | erot = 2.58120965850485 | epot = -21.6152997801578 | etot = -16.1411249352122 +710000 ekin = 2.18515172086139 | erot = 2.27924743097097 | epot = -21.5865916502444 | etot = -17.122192498412 +711000 ekin = 2.31589231212299 | erot = 1.40143925977899 | epot = -21.6089597508522 | etot = -17.8916281789502 +712000 ekin = 2.55835611026778 | erot = 2.27281573655802 | epot = -21.7227687229586 | etot = -16.8915968761328 +713000 ekin = 1.95615391137192 | erot = 2.3180685223896 | epot = -21.8059432402922 | etot = -17.5317208065307 +714000 ekin = 2.56238583099812 | erot = 2.10850361056242 | epot = -21.8681675013087 | etot = -17.1972780597481 +715000 ekin = 2.42321114653449 | erot = 3.74023135295615 | epot = -21.8498336266088 | etot = -15.6863911271181 +716000 ekin = 2.83316600532177 | erot = 2.84850242081136 | epot = -21.7640231598546 | etot = -16.0823547337214 +717000 ekin = 3.45113934412558 | erot = 3.20598462177201 | epot = -21.667790662391 | etot = -15.0106666964934 +718000 ekin = 3.10736232683018 | erot = 3.94031338601797 | epot = -21.5629179727886 | etot = -14.5152422599405 +719000 ekin = 2.38564322644681 | erot = 2.95089811755838 | epot = -21.5481188237003 | etot = -16.2115774796951 +720000 ekin = 2.22543420991222 | erot = 3.14305432696276 | epot = -21.5381615962024 | etot = -16.1696730593274 +721000 ekin = 1.71709109813907 | erot = 2.23939430363989 | epot = -21.4645851946691 | etot = -17.5080997928902 +722000 ekin = 1.93213958129581 | erot = 2.81573218276728 | epot = -21.4896847080113 | etot = -16.7418129439482 +723000 ekin = 2.3814534534689 | erot = 2.55666957995948 | epot = -21.4374887927968 | etot = -16.4993657593684 +724000 ekin = 1.74740284448188 | erot = 2.4555617568904 | epot = -21.4125175551609 | etot = -17.2095529537886 +725000 ekin = 2.29233638352032 | erot = 2.9526701477774 | epot = -21.4751392844086 | etot = -16.2301327531109 +726000 ekin = 1.63503646092182 | erot = 2.30649262262117 | epot = -21.5156851039584 | etot = -17.5741560204154 +727000 ekin = 2.46705454176008 | erot = 3.19802987014479 | epot = -21.5382715508196 | etot = -15.8731871389148 +728000 ekin = 2.21709576272191 | erot = 2.16616227421244 | epot = -21.5244744557248 | etot = -17.1412164187904 +729000 ekin = 1.89396537247993 | erot = 1.66596987620967 | epot = -21.5644109232526 | etot = -18.004475674563 +730000 ekin = 1.78155182892059 | erot = 2.15399661961713 | epot = -21.5594738957829 | etot = -17.6239254472452 +731000 ekin = 2.16713092512296 | erot = 2.96875570154118 | epot = -21.4952326145865 | etot = -16.3593459879223 +732000 ekin = 2.40927355189018 | erot = 2.27189990077002 | epot = -21.3831563581627 | etot = -16.7019829055024 +733000 ekin = 3.04824198143784 | erot = 2.57289903054807 | epot = -21.429005165309 | etot = -15.8078641533231 +734000 ekin = 2.36703883022855 | erot = 2.04468815017469 | epot = -21.4926214065432 | etot = -17.0808944261399 +735000 ekin = 2.13292788677937 | erot = 1.55097035487251 | epot = -21.5455592190822 | etot = -17.8616609774303 +736000 ekin = 2.13562110082196 | erot = 3.45795834862287 | epot = -21.6515763333194 | etot = -16.0579968838746 +737000 ekin = 1.73550703692746 | erot = 3.58781244645382 | epot = -21.6785680654269 | etot = -16.3552485820456 +738000 ekin = 2.01136680767019 | erot = 2.50533140705366 | epot = -21.7068415263434 | etot = -17.1901433116196 +739000 ekin = 1.85122466968333 | erot = 2.19323904324285 | epot = -21.7211705032462 | etot = -17.6767067903201 +740000 ekin = 2.84677298867337 | erot = 2.79086338446698 | epot = -21.7460997683893 | etot = -16.108463395249 +741000 ekin = 2.47281769013274 | erot = 2.90867674862121 | epot = -21.8038806031312 | etot = -16.4223861643772 +742000 ekin = 2.74212748781964 | erot = 3.26601844940295 | epot = -21.9417105639309 | etot = -15.9335646267083 +743000 ekin = 2.23337436613032 | erot = 3.20752099935254 | epot = -22.0769938861091 | etot = -16.6360985206262 +744000 ekin = 2.01007582963959 | erot = 3.79208398827071 | epot = -22.1581491314472 | etot = -16.3559893135369 +745000 ekin = 3.14168435406402 | erot = 2.32756039064277 | epot = -22.1552791709709 | etot = -16.6860344262642 +746000 ekin = 2.96147960587595 | erot = 2.64919778641529 | epot = -22.131657657659 | etot = -16.5209802653678 +747000 ekin = 2.31713973406909 | erot = 2.0538838502724 | epot = -22.1362115743712 | etot = -17.7651879900297 +748000 ekin = 2.36228107661837 | erot = 2.41530550223615 | epot = -22.1703943251347 | etot = -17.3928077462802 +749000 ekin = 2.07006713072585 | erot = 2.7743291960411 | epot = -22.1708421357978 | etot = -17.3264458090308 +750000 ekin = 1.65834656870048 | erot = 2.38415657369843 | epot = -22.2465520170919 | etot = -18.204048874693 +751000 ekin = 1.79302728344389 | erot = 2.827102160061 | epot = -22.3488339479635 | etot = -17.7287045044586 +752000 ekin = 1.35555517803007 | erot = 1.46019783589209 | epot = -22.4342877547318 | etot = -19.6185347408096 +753000 ekin = 1.88586262445723 | erot = 2.44014879801272 | epot = -22.3837690917336 | etot = -18.0577576692636 +754000 ekin = 1.74745498380874 | erot = 2.73612011854199 | epot = -22.2852965474798 | etot = -17.8017214451291 +755000 ekin = 2.39590781949902 | erot = 2.41019902787154 | epot = -22.2066358684386 | etot = -17.400529021068 +756000 ekin = 1.83745653598818 | erot = 2.79024351605605 | epot = -22.133592240187 | etot = -17.5058921881428 +757000 ekin = 1.97281200687049 | erot = 2.57792722235948 | epot = -22.0604464398181 | etot = -17.5097072105881 +758000 ekin = 1.18945619136922 | erot = 2.72372183682492 | epot = -21.9899494795137 | etot = -18.0767714513196 +759000 ekin = 2.16230453116658 | erot = 1.39722896511084 | epot = -22.0003304659983 | etot = -18.4407969697208 +760000 ekin = 2.57253050230035 | erot = 2.33269711137819 | epot = -22.0357457302398 | etot = -17.1305181165612 +761000 ekin = 2.08545216810511 | erot = 2.24940559703297 | epot = -22.1132097744113 | etot = -17.7783520092733 +762000 ekin = 2.13509249172209 | erot = 1.66078369856518 | epot = -22.1380840935026 | etot = -18.3422079032154 +763000 ekin = 2.42851727622128 | erot = 3.36016749294484 | epot = -22.2079173436287 | etot = -16.4192325744626 +764000 ekin = 2.84703530894743 | erot = 2.79172375883345 | epot = -22.2143624032421 | etot = -16.5756033354612 +765000 ekin = 1.81325658345262 | erot = 2.77448180912351 | epot = -22.1194010453623 | etot = -17.5316626527862 +766000 ekin = 2.64831101430988 | erot = 2.3138164970859 | epot = -21.9919179324216 | etot = -17.0297904210258 +767000 ekin = 2.58949745571041 | erot = 2.86718473216884 | epot = -21.9087370669524 | etot = -16.4520548790732 +768000 ekin = 1.86313167956692 | erot = 2.78552244417217 | epot = -21.9381577980074 | etot = -17.2895036742683 +769000 ekin = 2.40162376419982 | erot = 2.31402374045875 | epot = -22.0373843590672 | etot = -17.3217368544087 +770000 ekin = 2.49146487205159 | erot = 3.23101926076328 | epot = -22.1439576198693 | etot = -16.4214734870544 +771000 ekin = 2.33226337742861 | erot = 2.27787220200643 | epot = -22.1812213688414 | etot = -17.5710857894063 +772000 ekin = 2.28990016215835 | erot = 2.99389364569332 | epot = -22.2765115340955 | etot = -16.9927177262439 +773000 ekin = 2.23002457595115 | erot = 1.82240115552767 | epot = -22.3379686916384 | etot = -18.2855429601596 +774000 ekin = 2.82350297312971 | erot = 2.21054815770298 | epot = -22.331524297742 | etot = -17.2974731669093 +775000 ekin = 1.82305982105504 | erot = 1.87100336542221 | epot = -22.2729891281483 | etot = -18.578925941671 +776000 ekin = 1.39169167990077 | erot = 3.16027505319296 | epot = -22.2459295451276 | etot = -17.6939628120339 +777000 ekin = 1.6265637770548 | erot = 2.80881827044756 | epot = -22.1611617112313 | etot = -17.7257796637289 +778000 ekin = 1.49436478903862 | erot = 2.24161236856226 | epot = -22.1732646444852 | etot = -18.4372874868843 +779000 ekin = 1.88107404119766 | erot = 1.90732846459751 | epot = -22.2125828989308 | etot = -18.4241803931357 +780000 ekin = 1.70209634464211 | erot = 2.30515299210351 | epot = -22.2800747799124 | etot = -18.2728254431668 +781000 ekin = 2.12615575710868 | erot = 2.5606535839807 | epot = -22.3657963731658 | etot = -17.6789870320765 +782000 ekin = 2.60319344794517 | erot = 1.9571688066736 | epot = -22.278889588664 | etot = -17.7185273340452 +783000 ekin = 2.19489638548848 | erot = 2.9003350616753 | epot = -22.2004563501245 | etot = -17.1052249029607 +784000 ekin = 2.84914111009349 | erot = 2.24051018422878 | epot = -22.2093010900996 | etot = -17.1196497957773 +785000 ekin = 3.14240765153577 | erot = 2.92860772919915 | epot = -22.2500274240077 | etot = -16.1790120432728 +786000 ekin = 2.83372300736036 | erot = 3.44593690351849 | epot = -22.2923595270367 | etot = -16.0126996161579 +787000 ekin = 2.41074903520556 | erot = 3.01381650302092 | epot = -22.2329745868673 | etot = -16.8084090486408 +788000 ekin = 1.99557665602945 | erot = 2.01600225895996 | epot = -22.1996915458458 | etot = -18.1881126308564 +789000 ekin = 2.46258971641133 | erot = 2.27406771625316 | epot = -22.1314921413931 | etot = -17.3948347087286 +790000 ekin = 3.5794195002921 | erot = 2.82440864812442 | epot = -22.0691321886934 | etot = -15.6653040402769 +791000 ekin = 3.1240271028451 | erot = 2.42401718962737 | epot = -22.0808685046086 | etot = -16.5328242121361 +792000 ekin = 3.95429056548242 | erot = 1.97241939137157 | epot = -22.0156932891881 | etot = -16.0889833323341 +793000 ekin = 2.26828416500901 | erot = 2.58677202552917 | epot = -21.9219598803777 | etot = -17.0669036898395 +794000 ekin = 2.16106559150924 | erot = 2.44310931274122 | epot = -21.7619518452423 | etot = -17.1577769409919 +795000 ekin = 1.62519700428841 | erot = 2.41826691867446 | epot = -21.6012749849542 | etot = -17.5578110619913 +796000 ekin = 2.18377144801669 | erot = 2.13093440679001 | epot = -21.4820337714693 | etot = -17.1673279166626 +797000 ekin = 1.81427862345353 | erot = 1.99534051513419 | epot = -21.4739195915569 | etot = -17.6643004529692 +798000 ekin = 2.2201219513299 | erot = 2.51363796316553 | epot = -21.5008270155092 | etot = -16.7670671010138 +799000 ekin = 1.88984581553595 | erot = 2.87047971528298 | epot = -21.4708608053325 | etot = -16.7105352745136 +800000 ekin = 2.14235800297794 | erot = 2.35196377273805 | epot = -21.3792596865246 | etot = -16.8849379108086 +801000 ekin = 1.84302686949433 | erot = 1.65480855802629 | epot = -21.2211741734437 | etot = -17.7233387459231 +802000 ekin = 2.20305615004888 | erot = 2.22355768328245 | epot = -21.1073599995259 | etot = -16.6807461661946 +803000 ekin = 2.64836814873033 | erot = 1.90761871804858 | epot = -21.0752041885471 | etot = -16.5192173217682 +804000 ekin = 2.34495845479317 | erot = 2.89112045330492 | epot = -21.0176734836814 | etot = -15.7815945755833 +805000 ekin = 1.79915640284781 | erot = 2.71685844764875 | epot = -20.8858433761952 | etot = -16.3698285256987 +806000 ekin = 1.74992507845556 | erot = 2.08517047523252 | epot = -20.8503301901419 | etot = -17.0152346364538 +807000 ekin = 1.57172452594494 | erot = 1.70422569898767 | epot = -20.9092333967053 | etot = -17.6332831717727 +808000 ekin = 2.08106901002531 | erot = 2.4036706521883 | epot = -20.9858691795981 | etot = -16.5011295173845 +809000 ekin = 2.61736488835992 | erot = 1.51251405170843 | epot = -20.9790910298502 | etot = -16.8492120897819 +810000 ekin = 3.07344763503492 | erot = 2.65428122600395 | epot = -20.896297890317 | etot = -15.1685690292781 +811000 ekin = 3.028899831017 | erot = 3.61686315729187 | epot = -20.939661602879 | etot = -14.2938986145701 +812000 ekin = 2.13832655324419 | erot = 2.7919099294265 | epot = -21.0260005012597 | etot = -16.095764018589 +813000 ekin = 2.19077235410927 | erot = 3.16158040032406 | epot = -21.2169108164964 | etot = -15.8645580620631 +814000 ekin = 1.70775111413747 | erot = 2.98436840501864 | epot = -21.3089511890131 | etot = -16.6168316698569 +815000 ekin = 2.14630779714624 | erot = 2.27335416843263 | epot = -21.3099230783927 | etot = -16.8902611128138 +816000 ekin = 2.70331501775258 | erot = 1.53093796189124 | epot = -21.3384418834226 | etot = -17.1041889037788 +817000 ekin = 2.55738086811903 | erot = 2.58558173150041 | epot = -21.4691891608916 | etot = -16.3262265612722 +818000 ekin = 2.27829786328906 | erot = 2.26089725682103 | epot = -21.5162183667694 | etot = -16.9770232466593 +819000 ekin = 2.10478260130361 | erot = 3.02380855832961 | epot = -21.5292309310153 | etot = -16.4006397713821 +820000 ekin = 2.50608188233135 | erot = 2.71783485224719 | epot = -21.5036816055507 | etot = -16.2797648709722 +821000 ekin = 2.62609848062629 | erot = 2.55164634943844 | epot = -21.478766185164 | etot = -16.3010213550993 +822000 ekin = 3.63941681915299 | erot = 2.20246894917129 | epot = -21.4688230156577 | etot = -15.6269372473334 +823000 ekin = 3.58953515450024 | erot = 2.73556206545619 | epot = -21.4650227341943 | etot = -15.1399255142378 +824000 ekin = 4.11304720722591 | erot = 3.2917459513548 | epot = -21.4062011377905 | etot = -14.0014079792098 +825000 ekin = 2.90620097853796 | erot = 3.46409084826251 | epot = -21.2436944546109 | etot = -14.8734026278105 +826000 ekin = 1.72188438195169 | erot = 1.97028277378148 | epot = -21.0473904580338 | etot = -17.3552233023007 +827000 ekin = 1.9124069409458 | erot = 2.55760488338657 | epot = -20.9206700763425 | etot = -16.4506582520101 +828000 ekin = 2.38145056979363 | erot = 2.55544957149182 | epot = -20.8204865756543 | etot = -15.8835864343689 +829000 ekin = 2.24733826946605 | erot = 1.78474837345228 | epot = -20.7084449579388 | etot = -16.6763583150204 +830000 ekin = 2.52795893691035 | erot = 2.34146724282711 | epot = -20.5883731027638 | etot = -15.7189469230264 +831000 ekin = 2.68310001004752 | erot = 2.07407005901145 | epot = -20.4364451382899 | etot = -15.679275069231 +832000 ekin = 2.6732342426401 | erot = 2.02167788192499 | epot = -20.3691783993746 | etot = -15.6742662748095 +833000 ekin = 2.55071664949192 | erot = 2.59972899624767 | epot = -20.3036213925319 | etot = -15.1531757467923 +834000 ekin = 2.87089088359563 | erot = 2.32463192225235 | epot = -20.2984653371648 | etot = -15.1029425313168 +835000 ekin = 2.77558903596269 | erot = 2.73757154391999 | epot = -20.4022293845421 | etot = -14.8890688046595 +836000 ekin = 2.57713146919653 | erot = 2.85322310545496 | epot = -20.5403137141641 | etot = -15.1099591395126 +837000 ekin = 1.78075406754283 | erot = 1.97503243561096 | epot = -20.5889142070484 | etot = -16.8331277038946 +838000 ekin = 1.98032617531701 | erot = 2.7982946707394 | epot = -20.6049667376349 | etot = -15.8263458915785 +839000 ekin = 2.0003179521848 | erot = 2.70198331564815 | epot = -20.5921495833285 | etot = -15.8898483154955 +840000 ekin = 1.70031236242703 | erot = 2.95685689490568 | epot = -20.6678372916037 | etot = -16.010668034271 +841000 ekin = 2.77705100359315 | erot = 2.84742847205069 | epot = -20.7929304121763 | etot = -15.1684509365325 +842000 ekin = 2.54393458307436 | erot = 2.87172695192627 | epot = -20.8173418291016 | etot = -15.401680294101 +843000 ekin = 2.00273625390939 | erot = 2.63437491598434 | epot = -20.8053999188197 | etot = -16.1682887489259 +844000 ekin = 1.52900749569349 | erot = 1.92882434140971 | epot = -20.8427655387949 | etot = -17.3849337016917 +845000 ekin = 2.27176799938834 | erot = 2.308436365406 | epot = -20.9384881501645 | etot = -16.3582837853702 +846000 ekin = 2.06718804989496 | erot = 2.33108662324981 | epot = -21.008503215967 | etot = -16.6102285428222 +847000 ekin = 2.457310325364 | erot = 2.64112097293887 | epot = -20.9624761048838 | etot = -15.8640448065809 +848000 ekin = 2.13894899278459 | erot = 1.46487099434192 | epot = -20.9909626022984 | etot = -17.3871426151719 +849000 ekin = 2.0007946308419 | erot = 2.48568109050424 | epot = -20.9995492646628 | etot = -16.5130735433167 +850000 ekin = 2.54186297995285 | erot = 2.66929613872204 | epot = -20.9906717645298 | etot = -15.7795126458549 +851000 ekin = 2.16443404123472 | erot = 2.92830981454153 | epot = -20.9932718794597 | etot = -15.9005280236835 +852000 ekin = 2.48255398040851 | erot = 2.46238001266592 | epot = -21.018749118108 | etot = -16.0738151250336 +853000 ekin = 2.41541467016921 | erot = 2.97520224443385 | epot = -20.9598722543997 | etot = -15.5692553397966 +854000 ekin = 2.35150751079563 | erot = 2.85453387569363 | epot = -20.8693696367608 | etot = -15.6633282502715 +855000 ekin = 2.36749640703667 | erot = 2.0675340835823 | epot = -20.8980197782034 | etot = -16.4629892875844 +856000 ekin = 2.52164598863741 | erot = 2.75265020302047 | epot = -20.800830948998 | etot = -15.5265347573401 +857000 ekin = 2.55862872070476 | erot = 3.03030828592914 | epot = -20.6910887919773 | etot = -15.1021517853434 +858000 ekin = 3.12628251408762 | erot = 2.1455460426107 | epot = -20.6394579492303 | etot = -15.367629392532 +859000 ekin = 2.91259413572113 | erot = 2.23773675238284 | epot = -20.6611486479508 | etot = -15.5108177598468 +860000 ekin = 2.88318377110752 | erot = 1.51972062646443 | epot = -20.6828066069552 | etot = -16.2799022093833 +861000 ekin = 2.33529167415754 | erot = 2.85116617791259 | epot = -20.6796212139896 | etot = -15.4931633619195 +862000 ekin = 3.06091745354043 | erot = 1.86960550588563 | epot = -20.7257485328209 | etot = -15.7952255733949 +863000 ekin = 2.88295223464283 | erot = 1.77743902656171 | epot = -20.8340328987095 | etot = -16.173641637505 +864000 ekin = 2.95602292127633 | erot = 2.6505641071531 | epot = -21.016295456145 | etot = -15.4097084277156 +865000 ekin = 3.3172549369506 | erot = 2.24347319046513 | epot = -21.1441095096619 | etot = -15.5833813822461 +866000 ekin = 2.8446879555804 | erot = 3.16802464112883 | epot = -21.2275167371632 | etot = -15.214804140454 +867000 ekin = 2.74149808612435 | erot = 3.09628634794253 | epot = -21.2140642048229 | etot = -15.376279770756 +868000 ekin = 2.19141484864809 | erot = 2.23765996064101 | epot = -21.1661691183494 | etot = -16.7370943090603 +869000 ekin = 2.92726848075923 | erot = 2.49663936074752 | epot = -21.1109612585256 | etot = -15.6870534170189 +870000 ekin = 2.47986538741064 | erot = 2.11907230969515 | epot = -21.0900293946685 | etot = -16.4910916975627 +871000 ekin = 2.18342640526418 | erot = 2.37474045896628 | epot = -20.9804914418025 | etot = -16.422324577572 +872000 ekin = 1.52873571215978 | erot = 2.08908078804674 | epot = -20.9343176993392 | etot = -17.3165011991327 +873000 ekin = 1.39281578471524 | erot = 2.29034780878957 | epot = -21.0007866828842 | etot = -17.3176230893794 +874000 ekin = 1.40786554880768 | erot = 2.77007970032348 | epot = -21.160084274243 | etot = -16.9821390251118 +875000 ekin = 1.18320018517441 | erot = 2.7305884288351 | epot = -21.2959059488291 | etot = -17.3821173348196 +876000 ekin = 1.8300189393038 | erot = 2.99586941144887 | epot = -21.3298635968753 | etot = -16.5039752461226 +877000 ekin = 2.38032906471076 | erot = 2.03722695211227 | epot = -21.4152790752831 | etot = -16.99772305846 +878000 ekin = 2.1293851684127 | erot = 1.75666654131943 | epot = -21.412657760354 | etot = -17.5266060506219 +879000 ekin = 2.23837299177368 | erot = 2.71307243504657 | epot = -21.4006541150457 | etot = -16.4492086882254 +880000 ekin = 2.68032631557358 | erot = 2.78439945590096 | epot = -21.4462782448912 | etot = -15.9815524734167 +881000 ekin = 2.86810525851389 | erot = 2.35959915589952 | epot = -21.4314549447334 | etot = -16.20375053032 +882000 ekin = 2.33172283615115 | erot = 2.17176020371467 | epot = -21.369535469283 | etot = -16.8660524294172 +883000 ekin = 2.36331150998289 | erot = 1.97634374053966 | epot = -21.1748990104138 | etot = -16.8352437598913 +884000 ekin = 2.53782271833829 | erot = 2.25243670168427 | epot = -21.0795767771653 | etot = -16.2893173571427 +885000 ekin = 2.86057103069745 | erot = 2.27462544190307 | epot = -21.0782171958267 | etot = -15.9430207232262 +886000 ekin = 3.17034195996096 | erot = 1.74832646729409 | epot = -21.1280719510453 | etot = -16.2094035237903 +887000 ekin = 2.66023408534638 | erot = 2.49426802108016 | epot = -21.1909579488462 | etot = -16.0364558424197 +888000 ekin = 2.14156056158802 | erot = 2.83065920295552 | epot = -21.2749898508176 | etot = -16.302770086274 +889000 ekin = 2.13776380125426 | erot = 2.19994227158624 | epot = -21.1902576201104 | etot = -16.8525515472699 +890000 ekin = 1.76446650263826 | erot = 2.97354753014624 | epot = -21.2518724314555 | etot = -16.513858398671 +891000 ekin = 1.64433607192947 | erot = 2.28044235221045 | epot = -21.3759471910581 | etot = -17.4511687669181 +892000 ekin = 1.97381907006142 | erot = 2.35969977765342 | epot = -21.5200869372681 | etot = -17.1865680895533 +893000 ekin = 1.77998159671209 | erot = 1.83959134574388 | epot = -21.5960425863495 | etot = -17.9764696438935 +894000 ekin = 2.8098996128374 | erot = 2.80337844303785 | epot = -21.6896955865519 | etot = -16.0764175306767 +895000 ekin = 2.03570642281182 | erot = 2.73641442629084 | epot = -21.77632807541 | etot = -17.0042072263074 +896000 ekin = 1.6670401968188 | erot = 2.55842313387756 | epot = -21.9079691828366 | etot = -17.6825058521403 +897000 ekin = 1.79364820755772 | erot = 2.35937074837063 | epot = -22.0466195733302 | etot = -17.8936006174018 +898000 ekin = 1.84103348909591 | erot = 2.4159698011209 | epot = -22.0792153246985 | etot = -17.8222120344817 +899000 ekin = 1.6644807831865 | erot = 3.06295573986192 | epot = -22.0050930291629 | etot = -17.2776565061145 +900000 ekin = 2.15301263014261 | erot = 2.62503812958044 | epot = -21.9769631774149 | etot = -17.1989124176918 +901000 ekin = 2.43323525076021 | erot = 2.69661561775585 | epot = -22.0455467285607 | etot = -16.9156958600446 +902000 ekin = 2.57983518470479 | erot = 2.40634661051271 | epot = -22.0504126836938 | etot = -17.0642308884763 +903000 ekin = 2.38804084084236 | erot = 2.40369143268286 | epot = -22.0548572254258 | etot = -17.2631249519006 +904000 ekin = 1.9975679938241 | erot = 3.15736733739655 | epot = -22.0783783499621 | etot = -16.9234430187414 +905000 ekin = 2.28042135995781 | erot = 2.20746001153526 | epot = -22.092475444409 | etot = -17.604594072916 +906000 ekin = 2.49914497220395 | erot = 1.67106173041057 | epot = -22.0649292741971 | etot = -17.8947225715826 +907000 ekin = 2.34170753461351 | erot = 2.16830189815579 | epot = -21.9182395193391 | etot = -17.4082300865698 +908000 ekin = 2.83101675354561 | erot = 2.39226452568031 | epot = -21.9393923471479 | etot = -16.7161110679219 +909000 ekin = 3.13519044247878 | erot = 2.07053636961478 | epot = -22.044039894957 | etot = -16.8383130828634 +910000 ekin = 2.91492350277448 | erot = 3.54269221448408 | epot = -22.1774209001616 | etot = -15.719805182903 +911000 ekin = 1.86299522014884 | erot = 2.75425299355676 | epot = -22.2318842654016 | etot = -17.614636051696 +912000 ekin = 2.64270620869814 | erot = 1.86916034984858 | epot = -22.2816929482531 | etot = -17.7698263897064 +913000 ekin = 2.45835259040075 | erot = 2.03343540339216 | epot = -22.4051980318983 | etot = -17.9134100381054 +914000 ekin = 2.01630257583653 | erot = 3.01931541129968 | epot = -22.505580829989 | etot = -17.4699628428528 +915000 ekin = 2.73550820750709 | erot = 2.14051989379169 | epot = -22.5067223019054 | etot = -17.6306942006067 +916000 ekin = 2.38833694849903 | erot = 3.26236542376325 | epot = -22.5299732656691 | etot = -16.8792708934068 +917000 ekin = 2.21211072529667 | erot = 2.24425221182159 | epot = -22.5175498112378 | etot = -18.0611868741195 +918000 ekin = 2.11721632678553 | erot = 2.05681940825278 | epot = -22.4485798442659 | etot = -18.2745441092275 +919000 ekin = 2.6606540164524 | erot = 2.41853759346262 | epot = -22.4819256778217 | etot = -17.4027340679066 +920000 ekin = 3.26471044916532 | erot = 2.75531911342505 | epot = -22.5858600689149 | etot = -16.5658305063245 +921000 ekin = 2.72028388628927 | erot = 1.9696059637128 | epot = -22.639440275186 | etot = -17.949550425184 +922000 ekin = 1.43428549123066 | erot = 1.52428475569853 | epot = -22.6914991306332 | etot = -19.732928883704 +923000 ekin = 1.67603986848274 | erot = 1.86522020655464 | epot = -22.7510571233686 | etot = -19.2097970483313 +924000 ekin = 2.15000311118185 | erot = 1.53327070095755 | epot = -22.722341324193 | etot = -19.0390675120536 +925000 ekin = 2.27769316315993 | erot = 1.3558291477729 | epot = -22.6317669747038 | etot = -18.9982446637709 +926000 ekin = 2.0037075380337 | erot = 2.07123237010034 | epot = -22.5811533157097 | etot = -18.5062134075756 +927000 ekin = 2.5163142824884 | erot = 1.98711239136866 | epot = -22.6957752134474 | etot = -18.1923485395904 +928000 ekin = 2.57502157703452 | erot = 2.51449316644151 | epot = -22.8486668477058 | etot = -17.7591521042298 +929000 ekin = 2.66015175923782 | erot = 1.82991995656989 | epot = -22.8894816710891 | etot = -18.3994099552814 +930000 ekin = 2.41758548277495 | erot = 2.00977019739402 | epot = -22.9023129289068 | etot = -18.4749572487378 +931000 ekin = 3.01936517399357 | erot = 2.11115283295647 | epot = -22.8598478032752 | etot = -17.7293297963252 +932000 ekin = 2.34904883629147 | erot = 1.87134929534042 | epot = -22.900230384769 | etot = -18.6798322531371 +933000 ekin = 2.16775611540091 | erot = 2.83796264813669 | epot = -22.9075292968864 | etot = -17.9018105333488 +934000 ekin = 2.17428610858913 | erot = 2.11891276299501 | epot = -22.9275911153101 | etot = -18.634392243726 +935000 ekin = 2.35380058127247 | erot = 2.22719757040085 | epot = -22.9178791070039 | etot = -18.3368809553306 +936000 ekin = 2.29398857252167 | erot = 2.52122883801967 | epot = -23.0254587453496 | etot = -18.2102413348082 +937000 ekin = 2.32405492839276 | erot = 2.82571975062453 | epot = -23.1134869099967 | etot = -17.9637122309794 +938000 ekin = 2.46190818228192 | erot = 1.99586541720566 | epot = -23.1690855883853 | etot = -18.7113119888978 +939000 ekin = 2.99494633358444 | erot = 2.1120057997909 | epot = -23.1621265982256 | etot = -18.0551744648503 +940000 ekin = 3.76773061527755 | erot = 2.67954167018356 | epot = -23.1020260319689 | etot = -16.6547537465078 +941000 ekin = 3.15108874053801 | erot = 2.26610050109568 | epot = -23.0042404655517 | etot = -17.587051223918 +942000 ekin = 3.50311245643907 | erot = 1.88373602143018 | epot = -22.9671180112669 | etot = -17.5802695333976 +943000 ekin = 3.82043792465856 | erot = 2.71285823250348 | epot = -22.9404059827705 | etot = -16.4071098256085 +944000 ekin = 2.68278476017665 | erot = 2.75585489458161 | epot = -22.919058077481 | etot = -17.4804184227228 +945000 ekin = 2.55880828345198 | erot = 2.02741981318914 | epot = -22.8232630911495 | etot = -18.2370349945083 +946000 ekin = 2.47548691870273 | erot = 1.66864059361738 | epot = -22.6586979544826 | etot = -18.5145704421625 +947000 ekin = 2.41867478100658 | erot = 1.99274780926995 | epot = -22.5542133657 | etot = -18.1427907754235 +948000 ekin = 3.54970439277899 | erot = 2.57756240201333 | epot = -22.4104376157296 | etot = -16.2831708209373 +949000 ekin = 2.98589976166071 | erot = 2.44208964275302 | epot = -22.1971411230011 | etot = -16.7691517185873 +950000 ekin = 1.82147308870195 | erot = 3.05083899379338 | epot = -22.0435130221227 | etot = -17.1712009396274 +951000 ekin = 2.20031505253436 | erot = 2.38004890424644 | epot = -22.0174402075992 | etot = -17.4370762508184 +952000 ekin = 2.14165422682636 | erot = 1.67045420750585 | epot = -21.9875031647927 | etot = -18.1753947304605 +953000 ekin = 2.2983346942831 | erot = 1.97349532600851 | epot = -21.9532851584681 | etot = -17.6814551381765 +954000 ekin = 1.48835290094507 | erot = 3.35692451991831 | epot = -21.8812774176255 | etot = -17.0359999967621 +955000 ekin = 1.87513794155827 | erot = 2.65898918540887 | epot = -21.7919528937348 | etot = -17.2578257667677 +956000 ekin = 1.6947359470094 | erot = 2.15427252360414 | epot = -21.7268035908356 | etot = -17.877795120222 +957000 ekin = 1.75579814865835 | erot = 1.63901039608816 | epot = -21.700727032202 | etot = -18.3059184874555 +958000 ekin = 1.59869777656518 | erot = 2.20104985114387 | epot = -21.7023937250484 | etot = -17.9026460973393 +959000 ekin = 2.58438881562724 | erot = 2.4897790743314 | epot = -21.7153511733982 | etot = -16.6411832834396 +960000 ekin = 2.53916903929276 | erot = 2.05995138561213 | epot = -21.7134163297425 | etot = -17.1142959048376 +961000 ekin = 2.28282707786747 | erot = 2.18347157951504 | epot = -21.7152390799838 | etot = -17.2489404226013 +962000 ekin = 1.65520100959905 | erot = 3.51416445242775 | epot = -21.7329558565076 | etot = -16.5635903944808 +963000 ekin = 1.99568689924178 | erot = 1.50126173817713 | epot = -21.6847527677603 | etot = -18.1878041303413 +964000 ekin = 2.18616111169191 | erot = 2.27601428306196 | epot = -21.621271673579 | etot = -17.1590962788252 +965000 ekin = 2.12688674785305 | erot = 2.31141713690626 | epot = -21.6018715374842 | etot = -17.1635676527249 +966000 ekin = 3.18043989665769 | erot = 3.42455452205085 | epot = -21.638305203769 | etot = -15.0333107850605 +967000 ekin = 3.07300409154252 | erot = 2.17511749698304 | epot = -21.5951488445701 | etot = -16.3470272560445 +968000 ekin = 2.08663150655529 | erot = 2.13997027735021 | epot = -21.5232721871232 | etot = -17.2966704032177 +969000 ekin = 2.26951411936363 | erot = 2.21822796004341 | epot = -21.4611553284775 | etot = -16.9734132490705 +970000 ekin = 2.49167396599781 | erot = 2.62083774678039 | epot = -21.4077353682587 | etot = -16.2952236554805 +971000 ekin = 2.497450596106 | erot = 2.64553775005007 | epot = -21.3712924820092 | etot = -16.2283041358532 +972000 ekin = 3.2069302084461 | erot = 2.4701129448845 | epot = -21.3144344371103 | etot = -15.6373912837797 +973000 ekin = 3.35935448087941 | erot = 2.62917582888825 | epot = -21.2433830591837 | etot = -15.254852749416 +974000 ekin = 2.71069552226069 | erot = 2.13944446989067 | epot = -21.1404268855179 | etot = -16.2902868933666 +975000 ekin = 1.81165819781674 | erot = 2.10218924092727 | epot = -21.0499905566304 | etot = -17.1361431178864 +976000 ekin = 2.36984742020937 | erot = 1.38488988265325 | epot = -20.9803229653515 | etot = -17.2255856624889 +977000 ekin = 2.83728662155799 | erot = 3.02976542728586 | epot = -21.086860961914 | etot = -15.2198089130701 +978000 ekin = 3.14169266917128 | erot = 3.0279981203262 | epot = -21.1408187166748 | etot = -14.9711279271773 +979000 ekin = 3.63725915757345 | erot = 2.47075910077982 | epot = -21.0348329782418 | etot = -14.9268147198885 +980000 ekin = 3.42622785415583 | erot = 3.24164435781272 | epot = -20.9604411583362 | etot = -14.2925689463677 +981000 ekin = 2.9282364939793 | erot = 2.44516658563954 | epot = -20.999389015838 | etot = -15.6259859362192 +982000 ekin = 2.0455891107008 | erot = 2.21302288881361 | epot = -21.0172581853275 | etot = -16.7586461858131 +983000 ekin = 2.56053983213181 | erot = 1.98406283304104 | epot = -21.0054554868711 | etot = -16.4608528216982 +984000 ekin = 2.31455025377678 | erot = 2.58584391470351 | epot = -21.0528748947299 | etot = -16.1524807262496 +985000 ekin = 2.31703817263368 | erot = 2.99965025262552 | epot = -21.1270579315131 | etot = -15.8103695062539 +986000 ekin = 2.05103854432386 | erot = 2.1535155091137 | epot = -21.2182405597612 | etot = -17.0136865063236 +987000 ekin = 2.41899263793244 | erot = 1.58416150281503 | epot = -21.1906087726859 | etot = -17.1874546319384 +988000 ekin = 2.75135283132848 | erot = 2.70498731016258 | epot = -21.09026978368 | etot = -15.633929642189 +989000 ekin = 2.29408577956131 | erot = 2.85656205344493 | epot = -21.0178170251465 | etot = -15.8671691921403 +990000 ekin = 2.23414139649767 | erot = 2.58987928207187 | epot = -20.9412338597721 | etot = -16.1172131812026 +991000 ekin = 2.20140095465642 | erot = 2.53421928109187 | epot = -20.8284298905317 | etot = -16.0928096547834 +992000 ekin = 1.73516341340694 | erot = 2.49726908126814 | epot = -20.8981414535471 | etot = -16.665708958872 +993000 ekin = 1.38883779880922 | erot = 1.96818984395137 | epot = -20.9939445972527 | etot = -17.6369169544921 +994000 ekin = 1.48978908674571 | erot = 2.95636513336706 | epot = -21.0608370227912 | etot = -16.6146828026784 +995000 ekin = 2.31404204513712 | erot = 1.67482961392509 | epot = -21.1264761824825 | etot = -17.1376045234203 +996000 ekin = 2.89776504847011 | erot = 2.85063328331353 | epot = -21.0879631716189 | etot = -15.3395648398353 +997000 ekin = 3.12980664910277 | erot = 2.14994147346883 | epot = -21.0789162715404 | etot = -15.7991681489688 +998000 ekin = 2.21592279552962 | erot = 3.03017611615784 | epot = -20.9989402817529 | etot = -15.7528413700654 +999000 ekin = 2.60947995309596 | erot = 1.73829419308785 | epot = -20.9136108602423 | etot = -16.5658367140585 +1000000 ekin = 2.32269547490306 | erot = 2.87794942105203 | epot = -20.9071852604882 | etot = -15.7065403645331 + 1000000 0.10323091 -1.356822 0.050122912 -1.1615306 0.00013791576 +Loop time of 52.0267 on 4 procs for 1000000 steps with 16 atoms + +Performance: 16606.850 tau/day, 19220.892 timesteps/s +96.4% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.92946 | 16.932 | 31.787 | 338.2 | 32.55 +Bond | 0.12904 | 0.54878 | 0.89134 | 46.8 | 1.05 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 4.2008 | 5.1678 | 6.1197 | 36.6 | 9.93 +Output | 2.1e-05 | 3.15e-05 | 3.6e-05 | 0.0 | 0.00 +Modify | 0.32128 | 3.4221 | 6.4024 | 143.6 | 6.58 +Other | | 25.96 | | | 49.89 + +Nlocal: 4 ave 8 max 0 min +Histogram: 1 1 0 0 0 0 0 0 1 1 +Nghost: 9 ave 10 max 8 min +Histogram: 1 0 0 0 0 2 0 0 0 1 +Neighs: 34.5 ave 67 max 0 min +Histogram: 1 1 0 0 0 0 0 0 0 2 + +Total # of neighbors = 138 +Ave neighs/atom = 8.625 +Ave special neighs/atom = 3.75 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:52 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.1 b/examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.1 deleted file mode 100644 index 56f1b72277..0000000000 --- a/examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.1 +++ /dev/null @@ -1,172 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 2 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex2 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 16 atoms - reading velocities ... - 16 velocities - 16 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 13 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 4 = max # of 1-4 neighbors - 6 = max # of special neighbors - -set atom * mass 3.1575 - 16 settings made for mass - -group all type 1 4 -16 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna/fene -bond_coeff * 2.0 0.25 0.7525 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk -pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 - -# NVE ensemble -#fix 1 all nve/dot -fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 1.92828 - ghost atom cutoff = 1.92828 - binsize = 0.964142, bins = 42 42 42 - 5 neighbor lists, perpetual/occasional/extra = 5 0 0 - (1) pair oxdna/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 2.861 | 2.861 | 2.861 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.5402493 0.0070469125 -1.5332024 -8.5641987e-05 -1000 ekin = 1.54234964773389 | erot = 1.71563526070267 | epot = -24.5477045187653 | etot = -21.2897196103287 -2000 ekin = 1.85988866919215 | erot = 1.9424302796508 | epot = -24.4843044999595 | etot = -20.6819855511165 -3000 ekin = 2.68354339452998 | erot = 2.14216528317607 | epot = -24.4019350693561 | etot = -19.57622639165 -4000 ekin = 2.04461800191989 | erot = 1.49015219763162 | epot = -24.2959428773347 | etot = -20.7611726777832 -5000 ekin = 1.76794859210155 | erot = 2.54289684465818 | epot = -24.2337587736863 | etot = -19.9229133369266 -6000 ekin = 3.1106424806079 | erot = 2.04409805200892 | epot = -24.1585729744133 | etot = -19.0038324417964 -7000 ekin = 3.21360097519306 | erot = 2.71941303605722 | epot = -24.0566262531609 | etot = -18.1236122419107 -8000 ekin = 2.82489935901743 | erot = 2.66790555575696 | epot = -24.0194805097633 | etot = -18.526675594989 -9000 ekin = 2.69381302856378 | erot = 2.59107820129446 | epot = -23.9216126050554 | etot = -18.6367213751972 -10000 ekin = 2.65765007662471 | erot = 1.95562671446597 | epot = -23.7978334881241 | etot = -19.1845566970334 - 10000 0.11811778 -1.4992295 0.011864944 -1.3212615 -0.00013416809 -Loop time of 0.295538 on 1 procs for 10000 steps with 16 atoms - -Performance: 29234.801 tau/day, 33836.575 timesteps/s -99.7% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.20959 | 0.20959 | 0.20959 | 0.0 | 70.92 -Bond | 0.0073669 | 0.0073669 | 0.0073669 | 0.0 | 2.49 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0016472 | 0.0016472 | 0.0016472 | 0.0 | 0.56 -Output | 5.0068e-06 | 5.0068e-06 | 5.0068e-06 | 0.0 | 0.00 -Modify | 0.073117 | 0.073117 | 0.073117 | 0.0 | 24.74 -Other | | 0.003813 | | | 1.29 - -Nlocal: 16 ave 16 max 16 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 88 ave 88 max 88 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 88 -Ave neighs/atom = 5.5 -Ave special neighs/atom = 3.75 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.4 b/examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.4 deleted file mode 100644 index 5cb953cd8c..0000000000 --- a/examples/USER/cgdna/examples/oxDNA/duplex2/log.27Nov18.duplex2.g++.4 +++ /dev/null @@ -1,172 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 2 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex2 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 16 atoms - reading velocities ... - 16 velocities - 16 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 13 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 4 = max # of 1-4 neighbors - 6 = max # of special neighbors - -set atom * mass 3.1575 - 16 settings made for mass - -group all type 1 4 -16 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna/fene -bond_coeff * 2.0 0.25 0.7525 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna/excv oxdna/stk oxdna/hbond oxdna/xstk oxdna/coaxstk -pair_coeff * * oxdna/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna/hbond seqav 1.077 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna/coaxstk 46.0 0.4 0.6 0.22 0.58 2.0 2.541592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 -0.65 2.0 -0.65 - -# NVE ensemble -#fix 1 all nve/dot -fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 1.92828 - ghost atom cutoff = 1.92828 - binsize = 0.964142, bins = 42 42 42 - 5 neighbor lists, perpetual/occasional/extra = 5 0 0 - (1) pair oxdna/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 7.466 | 7.648 | 7.83 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.5402493 0.0070469125 -1.5332024 -8.5641987e-05 -1000 ekin = 1.34565986428024 | erot = 2.31051421234078 | epot = -24.5061991591502 | etot = -20.8500250825292 -2000 ekin = 2.15911766687235 | erot = 2.16031365874707 | epot = -24.4723177103698 | etot = -20.1528863847504 -3000 ekin = 3.26561948796015 | erot = 2.75651822936604 | epot = -24.412573068346 | etot = -18.3904353510198 -4000 ekin = 1.92438809241066 | erot = 2.12016940074985 | epot = -24.3496233970111 | etot = -20.3050659038506 -5000 ekin = 1.35986357015476 | erot = 1.99413493074226 | epot = -24.2789445616949 | etot = -20.9249460607979 -6000 ekin = 2.19432475124593 | erot = 1.74281260409078 | epot = -24.2128064295788 | etot = -20.2756690742421 -7000 ekin = 2.65619274477635 | erot = 1.74094257048458 | epot = -24.1673462333493 | etot = -19.7702109180883 -8000 ekin = 2.51333548501168 | erot = 2.34649854571051 | epot = -24.0812769481836 | etot = -19.2214429174614 -9000 ekin = 2.24506493169711 | erot = 2.0652555461504 | epot = -23.9906736063989 | etot = -19.6803531285514 -10000 ekin = 2.36632635249862 | erot = 1.7959247176153 | epot = -23.9002627850602 | etot = -19.7380117149463 - 10000 0.10517006 -1.5057137 0.011947302 -1.345871 -9.5924016e-05 -Loop time of 0.251867 on 4 procs for 10000 steps with 16 atoms - -Performance: 34303.820 tau/day, 39703.495 timesteps/s -97.8% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.0035377 | 0.092047 | 0.17435 | 26.0 | 36.55 -Bond | 0.00065637 | 0.0031857 | 0.0053554 | 3.8 | 1.26 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.013929 | 0.01497 | 0.015733 | 0.6 | 5.94 -Output | 5.0783e-05 | 5.2691e-05 | 5.3883e-05 | 0.0 | 0.02 -Modify | 0.0013576 | 0.020825 | 0.040231 | 11.8 | 8.27 -Other | | 0.1208 | | | 47.96 - -Nlocal: 4 ave 8 max 0 min -Histogram: 1 1 0 0 0 0 0 0 1 1 -Nghost: 9 ave 10 max 8 min -Histogram: 1 0 0 0 0 2 0 0 0 1 -Neighs: 34.5 ave 67 max 0 min -Histogram: 1 1 0 0 0 0 0 0 0 2 - -Total # of neighbors = 138 -Ave neighs/atom = 8.625 -Ave special neighs/atom = 3.75 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex1/data.duplex1 b/examples/USER/cgdna/examples/oxDNA2/duplex1/data.duplex1 index 6aee3233dd..0ef671c603 100644 --- a/examples/USER/cgdna/examples/oxDNA2/duplex1/data.duplex1 +++ b/examples/USER/cgdna/examples/oxDNA2/duplex1/data.duplex1 @@ -32,7 +32,7 @@ Atoms 9 3 4.860249842674775e-01 3.518234140414733e-01 3.897628551303121e-01 2 1 1 10 4 5.999999999999996e-01 -1.332267629550188e-16 -1.110223024625157e-16 2 1 1 -# Atom-ID, translational, rotational velocity +# Atom-ID, translational velocity, angular momentum Velocities 1 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex1/in.duplex1 b/examples/USER/cgdna/examples/oxDNA2/duplex1/in.duplex1 index 5260e51330..9ff9d3c4db 100644 --- a/examples/USER/cgdna/examples/oxDNA2/duplex1/in.duplex1 +++ b/examples/USER/cgdna/examples/oxDNA2/duplex1/in.duplex1 @@ -1,6 +1,7 @@ variable number equal 1 variable ofreq equal 1000 variable efreq equal 1000 +variable T equal 0.1 units lj @@ -30,19 +31,19 @@ bond_coeff * 2.0 0.25 0.7564 # oxDNA pair interactions pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna2/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqav ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 -pair_coeff * * oxdna2/dh 0.1 1.0 0.815 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 # NVE ensemble fix 1 all nve/dot -#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 #fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 timestep 1e-5 @@ -73,6 +74,6 @@ fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${e #dump_modify out sort id #dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" -run 10000 +run 1000000 #write_restart config.${number}.* diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.1 b/examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.1 new file mode 100644 index 0000000000..a699d8726d --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.1 @@ -0,0 +1,1172 @@ +LAMMPS (18 Jun 2019) +variable number equal 1 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex1 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 10 atoms + reading velocities ... + 10 velocities + 10 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 8 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 2 = max # of 1-4 neighbors + 4 = max # of special neighbors + special bonds CPU = 0.000102 secs + read_data CPU = 0.002436 secs + +set atom * mass 3.1575 + 10 settings made for mass + +group all type 1 4 +10 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna2/fene +bond_coeff * 2.0 0.25 0.7564 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh +pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna2/stk seqav ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqav 0.1 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 +pair_coeff * * oxdna2/dh 0.1 1.0 0.815 + +# NVE ensemble +fix 1 all nve/dot +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.6274 + ghost atom cutoff = 2.6274 + binsize = 1.3137, bins = 31 31 31 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 3.023 | 3.023 | 3.023 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.4712768 0.009525411 -1.4617514 4.663076e-06 +1000 ekin = 0.00113086229080528 | erot = 0.0043101016040658 | epot = -14.6229549982368 | etot = -14.617514034342 +2000 ekin = 0.0044853322434243 | erot = 0.0171407706505008 | epot = -14.6391401372615 | etot = -14.6175140343675 +3000 ekin = 0.00995035259649285 | erot = 0.0381961780846484 | epot = -14.6656605650904 | etot = -14.6175140344093 +4000 ekin = 0.0173418024862054 | erot = 0.0669935184860634 | epot = -14.7018493554381 | etot = -14.6175140344659 +5000 ekin = 0.0264109356286075 | erot = 0.102878288094517 | epot = -14.7468032582586 | etot = -14.6175140345355 +6000 ekin = 0.0368533113591442 | erot = 0.14504542056987 | epot = -14.7994127665447 | etot = -14.6175140346157 +7000 ekin = 0.0483200640564843 | erot = 0.192565862515508 | epot = -14.8583999612756 | etot = -14.6175140347036 +8000 ekin = 0.0604312317605998 | erot = 0.244417870131508 | epot = -14.9223631366883 | etot = -14.6175140347962 +9000 ekin = 0.0727907119671751 | erot = 0.299521949931839 | epot = -14.989826696789 | etot = -14.6175140348899 +10000 ekin = 0.0850022498875221 | erot = 0.356777997217902 | epot = -15.0592942820869 | etot = -14.6175140349815 +11000 ekin = 0.0966857134041704 | erot = 0.415102860829614 | epot = -15.1293026093013 | etot = -14.6175140350675 +12000 ekin = 0.107492790688446 | erot = 0.473466334178045 | epot = -15.1984731600115 | etot = -14.617514035145 +13000 ekin = 0.117121180381715 | erot = 0.530923485009724 | epot = -15.2655587006029 | etot = -14.6175140352115 +14000 ekin = 0.125326348459166 | erot = 0.586641324447693 | epot = -15.329481708172 | etot = -14.6175140352651 +15000 ekin = 0.131930017119452 | erot = 0.639918104234695 | epot = -15.389362156659 | etot = -14.6175140353048 +16000 ekin = 0.136824741331535 | erot = 0.690194029501056 | epot = -15.4445328061632 | etot = -14.6175140353306 +17000 ekin = 0.139974218116303 | erot = 0.73705286614779 | epot = -15.4945411196072 | etot = -14.6175140353432 +18000 ekin = 0.141409342139924 | erot = 0.780214750583505 | epot = -15.5391381280674 | etot = -14.617514035344 +19000 ekin = 0.14122042490348 | erot = 0.819521373491594 | epot = -15.5782558337303 | etot = -14.6175140353352 +20000 ekin = 0.139546371890615 | erot = 0.854915474127934 | epot = -15.6119758813378 | etot = -14.6175140353193 +21000 ekin = 0.136561897558623 | erot = 0.886417110947779 | epot = -15.6404930438051 | etot = -14.6175140352987 +22000 ekin = 0.132464002543739 | erot = 0.914099368829953 | epot = -15.6640774066495 | etot = -14.6175140352758 +23000 ekin = 0.127458921012922 | erot = 0.938065991541773 | epot = -15.6830389478072 | etot = -14.6175140352525 +24000 ekin = 0.121750582423385 | erot = 0.958432936326242 | epot = -15.6976975539802 | etot = -14.6175140352305 +25000 ekin = 0.115531361418989 | erot = 0.97531514293118 | epot = -15.7083605395609 | etot = -14.6175140352107 +26000 ekin = 0.108975565586104 | erot = 0.988819027952036 | epot = -15.7153086287315 | etot = -14.6175140351934 +27000 ekin = 0.102235785319049 | erot = 0.999040485514132 | epot = -15.7187903060115 | etot = -14.6175140351783 +28000 ekin = 0.095441943431881 | erot = 1.00606759140964 | epot = -15.7190235700066 | etot = -14.6175140351651 +29000 ekin = 0.0887026587343887 | erot = 1.00998681843601 | epot = -15.7162035123233 | etot = -14.6175140351529 +30000 ekin = 0.0821083868014372 | erot = 1.01089138149893 | epot = -15.7105138034411 | etot = -14.6175140351407 +31000 ekin = 0.0757357206087773 | erot = 1.00889031641317 | epot = -15.7021400721498 | etot = -14.6175140351278 +32000 ekin = 0.0696522149388972 | erot = 1.00411701389994 | epot = -15.691283263952 | etot = -14.6175140351132 +33000 ekin = 0.0639211300028632 | erot = 0.996736133735177 | epot = -15.6781712988344 | etot = -14.6175140350964 +34000 ekin = 0.0586055597939536 | erot = 0.986948071943124 | epot = -15.6630676668141 | etot = -14.617514035077 +35000 ekin = 0.0537715085519321 | erot = 0.97499041461744 | epot = -15.6462759582244 | etot = -14.617514035055 +36000 ekin = 0.0494895953264297 | erot = 0.961136064967259 | epot = -15.6281396953245 | etot = -14.6175140350308 +37000 ekin = 0.0458351949405726 | erot = 0.945687966086967 | epot = -15.6090371960325 | etot = -14.617514035005 +38000 ekin = 0.0428869588016531 | erot = 0.928970560852795 | epot = -15.5893715546332 | etot = -14.6175140349787 +39000 ekin = 0.0407237982122988 | erot = 0.9113183396798 | epot = -15.5695561728451 | etot = -14.617514034953 +40000 ekin = 0.0394205547754457 | erot = 0.893062038097747 | epot = -15.5499966278026 | etot = -14.6175140349294 +41000 ekin = 0.0390427256107104 | erot = 0.874513269990878 | epot = -15.5310700305109 | etot = -14.6175140349093 +42000 ekin = 0.0396407506458402 | erot = 0.855948622306271 | epot = -15.5131034078461 | etot = -14.617514034894 +43000 ekin = 0.0412444930542154 | erot = 0.837594480923697 | epot = -15.4963530088628 | etot = -14.6175140348849 +44000 ekin = 0.0438586280730372 | erot = 0.819614069272971 | epot = -15.4809867322287 | etot = -14.6175140348826 +45000 ekin = 0.0474596621516281 | erot = 0.802098297010783 | epot = -15.4670719940501 | etot = -14.6175140348877 +46000 ekin = 0.0519951857192148 | erot = 0.785061947877571 | epot = -15.4545711684965 | etot = -14.6175140348997 +47000 ekin = 0.0573856747191636 | erot = 0.76844639238657 | epot = -15.4433461020232 | etot = -14.6175140349174 +48000 ekin = 0.0635286843632004 | erot = 0.75212933501618 | epot = -15.433172054319 | etot = -14.6175140349396 +49000 ekin = 0.070304673538874 | erot = 0.735941123250837 | epot = -15.4237598317539 | etot = -14.6175140349642 +50000 ekin = 0.0775831019857076 | erot = 0.719686007781425 | epot = -15.4147831447563 | etot = -14.6175140349892 +51000 ekin = 0.0852270843845694 | erot = 0.703165726695028 | epot = -15.4059068460928 | etot = -14.6175140350132 +52000 ekin = 0.0930950223451647 | erot = 0.686202231166125 | epot = -15.396811288546 | etot = -14.6175140350347 +53000 ekin = 0.101038429252995 | erot = 0.668656546988927 | epot = -15.3872090112954 | etot = -14.6175140350535 +54000 ekin = 0.10889654098061 | erot = 0.650441726174306 | epot = -15.3768523022246 | etot = -14.6175140350697 +55000 ekin = 0.116489881626234 | erot = 0.631529329348001 | epot = -15.3655332460579 | etot = -14.6175140350836 +56000 ekin = 0.12361610349192 | erot = 0.611950383382611 | epot = -15.35308052197 | etot = -14.6175140350954 +57000 ekin = 0.130051530401153 | erot = 0.591792721317295 | epot = -15.3393582868232 | etot = -14.6175140351048 +58000 ekin = 0.135560625193501 | erot = 0.571196690673292 | epot = -15.3242713509773 | etot = -14.6175140351105 +59000 ekin = 0.139913350827135 | erot = 0.550350463180279 | epot = -15.307777849119 | etot = -14.6175140351115 +60000 ekin = 0.142907875045794 | erot = 0.529485019662529 | epot = -15.2899069298147 | etot = -14.6175140351063 +61000 ekin = 0.144394224777542 | erot = 0.508867904998907 | epot = -15.2707761648706 | etot = -14.6175140350941 +62000 ekin = 0.144294003785763 | erot = 0.488794507592477 | epot = -15.2506025464531 | etot = -14.6175140350748 +63000 ekin = 0.142612256998146 | erot = 0.469576039421557 | epot = -15.2297023314688 | etot = -14.6175140350491 +64000 ekin = 0.139439544726902 | erot = 0.45152434495459 | epot = -15.2084779247003 | etot = -14.6175140350188 +65000 ekin = 0.134944526553566 | erot = 0.434934714913839 | epot = -15.1873932764535 | etot = -14.6175140349861 +66000 ekin = 0.129359146358223 | erot = 0.420068607767106 | epot = -15.1669417890788 | etot = -14.6175140349535 +67000 ekin = 0.122959458764236 | erot = 0.407138362059705 | epot = -15.1476118557469 | etot = -14.617514034923 +68000 ekin = 0.116045210525559 | erot = 0.396295631876262 | epot = -15.1298548772986 | etot = -14.6175140348968 +69000 ekin = 0.108920722072365 | erot = 0.38762458997195 | epot = -15.1140593469202 | etot = -14.6175140348758 +70000 ekin = 0.101878740729572 | erot = 0.381140173640836 | epot = -15.1005329492313 | etot = -14.6175140348609 +71000 ekin = 0.0951880561484016 | erot = 0.376791007701538 | epot = -15.0894930987019 | etot = -14.617514034852 +72000 ekin = 0.0890849677261927 | erot = 0.374466237250371 | epot = -15.0810652398255 | etot = -14.6175140348489 +73000 ekin = 0.0837682427021612 | erot = 0.374005347599889 | epot = -15.0752876251531 | etot = -14.617514034851 +74000 ekin = 0.0793969849744096 | erot = 0.375210076750601 | epot = -15.0721210965825 | etot = -14.6175140348575 +75000 ekin = 0.0760907865069267 | erot = 0.377857644572265 | epot = -15.0714624659463 | etot = -14.6175140348671 +76000 ekin = 0.0739315834908328 | erot = 0.381714646755152 | epot = -15.0731602651247 | etot = -14.6175140348788 +77000 ekin = 0.0729667273608161 | erot = 0.386551032956121 | epot = -15.0770317952083 | etot = -14.6175140348914 +78000 ekin = 0.073212865507933 | erot = 0.392153586683229 | epot = -15.0828804870951 | etot = -14.617514034904 +79000 ekin = 0.074660287835072 | erot = 0.398338263929461 | epot = -15.09051258668 | etot = -14.6175140349155 +80000 ekin = 0.0772774298944847 | erot = 0.404960669863083 | epot = -15.0997521346826 | etot = -14.6175140349251 +81000 ekin = 0.0810152396746107 | erot = 0.411923913359048 | epot = -15.1104531879657 | etot = -14.617514034932 +82000 ekin = 0.0858111278279411 | erot = 0.419183131304986 | epot = -15.1225082940691 | etot = -14.6175140349362 +83000 ekin = 0.0915922459205373 | erot = 0.426746154030553 | epot = -15.1358524348887 | etot = -14.6175140349376 +84000 ekin = 0.0982778862653023 | erot = 0.434670094582779 | epot = -15.1504620157846 | etot = -14.6175140349365 +85000 ekin = 0.105780875252123 | erot = 0.443054055542032 | epot = -15.1663489657278 | etot = -14.6175140349337 +86000 ekin = 0.114007936320491 | erot = 0.452028591870552 | epot = -15.183550563121 | etot = -14.6175140349299 +87000 ekin = 0.122859117093021 | erot = 0.461742961599068 | epot = -15.2021161136185 | etot = -14.6175140349264 +88000 ekin = 0.132226490250365 | erot = 0.472351454260961 | epot = -15.2220919794351 | etot = -14.6175140349238 +89000 ekin = 0.14199243043518 | erot = 0.484000150228927 | epot = -15.2435066155872 | etot = -14.6175140349231 +90000 ekin = 0.152027823848745 | erot = 0.49681531383988 | epot = -15.2663571726137 | etot = -14.6175140349251 +91000 ekin = 0.162190574344125 | erot = 0.510894287760631 | epot = -15.2905988970349 | etot = -14.6175140349302 +92000 ekin = 0.172324730223241 | erot = 0.526299304076712 | epot = -15.3161380692387 | etot = -14.6175140349387 +93000 ekin = 0.182260479602514 | erot = 0.543054150883983 | epot = -15.342828665437 | etot = -14.6175140349505 +94000 ekin = 0.191815166424497 | erot = 0.561143224560487 | epot = -15.3704724259505 | etot = -14.6175140349655 +95000 ekin = 0.200795384589871 | erot = 0.580512230413669 | epot = -15.398821649987 | etot = -14.6175140349834 +96000 ekin = 0.209000133284301 | erot = 0.601069706845445 | epot = -15.4275838751336 | etot = -14.6175140350039 +97000 ekin = 0.216224974983076 | erot = 0.622688639933065 | epot = -15.4564276499427 | etot = -14.6175140350266 +98000 ekin = 0.222267131485452 | erot = 0.645207670246426 | epot = -15.4849888367829 | etot = -14.617514035051 +99000 ekin = 0.226931474008822 | erot = 0.668431711040234 | epot = -15.5128772201258 | etot = -14.6175140350768 +100000 ekin = 0.230037392185194 | erot = 0.692132125756912 | epot = -15.5396835530455 | etot = -14.6175140351034 +101000 ekin = 0.231426538774339 | erot = 0.716046886549487 | epot = -15.5649874604541 | etot = -14.6175140351302 +102000 ekin = 0.230971416186116 | erot = 0.739881303910906 | epot = -15.5883667552535 | etot = -14.6175140351565 +103000 ekin = 0.228584676860968 | erot = 0.763309953365433 | epot = -15.6094086654079 | etot = -14.6175140351815 +104000 ekin = 0.224228843046698 | erot = 0.785980326921886 | epot = -15.6277232051725 | etot = -14.6175140352039 +105000 ekin = 0.217925953180593 | erot = 0.807518535460022 | epot = -15.6429585238635 | etot = -14.6175140352229 +106000 ekin = 0.209766205881976 | erot = 0.827537066837565 | epot = -15.6548173079567 | etot = -14.6175140352372 +107000 ekin = 0.19991466311948 | erot = 0.845644346598459 | epot = -15.6630730449638 | etot = -14.6175140352459 +108000 ekin = 0.188614735691129 | erot = 0.861455562303715 | epot = -15.6675843332431 | etot = -14.6175140352483 +109000 ekin = 0.176187061061687 | erot = 0.874603999194433 | epot = -15.6683050955002 | etot = -14.6175140352441 +110000 ekin = 0.163022626611995 | erot = 0.88475208463374 | epot = -15.6652887464792 | etot = -14.6175140352335 +111000 ekin = 0.14956938211077 | erot = 0.89160140093568 | epot = -15.6586848182637 | etot = -14.6175140352173 +112000 ekin = 0.136312261124986 | erot = 0.8949011206007 | epot = -15.6487274169225 | etot = -14.6175140351968 +113000 ekin = 0.123747404857758 | erot = 0.894454602033368 | epot = -15.6357160420648 | etot = -14.6175140351736 +114000 ekin = 0.112352324429831 | erot = 0.890124196452667 | epot = -15.6199905560322 | etot = -14.6175140351497 +115000 ekin = 0.102554569787556 | erot = 0.881834585426713 | epot = -15.6019031903412 | etot = -14.6175140351269 +116000 ekin = 0.0947020047096738 | erot = 0.869575126614186 | epot = -15.5817911664307 | etot = -14.6175140351068 +117000 ekin = 0.0890378681937318 | erot = 0.853401690493949 | epot = -15.559953593778 | etot = -14.6175140350903 +118000 ekin = 0.0856833736308548 | erot = 0.833438318818926 | epot = -15.5366357275277 | etot = -14.6175140350779 +119000 ekin = 0.0846297171118248 | erot = 0.809878764032089 | epot = -15.5120225162133 | etot = -14.6175140350694 +120000 ekin = 0.0857402026936468 | erot = 0.782987649501416 | epot = -15.4862418872589 | etot = -14.6175140350638 +121000 ekin = 0.088761978164944 | erot = 0.753100709615785 | epot = -15.4593767228408 | etot = -14.61751403506 +122000 ekin = 0.0933458418336512 | erot = 0.720623403982127 | epot = -15.4314832808722 | etot = -14.6175140350564 +123000 ekin = 0.0990718975139699 | erot = 0.68602719834959 | epot = -15.4026131309152 | etot = -14.6175140350516 +124000 ekin = 0.105478567535099 | erot = 0.649842971567299 | epot = -15.3728355741467 | etot = -14.6175140350443 +125000 ekin = 0.112092583657528 | erot = 0.61265130691034 | epot = -15.3422579256011 | etot = -14.6175140350332 +126000 ekin = 0.118457948670349 | erot = 0.575069793125981 | epot = -15.3110417768144 | etot = -14.617514035018 +127000 ekin = 0.124162352097832 | erot = 0.537737821903371 | epot = -15.2794142089993 | etot = -14.6175140349981 +128000 ekin = 0.128860000475183 | erot = 0.501299660072983 | epot = -15.2476736955218 | etot = -14.6175140349736 +129000 ekin = 0.132290197681538 | erot = 0.466386755141783 | epot = -15.2161909877681 | etot = -14.6175140349448 +130000 ekin = 0.134291248323408 | erot = 0.433600287194685 | epot = -15.1854055704302 | etot = -14.6175140349121 +131000 ekin = 0.134809368079367 | erot = 0.403494917851113 | epot = -15.1558183208069 | etot = -14.6175140348764 +132000 ekin = 0.133902311413259 | erot = 0.376564532721602 | epot = -15.1279808789733 | etot = -14.6175140348385 +133000 ekin = 0.131737425950174 | erot = 0.353230559449875 | epot = -15.1024820201993 | etot = -14.6175140347993 +134000 ekin = 0.128583872250139 | erot = 0.333833200745338 | epot = -15.0799311077557 | etot = -14.6175140347602 +135000 ekin = 0.124798858319487 | erot = 0.31862567876175 | epot = -15.0609385718037 | etot = -14.6175140347224 +136000 ekin = 0.12080796695122 | erot = 0.307771366705934 | epot = -15.0460933683448 | etot = -14.6175140346877 +137000 ekin = 0.117080018573556 | erot = 0.301343503849859 | epot = -15.0359375570811 | etot = -14.6175140346577 +138000 ekin = 0.114097404451637 | erot = 0.299327064918768 | epot = -15.0309385040046 | etot = -14.6175140346342 +139000 ekin = 0.112323403877397 | erot = 0.301622293047273 | epot = -15.0314597315437 | etot = -14.6175140346191 +140000 ekin = 0.112168587317134 | erot = 0.308049410073558 | epot = -15.0377320320047 | etot = -14.617514034614 +141000 ekin = 0.113958896787483 | erot = 0.318354084563277 | epot = -15.0498270159712 | etot = -14.6175140346204 +142000 ekin = 0.117908250110044 | erot = 0.332213334114174 | epot = -15.0676356188633 | etot = -14.6175140346391 +143000 ekin = 0.124098500240116 | erot = 0.349241744868859 | epot = -15.0908542797794 | etot = -14.6175140346704 +144000 ekin = 0.132469049162244 | erot = 0.36899804234383 | epot = -15.1189811262199 | etot = -14.6175140347138 +145000 ekin = 0.142817534773294 | erot = 0.390992018433025 | epot = -15.1513235879745 | etot = -14.6175140347682 +146000 ekin = 0.154812002594044 | erot = 0.414692148538822 | epot = -15.1870181859643 | etot = -14.6175140348315 +147000 ekin = 0.168013608208165 | erot = 0.43953414756317 | epot = -15.2250617906724 | etot = -14.6175140349011 +148000 ekin = 0.181907755044192 | erot = 0.46493071599216 | epot = -15.2643525060103 | etot = -14.617514034974 +149000 ekin = 0.195940689918404 | erot = 0.490282644230507 | epot = -15.3037373691959 | etot = -14.6175140350469 +150000 ekin = 0.209558115498161 | erot = 0.514991307802203 | epot = -15.3420634584171 | etot = -14.6175140351168 +151000 ekin = 0.222242375358722 | erot = 0.538472447669863 | epot = -15.3782288582089 | etot = -14.6175140351803 +152000 ekin = 0.233545181100895 | erot = 0.560170967504241 | epot = -15.4112301838403 | etot = -14.6175140352351 +153000 ekin = 0.243113638171897 | erot = 0.579575715963473 | epot = -15.4402033894145 | etot = -14.6175140352791 +154000 ekin = 0.250708030719563 | erot = 0.596234520730074 | epot = -15.4644565867606 | etot = -14.617514035311 +155000 ekin = 0.256210874594961 | erot = 0.609768185048496 | epot = -15.4834930949732 | etot = -14.6175140353298 +156000 ekin = 0.259627463842806 | erot = 0.619882772314079 | epot = -15.4970242714923 | etot = -14.6175140353354 +157000 ekin = 0.26107875673392 | erot = 0.626379517381585 | epot = -15.5049723094438 | etot = -14.6175140353283 +158000 ekin = 0.260787877594978 | erot = 0.629161788909624 | epot = -15.5074637018139 | etot = -14.6175140353093 +159000 ekin = 0.259061752299553 | erot = 0.628238692725195 | epot = -15.5048144803046 | etot = -14.6175140352799 +160000 ekin = 0.256269476948141 | erot = 0.623725097357881 | epot = -15.4975086095477 | etot = -14.6175140352417 +161000 ekin = 0.252818974262866 | erot = 0.615838055765116 | epot = -15.4861710652245 | etot = -14.6175140351965 +162000 ekin = 0.249133354781009 | erot = 0.604889772114047 | epot = -15.4715371620415 | etot = -14.6175140351465 +163000 ekin = 0.245628201594233 | erot = 0.591277407066157 | epot = -15.4544196437542 | etot = -14.6175140350938 +164000 ekin = 0.242690765770646 | erot = 0.5754701254003 | epot = -15.4356749262112 | etot = -14.6175140350402 +165000 ekin = 0.240661818237773 | erot = 0.557993868664013 | epot = -15.4161697218898 | etot = -14.617514034988 +166000 ekin = 0.239820672159938 | erot = 0.539414388849556 | epot = -15.3967490959484 | etot = -14.6175140349389 +167000 ekin = 0.24037368261711 | erot = 0.520319112884873 | epot = -15.3782068303964 | etot = -14.6175140348944 +168000 ekin = 0.24244635767351 | erot = 0.501298426047331 | epot = -15.3612588185771 | etot = -14.6175140348562 +169000 ekin = 0.246079081489649 | erot = 0.482926967022199 | epot = -15.3465200833372 | etot = -14.6175140348253 +170000 ekin = 0.2512263556708 | erot = 0.465745518941327 | epot = -15.334485909415 | etot = -14.6175140348028 +171000 ekin = 0.257759407502687 | erot = 0.450244072412507 | epot = -15.3255175147045 | etot = -14.6175140347893 +172000 ekin = 0.265471962315305 | erot = 0.436846557572436 | epot = -15.3198325546728 | etot = -14.617514034785 +173000 ekin = 0.274088992052948 | erot = 0.425897760801831 | epot = -15.3175007876449 | etot = -14.6175140347901 +174000 ekin = 0.283278228108448 | erot = 0.417652965987037 | epot = -15.3184452288997 | etot = -14.6175140348042 +175000 ekin = 0.292664164217591 | erot = 0.412270652066437 | epot = -15.3224488511105 | etot = -14.6175140348264 +176000 ekin = 0.301844276744599 | erot = 0.409808663992694 | epot = -15.3291669755931 | etot = -14.6175140348558 +177000 ekin = 0.310407103278429 | erot = 0.410224178772685 | epot = -15.3381453169418 | etot = -14.6175140348907 +178000 ekin = 0.317951707449239 | erot = 0.413377690532346 | epot = -15.3488434329111 | etot = -14.6175140349295 +179000 ekin = 0.324107901132174 | erot = 0.419041092198358 | epot = -15.3606630283006 | etot = -14.6175140349701 +180000 ekin = 0.328556397749118 | erot = 0.426909726006353 | epot = -15.3729801587658 | etot = -14.6175140350103 +181000 ekin = 0.331047834154798 | erot = 0.436618006901549 | epot = -15.3851798761042 | etot = -14.6175140350478 +182000 ekin = 0.331419420115411 | erot = 0.447757936313848 | epot = -15.3966913915096 | etot = -14.6175140350804 +183000 ekin = 0.329607792338432 | erot = 0.459899520064776 | epot = -15.4070213475094 | etot = -14.6175140351062 +184000 ekin = 0.325656516855951 | erot = 0.472611792132538 | epot = -15.4157823441122 | etot = -14.6175140351237 +185000 ekin = 0.319716934488103 | erot = 0.485483030926984 | epot = -15.4227140005474 | etot = -14.6175140351323 +186000 ekin = 0.312041347783061 | erot = 0.498138700397667 | epot = -15.4276940833127 | etot = -14.6175140351319 +187000 ekin = 0.302968200961952 | erot = 0.510255791848641 | epot = -15.4307380279341 | etot = -14.6175140351235 +188000 ekin = 0.292899787357099 | erot = 0.521572552051206 | epot = -15.4319863745165 | etot = -14.6175140351082 +189000 ekin = 0.282274048056294 | erot = 0.531893031493142 | epot = -15.4316811146379 | etot = -14.6175140350885 +190000 ekin = 0.271533034589587 | erot = 0.541086413296707 | epot = -15.4301334829529 | etot = -14.6175140350666 +191000 ekin = 0.261091384545769 | erot = 0.54908161018572 | epot = -15.4276870297764 | etot = -14.6175140350449 +192000 ekin = 0.251308489708551 | erot = 0.555858063434352 | epot = -15.4246805881686 | etot = -14.6175140350257 +193000 ekin = 0.242467771120031 | erot = 0.561433978654736 | epot = -15.4214157847852 | etot = -14.6175140350104 +194000 ekin = 0.2347655816246 | erot = 0.565853352187793 | epot = -15.4181329688123 | etot = -14.6175140349999 +195000 ekin = 0.228310848061445 | erot = 0.569173077812631 | epot = -15.4149979608682 | etot = -14.6175140349941 +196000 ekin = 0.223134890550306 | erot = 0.57145120860725 | epot = -15.4121001341502 | etot = -14.6175140349926 +197000 ekin = 0.219209242156003 | erot = 0.572737138233763 | epot = -15.409460415384 | etot = -14.6175140349943 +198000 ekin = 0.216468062809104 | erot = 0.573064123808166 | epot = -15.4070462216152 | etot = -14.6175140349979 +199000 ekin = 0.214831137522652 | erot = 0.572444258403913 | epot = -15.4047894309289 | etot = -14.6175140350023 +200000 ekin = 0.214223573902254 | erot = 0.57086576066316 | epot = -15.4026033695722 | etot = -14.6175140350067 +201000 ekin = 0.214589119166907 | erot = 0.568292309386801 | epot = -15.4003954635645 | etot = -14.6175140350107 +202000 ekin = 0.215895325602457 | erot = 0.564664121433424 | epot = -15.3980734820503 | etot = -14.6175140350145 +203000 ekin = 0.218130347570136 | erot = 0.559900543318492 | epot = -15.395544925907 | etot = -14.6175140350184 +204000 ekin = 0.221292667473869 | erot = 0.553904074217835 | epot = -15.3927107767149 | etot = -14.6175140350232 +205000 ekin = 0.225376258610798 | erot = 0.546565915588112 | epot = -15.3894562092286 | etot = -14.6175140350297 +206000 ekin = 0.230354397529151 | erot = 0.537773288683187 | epot = -15.3856417212507 | etot = -14.6175140350384 +207000 ekin = 0.236165428414771 | erot = 0.527418806929786 | epot = -15.3810982703936 | etot = -14.617514035049 +208000 ekin = 0.242703261860427 | erot = 0.515412077175151 | epot = -15.3756293740966 | etot = -14.617514035061 +209000 ekin = 0.249814382550021 | erot = 0.501693407691568 | epot = -15.3690218253148 | etot = -14.6175140350732 +210000 ekin = 0.257301864855649 | erot = 0.486249049965564 | epot = -15.361064949905 | etot = -14.6175140350838 +211000 ekin = 0.264935635394273 | erot = 0.469126912720557 | epot = -15.3515765832057 | etot = -14.6175140350909 +212000 ekin = 0.272467183646406 | erot = 0.450451153648061 | epot = -15.3404323723872 | etot = -14.6175140350927 +213000 ekin = 0.279646306736793 | erot = 0.430433702677846 | epot = -15.3275940445023 | etot = -14.6175140350876 +214000 ekin = 0.286237611276688 | erot = 0.409381288017783 | epot = -15.3131329343691 | etot = -14.6175140350746 +215000 ekin = 0.292034643872632 | erot = 0.387696263734527 | epot = -15.2972449426606 | etot = -14.6175140350534 +216000 ekin = 0.296870258152624 | erot = 0.365870567411729 | epot = -15.2802548605889 | etot = -14.6175140350245 +217000 ekin = 0.300622666324868 | erot = 0.344472695102956 | epot = -15.2626093964168 | etot = -14.617514034989 +218000 ekin = 0.303217269541043 | erot = 0.324128407398458 | epot = -15.2448597118882 | etot = -14.6175140349487 +219000 ekin = 0.304624843911682 | erot = 0.305496496152239 | epot = -15.2276353749694 | etot = -14.6175140349055 +220000 ekin = 0.304856982073792 | erot = 0.289241221676068 | epot = -15.2116122386118 | etot = -14.6175140348619 +221000 ekin = 0.303959749544065 | erot = 0.276003133762455 | epot = -15.1974769181266 | etot = -14.61751403482 +222000 ekin = 0.302006434070655 | erot = 0.266369862265548 | epot = -15.1858903311184 | etot = -14.6175140347822 +223000 ekin = 0.299090105490396 | erot = 0.260848208954625 | epot = -15.1774523491954 | etot = -14.6175140347503 +224000 ekin = 0.29531650374511 | erot = 0.259838588557332 | epot = -15.1726691270288 | etot = -14.6175140347264 +225000 ekin = 0.290797600317434 | erot = 0.263612591735795 | epot = -15.1719242267649 | etot = -14.6175140347117 +226000 ekin = 0.285646103232653 | erot = 0.272294318080247 | epot = -15.1754544560203 | etot = -14.6175140347074 +227000 ekin = 0.279971018689074 | erot = 0.285846075011501 | epot = -15.1833311284151 | etot = -14.6175140347145 +228000 ekin = 0.273874374727583 | erot = 0.304059069119542 | epot = -15.1954474785804 | etot = -14.6175140347333 +229000 ekin = 0.267449174159942 | erot = 0.326549807965912 | epot = -15.2115130168895 | etot = -14.6175140347636 +230000 ekin = 0.260778614118952 | erot = 0.352763004039877 | epot = -15.2310556529637 | etot = -14.6175140348048 +231000 ekin = 0.253936564976955 | erot = 0.381981763344646 | epot = -15.2534323631772 | etot = -14.6175140348556 +232000 ekin = 0.24698923084228 | erot = 0.413345683736504 | epot = -15.2778489494931 | etot = -14.6175140349143 +233000 ekin = 0.239997814735683 | erot = 0.445877135783545 | epot = -15.3033889854978 | etot = -14.6175140349785 +234000 ekin = 0.233021891669698 | erot = 0.478515439398703 | epot = -15.3290513661138 | etot = -14.6175140350454 +235000 ekin = 0.226123071286244 | erot = 0.510157919201248 | epot = -15.3537950255994 | etot = -14.6175140351119 +236000 ekin = 0.219368436952614 | erot = 0.539706010633753 | epot = -15.3765884827609 | etot = -14.6175140351745 +237000 ekin = 0.212833212708479 | erot = 0.566113832023268 | epot = -15.3964610799618 | etot = -14.6175140352301 +238000 ekin = 0.206602165162757 | erot = 0.588436180449468 | epot = -15.412552380888 | etot = -14.6175140352757 +239000 ekin = 0.200769360307635 | erot = 0.605872583258753 | epot = -15.4241559788757 | etot = -14.6175140353093 +240000 ekin = 0.195436190928488 | erot = 0.617803458378408 | epot = -15.4307536846362 | etot = -14.6175140353293 +241000 ekin = 0.190707920284559 | erot = 0.623817360381655 | epot = -15.4320393160013 | etot = -14.6175140353351 +242000 ekin = 0.186689132523883 | erot = 0.623726737660644 | epot = -15.4279299055112 | etot = -14.6175140353267 +243000 ekin = 0.18347888087463 | erot = 0.61757185737741 | epot = -15.418564773557 | etot = -14.617514035305 +244000 ekin = 0.181166166759762 | erot = 0.60561292371356 | epot = -15.4042931257446 | etot = -14.6175140352713 +245000 ekin = 0.179826690515581 | erot = 0.588311983398978 | epot = -15.3856527091421 | etot = -14.6175140352276 +246000 ekin = 0.179521473344392 | erot = 0.566306329740652 | epot = -15.3633418382609 | etot = -14.6175140351758 +247000 ekin = 0.180297726608685 | erot = 0.54037552872489 | epot = -15.3381872904519 | etot = -14.6175140351184 +248000 ekin = 0.182192022180427 | erot = 0.511404282992934 | epot = -15.3111103402306 | etot = -14.6175140350572 +249000 ekin = 0.185235475058219 | erot = 0.480343275338998 | epot = -15.2830927853917 | etot = -14.6175140349945 +250000 ekin = 0.18946032457762 | erot = 0.448169956263045 | epot = -15.2551443157728 | etot = -14.6175140349321 +251000 ekin = 0.194907020011059 | erot = 0.415851007133659 | epot = -15.2282720620165 | etot = -14.6175140348718 +252000 ekin = 0.201630699422451 | erot = 0.384307951122869 | epot = -15.2034526853603 | etot = -14.617514034815 +253000 ekin = 0.209705815254746 | erot = 0.354387113740477 | epot = -15.1816069637584 | etot = -14.6175140347632 +254000 ekin = 0.219227629545986 | erot = 0.326834860919931 | epot = -15.1635765251836 | etot = -14.6175140347177 +255000 ekin = 0.230309407956005 | erot = 0.302278768995696 | epot = -15.1501022116313 | etot = -14.6175140346796 +256000 ekin = 0.243074422920893 | erot = 0.281215109558497 | epot = -15.1418035671295 | etot = -14.6175140346501 +257000 ekin = 0.257642364628865 | erot = 0.264002762945737 | epot = -15.139159162205 | etot = -14.6175140346304 +258000 ekin = 0.274110461102935 | erot = 0.250863404057276 | epot = -15.1424878997817 | etot = -14.6175140346215 +259000 ekin = 0.292530483428745 | erot = 0.241887528332562 | epot = -15.1519320463858 | etot = -14.6175140346245 +260000 ekin = 0.312883750214262 | erot = 0.237045600990929 | epot = -15.167443385845 | etot = -14.6175140346398 +261000 ekin = 0.335057071665646 | erot = 0.23620332462488 | epot = -15.1887744309582 | etot = -14.6175140346677 +262000 ekin = 0.358823075932977 | erot = 0.239139750883904 | epot = -15.2154768615246 | etot = -14.6175140347077 +263000 ekin = 0.383828346058697 | erot = 0.24556675356939 | epot = -15.2469091343868 | etot = -14.6175140347588 +264000 ekin = 0.409592161639846 | erot = 0.25514829095879 | epot = -15.2822544874178 | etot = -14.6175140348192 +265000 ekin = 0.435517425641053 | erot = 0.267517972446926 | epot = -15.3205494329745 | etot = -14.6175140348865 +266000 ekin = 0.460913759434934 | erot = 0.28229374222826 | epot = -15.3607215366211 | etot = -14.6175140349579 +267000 ekin = 0.485031075314244 | erot = 0.299088986461549 | epot = -15.4016340968062 | etot = -14.6175140350304 +268000 ekin = 0.507100517474285 | erot = 0.317519986657596 | epot = -15.4421345392328 | etot = -14.6175140351009 +269000 ekin = 0.526378761164296 | erot = 0.337210258004039 | epot = -15.4811030543346 | etot = -14.6175140351662 +270000 ekin = 0.542191399558024 | erot = 0.357792786171182 | epot = -15.5174982209533 | etot = -14.6175140352241 +271000 ekin = 0.55397150127625 | erot = 0.378911394713957 | epot = -15.5503969312626 | etot = -14.6175140352724 +272000 ekin = 0.561290243477908 | erot = 0.400222387434508 | epot = -15.579026666222 | etot = -14.6175140353095 +273000 ekin = 0.563877614618956 | erot = 0.421397250044594 | epot = -15.6027888999983 | etot = -14.6175140353347 +274000 ekin = 0.561632338448697 | erot = 0.442126671656052 | epot = -15.6212730454525 | etot = -14.6175140353478 +275000 ekin = 0.554621238225524 | erot = 0.462125606775959 | epot = -15.6342608803503 | etot = -14.6175140353488 +276000 ekin = 0.543069132888247 | erot = 0.481138682332307 | epot = -15.6417218505594 | etot = -14.6175140353389 +277000 ekin = 0.527340979966703 | erot = 0.498945052082944 | epot = -15.6438000673687 | etot = -14.617514035319 +278000 ekin = 0.507918337218215 | erot = 0.515361832412993 | epot = -15.6407942049222 | etot = -14.617514035291 +279000 ekin = 0.485372319602766 | erot = 0.53024547360125 | epot = -15.6331318284605 | etot = -14.6175140352565 +280000 ekin = 0.460335116507262 | erot = 0.543490744710295 | epot = -15.6213398964351 | etot = -14.6175140352175 +281000 ekin = 0.433471859961099 | erot = 0.555027349455695 | epot = -15.606013244593 | etot = -14.6175140351762 +282000 ekin = 0.405454262481042 | erot = 0.564814480005611 | epot = -15.5877827776215 | etot = -14.6175140351348 +283000 ekin = 0.376937038993841 | erot = 0.572833827991569 | epot = -15.56728490208 | etot = -14.6175140350946 +284000 ekin = 0.348537747962758 | erot = 0.579081711929156 | epot = -15.5451334949486 | etot = -14.6175140350567 +285000 ekin = 0.320820372083395 | erot = 0.583561068644996 | epot = -15.5218954757513 | etot = -14.6175140350229 +286000 ekin = 0.294282726921591 | erot = 0.586274110944376 | epot = -15.49807087286 | etot = -14.617514034994 +287000 ekin = 0.269347634013421 | erot = 0.58721647590847 | epot = -15.4740781448926 | etot = -14.6175140349707 +288000 ekin = 0.246357704467551 | erot = 0.586373659771232 | epot = -15.450245399192 | etot = -14.6175140349532 +289000 ekin = 0.22557352214567 | erot = 0.583720426230562 | epot = -15.4268079833179 | etot = -14.6175140349417 +290000 ekin = 0.207174962818393 | erot = 0.57922365744791 | epot = -15.4039126552014 | etot = -14.6175140349351 +291000 ekin = 0.191265313940187 | erot = 0.572848780862473 | epot = -15.3816281297352 | etot = -14.6175140349326 +292000 ekin = 0.177877757396419 | erot = 0.564569470031942 | epot = -15.3599612623613 | etot = -14.617514034933 +293000 ekin = 0.166983649288418 | erot = 0.554379837681261 | epot = -15.3388775219044 | etot = -14.6175140349348 +294000 ekin = 0.158501898150678 | erot = 0.542307895558042 | epot = -15.3183238286452 | etot = -14.6175140349364 +295000 ekin = 0.152308641379645 | erot = 0.528428741575596 | epot = -15.298251417892 | etot = -14.6175140349367 +296000 ekin = 0.148246390134139 | erot = 0.512875830575803 | epot = -15.2786362556445 | etot = -14.6175140349346 +297000 ekin = 0.146131889948737 | erot = 0.495848833634457 | epot = -15.2594947585125 | etot = -14.6175140349293 +298000 ekin = 0.145762142540829 | erot = 0.477616979344766 | epot = -15.2408931568064 | etot = -14.6175140349208 +299000 ekin = 0.146918339842591 | erot = 0.458517327975552 | epot = -15.2229497027275 | etot = -14.6175140349094 +300000 ekin = 0.149367830717969 | erot = 0.438948042713275 | epot = -15.205829908327 | etot = -14.6175140348958 +301000 ekin = 0.152864610233931 | erot = 0.419357266834875 | epot = -15.1897359119496 | etot = -14.6175140348808 +302000 ekin = 0.157149122640062 | erot = 0.400228590599294 | epot = -15.1748917481051 | etot = -14.6175140348658 +303000 ekin = 0.16194834771892 | erot = 0.382064246008704 | epot = -15.1615266285792 | etot = -14.6175140348516 +304000 ekin = 0.166977167327322 | erot = 0.365367110080369 | epot = -15.1498583122469 | etot = -14.6175140348392 +305000 ekin = 0.171941885875759 | erot = 0.350622387002877 | epot = -15.1400783077083 | etot = -14.6175140348297 +306000 ekin = 0.176546522696758 | erot = 0.338279561365245 | epot = -15.1323401188853 | etot = -14.6175140348233 +307000 ekin = 0.180502080572099 | erot = 0.328734935092634 | epot = -15.1267510504853 | etot = -14.6175140348206 +308000 ekin = 0.183539117579173 | erot = 0.32231506851894 | epot = -15.1233682209196 | etot = -14.6175140348214 +309000 ekin = 0.185422589168761 | erot = 0.31926113518105 | epot = -15.1221977591756 | etot = -14.6175140348258 +310000 ekin = 0.18596838252546 | erot = 0.319714556778101 | epot = -15.1231969741369 | etot = -14.6175140348333 +311000 ekin = 0.185060444471766 | erot = 0.323704474533048 | epot = -15.1262789538485 | etot = -14.6175140348436 +312000 ekin = 0.18266705569995 | erot = 0.331137883754578 | epot = -15.1313189743107 | etot = -14.6175140348562 +313000 ekin = 0.178854671448202 | erot = 0.341793554574001 | epot = -15.1381622608926 | etot = -14.6175140348704 +314000 ekin = 0.173797674113419 | erot = 0.355321045101389 | epot = -15.1466327541005 | etot = -14.6175140348857 +315000 ekin = 0.167782440686126 | erot = 0.371246117949507 | epot = -15.1565425935371 | etot = -14.6175140349014 +316000 ekin = 0.161204347699483 | erot = 0.388983636697569 | epot = -15.1677020193138 | etot = -14.6175140349167 +317000 ekin = 0.154556738723145 | erot = 0.407858516720337 | epot = -15.1799292903744 | etot = -14.6175140349309 +318000 ekin = 0.148411457828143 | erot = 0.427134549770667 | epot = -15.1930600425422 | etot = -14.6175140349434 +319000 ekin = 0.143391260343367 | erot = 0.446049980955804 | epot = -15.2069552762529 | etot = -14.6175140349537 +320000 ekin = 0.140135163879429 | erot = 0.463857713006082 | epot = -15.2215069118471 | etot = -14.6175140349616 +321000 ekin = 0.139258496830789 | erot = 0.479867117343116 | epot = -15.2366396491412 | etot = -14.6175140349673 +322000 ekin = 0.141309963686665 | erot = 0.493483840953484 | epot = -15.2523078396112 | etot = -14.6175140349711 +323000 ekin = 0.146728465401823 | erot = 0.504243890594755 | epot = -15.2684863909706 | etot = -14.6175140349741 +324000 ekin = 0.155802740978128 | erot = 0.511838753068286 | epot = -15.285155529024 | etot = -14.6175140349776 +325000 ekin = 0.168637192339279 | erot = 0.516129344219886 | epot = -15.3022805715426 | etot = -14.6175140349834 +326000 ekin = 0.185127492740314 | erot = 0.517147991937071 | epot = -15.31978951967 | etot = -14.6175140349926 +327000 ekin = 0.204949583924698 | erot = 0.515089155112464 | epot = -15.3375527740434 | etot = -14.6175140350062 +328000 ekin = 0.227565145375698 | erot = 0.510290835145397 | epot = -15.3553700155455 | etot = -14.6175140350244 +329000 ekin = 0.252245305620947 | erot = 0.503209396461946 | epot = -15.3729687371292 | etot = -14.6175140350463 +330000 ekin = 0.278112223737838 | erot = 0.494390678508285 | epot = -15.3900169373164 | etot = -14.6175140350703 +331000 ekin = 0.304195517643728 | erot = 0.484439927615862 | epot = -15.4061494803532 | etot = -14.6175140350936 +332000 ekin = 0.329497983391289 | erot = 0.473992405220338 | epot = -15.4210044237253 | etot = -14.6175140351137 +333000 ekin = 0.353063353197021 | erot = 0.463685785197061 | epot = -15.4342631735221 | etot = -14.617514035128 +334000 ekin = 0.374038491014966 | erot = 0.454134842084351 | epot = -15.4456873682339 | etot = -14.6175140351346 +335000 ekin = 0.391723520498624 | erot = 0.44590856262641 | epot = -15.4551461182577 | etot = -14.6175140351327 +336000 ekin = 0.405605581596876 | erot = 0.439509690041266 | epot = -15.4626293067607 | etot = -14.6175140351225 +337000 ekin = 0.415374601836511 | erot = 0.435356764652945 | epot = -15.4682454015947 | etot = -14.6175140351053 +338000 ekin = 0.420921997008494 | erot = 0.4337688621957 | epot = -15.4722048942871 | etot = -14.6175140350829 +339000 ekin = 0.422325110445994 | erot = 0.434953376212245 | epot = -15.4747925217162 | etot = -14.6175140350579 +340000 ekin = 0.419821259879065 | erot = 0.438997304560045 | epot = -15.4763325994719 | etot = -14.6175140350328 +341000 ekin = 0.413775534579932 | erot = 0.445862573585468 | epot = -15.4771521431752 | etot = -14.6175140350098 +342000 ekin = 0.404646174019828 | erot = 0.455385967573506 | epot = -15.4775461765844 | etot = -14.617514034991 +343000 ekin = 0.392950705832007 | erot = 0.467284215126369 | epot = -15.4777489559361 | etot = -14.6175140349777 +344000 ekin = 0.379235231728315 | erot = 0.481164689425287 | epot = -15.4779139561242 | etot = -14.6175140349706 +345000 ekin = 0.364048459932831 | erot = 0.49654196729344 | epot = -15.4781044621959 | etot = -14.6175140349696 +346000 ekin = 0.347921358320248 | erot = 0.512860132814242 | epot = -15.4782955261082 | etot = -14.6175140349738 +347000 ekin = 0.331352665808313 | erot = 0.529520204052381 | epot = -15.4783869048424 | etot = -14.6175140349817 +348000 ekin = 0.314799955037007 | erot = 0.545911447468509 | epot = -15.478225437497 | etot = -14.6175140349915 +349000 ekin = 0.298675493175969 | erot = 0.561444708833552 | epot = -15.4776342370106 | etot = -14.6175140350011 +350000 ekin = 0.28334581552179 | erot = 0.575585348315622 | epot = -15.4764451988457 | etot = -14.6175140350083 +351000 ekin = 0.269133730328657 | erot = 0.587883045338955 | epot = -15.474530810679 | etot = -14.6175140350114 +352000 ekin = 0.256321431306528 | erot = 0.597995738138102 | epot = -15.4718312044538 | etot = -14.6175140350092 +353000 ekin = 0.245153509655857 | erot = 0.605705335206491 | epot = -15.4683728798634 | etot = -14.617514035001 +354000 ekin = 0.235838910987786 | erot = 0.610923562934953 | epot = -15.4642765089099 | etot = -14.6175140349872 +355000 ekin = 0.228551231301984 | erot = 0.613687305426088 | epot = -15.4597525716969 | etot = -14.6175140349688 +356000 ekin = 0.223427131308619 | erot = 0.61414390282533 | epot = -15.4550850690815 | etot = -14.6175140349475 +357000 ekin = 0.220563006919496 | erot = 0.612527933402533 | epot = -15.4506049752473 | etot = -14.6175140349253 +358000 ekin = 0.220010333199303 | erot = 0.609131855544879 | epot = -15.4466562236489 | etot = -14.6175140349047 +359000 ekin = 0.221770268741646 | erot = 0.604273418958276 | epot = -15.443557722588 | etot = -14.6175140348881 +360000 ekin = 0.225788163654918 | erot = 0.598262925571842 | epot = -15.4415651241044 | etot = -14.6175140348777 +361000 ekin = 0.231948578438913 | erot = 0.59137325198523 | epot = -15.4408358652996 | etot = -14.6175140348754 +362000 ekin = 0.240071331019464 | erot = 0.583815109039738 | epot = -15.4414004749418 | etot = -14.6175140348826 +363000 ekin = 0.249908988059078 | erot = 0.575719406612622 | epot = -15.4431424295716 | etot = -14.6175140348999 +364000 ekin = 0.261146140583132 | erot = 0.56712790648618 | epot = -15.4457880819966 | etot = -14.6175140349273 +365000 ekin = 0.273400773646818 | erot = 0.557992653604894 | epot = -15.4489074622159 | etot = -14.6175140349642 +366000 ekin = 0.286228056504663 | erot = 0.548184015757871 | epot = -15.4519261072718 | etot = -14.6175140350093 +367000 ekin = 0.299126926926786 | erot = 0.537506547610907 | epot = -15.4541475095983 | etot = -14.6175140350606 +368000 ekin = 0.311549892639084 | erot = 0.525721330951755 | epot = -15.4547852587065 | etot = -14.6175140351156 +369000 ekin = 0.322916493342769 | erot = 0.512572942753926 | epot = -15.4530034712682 | etot = -14.6175140351715 +370000 ekin = 0.332630833324557 | erot = 0.497818805481132 | epot = -15.4479636740308 | etot = -14.6175140352251 +371000 ekin = 0.340103492446634 | erot = 0.481258447415918 | epot = -15.4388759751356 | etot = -14.6175140352731 +372000 ekin = 0.344777943664193 | erot = 0.462760223983496 | epot = -15.4250522029596 | etot = -14.6175140353119 +373000 ekin = 0.346161332162081 | erot = 0.442283380417406 | epot = -15.405958747918 | etot = -14.6175140353385 +374000 ekin = 0.343859062980667 | erot = 0.419893962766177 | epot = -15.3812670610967 | etot = -14.6175140353498 +375000 ekin = 0.337612023151491 | erot = 0.395773904235502 | epot = -15.35089996273 | etot = -14.617514035343 +376000 ekin = 0.327334336193659 | erot = 0.370223433835828 | epot = -15.3150718053453 | etot = -14.6175140353159 +377000 ekin = 0.313148263712968 | erot = 0.3436575453366 | epot = -15.2743198443167 | etot = -14.6175140352671 +378000 ekin = 0.295411338277735 | erot = 0.316597454537734 | epot = -15.2295228280119 | etot = -14.6175140351964 +379000 ekin = 0.274729408510529 | erot = 0.289657740939432 | epot = -15.1819011845551 | etot = -14.6175140351051 +380000 ekin = 0.251948675267414 | erot = 0.263529414055011 | epot = -15.1329921243187 | etot = -14.6175140349963 +381000 ekin = 0.228120837035203 | erot = 0.238958749468097 | epot = -15.0845936213794 | etot = -14.6175140348761 +382000 ekin = 0.204438854506746 | erot = 0.216721270519329 | epot = -15.0386741597779 | etot = -14.6175140347518 +383000 ekin = 0.182146263755385 | erot = 0.19759188098445 | epot = -14.9972521793722 | etot = -14.6175140346323 +384000 ekin = 0.162429780679522 | erot = 0.182311896924387 | epot = -14.9622557121308 | etot = -14.6175140345269 +385000 ekin = 0.146310622123822 | erot = 0.171555128911536 | epot = -14.9353797854792 | etot = -14.6175140344439 +386000 ekin = 0.134552389652403 | erot = 0.165895597224741 | epot = -14.9179620212657 | etot = -14.6175140343886 +387000 ekin = 0.127600986328395 | erot = 0.165779213534325 | epot = -14.9108942342266 | etot = -14.6175140343639 +388000 ekin = 0.125565151523028 | erot = 0.171500950984996 | epot = -14.9145801368772 | etot = -14.6175140343691 +389000 ekin = 0.128237001096973 | erot = 0.183188026636525 | epot = -14.9289390621349 | etot = -14.6175140344014 +390000 ekin = 0.135143637923168 | erot = 0.200788930663413 | epot = -14.9534466030433 | etot = -14.6175140344567 +391000 ekin = 0.145616156499953 | erot = 0.224068074688611 | epot = -14.9871982657191 | etot = -14.6175140345306 +392000 ekin = 0.158862235246809 | erot = 0.252606362171908 | epot = -15.0289826320371 | etot = -14.6175140346184 +393000 ekin = 0.174032087603698 | erot = 0.285808726839658 | epot = -15.0773548491589 | etot = -14.6175140347155 +394000 ekin = 0.190272707003915 | erot = 0.322920107512839 | epot = -15.1307068493349 | etot = -14.6175140348181 +395000 ekin = 0.206769905102427 | erot = 0.363051013228117 | epot = -15.1873349532527 | etot = -14.6175140349221 +396000 ekin = 0.222780272470673 | erot = 0.405212687947373 | epot = -15.2455069954414 | etot = -14.6175140350234 +397000 ekin = 0.23765569871957 | erot = 0.448360183482314 | epot = -15.3035299173199 | etot = -14.6175140351181 +398000 ekin = 0.250862154070766 | erot = 0.491439914329229 | epot = -15.3598161036022 | etot = -14.6175140352022 +399000 ekin = 0.261993055954332 | erot = 0.533437059170124 | epot = -15.4129441503972 | etot = -14.6175140352727 +400000 ekin = 0.270776550507805 | erot = 0.573417887949055 | epot = -15.4617084737844 | etot = -14.6175140353276 +401000 ekin = 0.277075831016468 | erot = 0.610562842823512 | epot = -15.505152709206 | etot = -14.617514035366 +402000 ekin = 0.280882158892238 | erot = 0.644187798759056 | epot = -15.5425839930397 | etot = -14.6175140353884 +403000 ekin = 0.282301228579434 | erot = 0.673752968641712 | epot = -15.5735682326173 | etot = -14.6175140353962 +404000 ekin = 0.281534519812515 | erot = 0.698860907481931 | epot = -15.5979094626858 | etot = -14.6175140353913 +405000 ekin = 0.278857975737129 | erot = 0.719246574878154 | epot = -15.6156185859915 | etot = -14.6175140353763 +406000 ekin = 0.274600555759475 | erot = 0.73476315739679 | epot = -15.6268777485094 | etot = -14.6175140353531 +407000 ekin = 0.269124923358509 | erot = 0.745367259285065 | epot = -15.6320062179673 | etot = -14.6175140353237 +408000 ekin = 0.262811853165719 | erot = 0.751106276665231 | epot = -15.63143216512 | etot = -14.6175140352891 +409000 ekin = 0.256049112192117 | erot = 0.752109968276187 | epot = -15.6256731157185 | etot = -14.6175140352502 +410000 ekin = 0.249224269809732 | erot = 0.74858433225965 | epot = -15.6153226372768 | etot = -14.6175140352074 +411000 ekin = 0.242720888553437 | erot = 0.740809103918433 | epot = -15.6010440276326 | etot = -14.6175140351607 +412000 ekin = 0.236916379506095 | erot = 0.729136085380854 | epot = -15.5835664999974 | etot = -14.6175140351104 +413000 ekin = 0.232179735243653 | erot = 0.713985498456999 | epot = -15.5636792687578 | etot = -14.6175140350572 +414000 ekin = 0.228867632642243 | erot = 0.695838652585891 | epot = -15.5422203202302 | etot = -14.6175140350021 +415000 ekin = 0.227317772307856 | erot = 0.675225695396218 | epot = -15.5200575026509 | etot = -14.6175140349469 +416000 ekin = 0.227838940777607 | erot = 0.652708261105161 | epot = -15.4980612367764 | etot = -14.6175140348937 +417000 ekin = 0.230697970866891 | erot = 0.628857925336047 | epot = -15.4770699310479 | etot = -14.617514034845 +418000 ekin = 0.236104416120681 | erot = 0.604232291329749 | epot = -15.4578507422538 | etot = -14.6175140348034 +419000 ekin = 0.244194252200401 | erot = 0.579351108945114 | epot = -15.4410593959166 | etot = -14.6175140347711 +420000 ekin = 0.255014214168464 | erot = 0.554674986841152 | epot = -15.4272032357598 | etot = -14.6175140347502 +421000 ekin = 0.268508458340295 | erot = 0.530589008736334 | epot = -15.4166115018185 | etot = -14.6175140347418 +422000 ekin = 0.284509119560496 | erot = 0.507392982380571 | epot = -15.4094161366875 | etot = -14.6175140347464 +423000 ekin = 0.302732060426934 | erot = 0.485299248118979 | epot = -15.4055453433093 | etot = -14.6175140347634 +424000 ekin = 0.322778728051398 | erot = 0.464438075670481 | epot = -15.4047308385137 | etot = -14.6175140347918 +425000 ekin = 0.344144594922637 | erot = 0.444869796712131 | epot = -15.4065284264641 | etot = -14.6175140348293 +426000 ekin = 0.366234204300038 | erot = 0.426602052983704 | epot = -15.4103502921573 | etot = -14.6175140348735 +427000 ekin = 0.388382398339816 | erot = 0.409609962240036 | epot = -15.4155063955013 | etot = -14.6175140349214 +428000 ekin = 0.409880900047524 | erot = 0.393856678091899 | epot = -15.4212516131094 | etot = -14.6175140349699 +429000 ekin = 0.430009061106479 | erot = 0.379311788381591 | epot = -15.4268348845041 | etot = -14.617514035016 +430000 ekin = 0.448067283636575 | erot = 0.3659652824005 | epot = -15.4315466010941 | etot = -14.617514035057 +431000 ekin = 0.463411378723588 | erot = 0.353835411175161 | epot = -15.4347608249895 | etot = -14.6175140350907 +432000 ekin = 0.475485941535269 | erot = 0.342969616703674 | epot = -15.4359695933546 | etot = -14.6175140351156 +433000 ekin = 0.483854704021334 | erot = 0.333438714396283 | epot = -15.4348074535483 | etot = -14.6175140351307 +434000 ekin = 0.488225698519521 | erot = 0.325325491782385 | epot = -15.4310652254377 | etot = -14.6175140351358 +435000 ekin = 0.48846961521868 | erot = 0.318709988965965 | epot = -15.4246936393157 | etot = -14.6175140351311 +436000 ekin = 0.484629100798397 | erot = 0.313653867974891 | epot = -15.4157970038909 | etot = -14.6175140351176 +437000 ekin = 0.476917712285193 | erot = 0.310186654191006 | epot = -15.4046184015729 | etot = -14.6175140350967 +438000 ekin = 0.465707830236428 | erot = 0.308296241623089 | epot = -15.3915181069294 | etot = -14.6175140350699 +439000 ekin = 0.45150753680146 | erot = 0.30792515377069 | epot = -15.3769467256113 | etot = -14.6175140350391 +440000 ekin = 0.434927659014138 | erot = 0.308973010492868 | epot = -15.3614147045135 | etot = -14.6175140350065 +441000 ekin = 0.416641657349937 | erot = 0.311304747383582 | epot = -15.3454604397074 | etot = -14.6175140349739 +442000 ekin = 0.397341542601571 | erot = 0.314762618736297 | epot = -15.3296181962812 | etot = -14.6175140349433 +443000 ekin = 0.377694362715545 | erot = 0.319179725729324 | epot = -15.314388123361 | etot = -14.6175140349161 +444000 ekin = 0.358304425136817 | erot = 0.32439329819003 | epot = -15.3002117582203 | etot = -14.6175140348934 +445000 ekin = 0.339684383335156 | erot = 0.330254911559461 | epot = -15.2874533297707 | etot = -14.6175140348761 +446000 ekin = 0.322237701351822 | erot = 0.336636009508 | epot = -15.2763877457241 | etot = -14.6175140348643 +447000 ekin = 0.30625308658371 | erot = 0.34342824275766 | epot = -15.2671953641993 | etot = -14.6175140348579 +448000 ekin = 0.291909091343975 | erot = 0.350538602019967 | epot = -15.2599617282208 | etot = -14.6175140348568 +449000 ekin = 0.279285717664377 | erot = 0.357880263087886 | epot = -15.254680015613 | etot = -14.6175140348608 +450000 ekin = 0.268379332693754 | erot = 0.365360767815974 | epot = -15.2512541353793 | etot = -14.6175140348696 +451000 ekin = 0.259117719163031 | erot = 0.372869677558793 | epot = -15.2495014316051 | etot = -14.6175140348833 +452000 ekin = 0.251373384973835 | erot = 0.380268095669032 | epot = -15.2491555155445 | etot = -14.6175140349017 +453000 ekin = 0.24497482412797 | erot = 0.387382402362676 | epot = -15.2498712614149 | etot = -14.6175140349243 +454000 ekin = 0.239716691076598 | erot = 0.394004131859313 | epot = -15.251234857886 | etot = -14.6175140349501 +455000 ekin = 0.235370413814522 | erot = 0.399897145639913 | epot = -15.252781594432 | etot = -14.6175140349776 +456000 ekin = 0.231696513790871 | erot = 0.404812188422525 | epot = -15.254022737218 | etot = -14.6175140350046 +457000 ekin = 0.22845901443235 | erot = 0.408507709512969 | epot = -15.2544807589739 | etot = -14.6175140350285 +458000 ekin = 0.225441196082656 | erot = 0.41077470562198 | epot = -15.2537299367515 | etot = -14.6175140350469 +459000 ekin = 0.22246101894078 | erot = 0.411462514810095 | epot = -15.251437568808 | etot = -14.6175140350572 +460000 ekin = 0.219384094438714 | erot = 0.410502136527495 | epot = -15.2474002660241 | etot = -14.6175140350579 +461000 ekin = 0.21613224524022 | erot = 0.40792384413126 | epot = -15.2415701244196 | etot = -14.6175140350481 +462000 ekin = 0.212686361973382 | erot = 0.403866554422734 | epot = -15.2340669514243 | etot = -14.6175140350282 +463000 ekin = 0.209083218482854 | erot = 0.398577486489151 | epot = -15.2251747399712 | etot = -14.6175140349992 +464000 ekin = 0.20540688826373 | erot = 0.392401883856613 | epot = -15.2153228070836 | etot = -14.6175140349633 +465000 ekin = 0.201776197881068 | erot = 0.385763783461919 | epot = -15.2050540162659 | etot = -14.6175140349229 +466000 ekin = 0.198330130961181 | erot = 0.379139817336986 | epot = -15.1949839831793 | etot = -14.6175140348811 +467000 ekin = 0.195213224017124 | erot = 0.373028711257475 | epot = -15.1857559701151 | etot = -14.6175140348405 +468000 ekin = 0.192562810062158 | erot = 0.367919448414916 | epot = -15.1779962932808 | etot = -14.6175140348037 +469000 ekin = 0.190499545154769 | erot = 0.364261004085612 | epot = -15.1722745840131 | etot = -14.6175140347727 +470000 ekin = 0.18912208603274 | erot = 0.362436180586983 | epot = -15.1690723013684 | etot = -14.6175140347487 +471000 ekin = 0.188506156938867 | erot = 0.362741456207278 | epot = -15.1687616478786 | etot = -14.6175140347325 +472000 ekin = 0.188707621222394 | erot = 0.365373993438347 | epot = -15.1715956493845 | etot = -14.6175140347238 +473000 ekin = 0.189768618622282 | erot = 0.370426120543888 | epot = -15.1777087738883 | etot = -14.6175140347222 +474000 ekin = 0.191725397341772 | erot = 0.377886798112635 | epot = -15.1871262301808 | etot = -14.6175140347264 +475000 ekin = 0.194616213071371 | erot = 0.387648901412467 | epot = -15.1997791492193 | etot = -14.6175140347354 +476000 ekin = 0.19848763616133 | erot = 0.399520678155556 | epot = -15.2155223490651 | etot = -14.6175140347483 +477000 ekin = 0.203397790430575 | erot = 0.413239540254448 | epot = -15.234151365449 | etot = -14.617514034764 +478000 ekin = 0.209415519783994 | erot = 0.428486466926518 | epot = -15.2554160214928 | etot = -14.6175140347823 +479000 ekin = 0.216615156595488 | erot = 0.444899686771521 | epot = -15.2790288781697 | etot = -14.6175140348027 +480000 ekin = 0.225067223158495 | erot = 0.462086880017487 | epot = -15.3046681380014 | etot = -14.6175140348255 +481000 ekin = 0.234826185148526 | erot = 0.479635803738694 | epot = -15.3319760237382 | etot = -14.6175140348509 +482000 ekin = 0.24591693935593 | erot = 0.497123799837189 | epot = -15.3605547740723 | etot = -14.6175140348792 +483000 ekin = 0.258322039581471 | erot = 0.514126984880484 | epot = -15.3899630593723 | etot = -14.6175140349103 +484000 ekin = 0.271971667055458 | erot = 0.530229960568097 | epot = -15.4197156625675 | etot = -14.617514034944 +485000 ekin = 0.286738030810237 | erot = 0.545036619609161 | epot = -15.4492886853988 | etot = -14.6175140349794 +486000 ekin = 0.302435294442602 | erot = 0.558182125190157 | epot = -15.4781314546481 | etot = -14.6175140350154 +487000 ekin = 0.318825369858635 | erot = 0.569345540302413 | epot = -15.5056849452114 | etot = -14.6175140350504 +488000 ekin = 0.335629120856599 | erot = 0.578262027782435 | epot = -15.5314051837218 | etot = -14.6175140350827 +489000 ekin = 0.352541803825719 | erot = 0.584733173542254 | epot = -15.5547890124787 | etot = -14.6175140351108 +490000 ekin = 0.369251041133798 | erot = 0.58863390237619 | epot = -15.5753989786432 | etot = -14.6175140351332 +491000 ekin = 0.385455339944008 | erot = 0.589914693970058 | epot = -15.5928840690631 | etot = -14.6175140351491 +492000 ekin = 0.40088115647899 | erot = 0.588598334680754 | epot = -15.6069935263179 | etot = -14.6175140351581 +493000 ekin = 0.415296746377553 | erot = 0.584771169137649 | epot = -15.6175819506758 | etot = -14.6175140351606 +494000 ekin = 0.428521503102931 | erot = 0.578569614095801 | epot = -15.6246051523561 | etot = -14.6175140351573 +495000 ekin = 0.440430011858771 | erot = 0.570163426568569 | epot = -15.6281074735768 | etot = -14.6175140351495 +496000 ekin = 0.450950706316734 | erot = 0.559737766477586 | epot = -15.628202507933 | etot = -14.6175140351387 +497000 ekin = 0.460059581798191 | erot = 0.547476355485745 | epot = -15.6250499724103 | etot = -14.6175140351264 +498000 ekin = 0.467769906492318 | erot = 0.533547985555278 | epot = -15.6188319271617 | etot = -14.6175140351141 +499000 ekin = 0.474119221073082 | erot = 0.518098277332704 | epot = -15.6097315335085 | etot = -14.6175140351027 +500000 ekin = 0.47915510663518 | erot = 0.501247978937513 | epot = -15.5979171206656 | etot = -14.6175140350929 +501000 ekin = 0.482921233338969 | erot = 0.483098304082662 | epot = -15.5835335725064 | etot = -14.6175140350848 +502000 ekin = 0.485445093649088 | erot = 0.463742920559554 | epot = -15.5667020492864 | etot = -14.6175140350777 +503000 ekin = 0.486728599209648 | erot = 0.443285305605623 | epot = -15.5475279398862 | etot = -14.6175140350709 +504000 ekin = 0.486742408087926 | erot = 0.421859374631785 | epot = -15.5261158177828 | etot = -14.6175140350631 +505000 ekin = 0.485424480827694 | erot = 0.399650657768087 | epot = -15.5025891736488 | etot = -14.617514035053 +506000 ekin = 0.48268297341187 | erot = 0.376914939267219 | epot = -15.4771119477182 | etot = -14.6175140350392 +507000 ekin = 0.478403198154612 | erot = 0.353991273961029 | epot = -15.4499085071364 | etot = -14.6175140350208 +508000 ekin = 0.472458052935441 | erot = 0.331306710133916 | epot = -15.4212787980666 | etot = -14.6175140349972 +509000 ekin = 0.46472106285539 | erot = 0.309370883447747 | epot = -15.3916059812718 | etot = -14.6175140349687 +510000 ekin = 0.455081004104095 | erot = 0.288759823578743 | epot = -15.3613548626186 | etot = -14.6175140349358 +511000 ekin = 0.443456979180403 | erot = 0.270089690707411 | epot = -15.3310607047875 | etot = -14.6175140348996 +512000 ekin = 0.429812848219575 | erot = 0.25398253489869 | epot = -15.3013094179802 | etot = -14.6175140348619 +513000 ekin = 0.414169942618988 | erot = 0.241027258547328 | epot = -15.2727112359908 | etot = -14.6175140348245 +514000 ekin = 0.396617122319459 | erot = 0.231739657368316 | epot = -15.245870814477 | etot = -14.6175140347893 +515000 ekin = 0.377317407138787 | erot = 0.226525548757195 | epot = -15.2213569906539 | etot = -14.6175140347579 +516000 ekin = 0.356510629533613 | erot = 0.225650587239684 | epot = -15.1996752515051 | etot = -14.6175140347318 +517000 ekin = 0.334511811731556 | erot = 0.229219509886492 | epot = -15.1812453563299 | etot = -14.6175140347118 +518000 ekin = 0.311705249160021 | erot = 0.23716641592675 | epot = -15.1663856997854 | etot = -14.6175140346987 +519000 ekin = 0.288534562405509 | erot = 0.249256456193826 | epot = -15.1553050532917 | etot = -14.6175140346923 +520000 ekin = 0.265489234982404 | erot = 0.265098165451267 | epot = -15.1481014351262 | etot = -14.6175140346925 +521000 ekin = 0.243088358087729 | erot = 0.284164745160129 | epot = -15.1447671379464 | etot = -14.6175140346986 +522000 ekin = 0.221862437060792 | erot = 0.305821970140486 | epot = -15.1451984419111 | etot = -14.6175140347098 +523000 ekin = 0.202334169776215 | erot = 0.329360070797338 | epot = -15.149208275299 | etot = -14.6175140347255 +524000 ekin = 0.184999091076189 | erot = 0.354026911471086 | epot = -15.1565400372918 | etot = -14.6175140347445 +525000 ekin = 0.170306912739355 | erot = 0.379059948771691 | epot = -15.1668808962774 | etot = -14.6175140347664 +526000 ekin = 0.158644243148445 | erot = 0.403715126925631 | epot = -15.1798734048646 | etot = -14.6175140347905 +527000 ekin = 0.150319367666608 | erot = 0.427291025812717 | epot = -15.1951244282958 | etot = -14.6175140348165 +528000 ekin = 0.145549592055318 | erot = 0.449147424933815 | epot = -15.2122110518333 | etot = -14.6175140348441 +529000 ekin = 0.144451603984815 | erot = 0.46871812185095 | epot = -15.2306837607091 | etot = -14.6175140348734 +530000 ekin = 0.147035267138349 | erot = 0.485518371011605 | epot = -15.2500676730542 | etot = -14.6175140349042 +531000 ekin = 0.153201203684292 | erot = 0.499147835497304 | epot = -15.2698630741182 | etot = -14.6175140349366 +532000 ekin = 0.162742448479717 | erot = 0.509290301682708 | epot = -15.2895467851327 | etot = -14.6175140349702 +533000 ekin = 0.175350354881916 | erot = 0.515711587206721 | epot = -15.3085759770934 | etot = -14.6175140350047 +534000 ekin = 0.190624856013519 | erot = 0.518257146630614 | epot = -15.3263960376834 | etot = -14.6175140350393 +535000 ekin = 0.208088493536824 | erot = 0.516850140104756 | epot = -15.3424526687142 | etot = -14.6175140350726 +536000 ekin = 0.227204325842689 | erot = 0.511491240065728 | epot = -15.3562096010119 | etot = -14.6175140351035 +537000 ekin = 0.247396768812984 | erot = 0.502260311074185 | epot = -15.3671711150173 | etot = -14.6175140351302 +538000 ekin = 0.268074342413392 | erot = 0.489319600961478 | epot = -15.3749079785256 | etot = -14.6175140351508 +539000 ekin = 0.288653182933449 | erot = 0.4729176796722 | epot = -15.3790848977693 | etot = -14.6175140351637 +540000 ekin = 0.308579985825782 | erot = 0.453392904739592 | epot = -15.3794869257329 | etot = -14.6175140351675 +541000 ekin = 0.327353008191246 | erot = 0.431174973010967 | epot = -15.3760420163633 | etot = -14.6175140351611 +542000 ekin = 0.344539853506965 | erot = 0.406783142889028 | epot = -15.3688370315399 | etot = -14.6175140351439 +543000 ekin = 0.359790986513993 | erot = 0.380819988063805 | epot = -15.3581250096939 | etot = -14.6175140351161 +544000 ekin = 0.37284826309085 | erot = 0.353960030672464 | epot = -15.344322328842 | etot = -14.6175140350787 +545000 ekin = 0.383548167009815 | erot = 0.326933212481791 | epot = -15.3279954145248 | etot = -14.6175140350332 +546000 ekin = 0.391819867385749 | erot = 0.300503784237994 | epot = -15.3098376866053 | etot = -14.6175140349815 +547000 ekin = 0.397678590182396 | erot = 0.275445713887096 | epot = -15.2906383389958 | etot = -14.6175140349263 +548000 ekin = 0.401215088504832 | erot = 0.252516050366015 | epot = -15.2712451737408 | etot = -14.6175140348699 +549000 ekin = 0.402582175512791 | erot = 0.232427794767637 | epot = -15.2525240050959 | etot = -14.6175140348155 +550000 ekin = 0.401979352687969 | erot = 0.215823740833009 | epot = -15.2353171282862 | etot = -14.6175140347652 +551000 ekin = 0.399636550193996 | erot = 0.203252510909739 | epot = -15.220403095825 | etot = -14.6175140347213 +552000 ekin = 0.395797934840894 | erot = 0.195147714573778 | epot = -15.2084596841007 | etot = -14.617514034686 +553000 ekin = 0.390706676476196 | erot = 0.191810879117336 | epot = -15.2000315902546 | etot = -14.6175140346611 +554000 ekin = 0.384591526958096 | erot = 0.19339860945437 | epot = -15.1955041710601 | etot = -14.6175140346476 +555000 ekin = 0.377656068332676 | erot = 0.199914362894006 | epot = -15.1950844658734 | etot = -14.6175140346467 +556000 ekin = 0.370071512615683 | erot = 0.211205266307111 | epot = -15.1987908135806 | etot = -14.6175140346578 +557000 ekin = 0.361973939272813 | erot = 0.226964515102972 | epot = -15.2064524890562 | etot = -14.6175140346805 +558000 ekin = 0.353466765020817 | erot = 0.246739996102199 | epot = -15.2177207958362 | etot = -14.6175140347132 +559000 ekin = 0.344628961765223 | erot = 0.269949765670651 | epot = -15.2320927621895 | etot = -14.6175140347536 +560000 ekin = 0.335528980568065 | erot = 0.295904778796298 | epot = -15.248947794163 | etot = -14.6175140347986 +561000 ekin = 0.326243446081694 | erot = 0.32383871490908 | epot = -15.2675961958353 | etot = -14.6175140348445 +562000 ekin = 0.316878486813705 | erot = 0.352943857553535 | epot = -15.2873363792542 | etot = -14.617514034887 +563000 ekin = 0.307590234581993 | erot = 0.382410843957943 | epot = -15.3075151134627 | etot = -14.6175140349227 +564000 ekin = 0.298599911427723 | erot = 0.411468934029848 | epot = -15.3275828804063 | etot = -14.6175140349488 +565000 ekin = 0.290198521501613 | erot = 0.439422606477982 | epot = -15.3471351629436 | etot = -14.617514034964 +566000 ekin = 0.282736992095915 | erot = 0.465680158920146 | epot = -15.3659311859852 | etot = -14.6175140349691 +567000 ekin = 0.276599956454237 | erot = 0.489770841523137 | epot = -15.3838848329439 | etot = -14.6175140349665 +568000 ekin = 0.272165052790849 | erot = 0.51134888782089 | epot = -15.4010279755719 | etot = -14.6175140349602 +569000 ekin = 0.269753809413351 | erot = 0.530185258477429 | epot = -15.4174531028455 | etot = -14.6175140349547 +570000 ekin = 0.269583567607364 | erot = 0.546150320474836 | epot = -15.4332479230362 | etot = -14.617514034954 +571000 ekin = 0.271731068577875 | erot = 0.559192265325752 | epot = -15.4484373688642 | etot = -14.6175140349606 +572000 ekin = 0.276116495687091 | erot = 0.569316321634121 | epot = -15.4629468522959 | etot = -14.6175140349747 +573000 ekin = 0.282512256444534 | erot = 0.576569321998237 | epot = -15.4765956134374 | etot = -14.6175140349946 +574000 ekin = 0.290574483947443 | erot = 0.58103049076154 | epot = -15.4891190097262 | etot = -14.6175140350172 +575000 ekin = 0.299890113326593 | erot = 0.582808418137594 | epot = -15.5002125665028 | etot = -14.6175140350386 +576000 ekin = 0.310029076130859 | erot = 0.582041678954832 | epot = -15.5095847901412 | etot = -14.6175140350555 +577000 ekin = 0.320591144135675 | erot = 0.578899817193377 | epot = -15.5170049963946 | etot = -14.6175140350655 +578000 ekin = 0.331239680817734 | erot = 0.573581904321388 | epot = -15.5223356202072 | etot = -14.6175140350681 +579000 ekin = 0.341718767395713 | erot = 0.566311213814816 | epot = -15.5255440162742 | etot = -14.6175140350637 +580000 ekin = 0.351854361646192 | erot = 0.557326170820746 | epot = -15.5266945675209 | etot = -14.617514035054 +581000 ekin = 0.361543170719959 | erot = 0.546869043111512 | epot = -15.5259262488727 | etot = -14.6175140350412 +582000 ekin = 0.370734291431731 | erot = 0.535174473618127 | epot = -15.5234228000774 | etot = -14.6175140350275 +583000 ekin = 0.37940854514636 | erot = 0.522459863754317 | epot = -15.5193824439152 | etot = -14.6175140350145 +584000 ekin = 0.387559338332064 | erot = 0.50891899993969 | epot = -15.5139923732753 | etot = -14.6175140350036 +585000 ekin = 0.395177418309436 | erot = 0.494719483694829 | epot = -15.5074109369994 | etot = -14.6175140349952 +586000 ekin = 0.402240533516594 | erot = 0.480003760424791 | epot = -15.4997583289309 | etot = -14.6175140349895 +587000 ekin = 0.408707997145263 | erot = 0.464893014294175 | epot = -15.4911150464257 | etot = -14.6175140349862 +588000 ekin = 0.41451954577295 | erot = 0.449492951760516 | epot = -15.4815265325182 | etot = -14.6175140349847 +589000 ekin = 0.419597612555334 | erot = 0.43390048790532 | epot = -15.4710121354448 | etot = -14.6175140349841 +590000 ekin = 0.423852083806567 | erot = 0.418210489542958 | epot = -15.4595766083332 | etot = -14.6175140349837 +591000 ekin = 0.427186671517479 | erot = 0.402521929657892 | epot = -15.447222636158 | etot = -14.6175140349826 +592000 ekin = 0.429506137373686 | erot = 0.386943005728737 | epot = -15.4339631780827 | etot = -14.6175140349802 +593000 ekin = 0.430723706116615 | erot = 0.371594936609099 | epot = -15.4198326777017 | etot = -14.617514034976 +594000 ekin = 0.430768094953839 | erot = 0.356614269836478 | epot = -15.4048963997596 | etot = -14.6175140349693 +595000 ekin = 0.42958966483036 | erot = 0.34215360916983 | epot = -15.3892573089602 | etot = -14.61751403496 +596000 ekin = 0.427165296133674 | erot = 0.328380718540701 | epot = -15.3730600496226 | etot = -14.6175140349482 +597000 ekin = 0.423501658500188 | erot = 0.315475989401846 | epot = -15.3564916828361 | etot = -14.617514034934 +598000 ekin = 0.418636501255824 | erot = 0.30362835958022 | epot = -15.3397788957539 | etot = -14.6175140349178 +599000 ekin = 0.412638207582771 | erot = 0.293029673722298 | epot = -15.3231819162053 | etot = -14.6175140349002 +600000 ekin = 0.405603414753992 | erot = 0.283867637225037 | epot = -15.306985086861 | etot = -14.6175140348819 +601000 ekin = 0.397652939448924 | erot = 0.27631757335997 | epot = -15.2914845476729 | etot = -14.617514034864 +602000 ekin = 0.388926339151977 | erot = 0.270533300127966 | epot = -15.2769736741272 | etot = -14.6175140348472 +603000 ekin = 0.379575547711323 | erot = 0.266637582798157 | epot = -15.2637271653422 | etot = -14.6175140348327 +604000 ekin = 0.369758112224678 | erot = 0.264712769809213 | epot = -15.2519849168553 | etot = -14.6175140348214 +605000 ekin = 0.359630614964776 | erot = 0.264792359550131 | epot = -15.241937009329 | etot = -14.617514034814 +606000 ekin = 0.349342882571482 | erot = 0.266854337886994 | epot = -15.2337112552696 | etot = -14.6175140348111 +607000 ekin = 0.339033558751721 | erot = 0.270817131627805 | epot = -15.2273647251923 | etot = -14.6175140348128 +608000 ekin = 0.328827538259558 | erot = 0.276538908097645 | epot = -15.2228804811762 | etot = -14.617514034819 +609000 ekin = 0.318835621087791 | erot = 0.283820700144912 | epot = -15.2201703560617 | etot = -14.617514034829 +610000 ekin = 0.309156542568471 | erot = 0.292413461056483 | epot = -15.2190840384669 | etot = -14.617514034842 +611000 ekin = 0.29988127210835 | erot = 0.302028697870677 | epot = -15.2194240048356 | etot = -14.6175140348566 +612000 ekin = 0.291099167856382 | erot = 0.312351863790435 | epot = -15.2209650665183 | etot = -14.6175140348715 +613000 ekin = 0.282905257831731 | erot = 0.323057294042835 | epot = -15.2234765867597 | etot = -14.6175140348851 +614000 ekin = 0.275407632339994 | erot = 0.333823223653581 | epot = -15.2267448908899 | etot = -14.6175140348963 +615000 ekin = 0.268733725567278 | erot = 0.344345386321387 | epot = -15.2305931467927 | etot = -14.617514034904 +616000 ekin = 0.263034181136557 | erot = 0.35434787992739 | epot = -15.2348960959719 | etot = -14.6175140349079 +617000 ekin = 0.258483071857821 | erot = 0.363590372787447 | epot = -15.2395874795532 | etot = -14.6175140349079 +618000 ekin = 0.255273496413574 | erot = 0.371871254538827 | epot = -15.2446587858571 | etot = -14.6175140349047 +619000 ekin = 0.253608004174632 | erot = 0.37902692128715 | epot = -15.2501489603613 | etot = -14.6175140348995 +620000 ekin = 0.253683881421992 | erot = 0.384927934513618 | epot = -15.2561258508295 | etot = -14.6175140348939 +621000 ekin = 0.255674023709804 | erot = 0.389473226071993 | epot = -15.2626612846714 | etot = -14.6175140348896 +622000 ekin = 0.25970485336757 | erot = 0.392583779639758 | epot = -15.2698026678959 | etot = -14.6175140348885 +623000 ekin = 0.265833429999403 | erot = 0.394197274405735 | epot = -15.2775447392974 | etot = -14.6175140348923 +624000 ekin = 0.274026439188228 | erot = 0.394265031624551 | epot = -15.2858055057147 | etot = -14.6175140349019 +625000 ekin = 0.284144015738384 | erot = 0.392752285176118 | epot = -15.2944103358322 | etot = -14.6175140349177 +626000 ekin = 0.295931256226139 | erot = 0.389642344380343 | epot = -15.3030876355457 | etot = -14.6175140349392 +627000 ekin = 0.309019727829663 | erot = 0.38494467650416 | epot = -15.3114784392987 | etot = -14.6175140349649 +628000 ekin = 0.322940275279064 | erot = 0.378706350959343 | epot = -15.3191606612307 | etot = -14.6175140349923 +629000 ekin = 0.337147043698277 | erot = 0.37102569897414 | epot = -15.3256867776908 | etot = -14.6175140350184 +630000 ekin = 0.351051052994981 | erot = 0.362066500826367 | epot = -15.3306315888613 | etot = -14.6175140350399 +631000 ekin = 0.364060148819096 | erot = 0.352070586245494 | epot = -15.333644770118 | etot = -14.6175140350534 +632000 ekin = 0.375621025661737 | erot = 0.341366514680777 | epot = -15.3345015753988 | etot = -14.6175140350563 +633000 ekin = 0.385258541224816 | erot = 0.33037209230534 | epot = -15.3331446685769 | etot = -14.6175140350467 +634000 ekin = 0.392607865616762 | erot = 0.31958895649352 | epot = -15.3297108571345 | etot = -14.6175140350242 +635000 ekin = 0.39743609727868 | erot = 0.309588318033271 | epot = -15.3245384503017 | etot = -14.6175140349897 +636000 ekin = 0.399651602685353 | erot = 0.30098809437835 | epot = -15.318153732009 | etot = -14.6175140349453 +637000 ekin = 0.399301141333129 | erot = 0.294422893568983 | epot = -15.3112380697961 | etot = -14.617514034894 +638000 ekin = 0.396556439147407 | erot = 0.290509369489655 | epot = -15.3045798434767 | etot = -14.6175140348397 +639000 ekin = 0.391692975513997 | erot = 0.289810143797434 | epot = -15.2990171540975 | etot = -14.617514034786 +640000 ekin = 0.385064212934161 | erot = 0.292799653113688 | epot = -15.2953779007847 | etot = -14.6175140347369 +641000 ekin = 0.377074355551302 | erot = 0.299834934663062 | epot = -15.2944233249094 | etot = -14.6175140346951 +642000 ekin = 0.368152133961515 | erot = 0.311133625026309 | epot = -15.2967997936509 | etot = -14.6175140346631 +643000 ekin = 0.358727298275111 | erot = 0.326760494743868 | epot = -15.3030018276614 | etot = -14.6175140346424 +644000 ekin = 0.349210670243499 | erot = 0.346622862554325 | epot = -15.3133475674317 | etot = -14.6175140346339 +645000 ekin = 0.339977915474886 | erot = 0.370474376280189 | epot = -15.3279663263927 | etot = -14.6175140346376 +646000 ekin = 0.331356734049287 | erot = 0.397926004729598 | epot = -15.3467967734319 | etot = -14.617514034653 +647000 ekin = 0.323616951062021 | erot = 0.428462692622343 | epot = -15.3695936783637 | etot = -14.6175140346794 +648000 ekin = 0.316962984679749 | erot = 0.461463981264525 | epot = -15.3959410006599 | etot = -14.6175140347156 +649000 ekin = 0.311528303721769 | erot = 0.496226945506609 | epot = -15.4252692839889 | etot = -14.6175140347605 +650000 ekin = 0.307371814502051 | erot = 0.53199011331203 | epot = -15.4568759626267 | etot = -14.6175140348127 +651000 ekin = 0.304476169211528 | erot = 0.567957247023637 | epot = -15.4899474511057 | etot = -14.6175140348705 +652000 ekin = 0.302748327843063 | erot = 0.603320352539344 | epot = -15.523582715315 | etot = -14.6175140349325 +653000 ekin = 0.302022769689561 | erot = 0.637281675063983 | epot = -15.5568184797505 | etot = -14.617514034997 +654000 ekin = 0.302067723594154 | erot = 0.669074745116258 | epot = -15.5886565037723 | etot = -14.6175140350619 +655000 ekin = 0.302594671774775 | erot = 0.697984728110365 | epot = -15.6180934350103 | etot = -14.6175140351252 +656000 ekin = 0.303271161273661 | erot = 0.723368330432067 | epot = -15.6441535268902 | etot = -14.6175140351845 +657000 ekin = 0.303736663270792 | erot = 0.744673311812443 | epot = -15.6659240103206 | etot = -14.6175140352373 +658000 ekin = 0.303620889262384 | erot = 0.761457272710392 | epot = -15.6825921972542 | etot = -14.6175140352814 +659000 ekin = 0.302563666907984 | erot = 0.773404945481054 | epot = -15.6934826477032 | etot = -14.6175140353142 +660000 ekin = 0.300235395695091 | erot = 0.780343280385843 | epot = -15.698092711415 | etot = -14.6175140353341 +661000 ekin = 0.296355710531902 | erot = 0.782250083093143 | epot = -15.6961198289647 | etot = -14.6175140353397 +662000 ekin = 0.290710478297184 | erot = 0.779257959177687 | epot = -15.6874824728051 | etot = -14.6175140353302 +663000 ekin = 0.283165147463639 | erot = 0.77165065199169 | epot = -15.6723298347614 | etot = -14.6175140353061 +664000 ekin = 0.273673427176448 | erot = 0.759850562455872 | epot = -15.6510380249006 | etot = -14.6175140352683 +665000 ekin = 0.262280913452385 | erot = 0.744397727319057 | epot = -15.6241926759903 | etot = -14.6175140352189 +666000 ekin = 0.249123647022483 | erot = 0.7259212317447 | epot = -15.5925589139278 | etot = -14.6175140351606 +667000 ekin = 0.234422061210147 | erot = 0.705104954965032 | epot = -15.5570410512716 | etot = -14.6175140350964 +668000 ekin = 0.218471158369324 | erot = 0.682650243124776 | epot = -15.5186354365237 | etot = -14.6175140350296 +669000 ekin = 0.201627981911843 | erot = 0.659238455806553 | epot = -15.4783804726815 | etot = -14.6175140349632 +670000 ekin = 0.184297501939065 | erot = 0.635496303880898 | epot = -15.43730784072 | etot = -14.6175140349001 +671000 ekin = 0.166917915805004 | erot = 0.611966525748027 | epot = -15.3963984763956 | etot = -14.6175140348426 +672000 ekin = 0.149946120674196 | erot = 0.589085832361493 | epot = -15.3565459878282 | etot = -14.6175140347926 +673000 ekin = 0.133843801904582 | erot = 0.567171306812613 | epot = -15.318529143468 | etot = -14.6175140347508 +674000 ekin = 0.119064262674576 | erot = 0.546415679820867 | epot = -15.2829939772136 | etot = -14.6175140347181 +675000 ekin = 0.106039855017085 | erot = 0.526891195482506 | epot = -15.250445085194 | etot = -14.6175140346944 +676000 ekin = 0.0951697078773878 | erot = 0.508561175678473 | epot = -15.2212449182352 | etot = -14.6175140346793 +677000 ekin = 0.086807451986192 | erot = 0.491297978909966 | epot = -15.1956194655683 | etot = -14.6175140346722 +678000 ekin = 0.0812485969712828 | erot = 0.474905301099178 | epot = -15.1736679327427 | etot = -14.6175140346722 +679000 ekin = 0.0787177619800211 | erot = 0.459143233464763 | epot = -15.1553750301234 | etot = -14.6175140346787 +680000 ekin = 0.0793562024648552 | erot = 0.443753980649329 | epot = -15.140624217805 | etot = -14.6175140346908 +681000 ekin = 0.0832104900789999 | erot = 0.428486254341784 | epot = -15.1292107791285 | etot = -14.6175140347077 +682000 ekin = 0.0902236865225188 | erot = 0.413116880933304 | epot = -15.1208546021847 | etot = -14.6175140347289 +683000 ekin = 0.100230543462408 | erot = 0.397468585264377 | epot = -15.11521316348 | etot = -14.6175140347533 +684000 ekin = 0.112958164258869 | erot = 0.381423459018597 | epot = -15.1118956580574 | etot = -14.6175140347799 +685000 ekin = 0.128033094046148 | erot = 0.364932120277307 | epot = -15.1104792491311 | etot = -14.6175140348076 +686000 ekin = 0.144995008361601 | erot = 0.348018922992647 | epot = -15.1105279661894 | etot = -14.6175140348351 +687000 ekin = 0.163316207854767 | erot = 0.330783730221022 | epot = -15.1116139729365 | etot = -14.6175140348607 +688000 ekin = 0.182425234215551 | erot = 0.313400732953855 | epot = -15.1133400020525 | etot = -14.6175140348831 +689000 ekin = 0.201732335852577 | erot = 0.296114640201443 | epot = -15.1153610109551 | etot = -14.6175140349011 +690000 ekin = 0.220654383891154 | erot = 0.279234374240434 | epot = -15.1174027930453 | etot = -14.6175140349137 +691000 ekin = 0.23863718992453 | erot = 0.263124260136862 | epot = -15.1192754849819 | etot = -14.6175140349205 +692000 ekin = 0.255173895596428 | erot = 0.248192653897472 | epot = -15.1208805844156 | etot = -14.6175140349217 +693000 ekin = 0.269818995118043 | erot = 0.234878024009109 | epot = -15.1222110540446 | etot = -14.6175140349175 +694000 ekin = 0.282198402189113 | erot = 0.223632668706427 | epot = -15.1233451058044 | etot = -14.6175140349089 +695000 ekin = 0.292016609393231 | erot = 0.214904477348993 | epot = -15.124435121639 | etot = -14.6175140348968 +696000 ekin = 0.299062308191112 | erot = 0.209117382947945 | epot = -15.1256937260212 | etot = -14.6175140348821 +697000 ekin = 0.30321380997214 | erot = 0.206651361568493 | epot = -15.1273792064064 | etot = -14.6175140348658 +698000 ekin = 0.30444525619219 | erot = 0.207822979229873 | epot = -15.1297822702705 | etot = -14.6175140348484 +699000 ekin = 0.302833983904948 | erot = 0.212867544425277 | epot = -15.1332155631607 | etot = -14.6175140348305 +700000 ekin = 0.29856859634332 | erot = 0.221923881123336 | epot = -15.1380065122785 | etot = -14.6175140348118 +701000 ekin = 0.291956369738242 | erot = 0.235022588976831 | epot = -15.1444929935074 | etot = -14.6175140347924 +702000 ekin = 0.283427734153835 | erot = 0.252078414121472 | epot = -15.153020183048 | etot = -14.6175140347727 +703000 ekin = 0.273534855576746 | erot = 0.272887068861365 | epot = -15.1639359591909 | etot = -14.6175140347528 +704000 ekin = 0.262941046164233 | erot = 0.297126498876432 | epot = -15.1775815797744 | etot = -14.6175140347337 +705000 ekin = 0.252398060444365 | erot = 0.324362359960393 | epot = -15.194274455122 | etot = -14.6175140347173 +706000 ekin = 0.242709489752073 | erot = 0.354057349893491 | epot = -15.2142808743513 | etot = -14.6175140347058 +707000 ekin = 0.234680465258637 | erot = 0.385584073394242 | epot = -15.2377785733552 | etot = -14.6175140347023 +708000 ekin = 0.229056562326157 | erot = 0.418241319394871 | epot = -15.264811916431 | etot = -14.61751403471 +709000 ekin = 0.226457657533258 | erot = 0.451273895783649 | epot = -15.2952455880485 | etot = -14.6175140347316 +710000 ekin = 0.227314828595311 | erot = 0.483896330830945 | epot = -15.3287251941949 | etot = -14.6175140347687 +711000 ekin = 0.231819479497128 | erot = 0.515320742171203 | epot = -15.3646542564898 | etot = -14.6175140348215 +712000 ekin = 0.239893150548963 | erot = 0.544788749312711 | epot = -15.4021959347498 | etot = -14.6175140348881 +713000 ekin = 0.251183758823288 | erot = 0.571606341188824 | epot = -15.4403041349766 | etot = -14.6175140349645 +714000 ekin = 0.265090036185525 | erot = 0.595179886372787 | epot = -15.4777839576035 | etot = -14.6175140350452 +715000 ekin = 0.280811306968559 | erot = 0.615050345044272 | epot = -15.5133756871366 | etot = -14.6175140351238 +716000 ekin = 0.297415784950407 | erot = 0.630922165703626 | epot = -15.5458519858478 | etot = -14.6175140351937 +717000 ekin = 0.313918116237917 | erot = 0.642683345316706 | epot = -15.5741154968041 | etot = -14.6175140352494 +718000 ekin = 0.329356373327112 | erot = 0.650413757300199 | epot = -15.597284165914 | etot = -14.6175140352867 +719000 ekin = 0.342860093484457 | erot = 0.654380316354483 | epot = -15.6147544451421 | etot = -14.6175140353032 +720000 ekin = 0.353703497403049 | erot = 0.655019233384572 | epot = -15.6262367660863 | etot = -14.6175140352987 +721000 ekin = 0.361340844905849 | erot = 0.652906431496321 | epot = -15.6317613116767 | etot = -14.6175140352745 +722000 ekin = 0.365423978941575 | erot = 0.648719378780931 | epot = -15.6316573929561 | etot = -14.6175140352336 +723000 ekin = 0.365803989072306 | erot = 0.643193727890481 | epot = -15.6265117521426 | etot = -14.6175140351798 +724000 ekin = 0.362520178745313 | erot = 0.637078359573022 | epot = -15.6171125734355 | etot = -14.6175140351172 +725000 ekin = 0.355779938480366 | erot = 0.631092082280502 | epot = -15.604386055811 | etot = -14.6175140350501 +726000 ekin = 0.345932952941823 | erot = 0.625884613514235 | epot = -15.5893316014386 | etot = -14.6175140349825 +727000 ekin = 0.333442641405672 | erot = 0.622003743386422 | epot = -15.5729604197101 | etot = -14.617514034918 +728000 ekin = 0.318857050497248 | erot = 0.619869891937897 | epot = -15.5562409772948 | etot = -14.6175140348596 +729000 ekin = 0.302780724957378 | erot = 0.619758691690217 | epot = -15.5400534514572 | etot = -14.6175140348096 +730000 ekin = 0.285848455041315 | erot = 0.621791770570811 | epot = -15.5251542603814 | etot = -14.6175140347693 +731000 ekin = 0.268701272205162 | erot = 0.625935552811657 | epot = -15.5121508597566 | etot = -14.6175140347398 +732000 ekin = 0.251964649664151 | erot = 0.632007594592174 | epot = -15.5014862789777 | etot = -14.6175140347214 +733000 ekin = 0.236228569496788 | erot = 0.639689689353094 | epot = -15.4934322935639 | etot = -14.617514034714 +734000 ekin = 0.222028960746823 | erot = 0.648546698715163 | epot = -15.4880896941794 | etot = -14.6175140347174 +735000 ekin = 0.209830023527925 | erot = 0.658049804517654 | epot = -15.4853938627761 | etot = -14.6175140347305 +736000 ekin = 0.200007166761159 | erot = 0.667602683399479 | epot = -15.4851238849135 | etot = -14.6175140347528 +737000 ekin = 0.192830719625055 | erot = 0.676569044421098 | epot = -15.4869137988298 | etot = -14.6175140347837 +738000 ekin = 0.188451200585547 | erot = 0.684300102137718 | epot = -15.4902653375453 | etot = -14.6175140348221 +739000 ekin = 0.186887639936592 | erot = 0.690160900651566 | epot = -15.4945625754552 | etot = -14.617514034867 +740000 ekin = 0.188021068410451 | erot = 0.693554915034906 | epot = -15.4990900183625 | etot = -14.6175140349172 +741000 ekin = 0.191595568995028 | erot = 0.693946922730537 | epot = -15.5030565266959 | etot = -14.6175140349703 +742000 ekin = 0.197228843628196 | erot = 0.690884208638673 | epot = -15.5056270872912 | etot = -14.6175140350243 +743000 ekin = 0.20443350363757 | erot = 0.684016821527744 | epot = -15.5059643602408 | etot = -14.6175140350755 +744000 ekin = 0.212648433381533 | erot = 0.673116668202852 | epot = -15.5032791367049 | etot = -14.6175140351205 +745000 ekin = 0.221277722248148 | erot = 0.658094727365387 | epot = -15.496886484769 | etot = -14.6175140351555 +746000 ekin = 0.229733012317517 | erot = 0.639014583781424 | epot = -15.4862616312763 | etot = -14.6175140351774 +747000 ekin = 0.2374740441444 | erot = 0.61610009667291 | epot = -15.4710881760011 | etot = -14.6175140351838 +748000 ekin = 0.244042266762953 | erot = 0.5897348727874 | epot = -15.4512911747243 | etot = -14.617514035174 +749000 ekin = 0.249083597953252 | erot = 0.56045151840338 | epot = -15.4270491515053 | etot = -14.6175140351487 +750000 ekin = 0.252358330147216 | erot = 0.528910066811307 | epot = -15.3987824320685 | etot = -14.61751403511 +751000 ekin = 0.253738423481735 | erot = 0.495866496254582 | epot = -15.3671189547979 | etot = -14.6175140350616 +752000 ekin = 0.253194394015788 | erot = 0.462133785333153 | epot = -15.3328422143563 | etot = -14.6175140350074 +753000 ekin = 0.250775308155868 | erot = 0.428539072350445 | epot = -15.2968284154581 | etot = -14.6175140349518 +754000 ekin = 0.246585878547032 | erot = 0.395880964578706 | epot = -15.2599808780244 | etot = -14.6175140348987 +755000 ekin = 0.240764398113293 | erot = 0.364890850085532 | epot = -15.2231692830501 | etot = -14.6175140348513 +756000 ekin = 0.23346447104344 | erot = 0.33620133003045 | epot = -15.1871798358857 | etot = -14.6175140348118 +757000 ekin = 0.224842467158388 | erot = 0.310323830730243 | epot = -15.1526803326699 | etot = -14.6175140347812 +758000 ekin = 0.215051562421428 | erot = 0.287636293952697 | epot = -15.120201891134 | etot = -14.6175140347599 +759000 ekin = 0.204242275876271 | erot = 0.268380753509857 | epot = -15.0901370641325 | etot = -14.6175140347464 +760000 ekin = 0.192568636065474 | erot = 0.252669695562842 | epot = -15.0627523663679 | etot = -14.6175140347396 +761000 ekin = 0.180198520175885 | erot = 0.240499428911651 | epot = -15.0382119838247 | etot = -14.6175140347371 +762000 ekin = 0.167326299029189 | erot = 0.231768292967787 | epot = -15.0166086267339 | etot = -14.6175140347369 +763000 ekin = 0.154185685901956 | erot = 0.226297425416186 | epot = -14.9979971460548 | etot = -14.6175140347367 +764000 ekin = 0.141060632748886 | erot = 0.22385200334864 | epot = -14.9824266708322 | etot = -14.6175140347347 +765000 ekin = 0.128292252296688 | erot = 0.224161332818126 | epot = -14.9699676198447 | etot = -14.6175140347299 +766000 ekin = 0.116280064488099 | erot = 0.226936813023238 | epot = -14.9607309122326 | etot = -14.6175140347212 +767000 ekin = 0.105476340626969 | erot = 0.23188750727037 | epot = -14.9548778826066 | etot = -14.6175140347093 +768000 ekin = 0.096372890945937 | erot = 0.238733641345087 | epot = -14.9526205669852 | etot = -14.6175140346942 +769000 ekin = 0.0894802427431669 | erot = 0.247218655409017 | epot = -14.9542129328294 | etot = -14.6175140346772 +770000 ekin = 0.0852997361093092 | erot = 0.257120353608164 | epot = -14.9599341243773 | etot = -14.6175140346598 +771000 ekin = 0.0842896183570599 | erot = 0.268261228608835 | epot = -14.9700648816096 | etot = -14.6175140346437 +772000 ekin = 0.0868267987477346 | erot = 0.280517313419992 | epot = -14.9848581467989 | etot = -14.6175140346312 +773000 ekin = 0.0931666172480206 | erot = 0.293824162660099 | epot = -15.0045048145328 | etot = -14.6175140346247 +774000 ekin = 0.103403843826671 | erot = 0.308178073397117 | epot = -15.0290959518505 | etot = -14.6175140346267 +775000 ekin = 0.117439110045757 | erot = 0.323630675217794 | epot = -15.0585838199034 | etot = -14.6175140346399 +776000 ekin = 0.134955835365974 | erot = 0.340275613675452 | epot = -15.0927454837074 | etot = -14.617514034666 +777000 ekin = 0.155413263635979 | erot = 0.358227842745911 | epot = -15.131155141088 | etot = -14.6175140347061 +778000 ekin = 0.178060391221893 | erot = 0.377596905889502 | epot = -15.1731713318714 | etot = -14.61751403476 +779000 ekin = 0.201973803865647 | erot = 0.398457850158065 | epot = -15.2179456888489 | etot = -14.6175140348252 +780000 ekin = 0.226119091214274 | erot = 0.420824480238275 | epot = -15.2644576063504 | etot = -14.6175140348978 +781000 ekin = 0.249431156626622 | erot = 0.444629585314847 | epot = -15.3115747769139 | etot = -14.6175140349725 +782000 ekin = 0.270904470269639 | erot = 0.469715692367583 | epot = -15.3581341976801 | etot = -14.6175140350429 +783000 ekin = 0.289681273783551 | erot = 0.495837747641305 | epot = -15.4030330565279 | etot = -14.617514035103 +784000 ekin = 0.305125009986927 | erot = 0.522676532161923 | epot = -15.445315577297 | etot = -14.6175140351482 +785000 ekin = 0.316868262923434 | erot = 0.549859353707342 | epot = -15.4842416518064 | etot = -14.6175140351756 +786000 ekin = 0.324828845889255 | erot = 0.576983310023016 | epot = -15.5193261910972 | etot = -14.6175140351849 +787000 ekin = 0.32919323387939 | erot = 0.603636505801527 | epot = -15.550343774859 | etot = -14.617514035178 +788000 ekin = 0.330371864852151 | erot = 0.629413875563716 | epot = -15.5772997755747 | etot = -14.6175140351588 +789000 ekin = 0.328934711355495 | erot = 0.653926193132344 | epot = -15.6003749396201 | etot = -14.6175140351322 +790000 ekin = 0.32553731947378 | erot = 0.676802790006292 | epot = -15.6198541445837 | etot = -14.6175140351036 +791000 ekin = 0.320847267933459 | erot = 0.697689943211487 | epot = -15.6360512462227 | etot = -14.6175140350777 +792000 ekin = 0.315479253539392 | erot = 0.716247584423973 | epot = -15.6492408730215 | etot = -14.6175140350582 +793000 ekin = 0.309944490982107 | erot = 0.732146955922051 | epot = -15.6596054819516 | etot = -14.6175140350474 +794000 ekin = 0.304617480925239 | erot = 0.745071299199412 | epot = -15.6672028151708 | etot = -14.6175140350461 +795000 ekin = 0.299720880976423 | erot = 0.754720862084592 | epot = -15.6719557781148 | etot = -14.6175140350538 +796000 ekin = 0.295327396180162 | erot = 0.760822658787278 | epot = -15.6736640900359 | etot = -14.6175140350685 +797000 ekin = 0.291376296851675 | erot = 0.763144639344914 | epot = -15.6720349712838 | etot = -14.6175140350872 +798000 ekin = 0.287701294703707 | erot = 0.761513269131401 | epot = -15.6667285989415 | etot = -14.6175140351064 +799000 ekin = 0.284065979572222 | erot = 0.755832991336602 | epot = -15.6574130060307 | etot = -14.6175140351219 +800000 ekin = 0.280202790631652 | erot = 0.746105645863969 | epot = -15.643822471626 | etot = -14.6175140351304 +801000 ekin = 0.275851560112653 | erot = 0.732447665813264 | epot = -15.6258132610543 | etot = -14.6175140351284 +802000 ekin = 0.270794034433592 | erot = 0.715102809072576 | epot = -15.6034108786199 | etot = -14.6175140351138 +803000 ekin = 0.264881442636465 | erot = 0.694448356025832 | epot = -15.5768438337476 | etot = -14.6175140350853 +804000 ekin = 0.258053167891105 | erot = 0.670993199746629 | epot = -15.5465604026808 | etot = -14.6175140350431 +805000 ekin = 0.250345604728483 | erot = 0.645366941436678 | epot = -15.5132265811537 | etot = -14.6175140349885 +806000 ekin = 0.241890533712104 | erot = 0.618299214644422 | epot = -15.4777037832803 | etot = -14.6175140349238 +807000 ekin = 0.232905655207387 | erot = 0.590591287736433 | epot = -15.4410109777962 | etot = -14.6175140348524 +808000 ekin = 0.223678061733381 | erot = 0.563080896688429 | epot = -15.4042729931999 | etot = -14.6175140347781 +809000 ekin = 0.21454303523099 | erot = 0.536602758842029 | epot = -15.3686598287782 | etot = -14.6175140347052 +810000 ekin = 0.205860488313568 | erot = 0.511947500023896 | epot = -15.3353220229752 | etot = -14.6175140346377 +811000 ekin = 0.197991117806005 | erot = 0.489821758278081 | epot = -15.3053269106636 | etot = -14.6175140345795 +812000 ekin = 0.191273941671524 | erot = 0.470812030934271 | epot = -15.2796000071394 | etot = -14.6175140345336 +813000 ekin = 0.186006404369985 | erot = 0.455354451062655 | epot = -15.2588748899354 | etot = -14.6175140345028 +814000 ekin = 0.18242775371236 | erot = 0.443712201374096 | epot = -15.243653989575 | etot = -14.6175140344885 +815000 ekin = 0.18070598633541 | erot = 0.435961774091635 | epot = -15.234181794919 | etot = -14.617514034492 +816000 ekin = 0.180928373605491 | erot = 0.431988814113314 | epot = -15.2304312222317 | etot = -14.6175140345129 +817000 ekin = 0.183095431234183 | erot = 0.431493858263631 | epot = -15.2321033240486 | etot = -14.6175140345508 +818000 ekin = 0.187118173911464 | erot = 0.434007895069526 | epot = -15.2386401035849 | etot = -14.6175140346039 +819000 ekin = 0.192818568053382 | erot = 0.43891728680681 | epot = -15.2492498895299 | etot = -14.6175140346697 +820000 ekin = 0.199933211814771 | erot = 0.445497181488374 | epot = -15.2629444280486 | etot = -14.6175140347454 +821000 ekin = 0.208120374081953 | erot = 0.452952069483821 | epot = -15.2785864783931 | etot = -14.6175140348273 +822000 ekin = 0.216970558498266 | erot = 0.460461605795678 | epot = -15.2949461992054 | etot = -14.6175140349114 +823000 ekin = 0.226020685629111 | erot = 0.467229260922827 | epot = -15.3107639815452 | etot = -14.6175140349933 +824000 ekin = 0.234771793851546 | erot = 0.47253085821668 | epot = -15.3248166871369 | etot = -14.6175140350687 +825000 ekin = 0.242709867661982 | erot = 0.475759712130438 | epot = -15.3359836149259 | etot = -14.6175140351335 +826000 ekin = 0.249329060857897 | erot = 0.476465014357233 | epot = -15.3433081103994 | etot = -14.6175140351843 +827000 ekin = 0.254156259485738 | erot = 0.474380409602743 | epot = -15.3460507043067 | etot = -14.6175140352182 +828000 ekin = 0.256775693170762 | erot = 0.46944038334452 | epot = -15.3437301117489 | etot = -14.6175140352336 +829000 ekin = 0.256852201216661 | erot = 0.461783092102077 | epot = -15.3361493285486 | etot = -14.6175140352298 +830000 ekin = 0.254151805816721 | erot = 0.451739467041208 | epot = -15.3234053080651 | etot = -14.6175140352072 +831000 ekin = 0.248558416433736 | erot = 0.439809632306583 | epot = -15.3058820839077 | etot = -14.6175140351674 +832000 ekin = 0.240085737091052 | erot = 0.426628719076076 | epot = -15.2842284912797 | etot = -14.6175140351126 +833000 ekin = 0.228883712687689 | erot = 0.412924890624274 | epot = -15.2593226383577 | etot = -14.6175140350458 +834000 ekin = 0.215239082681844 | erot = 0.399472764056086 | epot = -15.2322258817084 | etot = -14.6175140349705 +835000 ekin = 0.199569787294665 | erot = 0.387045440519586 | epot = -15.2041292627046 | etot = -14.6175140348904 +836000 ekin = 0.182413100763772 | erot = 0.376368114580803 | epot = -15.1762952501539 | etot = -14.6175140348093 +837000 ekin = 0.164407483062706 | erot = 0.36807582593139 | epot = -15.1499973437255 | etot = -14.6175140347314 +838000 ekin = 0.146268295773454 | erot = 0.362677435797712 | epot = -15.1264597662312 | etot = -14.61751403466 +839000 ekin = 0.128757768426402 | erot = 0.360527421580405 | epot = -15.1067992246056 | etot = -14.6175140345988 +840000 ekin = 0.112649960717984 | erot = 0.361806618656283 | epot = -15.091970613925 | etot = -14.6175140345507 +841000 ekin = 0.0986919456677054 | erot = 0.366512603929069 | epot = -15.0827185841153 | etot = -14.6175140345185 +842000 ekin = 0.0875630029234395 | erot = 0.374460003555771 | epot = -15.0795370409833 | etot = -14.6175140345041 +843000 ekin = 0.0798341847686366 | erot = 0.385290606532762 | epot = -15.08263882581 | etot = -14.6175140345086 +844000 ekin = 0.0759310929907395 | erot = 0.3984927697296 | epot = -15.0919378972525 | etot = -14.6175140345322 +845000 ekin = 0.076102961020352 | erot = 0.413429207168617 | epot = -15.107046202763 | etot = -14.617514034574 +846000 ekin = 0.0804010613290235 | erot = 0.429371869322532 | epot = -15.1272869652841 | etot = -14.6175140346325 +847000 ekin = 0.0886689809240873 | erot = 0.445542241998021 | epot = -15.1517252576265 | etot = -14.6175140347044 +848000 ekin = 0.100546421459775 | erot = 0.461155038711605 | epot = -15.179215494957 | etot = -14.6175140347856 +849000 ekin = 0.115486960010826 | erot = 0.475462945351677 | epot = -15.208463940234 | etot = -14.6175140348715 +850000 ekin = 0.132788806695669 | erot = 0.487799837752774 | epot = -15.2381026794056 | etot = -14.6175140349571 +851000 ekin = 0.15163622778631 | erot = 0.49761978557658 | epot = -15.2667700483999 | etot = -14.617514035037 +852000 ekin = 0.171148194576093 | erot = 0.5045292426275 | epot = -15.2931914723102 | etot = -14.6175140351066 +853000 ekin = 0.19043015939564 | erot = 0.508310157461229 | epot = -15.3162543520185 | etot = -14.6175140351617 +854000 ekin = 0.208624756899512 | erot = 0.508932337650922 | epot = -15.3350711297497 | etot = -14.6175140351993 +855000 ekin = 0.224957674812131 | erot = 0.506554231539335 | epot = -15.3490259415692 | etot = -14.6175140352178 +856000 ekin = 0.238775816538934 | erot = 0.501512259960027 | epot = -15.3578021117156 | etot = -14.6175140352166 +857000 ekin = 0.249575992233887 | erot = 0.494299801981668 | epot = -15.3613898294122 | etot = -14.6175140351967 +858000 ekin = 0.257023502073677 | erot = 0.485537766821904 | epot = -15.3600753040553 | etot = -14.6175140351598 +859000 ekin = 0.260960921285557 | erot = 0.47593924761589 | epot = -15.3544142040099 | etot = -14.6175140351084 +860000 ekin = 0.261408037072254 | erot = 0.466270984604724 | epot = -15.3451930567227 | etot = -14.6175140350457 +861000 ekin = 0.258554187538227 | erot = 0.457314264403266 | epot = -15.3333824869164 | etot = -14.6175140349749 +862000 ekin = 0.252744258033032 | erot = 0.449827506886351 | epot = -15.3200857998187 | etot = -14.6175140348993 +863000 ekin = 0.24445941779656 | erot = 0.444512141834286 | epot = -15.3064855944532 | etot = -14.6175140348224 +864000 ekin = 0.234293368840191 | erot = 0.441983030939893 | epot = -15.2937904345275 | etot = -14.6175140347474 +865000 ekin = 0.222924696624028 | erot = 0.442744308395087 | epot = -15.2831830396966 | etot = -14.6175140346775 +866000 ekin = 0.211086026109153 | erot = 0.447169652381141 | epot = -15.275769713106 | etot = -14.6175140346157 +867000 ekin = 0.199530465892741 | erot = 0.455487658924214 | epot = -15.2725321593816 | etot = -14.6175140345647 +868000 ekin = 0.188996288427104 | erot = 0.467771811643747 | epot = -15.2742821345979 | etot = -14.6175140345271 +869000 ekin = 0.180171161859106 | erot = 0.483934855626885 | epot = -15.2816200519912 | etot = -14.6175140345052 +870000 ekin = 0.17365741386822 | erot = 0.503727420429673 | epot = -15.2948988687985 | etot = -14.6175140345006 +871000 ekin = 0.169940429081846 | erot = 0.52674119313203 | epot = -15.3141956567285 | etot = -14.6175140345146 +872000 ekin = 0.169362274178155 | erot = 0.552417088945952 | epot = -15.3392933976716 | etot = -14.6175140345475 +873000 ekin = 0.172102391201285 | erot = 0.580058846014358 | epot = -15.3696752718142 | etot = -14.6175140345986 +874000 ekin = 0.17816700290151 | erot = 0.608852557307893 | epot = -15.4045335948759 | etot = -14.6175140346665 +875000 ekin = 0.187388233890407 | erot = 0.637892396630087 | epot = -15.4427946652692 | etot = -14.6175140347487 +876000 ekin = 0.19943318136702 | erot = 0.666212376945529 | epot = -15.4831595931541 | etot = -14.6175140348415 +877000 ekin = 0.213822249050307 | erot = 0.692823325238237 | epot = -15.5241596092293 | etot = -14.6175140349407 +878000 ekin = 0.229955728385699 | erot = 0.71675421264508 | epot = -15.5642239760723 | etot = -14.6175140350415 +879000 ekin = 0.24714610464469 | erot = 0.737095186135096 | epot = -15.6017553259188 | etot = -14.617514035139 +880000 ekin = 0.264653797001986 | erot = 0.753040153406107 | epot = -15.6352079856364 | etot = -14.6175140352283 +881000 ekin = 0.281723784261025 | erot = 0.763926241591362 | epot = -15.6631640611574 | etot = -14.617514035305 +882000 ekin = 0.297620641606497 | erot = 0.769267373447878 | epot = -15.6844020504201 | etot = -14.6175140353657 +883000 ekin = 0.31165996716591 | erot = 0.768779581882635 | epot = -15.6979535844562 | etot = -14.6175140354077 +884000 ekin = 0.32323477376766 | erot = 0.762396270684418 | epot = -15.7031450798815 | etot = -14.6175140354294 +885000 ekin = 0.331836099624976 | erot = 0.750272396067649 | epot = -15.6996225311232 | etot = -14.6175140354305 +886000 ekin = 0.33706775156376 | erot = 0.73277738526586 | epot = -15.6873591722413 | etot = -14.6175140354116 +887000 ekin = 0.33865564976609 | erot = 0.710477420750346 | epot = -15.6666471058906 | etot = -14.6175140353742 +888000 ekin = 0.336452632420724 | erot = 0.684108417156207 | epot = -15.6380750848973 | etot = -14.6175140353203 +889000 ekin = 0.330439768515565 | erot = 0.654541548240145 | epot = -15.6024953520085 | etot = -14.6175140352528 +890000 ekin = 0.320725208484774 | erot = 0.622743520027188 | epot = -15.5609827636863 | etot = -14.6175140351743 +891000 ekin = 0.30754138620901 | erot = 0.589733936087593 | epot = -15.5147893573847 | etot = -14.6175140350881 +892000 ekin = 0.291240998129824 | erot = 0.55654208039805 | epot = -15.4652971135248 | etot = -14.6175140349969 +893000 ekin = 0.272291667891339 | erot = 0.524165278720875 | epot = -15.413970981516 | etot = -14.6175140349038 +894000 ekin = 0.251268620703469 | erot = 0.493530718297772 | epot = -15.3623133738123 | etot = -14.617514034811 +895000 ekin = 0.228844131843647 | erot = 0.465462234286628 | epot = -15.3118204008517 | etot = -14.6175140347214 +896000 ekin = 0.205772103521931 | erot = 0.44065313730724 | epot = -15.2639392754666 | etot = -14.6175140346374 +897000 ekin = 0.182866017803037 | erot = 0.419645693758354 | epot = -15.2200257461231 | etot = -14.6175140345617 +898000 ekin = 0.160968870008541 | erot = 0.402817425242934 | epot = -15.1813003297485 | etot = -14.617514034497 +899000 ekin = 0.140914625128407 | erot = 0.390374024162942 | epot = -15.1488026837377 | etot = -14.6175140344464 +900000 ekin = 0.123482269337592 | erot = 0.382348451689143 | epot = -15.1233447554393 | etot = -14.6175140344126 +901000 ekin = 0.109345484385137 | erot = 0.3786057375543 | epot = -15.1054652563377 | etot = -14.6175140343982 +902000 ekin = 0.0990229789068443 | erot = 0.378853140166087 | epot = -15.0953901534781 | etot = -14.6175140344052 +903000 ekin = 0.0928360184564003 | erot = 0.382655585825594 | epot = -15.0930056387161 | etot = -14.6175140344341 +904000 ekin = 0.0908801123879861 | erot = 0.389456554773426 | epot = -15.0978507016452 | etot = -14.6175140344838 +905000 ekin = 0.0930167096525759 | erot = 0.398604648849945 | epot = -15.109135393054 | etot = -14.6175140345515 +906000 ekin = 0.0988880708462299 | erot = 0.409385812369135 | epot = -15.1257879178477 | etot = -14.6175140346323 +907000 ekin = 0.107954659147321 | erot = 0.421060528764021 | epot = -15.1465292226317 | etot = -14.6175140347203 +908000 ekin = 0.119550305154264 | erot = 0.432904367174404 | epot = -15.1699687071371 | etot = -14.6175140348085 +909000 ekin = 0.132947118364171 | erot = 0.44424923215812 | epot = -15.1947103854124 | etot = -14.6175140348901 +910000 ekin = 0.147420543333256 | erot = 0.454521879656354 | epot = -15.2194564579492 | etot = -14.6175140349595 +911000 ekin = 0.162305506309105 | erot = 0.463275978359162 | epot = -15.243095519681 | etot = -14.6175140350127 +912000 ekin = 0.177037050912775 | erot = 0.470214361754759 | epot = -15.264765447715 | etot = -14.6175140350475 +913000 ekin = 0.191172462463145 | erot = 0.47519909256641 | epot = -15.2838855900937 | etot = -14.6175140350641 +914000 ekin = 0.204395616840717 | erot = 0.478248345048037 | epot = -15.3001579969529 | etot = -14.6175140350642 +915000 ekin = 0.216507238695372 | erot = 0.479520616572283 | epot = -15.3135418903184 | etot = -14.6175140350507 +916000 ekin = 0.227406352399354 | erot = 0.479288139236181 | epot = -15.324208526663 | etot = -14.6175140350275 +917000 ekin = 0.237068358848421 | erot = 0.47790239272317 | epot = -15.3324847865699 | etot = -14.6175140349983 +918000 ekin = 0.245524170399261 | erot = 0.475755244752224 | epot = -15.3387934501184 | etot = -14.6175140349669 +919000 ekin = 0.252843202023974 | erot = 0.473239468155706 | epot = -15.343596705116 | etot = -14.6175140349363 +920000 ekin = 0.259121284815254 | erot = 0.470712244290015 | epot = -15.3473475640143 | etot = -14.617514034909 +921000 ekin = 0.264473144076574 | erot = 0.468464808092157 | epot = -15.3504519870554 | etot = -14.6175140348867 +922000 ekin = 0.269028180853983 | erot = 0.466700668341734 | epot = -15.3532428840659 | etot = -14.6175140348701 +923000 ekin = 0.272927944745736 | erot = 0.465523908452108 | epot = -15.3559658880573 | etot = -14.6175140348595 +924000 ekin = 0.276323793829006 | erot = 0.464938026324777 | epot = -15.3587758550082 | etot = -14.6175140348544 +925000 ekin = 0.279373649323259 | erot = 0.46485472138072 | epot = -15.361742405558 | etot = -14.617514034854 +926000 ekin = 0.282237300897742 | erot = 0.465111106681027 | epot = -15.3648624424358 | etot = -14.617514034857 +927000 ekin = 0.285070250341507 | erot = 0.465493135293317 | epot = -15.368077420497 | etot = -14.6175140348622 +928000 ekin = 0.288016501944515 | erot = 0.465762600718122 | epot = -15.3712931375312 | etot = -14.6175140348685 +929000 ekin = 0.291201026098165 | erot = 0.465684740678949 | epot = -15.3743998016517 | etot = -14.6175140348746 +930000 ekin = 0.294722459178849 | erot = 0.465054261989122 | epot = -15.3772907560474 | etot = -14.6175140348794 +931000 ekin = 0.298646764015069 | erot = 0.463717248452617 | epot = -15.37987804735 | etot = -14.6175140348823 +932000 ekin = 0.303002304639518 | erot = 0.461587311532337 | epot = -15.3821036510548 | etot = -14.6175140348829 +933000 ekin = 0.307776651094703 | erot = 0.458654945590446 | epot = -15.3839456315665 | etot = -14.6175140348813 +934000 ekin = 0.312915338271949 | erot = 0.454989722654232 | epot = -15.3854190958038 | etot = -14.6175140348776 +935000 ekin = 0.318322768321298 | erot = 0.450735625549576 | epot = -15.3865724287433 | etot = -14.6175140348724 +936000 ekin = 0.323865441581078 | erot = 0.4461003856938 | epot = -15.3874798621412 | etot = -14.6175140348663 +937000 ekin = 0.329377658420705 | erot = 0.441340069469478 | epot = -15.3882317627502 | etot = -14.61751403486 +938000 ekin = 0.334669609401419 | erot = 0.43674015463711 | epot = -15.3889237988925 | etot = -14.617514034854 +939000 ekin = 0.339538182698638 | erot = 0.43259572362611 | epot = -15.3896479411737 | etot = -14.6175140348489 +940000 ekin = 0.343779460435286 | erot = 0.429190561371808 | epot = -15.3904840566521 | etot = -14.617514034845 +941000 ekin = 0.347202304174038 | erot = 0.426777065358206 | epot = -15.3914934043749 | etot = -14.6175140348427 +942000 ekin = 0.349642062607923 | erot = 0.425558062624919 | epot = -15.3927141600748 | etot = -14.617514034842 +943000 ekin = 0.350973206935894 | erot = 0.425671371650785 | epot = -15.3941586134297 | etot = -14.617514034843 +944000 ekin = 0.351119786154916 | erot = 0.427178062459289 | epot = -15.3958118834598 | etot = -14.6175140348456 +945000 ekin = 0.350062816508881 | erot = 0.430055404933721 | epot = -15.3976322562924 | etot = -14.6175140348498 +946000 ekin = 0.347844068536826 | erot = 0.43419544779 | epot = -15.399553551182 | etot = -14.6175140348552 +947000 ekin = 0.344566017441624 | erot = 0.439410327984555 | epot = -15.4014903802875 | etot = -14.6175140348614 +948000 ekin = 0.340388212507466 | erot = 0.445444378277408 | epot = -15.4033466256523 | etot = -14.6175140348674 +949000 ekin = 0.335520427168573 | erot = 0.451992965714934 | epot = -15.405027427756 | etot = -14.6175140348725 +950000 ekin = 0.330213181196302 | erot = 0.458727107975965 | epot = -15.4064543240477 | etot = -14.6175140348755 +951000 ekin = 0.32474581655651 | erot = 0.465321341197607 | epot = -15.4075811926297 | etot = -14.6175140348755 +952000 ekin = 0.319412679962215 | erot = 0.471482169177628 | epot = -15.4084088840117 | etot = -14.6175140348718 +953000 ekin = 0.314508037100187 | erot = 0.476974139327395 | epot = -15.4089962112918 | etot = -14.6175140348642 +954000 ekin = 0.310309685024338 | erot = 0.48163943141798 | epot = -15.4094631512954 | etot = -14.6175140348531 +955000 ekin = 0.307061947765172 | erot = 0.485408201613879 | epot = -15.4099841842186 | etot = -14.6175140348396 +956000 ekin = 0.304958921288845 | erot = 0.488297803841432 | epot = -15.4107707599557 | etot = -14.6175140348254 +957000 ekin = 0.304129209168544 | erot = 0.490400499132465 | epot = -15.412043743114 | etot = -14.617514034813 +958000 ekin = 0.30462371461979 | erot = 0.491860923621405 | epot = -15.4139986730458 | etot = -14.6175140348046 +959000 ekin = 0.306408207891338 | erot = 0.492846142548894 | epot = -15.4167683852429 | etot = -14.6175140348027 +960000 ekin = 0.309362278812989 | erot = 0.493512316198202 | epot = -15.4203886298201 | etot = -14.6175140348089 +961000 ekin = 0.313285873784586 | erot = 0.493972653387296 | epot = -15.4247725619958 | etot = -14.6175140348239 +962000 ekin = 0.31791392478401 | erot = 0.494271324762717 | epot = -15.429699284394 | etot = -14.6175140348473 +963000 ekin = 0.322938673952677 | erot = 0.49436733773729 | epot = -15.4348200465674 | etot = -14.6175140348775 +964000 ekin = 0.328038281530642 | erot = 0.494131108238433 | epot = -15.4396834246807 | etot = -14.6175140349116 +965000 ekin = 0.332909295682699 | erot = 0.493354750676295 | epot = -15.4437780813051 | etot = -14.6175140349461 +966000 ekin = 0.33729968976251 | erot = 0.491775167781853 | epot = -15.4465888925212 | etot = -14.6175140349768 +967000 ekin = 0.341038574326505 | erot = 0.489107134739274 | epot = -15.4476597440655 | etot = -14.6175140349998 +968000 ekin = 0.344058508086205 | erot = 0.485082040988283 | epot = -15.446654584086 | etot = -14.6175140350116 +969000 ekin = 0.346406687226292 | erot = 0.479487053292162 | epot = -15.4434077755287 | etot = -14.6175140350102 +970000 ekin = 0.348242259950603 | erot = 0.472199376075359 | epot = -15.4379556710211 | etot = -14.6175140349951 +971000 ekin = 0.34981857790832 | erot = 0.46321104020783 | epot = -15.4305436530838 | etot = -14.6175140349677 +972000 ekin = 0.351451221504254 | erot = 0.452641107454446 | epot = -15.4216063638894 | etot = -14.6175140349307 +973000 ekin = 0.353474851841754 | erot = 0.440734047140903 | epot = -15.4117229338711 | etot = -14.6175140348884 +974000 ekin = 0.356193968986792 | erot = 0.42784496232361 | epot = -15.4015529661561 | etot = -14.6175140348457 +975000 ekin = 0.359834072253393 | erot = 0.414413971021987 | epot = -15.3917620780828 | etot = -14.6175140348074 +976000 ekin = 0.364500158165202 | erot = 0.400933139115816 | epot = -15.3829473320587 | etot = -14.6175140347777 +977000 ekin = 0.370148756532482 | erot = 0.387909813697021 | epot = -15.3755726049891 | etot = -14.6175140347596 +978000 ekin = 0.376577842833215 | erot = 0.375830059083025 | epot = -15.3699219366707 | etot = -14.6175140347545 +979000 ekin = 0.38343628910019 | erot = 0.365125297246779 | epot = -15.3660756211092 | etot = -14.6175140347622 +980000 ekin = 0.390251542223294 | erot = 0.35614439745949 | epot = -15.3639099744643 | etot = -14.6175140347816 +981000 ekin = 0.396471539317082 | erot = 0.349132547197932 | epot = -15.3631181213249 | etot = -14.6175140348099 +982000 ekin = 0.401514997593021 | erot = 0.344217435799683 | epot = -15.3632464682369 | etot = -14.6175140348442 +983000 ekin = 0.40482345877132 | erot = 0.341402706416172 | epot = -15.3637402000689 | etot = -14.6175140348814 +984000 ekin = 0.40590886668651 | erot = 0.340568324597744 | epot = -15.3639912262029 | etot = -14.6175140349187 +985000 ekin = 0.40439180306127 | erot = 0.341477444720355 | epot = -15.3633832827352 | etot = -14.6175140349536 +986000 ekin = 0.400027422801574 | erot = 0.34378943446128 | epot = -15.361330892247 | etot = -14.6175140349842 +987000 ekin = 0.392718180745197 | erot = 0.347078806738211 | epot = -15.3573110224925 | etot = -14.617514035009 +988000 ekin = 0.38251423921461 | erot = 0.35085976914659 | epot = -15.3508880433883 | etot = -14.6175140350271 +989000 ekin = 0.369603726654237 | erot = 0.354615837188711 | epot = -15.3417335988804 | etot = -14.6175140350375 +990000 ekin = 0.354295674461643 | erot = 0.357833454087933 | epot = -15.3296431635888 | etot = -14.6175140350392 +991000 ekin = 0.336998529351755 | erot = 0.360037895318059 | epot = -15.3145504597015 | etot = -14.6175140350317 +992000 ekin = 0.318196763890793 | erot = 0.360829065190808 | epot = -15.2965398640958 | etot = -14.6175140350142 +993000 ekin = 0.298427479538949 | erot = 0.359914303089432 | epot = -15.275855817615 | etot = -14.6175140349866 +994000 ekin = 0.278258203580391 | erot = 0.357135170965373 | epot = -15.2529074094948 | etot = -14.617514034949 +995000 ekin = 0.258266471895345 | erot = 0.352485480212691 | epot = -15.2282659870101 | etot = -14.617514034902 +996000 ekin = 0.239021351636229 | erot = 0.346118523027927 | epot = -15.2026539095112 | etot = -14.617514034847 +997000 ekin = 0.221066818081289 | erot = 0.338342492442898 | epot = -15.1769233453102 | etot = -14.617514034786 +998000 ekin = 0.204906835818331 | erot = 0.329604233509071 | epot = -15.1520251040488 | etot = -14.6175140347214 +999000 ekin = 0.190992053959174 | erot = 0.320462575795008 | epot = -15.1289686644104 | etot = -14.6175140346562 +1000000 ekin = 0.179708146665509 | erot = 0.311553394429298 | epot = -15.1087755756885 | etot = -14.6175140345937 + 1000000 0.013311715 -1.5443684 0.033490821 -1.4929067 -3.7544839e-05 +Loop time of 20.4903 on 1 procs for 1000000 steps with 10 atoms + +Performance: 42166.322 tau/day, 48803.614 timesteps/s +98.3% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 16.542 | 16.542 | 16.542 | 0.0 | 80.73 +Bond | 0.62224 | 0.62224 | 0.62224 | 0.0 | 3.04 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.21974 | 0.21974 | 0.21974 | 0.0 | 1.07 +Output | 7e-06 | 7e-06 | 7e-06 | 0.0 | 0.00 +Modify | 2.7798 | 2.7798 | 2.7798 | 0.0 | 13.57 +Other | | 0.3269 | | | 1.60 + +Nlocal: 10 ave 10 max 10 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 45 ave 45 max 45 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 45 +Ave neighs/atom = 4.5 +Ave special neighs/atom = 3.6 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:20 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.4 b/examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.4 new file mode 100644 index 0000000000..9856a9c95b --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex1/log.18Jun19.duplex1.g++.4 @@ -0,0 +1,1172 @@ +LAMMPS (18 Jun 2019) +variable number equal 1 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex1 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 10 atoms + reading velocities ... + 10 velocities + 10 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 8 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 2 = max # of 1-4 neighbors + 4 = max # of special neighbors + special bonds CPU = 0.000196 secs + read_data CPU = 0.003266 secs + +set atom * mass 3.1575 + 10 settings made for mass + +group all type 1 4 +10 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna2/fene +bond_coeff * 2.0 0.25 0.7564 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh +pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna2/stk seqav ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqav 0.1 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 +pair_coeff * * oxdna2/dh 0.1 1.0 0.815 + +# NVE ensemble +fix 1 all nve/dot +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.6274 + ghost atom cutoff = 2.6274 + binsize = 1.3137, bins = 31 31 31 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.652 | 7.834 | 8.016 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.4712768 0.009525411 -1.4617514 4.663076e-06 +1000 ekin = 0.00113086229080478 | erot = 0.00431010160406708 | epot = -14.6229549982368 | etot = -14.617514034342 +2000 ekin = 0.00448533224342286 | erot = 0.0171407706505013 | epot = -14.6391401372615 | etot = -14.6175140343675 +3000 ekin = 0.0099503525964896 | erot = 0.0381961780846439 | epot = -14.6656605650904 | etot = -14.6175140344093 +4000 ekin = 0.0173418024861991 | erot = 0.0669935184860482 | epot = -14.7018493554381 | etot = -14.6175140344659 +5000 ekin = 0.0264109356285965 | erot = 0.102878288094483 | epot = -14.7468032582586 | etot = -14.6175140345355 +6000 ekin = 0.0368533113591267 | erot = 0.14504542056981 | epot = -14.7994127665446 | etot = -14.6175140346157 +7000 ekin = 0.0483200640564583 | erot = 0.192565862515414 | epot = -14.8583999612755 | etot = -14.6175140347036 +8000 ekin = 0.0604312317605635 | erot = 0.244417870131371 | epot = -14.9223631366881 | etot = -14.6175140347962 +9000 ekin = 0.072790711967127 | erot = 0.299521949931656 | epot = -14.9898266967887 | etot = -14.6175140348899 +10000 ekin = 0.0850022498874609 | erot = 0.356777997217668 | epot = -15.0592942820866 | etot = -14.6175140349815 +11000 ekin = 0.0966857134040954 | erot = 0.415102860829322 | epot = -15.1293026093009 | etot = -14.6175140350675 +12000 ekin = 0.107492790688356 | erot = 0.473466334177699 | epot = -15.1984731600111 | etot = -14.617514035145 +13000 ekin = 0.117121180381612 | erot = 0.530923485009329 | epot = -15.2655587006024 | etot = -14.6175140352115 +14000 ekin = 0.125326348459051 | erot = 0.586641324447251 | epot = -15.3294817081714 | etot = -14.6175140352651 +15000 ekin = 0.131930017119328 | erot = 0.63991810423422 | epot = -15.3893621566583 | etot = -14.6175140353048 +16000 ekin = 0.136824741331405 | erot = 0.690194029500566 | epot = -15.4445328061626 | etot = -14.6175140353306 +17000 ekin = 0.139974218116171 | erot = 0.737052866147306 | epot = -15.4945411196066 | etot = -14.6175140353432 +18000 ekin = 0.141409342139797 | erot = 0.780214750583043 | epot = -15.5391381280668 | etot = -14.617514035344 +19000 ekin = 0.141220424903361 | erot = 0.819521373491177 | epot = -15.5782558337298 | etot = -14.6175140353352 +20000 ekin = 0.139546371890511 | erot = 0.854915474127585 | epot = -15.6119758813374 | etot = -14.6175140353193 +21000 ekin = 0.136561897558541 | erot = 0.886417110947522 | epot = -15.6404930438047 | etot = -14.6175140352986 +22000 ekin = 0.132464002543684 | erot = 0.914099368829796 | epot = -15.6640774066492 | etot = -14.6175140352758 +23000 ekin = 0.127458921012898 | erot = 0.938065991541741 | epot = -15.6830389478072 | etot = -14.6175140352525 +24000 ekin = 0.121750582423396 | erot = 0.958432936326346 | epot = -15.6976975539803 | etot = -14.6175140352306 +25000 ekin = 0.115531361419039 | erot = 0.975315142931434 | epot = -15.7083605395612 | etot = -14.6175140352107 +26000 ekin = 0.108975565586195 | erot = 0.988819027952452 | epot = -15.715308628732 | etot = -14.6175140351934 +27000 ekin = 0.102235785319183 | erot = 0.999040485514706 | epot = -15.7187903060122 | etot = -14.6175140351783 +28000 ekin = 0.0954419434320554 | erot = 1.00606759141037 | epot = -15.7190235700075 | etot = -14.6175140351651 +29000 ekin = 0.0887026587346012 | erot = 1.00998681843686 | epot = -15.7162035123244 | etot = -14.6175140351529 +30000 ekin = 0.0821083868016836 | erot = 1.01089138149989 | epot = -15.7105138034423 | etot = -14.6175140351407 +31000 ekin = 0.0757357206090521 | erot = 1.00889031641421 | epot = -15.702140072151 | etot = -14.6175140351278 +32000 ekin = 0.0696522149391935 | erot = 1.00411701390103 | epot = -15.6912832639534 | etot = -14.6175140351132 +33000 ekin = 0.0639211300031737 | erot = 0.996736133736263 | epot = -15.6781712988358 | etot = -14.6175140350964 +34000 ekin = 0.0586055597942697 | erot = 0.986948071944207 | epot = -15.6630676668155 | etot = -14.617514035077 +35000 ekin = 0.0537715085522448 | erot = 0.974990414618501 | epot = -15.6462759582258 | etot = -14.617514035055 +36000 ekin = 0.0494895953267295 | erot = 0.961136064968264 | epot = -15.6281396953257 | etot = -14.6175140350307 +37000 ekin = 0.0458351949408502 | erot = 0.945687966087874 | epot = -15.6090371960337 | etot = -14.617514035005 +38000 ekin = 0.0428869588018996 | erot = 0.928970560853581 | epot = -15.5893715546342 | etot = -14.6175140349787 +39000 ekin = 0.0407237982125063 | erot = 0.911318339680438 | epot = -15.5695561728459 | etot = -14.617514034953 +40000 ekin = 0.0394205547756063 | erot = 0.893062038098217 | epot = -15.5499966278032 | etot = -14.6175140349294 +41000 ekin = 0.0390427256108178 | erot = 0.874513269991183 | epot = -15.5310700305113 | etot = -14.6175140349092 +42000 ekin = 0.0396407506458889 | erot = 0.855948622306388 | epot = -15.5131034078463 | etot = -14.617514034894 +43000 ekin = 0.0412444930542012 | erot = 0.837594480923648 | epot = -15.4963530088627 | etot = -14.6175140348848 +44000 ekin = 0.0438586280729573 | erot = 0.819614069272763 | epot = -15.4809867322283 | etot = -14.6175140348826 +45000 ekin = 0.0474596621514809 | erot = 0.802098297010425 | epot = -15.4670719940496 | etot = -14.6175140348876 +46000 ekin = 0.0519951857190001 | erot = 0.785061947877089 | epot = -15.4545711684958 | etot = -14.6175140348997 +47000 ekin = 0.0573856747188828 | erot = 0.768446392385995 | epot = -15.4433461020223 | etot = -14.6175140349174 +48000 ekin = 0.0635286843628562 | erot = 0.752129335015535 | epot = -15.433172054318 | etot = -14.6175140349396 +49000 ekin = 0.0703046735384702 | erot = 0.735941123250163 | epot = -15.4237598317528 | etot = -14.6175140349642 +50000 ekin = 0.0775831019852491 | erot = 0.719686007780774 | epot = -15.4147831447551 | etot = -14.6175140349891 +51000 ekin = 0.0852270843840623 | erot = 0.703165726694424 | epot = -15.4059068460916 | etot = -14.6175140350132 +52000 ekin = 0.0930950223446157 | erot = 0.686202231165621 | epot = -15.3968112885448 | etot = -14.6175140350346 +53000 ekin = 0.101038429252411 | erot = 0.668656546988554 | epot = -15.3872090112944 | etot = -14.6175140350534 +54000 ekin = 0.108896540979999 | erot = 0.65044172617409 | epot = -15.3768523022237 | etot = -14.6175140350696 +55000 ekin = 0.116489881625605 | erot = 0.631529329347953 | epot = -15.3655332460571 | etot = -14.6175140350836 +56000 ekin = 0.12361610349128 | erot = 0.611950383382754 | epot = -15.3530805219694 | etot = -14.6175140350954 +57000 ekin = 0.130051530400511 | erot = 0.591792721317636 | epot = -15.3393582868229 | etot = -14.6175140351047 +58000 ekin = 0.135560625192868 | erot = 0.571196690673809 | epot = -15.3242713509772 | etot = -14.6175140351105 +59000 ekin = 0.13991335082652 | erot = 0.550350463180971 | epot = -15.307777849119 | etot = -14.6175140351115 +60000 ekin = 0.142907875045205 | erot = 0.529485019663366 | epot = -15.2899069298149 | etot = -14.6175140351063 +61000 ekin = 0.144394224776987 | erot = 0.508867904999859 | epot = -15.2707761648709 | etot = -14.6175140350941 +62000 ekin = 0.14429400378525 | erot = 0.488794507593493 | epot = -15.2506025464535 | etot = -14.6175140350748 +63000 ekin = 0.142612256997681 | erot = 0.469576039422599 | epot = -15.2297023314693 | etot = -14.617514035049 +64000 ekin = 0.139439544726489 | erot = 0.451524344955609 | epot = -15.2084779247008 | etot = -14.6175140350187 +65000 ekin = 0.134944526553205 | erot = 0.434934714914789 | epot = -15.1873932764541 | etot = -14.6175140349861 +66000 ekin = 0.129359146357915 | erot = 0.42006860776795 | epot = -15.1669417890793 | etot = -14.6175140349534 +67000 ekin = 0.122959458763979 | erot = 0.407138362060406 | epot = -15.1476118557473 | etot = -14.6175140349229 +68000 ekin = 0.116045210525348 | erot = 0.396295631876791 | epot = -15.1298548772989 | etot = -14.6175140348967 +69000 ekin = 0.108920722072196 | erot = 0.387624589972286 | epot = -15.1140593469203 | etot = -14.6175140348758 +70000 ekin = 0.10187874072944 | erot = 0.381140173640969 | epot = -15.1005329492312 | etot = -14.6175140348608 +71000 ekin = 0.0951880561483024 | erot = 0.376791007701474 | epot = -15.0894930987017 | etot = -14.6175140348519 +72000 ekin = 0.0890849677261225 | erot = 0.374466237250124 | epot = -15.0810652398251 | etot = -14.6175140348489 +73000 ekin = 0.0837682427021172 | erot = 0.37400534759948 | epot = -15.0752876251526 | etot = -14.617514034851 +74000 ekin = 0.0793969849743902 | erot = 0.375210076750066 | epot = -15.0721210965819 | etot = -14.6175140348574 +75000 ekin = 0.0760907865069309 | erot = 0.377857644571635 | epot = -15.0714624659456 | etot = -14.617514034867 +76000 ekin = 0.073931583490861 | erot = 0.381714646754472 | epot = -15.073160265124 | etot = -14.6175140348787 +77000 ekin = 0.0729667273608691 | erot = 0.386551032955436 | epot = -15.0770317952076 | etot = -14.6175140348913 +78000 ekin = 0.0732128655080132 | erot = 0.392153586682573 | epot = -15.0828804870945 | etot = -14.6175140349039 +79000 ekin = 0.0746602878351816 | erot = 0.398338263928879 | epot = -15.0905125866795 | etot = -14.6175140349154 +80000 ekin = 0.0772774298946258 | erot = 0.404960669862598 | epot = -15.0997521346822 | etot = -14.617514034925 +81000 ekin = 0.0810152396747851 | erot = 0.411923913358685 | epot = -15.1104531879654 | etot = -14.617514034932 +82000 ekin = 0.0858111278281503 | erot = 0.419183131304765 | epot = -15.122508294069 | etot = -14.6175140349361 +83000 ekin = 0.0915922459207823 | erot = 0.426746154030485 | epot = -15.1358524348888 | etot = -14.6175140349375 +84000 ekin = 0.0982778862655832 | erot = 0.434670094582864 | epot = -15.1504620157849 | etot = -14.6175140349364 +85000 ekin = 0.105780875252437 | erot = 0.443054055542249 | epot = -15.1663489657283 | etot = -14.6175140349336 +86000 ekin = 0.114007936320836 | erot = 0.452028591870875 | epot = -15.1835505631216 | etot = -14.6175140349299 +87000 ekin = 0.122859117093393 | erot = 0.461742961599463 | epot = -15.2021161136192 | etot = -14.6175140349264 +88000 ekin = 0.132226490250757 | erot = 0.472351454261397 | epot = -15.2220919794359 | etot = -14.6175140349237 +89000 ekin = 0.141992430435586 | erot = 0.48400015022936 | epot = -15.243506615588 | etot = -14.6175140349231 +90000 ekin = 0.152027823849156 | erot = 0.496815313840275 | epot = -15.2663571726144 | etot = -14.617514034925 +91000 ekin = 0.162190574344531 | erot = 0.510894287760946 | epot = -15.2905988970356 | etot = -14.6175140349301 +92000 ekin = 0.172324730223634 | erot = 0.526299304076921 | epot = -15.3161380692392 | etot = -14.6175140349387 +93000 ekin = 0.182260479602882 | erot = 0.543054150884053 | epot = -15.3428286654374 | etot = -14.6175140349505 +94000 ekin = 0.19181516642483 | erot = 0.561143224560411 | epot = -15.3704724259507 | etot = -14.6175140349654 +95000 ekin = 0.200795384590157 | erot = 0.580512230413436 | epot = -15.398821649987 | etot = -14.6175140349834 +96000 ekin = 0.209000133284529 | erot = 0.601069706845066 | epot = -15.4275838751334 | etot = -14.6175140350038 +97000 ekin = 0.216224974983237 | erot = 0.62268863993255 | epot = -15.4564276499423 | etot = -14.6175140350265 +98000 ekin = 0.222267131485539 | erot = 0.6452076702458 | epot = -15.4849888367823 | etot = -14.617514035051 +99000 ekin = 0.226931474008825 | erot = 0.668431711039527 | epot = -15.5128772201251 | etot = -14.6175140350767 +100000 ekin = 0.230037392185109 | erot = 0.692132125756159 | epot = -15.5396835530446 | etot = -14.6175140351033 +101000 ekin = 0.231426538774162 | erot = 0.716046886548711 | epot = -15.5649874604531 | etot = -14.6175140351302 +102000 ekin = 0.230971416185847 | erot = 0.739881303910146 | epot = -15.5883667552525 | etot = -14.6175140351565 +103000 ekin = 0.228584676860608 | erot = 0.763309953364731 | epot = -15.6094086654068 | etot = -14.6175140351814 +104000 ekin = 0.224228843046253 | erot = 0.78598032692129 | epot = -15.6277232051714 | etot = -14.6175140352039 +105000 ekin = 0.217925953180068 | erot = 0.807518535459536 | epot = -15.6429585238624 | etot = -14.6175140352228 +106000 ekin = 0.209766205881383 | erot = 0.827537066837229 | epot = -15.6548173079557 | etot = -14.6175140352371 +107000 ekin = 0.199914663118832 | erot = 0.845644346598305 | epot = -15.6630730449629 | etot = -14.6175140352458 +108000 ekin = 0.188614735690438 | erot = 0.86145556230374 | epot = -15.6675843332424 | etot = -14.6175140352482 +109000 ekin = 0.176187061060969 | erot = 0.874603999194657 | epot = -15.6683050954996 | etot = -14.617514035244 +110000 ekin = 0.163022626611269 | erot = 0.884752084634178 | epot = -15.6652887464788 | etot = -14.6175140352334 +111000 ekin = 0.149569382110055 | erot = 0.891601400936344 | epot = -15.6586848182636 | etot = -14.6175140352172 +112000 ekin = 0.136312261124298 | erot = 0.894901120601569 | epot = -15.6487274169225 | etot = -14.6175140351967 +113000 ekin = 0.123747404857111 | erot = 0.894454602034433 | epot = -15.635716042065 | etot = -14.6175140351735 +114000 ekin = 0.112352324429236 | erot = 0.89012419645392 | epot = -15.6199905560327 | etot = -14.6175140351496 +115000 ekin = 0.102554569787019 | erot = 0.881834585428133 | epot = -15.601903190342 | etot = -14.6175140351268 +116000 ekin = 0.094702004709198 | erot = 0.869575126615747 | epot = -15.5817911664316 | etot = -14.6175140351067 +117000 ekin = 0.0890378681933156 | erot = 0.853401690495617 | epot = -15.5599535937792 | etot = -14.6175140350902 +118000 ekin = 0.0856833736304911 | erot = 0.833438318820653 | epot = -15.536635727529 | etot = -14.6175140350778 +119000 ekin = 0.0846297171115028 | erot = 0.809878764033866 | epot = -15.5120225162146 | etot = -14.6175140350693 +120000 ekin = 0.0857402026933537 | erot = 0.782987649503194 | epot = -15.4862418872603 | etot = -14.6175140350638 +121000 ekin = 0.0887619781646647 | erot = 0.753100709617513 | epot = -15.4593767228421 | etot = -14.61751403506 +122000 ekin = 0.0933458418333701 | erot = 0.720623403983765 | epot = -15.4314832808735 | etot = -14.6175140350564 +123000 ekin = 0.0990718975136712 | erot = 0.686027198351099 | epot = -15.4026131309163 | etot = -14.6175140350515 +124000 ekin = 0.10547856753477 | erot = 0.649842971568616 | epot = -15.3728355741476 | etot = -14.6175140350442 +125000 ekin = 0.112092583657157 | erot = 0.612651306911466 | epot = -15.3422579256018 | etot = -14.6175140350331 +126000 ekin = 0.118457948669929 | erot = 0.575069793126885 | epot = -15.3110417768148 | etot = -14.6175140350179 +127000 ekin = 0.12416235209736 | erot = 0.537737821904032 | epot = -15.2794142089994 | etot = -14.617514034998 +128000 ekin = 0.12886000047466 | erot = 0.50129966007338 | epot = -15.2476736955216 | etot = -14.6175140349735 +129000 ekin = 0.132290197680968 | erot = 0.466386755141928 | epot = -15.2161909877676 | etot = -14.6175140349447 +130000 ekin = 0.134291248322799 | erot = 0.433600287194598 | epot = -15.1854055704295 | etot = -14.6175140349121 +131000 ekin = 0.134809368078731 | erot = 0.403494917850824 | epot = -15.1558183208059 | etot = -14.6175140348763 +132000 ekin = 0.133902311412609 | erot = 0.376564532721137 | epot = -15.1279808789722 | etot = -14.6175140348384 +133000 ekin = 0.131737425949523 | erot = 0.35323055944927 | epot = -15.102482020198 | etot = -14.6175140347992 +134000 ekin = 0.128583872249503 | erot = 0.333833200744645 | epot = -15.0799311077543 | etot = -14.6175140347601 +135000 ekin = 0.124798858318881 | erot = 0.318625678761018 | epot = -15.0609385718023 | etot = -14.6175140347224 +136000 ekin = 0.120807966950657 | erot = 0.307771366705204 | epot = -15.0460933683435 | etot = -14.6175140346876 +137000 ekin = 0.117080018573046 | erot = 0.301343503849178 | epot = -15.0359375570798 | etot = -14.6175140346576 +138000 ekin = 0.11409740445119 | erot = 0.299327064918184 | epot = -15.0309385040035 | etot = -14.6175140346342 +139000 ekin = 0.112323403877017 | erot = 0.30162229304682 | epot = -15.0314597315429 | etot = -14.6175140346191 +140000 ekin = 0.112168587316825 | erot = 0.308049410073269 | epot = -15.0377320320041 | etot = -14.617514034614 +141000 ekin = 0.113958896787242 | erot = 0.318354084563179 | epot = -15.0498270159708 | etot = -14.6175140346204 +142000 ekin = 0.117908250109871 | erot = 0.332213334114279 | epot = -15.0676356188632 | etot = -14.6175140346391 +143000 ekin = 0.124098500240005 | erot = 0.349241744869171 | epot = -15.0908542797795 | etot = -14.6175140346704 +144000 ekin = 0.132469049162189 | erot = 0.368998042344344 | epot = -15.1189811262203 | etot = -14.6175140347138 +145000 ekin = 0.142817534773286 | erot = 0.390992018433719 | epot = -15.1513235879751 | etot = -14.6175140347681 +146000 ekin = 0.154812002594074 | erot = 0.414692148539669 | epot = -15.1870181859652 | etot = -14.6175140348314 +147000 ekin = 0.168013608208222 | erot = 0.439534147564146 | epot = -15.2250617906734 | etot = -14.617514034901 +148000 ekin = 0.181907755044263 | erot = 0.464930715993231 | epot = -15.2643525060114 | etot = -14.617514034974 +149000 ekin = 0.195940689918476 | erot = 0.490282644231627 | epot = -15.303737369197 | etot = -14.6175140350469 +150000 ekin = 0.209558115498224 | erot = 0.514991307803342 | epot = -15.3420634584183 | etot = -14.6175140351167 +151000 ekin = 0.222242375358764 | erot = 0.538472447670959 | epot = -15.37822885821 | etot = -14.6175140351803 +152000 ekin = 0.233545181100908 | erot = 0.560170967505261 | epot = -15.4112301838413 | etot = -14.6175140352351 +153000 ekin = 0.243113638171877 | erot = 0.579575715964384 | epot = -15.4402033894153 | etot = -14.6175140352791 +154000 ekin = 0.250708030719506 | erot = 0.596234520730852 | epot = -15.4644565867613 | etot = -14.617514035311 +155000 ekin = 0.256210874594867 | erot = 0.60976818504912 | epot = -15.4834930949737 | etot = -14.6175140353297 +156000 ekin = 0.259627463842678 | erot = 0.619882772314523 | epot = -15.4970242714926 | etot = -14.6175140353354 +157000 ekin = 0.261078756733762 | erot = 0.626379517381851 | epot = -15.5049723094439 | etot = -14.6175140353283 +158000 ekin = 0.260787877594799 | erot = 0.629161788909728 | epot = -15.5074637018138 | etot = -14.6175140353093 +159000 ekin = 0.259061752299363 | erot = 0.628238692725143 | epot = -15.5048144803044 | etot = -14.6175140352799 +160000 ekin = 0.256269476947947 | erot = 0.623725097357694 | epot = -15.4975086095473 | etot = -14.6175140352416 +161000 ekin = 0.252818974262676 | erot = 0.615838055764808 | epot = -15.486171065224 | etot = -14.6175140351965 +162000 ekin = 0.249133354780831 | erot = 0.604889772113657 | epot = -15.471537162041 | etot = -14.6175140351465 +163000 ekin = 0.245628201594069 | erot = 0.591277407065719 | epot = -15.4544196437535 | etot = -14.6175140350937 +164000 ekin = 0.242690765770497 | erot = 0.575470125399849 | epot = -15.4356749262106 | etot = -14.6175140350402 +165000 ekin = 0.240661818237638 | erot = 0.557993868663582 | epot = -15.4161697218892 | etot = -14.617514034988 +166000 ekin = 0.239820672159809 | erot = 0.53941438884916 | epot = -15.3967490959478 | etot = -14.6175140349388 +167000 ekin = 0.240373682616981 | erot = 0.520319112884548 | epot = -15.3782068303959 | etot = -14.6175140348944 +168000 ekin = 0.24244635767337 | erot = 0.501298426047094 | epot = -15.3612588185766 | etot = -14.6175140348562 +169000 ekin = 0.246079081489486 | erot = 0.482926967022081 | epot = -15.3465200833369 | etot = -14.6175140348253 +170000 ekin = 0.251226355670601 | erot = 0.465745518941346 | epot = -15.3344859094148 | etot = -14.6175140348028 +171000 ekin = 0.257759407502439 | erot = 0.450244072412675 | epot = -15.3255175147044 | etot = -14.6175140347893 +172000 ekin = 0.265471962314995 | erot = 0.43684655757276 | epot = -15.3198325546728 | etot = -14.617514034785 +173000 ekin = 0.274088992052566 | erot = 0.425897760802307 | epot = -15.317500787645 | etot = -14.6175140347901 +174000 ekin = 0.283278228107989 | erot = 0.417652965987653 | epot = -15.3184452288998 | etot = -14.6175140348041 +175000 ekin = 0.292664164217049 | erot = 0.41227065206718 | epot = -15.3224488511106 | etot = -14.6175140348264 +176000 ekin = 0.301844276743974 | erot = 0.409808663993543 | epot = -15.3291669755933 | etot = -14.6175140348558 +177000 ekin = 0.310407103277722 | erot = 0.410224178773613 | epot = -15.338145316942 | etot = -14.6175140348907 +178000 ekin = 0.317951707448459 | erot = 0.413377690533319 | epot = -15.3488434329112 | etot = -14.6175140349295 +179000 ekin = 0.324107901131331 | erot = 0.419041092199345 | epot = -15.3606630283007 | etot = -14.61751403497 +180000 ekin = 0.328556397748226 | erot = 0.426909726007329 | epot = -15.3729801587658 | etot = -14.6175140350103 +181000 ekin = 0.331047834153872 | erot = 0.436618006902467 | epot = -15.3851798761041 | etot = -14.6175140350478 +182000 ekin = 0.331419420114469 | erot = 0.447757936314679 | epot = -15.3966913915095 | etot = -14.6175140350803 +183000 ekin = 0.32960779233749 | erot = 0.459899520065503 | epot = -15.4070213475091 | etot = -14.6175140351061 +184000 ekin = 0.325656516855028 | erot = 0.472611792133139 | epot = -15.4157823441118 | etot = -14.6175140351236 +185000 ekin = 0.319716934487211 | erot = 0.485483030927449 | epot = -15.4227140005469 | etot = -14.6175140351322 +186000 ekin = 0.312041347782212 | erot = 0.498138700398001 | epot = -15.4276940833121 | etot = -14.6175140351319 +187000 ekin = 0.302968200961153 | erot = 0.510255791848845 | epot = -15.4307380279334 | etot = -14.6175140351234 +188000 ekin = 0.292899787356355 | erot = 0.5215725520513 | epot = -15.4319863745157 | etot = -14.6175140351081 +189000 ekin = 0.282274048055605 | erot = 0.531893031493143 | epot = -15.4316811146372 | etot = -14.6175140350884 +190000 ekin = 0.271533034588949 | erot = 0.541086413296656 | epot = -15.4301334829521 | etot = -14.6175140350665 +191000 ekin = 0.261091384545176 | erot = 0.549081610185661 | epot = -15.4276870297757 | etot = -14.6175140350448 +192000 ekin = 0.251308489707993 | erot = 0.555858063434326 | epot = -15.4246805881679 | etot = -14.6175140350256 +193000 ekin = 0.242467771119499 | erot = 0.561433978654792 | epot = -15.4214157847846 | etot = -14.6175140350103 +194000 ekin = 0.234765581624083 | erot = 0.565853352187983 | epot = -15.4181329688119 | etot = -14.6175140349998 +195000 ekin = 0.228310848060933 | erot = 0.569173077812972 | epot = -15.414997960868 | etot = -14.6175140349941 +196000 ekin = 0.223134890549791 | erot = 0.571451208607789 | epot = -15.4121001341501 | etot = -14.6175140349925 +197000 ekin = 0.219209242155479 | erot = 0.572737138234515 | epot = -15.4094604153842 | etot = -14.6175140349942 +198000 ekin = 0.216468062808567 | erot = 0.573064123809139 | epot = -15.4070462216157 | etot = -14.6175140349979 +199000 ekin = 0.214831137522102 | erot = 0.572444258405115 | epot = -15.4047894309295 | etot = -14.6175140350023 +200000 ekin = 0.214223573901692 | erot = 0.570865760664587 | epot = -15.402603369573 | etot = -14.6175140350067 +201000 ekin = 0.214589119166338 | erot = 0.568292309388425 | epot = -15.4003954635655 | etot = -14.6175140350107 +202000 ekin = 0.215895325601886 | erot = 0.564664121435212 | epot = -15.3980734820515 | etot = -14.6175140350144 +203000 ekin = 0.218130347569574 | erot = 0.559900543320399 | epot = -15.3955449259083 | etot = -14.6175140350184 +204000 ekin = 0.221292667473328 | erot = 0.553904074219812 | epot = -15.3927107767163 | etot = -14.6175140350232 +205000 ekin = 0.225376258610291 | erot = 0.546565915590092 | epot = -15.3894562092301 | etot = -14.6175140350297 +206000 ekin = 0.230354397528691 | erot = 0.537773288685112 | epot = -15.3856417212522 | etot = -14.6175140350384 +207000 ekin = 0.236165428414371 | erot = 0.527418806931585 | epot = -15.3810982703949 | etot = -14.617514035049 +208000 ekin = 0.242703261860097 | erot = 0.515412077176746 | epot = -15.3756293740978 | etot = -14.617514035061 +209000 ekin = 0.249814382549771 | erot = 0.501693407692903 | epot = -15.3690218253159 | etot = -14.6175140350732 +210000 ekin = 0.257301864855487 | erot = 0.486249049966596 | epot = -15.3610649499059 | etot = -14.6175140350838 +211000 ekin = 0.264935635394204 | erot = 0.469126912721243 | epot = -15.3515765832063 | etot = -14.6175140350909 +212000 ekin = 0.272467183646431 | erot = 0.450451153648371 | epot = -15.3404323723875 | etot = -14.6175140350927 +213000 ekin = 0.279646306736912 | erot = 0.430433702677772 | epot = -15.3275940445023 | etot = -14.6175140350876 +214000 ekin = 0.286237611276899 | erot = 0.409381288017331 | epot = -15.3131329343688 | etot = -14.6175140350746 +215000 ekin = 0.29203464387293 | erot = 0.387696263733711 | epot = -15.29724494266 | etot = -14.6175140350534 +216000 ekin = 0.296870258153004 | erot = 0.365870567410591 | epot = -15.2802548605881 | etot = -14.6175140350245 +217000 ekin = 0.300622666325324 | erot = 0.344472695101547 | epot = -15.2626093964159 | etot = -14.617514034989 +218000 ekin = 0.303217269541564 | erot = 0.324128407396835 | epot = -15.244859711887 | etot = -14.6175140349486 +219000 ekin = 0.30462484391226 | erot = 0.305496496150474 | epot = -15.2276353749682 | etot = -14.6175140349055 +220000 ekin = 0.304856982074418 | erot = 0.289241221674229 | epot = -15.2116122386105 | etot = -14.6175140348619 +221000 ekin = 0.303959749544728 | erot = 0.276003133760616 | epot = -15.1974769181253 | etot = -14.61751403482 +222000 ekin = 0.302006434071345 | erot = 0.266369862263779 | epot = -15.1858903311172 | etot = -14.6175140347821 +223000 ekin = 0.299090105491099 | erot = 0.260848208952979 | epot = -15.1774523491944 | etot = -14.6175140347503 +224000 ekin = 0.295316503745815 | erot = 0.259838588555865 | epot = -15.172669127028 | etot = -14.6175140347263 +225000 ekin = 0.29079760031813 | erot = 0.263612591734547 | epot = -15.1719242267643 | etot = -14.6175140347116 +226000 ekin = 0.28564610323333 | erot = 0.272294318079248 | epot = -15.1754544560199 | etot = -14.6175140347074 +227000 ekin = 0.279971018689722 | erot = 0.285846075010758 | epot = -15.1833311284149 | etot = -14.6175140347144 +228000 ekin = 0.27387437472819 | erot = 0.304059069119049 | epot = -15.1954474785804 | etot = -14.6175140347332 +229000 ekin = 0.2674491741605 | erot = 0.326549807965654 | epot = -15.2115130168897 | etot = -14.6175140347636 +230000 ekin = 0.260778614119455 | erot = 0.352763004039831 | epot = -15.2310556529641 | etot = -14.6175140348048 +231000 ekin = 0.253936564977397 | erot = 0.381981763344761 | epot = -15.2534323631777 | etot = -14.6175140348555 +232000 ekin = 0.246989230842658 | erot = 0.413345683736738 | epot = -15.2778489494936 | etot = -14.6175140349142 +233000 ekin = 0.239997814735998 | erot = 0.445877135783837 | epot = -15.3033889854983 | etot = -14.6175140349784 +234000 ekin = 0.233021891669953 | erot = 0.478515439398998 | epot = -15.3290513661143 | etot = -14.6175140350454 +235000 ekin = 0.226123071286445 | erot = 0.510157919201484 | epot = -15.3537950255997 | etot = -14.6175140351118 +236000 ekin = 0.21936843695277 | erot = 0.539706010633891 | epot = -15.3765884827611 | etot = -14.6175140351745 +237000 ekin = 0.212833212708602 | erot = 0.566113832023262 | epot = -15.3964610799619 | etot = -14.61751403523 +238000 ekin = 0.206602165162865 | erot = 0.588436180449287 | epot = -15.4125523808878 | etot = -14.6175140352757 +239000 ekin = 0.200769360307748 | erot = 0.605872583258365 | epot = -15.4241559788754 | etot = -14.6175140353093 +240000 ekin = 0.195436190928625 | erot = 0.61780345837781 | epot = -15.4307536846357 | etot = -14.6175140353293 +241000 ekin = 0.190707920284743 | erot = 0.623817360380854 | epot = -15.4320393160006 | etot = -14.617514035335 +242000 ekin = 0.186689132524135 | erot = 0.623726737659666 | epot = -15.4279299055104 | etot = -14.6175140353266 +243000 ekin = 0.183478880874969 | erot = 0.617571857376273 | epot = -15.4185647735561 | etot = -14.6175140353049 +244000 ekin = 0.181166166760206 | erot = 0.605612923712308 | epot = -15.4042931257437 | etot = -14.6175140352712 +245000 ekin = 0.179826690516145 | erot = 0.588311983397642 | epot = -15.3856527091413 | etot = -14.6175140352275 +246000 ekin = 0.179521473345086 | erot = 0.566306329739288 | epot = -15.3633418382601 | etot = -14.6175140351758 +247000 ekin = 0.180297726609514 | erot = 0.540375528723551 | epot = -15.3381872904514 | etot = -14.6175140351183 +248000 ekin = 0.182192022181392 | erot = 0.511404282991666 | epot = -15.3111103402302 | etot = -14.6175140350572 +249000 ekin = 0.185235475059313 | erot = 0.480343275337858 | epot = -15.2830927853916 | etot = -14.6175140349945 +250000 ekin = 0.189460324578832 | erot = 0.448169956262064 | epot = -15.255144315773 | etot = -14.6175140349321 +251000 ekin = 0.19490702001237 | erot = 0.415851007132868 | epot = -15.228272062017 | etot = -14.6175140348717 +252000 ekin = 0.201630699423836 | erot = 0.384307951122289 | epot = -15.2034526853611 | etot = -14.617514034815 +253000 ekin = 0.209705815256177 | erot = 0.354387113740113 | epot = -15.1816069637594 | etot = -14.6175140347631 +254000 ekin = 0.219227629547432 | erot = 0.326834860919775 | epot = -15.1635765251848 | etot = -14.6175140347176 +255000 ekin = 0.230309407957432 | erot = 0.302278768995733 | epot = -15.1501022116327 | etot = -14.6175140346795 +256000 ekin = 0.243074422922267 | erot = 0.281215109558701 | epot = -15.141803567131 | etot = -14.61751403465 +257000 ekin = 0.257642364630153 | erot = 0.264002762946067 | epot = -15.1391591622066 | etot = -14.6175140346304 +258000 ekin = 0.274110461104108 | erot = 0.250863404057697 | epot = -15.1424878997833 | etot = -14.6175140346215 +259000 ekin = 0.292530483429775 | erot = 0.241887528333024 | epot = -15.1519320463872 | etot = -14.6175140346244 +260000 ekin = 0.312883750215128 | erot = 0.237045600991386 | epot = -15.1674433858462 | etot = -14.6175140346397 +261000 ekin = 0.335057071666333 | erot = 0.236203324625284 | epot = -15.1887744309592 | etot = -14.6175140346676 +262000 ekin = 0.358823075933473 | erot = 0.239139750884213 | epot = -15.2154768615253 | etot = -14.6175140347076 +263000 ekin = 0.383828346058996 | erot = 0.245566753569572 | epot = -15.2469091343872 | etot = -14.6175140347587 +264000 ekin = 0.409592161639947 | erot = 0.255148290958814 | epot = -15.2822544874178 | etot = -14.6175140348191 +265000 ekin = 0.435517425640964 | erot = 0.267517972446782 | epot = -15.3205494329741 | etot = -14.6175140348864 +266000 ekin = 0.460913759434661 | erot = 0.282293742227942 | epot = -15.3607215366204 | etot = -14.6175140349578 +267000 ekin = 0.485031075313793 | erot = 0.299088986461059 | epot = -15.4016340968052 | etot = -14.6175140350303 +268000 ekin = 0.50710051747368 | erot = 0.317519986656956 | epot = -15.4421345392314 | etot = -14.6175140351007 +269000 ekin = 0.526378761163555 | erot = 0.33721025800327 | epot = -15.4811030543329 | etot = -14.6175140351661 +270000 ekin = 0.542191399557166 | erot = 0.357792786170323 | epot = -15.5174982209515 | etot = -14.617514035224 +271000 ekin = 0.553971501275297 | erot = 0.378911394713051 | epot = -15.5503969312606 | etot = -14.6175140352722 +272000 ekin = 0.561290243476884 | erot = 0.400222387433604 | epot = -15.5790266662199 | etot = -14.6175140353094 +273000 ekin = 0.563877614617889 | erot = 0.421397250043755 | epot = -15.6027888999963 | etot = -14.6175140353346 +274000 ekin = 0.561632338447609 | erot = 0.442126671655328 | epot = -15.6212730454506 | etot = -14.6175140353477 +275000 ekin = 0.554621238224436 | erot = 0.462125606775396 | epot = -15.6342608803486 | etot = -14.6175140353487 +276000 ekin = 0.543069132887187 | erot = 0.481138682331962 | epot = -15.6417218505579 | etot = -14.6175140353387 +277000 ekin = 0.527340979965694 | erot = 0.498945052082853 | epot = -15.6438000673675 | etot = -14.6175140353189 +278000 ekin = 0.507918337217276 | erot = 0.515361832413196 | epot = -15.6407942049214 | etot = -14.617514035291 +279000 ekin = 0.485372319601914 | erot = 0.530245473601771 | epot = -15.6331318284601 | etot = -14.6175140352564 +280000 ekin = 0.46033511650651 | erot = 0.543490744711146 | epot = -15.6213398964351 | etot = -14.6175140352175 +281000 ekin = 0.433471859960453 | erot = 0.555027349456868 | epot = -15.6060132445935 | etot = -14.6175140351761 +282000 ekin = 0.405454262480505 | erot = 0.564814480007104 | epot = -15.5877827776223 | etot = -14.6175140351347 +283000 ekin = 0.376937038993415 | erot = 0.572833827993335 | epot = -15.5672849020813 | etot = -14.6175140350945 +284000 ekin = 0.348537747962441 | erot = 0.579081711931139 | epot = -15.5451334949501 | etot = -14.6175140350565 +285000 ekin = 0.320820372083179 | erot = 0.583561068647143 | epot = -15.5218954757531 | etot = -14.6175140350227 +286000 ekin = 0.294282726921465 | erot = 0.586274110946605 | epot = -15.4980708728619 | etot = -14.6175140349939 +287000 ekin = 0.269347634013372 | erot = 0.587216475910704 | epot = -15.4740781448946 | etot = -14.6175140349706 +288000 ekin = 0.246357704467567 | erot = 0.586373659773396 | epot = -15.4502453991941 | etot = -14.6175140349531 +289000 ekin = 0.225573522145737 | erot = 0.583720426232575 | epot = -15.4268079833199 | etot = -14.6175140349416 +290000 ekin = 0.207174962818498 | erot = 0.579223657449698 | epot = -15.4039126552032 | etot = -14.617514034935 +291000 ekin = 0.191265313940317 | erot = 0.57284878086397 | epot = -15.3816281297368 | etot = -14.6175140349325 +292000 ekin = 0.177877757396561 | erot = 0.564569470033103 | epot = -15.3599612623625 | etot = -14.6175140349328 +293000 ekin = 0.166983649288562 | erot = 0.55437983768204 | epot = -15.3388775219052 | etot = -14.6175140349346 +294000 ekin = 0.158501898150816 | erot = 0.542307895558416 | epot = -15.3183238286456 | etot = -14.6175140349363 +295000 ekin = 0.152308641379775 | erot = 0.528428741575564 | epot = -15.2982514178919 | etot = -14.6175140349366 +296000 ekin = 0.14824639013426 | erot = 0.512875830575376 | epot = -15.2786362556441 | etot = -14.6175140349344 +297000 ekin = 0.146131889948848 | erot = 0.49584883363365 | epot = -15.2594947585117 | etot = -14.6175140349292 +298000 ekin = 0.145762142540934 | erot = 0.47761697934363 | epot = -15.2408931568053 | etot = -14.6175140349207 +299000 ekin = 0.146918339842692 | erot = 0.458517327974144 | epot = -15.2229497027261 | etot = -14.6175140349093 +300000 ekin = 0.149367830718069 | erot = 0.438948042711649 | epot = -15.2058299083254 | etot = -14.6175140348957 +301000 ekin = 0.152864610234033 | erot = 0.419357266833102 | epot = -15.1897359119478 | etot = -14.6175140348807 +302000 ekin = 0.157149122640169 | erot = 0.400228590597444 | epot = -15.1748917481033 | etot = -14.6175140348656 +303000 ekin = 0.161948347719032 | erot = 0.382064246006851 | epot = -15.1615266285773 | etot = -14.6175140348514 +304000 ekin = 0.166977167327436 | erot = 0.365367110078575 | epot = -15.1498583122451 | etot = -14.6175140348391 +305000 ekin = 0.171941885875871 | erot = 0.350622387001196 | epot = -15.1400783077067 | etot = -14.6175140348296 +306000 ekin = 0.176546522696863 | erot = 0.338279561363742 | epot = -15.1323401188838 | etot = -14.6175140348232 +307000 ekin = 0.180502080572192 | erot = 0.32873493509135 | epot = -15.126751050484 | etot = -14.6175140348205 +308000 ekin = 0.183539117579248 | erot = 0.322315068517915 | epot = -15.1233682209185 | etot = -14.6175140348213 +309000 ekin = 0.18542258916881 | erot = 0.31926113518031 | epot = -15.1221977591748 | etot = -14.6175140348257 +310000 ekin = 0.185968382525478 | erot = 0.319714556777655 | epot = -15.1231969741364 | etot = -14.6175140348332 +311000 ekin = 0.185060444471749 | erot = 0.323704474532897 | epot = -15.1262789538482 | etot = -14.6175140348435 +312000 ekin = 0.182667055699898 | erot = 0.331137883754702 | epot = -15.1313189743107 | etot = -14.6175140348561 +313000 ekin = 0.178854671448117 | erot = 0.341793554574368 | epot = -15.1381622608928 | etot = -14.6175140348703 +314000 ekin = 0.173797674113305 | erot = 0.355321045101964 | epot = -15.1466327541009 | etot = -14.6175140348857 +315000 ekin = 0.167782440685989 | erot = 0.371246117950244 | epot = -15.1565425935376 | etot = -14.6175140349013 +316000 ekin = 0.161204347699333 | erot = 0.388983636698412 | epot = -15.1677020193144 | etot = -14.6175140349166 +317000 ekin = 0.154556738722997 | erot = 0.407858516721222 | epot = -15.179929290375 | etot = -14.6175140349308 +318000 ekin = 0.148411457828014 | erot = 0.427134549771526 | epot = -15.1930600425429 | etot = -14.6175140349434 +319000 ekin = 0.143391260343274 | erot = 0.446049980956587 | epot = -15.2069552762535 | etot = -14.6175140349536 +320000 ekin = 0.140135163879389 | erot = 0.463857713006731 | epot = -15.2215069118477 | etot = -14.6175140349616 +321000 ekin = 0.13925849683082 | erot = 0.47986711734359 | epot = -15.2366396491416 | etot = -14.6175140349672 +322000 ekin = 0.141309963686786 | erot = 0.493483840953745 | epot = -15.2523078396115 | etot = -14.617514034971 +323000 ekin = 0.146728465402049 | erot = 0.504243890594766 | epot = -15.2684863909708 | etot = -14.617514034974 +324000 ekin = 0.155802740978474 | erot = 0.511838753068047 | epot = -15.2851555290241 | etot = -14.6175140349776 +325000 ekin = 0.168637192339758 | erot = 0.516129344219392 | epot = -15.3022805715425 | etot = -14.6175140349833 +326000 ekin = 0.185127492740937 | erot = 0.517147991936341 | epot = -15.3197895196698 | etot = -14.6175140349925 +327000 ekin = 0.204949583925474 | erot = 0.515089155111526 | epot = -15.3375527740431 | etot = -14.6175140350061 +328000 ekin = 0.227565145376632 | erot = 0.510290835144293 | epot = -15.3553700155453 | etot = -14.6175140350243 +329000 ekin = 0.252245305622037 | erot = 0.503209396460715 | epot = -15.372968737129 | etot = -14.6175140350463 +330000 ekin = 0.278112223739082 | erot = 0.494390678506977 | epot = -15.3900169373163 | etot = -14.6175140350702 +331000 ekin = 0.304195517645115 | erot = 0.484439927614521 | epot = -15.4061494803532 | etot = -14.6175140350935 +332000 ekin = 0.329497983392802 | erot = 0.473992405219011 | epot = -15.4210044237255 | etot = -14.6175140351136 +333000 ekin = 0.353063353198636 | erot = 0.463685785195801 | epot = -15.4342631735224 | etot = -14.617514035128 +334000 ekin = 0.374038491016654 | erot = 0.454134842083192 | epot = -15.4456873682344 | etot = -14.6175140351345 +335000 ekin = 0.391723520500355 | erot = 0.445908562625392 | epot = -15.4551461182584 | etot = -14.6175140351326 +336000 ekin = 0.405605581598612 | erot = 0.439509690040415 | epot = -15.4626293067615 | etot = -14.6175140351225 +337000 ekin = 0.415374601838216 | erot = 0.435356764652285 | epot = -15.4682454015957 | etot = -14.6175140351052 +338000 ekin = 0.42092199701013 | erot = 0.433768862195237 | epot = -15.4722048942883 | etot = -14.6175140350829 +339000 ekin = 0.422325110447523 | erot = 0.434953376211998 | epot = -15.4747925217174 | etot = -14.6175140350579 +340000 ekin = 0.419821259880453 | erot = 0.438997304560007 | epot = -15.4763325994732 | etot = -14.6175140350327 +341000 ekin = 0.413775534581149 | erot = 0.445862573585633 | epot = -15.4771521431765 | etot = -14.6175140350097 +342000 ekin = 0.404646174020848 | erot = 0.455385967573857 | epot = -15.4775461765857 | etot = -14.617514034991 +343000 ekin = 0.39295070583281 | erot = 0.467284215126884 | epot = -15.4777489559374 | etot = -14.6175140349777 +344000 ekin = 0.379235231728883 | erot = 0.481164689425934 | epot = -15.4779139561254 | etot = -14.6175140349706 +345000 ekin = 0.364048459933153 | erot = 0.496541967294177 | epot = -15.4781044621969 | etot = -14.6175140349695 +346000 ekin = 0.347921358320316 | erot = 0.512860132815006 | epot = -15.478295526109 | etot = -14.6175140349737 +347000 ekin = 0.331352665808126 | erot = 0.529520204053122 | epot = -15.4783869048429 | etot = -14.6175140349817 +348000 ekin = 0.314799955036566 | erot = 0.545911447469168 | epot = -15.4782254374972 | etot = -14.6175140349915 +349000 ekin = 0.298675493175281 | erot = 0.561444708834092 | epot = -15.4776342370104 | etot = -14.6175140350011 +350000 ekin = 0.283345815520869 | erot = 0.575585348315993 | epot = -15.4764451988451 | etot = -14.6175140350083 +351000 ekin = 0.269133730327523 | erot = 0.587883045339117 | epot = -15.474530810678 | etot = -14.6175140350114 +352000 ekin = 0.256321431305203 | erot = 0.597995738138039 | epot = -15.4718312044524 | etot = -14.6175140350092 +353000 ekin = 0.24515350965437 | erot = 0.605705335206206 | epot = -15.4683728798616 | etot = -14.617514035001 +354000 ekin = 0.235838910986168 | erot = 0.610923562934476 | epot = -15.4642765089078 | etot = -14.6175140349872 +355000 ekin = 0.228551231300269 | erot = 0.613687305425456 | epot = -15.4597525716945 | etot = -14.6175140349688 +356000 ekin = 0.223427131306842 | erot = 0.61414390282459 | epot = -15.4550850690789 | etot = -14.6175140349475 +357000 ekin = 0.220563006917694 | erot = 0.612527933401747 | epot = -15.4506049752447 | etot = -14.6175140349253 +358000 ekin = 0.22001033319751 | erot = 0.60913185554411 | epot = -15.4466562236463 | etot = -14.6175140349046 +359000 ekin = 0.221770268739896 | erot = 0.604273418957587 | epot = -15.4435577225855 | etot = -14.617514034888 +360000 ekin = 0.225788163653238 | erot = 0.598262925571301 | epot = -15.4415651241022 | etot = -14.6175140348777 +361000 ekin = 0.231948578437327 | erot = 0.591373251984918 | epot = -15.4408358652977 | etot = -14.6175140348754 +362000 ekin = 0.240071331017989 | erot = 0.583815109039703 | epot = -15.4414004749403 | etot = -14.6175140348826 +363000 ekin = 0.249908988057725 | erot = 0.5757194066129 | epot = -15.4431424295705 | etot = -14.6175140348999 +364000 ekin = 0.261146140581906 | erot = 0.567127906486804 | epot = -15.445788081996 | etot = -14.6175140349273 +365000 ekin = 0.273400773645715 | erot = 0.55799265360587 | epot = -15.4489074622158 | etot = -14.6175140349642 +366000 ekin = 0.286228056503678 | erot = 0.548184015759183 | epot = -15.4519261072721 | etot = -14.6175140350092 +367000 ekin = 0.299126926925909 | erot = 0.537506547612528 | epot = -15.454147509599 | etot = -14.6175140350606 +368000 ekin = 0.311549892638302 | erot = 0.525721330953642 | epot = -15.4547852587076 | etot = -14.6175140351156 +369000 ekin = 0.32291649334207 | erot = 0.512572942756027 | epot = -15.4530034712696 | etot = -14.6175140351715 +370000 ekin = 0.332630833323927 | erot = 0.497818805483382 | epot = -15.4479636740324 | etot = -14.6175140352251 +371000 ekin = 0.340103492446064 | erot = 0.481258447418256 | epot = -15.4388759751374 | etot = -14.617514035273 +372000 ekin = 0.344777943663672 | erot = 0.462760223985855 | epot = -15.4250522029614 | etot = -14.6175140353119 +373000 ekin = 0.346161332161602 | erot = 0.442283380419715 | epot = -15.4059587479198 | etot = -14.6175140353385 +374000 ekin = 0.343859062980226 | erot = 0.419893962768359 | epot = -15.3812670610984 | etot = -14.6175140353498 +375000 ekin = 0.337612023151089 | erot = 0.395773904237503 | epot = -15.3508999627316 | etot = -14.617514035343 +376000 ekin = 0.327334336193297 | erot = 0.370223433837585 | epot = -15.3150718053467 | etot = -14.6175140353159 +377000 ekin = 0.31314826371265 | erot = 0.343657545338067 | epot = -15.2743198443178 | etot = -14.6175140352671 +378000 ekin = 0.295411338277465 | erot = 0.316597454538877 | epot = -15.2295228280127 | etot = -14.6175140351964 +379000 ekin = 0.274729408510311 | erot = 0.289657740940239 | epot = -15.1819011845556 | etot = -14.6175140351051 +380000 ekin = 0.251948675267255 | erot = 0.263529414055484 | epot = -15.1329921243191 | etot = -14.6175140349963 +381000 ekin = 0.228120837035106 | erot = 0.238958749468258 | epot = -15.0845936213795 | etot = -14.6175140348762 +382000 ekin = 0.204438854506711 | erot = 0.21672127051921 | epot = -15.0386741597778 | etot = -14.6175140347519 +383000 ekin = 0.182146263755408 | erot = 0.197591880984099 | epot = -14.9972521793719 | etot = -14.6175140346324 +384000 ekin = 0.162429780679591 | erot = 0.182311896923862 | epot = -14.9622557121303 | etot = -14.6175140345269 +385000 ekin = 0.14631062212392 | erot = 0.171555128910903 | epot = -14.9353797854787 | etot = -14.6175140344438 +386000 ekin = 0.134552389652504 | erot = 0.165895597224072 | epot = -14.9179620212652 | etot = -14.6175140343886 +387000 ekin = 0.127600986328474 | erot = 0.165779213533691 | epot = -14.9108942342261 | etot = -14.6175140343639 +388000 ekin = 0.125565151523057 | erot = 0.171500950984465 | epot = -14.9145801368767 | etot = -14.6175140343691 +389000 ekin = 0.128237001096924 | erot = 0.183188026636153 | epot = -14.9289390621345 | etot = -14.6175140344014 +390000 ekin = 0.135143637923019 | erot = 0.200788930663243 | epot = -14.953446603043 | etot = -14.6175140344567 +391000 ekin = 0.145616156499687 | erot = 0.224068074688667 | epot = -14.9871982657189 | etot = -14.6175140345306 +392000 ekin = 0.158862235246419 | erot = 0.252606362172197 | epot = -15.028982632037 | etot = -14.6175140346184 +393000 ekin = 0.174032087603182 | erot = 0.285808726840173 | epot = -15.0773548491589 | etot = -14.6175140347155 +394000 ekin = 0.190272707003279 | erot = 0.32292010751355 | epot = -15.130706849335 | etot = -14.6175140348181 +395000 ekin = 0.206769905101682 | erot = 0.363051013228993 | epot = -15.1873349532528 | etot = -14.6175140349222 +396000 ekin = 0.222780272469837 | erot = 0.405212687948367 | epot = -15.2455069954416 | etot = -14.6175140350234 +397000 ekin = 0.237655698718666 | erot = 0.448360183483368 | epot = -15.3035299173201 | etot = -14.6175140351181 +398000 ekin = 0.250862154069819 | erot = 0.491439914330298 | epot = -15.3598161036023 | etot = -14.6175140352022 +399000 ekin = 0.261993055953367 | erot = 0.533437059171161 | epot = -15.4129441503973 | etot = -14.6175140352727 +400000 ekin = 0.27077655050685 | erot = 0.573417887950022 | epot = -15.4617084737844 | etot = -14.6175140353276 +401000 ekin = 0.277075831015552 | erot = 0.610562842824378 | epot = -15.505152709206 | etot = -14.6175140353661 +402000 ekin = 0.280882158891387 | erot = 0.644187798759806 | epot = -15.5425839930396 | etot = -14.6175140353885 +403000 ekin = 0.282301228578668 | erot = 0.673752968642337 | epot = -15.5735682326172 | etot = -14.6175140353962 +404000 ekin = 0.281534519811851 | erot = 0.698860907482421 | epot = -15.5979094626856 | etot = -14.6175140353913 +405000 ekin = 0.278857975736577 | erot = 0.719246574878491 | epot = -15.6156185859914 | etot = -14.6175140353763 +406000 ekin = 0.27460055575904 | erot = 0.734763157396981 | epot = -15.6268777485092 | etot = -14.6175140353531 +407000 ekin = 0.269124923358191 | erot = 0.745367259285135 | epot = -15.632006217967 | etot = -14.6175140353237 +408000 ekin = 0.262811853165513 | erot = 0.75110627666519 | epot = -15.6314321651198 | etot = -14.6175140352891 +409000 ekin = 0.256049112192014 | erot = 0.752109968276038 | epot = -15.6256731157183 | etot = -14.6175140352503 +410000 ekin = 0.249224269809724 | erot = 0.748584332259421 | epot = -15.6153226372766 | etot = -14.6175140352074 +411000 ekin = 0.242720888553515 | erot = 0.74080910391814 | epot = -15.6010440276324 | etot = -14.6175140351607 +412000 ekin = 0.236916379506249 | erot = 0.729136085380527 | epot = -15.5835664999973 | etot = -14.6175140351105 +413000 ekin = 0.232179735243875 | erot = 0.713985498456682 | epot = -15.5636792687578 | etot = -14.6175140350572 +414000 ekin = 0.228867632642529 | erot = 0.695838652585608 | epot = -15.5422203202303 | etot = -14.6175140350022 +415000 ekin = 0.227317772308198 | erot = 0.675225695396014 | epot = -15.5200575026511 | etot = -14.6175140349469 +416000 ekin = 0.227838940778005 | erot = 0.65270826110506 | epot = -15.4980612367768 | etot = -14.6175140348937 +417000 ekin = 0.23069797086734 | erot = 0.628857925336074 | epot = -15.4770699310485 | etot = -14.6175140348451 +418000 ekin = 0.236104416121177 | erot = 0.604232291329939 | epot = -15.4578507422545 | etot = -14.6175140348034 +419000 ekin = 0.244194252200936 | erot = 0.579351108945467 | epot = -15.4410593959176 | etot = -14.6175140347712 +420000 ekin = 0.255014214169025 | erot = 0.554674986841681 | epot = -15.427203235761 | etot = -14.6175140347503 +421000 ekin = 0.268508458340867 | erot = 0.530589008737006 | epot = -15.4166115018197 | etot = -14.6175140347419 +422000 ekin = 0.284509119561056 | erot = 0.507392982381358 | epot = -15.4094161366888 | etot = -14.6175140347464 +423000 ekin = 0.302732060427453 | erot = 0.485299248119848 | epot = -15.4055453433108 | etot = -14.6175140347635 +424000 ekin = 0.322778728051846 | erot = 0.464438075671392 | epot = -15.4047308385151 | etot = -14.6175140347918 +425000 ekin = 0.344144594922978 | erot = 0.444869796713037 | epot = -15.4065284264654 | etot = -14.6175140348294 +426000 ekin = 0.366234204300236 | erot = 0.426602052984558 | epot = -15.4103502921584 | etot = -14.6175140348736 +427000 ekin = 0.388382398339839 | erot = 0.409609962240785 | epot = -15.4155063955021 | etot = -14.6175140349215 +428000 ekin = 0.409880900047347 | erot = 0.393856678092514 | epot = -15.4212516131098 | etot = -14.61751403497 +429000 ekin = 0.430009061106081 | erot = 0.379311788382045 | epot = -15.4268348845042 | etot = -14.617514035016 +430000 ekin = 0.448067283635938 | erot = 0.365965282400769 | epot = -15.4315466010937 | etot = -14.617514035057 +431000 ekin = 0.463411378722709 | erot = 0.353835411175237 | epot = -15.4347608249887 | etot = -14.6175140350907 +432000 ekin = 0.47548594153415 | erot = 0.342969616703567 | epot = -15.4359695933534 | etot = -14.6175140351157 +433000 ekin = 0.483854704019995 | erot = 0.333438714396017 | epot = -15.4348074535468 | etot = -14.6175140351308 +434000 ekin = 0.488225698517989 | erot = 0.325325491781988 | epot = -15.4310652254358 | etot = -14.6175140351358 +435000 ekin = 0.488469615216989 | erot = 0.318709988965469 | epot = -15.4246936393136 | etot = -14.6175140351312 +436000 ekin = 0.48462910079659 | erot = 0.313653867974335 | epot = -15.4157970038886 | etot = -14.6175140351176 +437000 ekin = 0.476917712283315 | erot = 0.310186654190433 | epot = -15.4046184015705 | etot = -14.6175140350967 +438000 ekin = 0.465707830234525 | erot = 0.308296241622533 | epot = -15.3915181069269 | etot = -14.6175140350699 +439000 ekin = 0.451507536799582 | erot = 0.307925153770196 | epot = -15.376946725609 | etot = -14.6175140350392 +440000 ekin = 0.434927659012326 | erot = 0.308973010492473 | epot = -15.3614147045113 | etot = -14.6175140350065 +441000 ekin = 0.416641657348227 | erot = 0.311304747383323 | epot = -15.3454604397054 | etot = -14.6175140349739 +442000 ekin = 0.397341542599983 | erot = 0.3147626187362 | epot = -15.3296181962795 | etot = -14.6175140349433 +443000 ekin = 0.377694362714098 | erot = 0.319179725729427 | epot = -15.3143881233596 | etot = -14.6175140349161 +444000 ekin = 0.358304425135514 | erot = 0.324393298190365 | epot = -15.3002117582193 | etot = -14.6175140348935 +445000 ekin = 0.339684383333994 | erot = 0.330254911560057 | epot = -15.2874533297702 | etot = -14.6175140348761 +446000 ekin = 0.322237701350787 | erot = 0.336636009508874 | epot = -15.276387745724 | etot = -14.6175140348643 +447000 ekin = 0.306253086582787 | erot = 0.343428242758822 | epot = -15.2671953641996 | etot = -14.617514034858 +448000 ekin = 0.291909091343146 | erot = 0.350538602021414 | epot = -15.2599617282214 | etot = -14.6175140348569 +449000 ekin = 0.279285717663623 | erot = 0.35788026308961 | epot = -15.2546800156141 | etot = -14.6175140348608 +450000 ekin = 0.268379332693062 | erot = 0.365360767817965 | epot = -15.2512541353807 | etot = -14.6175140348697 +451000 ekin = 0.259117719162389 | erot = 0.372869677561009 | epot = -15.2495014316067 | etot = -14.6175140348833 +452000 ekin = 0.251373384973236 | erot = 0.380268095671436 | epot = -15.2491555155464 | etot = -14.6175140349017 +453000 ekin = 0.244974824127414 | erot = 0.387382402365197 | epot = -15.249871261417 | etot = -14.6175140349243 +454000 ekin = 0.239716691076083 | erot = 0.39400413186188 | epot = -15.2512348578882 | etot = -14.6175140349502 +455000 ekin = 0.235370413814051 | erot = 0.399897145642462 | epot = -15.2527815944342 | etot = -14.6175140349777 +456000 ekin = 0.231696513790449 | erot = 0.40481218842498 | epot = -15.2540227372201 | etot = -14.6175140350047 +457000 ekin = 0.228459014431981 | erot = 0.40850770951526 | epot = -15.2544807589758 | etot = -14.6175140350286 +458000 ekin = 0.225441196082345 | erot = 0.410774705624049 | epot = -15.2537299367533 | etot = -14.6175140350469 +459000 ekin = 0.222461018940529 | erot = 0.411462514811891 | epot = -15.2514375688097 | etot = -14.6175140350572 +460000 ekin = 0.219384094438522 | erot = 0.410502136529 | epot = -15.2474002660254 | etot = -14.6175140350579 +461000 ekin = 0.216132245240083 | erot = 0.40792384413244 | epot = -15.2415701244207 | etot = -14.6175140350482 +462000 ekin = 0.212686361973293 | erot = 0.403866554423589 | epot = -15.2340669514251 | etot = -14.6175140350283 +463000 ekin = 0.209083218482802 | erot = 0.398577486489706 | epot = -15.2251747399718 | etot = -14.6175140349993 +464000 ekin = 0.205406888263705 | erot = 0.392401883856904 | epot = -15.2153228070839 | etot = -14.6175140349633 +465000 ekin = 0.201776197881055 | erot = 0.385763783461981 | epot = -15.205054016266 | etot = -14.617514034923 +466000 ekin = 0.198330130961163 | erot = 0.379139817336875 | epot = -15.1949839831792 | etot = -14.6175140348812 +467000 ekin = 0.195213224017084 | erot = 0.373028711257248 | epot = -15.1857559701149 | etot = -14.6175140348406 +468000 ekin = 0.192562810062079 | erot = 0.367919448414624 | epot = -15.1779962932805 | etot = -14.6175140348038 +469000 ekin = 0.190499545154634 | erot = 0.364261004085315 | epot = -15.1722745840127 | etot = -14.6175140347728 +470000 ekin = 0.189122086032537 | erot = 0.362436180586744 | epot = -15.1690723013681 | etot = -14.6175140347488 +471000 ekin = 0.188506156938585 | erot = 0.362741456207124 | epot = -15.1687616478783 | etot = -14.6175140347325 +472000 ekin = 0.188707621222025 | erot = 0.365373993438314 | epot = -15.1715956493842 | etot = -14.6175140347239 +473000 ekin = 0.189768618621823 | erot = 0.370426120543997 | epot = -15.1777087738881 | etot = -14.6175140347222 +474000 ekin = 0.191725397341228 | erot = 0.377886798112909 | epot = -15.1871262301805 | etot = -14.6175140347264 +475000 ekin = 0.194616213070748 | erot = 0.387648901412907 | epot = -15.1997791492191 | etot = -14.6175140347355 +476000 ekin = 0.19848763616064 | erot = 0.39952067815615 | epot = -15.2155223490651 | etot = -14.6175140347483 +477000 ekin = 0.203397790429832 | erot = 0.413239540255182 | epot = -15.2341513654491 | etot = -14.6175140347641 +478000 ekin = 0.209415519783212 | erot = 0.428486466927375 | epot = -15.2554160214929 | etot = -14.6175140347823 +479000 ekin = 0.216615156594683 | erot = 0.444899686772466 | epot = -15.2790288781699 | etot = -14.6175140348028 +480000 ekin = 0.225067223157677 | erot = 0.462086880018489 | epot = -15.3046681380017 | etot = -14.6175140348255 +481000 ekin = 0.234826185147703 | erot = 0.479635803739713 | epot = -15.3319760237384 | etot = -14.617514034851 +482000 ekin = 0.245916939355107 | erot = 0.497123799838186 | epot = -15.3605547740726 | etot = -14.6175140348793 +483000 ekin = 0.258322039580648 | erot = 0.514126984881418 | epot = -15.3899630593725 | etot = -14.6175140349104 +484000 ekin = 0.27197166705463 | erot = 0.530229960568927 | epot = -15.4197156625676 | etot = -14.6175140349441 +485000 ekin = 0.286738030809397 | erot = 0.545036619609846 | epot = -15.4492886853987 | etot = -14.6175140349795 +486000 ekin = 0.302435294441744 | erot = 0.55818212519067 | epot = -15.4781314546478 | etot = -14.6175140350154 +487000 ekin = 0.31882536985775 | erot = 0.569345540302742 | epot = -15.5056849452109 | etot = -14.6175140350504 +488000 ekin = 0.33562912085568 | erot = 0.578262027782569 | epot = -15.531405183721 | etot = -14.6175140350828 +489000 ekin = 0.352541803824768 | erot = 0.584733173542191 | epot = -15.5547890124778 | etot = -14.6175140351108 +490000 ekin = 0.369251041132819 | erot = 0.588633902375943 | epot = -15.575398978642 | etot = -14.6175140351332 +491000 ekin = 0.38545533994301 | erot = 0.589914693969638 | epot = -15.5928840690618 | etot = -14.6175140351491 +492000 ekin = 0.400881156477994 | erot = 0.588598334680196 | epot = -15.6069935263164 | etot = -14.6175140351582 +493000 ekin = 0.41529674637658 | erot = 0.584771169136983 | epot = -15.6175819506742 | etot = -14.6175140351607 +494000 ekin = 0.42852150310201 | erot = 0.578569614095072 | epot = -15.6246051523544 | etot = -14.6175140351573 +495000 ekin = 0.440430011857935 | erot = 0.570163426567811 | epot = -15.6281074735753 | etot = -14.6175140351496 +496000 ekin = 0.45095070631601 | erot = 0.559737766476832 | epot = -15.6282025079316 | etot = -14.6175140351387 +497000 ekin = 0.460059581797609 | erot = 0.547476355485017 | epot = -15.6250499724091 | etot = -14.6175140351264 +498000 ekin = 0.467769906491902 | erot = 0.533547985554597 | epot = -15.6188319271606 | etot = -14.6175140351141 +499000 ekin = 0.474119221072851 | erot = 0.51809827733209 | epot = -15.6097315335077 | etot = -14.6175140351027 +500000 ekin = 0.47915510663515 | erot = 0.501247978936972 | epot = -15.5979171206651 | etot = -14.617514035093 +501000 ekin = 0.482921233339145 | erot = 0.48309830408219 | epot = -15.5835335725062 | etot = -14.6175140350848 +502000 ekin = 0.485445093649468 | erot = 0.463742920559152 | epot = -15.5667020492864 | etot = -14.6175140350778 +503000 ekin = 0.486728599210218 | erot = 0.443285305605287 | epot = -15.5475279398865 | etot = -14.617514035071 +504000 ekin = 0.486742408088666 | erot = 0.421859374631512 | epot = -15.5261158177833 | etot = -14.6175140350632 +505000 ekin = 0.485424480828576 | erot = 0.399650657767878 | epot = -15.5025891736495 | etot = -14.617514035053 +506000 ekin = 0.482682973412862 | erot = 0.376914939267073 | epot = -15.4771119477192 | etot = -14.6175140350392 +507000 ekin = 0.478403198155678 | erot = 0.353991273960951 | epot = -15.4499085071374 | etot = -14.6175140350208 +508000 ekin = 0.472458052936543 | erot = 0.331306710133899 | epot = -15.4212787980677 | etot = -14.6175140349973 +509000 ekin = 0.464721062856492 | erot = 0.309370883447797 | epot = -15.3916059812731 | etot = -14.6175140349688 +510000 ekin = 0.455081004105159 | erot = 0.288759823578861 | epot = -15.3613548626198 | etot = -14.6175140349358 +511000 ekin = 0.443456979181393 | erot = 0.270089690707588 | epot = -15.3310607047887 | etot = -14.6175140348997 +512000 ekin = 0.42981284822046 | erot = 0.253982534898902 | epot = -15.3013094179813 | etot = -14.6175140348619 +513000 ekin = 0.414169942619743 | erot = 0.241027258547542 | epot = -15.2727112359918 | etot = -14.6175140348246 +514000 ekin = 0.396617122320061 | erot = 0.231739657368506 | epot = -15.2458708144779 | etot = -14.6175140347893 +515000 ekin = 0.377317407139222 | erot = 0.226525548757325 | epot = -15.2213569906545 | etot = -14.6175140347579 +516000 ekin = 0.356510629533878 | erot = 0.225650587239722 | epot = -15.1996752515054 | etot = -14.6175140347318 +517000 ekin = 0.334511811731657 | erot = 0.2292195098864 | epot = -15.1812453563299 | etot = -14.6175140347119 +518000 ekin = 0.311705249159968 | erot = 0.237166415926506 | epot = -15.1663856997852 | etot = -14.6175140346987 +519000 ekin = 0.288534562405324 | erot = 0.249256456193412 | epot = -15.1553050532911 | etot = -14.6175140346924 +520000 ekin = 0.265489234982117 | erot = 0.265098165450665 | epot = -15.1481014351253 | etot = -14.6175140346926 +521000 ekin = 0.243088358087376 | erot = 0.28416474515935 | epot = -15.1447671379453 | etot = -14.6175140346986 +522000 ekin = 0.221862437060409 | erot = 0.305821970139557 | epot = -15.1451984419098 | etot = -14.6175140347099 +523000 ekin = 0.202334169775844 | erot = 0.329360070796281 | epot = -15.1492082752976 | etot = -14.6175140347255 +524000 ekin = 0.18499909107587 | erot = 0.354026911469942 | epot = -15.1565400372904 | etot = -14.6175140347446 +525000 ekin = 0.170306912739125 | erot = 0.379059948770509 | epot = -15.1668808962761 | etot = -14.6175140347665 +526000 ekin = 0.158644243148338 | erot = 0.403715126924459 | epot = -15.1798734048633 | etot = -14.6175140347905 +527000 ekin = 0.150319367666652 | erot = 0.427291025811595 | epot = -15.1951244282948 | etot = -14.6175140348166 +528000 ekin = 0.145549592055536 | erot = 0.449147424932796 | epot = -15.2122110518326 | etot = -14.6175140348442 +529000 ekin = 0.144451603985221 | erot = 0.468718121850073 | epot = -15.2306837607087 | etot = -14.6175140348734 +530000 ekin = 0.14703526713895 | erot = 0.485518371010905 | epot = -15.2500676730542 | etot = -14.6175140349043 +531000 ekin = 0.153201203685084 | erot = 0.499147835496798 | epot = -15.2698630741185 | etot = -14.6175140349366 +532000 ekin = 0.162742448480689 | erot = 0.509290301682419 | epot = -15.2895467851334 | etot = -14.6175140349703 +533000 ekin = 0.175350354883052 | erot = 0.515711587206659 | epot = -15.3085759770945 | etot = -14.6175140350048 +534000 ekin = 0.190624856014791 | erot = 0.518257146630773 | epot = -15.3263960376849 | etot = -14.6175140350393 +535000 ekin = 0.2080884935382 | erot = 0.516850140105121 | epot = -15.342452668716 | etot = -14.6175140350727 +536000 ekin = 0.227204325844129 | erot = 0.511491240066285 | epot = -15.356209601014 | etot = -14.6175140351035 +537000 ekin = 0.247396768814447 | erot = 0.502260311074919 | epot = -15.3671711150196 | etot = -14.6175140351302 +538000 ekin = 0.268074342414832 | erot = 0.489319600962367 | epot = -15.374907978528 | etot = -14.6175140351508 +539000 ekin = 0.288653182934819 | erot = 0.472917679673217 | epot = -15.3790848977717 | etot = -14.6175140351637 +540000 ekin = 0.308579985827036 | erot = 0.453392904740712 | epot = -15.3794869257353 | etot = -14.6175140351676 +541000 ekin = 0.32735300819234 | erot = 0.431174973012169 | epot = -15.3760420163656 | etot = -14.6175140351611 +542000 ekin = 0.344539853507862 | erot = 0.406783142890278 | epot = -15.368837031542 | etot = -14.6175140351439 +543000 ekin = 0.359790986514659 | erot = 0.380819988065077 | epot = -15.3581250096959 | etot = -14.6175140351161 +544000 ekin = 0.372848263091261 | erot = 0.353960030673725 | epot = -15.3443223288437 | etot = -14.6175140350787 +545000 ekin = 0.383548167009949 | erot = 0.326933212483018 | epot = -15.3279954145262 | etot = -14.6175140350332 +546000 ekin = 0.391819867385597 | erot = 0.30050378423916 | epot = -15.3098376866063 | etot = -14.6175140349815 +547000 ekin = 0.397678590181961 | erot = 0.275445713888184 | epot = -15.2906383389964 | etot = -14.6175140349263 +548000 ekin = 0.401215088504123 | erot = 0.252516050367 | epot = -15.2712451737411 | etot = -14.6175140348699 +549000 ekin = 0.402582175511822 | erot = 0.232427794768509 | epot = -15.2525240050958 | etot = -14.6175140348155 +550000 ekin = 0.401979352686767 | erot = 0.215823740833757 | epot = -15.2353171282858 | etot = -14.6175140347652 +551000 ekin = 0.399636550192594 | erot = 0.203252510910356 | epot = -15.2204030958242 | etot = -14.6175140347213 +552000 ekin = 0.39579793483933 | erot = 0.19514771457426 | epot = -15.2084596840996 | etot = -14.617514034686 +553000 ekin = 0.390706676474511 | erot = 0.191810879117678 | epot = -15.2000315902533 | etot = -14.6175140346611 +554000 ekin = 0.384591526956334 | erot = 0.193398609454572 | epot = -15.1955041710586 | etot = -14.6175140346477 +555000 ekin = 0.37765606833088 | erot = 0.19991436289407 | epot = -15.1950844658717 | etot = -14.6175140346467 +556000 ekin = 0.370071512613894 | erot = 0.211205266307038 | epot = -15.1987908135787 | etot = -14.6175140346578 +557000 ekin = 0.361973939271072 | erot = 0.22696451510277 | epot = -15.2064524890543 | etot = -14.6175140346805 +558000 ekin = 0.353466765019157 | erot = 0.246739996101886 | epot = -15.2177207958342 | etot = -14.6175140347132 +559000 ekin = 0.344628961763677 | erot = 0.269949765670226 | epot = -15.2320927621875 | etot = -14.6175140347536 +560000 ekin = 0.335528980566657 | erot = 0.295904778795777 | epot = -15.2489477941611 | etot = -14.6175140347987 +561000 ekin = 0.326243446080443 | erot = 0.323838714908469 | epot = -15.2675961958334 | etot = -14.6175140348445 +562000 ekin = 0.31687848681263 | erot = 0.35294385755285 | epot = -15.2873363792525 | etot = -14.617514034887 +563000 ekin = 0.307590234581101 | erot = 0.382410843957197 | epot = -15.3075151134611 | etot = -14.6175140349228 +564000 ekin = 0.298599911427017 | erot = 0.411468934029061 | epot = -15.3275828804049 | etot = -14.6175140349488 +565000 ekin = 0.290198521501092 | erot = 0.439422606477171 | epot = -15.3471351629423 | etot = -14.617514034964 +566000 ekin = 0.282736992095573 | erot = 0.46568015891933 | epot = -15.365931185984 | etot = -14.6175140349691 +567000 ekin = 0.276599956454062 | erot = 0.489770841522339 | epot = -15.3838848329429 | etot = -14.6175140349665 +568000 ekin = 0.272165052790826 | erot = 0.511348887820125 | epot = -15.4010279755712 | etot = -14.6175140349602 +569000 ekin = 0.269753809413461 | erot = 0.530185258476706 | epot = -15.4174531028449 | etot = -14.6175140349547 +570000 ekin = 0.269583567607582 | erot = 0.546150320474166 | epot = -15.4332479230358 | etot = -14.617514034954 +571000 ekin = 0.271731068578169 | erot = 0.559192265325146 | epot = -15.4484373688639 | etot = -14.6175140349606 +572000 ekin = 0.27611649568743 | erot = 0.569316321633573 | epot = -15.4629468522957 | etot = -14.6175140349747 +573000 ekin = 0.282512256444883 | erot = 0.576569321997748 | epot = -15.4765956134373 | etot = -14.6175140349947 +574000 ekin = 0.290574483947772 | erot = 0.581030490761115 | epot = -15.4891190097262 | etot = -14.6175140350173 +575000 ekin = 0.299890113326873 | erot = 0.582808418137228 | epot = -15.5002125665028 | etot = -14.6175140350387 +576000 ekin = 0.310029076131071 | erot = 0.582041678954515 | epot = -15.5095847901411 | etot = -14.6175140350555 +577000 ekin = 0.320591144135804 | erot = 0.578899817193121 | epot = -15.5170049963945 | etot = -14.6175140350656 +578000 ekin = 0.331239680817777 | erot = 0.573581904321184 | epot = -15.5223356202071 | etot = -14.6175140350681 +579000 ekin = 0.341718767395671 | erot = 0.566311213814667 | epot = -15.5255440162741 | etot = -14.6175140350637 +580000 ekin = 0.351854361646072 | erot = 0.557326170820678 | epot = -15.5266945675208 | etot = -14.6175140350541 +581000 ekin = 0.361543170719775 | erot = 0.54686904311153 | epot = -15.5259262488726 | etot = -14.6175140350413 +582000 ekin = 0.370734291431498 | erot = 0.535174473618245 | epot = -15.5234228000773 | etot = -14.6175140350275 +583000 ekin = 0.37940854514609 | erot = 0.522459863754552 | epot = -15.5193824439152 | etot = -14.6175140350145 +584000 ekin = 0.38755933833177 | erot = 0.50891899994006 | epot = -15.5139923732754 | etot = -14.6175140350036 +585000 ekin = 0.395177418309126 | erot = 0.494719483695348 | epot = -15.5074109369997 | etot = -14.6175140349952 +586000 ekin = 0.402240533516271 | erot = 0.480003760425467 | epot = -15.4997583289313 | etot = -14.6175140349896 +587000 ekin = 0.408707997144929 | erot = 0.464893014295021 | epot = -15.4911150464262 | etot = -14.6175140349863 +588000 ekin = 0.414519545772604 | erot = 0.449492951761529 | epot = -15.4815265325189 | etot = -14.6175140349848 +589000 ekin = 0.419597612554971 | erot = 0.433900487906506 | epot = -15.4710121354457 | etot = -14.6175140349842 +590000 ekin = 0.423852083806182 | erot = 0.418210489544302 | epot = -15.4595766083342 | etot = -14.6175140349837 +591000 ekin = 0.42718667151707 | erot = 0.402521929659384 | epot = -15.4472226361591 | etot = -14.6175140349827 +592000 ekin = 0.429506137373247 | erot = 0.386943005730352 | epot = -15.4339631780839 | etot = -14.6175140349803 +593000 ekin = 0.430723706116147 | erot = 0.371594936610811 | epot = -15.4198326777029 | etot = -14.617514034976 +594000 ekin = 0.430768094953345 | erot = 0.356614269838259 | epot = -15.4048963997609 | etot = -14.6175140349693 +595000 ekin = 0.429589664829847 | erot = 0.342153609171636 | epot = -15.3892573089616 | etot = -14.6175140349601 +596000 ekin = 0.427165296133148 | erot = 0.328380718542492 | epot = -15.3730600496239 | etot = -14.6175140349483 +597000 ekin = 0.42350165849966 | erot = 0.315475989403582 | epot = -15.3564916828373 | etot = -14.6175140349341 +598000 ekin = 0.418636501255305 | erot = 0.303628359581859 | epot = -15.339778895755 | etot = -14.6175140349179 +599000 ekin = 0.412638207582272 | erot = 0.293029673723798 | epot = -15.3231819162063 | etot = -14.6175140349002 +600000 ekin = 0.405603414753522 | erot = 0.28386763722636 | epot = -15.3069850868619 | etot = -14.617514034882 +601000 ekin = 0.397652939448492 | erot = 0.276317573361084 | epot = -15.2914845476736 | etot = -14.617514034864 +602000 ekin = 0.388926339151588 | erot = 0.270533300128844 | epot = -15.2769736741277 | etot = -14.6175140348473 +603000 ekin = 0.379575547710976 | erot = 0.266637582798786 | epot = -15.2637271653425 | etot = -14.6175140348328 +604000 ekin = 0.369758112224373 | erot = 0.264712769809576 | epot = -15.2519849168554 | etot = -14.6175140348215 +605000 ekin = 0.35963061496451 | erot = 0.264792359550224 | epot = -15.2419370093288 | etot = -14.6175140348141 +606000 ekin = 0.349342882571248 | erot = 0.266854337886836 | epot = -15.2337112552692 | etot = -14.6175140348112 +607000 ekin = 0.339033558751512 | erot = 0.270817131627415 | epot = -15.2273647251918 | etot = -14.6175140348128 +608000 ekin = 0.32882753825937 | erot = 0.276538908097057 | epot = -15.2228804811754 | etot = -14.617514034819 +609000 ekin = 0.318835621087622 | erot = 0.283820700144174 | epot = -15.2201703560608 | etot = -14.617514034829 +610000 ekin = 0.309156542568317 | erot = 0.292413461055651 | epot = -15.219084038466 | etot = -14.617514034842 +611000 ekin = 0.299881272108214 | erot = 0.302028697869802 | epot = -15.2194240048347 | etot = -14.6175140348566 +612000 ekin = 0.291099167856268 | erot = 0.312351863789569 | epot = -15.2209650665173 | etot = -14.6175140348715 +613000 ekin = 0.282905257831642 | erot = 0.323057294042038 | epot = -15.2234765867589 | etot = -14.6175140348852 +614000 ekin = 0.275407632339941 | erot = 0.333823223652897 | epot = -15.2267448908892 | etot = -14.6175140348963 +615000 ekin = 0.26873372556727 | erot = 0.344345386320857 | epot = -15.2305931467922 | etot = -14.6175140349041 +616000 ekin = 0.263034181136603 | erot = 0.354347879927045 | epot = -15.2348960959716 | etot = -14.617514034908 +617000 ekin = 0.258483071857928 | erot = 0.363590372787296 | epot = -15.2395874795532 | etot = -14.617514034908 +618000 ekin = 0.255273496413749 | erot = 0.371871254538884 | epot = -15.2446587858574 | etot = -14.6175140349047 +619000 ekin = 0.253608004174875 | erot = 0.379026921287401 | epot = -15.2501489603618 | etot = -14.6175140348996 +620000 ekin = 0.253683881422301 | erot = 0.384927934514049 | epot = -15.2561258508302 | etot = -14.6175140348939 +621000 ekin = 0.255674023710173 | erot = 0.389473226072584 | epot = -15.2626612846724 | etot = -14.6175140348896 +622000 ekin = 0.25970485336799 | erot = 0.392583779640473 | epot = -15.269802667897 | etot = -14.6175140348886 +623000 ekin = 0.265833429999859 | erot = 0.394197274406549 | epot = -15.2775447392987 | etot = -14.6175140348923 +624000 ekin = 0.274026439188702 | erot = 0.394265031625425 | epot = -15.2858055057161 | etot = -14.6175140349019 +625000 ekin = 0.28414401573885 | erot = 0.392752285177019 | epot = -15.2944103358336 | etot = -14.6175140349177 +626000 ekin = 0.295931256226573 | erot = 0.389642344381245 | epot = -15.303087635547 | etot = -14.6175140349392 +627000 ekin = 0.309019727830035 | erot = 0.384944676505037 | epot = -15.3114784393 | etot = -14.6175140349649 +628000 ekin = 0.322940275279346 | erot = 0.378706350960174 | epot = -15.3191606612318 | etot = -14.6175140349923 +629000 ekin = 0.337147043698441 | erot = 0.371025698974895 | epot = -15.3256867776918 | etot = -14.6175140350184 +630000 ekin = 0.351051052995002 | erot = 0.362066500827022 | epot = -15.330631588862 | etot = -14.61751403504 +631000 ekin = 0.364060148818953 | erot = 0.352070586246035 | epot = -15.3336447701185 | etot = -14.6175140350535 +632000 ekin = 0.375621025661416 | erot = 0.341366514681189 | epot = -15.334501575399 | etot = -14.6175140350563 +633000 ekin = 0.385258541224309 | erot = 0.330372092305621 | epot = -15.3331446685767 | etot = -14.6175140350468 +634000 ekin = 0.392607865616072 | erot = 0.319588956493667 | epot = -15.329710857134 | etot = -14.6175140350243 +635000 ekin = 0.397436097277817 | erot = 0.309588318033289 | epot = -15.3245384503008 | etot = -14.6175140349897 +636000 ekin = 0.399651602684335 | erot = 0.300988094378234 | epot = -15.3181537320079 | etot = -14.6175140349453 +637000 ekin = 0.399301141331978 | erot = 0.294422893568735 | epot = -15.3112380697947 | etot = -14.617514034894 +638000 ekin = 0.396556439146157 | erot = 0.290509369489293 | epot = -15.3045798434752 | etot = -14.6175140348397 +639000 ekin = 0.391692975512685 | erot = 0.289810143796979 | epot = -15.2990171540957 | etot = -14.6175140347861 +640000 ekin = 0.385064212932825 | erot = 0.29279965311316 | epot = -15.2953779007829 | etot = -14.6175140347369 +641000 ekin = 0.377074355549984 | erot = 0.299834934662478 | epot = -15.2944233249076 | etot = -14.6175140346951 +642000 ekin = 0.368152133960252 | erot = 0.311133625025682 | epot = -15.2967997936491 | etot = -14.6175140346632 +643000 ekin = 0.35872729827394 | erot = 0.326760494743215 | epot = -15.3030018276596 | etot = -14.6175140346425 +644000 ekin = 0.349210670242454 | erot = 0.346622862553666 | epot = -15.3133475674301 | etot = -14.6175140346339 +645000 ekin = 0.339977915473995 | erot = 0.370474376279531 | epot = -15.3279663263912 | etot = -14.6175140346376 +646000 ekin = 0.331356734048571 | erot = 0.397926004728945 | epot = -15.3467967734306 | etot = -14.6175140346531 +647000 ekin = 0.323616951061498 | erot = 0.428462692621698 | epot = -15.3695936783626 | etot = -14.6175140346794 +648000 ekin = 0.316962984679426 | erot = 0.461463981263885 | epot = -15.395941000659 | etot = -14.6175140347157 +649000 ekin = 0.311528303721651 | erot = 0.496226945505972 | epot = -15.4252692839882 | etot = -14.6175140347606 +650000 ekin = 0.307371814502134 | erot = 0.531990113311391 | epot = -15.4568759626263 | etot = -14.6175140348127 +651000 ekin = 0.304476169211803 | erot = 0.567957247022998 | epot = -15.4899474511054 | etot = -14.6175140348706 +652000 ekin = 0.302748327843514 | erot = 0.603320352538697 | epot = -15.5235827153148 | etot = -14.6175140349326 +653000 ekin = 0.302022769690169 | erot = 0.637281675063339 | epot = -15.5568184797505 | etot = -14.617514034997 +654000 ekin = 0.302067723594894 | erot = 0.669074745115614 | epot = -15.5886565037725 | etot = -14.617514035062 +655000 ekin = 0.30259467177562 | erot = 0.697984728109731 | epot = -15.6180934350106 | etot = -14.6175140351253 +656000 ekin = 0.30327116127458 | erot = 0.723368330431443 | epot = -15.6441535268905 | etot = -14.6175140351845 +657000 ekin = 0.303736663271753 | erot = 0.744673311811842 | epot = -15.665924010321 | etot = -14.6175140352374 +658000 ekin = 0.303620889263354 | erot = 0.761457272709825 | epot = -15.6825921972547 | etot = -14.6175140352815 +659000 ekin = 0.302563666908929 | erot = 0.773404945480537 | epot = -15.6934826477038 | etot = -14.6175140353143 +660000 ekin = 0.300235395695977 | erot = 0.780343280385416 | epot = -15.6980927114156 | etot = -14.6175140353342 +661000 ekin = 0.2963557105327 | erot = 0.782250083092817 | epot = -15.6961198289653 | etot = -14.6175140353398 +662000 ekin = 0.290710478297869 | erot = 0.779257959177475 | epot = -15.6874824728057 | etot = -14.6175140353303 +663000 ekin = 0.283165147464189 | erot = 0.771650651991606 | epot = -15.672329834762 | etot = -14.6175140353062 +664000 ekin = 0.27367342717685 | erot = 0.75985056245593 | epot = -15.6510380249012 | etot = -14.6175140352684 +665000 ekin = 0.262280913452633 | erot = 0.744397727319261 | epot = -15.6241926759909 | etot = -14.617514035219 +666000 ekin = 0.249123647022576 | erot = 0.725921231745041 | epot = -15.5925589139283 | etot = -14.6175140351607 +667000 ekin = 0.234422061210095 | erot = 0.705104954965518 | epot = -15.5570410512721 | etot = -14.6175140350965 +668000 ekin = 0.218471158369142 | erot = 0.682650243125394 | epot = -15.5186354365242 | etot = -14.6175140350297 +669000 ekin = 0.201627981911554 | erot = 0.659238455807285 | epot = -15.4783804726821 | etot = -14.6175140349633 +670000 ekin = 0.184297501938695 | erot = 0.635496303881749 | epot = -15.4373078407206 | etot = -14.6175140349002 +671000 ekin = 0.166917915804586 | erot = 0.611966525748987 | epot = -15.3963984763963 | etot = -14.6175140348427 +672000 ekin = 0.149946120673763 | erot = 0.589085832362546 | epot = -15.3565459878289 | etot = -14.6175140347926 +673000 ekin = 0.133843801904168 | erot = 0.567171306813735 | epot = -15.3185291434688 | etot = -14.6175140347509 +674000 ekin = 0.119064262674211 | erot = 0.546415679822031 | epot = -15.2829939772145 | etot = -14.6175140347182 +675000 ekin = 0.106039855016797 | erot = 0.526891195483695 | epot = -15.250445085195 | etot = -14.6175140346945 +676000 ekin = 0.0951697078771964 | erot = 0.508561175679673 | epot = -15.2212449182363 | etot = -14.6175140346794 +677000 ekin = 0.0868074519861108 | erot = 0.491297978911151 | epot = -15.1956194655695 | etot = -14.6175140346723 +678000 ekin = 0.0812485969713162 | erot = 0.47490530110032 | epot = -15.173667932744 | etot = -14.6175140346723 +679000 ekin = 0.0787177619801643 | erot = 0.459143233465844 | epot = -15.1553750301248 | etot = -14.6175140346788 +680000 ekin = 0.079356202465094 | erot = 0.443753980650321 | epot = -15.1406242178063 | etot = -14.6175140346909 +681000 ekin = 0.0832104900793129 | erot = 0.428486254342671 | epot = -15.1292107791298 | etot = -14.6175140347078 +682000 ekin = 0.0902236865228784 | erot = 0.41311688093406 | epot = -15.1208546021859 | etot = -14.617514034729 +683000 ekin = 0.100230543462783 | erot = 0.397468585264983 | epot = -15.1152131634811 | etot = -14.6175140347533 +684000 ekin = 0.112958164259223 | erot = 0.38142345901904 | epot = -15.1118956580582 | etot = -14.61751403478 +685000 ekin = 0.128033094046448 | erot = 0.364932120277571 | epot = -15.1104792491317 | etot = -14.6175140348077 +686000 ekin = 0.144995008361815 | erot = 0.348018922992721 | epot = -15.1105279661897 | etot = -14.6175140348351 +687000 ekin = 0.163316207854869 | erot = 0.330783730220898 | epot = -15.1116139729366 | etot = -14.6175140348608 +688000 ekin = 0.18242523421552 | erot = 0.313400732953528 | epot = -15.1133400020522 | etot = -14.6175140348832 +689000 ekin = 0.201732335852404 | erot = 0.296114640200911 | epot = -15.1153610109544 | etot = -14.6175140349011 +690000 ekin = 0.220654383890837 | erot = 0.2792343742397 | epot = -15.1174027930443 | etot = -14.6175140349138 +691000 ekin = 0.238637189924079 | erot = 0.263124260135935 | epot = -15.1192754849806 | etot = -14.6175140349206 +692000 ekin = 0.255173895595862 | erot = 0.248192653896372 | epot = -15.120880584414 | etot = -14.6175140349217 +693000 ekin = 0.269818995117389 | erot = 0.23487802400786 | epot = -15.1222110540428 | etot = -14.6175140349175 +694000 ekin = 0.282198402188406 | erot = 0.223632668705058 | epot = -15.1233451058024 | etot = -14.6175140349089 +695000 ekin = 0.292016609392508 | erot = 0.214904477347547 | epot = -15.1244351216369 | etot = -14.6175140348968 +696000 ekin = 0.299062308190414 | erot = 0.209117382946464 | epot = -15.125693726019 | etot = -14.6175140348821 +697000 ekin = 0.303213809971508 | erot = 0.20665136156702 | epot = -15.1273792064044 | etot = -14.6175140348658 +698000 ekin = 0.304445256191661 | erot = 0.207822979228463 | epot = -15.1297822702686 | etot = -14.6175140348484 +699000 ekin = 0.302833983904557 | erot = 0.212867544423975 | epot = -15.133215563159 | etot = -14.6175140348305 +700000 ekin = 0.298568596343091 | erot = 0.221923881122192 | epot = -15.1380065122771 | etot = -14.6175140348118 +701000 ekin = 0.291956369738192 | erot = 0.235022588975887 | epot = -15.1444929935065 | etot = -14.6175140347924 +702000 ekin = 0.283427734153971 | erot = 0.252078414120766 | epot = -15.1530201830474 | etot = -14.6175140347727 +703000 ekin = 0.273534855577063 | erot = 0.272887068860917 | epot = -15.1639359591908 | etot = -14.6175140347528 +704000 ekin = 0.262941046164718 | erot = 0.297126498876258 | epot = -15.1775815797747 | etot = -14.6175140347337 +705000 ekin = 0.252398060444993 | erot = 0.324362359960494 | epot = -15.1942744551228 | etot = -14.6175140347173 +706000 ekin = 0.242709489752809 | erot = 0.35405734989386 | epot = -15.2142808743525 | etot = -14.6175140347058 +707000 ekin = 0.23468046525944 | erot = 0.385584073394854 | epot = -15.2377785733566 | etot = -14.6175140347023 +708000 ekin = 0.229056562326985 | erot = 0.418241319395694 | epot = -15.2648119164327 | etot = -14.61751403471 +709000 ekin = 0.226457657534062 | erot = 0.451273895784643 | epot = -15.2952455880503 | etot = -14.6175140347316 +710000 ekin = 0.227314828596047 | erot = 0.483896330832059 | epot = -15.3287251941968 | etot = -14.6175140347687 +711000 ekin = 0.231819479497758 | erot = 0.51532074217238 | epot = -15.3646542564917 | etot = -14.6175140348216 +712000 ekin = 0.239893150549453 | erot = 0.544788749313893 | epot = -15.4021959347515 | etot = -14.6175140348881 +713000 ekin = 0.251183758823612 | erot = 0.571606341189966 | epot = -15.4403041349782 | etot = -14.6175140349646 +714000 ekin = 0.265090036185669 | erot = 0.595179886373849 | epot = -15.4777839576048 | etot = -14.6175140350453 +715000 ekin = 0.280811306968513 | erot = 0.615050345045216 | epot = -15.5133756871376 | etot = -14.6175140351238 +716000 ekin = 0.297415784950172 | erot = 0.63092216570443 | epot = -15.5458519858484 | etot = -14.6175140351938 +717000 ekin = 0.313918116237496 | erot = 0.642683345317361 | epot = -15.5741154968044 | etot = -14.6175140352495 +718000 ekin = 0.329356373326515 | erot = 0.650413757300699 | epot = -15.597284165914 | etot = -14.6175140352868 +719000 ekin = 0.342860093483698 | erot = 0.654380316354833 | epot = -15.6147544451418 | etot = -14.6175140353033 +720000 ekin = 0.353703497402146 | erot = 0.655019233384794 | epot = -15.6262367660857 | etot = -14.6175140352987 +721000 ekin = 0.361340844904821 | erot = 0.652906431496425 | epot = -15.6317613116759 | etot = -14.6175140352746 +722000 ekin = 0.365423978940444 | erot = 0.648719378780955 | epot = -15.6316573929551 | etot = -14.6175140352337 +723000 ekin = 0.365803989071099 | erot = 0.643193727890457 | epot = -15.6265117521414 | etot = -14.6175140351799 +724000 ekin = 0.362520178744054 | erot = 0.637078359572984 | epot = -15.6171125734343 | etot = -14.6175140351172 +725000 ekin = 0.355779938479084 | erot = 0.631092082280464 | epot = -15.6043860558097 | etot = -14.6175140350502 +726000 ekin = 0.345932952940548 | erot = 0.625884613514222 | epot = -15.5893316014373 | etot = -14.6175140349826 +727000 ekin = 0.333442641404433 | erot = 0.622003743386452 | epot = -15.572960419709 | etot = -14.6175140349181 +728000 ekin = 0.31885705049608 | erot = 0.619869891937983 | epot = -15.5562409772938 | etot = -14.6175140348597 +729000 ekin = 0.30278072495631 | erot = 0.61975869169039 | epot = -15.5400534514564 | etot = -14.6175140348097 +730000 ekin = 0.285848455040377 | erot = 0.621791770571061 | epot = -15.5251542603808 | etot = -14.6175140347694 +731000 ekin = 0.26870127220438 | erot = 0.625935552811994 | epot = -15.5121508597562 | etot = -14.6175140347399 +732000 ekin = 0.251964649663544 | erot = 0.632007594592584 | epot = -15.5014862789777 | etot = -14.6175140347215 +733000 ekin = 0.236228569496369 | erot = 0.639689689353592 | epot = -15.4934322935641 | etot = -14.6175140347141 +734000 ekin = 0.2220289607466 | erot = 0.64854669871573 | epot = -15.4880896941798 | etot = -14.6175140347175 +735000 ekin = 0.209830023527896 | erot = 0.658049804518268 | epot = -15.4853938627768 | etot = -14.6175140347306 +736000 ekin = 0.20000716676131 | erot = 0.667602683400117 | epot = -15.4851238849144 | etot = -14.6175140347529 +737000 ekin = 0.192830719625365 | erot = 0.676569044421737 | epot = -15.4869137988309 | etot = -14.6175140347838 +738000 ekin = 0.188451200585985 | erot = 0.684300102138329 | epot = -15.4902653375465 | etot = -14.6175140348222 +739000 ekin = 0.186887639937117 | erot = 0.6901609006521 | epot = -15.4945625754563 | etot = -14.6175140348671 +740000 ekin = 0.18802106841102 | erot = 0.693554915035337 | epot = -15.4990900183636 | etot = -14.6175140349173 +741000 ekin = 0.191595568995591 | erot = 0.693946922730827 | epot = -15.5030565266968 | etot = -14.6175140349704 +742000 ekin = 0.197228843628703 | erot = 0.690884208638806 | epot = -15.5056270872919 | etot = -14.6175140350244 +743000 ekin = 0.204433503637974 | erot = 0.684016821527692 | epot = -15.5059643602413 | etot = -14.6175140350756 +744000 ekin = 0.212648433381792 | erot = 0.673116668202608 | epot = -15.503279136705 | etot = -14.6175140351206 +745000 ekin = 0.221277722248228 | erot = 0.658094727364962 | epot = -15.4968864847688 | etot = -14.6175140351556 +746000 ekin = 0.229733012317398 | erot = 0.639014583780834 | epot = -15.4862616312757 | etot = -14.6175140351775 +747000 ekin = 0.23747404414407 | erot = 0.616100096672176 | epot = -15.4710881760002 | etot = -14.6175140351839 +748000 ekin = 0.244042266762415 | erot = 0.589734872786552 | epot = -15.4512911747231 | etot = -14.6175140351741 +749000 ekin = 0.249083597952522 | erot = 0.560451518402465 | epot = -15.4270491515038 | etot = -14.6175140351488 +750000 ekin = 0.25235833014632 | erot = 0.528910066810374 | epot = -15.3987824320668 | etot = -14.6175140351102 +751000 ekin = 0.253738423480709 | erot = 0.495866496253692 | epot = -15.3671189547962 | etot = -14.6175140350618 +752000 ekin = 0.253194394014668 | erot = 0.462133785332355 | epot = -15.3328422143545 | etot = -14.6175140350075 +753000 ekin = 0.250775308154698 | erot = 0.428539072349797 | epot = -15.2968284154564 | etot = -14.6175140349519 +754000 ekin = 0.246585878545855 | erot = 0.395880964578259 | epot = -15.2599808780229 | etot = -14.6175140348988 +755000 ekin = 0.240764398112151 | erot = 0.364890850085332 | epot = -15.2231692830489 | etot = -14.6175140348514 +756000 ekin = 0.233464471042371 | erot = 0.33620133003052 | epot = -15.1871798358848 | etot = -14.6175140348119 +757000 ekin = 0.224842467157428 | erot = 0.310323830730607 | epot = -15.1526803326694 | etot = -14.6175140347814 +758000 ekin = 0.215051562420606 | erot = 0.287636293953365 | epot = -15.1202018911339 | etot = -14.61751403476 +759000 ekin = 0.204242275875609 | erot = 0.268380753510832 | epot = -15.090137064133 | etot = -14.6175140347465 +760000 ekin = 0.192568636064991 | erot = 0.252669695564108 | epot = -15.0627523663688 | etot = -14.6175140347397 +761000 ekin = 0.180198520175589 | erot = 0.240499428913179 | epot = -15.038211983826 | etot = -14.6175140347373 +762000 ekin = 0.167326299029085 | erot = 0.231768292969539 | epot = -15.0166086267357 | etot = -14.617514034737 +763000 ekin = 0.15418568590204 | erot = 0.226297425418118 | epot = -14.997997146057 | etot = -14.6175140347368 +764000 ekin = 0.141060632749147 | erot = 0.223852003350697 | epot = -14.9824266708347 | etot = -14.6175140347349 +765000 ekin = 0.128292252297103 | erot = 0.224161332820243 | epot = -14.9699676198474 | etot = -14.61751403473 +766000 ekin = 0.116280064488639 | erot = 0.226936813025351 | epot = -14.9607309122354 | etot = -14.6175140347214 +767000 ekin = 0.105476340627594 | erot = 0.231887507272404 | epot = -14.9548778826094 | etot = -14.6175140347094 +768000 ekin = 0.0963728909465988 | erot = 0.23873364134698 | epot = -14.952620566988 | etot = -14.6175140346944 +769000 ekin = 0.0894802427438104 | erot = 0.247218655410706 | epot = -14.9542129328319 | etot = -14.6175140346774 +770000 ekin = 0.0852997361098734 | erot = 0.257120353609604 | epot = -14.9599341243794 | etot = -14.6175140346599 +771000 ekin = 0.0842896183574806 | erot = 0.268261228609983 | epot = -14.9700648816113 | etot = -14.6175140346438 +772000 ekin = 0.0868267987479503 | erot = 0.280517313420827 | epot = -14.9848581468001 | etot = -14.6175140346313 +773000 ekin = 0.0931666172479738 | erot = 0.29382416266062 | epot = -15.0045048145334 | etot = -14.6175140346248 +774000 ekin = 0.103403843826315 | erot = 0.308178073397328 | epot = -15.0290959518505 | etot = -14.6175140346269 +775000 ekin = 0.117439110045059 | erot = 0.323630675217718 | epot = -15.0585838199028 | etot = -14.61751403464 +776000 ekin = 0.134955835364923 | erot = 0.340275613675133 | epot = -15.0927454837062 | etot = -14.6175140346661 +777000 ekin = 0.155413263634583 | erot = 0.3582278427454 | epot = -15.1311551410863 | etot = -14.6175140347063 +778000 ekin = 0.178060391220183 | erot = 0.377596905888865 | epot = -15.1731713318691 | etot = -14.6175140347601 +779000 ekin = 0.201973803863677 | erot = 0.398457850157374 | epot = -15.2179456888463 | etot = -14.6175140348253 +780000 ekin = 0.226119091212116 | erot = 0.420824480237598 | epot = -15.2644576063476 | etot = -14.6175140348979 +781000 ekin = 0.249431156624362 | erot = 0.444629585314245 | epot = -15.3115747769111 | etot = -14.6175140349725 +782000 ekin = 0.27090447026737 | erot = 0.469715692367108 | epot = -15.3581341976774 | etot = -14.617514035043 +783000 ekin = 0.289681273781371 | erot = 0.495837747641005 | epot = -15.4030330565255 | etot = -14.6175140351031 +784000 ekin = 0.305125009984925 | erot = 0.522676532161846 | epot = -15.4453155772951 | etot = -14.6175140351483 +785000 ekin = 0.316868262921689 | erot = 0.549859353707494 | epot = -15.4842416518049 | etot = -14.6175140351757 +786000 ekin = 0.324828845887827 | erot = 0.57698331002341 | epot = -15.5193261910962 | etot = -14.617514035185 +787000 ekin = 0.32919323387832 | erot = 0.60363650580216 | epot = -15.5503437748586 | etot = -14.6175140351781 +788000 ekin = 0.33037186485146 | erot = 0.629413875564563 | epot = -15.5772997755749 | etot = -14.6175140351589 +789000 ekin = 0.328934711355184 | erot = 0.653926193133396 | epot = -15.6003749396209 | etot = -14.6175140351323 +790000 ekin = 0.325537319473833 | erot = 0.676802790007515 | epot = -15.619854144585 | etot = -14.6175140351037 +791000 ekin = 0.320847267933844 | erot = 0.697689943212853 | epot = -15.6360512462245 | etot = -14.6175140350778 +792000 ekin = 0.315479253540059 | erot = 0.716247584425432 | epot = -15.6492408730237 | etot = -14.6175140350582 +793000 ekin = 0.309944490982995 | erot = 0.732146955923568 | epot = -15.659605481954 | etot = -14.6175140350475 +794000 ekin = 0.304617480926279 | erot = 0.745071299200936 | epot = -15.6672028151733 | etot = -14.6175140350461 +795000 ekin = 0.299720880977542 | erot = 0.754720862086076 | epot = -15.6719557781174 | etot = -14.6175140350538 +796000 ekin = 0.295327396181288 | erot = 0.760822658788699 | epot = -15.6736640900385 | etot = -14.6175140350685 +797000 ekin = 0.291376296852734 | erot = 0.763144639346229 | epot = -15.6720349712862 | etot = -14.6175140350872 +798000 ekin = 0.287701294704638 | erot = 0.761513269132583 | epot = -15.6667285989436 | etot = -14.6175140351064 +799000 ekin = 0.284065979572969 | erot = 0.755832991337638 | epot = -15.6574130060325 | etot = -14.6175140351219 +800000 ekin = 0.280202790632173 | erot = 0.746105645864818 | epot = -15.6438224716274 | etot = -14.6175140351304 +801000 ekin = 0.275851560112921 | erot = 0.732447665813908 | epot = -15.6258132610552 | etot = -14.6175140351284 +802000 ekin = 0.270794034433598 | erot = 0.715102809072986 | epot = -15.6034108786203 | etot = -14.6175140351137 +803000 ekin = 0.264881442636211 | erot = 0.694448356025999 | epot = -15.5768438337475 | etot = -14.6175140350853 +804000 ekin = 0.258053167890611 | erot = 0.670993199746564 | epot = -15.5465604026803 | etot = -14.6175140350431 +805000 ekin = 0.250345604727777 | erot = 0.645366941436383 | epot = -15.5132265811527 | etot = -14.6175140349885 +806000 ekin = 0.241890533711227 | erot = 0.618299214643911 | epot = -15.4777037832789 | etot = -14.6175140349238 +807000 ekin = 0.232905655206386 | erot = 0.59059128773573 | epot = -15.4410109777945 | etot = -14.6175140348524 +808000 ekin = 0.223678061732307 | erot = 0.563080896687569 | epot = -15.404272993198 | etot = -14.6175140347781 +809000 ekin = 0.21454303522989 | erot = 0.536602758841035 | epot = -15.3686598287761 | etot = -14.6175140347052 +810000 ekin = 0.205860488312487 | erot = 0.511947500022813 | epot = -15.335322022973 | etot = -14.6175140346377 +811000 ekin = 0.197991117804985 | erot = 0.489821758276953 | epot = -15.3053269106614 | etot = -14.6175140345795 +812000 ekin = 0.191273941670598 | erot = 0.470812030933133 | epot = -15.2796000071373 | etot = -14.6175140345336 +813000 ekin = 0.18600640436918 | erot = 0.455354451061547 | epot = -15.2588748899335 | etot = -14.6175140345028 +814000 ekin = 0.182427753711695 | erot = 0.443712201373049 | epot = -15.2436539895733 | etot = -14.6175140344886 +815000 ekin = 0.180705986334899 | erot = 0.435961774090678 | epot = -15.2341817949176 | etot = -14.617514034492 +816000 ekin = 0.180928373605138 | erot = 0.431988814112469 | epot = -15.2304312222306 | etot = -14.617514034513 +817000 ekin = 0.183095431233989 | erot = 0.431493858262917 | epot = -15.2321033240477 | etot = -14.6175140345508 +818000 ekin = 0.187118173911423 | erot = 0.43400789506895 | epot = -15.2386401035843 | etot = -14.6175140346039 +819000 ekin = 0.192818568053485 | erot = 0.438917286806367 | epot = -15.2492498895297 | etot = -14.6175140346698 +820000 ekin = 0.199933211815007 | erot = 0.445497181488063 | epot = -15.2629444280486 | etot = -14.6175140347455 +821000 ekin = 0.208120374082307 | erot = 0.452952069483619 | epot = -15.2785864783934 | etot = -14.6175140348274 +822000 ekin = 0.216970558498724 | erot = 0.460461605795572 | epot = -15.2949461992058 | etot = -14.6175140349115 +823000 ekin = 0.226020685629653 | erot = 0.467229260922794 | epot = -15.3107639815457 | etot = -14.6175140349933 +824000 ekin = 0.234771793852154 | erot = 0.472530858216694 | epot = -15.3248166871376 | etot = -14.6175140350687 +825000 ekin = 0.242709867662635 | erot = 0.475759712130466 | epot = -15.3359836149267 | etot = -14.6175140351336 +826000 ekin = 0.249329060858575 | erot = 0.476465014357238 | epot = -15.3433081104001 | etot = -14.6175140351843 +827000 ekin = 0.25415625948642 | erot = 0.474380409602698 | epot = -15.3460507043074 | etot = -14.6175140352183 +828000 ekin = 0.256775693171424 | erot = 0.469440383344404 | epot = -15.3437301117495 | etot = -14.6175140352337 +829000 ekin = 0.256852201217284 | erot = 0.46178309210187 | epot = -15.336149328549 | etot = -14.6175140352299 +830000 ekin = 0.254151805817283 | erot = 0.451739467040903 | epot = -15.3234053080654 | etot = -14.6175140352073 +831000 ekin = 0.248558416434218 | erot = 0.439809632306185 | epot = -15.3058820839079 | etot = -14.6175140351675 +832000 ekin = 0.240085737091441 | erot = 0.426628719075599 | epot = -15.2842284912797 | etot = -14.6175140351126 +833000 ekin = 0.228883712687973 | erot = 0.412924890623741 | epot = -15.2593226383575 | etot = -14.6175140350458 +834000 ekin = 0.215239082682017 | erot = 0.399472764055522 | epot = -15.2322258817081 | etot = -14.6175140349705 +835000 ekin = 0.199569787294727 | erot = 0.387045440519038 | epot = -15.2041292627042 | etot = -14.6175140348904 +836000 ekin = 0.182413100763729 | erot = 0.376368114580306 | epot = -15.1762952501535 | etot = -14.6175140348094 +837000 ekin = 0.164407483062571 | erot = 0.368075825930997 | epot = -15.149997343725 | etot = -14.6175140347315 +838000 ekin = 0.146268295773245 | erot = 0.362677435797452 | epot = -15.1264597662308 | etot = -14.6175140346601 +839000 ekin = 0.128757768426142 | erot = 0.360527421580312 | epot = -15.1067992246053 | etot = -14.6175140345989 +840000 ekin = 0.112649960717701 | erot = 0.36180661865639 | epot = -15.0919706139249 | etot = -14.6175140345508 +841000 ekin = 0.0986919456674289 | erot = 0.36651260392939 | epot = -15.0827185841154 | etot = -14.6175140345186 +842000 ekin = 0.0875630029231973 | erot = 0.374460003556307 | epot = -15.0795370409836 | etot = -14.6175140345041 +843000 ekin = 0.0798341847684568 | erot = 0.385290606533499 | epot = -15.0826388258105 | etot = -14.6175140345086 +844000 ekin = 0.0759310929906455 | erot = 0.398492769730518 | epot = -15.0919378972534 | etot = -14.6175140345322 +845000 ekin = 0.0761029610203614 | erot = 0.413429207169692 | epot = -15.1070462027642 | etot = -14.6175140345741 +846000 ekin = 0.0804010613291467 | erot = 0.429371869323724 | epot = -15.1272869652855 | etot = -14.6175140346326 +847000 ekin = 0.0886689809243283 | erot = 0.445542241999283 | epot = -15.151725257628 | etot = -14.6175140347044 +848000 ekin = 0.100546421460129 | erot = 0.46115503871289 | epot = -15.1792154949586 | etot = -14.6175140347856 +849000 ekin = 0.115486960011282 | erot = 0.475462945352927 | epot = -15.2084639402358 | etot = -14.6175140348716 +850000 ekin = 0.132788806696208 | erot = 0.487799837753942 | epot = -15.2381026794073 | etot = -14.6175140349572 +851000 ekin = 0.151636227786906 | erot = 0.497619785577632 | epot = -15.2667700484016 | etot = -14.6175140350371 +852000 ekin = 0.171148194576718 | erot = 0.504529242628412 | epot = -15.2931914723118 | etot = -14.6175140351066 +853000 ekin = 0.190430159396265 | erot = 0.50831015746196 | epot = -15.31625435202 | etot = -14.6175140351617 +854000 ekin = 0.208624756900111 | erot = 0.508932337651449 | epot = -15.3350711297509 | etot = -14.6175140351993 +855000 ekin = 0.224957674812678 | erot = 0.506554231539646 | epot = -15.3490259415702 | etot = -14.6175140352179 +856000 ekin = 0.238775816539412 | erot = 0.501512259960127 | epot = -15.3578021117162 | etot = -14.6175140352167 +857000 ekin = 0.249575992234284 | erot = 0.494299801981541 | epot = -15.3613898294126 | etot = -14.6175140351967 +858000 ekin = 0.257023502073991 | erot = 0.485537766821542 | epot = -15.3600753040553 | etot = -14.6175140351598 +859000 ekin = 0.260960921285794 | erot = 0.475939247615297 | epot = -15.3544142040096 | etot = -14.6175140351085 +860000 ekin = 0.261408037072425 | erot = 0.466270984603931 | epot = -15.3451930567221 | etot = -14.6175140350458 +861000 ekin = 0.258554187538353 | erot = 0.457314264402295 | epot = -15.3333824869156 | etot = -14.6175140349749 +862000 ekin = 0.252744258033141 | erot = 0.449827506885222 | epot = -15.3200857998177 | etot = -14.6175140348993 +863000 ekin = 0.244459417796683 | erot = 0.444512141833012 | epot = -15.3064855944521 | etot = -14.6175140348224 +864000 ekin = 0.23429336884036 | erot = 0.441983030938511 | epot = -15.2937904345263 | etot = -14.6175140347475 +865000 ekin = 0.222924696624272 | erot = 0.442744308393629 | epot = -15.2831830396954 | etot = -14.6175140346775 +866000 ekin = 0.211086026109497 | erot = 0.447169652379628 | epot = -15.2757697131049 | etot = -14.6175140346158 +867000 ekin = 0.199530465893205 | erot = 0.455487658922675 | epot = -15.2725321593806 | etot = -14.6175140345647 +868000 ekin = 0.188996288427701 | erot = 0.467771811642206 | epot = -15.274282134597 | etot = -14.6175140345271 +869000 ekin = 0.180171161859839 | erot = 0.483934855625384 | epot = -15.2816200519904 | etot = -14.6175140345052 +870000 ekin = 0.173657413869083 | erot = 0.503727420428225 | epot = -15.2948988687979 | etot = -14.6175140345006 +871000 ekin = 0.169940429082826 | erot = 0.526741193130643 | epot = -15.3141956567281 | etot = -14.6175140345146 +872000 ekin = 0.169362274179231 | erot = 0.55241708894464 | epot = -15.3392933976713 | etot = -14.6175140345475 +873000 ekin = 0.172102391202432 | erot = 0.580058846013128 | epot = -15.3696752718142 | etot = -14.6175140345986 +874000 ekin = 0.178167002902699 | erot = 0.608852557306752 | epot = -15.404533594876 | etot = -14.6175140346666 +875000 ekin = 0.187388233891608 | erot = 0.637892396629037 | epot = -15.4427946652693 | etot = -14.6175140347487 +876000 ekin = 0.199433181368205 | erot = 0.666212376944565 | epot = -15.4831595931543 | etot = -14.6175140348416 +877000 ekin = 0.213822249051452 | erot = 0.69282332523737 | epot = -15.5241596092296 | etot = -14.6175140349407 +878000 ekin = 0.229955728386783 | erot = 0.716754212644293 | epot = -15.5642239760726 | etot = -14.6175140350415 +879000 ekin = 0.247146104645698 | erot = 0.737095186134375 | epot = -15.6017553259191 | etot = -14.617514035139 +880000 ekin = 0.264653797002906 | erot = 0.753040153405454 | epot = -15.6352079856366 | etot = -14.6175140352283 +881000 ekin = 0.28172378426185 | erot = 0.763926241590771 | epot = -15.6631640611577 | etot = -14.617514035305 +882000 ekin = 0.297620641607227 | erot = 0.769267373447333 | epot = -15.6844020504203 | etot = -14.6175140353657 +883000 ekin = 0.311659967166543 | erot = 0.768779581882131 | epot = -15.6979535844564 | etot = -14.6175140354077 +884000 ekin = 0.323234773768197 | erot = 0.762396270683944 | epot = -15.7031450798816 | etot = -14.6175140354294 +885000 ekin = 0.331836099625417 | erot = 0.750272396067174 | epot = -15.6996225311231 | etot = -14.6175140354305 +886000 ekin = 0.337067751564103 | erot = 0.732777385265373 | epot = -15.6873591722411 | etot = -14.6175140354117 +887000 ekin = 0.338655649766336 | erot = 0.710477420749848 | epot = -15.6666471058904 | etot = -14.6175140353742 +888000 ekin = 0.336452632420875 | erot = 0.684108417155686 | epot = -15.6380750848969 | etot = -14.6175140353203 +889000 ekin = 0.330439768515621 | erot = 0.654541548239603 | epot = -15.602495352008 | etot = -14.6175140352528 +890000 ekin = 0.320725208484741 | erot = 0.62274352002662 | epot = -15.5609827636857 | etot = -14.6175140351743 +891000 ekin = 0.307541386208895 | erot = 0.589733936087021 | epot = -15.514789357384 | etot = -14.6175140350881 +892000 ekin = 0.291240998129636 | erot = 0.556542080397485 | epot = -15.465297113524 | etot = -14.6175140349969 +893000 ekin = 0.272291667891092 | erot = 0.524165278720341 | epot = -15.4139709815152 | etot = -14.6175140349038 +894000 ekin = 0.251268620703177 | erot = 0.493530718297282 | epot = -15.3623133738115 | etot = -14.6175140348111 +895000 ekin = 0.228844131843334 | erot = 0.465462234286213 | epot = -15.311820400851 | etot = -14.6175140347214 +896000 ekin = 0.205772103521623 | erot = 0.440653137306931 | epot = -15.263939275466 | etot = -14.6175140346374 +897000 ekin = 0.18286601780276 | erot = 0.419645693758162 | epot = -15.2200257461227 | etot = -14.6175140345617 +898000 ekin = 0.160968870008327 | erot = 0.40281742524286 | epot = -15.1813003297482 | etot = -14.617514034497 +899000 ekin = 0.140914625128286 | erot = 0.390374024162985 | epot = -15.1488026837377 | etot = -14.6175140344464 +900000 ekin = 0.123482269337591 | erot = 0.382348451689304 | epot = -15.1233447554395 | etot = -14.6175140344126 +901000 ekin = 0.109345484385278 | erot = 0.378605737554559 | epot = -15.1054652563381 | etot = -14.6175140343982 +902000 ekin = 0.0990229789071406 | erot = 0.37885314016642 | epot = -15.0953901534788 | etot = -14.6175140344052 +903000 ekin = 0.0928360184568559 | erot = 0.382655585825979 | epot = -15.093005638717 | etot = -14.6175140344341 +904000 ekin = 0.0908801123885926 | erot = 0.389456554773827 | epot = -15.0978507016463 | etot = -14.6175140344838 +905000 ekin = 0.0930167096533132 | erot = 0.398604648850322 | epot = -15.1091353930552 | etot = -14.6175140345515 +906000 ekin = 0.0988880708470662 | erot = 0.409385812369458 | epot = -15.1257879178489 | etot = -14.6175140346324 +907000 ekin = 0.107954659148216 | erot = 0.421060528764254 | epot = -15.1465292226329 | etot = -14.6175140347204 +908000 ekin = 0.119550305155171 | erot = 0.432904367174519 | epot = -15.1699687071382 | etot = -14.6175140348085 +909000 ekin = 0.132947118365042 | erot = 0.444249232158093 | epot = -15.1947103854133 | etot = -14.6175140348902 +910000 ekin = 0.14742054333404 | erot = 0.45452187965619 | epot = -15.2194564579498 | etot = -14.6175140349596 +911000 ekin = 0.162305506309761 | erot = 0.463275978358842 | epot = -15.2430955196813 | etot = -14.6175140350127 +912000 ekin = 0.177037050913266 | erot = 0.470214361754283 | epot = -15.2647654477151 | etot = -14.6175140350476 +913000 ekin = 0.191172462463443 | erot = 0.475199092565798 | epot = -15.2838855900934 | etot = -14.6175140350642 +914000 ekin = 0.204395616840806 | erot = 0.478248345047313 | epot = -15.3001579969523 | etot = -14.6175140350642 +915000 ekin = 0.21650723869525 | erot = 0.479520616571472 | epot = -15.3135418903175 | etot = -14.6175140350508 +916000 ekin = 0.22740635239903 | erot = 0.479288139235308 | epot = -15.3242085266619 | etot = -14.6175140350276 +917000 ekin = 0.237068358847916 | erot = 0.477902392722287 | epot = -15.3324847865686 | etot = -14.6175140349984 +918000 ekin = 0.245524170398606 | erot = 0.475755244751368 | epot = -15.338793450117 | etot = -14.617514034967 +919000 ekin = 0.252843202023207 | erot = 0.473239468154926 | epot = -15.3435967051145 | etot = -14.6175140349364 +920000 ekin = 0.259121284814418 | erot = 0.470712244289352 | epot = -15.3473475640129 | etot = -14.6175140349091 +921000 ekin = 0.264473144075716 | erot = 0.468464808091652 | epot = -15.3504519870541 | etot = -14.6175140348868 +922000 ekin = 0.269028180853147 | erot = 0.466700668341421 | epot = -15.3532428840648 | etot = -14.6175140348703 +923000 ekin = 0.272927944744965 | erot = 0.465523908452019 | epot = -15.3559658880565 | etot = -14.6175140348596 +924000 ekin = 0.276323793828338 | erot = 0.464938026324942 | epot = -15.3587758550077 | etot = -14.6175140348544 +925000 ekin = 0.279373649322719 | erot = 0.464854721381143 | epot = -15.3617424055579 | etot = -14.6175140348541 +926000 ekin = 0.282237300897349 | erot = 0.465111106681717 | epot = -15.3648624424361 | etot = -14.6175140348571 +927000 ekin = 0.285070250341268 | erot = 0.465493135294266 | epot = -15.3680774204978 | etot = -14.6175140348623 +928000 ekin = 0.288016501944426 | erot = 0.465762600719312 | epot = -15.3712931375323 | etot = -14.6175140348686 +929000 ekin = 0.291201026098215 | erot = 0.465684740680354 | epot = -15.3743998016532 | etot = -14.6175140348747 +930000 ekin = 0.294722459179014 | erot = 0.465054261990702 | epot = -15.3772907560492 | etot = -14.6175140348795 +931000 ekin = 0.29864676401532 | erot = 0.463717248454336 | epot = -15.3798780473521 | etot = -14.6175140348824 +932000 ekin = 0.30300230463982 | erot = 0.461587311534142 | epot = -15.382103651057 | etot = -14.617514034883 +933000 ekin = 0.307776651095021 | erot = 0.458654945592281 | epot = -15.3839456315687 | etot = -14.6175140348814 +934000 ekin = 0.312915338272243 | erot = 0.454989722656041 | epot = -15.385419095806 | etot = -14.6175140348777 +935000 ekin = 0.318322768321537 | erot = 0.4507356255513 | epot = -15.3865724287453 | etot = -14.6175140348725 +936000 ekin = 0.323865441581232 | erot = 0.446100385695392 | epot = -15.3874798621431 | etot = -14.6175140348664 +937000 ekin = 0.329377658420751 | erot = 0.441340069470884 | epot = -15.3882317627517 | etot = -14.6175140348601 +938000 ekin = 0.334669609401342 | erot = 0.436740154638299 | epot = -15.3889237988938 | etot = -14.6175140348541 +939000 ekin = 0.339538182698431 | erot = 0.432595723627041 | epot = -15.3896479411745 | etot = -14.617514034849 +940000 ekin = 0.343779460434951 | erot = 0.429190561372456 | epot = -15.3904840566526 | etot = -14.6175140348452 +941000 ekin = 0.347202304173587 | erot = 0.426777065358565 | epot = -15.391493404375 | etot = -14.6175140348428 +942000 ekin = 0.349642062607373 | erot = 0.425558062624985 | epot = -15.3927141600744 | etot = -14.6175140348421 +943000 ekin = 0.350973206935267 | erot = 0.425671371650545 | epot = -15.3941586134289 | etot = -14.6175140348431 +944000 ekin = 0.351119786154239 | erot = 0.427178062458757 | epot = -15.3958118834587 | etot = -14.6175140348457 +945000 ekin = 0.350062816508182 | erot = 0.430055404932911 | epot = -15.397632256291 | etot = -14.6175140348499 +946000 ekin = 0.347844068536133 | erot = 0.434195447788936 | epot = -15.3995535511804 | etot = -14.6175140348553 +947000 ekin = 0.344566017440968 | erot = 0.439410327983271 | epot = -15.4014903802857 | etot = -14.6175140348614 +948000 ekin = 0.340388212506876 | erot = 0.445444378275944 | epot = -15.4033466256503 | etot = -14.6175140348675 +949000 ekin = 0.335520427168076 | erot = 0.451992965713332 | epot = -15.405027427754 | etot = -14.6175140348726 +950000 ekin = 0.330213181195925 | erot = 0.458727107974287 | epot = -15.4064543240458 | etot = -14.6175140348756 +951000 ekin = 0.324745816556271 | erot = 0.465321341195901 | epot = -15.4075811926278 | etot = -14.6175140348756 +952000 ekin = 0.319412679962131 | erot = 0.471482169175953 | epot = -15.4084088840101 | etot = -14.617514034872 +953000 ekin = 0.314508037100271 | erot = 0.476974139325801 | epot = -15.4089962112904 | etot = -14.6175140348643 +954000 ekin = 0.310309685024597 | erot = 0.481639431416524 | epot = -15.4094631512943 | etot = -14.6175140348532 +955000 ekin = 0.30706194776561 | erot = 0.485408201612597 | epot = -15.4099841842179 | etot = -14.6175140348397 +956000 ekin = 0.304958921289462 | erot = 0.488297803840355 | epot = -15.4107707599554 | etot = -14.6175140348255 +957000 ekin = 0.304129209169334 | erot = 0.490400499131601 | epot = -15.4120437431141 | etot = -14.6175140348131 +958000 ekin = 0.304623714620741 | erot = 0.491860923620763 | epot = -15.4139986730463 | etot = -14.6175140348048 +959000 ekin = 0.306408207892433 | erot = 0.492846142548468 | epot = -15.4167683852438 | etot = -14.6175140348029 +960000 ekin = 0.309362278814204 | erot = 0.493512316197963 | epot = -15.4203886298212 | etot = -14.617514034809 +961000 ekin = 0.313285873785893 | erot = 0.493972653387203 | epot = -15.4247725619971 | etot = -14.617514034824 +962000 ekin = 0.317913924785377 | erot = 0.494271324762721 | epot = -15.4296992843955 | etot = -14.6175140348474 +963000 ekin = 0.322938673954067 | erot = 0.494367337737335 | epot = -15.434820046569 | etot = -14.6175140348776 +964000 ekin = 0.32803828153202 | erot = 0.494131108238476 | epot = -15.4396834246822 | etot = -14.6175140349118 +965000 ekin = 0.332909295684033 | erot = 0.493354750676285 | epot = -15.4437780813066 | etot = -14.6175140349462 +966000 ekin = 0.337299689763766 | erot = 0.491775167781745 | epot = -15.4465888925225 | etot = -14.617514034977 +967000 ekin = 0.341038574327655 | erot = 0.489107134739062 | epot = -15.4476597440666 | etot = -14.6175140349999 +968000 ekin = 0.344058508087222 | erot = 0.485082040987952 | epot = -15.4466545840868 | etot = -14.6175140350117 +969000 ekin = 0.346406687227151 | erot = 0.479487053291702 | epot = -15.4434077755292 | etot = -14.6175140350103 +970000 ekin = 0.348242259951282 | erot = 0.472199376074787 | epot = -15.4379556710213 | etot = -14.6175140349953 +971000 ekin = 0.349818577908804 | erot = 0.463211040207177 | epot = -15.4305436530837 | etot = -14.6175140349678 +972000 ekin = 0.351451221504524 | erot = 0.452641107453752 | epot = -15.4216063638891 | etot = -14.6175140349308 +973000 ekin = 0.3534748518418 | erot = 0.440734047140215 | epot = -15.4117229338706 | etot = -14.6175140348885 +974000 ekin = 0.356193968986606 | erot = 0.427844962322964 | epot = -15.4015529661554 | etot = -14.6175140348458 +975000 ekin = 0.359834072252968 | erot = 0.414413971021433 | epot = -15.3917620780819 | etot = -14.6175140348075 +976000 ekin = 0.364500158164541 | erot = 0.400933139115399 | epot = -15.3829473320578 | etot = -14.6175140347778 +977000 ekin = 0.370148756531594 | erot = 0.387909813696784 | epot = -15.3755726049881 | etot = -14.6175140347597 +978000 ekin = 0.376577842832112 | erot = 0.37583005908299 | epot = -15.3699219366697 | etot = -14.6175140347546 +979000 ekin = 0.383436289098897 | erot = 0.365125297246974 | epot = -15.3660756211082 | etot = -14.6175140347623 +980000 ekin = 0.390251542221838 | erot = 0.356144397459927 | epot = -15.3639099744635 | etot = -14.6175140347817 +981000 ekin = 0.396471539315499 | erot = 0.349132547198626 | epot = -15.3631181213241 | etot = -14.61751403481 +982000 ekin = 0.401514997591354 | erot = 0.344217435800631 | epot = -15.3632464682362 | etot = -14.6175140348443 +983000 ekin = 0.404823458769612 | erot = 0.341402706417366 | epot = -15.3637402000685 | etot = -14.6175140348815 +984000 ekin = 0.405908866684804 | erot = 0.34056832459917 | epot = -15.3639912262027 | etot = -14.6175140349188 +985000 ekin = 0.404391803059605 | erot = 0.341477444721989 | epot = -15.3633832827353 | etot = -14.6175140349537 +986000 ekin = 0.400027422799988 | erot = 0.343789434463081 | epot = -15.3613308922474 | etot = -14.6175140349843 +987000 ekin = 0.392718180743718 | erot = 0.347078806740141 | epot = -15.357311022493 | etot = -14.6175140350092 +988000 ekin = 0.382514239213264 | erot = 0.350859769148604 | epot = -15.3508880433891 | etot = -14.6175140350273 +989000 ekin = 0.36960372665304 | erot = 0.354615837190747 | epot = -15.3417335988814 | etot = -14.6175140350376 +990000 ekin = 0.354295674460603 | erot = 0.357833454089941 | epot = -15.3296431635899 | etot = -14.6175140350393 +991000 ekin = 0.336998529350877 | erot = 0.360037895319979 | epot = -15.3145504597026 | etot = -14.6175140350318 +992000 ekin = 0.318196763890073 | erot = 0.360829065192576 | epot = -15.296539864097 | etot = -14.6175140350143 +993000 ekin = 0.298427479538382 | erot = 0.359914303090994 | epot = -15.2758558176161 | etot = -14.6175140349867 +994000 ekin = 0.278258203579966 | erot = 0.357135170966681 | epot = -15.2529074094957 | etot = -14.6175140349491 +995000 ekin = 0.258266471895044 | erot = 0.352485480213702 | epot = -15.2282659870109 | etot = -14.6175140349022 +996000 ekin = 0.239021351636038 | erot = 0.346118523028621 | epot = -15.2026539095118 | etot = -14.6175140348471 +997000 ekin = 0.221066818081191 | erot = 0.338342492443265 | epot = -15.1769233453106 | etot = -14.6175140347861 +998000 ekin = 0.204906835818307 | erot = 0.329604233509113 | epot = -15.152025104049 | etot = -14.6175140347215 +999000 ekin = 0.190992053959209 | erot = 0.320462575794744 | epot = -15.1289686644103 | etot = -14.6175140346563 +1000000 ekin = 0.179708146665587 | erot = 0.311553394428757 | epot = -15.1087755756882 | etot = -14.6175140345938 + 1000000 0.013311715 -1.5443684 0.033490821 -1.4929067 -3.7544839e-05 +Loop time of 28.9854 on 4 procs for 1000000 steps with 10 atoms + +Performance: 29808.075 tau/day, 34500.086 timesteps/s +96.6% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.85571 | 9.8341 | 18.111 | 228.8 | 33.93 +Bond | 0.12393 | 0.38078 | 0.62324 | 32.7 | 1.31 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 2.795 | 3.6269 | 4.4228 | 30.4 | 12.51 +Output | 1.8e-05 | 2.575e-05 | 2.9e-05 | 0.0 | 0.00 +Modify | 0.24721 | 1.1083 | 1.9206 | 64.1 | 3.82 +Other | | 14.04 | | | 48.42 + +Nlocal: 2.5 ave 5 max 0 min +Histogram: 1 0 1 0 0 0 0 0 1 1 +Nghost: 7.5 ave 10 max 5 min +Histogram: 1 0 1 0 0 0 0 0 1 1 +Neighs: 18.5 ave 35 max 0 min +Histogram: 1 0 1 0 0 0 0 0 1 1 + +Total # of neighbors = 74 +Ave neighs/atom = 7.4 +Ave special neighs/atom = 3.6 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:28 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.1 b/examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.1 deleted file mode 100644 index 2c09a4f99d..0000000000 --- a/examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.1 +++ /dev/null @@ -1,178 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 1 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex1 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 10 atoms - reading velocities ... - 10 velocities - 10 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 8 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 2 = max # of 1-4 neighbors - 4 = max # of special neighbors - -set atom * mass 3.1575 - 10 settings made for mass - -group all type 1 4 -10 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna2/fene -bond_coeff * 2.0 0.25 0.7564 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh -pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna2/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 -pair_coeff * * oxdna2/dh 0.1 1.0 0.815 - -# NVE ensemble -fix 1 all nve/dot -#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.6274 - ghost atom cutoff = 2.6274 - binsize = 1.3137, bins = 31 31 31 - 6 neighbor lists, perpetual/occasional/extra = 6 0 0 - (1) pair oxdna2/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna2/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna2/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna2/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna2/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (6) pair oxdna2/dh, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 3.023 | 3.023 | 3.023 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.4712768 0.009525411 -1.4617514 -5.8922361e-05 -1000 ekin = 0.00113086229080528 | erot = 0.0043101016040658 | epot = -14.6229549982368 | etot = -14.617514034342 -2000 ekin = 0.0044853322434243 | erot = 0.0171407706505008 | epot = -14.6391401372615 | etot = -14.6175140343675 -3000 ekin = 0.00995035259649284 | erot = 0.0381961780846485 | epot = -14.6656605650904 | etot = -14.6175140344093 -4000 ekin = 0.0173418024862054 | erot = 0.0669935184860634 | epot = -14.7018493554381 | etot = -14.6175140344659 -5000 ekin = 0.0264109356286075 | erot = 0.102878288094517 | epot = -14.7468032582586 | etot = -14.6175140345355 -6000 ekin = 0.0368533113591442 | erot = 0.14504542056987 | epot = -14.7994127665447 | etot = -14.6175140346157 -7000 ekin = 0.0483200640564843 | erot = 0.19256586251551 | epot = -14.8583999612756 | etot = -14.6175140347036 -8000 ekin = 0.0604312317605998 | erot = 0.24441787013151 | epot = -14.9223631366883 | etot = -14.6175140347962 -9000 ekin = 0.0727907119671751 | erot = 0.299521949931843 | epot = -14.989826696789 | etot = -14.6175140348899 -10000 ekin = 0.0850022498875221 | erot = 0.356777997217908 | epot = -15.0592942820869 | etot = -14.6175140349815 - 10000 0.006296463 -1.5144685 0.0085391004 -1.4974292 -0.00010794792 -Loop time of 0.149406 on 1 procs for 10000 steps with 10 atoms - -Performance: 57828.835 tau/day, 66931.522 timesteps/s -99.9% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.11971 | 0.11971 | 0.11971 | 0.0 | 80.12 -Bond | 0.0051196 | 0.0051196 | 0.0051196 | 0.0 | 3.43 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0013614 | 0.0013614 | 0.0013614 | 0.0 | 0.91 -Output | 5.0068e-06 | 5.0068e-06 | 5.0068e-06 | 0.0 | 0.00 -Modify | 0.018941 | 0.018941 | 0.018941 | 0.0 | 12.68 -Other | | 0.004268 | | | 2.86 - -Nlocal: 10 ave 10 max 10 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 45 ave 45 max 45 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 45 -Ave neighs/atom = 4.5 -Ave special neighs/atom = 3.6 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.4 b/examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.4 deleted file mode 100644 index a326248cdb..0000000000 --- a/examples/USER/cgdna/examples/oxDNA2/duplex1/log.27Nov18.duplex1.g++.4 +++ /dev/null @@ -1,178 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 1 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex1 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 10 atoms - reading velocities ... - 10 velocities - 10 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 8 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 2 = max # of 1-4 neighbors - 4 = max # of special neighbors - -set atom * mass 3.1575 - 10 settings made for mass - -group all type 1 4 -10 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna2/fene -bond_coeff * 2.0 0.25 0.7564 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh -pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna2/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 -pair_coeff * * oxdna2/dh 0.1 1.0 0.815 - -# NVE ensemble -fix 1 all nve/dot -#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.6274 - ghost atom cutoff = 2.6274 - binsize = 1.3137, bins = 31 31 31 - 6 neighbor lists, perpetual/occasional/extra = 6 0 0 - (1) pair oxdna2/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna2/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna2/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna2/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna2/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (6) pair oxdna2/dh, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 7.652 | 7.834 | 8.016 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.4712768 0.009525411 -1.4617514 -5.8922361e-05 -1000 ekin = 0.00113086229080478 | erot = 0.00431010160406708 | epot = -14.6229549982368 | etot = -14.617514034342 -2000 ekin = 0.00448533224342286 | erot = 0.0171407706505013 | epot = -14.6391401372615 | etot = -14.6175140343675 -3000 ekin = 0.0099503525964896 | erot = 0.0381961780846438 | epot = -14.6656605650904 | etot = -14.6175140344093 -4000 ekin = 0.0173418024861991 | erot = 0.0669935184860479 | epot = -14.7018493554381 | etot = -14.6175140344659 -5000 ekin = 0.0264109356285965 | erot = 0.102878288094482 | epot = -14.7468032582586 | etot = -14.6175140345355 -6000 ekin = 0.0368533113591268 | erot = 0.145045420569809 | epot = -14.7994127665446 | etot = -14.6175140346156 -7000 ekin = 0.0483200640564584 | erot = 0.192565862515413 | epot = -14.8583999612755 | etot = -14.6175140347036 -8000 ekin = 0.0604312317605635 | erot = 0.24441787013137 | epot = -14.9223631366881 | etot = -14.6175140347962 -9000 ekin = 0.072790711967127 | erot = 0.299521949931654 | epot = -14.9898266967887 | etot = -14.6175140348899 -10000 ekin = 0.0850022498874609 | erot = 0.356777997217666 | epot = -15.0592942820866 | etot = -14.6175140349815 - 10000 0.006296463 -1.5144685 0.0085391004 -1.4974292 -0.00010794792 -Loop time of 0.14583 on 4 procs for 10000 steps with 10 atoms - -Performance: 59247.054 tau/day, 68572.979 timesteps/s -97.5% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.0034175 | 0.055587 | 0.10059 | 17.9 | 38.12 -Bond | 0.00064635 | 0.002131 | 0.0035357 | 2.5 | 1.46 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.014538 | 0.014932 | 0.015271 | 0.2 | 10.24 -Output | 5.7459e-05 | 5.7697e-05 | 5.7936e-05 | 0.0 | 0.04 -Modify | 0.0012829 | 0.0063873 | 0.011321 | 5.2 | 4.38 -Other | | 0.06674 | | | 45.76 - -Nlocal: 2.5 ave 5 max 0 min -Histogram: 1 0 1 0 0 0 0 0 1 1 -Nghost: 7.5 ave 10 max 5 min -Histogram: 1 0 1 0 0 0 0 0 1 1 -Neighs: 18.5 ave 35 max 0 min -Histogram: 1 0 1 0 0 0 0 0 1 1 - -Total # of neighbors = 74 -Ave neighs/atom = 7.4 -Ave special neighs/atom = 3.6 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex2/data.duplex2 b/examples/USER/cgdna/examples/oxDNA2/duplex2/data.duplex2 index 6547def910..72872d431a 100644 --- a/examples/USER/cgdna/examples/oxDNA2/duplex2/data.duplex2 +++ b/examples/USER/cgdna/examples/oxDNA2/duplex2/data.duplex2 @@ -38,7 +38,7 @@ Atoms 15 3 4.860249842674773e-01 3.518234140414733e-01 3.897628551303119e-01 2 1 1 16 4 5.999999999999995e-01 -3.330669073875470e-17 -3.330669073875470e-16 2 1 1 -# Atom-ID, translational, rotational velocity +# Atom-ID, translational velocity, angular momentum Velocities 1 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex2/in.duplex2 b/examples/USER/cgdna/examples/oxDNA2/duplex2/in.duplex2 index 3d4393e09b..3850dfcedf 100644 --- a/examples/USER/cgdna/examples/oxDNA2/duplex2/in.duplex2 +++ b/examples/USER/cgdna/examples/oxDNA2/duplex2/in.duplex2 @@ -1,7 +1,7 @@ variable number equal 2 variable ofreq equal 1000 variable efreq equal 1000 - +variable T equal 0.1 units lj dimension 3 @@ -30,19 +30,19 @@ bond_coeff * 2.0 0.25 0.7564 # oxDNA pair interactions pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna2/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqav ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 -pair_coeff * * oxdna2/dh 0.1 1.0 0.815 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 # NVE ensemble #fix 1 all nve/dot -fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 #fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 timestep 1e-5 @@ -73,6 +73,6 @@ fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${e #dump_modify out sort id #dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" -run 10000 +run 1000000 #write_restart config.${number}.* diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.1 b/examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.1 new file mode 100644 index 0000000000..e4478a8942 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.1 @@ -0,0 +1,1173 @@ +LAMMPS (18 Jun 2019) +variable number equal 2 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex2 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 16 atoms + reading velocities ... + 16 velocities + 16 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 13 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 4 = max # of 1-4 neighbors + 6 = max # of special neighbors + special bonds CPU = 0.000103 secs + read_data CPU = 0.00215 secs + +set atom * mass 3.1575 + 16 settings made for mass + +group all type 1 4 +16 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna2/fene +bond_coeff * 2.0 0.25 0.7564 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh +pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna2/stk seqav ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqav 0.1 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 +pair_coeff * * oxdna2/dh 0.1 1.0 0.815 + +# NVE ensemble +#fix 1 all nve/dot +fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.6274 + ghost atom cutoff = 2.6274 + binsize = 1.3137, bins = 31 31 31 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 3.025 | 3.025 | 3.025 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.5358787 0.0096742456 -1.5262045 1.0127369e-05 +1000 ekin = 1.54282272464468 | erot = 1.71757897250772 | epot = -24.4403527731341 | etot = -21.1799510759817 +2000 ekin = 1.86109566690716 | erot = 1.93804145796026 | epot = -24.3759816748265 | etot = -20.5768445499591 +3000 ekin = 2.68769182431188 | erot = 2.14559269500086 | epot = -24.2916556822451 | etot = -19.4583711629324 +4000 ekin = 2.04710303757243 | erot = 1.48774072590987 | epot = -24.190371461807 | etot = -20.6555276983247 +5000 ekin = 1.77654023802719 | erot = 2.53418650522101 | epot = -24.1246365663843 | etot = -19.8139098231361 +6000 ekin = 3.12253137872527 | erot = 2.04028266818831 | epot = -24.0491248750916 | etot = -18.8863108281781 +7000 ekin = 3.22418765752177 | erot = 2.72037570174022 | epot = -23.9458569915548 | etot = -18.0012936322928 +8000 ekin = 2.83204202112963 | erot = 2.67060276413776 | epot = -23.9211291529766 | etot = -18.4184843677092 +9000 ekin = 2.69585642754481 | erot = 2.59559820250212 | epot = -23.8340823338302 | etot = -18.5426277037833 +10000 ekin = 2.66058119525512 | erot = 1.95965933336077 | epot = -23.7132443170725 | etot = -19.0930037884567 +11000 ekin = 2.34346978235591 | erot = 2.0608750207871 | epot = -23.5779637301072 | etot = -19.1736189269642 +12000 ekin = 2.71430148816282 | erot = 2.08352509995717 | epot = -23.4639027443831 | etot = -18.6660761562631 +13000 ekin = 2.61978682102879 | erot = 2.37135270083347 | epot = -23.3602247027812 | etot = -18.3690851809189 +14000 ekin = 3.07648218347461 | erot = 2.513719767243 | epot = -23.2345584968309 | etot = -17.6443565461133 +15000 ekin = 2.98155804409324 | erot = 1.87766202539412 | epot = -23.0833749664029 | etot = -18.2241548969156 +16000 ekin = 2.18215330648447 | erot = 2.12621179836828 | epot = -22.9601160092383 | etot = -18.6517509043856 +17000 ekin = 1.85636180329758 | erot = 2.31208745603367 | epot = -22.8022922969143 | etot = -18.633843037583 +18000 ekin = 2.26768559168017 | erot = 1.2389450409061 | epot = -22.668242963885 | etot = -19.1616123312987 +19000 ekin = 2.41605854545852 | erot = 2.44791952321404 | epot = -22.5387095337131 | etot = -17.6747314650405 +20000 ekin = 2.51175765558337 | erot = 2.15047735899709 | epot = -22.3909493829452 | etot = -17.7287143683647 +21000 ekin = 2.9915110961596 | erot = 2.41132105778464 | epot = -22.5047205397251 | etot = -17.1018883857809 +22000 ekin = 3.06067007914886 | erot = 1.83986675392832 | epot = -22.6049739626141 | etot = -17.7044371295369 +23000 ekin = 2.66061083480474 | erot = 2.22251362834379 | epot = -22.5979829967718 | etot = -17.7148585336233 +24000 ekin = 2.65745533322327 | erot = 2.79344397300952 | epot = -22.5688422615674 | etot = -17.1179429553346 +25000 ekin = 2.30064465907917 | erot = 2.20975367009042 | epot = -22.5633453862602 | etot = -18.0529470570906 +26000 ekin = 1.6282588103248 | erot = 2.51914272742421 | epot = -22.6015006270016 | etot = -18.4540990892526 +27000 ekin = 1.76021840072103 | erot = 3.70719293889859 | epot = -22.6409357152274 | etot = -17.1735243756077 +28000 ekin = 2.28064774169505 | erot = 2.34192414128161 | epot = -22.7124772012735 | etot = -18.0899053182968 +29000 ekin = 2.05883865245349 | erot = 1.85387249117169 | epot = -22.7242388348361 | etot = -18.811527691211 +30000 ekin = 2.41090888362676 | erot = 1.86304539977924 | epot = -22.6876650006964 | etot = -18.4137107172904 +31000 ekin = 2.76955959719985 | erot = 2.74117025737249 | epot = -22.6962463526981 | etot = -17.1855164981257 +32000 ekin = 2.08562644954365 | erot = 2.81609166367558 | epot = -22.7309387973059 | etot = -17.8292206840867 +33000 ekin = 2.08306771838837 | erot = 3.6412168312574 | epot = -22.671701882331 | etot = -16.9474173326852 +34000 ekin = 2.32648544880974 | erot = 3.09480128654123 | epot = -22.5637155764017 | etot = -17.1424288410507 +35000 ekin = 2.32492461599899 | erot = 2.02549181832456 | epot = -22.4811871522455 | etot = -18.1307707179219 +36000 ekin = 1.9160219633488 | erot = 1.97655634076097 | epot = -22.3849871062612 | etot = -18.4924088021514 +37000 ekin = 1.57338784336504 | erot = 2.62872199467344 | epot = -22.3528406869297 | etot = -18.1507308488912 +38000 ekin = 2.21547906806797 | erot = 2.89630123965964 | epot = -22.3056616105138 | etot = -17.1938813027862 +39000 ekin = 2.55049061085212 | erot = 2.46486573403212 | epot = -22.2602280028032 | etot = -17.244871657919 +40000 ekin = 2.25628181110086 | erot = 1.87515483835113 | epot = -22.2878959489406 | etot = -18.1564592994886 +41000 ekin = 2.46478791133629 | erot = 2.50742704532316 | epot = -22.3614598606398 | etot = -17.3892449039804 +42000 ekin = 2.69217693496336 | erot = 2.04021031621289 | epot = -22.3505245167544 | etot = -17.6181372655782 +43000 ekin = 2.40211339309477 | erot = 1.6668978842528 | epot = -22.353509525279 | etot = -18.2844982479314 +44000 ekin = 2.30891568897327 | erot = 2.40213237626172 | epot = -22.3871831090405 | etot = -17.6761350438055 +45000 ekin = 1.83275065976638 | erot = 2.26068140262528 | epot = -22.4994702091406 | etot = -18.406038146749 +46000 ekin = 1.97585087518641 | erot = 3.0186371421683 | epot = -22.4902643909032 | etot = -17.4957763735485 +47000 ekin = 1.30702141485601 | erot = 1.99592830992523 | epot = -22.4679405795691 | etot = -19.1649908547879 +48000 ekin = 2.58893650014613 | erot = 1.90050780837457 | epot = -22.5072015009757 | etot = -18.017757192455 +49000 ekin = 2.30293607053961 | erot = 2.71885537559561 | epot = -22.5026363414396 | etot = -17.4808448953044 +50000 ekin = 2.47053682632632 | erot = 3.4216531112208 | epot = -22.415032340787 | etot = -16.5228424032399 +51000 ekin = 2.70972992123879 | erot = 1.4301791663753 | epot = -22.3056750708571 | etot = -18.165765983243 +52000 ekin = 3.01390456844682 | erot = 1.97787470370191 | epot = -22.2827481318966 | etot = -17.2909688597479 +53000 ekin = 2.43796472406694 | erot = 4.25598325759163 | epot = -22.2611961774508 | etot = -15.5672481957922 +54000 ekin = 2.47286167616923 | erot = 2.3677730007818 | epot = -22.243519577301 | etot = -17.40288490035 +55000 ekin = 2.25994505035907 | erot = 1.91872181759988 | epot = -22.2996523252175 | etot = -18.1209854572585 +56000 ekin = 2.3461223108806 | erot = 2.20461695689782 | epot = -22.370356062429 | etot = -17.8196167946505 +57000 ekin = 2.51587877543148 | erot = 2.87451767129977 | epot = -22.4723343857415 | etot = -17.0819379390103 +58000 ekin = 2.49925674722554 | erot = 2.80569508565646 | epot = -22.5303780310556 | etot = -17.2254261981736 +59000 ekin = 2.75080755995156 | erot = 2.17181245800364 | epot = -22.5861118023788 | etot = -17.6634917844236 +60000 ekin = 3.2849676836621 | erot = 1.98487748777051 | epot = -22.5789662701264 | etot = -17.3091210986938 +61000 ekin = 2.4147550327795 | erot = 1.80972454908232 | epot = -22.5207352876114 | etot = -18.2962557057495 +62000 ekin = 2.82665653061546 | erot = 1.68517769072779 | epot = -22.4078181490349 | etot = -17.8959839276917 +63000 ekin = 3.70002607874218 | erot = 1.92704686824234 | epot = -22.2626867402007 | etot = -16.6356137932161 +64000 ekin = 3.61736288982706 | erot = 3.03600982585025 | epot = -22.2659045523542 | etot = -15.6125318366769 +65000 ekin = 3.40363639902008 | erot = 3.89044870099903 | epot = -22.2274777177663 | etot = -14.9333926177472 +66000 ekin = 2.94418257190202 | erot = 2.45963190668857 | epot = -22.1363667635561 | etot = -16.7325522849655 +67000 ekin = 2.60477940218663 | erot = 2.10479080523513 | epot = -22.038362895265 | etot = -17.3287926878432 +68000 ekin = 2.57158327795866 | erot = 2.46431755410219 | epot = -22.0244560205645 | etot = -16.9885551885036 +69000 ekin = 2.43845102321476 | erot = 2.85996177461682 | epot = -22.0620804569545 | etot = -16.7636676591229 +70000 ekin = 3.08348233524936 | erot = 2.49640850205841 | epot = -22.1433186271748 | etot = -16.563427789867 +71000 ekin = 2.5576093427884 | erot = 2.50957641127969 | epot = -22.2697187660694 | etot = -17.2025330120013 +72000 ekin = 1.7831483145096 | erot = 2.52806261120156 | epot = -22.3815818044114 | etot = -18.0703708787002 +73000 ekin = 1.86053585113659 | erot = 2.3350857968737 | epot = -22.4387359493251 | etot = -18.2431143013148 +74000 ekin = 3.14016175467449 | erot = 2.13186507521504 | epot = -22.447062887188 | etot = -17.1750360572984 +75000 ekin = 2.60368665360454 | erot = 2.18680067560206 | epot = -22.4438479629936 | etot = -17.653360633787 +76000 ekin = 1.9633244939079 | erot = 1.96057322365503 | epot = -22.4704022140376 | etot = -18.5465044964747 +77000 ekin = 2.09841107775422 | erot = 2.1471460143176 | epot = -22.4970899098551 | etot = -18.2515328177832 +78000 ekin = 2.49484391610508 | erot = 2.50538853212234 | epot = -22.4472882748805 | etot = -17.4470558266531 +79000 ekin = 3.10058476014063 | erot = 2.47637061915656 | epot = -22.3558276087081 | etot = -16.7788722294109 +80000 ekin = 2.52610159631253 | erot = 1.89085194000216 | epot = -22.2951000287249 | etot = -17.8781464924102 +81000 ekin = 2.34286765202483 | erot = 2.2376810918426 | epot = -22.2933034850974 | etot = -17.71275474123 +82000 ekin = 1.55517061572748 | erot = 2.02195112736337 | epot = -22.2470532436032 | etot = -18.6699315005123 +83000 ekin = 2.27421747802727 | erot = 3.34135950792192 | epot = -22.2406089881454 | etot = -16.6250320021963 +84000 ekin = 2.91603956429582 | erot = 2.09861057599124 | epot = -22.2305865946953 | etot = -17.2159364544083 +85000 ekin = 3.17172070756641 | erot = 2.91883241347319 | epot = -22.2381339647476 | etot = -16.147580843708 +86000 ekin = 3.48918734688943 | erot = 2.79711547316344 | epot = -22.2890012778608 | etot = -16.0026984578079 +87000 ekin = 3.648834525211 | erot = 2.30637362835037 | epot = -22.2817018896603 | etot = -16.3264937360989 +88000 ekin = 3.16156585935194 | erot = 2.24503314085539 | epot = -22.2225172277202 | etot = -16.8159182275129 +89000 ekin = 3.32092350591891 | erot = 1.79966969251215 | epot = -22.1549711261911 | etot = -17.03437792776 +90000 ekin = 2.41383485147934 | erot = 2.22694238351369 | epot = -21.9352492588881 | etot = -17.294472023895 +91000 ekin = 1.87769980964557 | erot = 2.50898156232204 | epot = -21.766796868726 | etot = -17.3801154967584 +92000 ekin = 2.06420930396832 | erot = 2.23853979300919 | epot = -21.6902828653619 | etot = -17.3875337683844 +93000 ekin = 1.94960374605101 | erot = 3.00245663654886 | epot = -21.6771969695753 | etot = -16.7251365869754 +94000 ekin = 2.07633340602167 | erot = 3.38669471112637 | epot = -21.7794316475531 | etot = -16.3164035304051 +95000 ekin = 2.09307446139111 | erot = 2.0811295310408 | epot = -21.9165143849258 | etot = -17.7423103924939 +96000 ekin = 2.66782345206074 | erot = 1.87453507536254 | epot = -21.9748225431664 | etot = -17.4324640157432 +97000 ekin = 1.93962158410337 | erot = 2.81228342262069 | epot = -22.0301811391172 | etot = -17.2782761323932 +98000 ekin = 1.98651083318125 | erot = 2.05358325550364 | epot = -22.1050988415859 | etot = -18.065004752901 +99000 ekin = 2.50729461715162 | erot = 3.55227490812968 | epot = -22.2148658268239 | etot = -16.1552963015426 +100000 ekin = 1.87954195221303 | erot = 2.38994009743578 | epot = -22.3826768493088 | etot = -18.11319479966 +101000 ekin = 1.66917867676911 | erot = 3.61296864361924 | epot = -22.4122779848186 | etot = -17.1301306644303 +102000 ekin = 1.63707836649616 | erot = 3.33958463197985 | epot = -22.3664797586262 | etot = -17.3898167601502 +103000 ekin = 2.00216132457488 | erot = 2.34409134088738 | epot = -22.338100531932 | etot = -17.9918478664698 +104000 ekin = 2.03704734920245 | erot = 2.74903331701925 | epot = -22.3478074938274 | etot = -17.5617268276057 +105000 ekin = 1.85601249652044 | erot = 2.00020228548217 | epot = -22.2937670136133 | etot = -18.4375522316107 +106000 ekin = 1.70582694215149 | erot = 1.90992656339968 | epot = -22.3252996603125 | etot = -18.7095461547614 +107000 ekin = 2.61183521416777 | erot = 1.56756438600251 | epot = -22.3815585845482 | etot = -18.2021589843779 +108000 ekin = 2.13345133147477 | erot = 2.1967764492834 | epot = -22.2873637709221 | etot = -17.9571359901639 +109000 ekin = 2.23517703897427 | erot = 2.12289589403282 | epot = -22.1519605830327 | etot = -17.7938876500256 +110000 ekin = 1.66340581480182 | erot = 2.52573727214601 | epot = -22.1681066766204 | etot = -17.9789635896725 +111000 ekin = 2.28529122032929 | erot = 2.24044883756493 | epot = -22.1711980210611 | etot = -17.6454579631669 +112000 ekin = 2.60405127944181 | erot = 2.43646974545776 | epot = -22.1582164438795 | etot = -17.11769541898 +113000 ekin = 2.40208651796091 | erot = 3.06270264515793 | epot = -22.1587051510952 | etot = -16.6939159879764 +114000 ekin = 2.34302229470158 | erot = 2.30426477746864 | epot = -22.1439772736805 | etot = -17.4966902015103 +115000 ekin = 1.69616053999229 | erot = 3.11049212247371 | epot = -22.1736739038021 | etot = -17.3670212413361 +116000 ekin = 1.51961045217859 | erot = 2.22203808801726 | epot = -22.2355447345615 | etot = -18.4938961943657 +117000 ekin = 1.69355164638512 | erot = 2.33913072714747 | epot = -22.2671845473364 | etot = -18.2345021738038 +118000 ekin = 2.1960991163694 | erot = 2.33815079858085 | epot = -22.2453229868293 | etot = -17.7110730718791 +119000 ekin = 2.55982892523823 | erot = 2.47378749563683 | epot = -22.2824155531543 | etot = -17.2487991322793 +120000 ekin = 1.76091001620491 | erot = 2.1741296357231 | epot = -22.2369948282136 | etot = -18.3019551762855 +121000 ekin = 2.80671234452976 | erot = 2.30128219469303 | epot = -22.2260257995407 | etot = -17.1180312603179 +122000 ekin = 3.23136903340218 | erot = 3.30036165167127 | epot = -22.2515019863338 | etot = -15.7197713012603 +123000 ekin = 2.8561114897291 | erot = 3.24294818442618 | epot = -22.2018342366988 | etot = -16.1027745625435 +124000 ekin = 2.14842162472016 | erot = 2.7693802805091 | epot = -22.0303368839078 | etot = -17.1125349786785 +125000 ekin = 1.83317468651689 | erot = 1.37271219749613 | epot = -21.8885764971633 | etot = -18.6826896131502 +126000 ekin = 2.45181092117661 | erot = 3.08753876167365 | epot = -21.8912653158441 | etot = -16.3519156329938 +127000 ekin = 2.39800706812202 | erot = 2.35255982488708 | epot = -21.8786845575463 | etot = -17.1281176645372 +128000 ekin = 2.72073389273301 | erot = 1.81206134758344 | epot = -21.8246886433981 | etot = -17.2918934030816 +129000 ekin = 2.76648233159587 | erot = 2.90133130407443 | epot = -21.9103698595755 | etot = -16.2425562239052 +130000 ekin = 3.26919771496399 | erot = 2.56804213542044 | epot = -22.0468205769693 | etot = -16.2095807265849 +131000 ekin = 2.65797021501453 | erot = 2.51912811588696 | epot = -22.1046945041584 | etot = -16.9275961732569 +132000 ekin = 2.60615175826329 | erot = 3.39821871959342 | epot = -22.1393658191679 | etot = -16.1349953413112 +133000 ekin = 2.01702653257964 | erot = 2.88164356754679 | epot = -22.1083395633022 | etot = -17.2096694631758 +134000 ekin = 1.62732528940444 | erot = 1.66916296573806 | epot = -22.0617984863721 | etot = -18.7653102312296 +135000 ekin = 2.44472224525446 | erot = 2.12100291286044 | epot = -22.0290071826116 | etot = -17.4632820244967 +136000 ekin = 2.29361895961086 | erot = 3.04813516280966 | epot = -21.9240579822781 | etot = -16.5823038598575 +137000 ekin = 2.71943103843212 | erot = 2.46250134466529 | epot = -21.759346222065 | etot = -16.5774138389676 +138000 ekin = 3.29026615453928 | erot = 1.74005246857097 | epot = -21.7424803627639 | etot = -16.7121617396537 +139000 ekin = 2.76078280183931 | erot = 1.72093988964439 | epot = -21.8915740702781 | etot = -17.4098513787944 +140000 ekin = 2.72717929836212 | erot = 2.46093572161851 | epot = -21.9730696792527 | etot = -16.784954659272 +141000 ekin = 2.79178566984556 | erot = 2.45152416051809 | epot = -21.9760531770405 | etot = -16.7327433466769 +142000 ekin = 3.51808959230238 | erot = 3.47662361887462 | epot = -21.9144706671159 | etot = -14.9197574559389 +143000 ekin = 2.56674276565954 | erot = 2.02320192154355 | epot = -21.887847774869 | etot = -17.2979030876659 +144000 ekin = 3.71876753045239 | erot = 3.03518010984555 | epot = -21.8693810552709 | etot = -15.115433414973 +145000 ekin = 3.61067898932004 | erot = 2.70461629179152 | epot = -21.7768865247848 | etot = -15.4615912436733 +146000 ekin = 3.85672431702576 | erot = 2.48360222237068 | epot = -21.7383083831155 | etot = -15.3979818437191 +147000 ekin = 3.26264642879795 | erot = 2.07790943830875 | epot = -21.612808589745 | etot = -16.2722527226383 +148000 ekin = 2.49411629896921 | erot = 1.64570933977901 | epot = -21.3601881264357 | etot = -17.2203624876875 +149000 ekin = 2.73353556199719 | erot = 2.27529903215971 | epot = -21.180923940444 | etot = -16.1720893462871 +150000 ekin = 2.6282457385967 | erot = 2.90058901460194 | epot = -21.0864924194498 | etot = -15.5576576662512 +151000 ekin = 2.07954165316093 | erot = 2.1164125590575 | epot = -20.9951076802445 | etot = -16.7991534680261 +152000 ekin = 2.41868973763601 | erot = 2.60413735099777 | epot = -20.8520585412647 | etot = -15.8292314526309 +153000 ekin = 2.12569822788918 | erot = 2.25674944787518 | epot = -20.8874716791535 | etot = -16.5050240033891 +154000 ekin = 2.34486280100484 | erot = 2.61050919353092 | epot = -20.9924730886396 | etot = -16.0371010941038 +155000 ekin = 2.06912274657395 | erot = 3.0299583491991 | epot = -21.0207700832301 | etot = -15.921688987457 +156000 ekin = 2.03235057930374 | erot = 3.18386486882217 | epot = -20.8574059636368 | etot = -15.6411905155109 +157000 ekin = 2.3579061324469 | erot = 1.91132393217369 | epot = -20.8256173876826 | etot = -16.556387323062 +158000 ekin = 2.17332819176356 | erot = 2.47832446500284 | epot = -20.9206749462161 | etot = -16.2690222894497 +159000 ekin = 2.87139796431922 | erot = 2.29125458595932 | epot = -21.0425793637301 | etot = -15.8799268134516 +160000 ekin = 2.19495281512895 | erot = 2.37206762182712 | epot = -21.12868212155 | etot = -16.5616616845939 +161000 ekin = 2.13209841436583 | erot = 2.44149028746738 | epot = -21.2267263358883 | etot = -16.6531376340551 +162000 ekin = 1.75046056470489 | erot = 2.66847316377717 | epot = -21.2792984888785 | etot = -16.8603647603965 +163000 ekin = 2.22203312194875 | erot = 2.03600602857084 | epot = -21.4244626156303 | etot = -17.1664234651107 +164000 ekin = 2.74926161019501 | erot = 1.42936965542836 | epot = -21.5631783920293 | etot = -17.384547126406 +165000 ekin = 2.66465183950737 | erot = 2.28908630196103 | epot = -21.572272285795 | etot = -16.6185341443266 +166000 ekin = 3.29267065001881 | erot = 2.38564084157004 | epot = -21.5039232020267 | etot = -15.8256117104378 +167000 ekin = 3.03664818915841 | erot = 2.03669674074452 | epot = -21.5747204885882 | etot = -16.5013755586853 +168000 ekin = 3.16556842965113 | erot = 1.85206282714724 | epot = -21.6223493129218 | etot = -16.6047180561234 +169000 ekin = 2.24511985727904 | erot = 2.66889068764969 | epot = -21.5368970033532 | etot = -16.6228864584245 +170000 ekin = 2.43734116474603 | erot = 2.49716986363814 | epot = -21.3912465276853 | etot = -16.4567354993011 +171000 ekin = 1.90620260936893 | erot = 2.39687883544744 | epot = -21.3008997539566 | etot = -16.9978183091402 +172000 ekin = 2.87444998880216 | erot = 3.21713663160875 | epot = -21.2616188758685 | etot = -15.1700322554576 +173000 ekin = 2.74942738368889 | erot = 2.14120450530294 | epot = -21.2850360200821 | etot = -16.3944041310903 +174000 ekin = 2.4529377396394 | erot = 2.23261644076142 | epot = -21.3299047479428 | etot = -16.644350567542 +175000 ekin = 2.84864650053625 | erot = 2.37733794803682 | epot = -21.2943230039461 | etot = -16.068338555373 +176000 ekin = 2.13647755199109 | erot = 1.89602819204849 | epot = -21.3605335602015 | etot = -17.3280278161619 +177000 ekin = 2.57740970525463 | erot = 2.74252419383388 | epot = -21.3306809364134 | etot = -16.0107470373249 +178000 ekin = 1.83680522170069 | erot = 2.5856914127028 | epot = -21.2632846497336 | etot = -16.8407880153301 +179000 ekin = 2.51484018139121 | erot = 2.38459479892641 | epot = -21.325303559771 | etot = -16.4258685794534 +180000 ekin = 1.88523508330591 | erot = 2.46381998482447 | epot = -21.4811020579528 | etot = -17.1320469898224 +181000 ekin = 1.75689043588625 | erot = 3.04324017089631 | epot = -21.474228259015 | etot = -16.6740976522324 +182000 ekin = 1.56534231241504 | erot = 2.04864866727399 | epot = -21.4129540971941 | etot = -17.798963117505 +183000 ekin = 2.00287899563344 | erot = 2.82515065812734 | epot = -21.49258719815 | etot = -16.6645575443892 +184000 ekin = 2.68544625765532 | erot = 2.43626281495748 | epot = -21.6103862218356 | etot = -16.4886771492228 +185000 ekin = 2.99891111533195 | erot = 3.19602779235331 | epot = -21.6822175762628 | etot = -15.4872786685775 +186000 ekin = 3.18195376963592 | erot = 2.43765957688182 | epot = -21.7117512273523 | etot = -16.0921378808346 +187000 ekin = 2.64722090162018 | erot = 3.43145857630564 | epot = -21.6694156065006 | etot = -15.5907361285748 +188000 ekin = 2.8593721905413 | erot = 3.05764002667605 | epot = -21.6129263142805 | etot = -15.6959140970631 +189000 ekin = 2.64258352431382 | erot = 1.81957536948003 | epot = -21.5503774009301 | etot = -17.0882185071363 +190000 ekin = 2.2190608435254 | erot = 1.84740673329965 | epot = -21.5105703637082 | etot = -17.4441027868831 +191000 ekin = 2.27442549063464 | erot = 2.06581774328105 | epot = -21.4485511972947 | etot = -17.108307963379 +192000 ekin = 2.27419285809427 | erot = 3.10822480468651 | epot = -21.4844439428341 | etot = -16.1020262800533 +193000 ekin = 1.95256612457884 | erot = 1.88944690058107 | epot = -21.4719648319093 | etot = -17.6299518067494 +194000 ekin = 2.46290863552507 | erot = 2.02714246570739 | epot = -21.3483686370757 | etot = -16.8583175358433 +195000 ekin = 3.12615833704228 | erot = 2.09882827884293 | epot = -21.2854694780647 | etot = -16.0604828621794 +196000 ekin = 2.70126861243405 | erot = 2.51307250710585 | epot = -21.2052184052664 | etot = -15.9908772857265 +197000 ekin = 2.55113347479427 | erot = 2.07490331769114 | epot = -21.0379488001649 | etot = -16.4119120076795 +198000 ekin = 2.7091171175815 | erot = 1.79542986755821 | epot = -21.0311079948236 | etot = -16.5265610096839 +199000 ekin = 2.57086088527333 | erot = 2.33194065149168 | epot = -21.0448935828999 | etot = -16.1420920461349 +200000 ekin = 2.89149033048946 | erot = 1.42165157230865 | epot = -21.03770919399 | etot = -16.7245672911919 +201000 ekin = 2.68304721320748 | erot = 1.55647352804279 | epot = -21.0368254418007 | etot = -16.7973047005504 +202000 ekin = 2.2656487707054 | erot = 2.24246330836477 | epot = -20.9783437689148 | etot = -16.4702316898446 +203000 ekin = 2.11263799464235 | erot = 2.0311722239375 | epot = -20.9045528293636 | etot = -16.7607426107837 +204000 ekin = 2.10289033168206 | erot = 1.89431766090034 | epot = -20.917707897003 | etot = -16.9204999044206 +205000 ekin = 1.32594040742044 | erot = 2.12787440210413 | epot = -20.9650467335179 | etot = -17.5112319239933 +206000 ekin = 1.37942510627947 | erot = 2.255876437166 | epot = -20.9344799697865 | etot = -17.299178426341 +207000 ekin = 1.89707208497052 | erot = 1.80792832329628 | epot = -21.0372131039119 | etot = -17.3322126956451 +208000 ekin = 1.82394216235567 | erot = 3.24636401083921 | epot = -21.2905133091558 | etot = -16.2202071359609 +209000 ekin = 2.80235035495642 | erot = 2.34817422826193 | epot = -21.4119988544966 | etot = -16.2614742712782 +210000 ekin = 3.17268831077415 | erot = 3.11920168004874 | epot = -21.4880486169942 | etot = -15.1961586261713 +211000 ekin = 2.46911290485391 | erot = 2.09583435351186 | epot = -21.6131156278285 | etot = -17.0481683694628 +212000 ekin = 2.36983963899524 | erot = 1.93490727968814 | epot = -21.6916906588951 | etot = -17.3869437402117 +213000 ekin = 1.90089387455099 | erot = 2.5187405361218 | epot = -21.7688631446424 | etot = -17.3492287339696 +214000 ekin = 1.97453946438608 | erot = 2.49804990679736 | epot = -21.7968032544022 | etot = -17.3242138832188 +215000 ekin = 1.97170537707849 | erot = 3.1720109210939 | epot = -21.7980499435109 | etot = -16.6543336453385 +216000 ekin = 1.89064429395263 | erot = 1.88113651267029 | epot = -21.7625464985643 | etot = -17.9907656919414 +217000 ekin = 2.0626433286583 | erot = 1.95286476791462 | epot = -21.8181895344454 | etot = -17.8026814378725 +218000 ekin = 2.31967181974704 | erot = 1.6896622434335 | epot = -21.7699992955268 | etot = -17.7606652323462 +219000 ekin = 2.46739391618502 | erot = 2.20775453602831 | epot = -21.776978875084 | etot = -17.1018304228706 +220000 ekin = 1.73785505731585 | erot = 3.0372433480804 | epot = -21.7321393101048 | etot = -16.9570409047086 +221000 ekin = 1.778697043089 | erot = 2.7846909329313 | epot = -21.7425830987872 | etot = -17.1791951227669 +222000 ekin = 2.62634865011186 | erot = 2.86077326472522 | epot = -21.7007933593054 | etot = -16.2136714444683 +223000 ekin = 3.04431297723215 | erot = 1.94008328047868 | epot = -21.7188465939138 | etot = -16.734450336203 +224000 ekin = 2.71939424183677 | erot = 2.42480251627533 | epot = -21.6866518782312 | etot = -16.5424551201191 +225000 ekin = 2.02593449761365 | erot = 3.37613250979673 | epot = -21.6919775986917 | etot = -16.2899105912813 +226000 ekin = 2.36496088602628 | erot = 2.39060577783945 | epot = -21.7612411053054 | etot = -17.0056744414397 +227000 ekin = 2.73527371921374 | erot = 2.63040468048003 | epot = -21.8235720454426 | etot = -16.4578936457488 +228000 ekin = 2.09009153610323 | erot = 2.26861924367323 | epot = -21.8859446312141 | etot = -17.5272338514377 +229000 ekin = 1.80131280326501 | erot = 1.7963110804324 | epot = -21.9677974652423 | etot = -18.3701735815449 +230000 ekin = 2.77436270232913 | erot = 2.22792046726092 | epot = -21.9902739646399 | etot = -16.9879907950498 +231000 ekin = 3.15789416871844 | erot = 2.77494856675301 | epot = -21.9771750398138 | etot = -16.0443323043424 +232000 ekin = 1.86920525086143 | erot = 1.70617009970185 | epot = -22.0127465263534 | etot = -18.4373711757901 +233000 ekin = 1.75915660001321 | erot = 1.56505378532405 | epot = -21.9936912811375 | etot = -18.6694808958002 +234000 ekin = 2.33631680564953 | erot = 2.05523369254154 | epot = -21.9151391633044 | etot = -17.5235886651133 +235000 ekin = 1.95729755108493 | erot = 2.52297007842176 | epot = -21.8622583087295 | etot = -17.3819906792228 +236000 ekin = 2.26174488772854 | erot = 1.90926942275389 | epot = -21.8776848863915 | etot = -17.7066705759091 +237000 ekin = 2.48859859508474 | erot = 2.6489237604941 | epot = -21.9479801146397 | etot = -16.8104577590608 +238000 ekin = 2.21074117955686 | erot = 2.74245988956904 | epot = -22.0027094279364 | etot = -17.0495083588105 +239000 ekin = 2.72897236706913 | erot = 2.49153579775713 | epot = -22.0211522435864 | etot = -16.8006440787602 +240000 ekin = 3.10410575629688 | erot = 2.19185039149975 | epot = -21.9285399490843 | etot = -16.6325838012877 +241000 ekin = 3.04659381738443 | erot = 2.65407823399251 | epot = -21.8553999209703 | etot = -16.1547278695933 +242000 ekin = 2.22634814860329 | erot = 2.33710119371497 | epot = -21.778295180705 | etot = -17.2148458383868 +243000 ekin = 1.53739989500925 | erot = 2.804422651144 | epot = -21.7210994015014 | etot = -17.3792768553481 +244000 ekin = 1.91594160283678 | erot = 2.43897673315061 | epot = -21.6239948430905 | etot = -17.2690765071031 +245000 ekin = 1.9573212108497 | erot = 2.60792757585164 | epot = -21.4969890421964 | etot = -16.931740255495 +246000 ekin = 2.07155268659352 | erot = 2.40712847472271 | epot = -21.4555802858827 | etot = -16.9768991245664 +247000 ekin = 1.55687592357629 | erot = 2.27937051296287 | epot = -21.415801560854 | etot = -17.5795551243148 +248000 ekin = 1.83815644169539 | erot = 2.56757546633135 | epot = -21.4396063392852 | etot = -17.0338744312585 +249000 ekin = 1.79880701831597 | erot = 2.0439839568354 | epot = -21.5116552123395 | etot = -17.6688642371882 +250000 ekin = 1.6819474109243 | erot = 3.39458382990459 | epot = -21.5432862054069 | etot = -16.466754964578 +251000 ekin = 2.13148829031636 | erot = 3.25959517865089 | epot = -21.5335137503413 | etot = -16.142430281374 +252000 ekin = 2.05395839402013 | erot = 2.53819950912971 | epot = -21.5603119938518 | etot = -16.9681540907019 +253000 ekin = 1.65837982841157 | erot = 3.21084156386521 | epot = -21.5856483774528 | etot = -16.716426985176 +254000 ekin = 2.32607189562296 | erot = 3.10904441141191 | epot = -21.5835562113995 | etot = -16.1484399043647 +255000 ekin = 2.50516183463011 | erot = 2.76806754476897 | epot = -21.5622650070292 | etot = -16.2890356276301 +256000 ekin = 1.97348594928106 | erot = 2.62554900973971 | epot = -21.5549569513865 | etot = -16.9559219923657 +257000 ekin = 2.23010268129159 | erot = 3.26394503338319 | epot = -21.5756937773404 | etot = -16.0816460626656 +258000 ekin = 2.0447966409083 | erot = 1.84671550533958 | epot = -21.6926265414806 | etot = -17.8011143952327 +259000 ekin = 2.87403716266236 | erot = 2.7890686554313 | epot = -21.799948240906 | etot = -16.1368424228124 +260000 ekin = 2.90780294403218 | erot = 2.19263097772001 | epot = -21.8560884935551 | etot = -16.7556545718029 +261000 ekin = 2.76828016335186 | erot = 2.34066383431491 | epot = -21.904753347489 | etot = -16.7958093498223 +262000 ekin = 3.52268021990509 | erot = 1.77075610541266 | epot = -21.923252751046 | etot = -16.6298164257282 +263000 ekin = 3.08420493567484 | erot = 2.42539400967894 | epot = -21.8573813915989 | etot = -16.3477824462451 +264000 ekin = 2.24745015945595 | erot = 2.03541588430139 | epot = -21.8692313889178 | etot = -17.5863653451605 +265000 ekin = 1.92522220276231 | erot = 2.5003676829468 | epot = -21.7418152763709 | etot = -17.3162253906618 +266000 ekin = 2.39641107663208 | erot = 3.25288398956727 | epot = -21.6961161037834 | etot = -16.046821037584 +267000 ekin = 1.71111784450077 | erot = 2.23671058890166 | epot = -21.6618183077995 | etot = -17.7139898743971 +268000 ekin = 2.10089423119538 | erot = 3.22434301936133 | epot = -21.6199098144813 | etot = -16.2946725639246 +269000 ekin = 1.9625053447265 | erot = 2.78709438989466 | epot = -21.512378343547 | etot = -16.7627786089258 +270000 ekin = 2.11347862898579 | erot = 2.66955708081142 | epot = -21.4131997021519 | etot = -16.6301639923547 +271000 ekin = 2.18755627878071 | erot = 3.10635949745237 | epot = -21.231195119641 | etot = -15.9372793434079 +272000 ekin = 2.53142755489725 | erot = 2.28018838604503 | epot = -21.0716416692008 | etot = -16.2600257282585 +273000 ekin = 1.9364743445402 | erot = 1.99261296885892 | epot = -21.007557675667 | etot = -17.0784703622679 +274000 ekin = 1.91013630831847 | erot = 2.2120127665723 | epot = -21.0477834541013 | etot = -16.9256343792105 +275000 ekin = 1.79273258693701 | erot = 3.10050032804429 | epot = -21.0858519409205 | etot = -16.1926190259392 +276000 ekin = 3.35719138398128 | erot = 2.41111345420191 | epot = -21.0304226706007 | etot = -15.2621178324176 +277000 ekin = 2.41774397151369 | erot = 1.50719443697989 | epot = -20.9759671563228 | etot = -17.0510287478292 +278000 ekin = 2.53951758510302 | erot = 2.14756601555722 | epot = -20.9653070148297 | etot = -16.2782234141694 +279000 ekin = 1.90856122527452 | erot = 2.38982437581387 | epot = -20.9745429336076 | etot = -16.6761573325192 +280000 ekin = 2.37131544290542 | erot = 3.59489996493466 | epot = -20.85613421052 | etot = -14.8899188026799 +281000 ekin = 1.76889591811704 | erot = 1.7951894912658 | epot = -20.9289254822807 | etot = -17.3648400728979 +282000 ekin = 2.27070827347114 | erot = 3.05009551199377 | epot = -20.8916515658568 | etot = -15.5708477803919 +283000 ekin = 2.18685960365006 | erot = 2.20812220616949 | epot = -20.8474969045899 | etot = -16.4525150947704 +284000 ekin = 1.91940159973892 | erot = 2.20890146173499 | epot = -20.8751887573221 | etot = -16.7468856958482 +285000 ekin = 3.15509933694634 | erot = 1.80738796351619 | epot = -21.0554892608396 | etot = -16.0930019603771 +286000 ekin = 3.87415003559708 | erot = 1.83530883692693 | epot = -21.2366462656484 | etot = -15.5271873931244 +287000 ekin = 3.65191681280166 | erot = 2.913547855761 | epot = -21.3085830740657 | etot = -14.7431184055031 +288000 ekin = 3.25566521528532 | erot = 1.61409275051713 | epot = -21.3016538192157 | etot = -16.4318958534132 +289000 ekin = 2.57277357969492 | erot = 2.7865509468974 | epot = -21.2753452951968 | etot = -15.9160207686044 +290000 ekin = 2.70842209282674 | erot = 2.41918512811132 | epot = -21.2877903800065 | etot = -16.1601831590685 +291000 ekin = 2.06014704473036 | erot = 2.36104758138505 | epot = -21.2845199368975 | etot = -16.8633253107821 +292000 ekin = 2.28556270655109 | erot = 2.04929815389926 | epot = -21.3435089189608 | etot = -17.0086480585104 +293000 ekin = 2.24999256733429 | erot = 2.35234276421049 | epot = -21.4532864362272 | etot = -16.8509511046824 +294000 ekin = 2.93128079968628 | erot = 2.88901294012339 | epot = -21.5344832077337 | etot = -15.7141894679241 +295000 ekin = 2.66786158124138 | erot = 2.29144551421467 | epot = -21.6972562684637 | etot = -16.7379491730076 +296000 ekin = 2.20703931624838 | erot = 2.91798090137806 | epot = -21.7499994740518 | etot = -16.6249792564254 +297000 ekin = 2.17711857895463 | erot = 3.3139407196584 | epot = -21.7438418246471 | etot = -16.2527825260341 +298000 ekin = 2.91263821701566 | erot = 2.35687557807243 | epot = -21.7003108484957 | etot = -16.4307970534076 +299000 ekin = 3.16765240032233 | erot = 2.23927360570976 | epot = -21.8111744518828 | etot = -16.4042484458507 +300000 ekin = 3.29571242152463 | erot = 1.38932168050636 | epot = -21.8854995787115 | etot = -17.2004654766805 +301000 ekin = 2.38336849338668 | erot = 3.30873138065989 | epot = -21.9040100279112 | etot = -16.2119101538647 +302000 ekin = 2.92546415072637 | erot = 3.247691767578 | epot = -21.8700812142841 | etot = -15.6969252959798 +303000 ekin = 2.4103373416559 | erot = 2.62018947425678 | epot = -21.8591741279587 | etot = -16.828647312046 +304000 ekin = 2.22974120288231 | erot = 2.69525972032883 | epot = -21.7977946057185 | etot = -16.8727936825074 +305000 ekin = 2.37900884029014 | erot = 2.39016080950149 | epot = -21.7722637572341 | etot = -17.0030941074424 +306000 ekin = 1.9446171443063 | erot = 2.89927908625624 | epot = -21.772518921465 | etot = -16.9286226909024 +307000 ekin = 2.51296678773709 | erot = 2.07871985749639 | epot = -21.7145354205816 | etot = -17.1228487753482 +308000 ekin = 2.81300442192371 | erot = 2.63068774502107 | epot = -21.7059595575782 | etot = -16.2622673906334 +309000 ekin = 2.33295752921531 | erot = 2.12114847477695 | epot = -21.6789859227475 | etot = -17.2248799187552 +310000 ekin = 2.52283407385729 | erot = 3.21577684610766 | epot = -21.6977338722704 | etot = -15.9591229523054 +311000 ekin = 2.34905401714491 | erot = 3.03961744974846 | epot = -21.7112095513776 | etot = -16.3225380844842 +312000 ekin = 1.82668239636477 | erot = 3.25882975871633 | epot = -21.5839087054203 | etot = -16.4983965503392 +313000 ekin = 1.63596397844578 | erot = 2.08106491982899 | epot = -21.6088054377576 | etot = -17.8917765394829 +314000 ekin = 2.27268061655198 | erot = 2.56861774872119 | epot = -21.622333325343 | etot = -16.7810349600698 +315000 ekin = 2.53123691731374 | erot = 2.1324731770604 | epot = -21.7018350864597 | etot = -17.0381249920856 +316000 ekin = 1.99511026234591 | erot = 1.80085053236165 | epot = -21.7165753862862 | etot = -17.9206145915787 +317000 ekin = 2.11342130166581 | erot = 2.00931752224566 | epot = -21.7049091699378 | etot = -17.5821703460263 +318000 ekin = 2.29657040201996 | erot = 1.9218952520588 | epot = -21.6732020643863 | etot = -17.4547364103076 +319000 ekin = 1.98100978177984 | erot = 1.68241530251755 | epot = -21.5700337503682 | etot = -17.9066086660708 +320000 ekin = 2.46277902525288 | erot = 3.0707129249839 | epot = -21.5118277867106 | etot = -15.9783358364738 +321000 ekin = 1.8533722862421 | erot = 2.67441728470359 | epot = -21.5413634192757 | etot = -17.01357384833 +322000 ekin = 1.94543884879318 | erot = 3.3613066315754 | epot = -21.4649757180038 | etot = -16.1582302376352 +323000 ekin = 1.92582236335168 | erot = 2.08582462630249 | epot = -21.5020070864549 | etot = -17.4903600968007 +324000 ekin = 2.21385975174577 | erot = 2.45972054558752 | epot = -21.6040339423077 | etot = -16.9304536449744 +325000 ekin = 2.71973574551436 | erot = 2.37172075216282 | epot = -21.7154750081878 | etot = -16.6240185105106 +326000 ekin = 1.88834012476607 | erot = 1.92160793718507 | epot = -21.7697066104337 | etot = -17.9597585484825 +327000 ekin = 3.03100650626309 | erot = 1.66914039489952 | epot = -21.8474776692767 | etot = -17.1473307681141 +328000 ekin = 2.74123304387623 | erot = 1.9170666048058 | epot = -21.8856206551572 | etot = -17.2273210064752 +329000 ekin = 2.94158338898171 | erot = 3.13997083102765 | epot = -21.9406516192959 | etot = -15.8590973992865 +330000 ekin = 2.91669398329971 | erot = 2.01301123001111 | epot = -21.9369752911326 | etot = -17.0072700778218 +331000 ekin = 2.28417665381006 | erot = 2.04960167200569 | epot = -21.927160006304 | etot = -17.5933816804883 +332000 ekin = 2.4148148688836 | erot = 3.18178691603942 | epot = -21.9797962539673 | etot = -16.3831944690443 +333000 ekin = 2.45630818257634 | erot = 2.70954264697347 | epot = -22.0834375892948 | etot = -16.917586759745 +334000 ekin = 2.37347521855933 | erot = 2.99534828037212 | epot = -22.119902754337 | etot = -16.7510792554055 +335000 ekin = 2.11274250313861 | erot = 3.56585847378427 | epot = -22.1620352555629 | etot = -16.48343427864 +336000 ekin = 2.63429420241716 | erot = 2.12841745309053 | epot = -22.1384285356293 | etot = -17.3757168801216 +337000 ekin = 2.74014146566976 | erot = 2.73588205536329 | epot = -22.1194416289215 | etot = -16.6434181078884 +338000 ekin = 1.84480508690214 | erot = 2.23455733552335 | epot = -22.1965093971539 | etot = -18.1171469747284 +339000 ekin = 1.56183988387053 | erot = 2.489100411134 | epot = -22.2396203002948 | etot = -18.1886800052903 +340000 ekin = 1.46409027371678 | erot = 4.0512372950447 | epot = -22.1584645354502 | etot = -16.6431369666887 +341000 ekin = 1.68589245970878 | erot = 2.79353148184118 | epot = -22.1393063295445 | etot = -17.6598823879945 +342000 ekin = 1.9632055547669 | erot = 2.74455536956775 | epot = -22.2008946996018 | etot = -17.4931337752671 +343000 ekin = 2.66782090058793 | erot = 3.18156117072004 | epot = -22.2922370675599 | etot = -16.4428549962519 +344000 ekin = 1.78878469299216 | erot = 2.18063379585249 | epot = -22.3229742728833 | etot = -18.3535557840387 +345000 ekin = 1.540972096623 | erot = 1.85836807653953 | epot = -22.3669594635967 | etot = -18.9676192904341 +346000 ekin = 1.69306131915114 | erot = 1.80797582028411 | epot = -22.3312791976866 | etot = -18.8302420582514 +347000 ekin = 1.37617258934979 | erot = 2.61616357123582 | epot = -22.3534264320593 | etot = -18.3610902714737 +348000 ekin = 2.13829045790164 | erot = 2.85908731375532 | epot = -22.3464198630052 | etot = -17.3490420913483 +349000 ekin = 1.82945196641201 | erot = 1.97678849263654 | epot = -22.3619223728943 | etot = -18.5556819138458 +350000 ekin = 1.78944470920989 | erot = 2.50950790539659 | epot = -22.3467767277336 | etot = -18.0478241131271 +351000 ekin = 1.68749587286921 | erot = 2.81742906170281 | epot = -22.4171372510498 | etot = -17.9122123164778 +352000 ekin = 2.77021178817643 | erot = 2.15256178979697 | epot = -22.5877268787862 | etot = -17.6649533008128 +353000 ekin = 3.5651579503159 | erot = 1.46627940614144 | epot = -22.6396840781933 | etot = -17.608246721736 +354000 ekin = 3.44763260550689 | erot = 2.25092776011915 | epot = -22.5553143373262 | etot = -16.8567539717001 +355000 ekin = 2.03402845200418 | erot = 2.90906782343746 | epot = -22.5137132330461 | etot = -17.5706169576044 +356000 ekin = 2.10644486273696 | erot = 3.31938387624324 | epot = -22.5442634045104 | etot = -17.1184346655302 +357000 ekin = 2.76535001946383 | erot = 2.50873330135166 | epot = -22.52215971412 | etot = -17.2480763933045 +358000 ekin = 2.53751054023787 | erot = 2.26477084741189 | epot = -22.5103746530379 | etot = -17.7080932653881 +359000 ekin = 3.23570364771486 | erot = 2.52813698122051 | epot = -22.6019986378314 | etot = -16.838158008896 +360000 ekin = 2.59175576606819 | erot = 1.97223576668381 | epot = -22.6470028729806 | etot = -18.0830113402286 +361000 ekin = 2.61182361704566 | erot = 2.50385714239847 | epot = -22.6927829246934 | etot = -17.5771021652493 +362000 ekin = 2.38475515872101 | erot = 3.84233912950958 | epot = -22.6454854809905 | etot = -16.4183911927599 +363000 ekin = 2.88487115582968 | erot = 1.98709532428838 | epot = -22.5316518293815 | etot = -17.6596853492635 +364000 ekin = 2.24456282663807 | erot = 1.87857741688963 | epot = -22.4065988337859 | etot = -18.2834585902582 +365000 ekin = 2.04295690198209 | erot = 2.81008642631349 | epot = -22.2314366274422 | etot = -17.3783932991466 +366000 ekin = 2.266544192376 | erot = 1.95642386899595 | epot = -22.1933765521819 | etot = -17.97040849081 +367000 ekin = 2.81580114465084 | erot = 2.51878026336671 | epot = -22.2503978612043 | etot = -16.9158164531867 +368000 ekin = 2.81616947616975 | erot = 2.18673959088794 | epot = -22.3700662776457 | etot = -17.367157210588 +369000 ekin = 2.31685128708704 | erot = 2.8485166214536 | epot = -22.4347113127671 | etot = -17.2693434042264 +370000 ekin = 2.66633369096824 | erot = 2.10373843245294 | epot = -22.5097473869516 | etot = -17.7396752635304 +371000 ekin = 2.19554700980946 | erot = 3.61136788339347 | epot = -22.5751109079912 | etot = -16.7681960147883 +372000 ekin = 1.77355024694411 | erot = 3.42422008956619 | epot = -22.6682235461143 | etot = -17.470453209604 +373000 ekin = 2.14882393689494 | erot = 2.79102164241389 | epot = -22.7183823639386 | etot = -17.7785367846297 +374000 ekin = 2.69471790401649 | erot = 3.57888941010137 | epot = -22.8644350080836 | etot = -16.5908276939657 +375000 ekin = 2.40588229328688 | erot = 2.98559431132055 | epot = -22.9231560989464 | etot = -17.5316794943389 +376000 ekin = 3.36525975858234 | erot = 3.24749522030667 | epot = -22.9448546765658 | etot = -16.3320996976767 +377000 ekin = 3.1898535090454 | erot = 2.65440981370779 | epot = -22.8890189773608 | etot = -17.0447556546076 +378000 ekin = 1.54661929765086 | erot = 2.66304115784623 | epot = -22.8894135140088 | etot = -18.6797530585117 +379000 ekin = 1.93848939303329 | erot = 2.54534330055222 | epot = -22.9081180555037 | etot = -18.4242853619182 +380000 ekin = 2.66258042260528 | erot = 2.88895789126712 | epot = -22.9376621442708 | etot = -17.3861238303984 +381000 ekin = 2.95374671041029 | erot = 2.1769850563328 | epot = -22.9816080577256 | etot = -17.8508762909825 +382000 ekin = 2.58850292280408 | erot = 2.01885613358327 | epot = -22.9279053853416 | etot = -18.3205463289542 +383000 ekin = 2.01542491830335 | erot = 2.50444856286716 | epot = -22.9509700194999 | etot = -18.4310965383294 +384000 ekin = 2.10088918623931 | erot = 2.19861971638621 | epot = -22.9637245689725 | etot = -18.664215666347 +385000 ekin = 1.91381637067085 | erot = 1.63023926713733 | epot = -22.9798616984434 | etot = -19.4358060606352 +386000 ekin = 1.55997375471681 | erot = 1.35864886272388 | epot = -23.026401230456 | etot = -20.1077786130153 +387000 ekin = 2.21265030198491 | erot = 1.7501227932087 | epot = -23.0266356759123 | etot = -19.0638625807187 +388000 ekin = 1.98732621523102 | erot = 1.96003045102707 | epot = -22.9343684877508 | etot = -18.9870118214927 +389000 ekin = 2.5418388293764 | erot = 2.33933777400626 | epot = -22.9288764120935 | etot = -18.0476998087109 +390000 ekin = 2.07840415144685 | erot = 1.88714080084969 | epot = -22.8368099519711 | etot = -18.8712649996745 +391000 ekin = 1.85201287716429 | erot = 2.41309749069991 | epot = -22.8035614550317 | etot = -18.5384510871675 +392000 ekin = 2.19897450334475 | erot = 2.90002030847564 | epot = -22.8026053664846 | etot = -17.7036105546642 +393000 ekin = 2.15250422129825 | erot = 3.1954140871906 | epot = -22.8935871868038 | etot = -17.5456688783149 +394000 ekin = 1.99220043003136 | erot = 2.14720550675182 | epot = -22.8839525821639 | etot = -18.7445466453807 +395000 ekin = 2.03384825587122 | erot = 2.5026704188622 | epot = -22.9355340107645 | etot = -18.3990153360311 +396000 ekin = 2.14388612805494 | erot = 1.95887569078926 | epot = -23.0314147787906 | etot = -18.9286529599464 +397000 ekin = 2.39817268086959 | erot = 1.65198489715495 | epot = -23.1381610188687 | etot = -19.0880034408442 +398000 ekin = 3.5848529329223 | erot = 2.5137795193631 | epot = -23.2493671328086 | etot = -17.1507346805232 +399000 ekin = 2.65690410152896 | erot = 1.78815540583896 | epot = -23.3551071826471 | etot = -18.9100476752792 +400000 ekin = 2.5116972230557 | erot = 2.10904464709597 | epot = -23.4242760069967 | etot = -18.803534136845 +401000 ekin = 2.05111703519218 | erot = 2.15375363886755 | epot = -23.4796569613041 | etot = -19.2747862872443 +402000 ekin = 2.43372934314587 | erot = 2.11260100954187 | epot = -23.4682554876931 | etot = -18.9219251350053 +403000 ekin = 2.53598880596584 | erot = 2.81278076880176 | epot = -23.5378775828587 | etot = -18.1891080080911 +404000 ekin = 2.18194702425602 | erot = 2.63711249102604 | epot = -23.6244518702206 | etot = -18.8053923549385 +405000 ekin = 2.45121967393562 | erot = 2.40500763090291 | epot = -23.6357713162683 | etot = -18.7795440114298 +406000 ekin = 2.21958671378093 | erot = 2.24922226746756 | epot = -23.6553601287 | etot = -19.1865511474515 +407000 ekin = 1.98564574231222 | erot = 2.77863717556005 | epot = -23.5607032705187 | etot = -18.7964203526464 +408000 ekin = 2.57646591315375 | erot = 2.58095218000659 | epot = -23.4398366413677 | etot = -18.2824185482073 +409000 ekin = 2.36945583486912 | erot = 2.25935935813466 | epot = -23.3294611001761 | etot = -18.7006459071724 +410000 ekin = 2.02254604345491 | erot = 1.96483214055515 | epot = -23.3122760741247 | etot = -19.3248978901146 +411000 ekin = 1.87895167522371 | erot = 2.65152784802951 | epot = -23.2919254735047 | etot = -18.7614459502515 +412000 ekin = 1.99369299492691 | erot = 2.68971636909523 | epot = -23.2559513781021 | etot = -18.57254201408 +413000 ekin = 2.38900558877156 | erot = 2.64564764432049 | epot = -23.2013938450539 | etot = -18.1667406119618 +414000 ekin = 2.42764300748033 | erot = 1.75174590229272 | epot = -23.1266922276306 | etot = -18.9473033178576 +415000 ekin = 2.76414124953308 | erot = 2.44215852210494 | epot = -23.1817305186064 | etot = -17.9754307469683 +416000 ekin = 2.08280868301927 | erot = 2.76578542751831 | epot = -23.1905832299196 | etot = -18.341989119382 +417000 ekin = 1.99968890800012 | erot = 1.95787693284286 | epot = -23.194417716001 | etot = -19.236851875158 +418000 ekin = 2.38298881868294 | erot = 2.55898711987873 | epot = -23.1586352965619 | etot = -18.2166593580002 +419000 ekin = 2.9839633883085 | erot = 2.57065203496089 | epot = -23.0544780894577 | etot = -17.4998626661883 +420000 ekin = 2.60178854557762 | erot = 2.46052060802045 | epot = -22.9622762729971 | etot = -17.899967119399 +421000 ekin = 2.51720276737396 | erot = 1.77804167911051 | epot = -22.9515897224038 | etot = -18.6563452759193 +422000 ekin = 2.7320348139792 | erot = 1.67298118116889 | epot = -22.9404137463627 | etot = -18.5353977512146 +423000 ekin = 2.13282380031375 | erot = 2.54987675813572 | epot = -22.8157706530705 | etot = -18.133070094621 +424000 ekin = 1.90610672595356 | erot = 2.31894231724673 | epot = -22.7787002443962 | etot = -18.553651201196 +425000 ekin = 2.37366400687573 | erot = 1.95578603620107 | epot = -22.7873996262579 | etot = -18.4579495831811 +426000 ekin = 2.23502410344739 | erot = 2.60951465135819 | epot = -22.8069525247999 | etot = -17.9624137699943 +427000 ekin = 1.88572309905852 | erot = 2.12675775194484 | epot = -22.973782602072 | etot = -18.9613017510686 +428000 ekin = 1.93180562731872 | erot = 2.45432362930894 | epot = -23.1062681387344 | etot = -18.7201388821067 +429000 ekin = 1.72618205037519 | erot = 2.1638575670951 | epot = -23.1203764425356 | etot = -19.2303368250654 +430000 ekin = 2.31236502680075 | erot = 2.14057167953237 | epot = -23.127316365141 | etot = -18.6743796588079 +431000 ekin = 2.45859340033276 | erot = 2.41557475448707 | epot = -23.137683007962 | etot = -18.2635148531422 +432000 ekin = 2.80043339920945 | erot = 2.19140888866301 | epot = -23.1459051340744 | etot = -18.1540628462019 +433000 ekin = 2.2038223816989 | erot = 1.62239062651454 | epot = -23.1902054552061 | etot = -19.3639924469927 +434000 ekin = 2.59117398719482 | erot = 2.35262979682601 | epot = -23.2174180769097 | etot = -18.2736142928889 +435000 ekin = 2.29283868462832 | erot = 2.54026007379789 | epot = -23.1968654207439 | etot = -18.3637666623176 +436000 ekin = 2.43256920688117 | erot = 2.74968424233253 | epot = -23.2466230085986 | etot = -18.0643695593849 +437000 ekin = 1.64425125112848 | erot = 3.23329270267647 | epot = -23.2380191669749 | etot = -18.3604752131699 +438000 ekin = 1.56124620606823 | erot = 2.60252333491232 | epot = -23.1341667906033 | etot = -18.9703972496228 +439000 ekin = 2.30501653948793 | erot = 1.93890022921162 | epot = -23.14170715719 | etot = -18.8977903884904 +440000 ekin = 2.52023257151789 | erot = 3.04669715760005 | epot = -23.2021590525686 | etot = -17.6352293234507 +441000 ekin = 2.79903748157629 | erot = 2.54578114158762 | epot = -23.1760357267403 | etot = -17.8312171035764 +442000 ekin = 2.93503932875119 | erot = 2.87674150367343 | epot = -23.1192988997858 | etot = -17.3075180673612 +443000 ekin = 1.96853850230447 | erot = 1.76444304280728 | epot = -23.0474504745021 | etot = -19.3144689293904 +444000 ekin = 2.00740903163919 | erot = 2.25338146232896 | epot = -22.9768126386128 | etot = -18.7160221446446 +445000 ekin = 2.22543241532629 | erot = 2.06325853122729 | epot = -22.8128736901554 | etot = -18.5241827436018 +446000 ekin = 2.44497213168066 | erot = 2.37296472072563 | epot = -22.7182187420116 | etot = -17.9002818896053 +447000 ekin = 2.27682912672612 | erot = 2.40590062157627 | epot = -22.73821768508 | etot = -18.0554879367776 +448000 ekin = 2.17717815648414 | erot = 1.94002353369628 | epot = -22.8515885285926 | etot = -18.7343868384122 +449000 ekin = 2.21957974285234 | erot = 2.34288028472299 | epot = -22.9413256171992 | etot = -18.3788655896239 +450000 ekin = 2.75054329798646 | erot = 1.97942707751151 | epot = -22.8960066852305 | etot = -18.1660363097325 +451000 ekin = 2.21127283509867 | erot = 2.13383865709095 | epot = -22.93012845553 | etot = -18.5850169633403 +452000 ekin = 2.54342208027875 | erot = 2.35725031977164 | epot = -22.9678192920236 | etot = -18.0671468919732 +453000 ekin = 2.22826691368246 | erot = 1.78505555998555 | epot = -22.9525856519538 | etot = -18.9392631782858 +454000 ekin = 2.43963081757063 | erot = 2.59545869820689 | epot = -22.8816014548474 | etot = -17.8465119390699 +455000 ekin = 2.04579285921012 | erot = 2.79600798010941 | epot = -22.6671256943706 | etot = -17.8253248550511 +456000 ekin = 2.02054568037702 | erot = 2.5142933737518 | epot = -22.4807651427491 | etot = -17.9459260886202 +457000 ekin = 2.62427297855768 | erot = 2.43881475758852 | epot = -22.3628471473124 | etot = -17.2997594111662 +458000 ekin = 2.00982157063058 | erot = 1.99237218757745 | epot = -22.2563036448067 | etot = -18.2541098865987 +459000 ekin = 1.75248702434071 | erot = 2.49686008961238 | epot = -22.2467888503062 | etot = -17.9974417363531 +460000 ekin = 1.91910131837566 | erot = 2.07619395094217 | epot = -22.2400567481829 | etot = -18.2447614788651 +461000 ekin = 1.56844353839394 | erot = 1.28973659789019 | epot = -22.2093526564538 | etot = -19.3511725201697 +462000 ekin = 2.45174884293064 | erot = 1.36031689293857 | epot = -22.3089787954009 | etot = -18.4969130595317 +463000 ekin = 2.64349839520108 | erot = 2.07831354185085 | epot = -22.4300376076151 | etot = -17.7082256705631 +464000 ekin = 2.67299819724031 | erot = 3.73615881795558 | epot = -22.554470130186 | etot = -16.1453131149901 +465000 ekin = 1.95390361110071 | erot = 2.23920710641231 | epot = -22.7384686297881 | etot = -18.545357912275 +466000 ekin = 2.13348556167989 | erot = 2.96280610170109 | epot = -22.8443072066537 | etot = -17.7480155432727 +467000 ekin = 2.46613760277875 | erot = 2.11616591175904 | epot = -23.0265043956358 | etot = -18.444200881098 +468000 ekin = 1.99036864211387 | erot = 1.62858187482038 | epot = -23.0961237334908 | etot = -19.4771732165565 +469000 ekin = 2.49659836745282 | erot = 2.63661728128629 | epot = -23.1411267023576 | etot = -18.0079110536185 +470000 ekin = 2.92199371715687 | erot = 3.21712399422296 | epot = -23.1457817109815 | etot = -17.0066639996017 +471000 ekin = 2.36477645073574 | erot = 1.72314859686431 | epot = -23.1045733261495 | etot = -19.0166482785494 +472000 ekin = 2.18519498855062 | erot = 2.00240720258206 | epot = -23.072627104452 | etot = -18.8850249133193 +473000 ekin = 2.3714321613692 | erot = 2.86124663404655 | epot = -23.0328429128019 | etot = -17.8001641173862 +474000 ekin = 2.1857949588469 | erot = 2.60051446256873 | epot = -22.9136735669303 | etot = -18.1273641455147 +475000 ekin = 2.39661135768768 | erot = 2.01358694537797 | epot = -22.813046501162 | etot = -18.4028481980963 +476000 ekin = 2.10676579065005 | erot = 2.60327856915634 | epot = -22.8119267991277 | etot = -18.1018824393213 +477000 ekin = 2.53295314095718 | erot = 3.55510942450984 | epot = -22.7955031957515 | etot = -16.7074406302845 +478000 ekin = 2.40630114318287 | erot = 2.73236241457618 | epot = -22.7034337758127 | etot = -17.5647702180536 +479000 ekin = 1.27745698905519 | erot = 2.99245403250463 | epot = -22.6605920931777 | etot = -18.3906810716179 +480000 ekin = 1.82390564518045 | erot = 2.13920354248295 | epot = -22.6299626931083 | etot = -18.6668535054449 +481000 ekin = 2.3880478628611 | erot = 3.18399864702822 | epot = -22.6553769169915 | etot = -17.0833304071022 +482000 ekin = 3.20116727691415 | erot = 2.41976760575225 | epot = -22.6125762236254 | etot = -16.991641340959 +483000 ekin = 3.03846588981692 | erot = 2.48627946336888 | epot = -22.5774232520165 | etot = -17.0526778988307 +484000 ekin = 2.70181776439228 | erot = 2.52677846233176 | epot = -22.6070502809988 | etot = -17.3784540542748 +485000 ekin = 3.27224317472663 | erot = 2.42431335826243 | epot = -22.5997277235211 | etot = -16.9031711905321 +486000 ekin = 1.96596043103987 | erot = 1.75891125021975 | epot = -22.642547970919 | etot = -18.9176762896594 +487000 ekin = 2.6234378417876 | erot = 2.50755895035553 | epot = -22.7339556642929 | etot = -17.6029588721497 +488000 ekin = 1.75208074499658 | erot = 2.6448687233026 | epot = -22.7917400975639 | etot = -18.3947906292648 +489000 ekin = 2.08733298303259 | erot = 2.9523180967106 | epot = -22.881879447047 | etot = -17.8422283673038 +490000 ekin = 2.30760030156363 | erot = 2.33161319100248 | epot = -22.8847649865187 | etot = -18.2455514939526 +491000 ekin = 2.48196214295004 | erot = 2.59523958504393 | epot = -22.8776771178079 | etot = -17.800475389814 +492000 ekin = 3.28209206383218 | erot = 2.1852502939697 | epot = -22.8577625078557 | etot = -17.3904201500538 +493000 ekin = 3.37967323337949 | erot = 2.35355143859173 | epot = -22.8047552632571 | etot = -17.0715305912858 +494000 ekin = 3.57464120696614 | erot = 2.24853455202993 | epot = -22.8042956353342 | etot = -16.9811198763381 +495000 ekin = 2.5052992174061 | erot = 2.15850924694968 | epot = -22.7996067752132 | etot = -18.1357983108574 +496000 ekin = 1.95429188426678 | erot = 3.5825937389492 | epot = -22.837298805698 | etot = -17.3004131824821 +497000 ekin = 2.22186292996358 | erot = 2.46502235984734 | epot = -22.8432554612651 | etot = -18.1563701714542 +498000 ekin = 1.72648192614392 | erot = 2.39641281876546 | epot = -22.7792810810776 | etot = -18.6563863361682 +499000 ekin = 2.44591165293457 | erot = 2.82720242160824 | epot = -22.7953427712295 | etot = -17.5222286966867 +500000 ekin = 2.7851302139546 | erot = 2.23270136622152 | epot = -22.8991185931508 | etot = -17.8812870129746 +501000 ekin = 2.99439211318652 | erot = 1.97783069072832 | epot = -22.9279475016441 | etot = -17.9557246977292 +502000 ekin = 2.9862206030979 | erot = 1.79973926744011 | epot = -22.956155459855 | etot = -18.170195589317 +503000 ekin = 2.51500932637374 | erot = 2.88863666961797 | epot = -22.9858023469845 | etot = -17.5821563509928 +504000 ekin = 2.84387999289216 | erot = 2.69340549636984 | epot = -22.9170131486245 | etot = -17.3797276593625 +505000 ekin = 2.95569075243612 | erot = 2.602585876956 | epot = -22.9907249028698 | etot = -17.4324482734777 +506000 ekin = 2.19812159740513 | erot = 1.96718410179931 | epot = -23.0318373952185 | etot = -18.8665316960141 +507000 ekin = 2.26250501037088 | erot = 2.70461320689487 | epot = -22.9974394720575 | etot = -18.0303212547917 +508000 ekin = 2.63634784309456 | erot = 2.05036585895923 | epot = -23.0090804345496 | etot = -18.3223667324958 +509000 ekin = 2.94151668821484 | erot = 2.91160221114196 | epot = -23.0621014211554 | etot = -17.2089825217986 +510000 ekin = 2.26258273420884 | erot = 2.8155823326395 | epot = -23.1767418648115 | etot = -18.0985767979631 +511000 ekin = 2.89871784417207 | erot = 2.15651428734314 | epot = -23.2992796007865 | etot = -18.2440474692713 +512000 ekin = 2.18241701331153 | erot = 2.32471024525139 | epot = -23.3744961479659 | etot = -18.867368889403 +513000 ekin = 1.69086971293502 | erot = 2.8783745660792 | epot = -23.3843289700052 | etot = -18.8150846909909 +514000 ekin = 1.72546832120935 | erot = 2.33325616873572 | epot = -23.3798363194193 | etot = -19.3211118294743 +515000 ekin = 1.99840202228396 | erot = 1.80255577214453 | epot = -23.3747953532199 | etot = -19.5738375587914 +516000 ekin = 3.02853898966319 | erot = 1.54004582498168 | epot = -23.3386782444955 | etot = -18.7700934298506 +517000 ekin = 2.46344499126943 | erot = 2.11388687673044 | epot = -23.3135548350045 | etot = -18.7362229670046 +518000 ekin = 2.0362169291028 | erot = 2.51796163147274 | epot = -23.2504637438686 | etot = -18.6962851832931 +519000 ekin = 1.58660977959654 | erot = 1.63211831489779 | epot = -23.2081782818072 | etot = -19.9894501873129 +520000 ekin = 2.16318611090781 | erot = 1.89658879288914 | epot = -23.2096974204855 | etot = -19.1499225166885 +521000 ekin = 1.97684804456375 | erot = 2.08731550434085 | epot = -23.2527315496486 | etot = -19.188568000744 +522000 ekin = 2.69827007409924 | erot = 2.19560826391663 | epot = -23.3133573112007 | etot = -18.4194789731848 +523000 ekin = 2.2478363305578 | erot = 1.67442261891177 | epot = -23.3604551637841 | etot = -19.4381962143146 +524000 ekin = 2.34895041229461 | erot = 2.10078601700867 | epot = -23.381233923661 | etot = -18.9314974943577 +525000 ekin = 2.13155817393156 | erot = 2.07239357304026 | epot = -23.4395046885398 | etot = -19.235552941568 +526000 ekin = 2.50234900291801 | erot = 2.25431525777582 | epot = -23.4988198653879 | etot = -18.7421556046941 +527000 ekin = 3.03511403104629 | erot = 1.80504692374136 | epot = -23.5562539149297 | etot = -18.7160929601421 +528000 ekin = 2.56074044727573 | erot = 2.54331285469023 | epot = -23.5735936308822 | etot = -18.4695403289162 +529000 ekin = 2.37500349152887 | erot = 1.93006279746846 | epot = -23.5580125050353 | etot = -19.252946216038 +530000 ekin = 3.34194424343389 | erot = 3.41373524710891 | epot = -23.4507267657596 | etot = -16.6950472752168 +531000 ekin = 2.42341072166937 | erot = 2.35978455298084 | epot = -23.1501712562452 | etot = -18.366975981595 +532000 ekin = 2.58886764526949 | erot = 1.86996947608086 | epot = -23.1663546344342 | etot = -18.7075175130839 +533000 ekin = 2.18022742299593 | erot = 2.16045486833456 | epot = -23.380637574335 | etot = -19.0399552830045 +534000 ekin = 2.34791679374047 | erot = 2.03855517230123 | epot = -23.463831563993 | etot = -19.0773595979513 +535000 ekin = 2.37817813408508 | erot = 2.07397219148902 | epot = -23.4832900392636 | etot = -19.0311397136895 +536000 ekin = 2.46210672665338 | erot = 1.8947790016655 | epot = -23.4672059982835 | etot = -19.1103202699646 +537000 ekin = 1.71186030024847 | erot = 2.1344462698512 | epot = -23.5555571897054 | etot = -19.7092506196057 +538000 ekin = 2.16671541009104 | erot = 2.76559932728314 | epot = -23.6609154290595 | etot = -18.7286006916853 +539000 ekin = 2.16621132370208 | erot = 2.29104148484627 | epot = -23.7377569804062 | etot = -19.2805041718579 +540000 ekin = 2.37610335621453 | erot = 1.63780764528448 | epot = -23.7325177726622 | etot = -19.7186067711632 +541000 ekin = 2.61201541528826 | erot = 2.52498155703037 | epot = -23.6623419839272 | etot = -18.5253450116085 +542000 ekin = 2.72898292667725 | erot = 2.10989431729706 | epot = -23.7000798212983 | etot = -18.861202577324 +543000 ekin = 2.72070152721044 | erot = 1.85641764017256 | epot = -23.6069628280622 | etot = -19.0298436606792 +544000 ekin = 2.11779438939827 | erot = 1.50576740930398 | epot = -23.5826778503359 | etot = -19.9591160516337 +545000 ekin = 1.70778076743634 | erot = 2.56995673058895 | epot = -23.583343914622 | etot = -19.3056064165967 +546000 ekin = 2.3805758278215 | erot = 1.86648142267507 | epot = -23.6114100683877 | etot = -19.3643528178911 +547000 ekin = 2.45245186799104 | erot = 2.45758854207408 | epot = -23.6611856045782 | etot = -18.7511451945131 +548000 ekin = 2.39042546399151 | erot = 2.39603897463391 | epot = -23.6735607421256 | etot = -18.8870963035002 +549000 ekin = 2.59234094316699 | erot = 2.03286284306236 | epot = -23.6646331709071 | etot = -19.0394293846778 +550000 ekin = 1.99320521419403 | erot = 1.84894458030441 | epot = -23.6669378249973 | etot = -19.8247880304988 +551000 ekin = 2.44898809443739 | erot = 2.0219242208942 | epot = -23.6235443659669 | etot = -19.1526320506353 +552000 ekin = 2.69502802037877 | erot = 1.40870700355959 | epot = -23.4610294466586 | etot = -19.3572944227202 +553000 ekin = 1.76133393557171 | erot = 2.61023484195893 | epot = -23.254624102607 | etot = -18.8830553250764 +554000 ekin = 2.30411800065654 | erot = 2.33064249173903 | epot = -23.2181242479504 | etot = -18.5833637555548 +555000 ekin = 3.27047384641377 | erot = 1.6422371773255 | epot = -23.1973795659522 | etot = -18.2846685422129 +556000 ekin = 2.90314776795354 | erot = 2.59897046564306 | epot = -23.1460736374982 | etot = -17.6439554039016 +557000 ekin = 2.91673821282758 | erot = 3.16411852075219 | epot = -23.1459806883625 | etot = -17.0651239547827 +558000 ekin = 2.82902946234823 | erot = 2.71147602500681 | epot = -23.1195640745749 | etot = -17.5790585872199 +559000 ekin = 2.44501247164481 | erot = 3.2946921444891 | epot = -23.1638653139107 | etot = -17.4241606977768 +560000 ekin = 2.31903153876872 | erot = 2.34794389762528 | epot = -23.1221343768987 | etot = -18.4551589405047 +561000 ekin = 2.04778211145284 | erot = 2.88230317636058 | epot = -23.0254469759625 | etot = -18.0953616881491 +562000 ekin = 2.23097749779459 | erot = 3.71637560430596 | epot = -22.8954878936692 | etot = -16.9481347915687 +563000 ekin = 3.13589796296721 | erot = 2.30360204009239 | epot = -22.9672461823823 | etot = -17.5277461793227 +564000 ekin = 2.43468506100309 | erot = 2.37780089042927 | epot = -22.9400399192094 | etot = -18.127553967777 +565000 ekin = 2.74707381978168 | erot = 2.07635638038451 | epot = -22.9404100305402 | etot = -18.116979830374 +566000 ekin = 2.4222424655432 | erot = 2.23675573588529 | epot = -22.964317030412 | etot = -18.3053188289835 +567000 ekin = 2.66075150820169 | erot = 2.00813116398473 | epot = -23.0598382212572 | etot = -18.3909555490708 +568000 ekin = 3.04180913535304 | erot = 1.98452490185762 | epot = -23.1129541055894 | etot = -18.0866200683787 +569000 ekin = 3.57499094364799 | erot = 2.06992850387417 | epot = -23.117960007112 | etot = -17.4730405595898 +570000 ekin = 2.66020768003306 | erot = 2.34012507933247 | epot = -23.1339632056245 | etot = -18.133630446259 +571000 ekin = 1.94924082891001 | erot = 2.84220462440654 | epot = -23.0609933320748 | etot = -18.2695478787583 +572000 ekin = 2.41536650984725 | erot = 2.40871845587551 | epot = -23.0560879925718 | etot = -18.232003026849 +573000 ekin = 1.75696177901838 | erot = 2.31680084915611 | epot = -23.107424588529 | etot = -19.0336619603545 +574000 ekin = 2.1071071848933 | erot = 2.59270710144433 | epot = -23.1966129698341 | etot = -18.4967986834965 +575000 ekin = 2.37668274547159 | erot = 2.79832262601946 | epot = -23.2697902014998 | etot = -18.0947848300088 +576000 ekin = 2.17648663043414 | erot = 3.28534323951364 | epot = -23.3035961850707 | etot = -17.8417663151229 +577000 ekin = 2.48653402473871 | erot = 2.29382004189646 | epot = -23.3348256872303 | etot = -18.5544716205951 +578000 ekin = 2.63497646120015 | erot = 2.38541222697017 | epot = -23.3938829535157 | etot = -18.3734942653454 +579000 ekin = 2.68807604490538 | erot = 1.70832449354964 | epot = -23.3711370904455 | etot = -18.9747365519905 +580000 ekin = 2.35405412912148 | erot = 2.8553242408976 | epot = -23.3804498064804 | etot = -18.1710714364613 +581000 ekin = 2.45622900796811 | erot = 2.60461398742566 | epot = -23.3507481421638 | etot = -18.28990514677 +582000 ekin = 2.33821855888559 | erot = 3.20610340688907 | epot = -23.4193095100182 | etot = -17.8749875442436 +583000 ekin = 1.96183085357235 | erot = 2.81826367270291 | epot = -23.5872275727996 | etot = -18.8071330465243 +584000 ekin = 2.00096559581716 | erot = 1.71662185522173 | epot = -23.6766993596687 | etot = -19.9591119086298 +585000 ekin = 2.2650842350347 | erot = 2.08204874292297 | epot = -23.7234738719865 | etot = -19.3763408940288 +586000 ekin = 2.20207640113325 | erot = 1.96861811478536 | epot = -23.6859240119471 | etot = -19.5152294960285 +587000 ekin = 3.67938790357027 | erot = 1.82484412869377 | epot = -23.6634672548209 | etot = -18.1592352225569 +588000 ekin = 3.48089636122829 | erot = 2.30691916064612 | epot = -23.5643712718911 | etot = -17.7765557500167 +589000 ekin = 2.63030533099327 | erot = 2.9702466869305 | epot = -23.3767694123201 | etot = -17.7762173943963 +590000 ekin = 1.60813837628253 | erot = 2.03263132264272 | epot = -23.1946522249358 | etot = -19.5538825260106 +591000 ekin = 1.81653381805571 | erot = 1.75591263591366 | epot = -23.1302877005862 | etot = -19.5578412466168 +592000 ekin = 2.57247249135485 | erot = 2.59257155085885 | epot = -23.1533569826366 | etot = -17.9883129404229 +593000 ekin = 2.43678836763256 | erot = 1.78797409267748 | epot = -23.1035527853187 | etot = -18.8787903250087 +594000 ekin = 2.12126425466624 | erot = 2.16319102375819 | epot = -23.0537965790237 | etot = -18.7693413005993 +595000 ekin = 2.61494655403376 | erot = 2.04015446622256 | epot = -23.041588630948 | etot = -18.3864876106917 +596000 ekin = 2.58385979830463 | erot = 2.125984026295 | epot = -23.0987578414776 | etot = -18.388914016878 +597000 ekin = 3.0356528884646 | erot = 3.13920569000609 | epot = -23.0959220060406 | etot = -16.92106342757 +598000 ekin = 3.448018111133 | erot = 2.86438132305443 | epot = -23.1524961324829 | etot = -16.8400966982954 +599000 ekin = 2.14568317629689 | erot = 3.49762367929462 | epot = -23.1236320419091 | etot = -17.4803251863176 +600000 ekin = 2.20856388598401 | erot = 2.50873295237986 | epot = -23.1229244675557 | etot = -18.4056276291918 +601000 ekin = 2.82305805419651 | erot = 2.82785171484619 | epot = -23.093817009667 | etot = -17.4429072406243 +602000 ekin = 2.33756515640057 | erot = 2.3814563165261 | epot = -23.0592036595801 | etot = -18.3401821866535 +603000 ekin = 1.93163217766375 | erot = 1.95544716703194 | epot = -22.941151667404 | etot = -19.0540723227083 +604000 ekin = 2.67918576808855 | erot = 3.14415640026539 | epot = -22.9119901406973 | etot = -17.0886479723434 +605000 ekin = 2.72017891571417 | erot = 2.06410352610178 | epot = -22.9250944568005 | etot = -18.1408120149845 +606000 ekin = 2.99653903957879 | erot = 2.03201724640129 | epot = -22.8426486789921 | etot = -17.814092393012 +607000 ekin = 2.88290327274547 | erot = 2.37629823895312 | epot = -22.8265624505584 | etot = -17.5673609388598 +608000 ekin = 3.6564890765792 | erot = 2.46096427245297 | epot = -22.7637531347954 | etot = -16.6462997857633 +609000 ekin = 2.67772613172483 | erot = 2.28052588350936 | epot = -22.784032519386 | etot = -17.8257805041518 +610000 ekin = 2.96660977711584 | erot = 2.13935236193287 | epot = -22.7753012812081 | etot = -17.6693391421594 +611000 ekin = 3.84936812341098 | erot = 2.13515328821562 | epot = -22.7555358965927 | etot = -16.7710144849661 +612000 ekin = 2.85991416578252 | erot = 2.46799936153364 | epot = -22.6670923038619 | etot = -17.3391787765458 +613000 ekin = 2.93458428860956 | erot = 2.15612272200133 | epot = -22.6620509726505 | etot = -17.5713439620396 +614000 ekin = 2.80109550846435 | erot = 2.03413630963325 | epot = -22.735929073337 | etot = -17.9006972552394 +615000 ekin = 2.29275572188425 | erot = 2.37295436060996 | epot = -22.8265717932651 | etot = -18.1608617107709 +616000 ekin = 1.78880182339297 | erot = 2.46512387757483 | epot = -22.9181914142038 | etot = -18.664265713236 +617000 ekin = 2.58548247747108 | erot = 2.53734413400793 | epot = -22.9371325341202 | etot = -17.8143059226412 +618000 ekin = 2.31891017470357 | erot = 2.68587322473765 | epot = -22.8737927646705 | etot = -17.8690093652293 +619000 ekin = 1.95260275466613 | erot = 2.00546202293513 | epot = -22.8346556656307 | etot = -18.8765908880295 +620000 ekin = 2.9312355259843 | erot = 2.17154966265513 | epot = -22.9093263040915 | etot = -17.806541115452 +621000 ekin = 2.92251791603671 | erot = 1.69365790820559 | epot = -22.9491849521548 | etot = -18.3330091279125 +622000 ekin = 2.04583493083921 | erot = 2.52347309118728 | epot = -22.8885087146283 | etot = -18.3192006926018 +623000 ekin = 1.97949309574552 | erot = 3.07796024634624 | epot = -22.899088756596 | etot = -17.8416354145043 +624000 ekin = 2.09648243468335 | erot = 2.65430331108241 | epot = -22.914733999871 | etot = -18.1639482541052 +625000 ekin = 2.53179488470072 | erot = 2.36095144458489 | epot = -22.9722766139489 | etot = -18.0795302846633 +626000 ekin = 2.71471201325311 | erot = 2.038002303651 | epot = -23.0006194176227 | etot = -18.2479051007186 +627000 ekin = 2.22374294193216 | erot = 2.35282114621755 | epot = -22.9588355159151 | etot = -18.3822714277654 +628000 ekin = 2.28003968408293 | erot = 2.28859673286464 | epot = -22.8537881524811 | etot = -18.2851517355335 +629000 ekin = 2.52123014813329 | erot = 1.89624895610832 | epot = -22.7908976494591 | etot = -18.3734185452175 +630000 ekin = 3.09551469183927 | erot = 2.51634259883875 | epot = -22.7156574639271 | etot = -17.1038001732491 +631000 ekin = 2.38491234780997 | erot = 3.31746706623938 | epot = -22.7274824388449 | etot = -17.0251030247955 +632000 ekin = 2.58509546960735 | erot = 2.52764681234154 | epot = -22.6801845001954 | etot = -17.5674422182465 +633000 ekin = 2.43450196234921 | erot = 1.9074646477535 | epot = -22.6545806388637 | etot = -18.312614028761 +634000 ekin = 2.22577935817066 | erot = 2.00781737526926 | epot = -22.5723806994747 | etot = -18.3387839660348 +635000 ekin = 2.21833116743445 | erot = 1.98256884900851 | epot = -22.5422908112103 | etot = -18.3413907947673 +636000 ekin = 2.25207449335774 | erot = 2.77890466668274 | epot = -22.5736742647701 | etot = -17.5426951047296 +637000 ekin = 1.94359576469155 | erot = 2.6121109986752 | epot = -22.6035657643129 | etot = -18.0478590009461 +638000 ekin = 2.53947002676468 | erot = 3.14006412371943 | epot = -22.5826147275244 | etot = -16.9030805770402 +639000 ekin = 2.37745481188141 | erot = 2.49540365345358 | epot = -22.5449630195302 | etot = -17.6721045541952 +640000 ekin = 2.08212454926531 | erot = 2.21940536991445 | epot = -22.453303862966 | etot = -18.1517739437862 +641000 ekin = 2.47971433110368 | erot = 3.55852071727848 | epot = -22.3500233136602 | etot = -16.3117882652781 +642000 ekin = 3.38958957156561 | erot = 2.18184701440171 | epot = -22.2389727056174 | etot = -16.6675361196501 +643000 ekin = 2.84881174665207 | erot = 2.413254877821 | epot = -22.1927147648616 | etot = -16.9306481403886 +644000 ekin = 2.9788163296922 | erot = 1.93799042516405 | epot = -22.1764728944767 | etot = -17.2596661396204 +645000 ekin = 4.12550859701587 | erot = 1.89960014649319 | epot = -22.1706973334318 | etot = -16.1455885899228 +646000 ekin = 2.52696357860359 | erot = 2.00637360005821 | epot = -22.1102258356952 | etot = -17.5768886570333 +647000 ekin = 2.55512268942677 | erot = 2.20922204555245 | epot = -22.1538572894812 | etot = -17.389512554502 +648000 ekin = 3.02957533574521 | erot = 2.11325139659861 | epot = -22.1575349215939 | etot = -17.0147081892501 +649000 ekin = 2.58453912449214 | erot = 3.20631221677863 | epot = -22.1339073532352 | etot = -16.3430560119644 +650000 ekin = 3.77204744414227 | erot = 2.43066777037188 | epot = -22.0837500061792 | etot = -15.8810347916651 +651000 ekin = 3.31369677202991 | erot = 2.36221103045568 | epot = -21.9243902112032 | etot = -16.2484824087176 +652000 ekin = 2.49262898649827 | erot = 3.02155153905954 | epot = -21.7253342697997 | etot = -16.2111537442419 +653000 ekin = 2.82559687485827 | erot = 2.53899564631137 | epot = -21.7211782659414 | etot = -16.3565857447718 +654000 ekin = 2.35170683287638 | erot = 2.15925543988734 | epot = -21.9219546077978 | etot = -17.4109923350341 +655000 ekin = 2.2746913368331 | erot = 2.12498780379593 | epot = -21.9020101665877 | etot = -17.5023310259586 +656000 ekin = 2.33856358324454 | erot = 2.10525554685067 | epot = -21.9227166217961 | etot = -17.4788974917008 +657000 ekin = 2.74434355807405 | erot = 2.19006149870653 | epot = -22.1368388094875 | etot = -17.2024337527069 +658000 ekin = 3.04721032533817 | erot = 2.59752520159664 | epot = -22.2936626687419 | etot = -16.6489271418071 +659000 ekin = 2.86427564828999 | erot = 3.42151988715138 | epot = -22.2986314842237 | etot = -16.0128359487823 +660000 ekin = 2.92506899234012 | erot = 1.63381738879488 | epot = -22.3375917964994 | etot = -17.7787054153644 +661000 ekin = 3.22051797741487 | erot = 1.86658559874782 | epot = -22.4692759662967 | etot = -17.382172390134 +662000 ekin = 3.06008561550976 | erot = 2.20194497946945 | epot = -22.5616874184536 | etot = -17.2996568234744 +663000 ekin = 1.91383924631387 | erot = 2.47155788641765 | epot = -22.6270449564058 | etot = -18.2416478236743 +664000 ekin = 1.43175220258741 | erot = 1.36481827202384 | epot = -22.714938601816 | etot = -19.9183681272047 +665000 ekin = 1.55751729325324 | erot = 2.30904543593978 | epot = -22.7903483651339 | etot = -18.9237856359409 +666000 ekin = 2.44554812999981 | erot = 1.7728381640758 | epot = -22.9292683336281 | etot = -18.7108820395525 +667000 ekin = 2.81292959120154 | erot = 2.33182461186713 | epot = -23.1152300896738 | etot = -17.9704758866051 +668000 ekin = 2.71701517852366 | erot = 3.1927510370022 | epot = -23.1898047541379 | etot = -17.2800385386121 +669000 ekin = 3.4211844979108 | erot = 2.4483988547294 | epot = -23.2367567149657 | etot = -17.3671733623255 +670000 ekin = 2.540272537006 | erot = 1.98108817711494 | epot = -23.1773017073799 | etot = -18.655940993259 +671000 ekin = 2.38054183576284 | erot = 2.98341127846263 | epot = -23.1403357669317 | etot = -17.7763826527062 +672000 ekin = 3.02714775234025 | erot = 2.54429912094893 | epot = -23.1240813931427 | etot = -17.5526345198536 +673000 ekin = 3.42342714962536 | erot = 2.36764796314287 | epot = -23.0365834633316 | etot = -17.2455083505634 +674000 ekin = 3.1787369792725 | erot = 2.10003598211897 | epot = -22.9565366380298 | etot = -17.6777636766383 +675000 ekin = 2.35379506516488 | erot = 1.53509045481238 | epot = -22.8504434741329 | etot = -18.9615579541557 +676000 ekin = 2.44888744246419 | erot = 2.24653163842729 | epot = -22.7725645250621 | etot = -18.0771454441706 +677000 ekin = 2.75831894151647 | erot = 1.93124166774781 | epot = -22.8527844251281 | etot = -18.1632238158638 +678000 ekin = 2.86751481243524 | erot = 1.65310315497864 | epot = -22.8648869805436 | etot = -18.3442690131297 +679000 ekin = 2.34238342331609 | erot = 2.69036620616395 | epot = -22.9330609670147 | etot = -17.9003113375347 +680000 ekin = 2.47092831167294 | erot = 2.90821987338148 | epot = -22.9893989293305 | etot = -17.610250744276 +681000 ekin = 1.90592213851373 | erot = 2.57738203916981 | epot = -22.9226803153478 | etot = -18.4393761376642 +682000 ekin = 2.11776015116235 | erot = 2.69956516894844 | epot = -22.8385618600593 | etot = -18.0212365399485 +683000 ekin = 2.36569744411279 | erot = 2.12377742206911 | epot = -22.7248964050232 | etot = -18.2354215388413 +684000 ekin = 2.87481829504096 | erot = 2.65568540935019 | epot = -22.6557781340276 | etot = -17.1252744296364 +685000 ekin = 3.04590812681261 | erot = 2.17384411148381 | epot = -22.6239841629455 | etot = -17.4042319246491 +686000 ekin = 2.45732454887051 | erot = 2.42727693460545 | epot = -22.5554269158738 | etot = -17.6708254323979 +687000 ekin = 2.74615797772517 | erot = 1.80419114366277 | epot = -22.4906419692597 | etot = -17.9402928478718 +688000 ekin = 1.7920739822545 | erot = 2.04572898801195 | epot = -22.4080555397627 | etot = -18.5702525694962 +689000 ekin = 2.87658871003945 | erot = 1.89509928788519 | epot = -22.4597913998897 | etot = -17.6881034019651 +690000 ekin = 2.12362847773645 | erot = 2.42433705189552 | epot = -22.5737079170673 | etot = -18.0257423874353 +691000 ekin = 2.15963929746743 | erot = 2.52975117929537 | epot = -22.5896382204305 | etot = -17.9002477436677 +692000 ekin = 2.88714768351631 | erot = 2.65189982514091 | epot = -22.4796475018852 | etot = -16.9405999932279 +693000 ekin = 2.30934205113368 | erot = 2.51896960835911 | epot = -22.3454093965687 | etot = -17.5170977370759 +694000 ekin = 2.90083400146798 | erot = 2.34214046553658 | epot = -22.2620689836397 | etot = -17.0190945166351 +695000 ekin = 2.9577943585455 | erot = 2.23887088042094 | epot = -22.303054593607 | etot = -17.1063893546405 +696000 ekin = 2.65803880066321 | erot = 2.33953886943022 | epot = -22.3444459486844 | etot = -17.3468682785909 +697000 ekin = 1.89104688866877 | erot = 1.78290264315477 | epot = -22.3519476787994 | etot = -18.6779981469758 +698000 ekin = 2.22763370474282 | erot = 2.82521193129044 | epot = -22.374966668557 | etot = -17.3221210325237 +699000 ekin = 2.35357258316915 | erot = 2.06864522211151 | epot = -22.302995332199 | etot = -17.8807775269184 +700000 ekin = 2.58206368687336 | erot = 2.33093601350411 | epot = -22.2613878464485 | etot = -17.3483881460711 +701000 ekin = 2.99704307093403 | erot = 1.89954183386767 | epot = -22.3232249760621 | etot = -17.4266400712604 +702000 ekin = 2.67512006336489 | erot = 2.64729282748452 | epot = -22.3604874692709 | etot = -17.0380745784215 +703000 ekin = 2.02348242287829 | erot = 2.03755058248806 | epot = -22.4348344343157 | etot = -18.3738014289493 +704000 ekin = 1.59657624705204 | erot = 1.63613322855987 | epot = -22.4674717825454 | etot = -19.2347623069335 +705000 ekin = 2.34019771505867 | erot = 1.91006554831154 | epot = -22.5441024225864 | etot = -18.2938391592161 +706000 ekin = 2.47926998793354 | erot = 3.26999075651193 | epot = -22.5117539612542 | etot = -16.7624932168087 +707000 ekin = 2.38604341038216 | erot = 2.41699636933021 | epot = -22.604009927914 | etot = -17.8009701482016 +708000 ekin = 1.68115636633466 | erot = 2.34002138995268 | epot = -22.7466665621618 | etot = -18.7254888058744 +709000 ekin = 1.80992626994918 | erot = 2.57911114058356 | epot = -23.0637398035031 | etot = -18.6747023929704 +710000 ekin = 2.07665974484992 | erot = 1.83617776589231 | epot = -23.1977961917903 | etot = -19.2849586810481 +711000 ekin = 1.95352231029107 | erot = 2.41454578486037 | epot = -23.2358193849337 | etot = -18.8677512897822 +712000 ekin = 2.13370686414587 | erot = 1.78661700982467 | epot = -23.2645434465923 | etot = -19.3442195726217 +713000 ekin = 2.90695161716251 | erot = 1.55091931636559 | epot = -23.1835772351912 | etot = -18.7257063016631 +714000 ekin = 2.06629801094757 | erot = 1.86611085535956 | epot = -23.2239032864041 | etot = -19.2914944200969 +715000 ekin = 2.52903922778277 | erot = 1.94261958015835 | epot = -23.1658397986034 | etot = -18.6941809906622 +716000 ekin = 3.03498992772823 | erot = 2.21064066235538 | epot = -23.2216970852983 | etot = -17.9760664952147 +717000 ekin = 3.07971375394894 | erot = 2.47094593918087 | epot = -23.3639588975855 | etot = -17.8132992044557 +718000 ekin = 3.49703192209654 | erot = 2.27170758510088 | epot = -23.4199184473786 | etot = -17.6511789401811 +719000 ekin = 4.06139770605771 | erot = 3.10418818480813 | epot = -23.4072026156126 | etot = -16.2416167247468 +720000 ekin = 2.49828440590245 | erot = 1.90909738802778 | epot = -23.262316602338 | etot = -18.8549348084078 +721000 ekin = 2.57931762358207 | erot = 1.98570897250437 | epot = -23.1440560046385 | etot = -18.579029408552 +722000 ekin = 2.01081836336836 | erot = 2.2747167647488 | epot = -23.1040519922181 | etot = -18.8185168641009 +723000 ekin = 2.44097316114449 | erot = 2.07630856281912 | epot = -23.1828606158314 | etot = -18.6655788918678 +724000 ekin = 1.90797367222605 | erot = 1.93592443836535 | epot = -23.2376437089983 | etot = -19.3937455984069 +725000 ekin = 2.19373210936071 | erot = 2.80513028222362 | epot = -23.2888134461385 | etot = -18.2899510545542 +726000 ekin = 2.2764864004673 | erot = 2.54378150467671 | epot = -23.3354979947709 | etot = -18.5152300896268 +727000 ekin = 1.72219216954142 | erot = 2.62563304726333 | epot = -23.3703740298761 | etot = -19.0225488130713 +728000 ekin = 2.25087046178847 | erot = 3.59486012962608 | epot = -23.435416924773 | etot = -17.5896863333584 +729000 ekin = 2.68839033328484 | erot = 1.72111131116557 | epot = -23.4784810452544 | etot = -19.0689794008039 +730000 ekin = 2.5329756962683 | erot = 2.7666773813211 | epot = -23.4899025882625 | etot = -18.1902495106731 +731000 ekin = 2.6760609901083 | erot = 2.04579712240261 | epot = -23.5241973416199 | etot = -18.802339229109 +732000 ekin = 2.77848516459028 | erot = 1.88432734797838 | epot = -23.5774208145874 | etot = -18.9146083020187 +733000 ekin = 2.18895381088671 | erot = 2.63471719118119 | epot = -23.6107634586383 | etot = -18.7870924565704 +734000 ekin = 1.69467760927658 | erot = 2.30338410687055 | epot = -23.5936446347431 | etot = -19.595582918596 +735000 ekin = 2.17749689272956 | erot = 2.71618098412724 | epot = -23.5330417303215 | etot = -18.6393638534647 +736000 ekin = 2.29375858428166 | erot = 1.1740900723812 | epot = -23.503450790287 | etot = -20.0356021336242 +737000 ekin = 2.20827752624533 | erot = 3.11531250945766 | epot = -23.4552023795231 | etot = -18.1316123438201 +738000 ekin = 1.72303720787712 | erot = 2.28747842674015 | epot = -23.3309270174989 | etot = -19.3204113828816 +739000 ekin = 1.39492824364512 | erot = 2.17488386602882 | epot = -23.28548996576 | etot = -19.7156778560861 +740000 ekin = 1.90426261774289 | erot = 2.27825159935278 | epot = -23.2514184467463 | etot = -19.0689042296506 +741000 ekin = 2.02024508457136 | erot = 2.72073546284876 | epot = -23.1876217096301 | etot = -18.4466411622099 +742000 ekin = 1.97487019042321 | erot = 1.87541960482772 | epot = -23.0929182320365 | etot = -19.2426284367856 +743000 ekin = 1.96486238454688 | erot = 2.76982785281128 | epot = -22.9318899502109 | etot = -18.1971997128528 +744000 ekin = 2.04909521933131 | erot = 2.34373814592941 | epot = -22.8510525613065 | etot = -18.4582191960458 +745000 ekin = 1.66771130319646 | erot = 1.87270341329448 | epot = -22.7977076876185 | etot = -19.2572929711276 +746000 ekin = 2.11650515037838 | erot = 2.03542197982564 | epot = -22.7785820280378 | etot = -18.6266548978338 +747000 ekin = 3.07964448387158 | erot = 1.66910106460583 | epot = -22.8037757029139 | etot = -18.0550301544365 +748000 ekin = 3.03811477337698 | erot = 1.85631102018694 | epot = -22.8436239146773 | etot = -17.9491981211133 +749000 ekin = 2.53753852426481 | erot = 2.01199117356573 | epot = -22.860297041716 | etot = -18.3107673438855 +750000 ekin = 2.77210902960465 | erot = 2.32628560304478 | epot = -22.9528220918576 | etot = -17.8544274592082 +751000 ekin = 2.52040431872467 | erot = 2.34903725042469 | epot = -23.0127359055533 | etot = -18.1432943364039 +752000 ekin = 2.46408285580806 | erot = 1.68868786663082 | epot = -22.9901282704654 | etot = -18.8373575480265 +753000 ekin = 2.47364326188914 | erot = 1.55776271670366 | epot = -23.1135680684223 | etot = -19.0821620898295 +754000 ekin = 2.5278916038673 | erot = 2.29496804643662 | epot = -23.2403939606523 | etot = -18.4175343103483 +755000 ekin = 1.52934303772527 | erot = 2.21322404979637 | epot = -23.262110017443 | etot = -19.5195429299214 +756000 ekin = 2.10423967353423 | erot = 2.40303050505255 | epot = -23.1685739957517 | etot = -18.6613038171649 +757000 ekin = 2.92559629660516 | erot = 2.0691293568206 | epot = -23.1502917576405 | etot = -18.1555661042147 +758000 ekin = 2.37300490719645 | erot = 2.51363215153151 | epot = -23.0495756460038 | etot = -18.1629385872758 +759000 ekin = 2.6014595730178 | erot = 2.39657042348208 | epot = -22.9025259489071 | etot = -17.9044959524072 +760000 ekin = 3.23086874355225 | erot = 2.77072134903012 | epot = -22.8089299952235 | etot = -16.8073399026412 +761000 ekin = 3.41475369307092 | erot = 1.70180532416599 | epot = -22.7404708369396 | etot = -17.6239118197027 +762000 ekin = 3.40874473404401 | erot = 2.52147443954634 | epot = -22.5276669204419 | etot = -16.5974477468515 +763000 ekin = 2.64281892112082 | erot = 1.82464895439093 | epot = -22.3890167593186 | etot = -17.9215488838069 +764000 ekin = 2.38098664175603 | erot = 2.71455563654527 | epot = -22.2309521785191 | etot = -17.1354099002178 +765000 ekin = 2.24221473762586 | erot = 1.94826539133556 | epot = -22.122583392123 | etot = -17.9321032631616 +766000 ekin = 2.50645584526003 | erot = 1.96129579948818 | epot = -21.9857907119498 | etot = -17.5180390672015 +767000 ekin = 2.34028568638226 | erot = 2.64592471376141 | epot = -21.9051815399867 | etot = -16.918971139843 +768000 ekin = 1.86752761821211 | erot = 2.06138447840236 | epot = -21.8874171216963 | etot = -17.9585050250818 +769000 ekin = 3.03590459157853 | erot = 2.66440802561784 | epot = -21.8247140853503 | etot = -16.124401468154 +770000 ekin = 2.42567220683552 | erot = 1.97830158892933 | epot = -21.8110526122117 | etot = -17.4070788164468 +771000 ekin = 2.20056711884501 | erot = 2.53255190976195 | epot = -21.7341162461991 | etot = -17.0009972175921 +772000 ekin = 2.75016173617492 | erot = 1.98403019503999 | epot = -21.8164316952287 | etot = -17.0822397640138 +773000 ekin = 2.14723076845117 | erot = 2.41512334908793 | epot = -21.9576017041203 | etot = -17.3952475865812 +774000 ekin = 2.20536023895281 | erot = 1.98379412617599 | epot = -22.043759647449 | etot = -17.8546052823202 +775000 ekin = 2.53158393271132 | erot = 2.8225938280108 | epot = -22.2469056379858 | etot = -16.8927278772637 +776000 ekin = 3.15988726149912 | erot = 2.46223044860468 | epot = -22.4204382258798 | etot = -16.798320515776 +777000 ekin = 1.91542872566335 | erot = 1.75408058586262 | epot = -22.4517075164596 | etot = -18.7821982049336 +778000 ekin = 2.94665474162607 | erot = 2.31805831302194 | epot = -22.4632153304498 | etot = -17.1985022758018 +779000 ekin = 3.10970934270731 | erot = 2.04446179405629 | epot = -22.4851490287702 | etot = -17.3309778920066 +780000 ekin = 2.85215832341045 | erot = 3.13312086675091 | epot = -22.4501531708741 | etot = -16.4648739807127 +781000 ekin = 2.36733074493229 | erot = 3.56399648845806 | epot = -22.4171363625471 | etot = -16.4858091291567 +782000 ekin = 2.32796510372074 | erot = 2.86343667143255 | epot = -22.3438054250098 | etot = -17.1524036498565 +783000 ekin = 1.86439500745061 | erot = 3.05233385447291 | epot = -22.2079509833896 | etot = -17.2912221214661 +784000 ekin = 2.05476588420882 | erot = 2.29789997988689 | epot = -22.1006364427793 | etot = -17.7479705786836 +785000 ekin = 2.03879516593738 | erot = 2.15052527915338 | epot = -22.0056061371158 | etot = -17.816285692025 +786000 ekin = 2.3752160296601 | erot = 2.32156698168742 | epot = -21.9727988200248 | etot = -17.2760158086773 +787000 ekin = 2.76686314352376 | erot = 2.23625261993099 | epot = -21.8969600931556 | etot = -16.8938443297008 +788000 ekin = 2.13318993659091 | erot = 2.25162748275281 | epot = -21.8604178455632 | etot = -17.4756004262194 +789000 ekin = 1.98216852118508 | erot = 1.98058785261598 | epot = -21.844134033761 | etot = -17.8813776599599 +790000 ekin = 1.67847851427146 | erot = 1.42560334440858 | epot = -21.941301490604 | etot = -18.837219631924 +791000 ekin = 2.12689982203095 | erot = 2.53200907087448 | epot = -22.0864434478656 | etot = -17.4275345549602 +792000 ekin = 1.72797703494859 | erot = 2.22448376175168 | epot = -22.1854190028922 | etot = -18.2329582061919 +793000 ekin = 3.18409314211953 | erot = 1.94056710411296 | epot = -22.3760603901177 | etot = -17.2514001438852 +794000 ekin = 2.49071782059139 | erot = 3.01186430180266 | epot = -22.4315505782774 | etot = -16.9289684558833 +795000 ekin = 2.89844296027926 | erot = 3.07659510288655 | epot = -22.5164404652995 | etot = -16.5414024021337 +796000 ekin = 2.32845268798927 | erot = 1.62708270564126 | epot = -22.5660647482766 | etot = -18.6105293546461 +797000 ekin = 2.20766900620157 | erot = 3.6597733457204 | epot = -22.5351911425215 | etot = -16.6677487905995 +798000 ekin = 2.12139450500735 | erot = 2.94419809776829 | epot = -22.53586560158 | etot = -17.4702729988044 +799000 ekin = 2.48452434226029 | erot = 2.7415786036137 | epot = -22.4941328101442 | etot = -17.2680298642702 +800000 ekin = 2.17521613585505 | erot = 2.96480330538541 | epot = -22.3818079549674 | etot = -17.2417885137269 +801000 ekin = 2.54690065539559 | erot = 2.74966931670846 | epot = -22.3008594124712 | etot = -17.0042894403671 +802000 ekin = 3.02823775407486 | erot = 2.8915936784506 | epot = -22.2024149184001 | etot = -16.2825834858746 +803000 ekin = 2.21042161290743 | erot = 2.51594019231142 | epot = -22.1069208353333 | etot = -17.3805590301145 +804000 ekin = 2.91061289296152 | erot = 1.5830418961718 | epot = -22.0839512655924 | etot = -17.5902964764591 +805000 ekin = 2.67762522194669 | erot = 3.06970455948968 | epot = -22.0793101970619 | etot = -16.3319804156255 +806000 ekin = 2.75979804034939 | erot = 2.2176860954027 | epot = -22.0549669082474 | etot = -17.0774827724953 +807000 ekin = 2.11041519443391 | erot = 2.83915265443807 | epot = -22.1073292774231 | etot = -17.1577614285511 +808000 ekin = 1.84392510139081 | erot = 2.29797054411878 | epot = -22.0753255923415 | etot = -17.9334299468319 +809000 ekin = 1.93171652686567 | erot = 1.94021167949754 | epot = -22.0668297694372 | etot = -18.194901563074 +810000 ekin = 1.97774334424761 | erot = 2.6472977913531 | epot = -22.1020544833021 | etot = -17.4770133477014 +811000 ekin = 2.2417092413671 | erot = 1.75505259459069 | epot = -22.1062654329495 | etot = -18.1095035969917 +812000 ekin = 2.49053159164605 | erot = 2.33986799245713 | epot = -22.124141511127 | etot = -17.2937419270238 +813000 ekin = 3.01755249739549 | erot = 2.24004680047387 | epot = -22.1167722656682 | etot = -16.8591729677989 +814000 ekin = 2.86045886242639 | erot = 2.24119269343823 | epot = -22.1084535534804 | etot = -17.0068019976158 +815000 ekin = 2.57503557502156 | erot = 2.76212054641368 | epot = -21.9950519676046 | etot = -16.6578958461694 +816000 ekin = 2.19961906931023 | erot = 2.59194277056134 | epot = -22.0843443380244 | etot = -17.2927824981528 +817000 ekin = 1.75062364873707 | erot = 2.66165019507354 | epot = -22.3739862599355 | etot = -17.9617124161249 +818000 ekin = 2.24809257416679 | erot = 2.59026399650675 | epot = -22.5610524731389 | etot = -17.7226959024654 +819000 ekin = 2.12537334404071 | erot = 2.59618311382673 | epot = -22.5606510650104 | etot = -17.839094607143 +820000 ekin = 1.93414650390356 | erot = 2.29085663493509 | epot = -22.4839314706954 | etot = -18.2589283318568 +821000 ekin = 2.11382182469737 | erot = 2.38685226676536 | epot = -22.47627897247 | etot = -17.9756048810073 +822000 ekin = 2.2613431095799 | erot = 2.12056938305333 | epot = -22.370909843474 | etot = -17.9889973508408 +823000 ekin = 2.31560863750917 | erot = 2.60350436456086 | epot = -22.4988996092736 | etot = -17.5797866072036 +824000 ekin = 1.73697879038959 | erot = 1.5185057021212 | epot = -22.6200401147494 | etot = -19.3645556222386 +825000 ekin = 1.63614248894086 | erot = 1.97731468932685 | epot = -22.6198150724223 | etot = -19.0063578941546 +826000 ekin = 2.00841233147246 | erot = 2.17850248200248 | epot = -22.5466518143203 | etot = -18.3597370008454 +827000 ekin = 2.18457105279113 | erot = 2.44711764942285 | epot = -22.4005870169979 | etot = -17.7688983147839 +828000 ekin = 1.91039404464085 | erot = 2.73449242191012 | epot = -22.3948651441296 | etot = -17.7499786775786 +829000 ekin = 2.07228257188588 | erot = 2.97134747466499 | epot = -22.4347910090961 | etot = -17.3911609625452 +830000 ekin = 1.99293621346915 | erot = 2.15765133255911 | epot = -22.4843800017124 | etot = -18.3337924556842 +831000 ekin = 2.33241187954984 | erot = 2.37634533076884 | epot = -22.5757045912718 | etot = -17.8669473809531 +832000 ekin = 2.02856108052035 | erot = 1.94729581180225 | epot = -22.6670251626246 | etot = -18.691168270302 +833000 ekin = 2.28623411522758 | erot = 2.15108044390973 | epot = -22.7566850878713 | etot = -18.319370528734 +834000 ekin = 2.12105013529711 | erot = 1.5116778668129 | epot = -22.7735851481702 | etot = -19.1408571460602 +835000 ekin = 2.88531776933573 | erot = 2.74027641398136 | epot = -22.8585330533172 | etot = -17.2329388700001 +836000 ekin = 3.32070208623905 | erot = 2.42231134749978 | epot = -22.8959107751695 | etot = -17.1528973414306 +837000 ekin = 2.74149226799164 | erot = 2.32127198719276 | epot = -22.8906677110002 | etot = -17.8279034558158 +838000 ekin = 3.13302338440878 | erot = 3.19829232559053 | epot = -22.9166668544453 | etot = -16.585351144446 +839000 ekin = 2.73522885875602 | erot = 2.61100294075548 | epot = -22.8499426413711 | etot = -17.5037108418596 +840000 ekin = 2.97139629828009 | erot = 1.43157972743722 | epot = -22.7763904271576 | etot = -18.3734144014403 +841000 ekin = 2.9571795545775 | erot = 2.67280681737836 | epot = -22.7408850128302 | etot = -17.1108986408743 +842000 ekin = 2.17222575948606 | erot = 2.30478646820068 | epot = -22.7382440804492 | etot = -18.2612318527624 +843000 ekin = 2.83292824269634 | erot = 2.04165126380544 | epot = -22.7426687858571 | etot = -17.8680892793554 +844000 ekin = 2.95938970875204 | erot = 1.50198210425589 | epot = -22.783719790782 | etot = -18.3223479777741 +845000 ekin = 3.16076837184522 | erot = 2.28216144351779 | epot = -22.7913524647186 | etot = -17.3484226493555 +846000 ekin = 3.3398977708405 | erot = 2.53602189023877 | epot = -22.7943227793905 | etot = -16.9184031183113 +847000 ekin = 2.14145435242079 | erot = 2.75036267291773 | epot = -22.7255800042885 | etot = -17.83376297895 +848000 ekin = 2.48912550447967 | erot = 2.81875176956459 | epot = -22.5834297802211 | etot = -17.2755525061768 +849000 ekin = 1.98023552181666 | erot = 2.5692134285068 | epot = -22.4587431120173 | etot = -17.9092941616939 +850000 ekin = 2.0475383789703 | erot = 1.80627608629883 | epot = -22.442868440532 | etot = -18.5890539752628 +851000 ekin = 2.09704360250612 | erot = 1.85768640504848 | epot = -22.4344168330881 | etot = -18.4796868255335 +852000 ekin = 1.70813487206096 | erot = 1.42387059402563 | epot = -22.3764553852037 | etot = -19.2444499191171 +853000 ekin = 2.00140314580349 | erot = 3.04689599134399 | epot = -22.4103147041128 | etot = -17.3620155669653 +854000 ekin = 3.02149896921022 | erot = 2.22990677084323 | epot = -22.4965128093929 | etot = -17.2451070693394 +855000 ekin = 2.19607047478225 | erot = 2.83672007906388 | epot = -22.5083573431917 | etot = -17.4755667893456 +856000 ekin = 2.44947669543341 | erot = 1.52884872890501 | epot = -22.4898047833717 | etot = -18.5114793590332 +857000 ekin = 2.53345481305323 | erot = 2.80399799726174 | epot = -22.39864736443 | etot = -17.061194554115 +858000 ekin = 2.20266598505728 | erot = 2.82477658278041 | epot = -22.322749893257 | etot = -17.2953073254193 +859000 ekin = 2.30655855498922 | erot = 2.31428920065484 | epot = -22.299458676259 | etot = -17.6786109206149 +860000 ekin = 1.99697183524065 | erot = 1.95028062775308 | epot = -22.3156691349687 | etot = -18.3684166719749 +861000 ekin = 2.69687116915107 | erot = 2.24433771449493 | epot = -22.3086232893581 | etot = -17.3674144057121 +862000 ekin = 2.86022987586877 | erot = 2.41684736135787 | epot = -22.2874375572893 | etot = -17.0103603200626 +863000 ekin = 2.60871204568914 | erot = 3.3557366458487 | epot = -22.2313024399491 | etot = -16.2668537484113 +864000 ekin = 2.90978326967391 | erot = 2.29745178043259 | epot = -22.1985713670251 | etot = -16.9913363169186 +865000 ekin = 1.92892881804686 | erot = 2.15731715168145 | epot = -22.0984656787339 | etot = -18.0122197090056 +866000 ekin = 1.96990768776308 | erot = 1.64764578107637 | epot = -21.9980087709689 | etot = -18.3804553021294 +867000 ekin = 1.75218832670564 | erot = 3.37220276943672 | epot = -21.9060579112704 | etot = -16.781666815128 +868000 ekin = 1.82818126605702 | erot = 2.79449094294287 | epot = -21.9401796601767 | etot = -17.3175074511768 +869000 ekin = 2.38095838431442 | erot = 2.38587739965205 | epot = -22.0329803939138 | etot = -17.2661446099473 +870000 ekin = 1.91334960398162 | erot = 3.22058637313173 | epot = -22.0372634175766 | etot = -16.9033274404632 +871000 ekin = 3.11762256076551 | erot = 2.95337521110721 | epot = -21.9585521021423 | etot = -15.8875543302696 +872000 ekin = 2.97995457097216 | erot = 1.38589789821627 | epot = -21.8388140547637 | etot = -17.4729615855753 +873000 ekin = 2.75063242740213 | erot = 2.24384409185972 | epot = -21.7621446383558 | etot = -16.767668119094 +874000 ekin = 2.42548187796032 | erot = 2.11160399589529 | epot = -21.6726796153781 | etot = -17.1355937415225 +875000 ekin = 2.99029080863986 | erot = 2.74119845235593 | epot = -21.6681717382462 | etot = -15.9366824772504 +876000 ekin = 2.13275197859305 | erot = 2.233203194222 | epot = -21.6687594523732 | etot = -17.3028042795581 +877000 ekin = 1.83070162423874 | erot = 1.6010526911626 | epot = -21.6263742280813 | etot = -18.19461991268 +878000 ekin = 2.01997494895548 | erot = 2.72070409004295 | epot = -21.632105565574 | etot = -16.8914265265756 +879000 ekin = 1.43444833027133 | erot = 2.17422677437648 | epot = -21.5501867528963 | etot = -17.9415116482485 +880000 ekin = 2.09181862571921 | erot = 2.57771231025419 | epot = -21.4847603093162 | etot = -16.8152293733428 +881000 ekin = 1.54081572899847 | erot = 1.98591498012594 | epot = -21.5197472943257 | etot = -17.9930165852013 +882000 ekin = 2.2061903789583 | erot = 2.64808794630213 | epot = -21.6149395754995 | etot = -16.760661250239 +883000 ekin = 2.22398786469444 | erot = 2.23146516226547 | epot = -21.6814015671086 | etot = -17.2259485401487 +884000 ekin = 2.78668802039765 | erot = 2.10130089852047 | epot = -21.7272273228039 | etot = -16.8392384038858 +885000 ekin = 1.92361997638943 | erot = 1.77572378933155 | epot = -21.7696517903878 | etot = -18.0703080246668 +886000 ekin = 1.99836032534883 | erot = 3.11596676947403 | epot = -21.7879382713548 | etot = -16.673611176532 +887000 ekin = 1.98879909318866 | erot = 2.81589132946027 | epot = -21.7923091863043 | etot = -16.9876187636554 +888000 ekin = 1.92041141945741 | erot = 2.3252911526479 | epot = -21.8607011941373 | etot = -17.614998622032 +889000 ekin = 1.8806357075667 | erot = 2.46119753007268 | epot = -21.9506056361693 | etot = -17.6087723985299 +890000 ekin = 1.86005551534237 | erot = 2.25705356539098 | epot = -22.0523870894554 | etot = -17.9352780087221 +891000 ekin = 2.60384568426052 | erot = 2.35330960558484 | epot = -22.1900620535717 | etot = -17.2329067637263 +892000 ekin = 2.68682478776143 | erot = 2.69192226449536 | epot = -22.2913421142228 | etot = -16.9125950619661 +893000 ekin = 2.17360632388892 | erot = 2.98553431183659 | epot = -22.2913111245685 | etot = -17.132170488843 +894000 ekin = 2.52600330506545 | erot = 2.45861329518365 | epot = -22.2813523194117 | etot = -17.2967357191626 +895000 ekin = 2.51964265942842 | erot = 2.458508768977 | epot = -22.3090530666537 | etot = -17.3309016382482 +896000 ekin = 1.83970949418621 | erot = 2.7876698428861 | epot = -22.2816769795447 | etot = -17.6542976424724 +897000 ekin = 2.36177466310812 | erot = 2.0208895092276 | epot = -22.2244555724411 | etot = -17.8417914001054 +898000 ekin = 2.11475930620727 | erot = 1.90142689771282 | epot = -22.1399515435435 | etot = -18.1237653396234 +899000 ekin = 2.62628238826603 | erot = 2.33607509693707 | epot = -22.040854543184 | etot = -17.0784970579809 +900000 ekin = 2.1134311489616 | erot = 2.28923041198217 | epot = -22.042922147544 | etot = -17.6402605866003 +901000 ekin = 1.9156742929676 | erot = 1.81441237665855 | epot = -22.0776682049659 | etot = -18.3475815353397 +902000 ekin = 2.56902181313363 | erot = 2.49856756454338 | epot = -22.0065137105888 | etot = -16.9389243329118 +903000 ekin = 1.85774740371253 | erot = 2.17490444163848 | epot = -21.9440961512363 | etot = -17.9114443058853 +904000 ekin = 1.86493397406833 | erot = 2.32873873815716 | epot = -21.8931358584844 | etot = -17.6994631462589 +905000 ekin = 2.31979070947169 | erot = 2.14360558294755 | epot = -21.824385320242 | etot = -17.3609890278228 +906000 ekin = 2.49844805906095 | erot = 2.24842339845928 | epot = -21.8343155675942 | etot = -17.087444110074 +907000 ekin = 4.2050069684007 | erot = 2.50213003512293 | epot = -21.926981437738 | etot = -15.2198444342144 +908000 ekin = 3.27384188266606 | erot = 2.113986364986 | epot = -22.0851390841283 | etot = -16.6973108364762 +909000 ekin = 2.63126156907554 | erot = 1.92589592890071 | epot = -22.2067426627273 | etot = -17.649585164751 +910000 ekin = 2.59247391196527 | erot = 2.91530974700789 | epot = -22.3083595488238 | etot = -16.8005758898507 +911000 ekin = 2.58542931349158 | erot = 4.35273181589072 | epot = -22.3703725466068 | etot = -15.4322114172245 +912000 ekin = 3.05788115941417 | erot = 3.70629270837706 | epot = -22.3924331468687 | etot = -15.6282592790774 +913000 ekin = 2.82179099955174 | erot = 2.17271040546975 | epot = -22.3592523787226 | etot = -17.3647509737011 +914000 ekin = 2.15502438011904 | erot = 1.21668409626845 | epot = -22.2678100512732 | etot = -18.8961015748857 +915000 ekin = 1.59606663662058 | erot = 2.96270026674799 | epot = -22.1740650061606 | etot = -17.615298102792 +916000 ekin = 2.59113116114426 | erot = 3.74925276784446 | epot = -22.2376802645764 | etot = -15.8972963355877 +917000 ekin = 3.04931771481537 | erot = 2.87183708314021 | epot = -22.2631766381559 | etot = -16.3420218402004 +918000 ekin = 2.92188996322642 | erot = 2.63336986904281 | epot = -22.2586011448583 | etot = -16.7033413125891 +919000 ekin = 3.21078589975638 | erot = 2.75946192406924 | epot = -22.2354679015341 | etot = -16.2652200777085 +920000 ekin = 2.28588196467068 | erot = 2.37332214874002 | epot = -22.2033589800159 | etot = -17.5441548666052 +921000 ekin = 2.38962275209347 | erot = 2.43661594631483 | epot = -22.1850468087942 | etot = -17.3588081103859 +922000 ekin = 2.30444121290069 | erot = 2.41446680487179 | epot = -22.1364838134968 | etot = -17.4175757957243 +923000 ekin = 2.49328668364371 | erot = 2.66692739305866 | epot = -22.1214525565084 | etot = -16.961238479806 +924000 ekin = 1.53749552443357 | erot = 2.96826070169594 | epot = -22.0894201538095 | etot = -17.58366392768 +925000 ekin = 1.85840160112661 | erot = 1.96300614534087 | epot = -22.0261080308484 | etot = -18.2047002843809 +926000 ekin = 1.36444139420093 | erot = 2.1171911056521 | epot = -22.0105169062661 | etot = -18.5288844064131 +927000 ekin = 2.55080456695379 | erot = 2.08771192494034 | epot = -22.0296775970306 | etot = -17.3911611051365 +928000 ekin = 2.08687563155734 | erot = 2.73937352627042 | epot = -22.0655254209395 | etot = -17.2392762631117 +929000 ekin = 1.85842465674464 | erot = 1.85229951899858 | epot = -22.161879510768 | etot = -18.4511553350248 +930000 ekin = 1.98312460976539 | erot = 2.1107410982594 | epot = -22.14836282055 | etot = -18.0544971125252 +931000 ekin = 2.44403538776918 | erot = 1.87099700190232 | epot = -22.0455015122594 | etot = -17.7304691225879 +932000 ekin = 2.7450847259232 | erot = 2.34428750425033 | epot = -22.0610452671158 | etot = -16.9716730369423 +933000 ekin = 3.03611053551161 | erot = 2.51768120120295 | epot = -21.9625013660046 | etot = -16.4087096292901 +934000 ekin = 2.94656859108538 | erot = 2.48807299457996 | epot = -21.861427363924 | etot = -16.4267857782587 +935000 ekin = 2.79276097099932 | erot = 2.14683659927043 | epot = -21.8273092000012 | etot = -16.8877116297315 +936000 ekin = 2.97178317336133 | erot = 2.07585468409967 | epot = -21.8285263420326 | etot = -16.7808884845716 +937000 ekin = 3.04678623330025 | erot = 2.3469475727902 | epot = -21.7540111620946 | etot = -16.3602773560041 +938000 ekin = 2.98751343731959 | erot = 2.36094469095133 | epot = -21.6698990656412 | etot = -16.3214409373703 +939000 ekin = 2.58148991378899 | erot = 2.28540307033942 | epot = -21.641624391377 | etot = -16.7747314072486 +940000 ekin = 2.64449140269543 | erot = 2.76444805229845 | epot = -21.5519193090555 | etot = -16.1429798540616 +941000 ekin = 2.27119597888968 | erot = 2.6047011226429 | epot = -21.4613787017959 | etot = -16.5854816002633 +942000 ekin = 1.87372343217533 | erot = 2.80846718394805 | epot = -21.3627475231486 | etot = -16.6805569070252 +943000 ekin = 2.47144243861285 | erot = 2.33780411758964 | epot = -21.3635196463293 | etot = -16.5542730901269 +944000 ekin = 2.13395812695593 | erot = 1.92152946754219 | epot = -21.3250397924826 | etot = -17.2695521979844 +945000 ekin = 2.55906013749132 | erot = 2.2064112111687 | epot = -21.3688330068161 | etot = -16.6033616581561 +946000 ekin = 2.36057360323902 | erot = 2.87561909021941 | epot = -21.3642087487724 | etot = -16.128016055314 +947000 ekin = 2.0664007802554 | erot = 1.8712733843037 | epot = -21.3615863875836 | etot = -17.4239122230245 +948000 ekin = 1.84827298766581 | erot = 1.37746869479931 | epot = -21.4042186851624 | etot = -18.1784770026972 +949000 ekin = 1.76268582715986 | erot = 2.31704980534492 | epot = -21.4240851264671 | etot = -17.3443494939624 +950000 ekin = 1.71596526195605 | erot = 2.24238613701562 | epot = -21.4136184248624 | etot = -17.4552670258908 +951000 ekin = 1.97739431794919 | erot = 2.32356723589743 | epot = -21.4746626443703 | etot = -17.1737010905236 +952000 ekin = 2.93969915889367 | erot = 2.72641565709973 | epot = -21.5183559681327 | etot = -15.8522411521393 +953000 ekin = 2.94576770934606 | erot = 2.38856498634115 | epot = -21.5141407104899 | etot = -16.1798080148027 +954000 ekin = 3.09120782928501 | erot = 1.98547863545544 | epot = -21.4220978424351 | etot = -16.3454113776947 +955000 ekin = 3.57635302907509 | erot = 2.07344226252239 | epot = -21.3055276294275 | etot = -15.65573233783 +956000 ekin = 2.96199697760255 | erot = 3.68176573533001 | epot = -21.1569123839441 | etot = -14.5131496710115 +957000 ekin = 2.99343140156395 | erot = 2.6641673976979 | epot = -20.9767503534011 | etot = -15.3191515541393 +958000 ekin = 2.66519710291016 | erot = 2.94296730915348 | epot = -20.778322783175 | etot = -15.1701583711114 +959000 ekin = 1.92859078964251 | erot = 2.44737003089627 | epot = -20.7022563699757 | etot = -16.3262955494369 +960000 ekin = 1.49451727360012 | erot = 3.13583888779427 | epot = -20.7118848436939 | etot = -16.0815286822995 +961000 ekin = 1.95030797402212 | erot = 2.08601754519332 | epot = -20.7116280307748 | etot = -16.6753025115593 +962000 ekin = 2.02519672504697 | erot = 1.8993614904036 | epot = -20.7772856698007 | etot = -16.8527274543501 +963000 ekin = 1.81866098250674 | erot = 2.47413067985077 | epot = -20.8446590259958 | etot = -16.5518673636383 +964000 ekin = 2.82274927013719 | erot = 2.43518028535965 | epot = -20.9038261011269 | etot = -15.64589654563 +965000 ekin = 2.55107687208175 | erot = 2.29878175210651 | epot = -20.9717669792334 | etot = -16.1219083550452 +966000 ekin = 2.1200913755337 | erot = 2.2846988725502 | epot = -21.0606259488472 | etot = -16.6558357007633 +967000 ekin = 1.58229605946639 | erot = 3.55757301639252 | epot = -21.1224849810159 | etot = -15.982615905157 +968000 ekin = 1.95011274740584 | erot = 2.3752003899703 | epot = -21.1147445818894 | etot = -16.7894314445132 +969000 ekin = 2.19259033480515 | erot = 2.45911844664679 | epot = -21.0841141670188 | etot = -16.4324053855669 +970000 ekin = 1.87048608890169 | erot = 2.95646346755995 | epot = -21.0142741201673 | etot = -16.1873245637056 +971000 ekin = 1.950153162929 | erot = 3.0717285905854 | epot = -20.9854323440231 | etot = -15.9635505905087 +972000 ekin = 1.93197938125398 | erot = 2.56232300543577 | epot = -20.9700672251306 | etot = -16.4757648384409 +973000 ekin = 2.21536036218028 | erot = 2.92680374210101 | epot = -20.9735070987956 | etot = -15.8313429945143 +974000 ekin = 2.53787477442507 | erot = 2.68950390909793 | epot = -20.9249780227203 | etot = -15.6975993391973 +975000 ekin = 3.3832404833891 | erot = 2.33888514036507 | epot = -20.8975294326534 | etot = -15.1754038088992 +976000 ekin = 2.84644457799265 | erot = 3.11578234174529 | epot = -20.8919958508098 | etot = -14.9297689310719 +977000 ekin = 2.71728271399263 | erot = 2.50842582300821 | epot = -20.8689034899506 | etot = -15.6431949529497 +978000 ekin = 1.79447160570111 | erot = 2.0736426807417 | epot = -20.8420102217514 | etot = -16.9738959353086 +979000 ekin = 1.87121723303036 | erot = 2.21930404593537 | epot = -20.7748213462523 | etot = -16.6843000672865 +980000 ekin = 1.92329753072694 | erot = 1.58075512357095 | epot = -20.7449893755876 | etot = -17.2409367212897 +981000 ekin = 1.54378956643562 | erot = 2.05667260838343 | epot = -20.8055475552994 | etot = -17.2050853804803 +982000 ekin = 1.84106018589786 | erot = 1.96434982363189 | epot = -20.9115392638984 | etot = -17.1061292543687 +983000 ekin = 2.72419781781661 | erot = 1.79041192395563 | epot = -20.935370561762 | etot = -16.4207608199898 +984000 ekin = 3.62592878226169 | erot = 2.63360520982709 | epot = -21.0391300854773 | etot = -14.7795960933885 +985000 ekin = 2.94852029277516 | erot = 2.17123324675229 | epot = -21.210668025134 | etot = -16.0909144856065 +986000 ekin = 2.87308205004233 | erot = 2.17802315487852 | epot = -21.3375937115616 | etot = -16.2864885066408 +987000 ekin = 3.37012638403781 | erot = 2.51985184465596 | epot = -21.4043627880157 | etot = -15.514384559322 +988000 ekin = 3.46870329025365 | erot = 3.24288958557111 | epot = -21.4574256625201 | etot = -14.7458327866953 +989000 ekin = 2.84167714920458 | erot = 2.20794124486355 | epot = -21.6063889534189 | etot = -16.5567705593508 +990000 ekin = 2.79616762915596 | erot = 1.83962543905575 | epot = -21.6049428673847 | etot = -16.969149799173 +991000 ekin = 3.12376374867622 | erot = 3.19217780569165 | epot = -21.5124272449002 | etot = -15.1964856905324 +992000 ekin = 3.28266282243327 | erot = 2.63435990952508 | epot = -21.3973672594977 | etot = -15.4803445275393 +993000 ekin = 3.03845590773447 | erot = 2.22451011589011 | epot = -21.3214832241627 | etot = -16.0585172005382 +994000 ekin = 3.17417330085466 | erot = 2.79358287085479 | epot = -21.2400043434466 | etot = -15.2722481717371 +995000 ekin = 3.20646780888655 | erot = 1.72565517852613 | epot = -21.1372155372729 | etot = -16.2050925498602 +996000 ekin = 3.05109485375234 | erot = 3.18000631651671 | epot = -21.0952864235923 | etot = -14.8641852533233 +997000 ekin = 2.95625677593347 | erot = 3.15916554858247 | epot = -21.058148007987 | etot = -14.942725683471 +998000 ekin = 3.06605914614908 | erot = 1.97682176881012 | epot = -20.9834240684974 | etot = -15.9405431535382 +999000 ekin = 2.08919327368179 | erot = 2.76364485800616 | epot = -20.9705413117635 | etot = -16.1177031800756 +1000000 ekin = 2.11761701334905 | erot = 2.1409630347026 | epot = -20.9096627221725 | etot = -16.6510826741208 + 1000000 0.094116312 -1.3659956 0.059141691 -1.1745029 -3.0654283e-05 +Loop time of 43.6978 on 1 procs for 1000000 steps with 16 atoms + +Performance: 19772.150 tau/day, 22884.433 timesteps/s +98.6% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 32.769 | 32.769 | 32.769 | 0.0 | 74.99 +Bond | 0.93071 | 0.93071 | 0.93071 | 0.0 | 2.13 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.19584 | 0.19584 | 0.19584 | 0.0 | 0.45 +Output | 1e-05 | 1e-05 | 1e-05 | 0.0 | 0.00 +Modify | 9.4507 | 9.4507 | 9.4507 | 0.0 | 21.63 +Other | | 0.3515 | | | 0.80 + +Nlocal: 16 ave 16 max 16 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 116 ave 116 max 116 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 116 +Ave neighs/atom = 7.25 +Ave special neighs/atom = 3.75 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:43 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.4 b/examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.4 new file mode 100644 index 0000000000..8989bce5ef --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex2/log.18Jun19.duplex2.g++.4 @@ -0,0 +1,1173 @@ +LAMMPS (18 Jun 2019) +variable number equal 2 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex2 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 16 atoms + reading velocities ... + 16 velocities + 16 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 13 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 4 = max # of 1-4 neighbors + 6 = max # of special neighbors + special bonds CPU = 0.000162 secs + read_data CPU = 0.002971 secs + +set atom * mass 3.1575 + 16 settings made for mass + +group all type 1 4 +16 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna2/fene +bond_coeff * 2.0 0.25 0.7564 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh +pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna2/stk seqav ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqav 0.1 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 +pair_coeff * * oxdna2/dh 0.1 1.0 0.815 + +# NVE ensemble +#fix 1 all nve/dot +fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 ${T} 0.03 457145 angmom 10 +fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.6274 + ghost atom cutoff = 2.6274 + binsize = 1.3137, bins = 31 31 31 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.777 | 7.959 | 8.142 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.5358787 0.0096742456 -1.5262045 1.0127369e-05 +1000 ekin = 1.34554291364716 | erot = 2.30525041754444 | epot = -24.3924150888896 | etot = -20.741621757698 +2000 ekin = 2.15972469811184 | erot = 2.1628675965276 | epot = -24.3548203354875 | etot = -20.0322280408481 +3000 ekin = 3.26433550542939 | erot = 2.76107866472087 | epot = -24.2947953202752 | etot = -18.269381150125 +4000 ekin = 1.9203212531997 | erot = 2.133394384253 | epot = -24.234098584123 | etot = -20.1803829466703 +5000 ekin = 1.35481075814721 | erot = 2.00854026688447 | epot = -24.1768963201279 | etot = -20.8135452950963 +6000 ekin = 2.18974627635306 | erot = 1.73271671162436 | epot = -24.1096616118305 | etot = -20.1871986238531 +7000 ekin = 2.65472853187395 | erot = 1.73258720631297 | epot = -24.0561118130561 | etot = -19.6687960748691 +8000 ekin = 2.51192327964357 | erot = 2.34132844779952 | epot = -23.9708695663488 | etot = -19.1176178389058 +9000 ekin = 2.24554900802464 | erot = 2.0522939078286 | epot = -23.874757758319 | etot = -19.5769148424658 +10000 ekin = 2.36227360512089 | erot = 1.80185994066737 | epot = -23.7793375260418 | etot = -19.6152039802535 +11000 ekin = 2.03264234985168 | erot = 1.68707706801736 | epot = -23.7396221351636 | etot = -20.0199027172945 +12000 ekin = 2.66329111303325 | erot = 2.49804687909781 | epot = -23.7366995564469 | etot = -18.5753615643158 +13000 ekin = 1.89677055811531 | erot = 2.34624821263612 | epot = -23.6591067615901 | etot = -19.4160879908387 +14000 ekin = 1.91279445145792 | erot = 2.13129118502405 | epot = -23.6468743458148 | etot = -19.6027887093328 +15000 ekin = 2.41876331112169 | erot = 2.07362128417238 | epot = -23.5767792498568 | etot = -19.0843946545628 +16000 ekin = 2.76615310647131 | erot = 1.19495009524763 | epot = -23.4862363509196 | etot = -19.5251331492006 +17000 ekin = 2.45632569069911 | erot = 2.37627186077148 | epot = -23.500787861849 | etot = -18.6681903103784 +18000 ekin = 2.18348858414473 | erot = 2.46933014500077 | epot = -23.5223047738331 | etot = -18.8694860446876 +19000 ekin = 2.2074746303434 | erot = 2.45349372324724 | epot = -23.4618353655003 | etot = -18.8008670119096 +20000 ekin = 2.06964129991908 | erot = 1.80832666230414 | epot = -23.4930879797962 | etot = -19.615120017573 +21000 ekin = 2.26572194434983 | erot = 2.76680470094409 | epot = -23.5023070260553 | etot = -18.4697803807614 +22000 ekin = 2.69295306575102 | erot = 1.86984875574017 | epot = -23.4463493063166 | etot = -18.8835474848254 +23000 ekin = 1.99930153068661 | erot = 2.27735339437466 | epot = -23.3493214662276 | etot = -19.0726665411663 +24000 ekin = 2.20679650752062 | erot = 2.98147599881873 | epot = -23.273517698415 | etot = -18.0852451920757 +25000 ekin = 2.28085541692287 | erot = 2.99165466281124 | epot = -23.2072100929465 | etot = -17.9347000132124 +26000 ekin = 1.9530124305314 | erot = 2.81680126246586 | epot = -23.0636678500934 | etot = -18.2938541570962 +27000 ekin = 1.96948983508855 | erot = 2.69266617300682 | epot = -22.9870601707012 | etot = -18.3249041626058 +28000 ekin = 2.02061868464074 | erot = 2.37038530969117 | epot = -22.9383598315964 | etot = -18.5473558372645 +29000 ekin = 2.51387846128098 | erot = 2.0265039132053 | epot = -22.888959880923 | etot = -18.3485775064367 +30000 ekin = 1.95889729807242 | erot = 2.1170713545074 | epot = -22.7896312662562 | etot = -18.7136626136764 +31000 ekin = 1.81775203419098 | erot = 2.326796842935 | epot = -22.7561124537192 | etot = -18.6115635765932 +32000 ekin = 1.87947265787065 | erot = 2.0009346769358 | epot = -22.8533570528062 | etot = -18.9729497179997 +33000 ekin = 1.77435214491107 | erot = 1.82826131933673 | epot = -22.8632647352802 | etot = -19.2606512710324 +34000 ekin = 2.27098719472917 | erot = 3.11275511420439 | epot = -22.9527052663856 | etot = -17.5689629574521 +35000 ekin = 2.88921171289845 | erot = 1.82538384737236 | epot = -23.0316569923336 | etot = -18.3170614320628 +36000 ekin = 2.40471013682393 | erot = 2.59817148723643 | epot = -23.1277697887139 | etot = -18.1248881646536 +37000 ekin = 2.23499312928139 | erot = 1.74662115184433 | epot = -23.1542126827759 | etot = -19.1725984016501 +38000 ekin = 2.13875747252781 | erot = 3.07733571118648 | epot = -23.0916051545794 | etot = -17.8755119708651 +39000 ekin = 2.08901196654187 | erot = 2.81975762995374 | epot = -23.0796147800379 | etot = -18.1708451835423 +40000 ekin = 2.95155149177527 | erot = 2.19459039829335 | epot = -23.141500571363 | etot = -17.9953586812944 +41000 ekin = 2.49235596566196 | erot = 3.45295839915509 | epot = -23.115526015811 | etot = -17.1702116509939 +42000 ekin = 2.58401591894786 | erot = 3.0976076851145 | epot = -23.0181097727229 | etot = -17.3364861686605 +43000 ekin = 2.17593293893362 | erot = 2.65403748718844 | epot = -22.8962504257564 | etot = -18.0662799996343 +44000 ekin = 2.34068034665607 | erot = 3.294882771572 | epot = -22.8143844644656 | etot = -17.1788213462375 +45000 ekin = 1.87200112415306 | erot = 3.49863859200052 | epot = -22.6989374637074 | etot = -17.3282977475538 +46000 ekin = 2.60943921333194 | erot = 2.23170007842725 | epot = -22.5884035122493 | etot = -17.7472642204901 +47000 ekin = 1.89594756436345 | erot = 3.4002587629387 | epot = -22.4938472923117 | etot = -17.1976409650096 +48000 ekin = 2.49339593279701 | erot = 2.5104785556399 | epot = -22.5372062210456 | etot = -17.5333317326087 +49000 ekin = 3.2041407554348 | erot = 2.17669016194865 | epot = -22.5688036423094 | etot = -17.1879727249259 +50000 ekin = 2.93024070185999 | erot = 1.55416219951966 | epot = -22.6087903765995 | etot = -18.1243874752199 +51000 ekin = 2.8585759501124 | erot = 2.69193261792584 | epot = -22.6228353253324 | etot = -17.0723267572942 +52000 ekin = 2.3079418078843 | erot = 1.84260643306147 | epot = -22.6230480697441 | etot = -18.4724998287983 +53000 ekin = 3.1803685919024 | erot = 1.67451273370508 | epot = -22.6834814309773 | etot = -17.8286001053698 +54000 ekin = 2.6151376953128 | erot = 1.96091197875017 | epot = -22.7484551927013 | etot = -18.1724055186384 +55000 ekin = 3.1639577845443 | erot = 2.86286196426802 | epot = -22.7917236196438 | etot = -16.7649038708315 +56000 ekin = 2.52994034294643 | erot = 3.05544364249365 | epot = -22.7651844773103 | etot = -17.1798004918702 +57000 ekin = 2.40889871674401 | erot = 3.4525690879514 | epot = -22.7113139496974 | etot = -16.849846145002 +58000 ekin = 1.9363727739706 | erot = 2.52762778976703 | epot = -22.6468058892224 | etot = -18.1828053254848 +59000 ekin = 2.55505415922972 | erot = 3.52385701835933 | epot = -22.6037443858311 | etot = -16.5248332082421 +60000 ekin = 2.80945252332612 | erot = 2.88606183204889 | epot = -22.5227874119079 | etot = -16.8272730565329 +61000 ekin = 2.69750183117722 | erot = 2.55373633146433 | epot = -22.4306469225965 | etot = -17.1794087599549 +62000 ekin = 2.74494354639602 | erot = 2.23074517653766 | epot = -22.3675792436719 | etot = -17.3918905207383 +63000 ekin = 2.66335513293138 | erot = 2.46159865380861 | epot = -22.3527707145482 | etot = -17.2278169278082 +64000 ekin = 2.12832019835147 | erot = 2.78772793164811 | epot = -22.3048690294469 | etot = -17.3888208994473 +65000 ekin = 1.88429801911228 | erot = 2.70719871478483 | epot = -22.3342736701749 | etot = -17.7427769362778 +66000 ekin = 2.77106091929282 | erot = 1.94126620531915 | epot = -22.338257942783 | etot = -17.625930818171 +67000 ekin = 2.53561386235746 | erot = 2.45901054739082 | epot = -22.3780784743028 | etot = -17.3834540645545 +68000 ekin = 2.9678648663671 | erot = 1.95502711706149 | epot = -22.4420512915713 | etot = -17.5191593081427 +69000 ekin = 2.61501630036274 | erot = 2.2429513448561 | epot = -22.3607835407198 | etot = -17.502815895501 +70000 ekin = 2.41492598760663 | erot = 2.80885610657203 | epot = -22.2905725083407 | etot = -17.066790414162 +71000 ekin = 2.65062529541957 | erot = 2.88868401392431 | epot = -22.2951070257787 | etot = -16.7557977164349 +72000 ekin = 2.93273744051009 | erot = 2.82552508252073 | epot = -22.4016757930526 | etot = -16.6434132700218 +73000 ekin = 2.18922665452238 | erot = 3.03559183860538 | epot = -22.4509770394845 | etot = -17.2261585463568 +74000 ekin = 2.16074843540078 | erot = 2.83668185121384 | epot = -22.4374624006144 | etot = -17.4400321139998 +75000 ekin = 1.52329638473031 | erot = 1.91520672578907 | epot = -22.5623153080324 | etot = -19.123812197513 +76000 ekin = 1.89250964827726 | erot = 2.83358650938892 | epot = -22.6698326202442 | etot = -17.943736462578 +77000 ekin = 2.82066630152179 | erot = 3.19779433197964 | epot = -22.7402096770599 | etot = -16.7217490435584 +78000 ekin = 2.42603824235662 | erot = 2.82319136688957 | epot = -22.7334053911689 | etot = -17.4841757819227 +79000 ekin = 2.1571494738421 | erot = 1.67722302323495 | epot = -22.7616861631187 | etot = -18.9273136660417 +80000 ekin = 2.3760789053548 | erot = 2.58372913427157 | epot = -22.6889139769023 | etot = -17.729105937276 +81000 ekin = 2.73468961033338 | erot = 1.92748741387075 | epot = -22.6388260929897 | etot = -17.9766490687856 +82000 ekin = 1.90565370838817 | erot = 1.71715050303634 | epot = -22.5547415381056 | etot = -18.9319373266811 +83000 ekin = 1.63698443616271 | erot = 1.88092293220519 | epot = -22.4792739412377 | etot = -18.9613665728698 +84000 ekin = 1.65571812906993 | erot = 2.10290321918187 | epot = -22.4031972735297 | etot = -18.6445759252779 +85000 ekin = 2.40863681830855 | erot = 2.04741059095057 | epot = -22.321221903585 | etot = -17.8651744943259 +86000 ekin = 2.50560893716733 | erot = 1.80624308622105 | epot = -22.3789065133115 | etot = -18.0670544899231 +87000 ekin = 2.13576456371582 | erot = 1.97115993651017 | epot = -22.4335511413526 | etot = -18.3266266411266 +88000 ekin = 1.74897318407528 | erot = 2.37233945814529 | epot = -22.4142028246849 | etot = -18.2928901824643 +89000 ekin = 1.85559683216276 | erot = 3.29559734355419 | epot = -22.4519626048678 | etot = -17.3007684291509 +90000 ekin = 2.22181579992018 | erot = 2.33948779846394 | epot = -22.5289826258985 | etot = -17.9676790275144 +91000 ekin = 2.40596540834273 | erot = 3.11545124680293 | epot = -22.4975752624166 | etot = -16.9761586072709 +92000 ekin = 2.6773157744569 | erot = 3.00279439655287 | epot = -22.4834827179575 | etot = -16.8033725469477 +93000 ekin = 3.0427813598525 | erot = 3.03722776158512 | epot = -22.4121259471479 | etot = -16.3321168257103 +94000 ekin = 3.20507830840023 | erot = 1.86440047317737 | epot = -22.5079833350679 | etot = -17.4385045534903 +95000 ekin = 3.4839955648833 | erot = 2.87934575393031 | epot = -22.5675869456428 | etot = -16.2042456268292 +96000 ekin = 2.8873631080951 | erot = 2.38554372248299 | epot = -22.5453635283434 | etot = -17.2724566977653 +97000 ekin = 1.92899149350272 | erot = 2.09886479790579 | epot = -22.5208382020819 | etot = -18.4929819106733 +98000 ekin = 2.21420868967462 | erot = 3.66528252896999 | epot = -22.4426781355708 | etot = -16.5631869169262 +99000 ekin = 1.98238051924192 | erot = 2.77358159119584 | epot = -22.3579409961467 | etot = -17.6019788857089 +100000 ekin = 1.80278462349605 | erot = 2.65457154995031 | epot = -22.2926900475079 | etot = -17.8353338740616 +101000 ekin = 2.14042196591663 | erot = 2.38610603254675 | epot = -22.2789462117326 | etot = -17.7524182132692 +102000 ekin = 1.54923043145398 | erot = 2.30485616158943 | epot = -22.27519637673 | etot = -18.4211097836866 +103000 ekin = 1.66618004359352 | erot = 2.82192794888076 | epot = -22.3284746660305 | etot = -17.8403666735562 +104000 ekin = 1.8840390723585 | erot = 3.37607054348826 | epot = -22.4068162519772 | etot = -17.1467066361304 +105000 ekin = 2.08970806137592 | erot = 2.01278733908098 | epot = -22.450865561264 | etot = -18.3483701608071 +106000 ekin = 2.87186619049714 | erot = 1.95029477179727 | epot = -22.46479383237 | etot = -17.6426328700756 +107000 ekin = 2.28516102595382 | erot = 1.55115426482475 | epot = -22.420448971169 | etot = -18.5841336803904 +108000 ekin = 2.4440862469061 | erot = 1.71323205815914 | epot = -22.4934628688132 | etot = -18.336144563748 +109000 ekin = 2.33376449416318 | erot = 2.92962175925398 | epot = -22.4792154966925 | etot = -17.2158292432753 +110000 ekin = 2.7815613020599 | erot = 2.36483486971455 | epot = -22.4384263756784 | etot = -17.2920302039039 +111000 ekin = 2.32472851347632 | erot = 2.09554567134105 | epot = -22.3756448055424 | etot = -17.955370620725 +112000 ekin = 2.91126509700492 | erot = 1.8278781240038 | epot = -22.2278235937356 | etot = -17.4886803727269 +113000 ekin = 2.82522334536064 | erot = 1.67936756938672 | epot = -22.2030639545535 | etot = -17.6984730398062 +114000 ekin = 3.42964629994365 | erot = 2.67287683722422 | epot = -22.3274259722919 | etot = -16.224902835124 +115000 ekin = 3.0542495603856 | erot = 1.72370226125566 | epot = -22.3530732875163 | etot = -17.575121465875 +116000 ekin = 3.19934505541307 | erot = 3.20304074939432 | epot = -22.4112422200445 | etot = -16.0088564152371 +117000 ekin = 3.03942349360439 | erot = 2.40720645224432 | epot = -22.3646852618703 | etot = -16.9180553160216 +118000 ekin = 3.21704225120818 | erot = 1.46425401673931 | epot = -22.2864155249032 | etot = -17.6051192569557 +119000 ekin = 2.33989996826882 | erot = 3.07668030790319 | epot = -22.2283862990246 | etot = -16.8118060228526 +120000 ekin = 1.93772242476321 | erot = 2.20130457047854 | epot = -22.1620199969907 | etot = -18.022993001749 +121000 ekin = 1.94013950333198 | erot = 3.08987281123525 | epot = -22.1565667857742 | etot = -17.126554471207 +122000 ekin = 1.68663003450368 | erot = 1.73461876453175 | epot = -22.2565715090021 | etot = -18.8353227099667 +123000 ekin = 1.72841976989173 | erot = 2.32750063038672 | epot = -22.3665160016578 | etot = -18.3105956013793 +124000 ekin = 2.73468934475335 | erot = 1.93313584543739 | epot = -22.378088078826 | etot = -17.7102628886353 +125000 ekin = 2.77507735763211 | erot = 1.95244582221334 | epot = -22.3863676939847 | etot = -17.6588445141392 +126000 ekin = 2.04549959008918 | erot = 1.485897173428 | epot = -22.4226219879524 | etot = -18.8912252244352 +127000 ekin = 1.86410777734907 | erot = 1.58829497411524 | epot = -22.4027380289015 | etot = -18.9503352774372 +128000 ekin = 1.63329448006254 | erot = 1.88032753965974 | epot = -22.3918784566533 | etot = -18.8782564369311 +129000 ekin = 2.51522192674941 | erot = 2.38822614049102 | epot = -22.396225517968 | etot = -17.4927774507275 +130000 ekin = 1.61191166117177 | erot = 2.81688343133435 | epot = -22.341565060394 | etot = -17.9127699678878 +131000 ekin = 2.29569747740708 | erot = 2.2886876976091 | epot = -22.2184139794107 | etot = -17.6340288043945 +132000 ekin = 2.97393694467802 | erot = 2.3613525440602 | epot = -22.1410658382525 | etot = -16.8057763495143 +133000 ekin = 2.01357676743257 | erot = 2.125828419273 | epot = -22.1312019600638 | etot = -17.9917967733582 +134000 ekin = 1.56048037412857 | erot = 2.84208065022547 | epot = -22.0682869067536 | etot = -17.6657258823995 +135000 ekin = 1.79811942319758 | erot = 2.40075843487508 | epot = -22.0853555614258 | etot = -17.8864777033532 +136000 ekin = 1.63631696233012 | erot = 2.13166656554854 | epot = -22.0879615470249 | etot = -18.3199780191463 +137000 ekin = 2.36040439516093 | erot = 1.93785486632901 | epot = -22.1234845924018 | etot = -17.8252253309118 +138000 ekin = 2.94591421775872 | erot = 1.58866111192914 | epot = -22.1783168558241 | etot = -17.6437415261363 +139000 ekin = 3.17560544591524 | erot = 2.24933296614107 | epot = -22.2966418842012 | etot = -16.8717034721449 +140000 ekin = 2.24781162873235 | erot = 3.05934139328612 | epot = -22.4681108223249 | etot = -17.1609578003064 +141000 ekin = 1.89078628042285 | erot = 3.13246933186326 | epot = -22.730922227649 | etot = -17.7076666153629 +142000 ekin = 2.51033894675651 | erot = 2.4942894309123 | epot = -22.8404165502847 | etot = -17.8357881726159 +143000 ekin = 2.40438807844298 | erot = 2.71461817456284 | epot = -22.8207220890738 | etot = -17.7017158360679 +144000 ekin = 1.9307425487964 | erot = 2.67760329085926 | epot = -22.6973757396236 | etot = -18.0890298999679 +145000 ekin = 1.82681171280412 | erot = 1.73674169257736 | epot = -22.6628534675149 | etot = -19.0993000621335 +146000 ekin = 2.42423538163981 | erot = 2.0908776294658 | epot = -22.6072904345337 | etot = -18.0921774234281 +147000 ekin = 1.44607209743073 | erot = 1.8801263906251 | epot = -22.5001275476876 | etot = -19.1739290596318 +148000 ekin = 1.9349809420382 | erot = 2.57774390934154 | epot = -22.4721664357448 | etot = -17.9594415843651 +149000 ekin = 2.02370265642699 | erot = 3.3179576458013 | epot = -22.3745153112138 | etot = -17.0328550089855 +150000 ekin = 2.48124469844233 | erot = 2.68185291250579 | epot = -22.1950329772129 | etot = -17.0319353662648 +151000 ekin = 2.76319440452884 | erot = 1.87355938382631 | epot = -21.986630645846 | etot = -17.3498768574909 +152000 ekin = 2.77453107952051 | erot = 1.77016628972892 | epot = -21.7977108098427 | etot = -17.2530134405933 +153000 ekin = 3.08827014622555 | erot = 1.80976617511255 | epot = -21.6910123469878 | etot = -16.7929760256497 +154000 ekin = 2.32051051770812 | erot = 2.18004857730092 | epot = -21.6406733490634 | etot = -17.1401142540543 +155000 ekin = 1.95766873014157 | erot = 2.67064554154836 | epot = -21.7315745360126 | etot = -17.1032602643227 +156000 ekin = 2.69830438989808 | erot = 2.24987636164771 | epot = -21.7962907570244 | etot = -16.8481100054786 +157000 ekin = 3.89340900899948 | erot = 2.73733315325155 | epot = -21.8437967078712 | etot = -15.2130545456202 +158000 ekin = 2.84737207100033 | erot = 2.70157958556583 | epot = -21.878244439129 | etot = -16.3292927825628 +159000 ekin = 3.1312088996125 | erot = 2.65375527842548 | epot = -21.8350703791794 | etot = -16.0501062011414 +160000 ekin = 2.54316260055464 | erot = 3.27950281054041 | epot = -21.8888467298127 | etot = -16.0661813187176 +161000 ekin = 2.49549109190181 | erot = 2.45028506429479 | epot = -21.8585593359585 | etot = -16.9127831797619 +162000 ekin = 3.05200272259994 | erot = 2.59164651185653 | epot = -21.8439750046483 | etot = -16.2003257701918 +163000 ekin = 3.30374280597553 | erot = 2.24193960212662 | epot = -21.8717863279577 | etot = -16.3261039198555 +164000 ekin = 3.53081155329031 | erot = 2.22419322011391 | epot = -21.8162094860939 | etot = -16.0612047126897 +165000 ekin = 2.48919804649027 | erot = 2.59105984700639 | epot = -21.7395563276218 | etot = -16.6592984341251 +166000 ekin = 2.14880495285182 | erot = 3.05770380831398 | epot = -21.6850566092694 | etot = -16.4785478481036 +167000 ekin = 2.78181890034675 | erot = 2.90402826001928 | epot = -21.5971987360122 | etot = -15.9113515756462 +168000 ekin = 1.74726050172142 | erot = 2.76898886506121 | epot = -21.490566893224 | etot = -16.9743175264414 +169000 ekin = 1.8134289785439 | erot = 2.45780601602371 | epot = -21.4680710936728 | etot = -17.1968360991052 +170000 ekin = 1.69364478039988 | erot = 2.87928997590297 | epot = -21.4668806356843 | etot = -16.8939458793814 +171000 ekin = 2.14879448642638 | erot = 1.61442218455815 | epot = -21.3172106430715 | etot = -17.553993972087 +172000 ekin = 1.68431962963431 | erot = 2.36087816720612 | epot = -21.1539793618528 | etot = -17.1087815650124 +173000 ekin = 2.05784071815669 | erot = 2.17142592689102 | epot = -21.0926393885011 | etot = -16.8633727434534 +174000 ekin = 2.49611606122761 | erot = 3.09665692560806 | epot = -20.9460348670979 | etot = -15.3532618802622 +175000 ekin = 2.61673440848865 | erot = 2.88720331620426 | epot = -20.8525764091519 | etot = -15.348638684459 +176000 ekin = 2.16190213742438 | erot = 2.672518464664 | epot = -20.8442274508468 | etot = -16.0098068487584 +177000 ekin = 2.83236394902013 | erot = 2.81489135382763 | epot = -20.925759607446 | etot = -15.2785043045983 +178000 ekin = 3.17804494293424 | erot = 1.88346790512585 | epot = -21.0677853312893 | etot = -16.0062724832292 +179000 ekin = 2.33267448424065 | erot = 2.85731052069525 | epot = -21.1181390109479 | etot = -15.928154006012 +180000 ekin = 2.39061531304011 | erot = 2.93791308776 | epot = -21.1146449531392 | etot = -15.786116552339 +181000 ekin = 2.79990361156737 | erot = 3.28891520287386 | epot = -21.0834365456108 | etot = -14.9946177311695 +182000 ekin = 3.02616507870526 | erot = 2.3341432703009 | epot = -21.0600545808659 | etot = -15.6997462318597 +183000 ekin = 2.45290144562467 | erot = 2.21141617846262 | epot = -20.911866387917 | etot = -16.2475487638297 +184000 ekin = 2.56560515060991 | erot = 2.7739810551646 | epot = -20.6989716212004 | etot = -15.3593854154259 +185000 ekin = 2.17586139274635 | erot = 1.95913868179524 | epot = -20.5985322435751 | etot = -16.4635321690335 +186000 ekin = 2.07303044902321 | erot = 3.15122816264525 | epot = -20.4965070011281 | etot = -15.2722483894597 +187000 ekin = 2.44319481307615 | erot = 1.92784212082443 | epot = -20.5124982035642 | etot = -16.1414612696636 +188000 ekin = 2.28870879542405 | erot = 2.8871121346017 | epot = -20.6323506293031 | etot = -15.4565296992773 +189000 ekin = 1.68047280237829 | erot = 3.05535775765803 | epot = -20.6378101864803 | etot = -15.901979626444 +190000 ekin = 1.97184665786397 | erot = 2.95271452778009 | epot = -20.6376534135265 | etot = -15.7130922278825 +191000 ekin = 2.30626539196432 | erot = 2.64854814117512 | epot = -20.6037323569656 | etot = -15.6489188238262 +192000 ekin = 3.54976671698926 | erot = 2.91090725702116 | epot = -20.5525508832509 | etot = -14.0918769092405 +193000 ekin = 2.63938438600422 | erot = 3.14409581682352 | epot = -20.5892132844066 | etot = -14.8057330815789 +194000 ekin = 2.67903757365037 | erot = 2.30768318132376 | epot = -20.4753987179501 | etot = -15.488677962976 +195000 ekin = 1.89257615363314 | erot = 2.64508051866103 | epot = -20.4197880125065 | etot = -15.8821313402123 +196000 ekin = 2.29151017050607 | erot = 2.32636787964875 | epot = -20.4440761857987 | etot = -15.8261981356438 +197000 ekin = 2.48344018982905 | erot = 2.5654400941963 | epot = -20.516126938087 | etot = -15.4672466540616 +198000 ekin = 2.01386156849612 | erot = 1.52779840514975 | epot = -20.537160292649 | etot = -16.9955003190031 +199000 ekin = 1.50729232131931 | erot = 2.19878124720506 | epot = -20.5584754599868 | etot = -16.8524018914625 +200000 ekin = 1.64236235330806 | erot = 2.46736341802316 | epot = -20.5387924113648 | etot = -16.4290666400336 +201000 ekin = 2.627066472214 | erot = 2.61321940355396 | epot = -20.6089911163939 | etot = -15.3687052406259 +202000 ekin = 2.3129503751722 | erot = 2.54874856259559 | epot = -20.6732219111123 | etot = -15.8115229733445 +203000 ekin = 1.63961009223968 | erot = 2.10835750593015 | epot = -20.7002051999767 | etot = -16.9522376018069 +204000 ekin = 2.0558049009161 | erot = 1.9161072834091 | epot = -20.8154459612946 | etot = -16.8435337769694 +205000 ekin = 3.04603860094189 | erot = 3.24233043438682 | epot = -20.9297600758299 | etot = -14.6413910405012 +206000 ekin = 2.56775422508359 | erot = 2.20992928465512 | epot = -21.0192669133083 | etot = -16.2415834035696 +207000 ekin = 3.46597997409567 | erot = 2.48427015330086 | epot = -21.151399026488 | etot = -15.2011488990915 +208000 ekin = 2.51159742060494 | erot = 2.22948191756652 | epot = -21.2942477400986 | etot = -16.5531684019271 +209000 ekin = 3.78908644724162 | erot = 2.17660742759513 | epot = -21.4499700336111 | etot = -15.4842761587743 +210000 ekin = 3.03133642129733 | erot = 2.21595982730352 | epot = -21.5648709610245 | etot = -16.3175747124237 +211000 ekin = 1.63075564056512 | erot = 2.12650387194819 | epot = -21.6099552204253 | etot = -17.852695707912 +212000 ekin = 2.67694215598975 | erot = 2.47186432110288 | epot = -21.8481434074352 | etot = -16.6993369303425 +213000 ekin = 2.70688282449408 | erot = 1.96666534072978 | epot = -22.1170796448084 | etot = -17.4435314795845 +214000 ekin = 2.88993887341392 | erot = 3.16392577542175 | epot = -22.1689844550676 | etot = -16.1151198062319 +215000 ekin = 2.59587305508913 | erot = 1.84775314628517 | epot = -22.0799472955547 | etot = -17.6363210941804 +216000 ekin = 2.59710486720184 | erot = 2.79170232594871 | epot = -22.123050002636 | etot = -16.7342428094855 +217000 ekin = 2.50043297628753 | erot = 1.89569946865143 | epot = -22.2232445790842 | etot = -17.8271121341452 +218000 ekin = 2.42608117861514 | erot = 2.42380011003409 | epot = -22.2442965405807 | etot = -17.3944152519314 +219000 ekin = 2.31038806457503 | erot = 2.64910389607574 | epot = -22.2862511100887 | etot = -17.3267591494379 +220000 ekin = 1.69989575631519 | erot = 2.34717348369245 | epot = -22.2936253261379 | etot = -18.2465560861303 +221000 ekin = 2.0597604328414 | erot = 2.4617257870959 | epot = -22.2693428350923 | etot = -17.747856615155 +222000 ekin = 1.56778478035701 | erot = 2.12765432596982 | epot = -22.1639011265163 | etot = -18.4684620201895 +223000 ekin = 1.84761048251748 | erot = 1.88006246465219 | epot = -22.0932628941083 | etot = -18.3655899469387 +224000 ekin = 2.59436846043989 | erot = 2.94714248251079 | epot = -22.1101977210218 | etot = -16.5686867780711 +225000 ekin = 3.30446830369106 | erot = 2.86069163428051 | epot = -22.1130335717329 | etot = -15.9478736337614 +226000 ekin = 3.03148439961004 | erot = 2.0857715841185 | epot = -22.1515480756285 | etot = -17.0342920918999 +227000 ekin = 2.52473737037052 | erot = 3.1515233037479 | epot = -22.2272979755786 | etot = -16.5510373014602 +228000 ekin = 2.32773029487822 | erot = 2.67887550863523 | epot = -22.3289846157579 | etot = -17.3223788122445 +229000 ekin = 2.908632187774 | erot = 2.89972099244786 | epot = -22.4590990625921 | etot = -16.6507458823703 +230000 ekin = 2.30901008738396 | erot = 3.48892218468534 | epot = -22.5811133380347 | etot = -16.7831810659654 +231000 ekin = 2.09445974553368 | erot = 3.10137653837903 | epot = -22.6273628788262 | etot = -17.4315265949135 +232000 ekin = 2.11347252785341 | erot = 1.99214840222577 | epot = -22.6148559367411 | etot = -18.5092350066619 +233000 ekin = 2.31469131808302 | erot = 2.82702779723524 | epot = -22.573468078272 | etot = -17.4317489629538 +234000 ekin = 2.08691986790862 | erot = 2.09006771152617 | epot = -22.5768924885421 | etot = -18.3999049091073 +235000 ekin = 2.43602788311011 | erot = 2.79756094595935 | epot = -22.5841308018507 | etot = -17.3505419727812 +236000 ekin = 2.93232983655883 | erot = 3.05945149934941 | epot = -22.5011281720659 | etot = -16.5093468361576 +237000 ekin = 3.2236915032749 | erot = 3.26810349425041 | epot = -22.3869936414794 | etot = -15.8951986439541 +238000 ekin = 2.4674995923353 | erot = 2.31630563795609 | epot = -22.3210409459325 | etot = -17.5372357156411 +239000 ekin = 2.10887317283391 | erot = 2.47562990634415 | epot = -22.3008221039947 | etot = -17.7163190248166 +240000 ekin = 1.76092230208337 | erot = 2.62077674301801 | epot = -22.2503883436816 | etot = -17.8686892985802 +241000 ekin = 1.93966929781469 | erot = 1.41063904300121 | epot = -22.2367099354244 | etot = -18.8864015946085 +242000 ekin = 3.03220831764684 | erot = 2.02809667614523 | epot = -22.2529237351145 | etot = -17.1926187413224 +243000 ekin = 2.84396619393303 | erot = 1.7910064306681 | epot = -22.2768680265869 | etot = -17.6418954019858 +244000 ekin = 1.94630661585721 | erot = 2.3722540427007 | epot = -22.2272698315535 | etot = -17.9087091729956 +245000 ekin = 2.21268964174709 | erot = 2.75899365563147 | epot = -22.1926413343766 | etot = -17.2209580369981 +246000 ekin = 2.07547606015104 | erot = 2.22089229769683 | epot = -22.119471822751 | etot = -17.8231034649032 +247000 ekin = 1.58341517009487 | erot = 3.06778333448391 | epot = -22.0033087190277 | etot = -17.3521102144489 +248000 ekin = 2.1365138975527 | erot = 3.53502738921423 | epot = -21.8495423719646 | etot = -16.1780010851977 +249000 ekin = 2.17149547481658 | erot = 3.29316066315612 | epot = -21.813933670884 | etot = -16.3492775329113 +250000 ekin = 2.39365756609179 | erot = 2.39580124119371 | epot = -21.767733544404 | etot = -16.9782747371185 +251000 ekin = 1.2828204065042 | erot = 2.24293125468609 | epot = -21.7209613352709 | etot = -18.1952096740806 +252000 ekin = 1.76792385357404 | erot = 2.13774913157991 | epot = -21.715743646839 | etot = -17.8100706616851 +253000 ekin = 2.15844787240193 | erot = 2.59910839140098 | epot = -21.6939194867273 | etot = -16.9363632229244 +254000 ekin = 2.46988601582316 | erot = 1.99393049965303 | epot = -21.6738244724958 | etot = -17.2100079570196 +255000 ekin = 2.31014544453096 | erot = 2.03140480982291 | epot = -21.6888108217887 | etot = -17.3472605674348 +256000 ekin = 2.90570988017011 | erot = 2.61779108741197 | epot = -21.6304219101588 | etot = -16.1069209425767 +257000 ekin = 2.87227426842454 | erot = 2.08598550349753 | epot = -21.5998306482426 | etot = -16.6415708763206 +258000 ekin = 2.06365418401471 | erot = 2.33103720962373 | epot = -21.5019981919811 | etot = -17.1073067983427 +259000 ekin = 2.23106413601668 | erot = 2.88992031738565 | epot = -21.4929751490585 | etot = -16.3719906956562 +260000 ekin = 2.49064109684832 | erot = 2.38083177290805 | epot = -21.4659963710747 | etot = -16.5945235013183 +261000 ekin = 2.09140199827797 | erot = 2.40209752473156 | epot = -21.4076397934529 | etot = -16.9141402704433 +262000 ekin = 2.36091906713393 | erot = 2.66652490187927 | epot = -21.359937125592 | etot = -16.3324931565788 +263000 ekin = 2.2112169796158 | erot = 2.73059503173094 | epot = -21.4187723839513 | etot = -16.4769603726046 +264000 ekin = 2.28961718487933 | erot = 2.75455515229635 | epot = -21.370776058554 | etot = -16.3266037213783 +265000 ekin = 1.71596203334806 | erot = 1.76104932073225 | epot = -21.2034176623527 | etot = -17.7264063082724 +266000 ekin = 2.51424635704546 | erot = 2.09488481391075 | epot = -21.0818656942669 | etot = -16.4727345233107 +267000 ekin = 2.81393895925601 | erot = 2.14232705328249 | epot = -21.1259701200622 | etot = -16.1697041075237 +268000 ekin = 3.10191854871686 | erot = 2.80451383793942 | epot = -21.0933882633302 | etot = -15.1869558766739 +269000 ekin = 3.52550118014125 | erot = 2.35973600910593 | epot = -21.0585255577117 | etot = -15.1732883684645 +270000 ekin = 3.50731584216641 | erot = 1.86855463358785 | epot = -21.093710946541 | etot = -15.7178404707867 +271000 ekin = 3.5675331453682 | erot = 2.0823459971557 | epot = -21.1717850302959 | etot = -15.521905887772 +272000 ekin = 2.43382567191708 | erot = 3.09591378837425 | epot = -21.2584464912718 | etot = -15.7287070309805 +273000 ekin = 2.38177594135517 | erot = 3.14028416008422 | epot = -21.3418702267283 | etot = -15.8198101252889 +274000 ekin = 2.46408091312732 | erot = 2.01407385193325 | epot = -21.3513679347441 | etot = -16.8732131696836 +275000 ekin = 2.45653813926169 | erot = 3.06780010281641 | epot = -21.3769507768006 | etot = -15.8526125347225 +276000 ekin = 2.79508720985829 | erot = 2.87011619931109 | epot = -21.3368600634473 | etot = -15.671656654278 +277000 ekin = 2.21394865880382 | erot = 2.19504097967885 | epot = -21.2606836087454 | etot = -16.8516939702627 +278000 ekin = 2.75723780567064 | erot = 3.25107227641375 | epot = -21.1755556732391 | etot = -15.1672455911547 +279000 ekin = 2.50738352588257 | erot = 1.80312795092014 | epot = -21.119949297869 | etot = -16.8094378210662 +280000 ekin = 2.35419479075042 | erot = 1.7566104351529 | epot = -21.0612865360217 | etot = -16.9504813101184 +281000 ekin = 2.54091624756361 | erot = 2.29354970120309 | epot = -21.0950091005497 | etot = -16.260543151783 +282000 ekin = 2.99712896075656 | erot = 2.42094408338315 | epot = -21.2220089565004 | etot = -15.8039359123607 +283000 ekin = 2.56696810638689 | erot = 2.10068113035835 | epot = -21.403161576838 | etot = -16.7355123400928 +284000 ekin = 2.50149529685552 | erot = 3.12894850572552 | epot = -21.5256946024495 | etot = -15.8952507998684 +285000 ekin = 2.42104861452631 | erot = 1.7773884250687 | epot = -21.6343236201921 | etot = -17.4358865805971 +286000 ekin = 1.95703367775988 | erot = 2.02947038358402 | epot = -21.6777606373854 | etot = -17.6912565760415 +287000 ekin = 2.563069553437 | erot = 2.57822888294094 | epot = -21.7096788412169 | etot = -16.568380404839 +288000 ekin = 2.18408141161779 | erot = 1.69724000161796 | epot = -21.6059228036045 | etot = -17.7246013903687 +289000 ekin = 2.32975723406079 | erot = 1.67288237726622 | epot = -21.4690249265465 | etot = -17.4663853152195 +290000 ekin = 2.22773933829104 | erot = 2.00568808096403 | epot = -21.3936416309443 | etot = -17.1602142116892 +291000 ekin = 1.46140048209222 | erot = 2.68187349132486 | epot = -21.320309661152 | etot = -17.177035687735 +292000 ekin = 2.07752653885401 | erot = 2.42042811850752 | epot = -21.2225710152689 | etot = -16.7246163579074 +293000 ekin = 2.14598735312316 | erot = 1.87232699516306 | epot = -21.1503112105659 | etot = -17.1319968622797 +294000 ekin = 2.15249843510191 | erot = 2.17548638187737 | epot = -21.1209057143321 | etot = -16.7929208973528 +295000 ekin = 2.13417246804068 | erot = 2.31578295657371 | epot = -21.023273761855 | etot = -16.5733183372406 +296000 ekin = 1.52381700282724 | erot = 2.92433462308731 | epot = -21.0839283123442 | etot = -16.6357766864297 +297000 ekin = 2.45165869902145 | erot = 2.17953392904489 | epot = -21.0491333291916 | etot = -16.4179407011252 +298000 ekin = 1.77920935759369 | erot = 2.01251348063453 | epot = -21.0971977522748 | etot = -17.3054749140465 +299000 ekin = 1.87538650376616 | erot = 1.65135039658661 | epot = -21.119277949862 | etot = -17.5925410495092 +300000 ekin = 2.3167056751994 | erot = 1.510902648654 | epot = -21.178913099451 | etot = -17.3513047755976 +301000 ekin = 2.00567209290794 | erot = 2.01270349508404 | epot = -21.2857234594098 | etot = -17.2673478714178 +302000 ekin = 1.78598592595272 | erot = 2.2354055492879 | epot = -21.3905601140029 | etot = -17.3691686387622 +303000 ekin = 2.73278841880507 | erot = 1.64856089415774 | epot = -21.3608973804115 | etot = -16.9795480674487 +304000 ekin = 2.5809493598196 | erot = 2.00558555026353 | epot = -21.400198286629 | etot = -16.8136633765459 +305000 ekin = 2.43647384348742 | erot = 2.28275438290435 | epot = -21.3863075230184 | etot = -16.6670792966266 +306000 ekin = 2.14332823539982 | erot = 2.4338461634411 | epot = -21.3233075109442 | etot = -16.7461331121032 +307000 ekin = 3.21424191196812 | erot = 3.27591538479569 | epot = -21.289790084126 | etot = -14.7996327873622 +308000 ekin = 3.45838026839176 | erot = 2.68116130354006 | epot = -21.3419403426811 | etot = -15.2023987707493 +309000 ekin = 2.38041738433959 | erot = 2.92081370932153 | epot = -21.4463399141034 | etot = -16.1451088204423 +310000 ekin = 2.50977269558789 | erot = 2.34824464102402 | epot = -21.4648074532888 | etot = -16.6067901166769 +311000 ekin = 2.57488628819259 | erot = 2.293754673538 | epot = -21.5151382155269 | etot = -16.6464972537963 +312000 ekin = 2.09623150906876 | erot = 2.93795890592974 | epot = -21.6260240426366 | etot = -16.5918336276381 +313000 ekin = 1.8184499729194 | erot = 2.28463898505893 | epot = -21.6999003790643 | etot = -17.5968114210859 +314000 ekin = 2.3228324174232 | erot = 2.19580475273396 | epot = -21.6870491287185 | etot = -17.1684119585613 +315000 ekin = 1.84546653836013 | erot = 2.13886071139629 | epot = -21.7312132691438 | etot = -17.7468860193873 +316000 ekin = 2.1657114199577 | erot = 3.03124199276298 | epot = -21.7430929234306 | etot = -16.5461395107099 +317000 ekin = 2.42793755919909 | erot = 3.57187833839244 | epot = -21.8303487369249 | etot = -15.8305328393334 +318000 ekin = 2.31418145055206 | erot = 3.02858542885927 | epot = -21.9347898317926 | etot = -16.5920229523813 +319000 ekin = 2.35032973997068 | erot = 3.16078759112674 | epot = -22.0387665246751 | etot = -16.5276491935776 +320000 ekin = 1.78202525445684 | erot = 2.83297321443624 | epot = -22.1187616541783 | etot = -17.5037631852852 +321000 ekin = 2.87441941784728 | erot = 2.26223197636944 | epot = -22.1065455913123 | etot = -16.9698941970956 +322000 ekin = 2.79013397204362 | erot = 2.68769432639935 | epot = -22.1121405540937 | etot = -16.6343122556507 +323000 ekin = 2.070121980457 | erot = 2.31830584817612 | epot = -22.1539458855415 | etot = -17.7655180569083 +324000 ekin = 2.58383941134683 | erot = 2.58296807603305 | epot = -22.1539753505051 | etot = -16.9871678631253 +325000 ekin = 3.43451304817783 | erot = 2.45405386180802 | epot = -21.938960387404 | etot = -16.0503934774181 +326000 ekin = 3.49680929786584 | erot = 2.85196633398113 | epot = -21.8204400999953 | etot = -15.4716644681484 +327000 ekin = 2.68799300805475 | erot = 2.21805195956654 | epot = -21.7892073548558 | etot = -16.8831623872345 +328000 ekin = 1.81477491971657 | erot = 2.35891534842888 | epot = -21.7275637950057 | etot = -17.5538735268602 +329000 ekin = 2.19319322627006 | erot = 2.40717958919081 | epot = -21.6826095784948 | etot = -17.0822367630339 +330000 ekin = 1.87131927244382 | erot = 2.03694340108429 | epot = -21.5934239674847 | etot = -17.6851612939566 +331000 ekin = 2.37197683084608 | erot = 1.80087022346348 | epot = -21.5641185835514 | etot = -17.3912715292419 +332000 ekin = 1.69601394569048 | erot = 2.54947032294377 | epot = -21.5986464339748 | etot = -17.3531621653406 +333000 ekin = 1.59867443991714 | erot = 2.14911483871162 | epot = -21.7162173059518 | etot = -17.9684280273231 +334000 ekin = 2.25811733625553 | erot = 2.62323988136568 | epot = -21.7749416190679 | etot = -16.8935844014467 +335000 ekin = 2.93433632601273 | erot = 3.10350297573268 | epot = -21.7966831809595 | etot = -15.7588438792141 +336000 ekin = 2.76337640462581 | erot = 2.54930710489019 | epot = -21.7180312833467 | etot = -16.4053477738307 +337000 ekin = 3.19235531401951 | erot = 3.87146146874103 | epot = -21.8022396262892 | etot = -14.7384228435286 +338000 ekin = 2.33305125173566 | erot = 2.13094194678887 | epot = -21.8068682042896 | etot = -17.3428750057651 +339000 ekin = 1.71673308889604 | erot = 2.30964121170968 | epot = -21.7941224580796 | etot = -17.7677481574739 +340000 ekin = 1.59424151294027 | erot = 3.16324993863714 | epot = -21.7679173396748 | etot = -17.0104258880973 +341000 ekin = 1.69465464335694 | erot = 3.18694861883744 | epot = -21.7067352043109 | etot = -16.8251319421165 +342000 ekin = 1.81243763026219 | erot = 2.60448215582795 | epot = -21.5993126794634 | etot = -17.1823928933732 +343000 ekin = 3.08243814047349 | erot = 2.9217466333323 | epot = -21.5855979229594 | etot = -15.5814131491536 +344000 ekin = 2.94964594107348 | erot = 3.10231272046816 | epot = -21.5506154266351 | etot = -15.4986567650935 +345000 ekin = 2.34525111670595 | erot = 2.88045261854212 | epot = -21.530734043011 | etot = -16.3050303077629 +346000 ekin = 2.03136740406842 | erot = 3.44352096435563 | epot = -21.4703041890966 | etot = -15.9954158206726 +347000 ekin = 2.34515762081498 | erot = 1.91414074840886 | epot = -21.3488386855954 | etot = -17.0895403163716 +348000 ekin = 2.76763212340836 | erot = 2.78035348102326 | epot = -21.3102796687364 | etot = -15.7622940643048 +349000 ekin = 2.29342234253801 | erot = 3.14526664575919 | epot = -21.3922932631024 | etot = -15.9536042748052 +350000 ekin = 2.17828641691343 | erot = 2.38211689163937 | epot = -21.3570978647003 | etot = -16.7966945561475 +351000 ekin = 2.2787342054874 | erot = 2.85568682453813 | epot = -21.3165609660186 | etot = -16.182139935993 +352000 ekin = 2.70894563927919 | erot = 2.77656375044279 | epot = -21.3565059314145 | etot = -15.8709965416925 +353000 ekin = 1.74748047732915 | erot = 2.14191122851256 | epot = -21.3195625770357 | etot = -17.430170871194 +354000 ekin = 2.30492780756568 | erot = 2.37159952583724 | epot = -21.3742968901642 | etot = -16.6977695567612 +355000 ekin = 2.32493886573112 | erot = 2.38411746089983 | epot = -21.339340741587 | etot = -16.6302844149561 +356000 ekin = 2.9749649543268 | erot = 2.9916655517553 | epot = -21.2468948072712 | etot = -15.2802643011891 +357000 ekin = 1.79541671946026 | erot = 2.13971792108731 | epot = -21.2216819829681 | etot = -17.2865473424205 +358000 ekin = 2.06637919290965 | erot = 1.9076530715578 | epot = -21.2447441674953 | etot = -17.2707119030278 +359000 ekin = 2.02344077580052 | erot = 2.11726163321539 | epot = -21.2183688961264 | etot = -17.0776664871105 +360000 ekin = 2.64012587839158 | erot = 2.43776362828977 | epot = -21.1472477161847 | etot = -16.0693582095033 +361000 ekin = 2.41850555983882 | erot = 2.39054736245265 | epot = -21.2133787743639 | etot = -16.4043258520724 +362000 ekin = 2.2486199222758 | erot = 2.04489136793498 | epot = -21.2088914287919 | etot = -16.9153801385811 +363000 ekin = 3.21904252076974 | erot = 1.79717950163013 | epot = -21.2620537293498 | etot = -16.24583170695 +364000 ekin = 2.9845697448498 | erot = 2.18316673460243 | epot = -21.2883338312843 | etot = -16.120597351832 +365000 ekin = 2.49427392981412 | erot = 2.31205455481896 | epot = -21.4001153296815 | etot = -16.5937868450484 +366000 ekin = 2.61706523565788 | erot = 2.20229130507574 | epot = -21.4506718008962 | etot = -16.6313152601626 +367000 ekin = 2.24650816549397 | erot = 1.87906237362998 | epot = -21.5207044850599 | etot = -17.3951339459359 +368000 ekin = 2.46672276241562 | erot = 2.37638546053105 | epot = -21.5628581383216 | etot = -16.7197499153749 +369000 ekin = 2.03614635149851 | erot = 2.85426887707092 | epot = -21.6803034764487 | etot = -16.7898882478793 +370000 ekin = 2.13410724028005 | erot = 2.17304603842012 | epot = -21.7343761700058 | etot = -17.4272228913057 +371000 ekin = 2.21722409826115 | erot = 2.11058746733929 | epot = -21.6422617131998 | etot = -17.3144501475994 +372000 ekin = 1.88083333566673 | erot = 1.90617172826127 | epot = -21.6005499693118 | etot = -17.8135449053838 +373000 ekin = 1.98298204516521 | erot = 1.78267682128409 | epot = -21.5708808628646 | etot = -17.8052219964153 +374000 ekin = 2.88981201933268 | erot = 1.90326894499807 | epot = -21.4624711307906 | etot = -16.6693901664599 +375000 ekin = 2.31951869092549 | erot = 1.92779670517485 | epot = -21.3521768069862 | etot = -17.1048614108859 +376000 ekin = 2.60113015271722 | erot = 2.31181306588444 | epot = -21.34681055463 | etot = -16.4338673360283 +377000 ekin = 2.23867315344604 | erot = 1.65923992926403 | epot = -21.2611852709131 | etot = -17.363272188203 +378000 ekin = 2.38125181613766 | erot = 2.54002618279121 | epot = -21.2390275318703 | etot = -16.3177495329414 +379000 ekin = 2.06952281308678 | erot = 2.11888196225292 | epot = -21.194025606577 | etot = -17.0056208312373 +380000 ekin = 2.59961269461524 | erot = 2.3751200788503 | epot = -21.1885781090515 | etot = -16.2138453355859 +381000 ekin = 2.42019573552876 | erot = 2.20667402504614 | epot = -21.1989968748535 | etot = -16.5721271142786 +382000 ekin = 2.04746564398744 | erot = 3.34439482672214 | epot = -21.2903574441545 | etot = -15.8984969734449 +383000 ekin = 2.65699216362738 | erot = 1.56546061375907 | epot = -21.3572338418187 | etot = -17.1347810644322 +384000 ekin = 2.43156675693926 | erot = 2.00097327452753 | epot = -21.3434156392382 | etot = -16.9108756077714 +385000 ekin = 1.95152101616516 | erot = 3.28345377140313 | epot = -21.4173973675698 | etot = -16.1824225800015 +386000 ekin = 2.10919215730741 | erot = 2.90700736383436 | epot = -21.3963452767614 | etot = -16.3801457556197 +387000 ekin = 2.34448447096483 | erot = 2.50155013212484 | epot = -21.3487258248084 | etot = -16.5026912217187 +388000 ekin = 2.71771591111729 | erot = 2.76803950274557 | epot = -21.3515918112166 | etot = -15.8658363973537 +389000 ekin = 3.06825183100775 | erot = 3.06148533146046 | epot = -21.4826430036711 | etot = -15.3529058412029 +390000 ekin = 2.56997560639923 | erot = 2.05646161654304 | epot = -21.5623801506968 | etot = -16.9359429277546 +391000 ekin = 2.1110114400687 | erot = 2.44612603817531 | epot = -21.6052888202632 | etot = -17.0481513420191 +392000 ekin = 2.58328475785099 | erot = 2.75249392862464 | epot = -21.7336094646938 | etot = -16.3978307782182 +393000 ekin = 2.03977041996533 | erot = 1.67448219405536 | epot = -21.8740604202474 | etot = -18.1598078062267 +394000 ekin = 2.1229408356241 | erot = 2.43410977254954 | epot = -21.9094739378951 | etot = -17.3524233297214 +395000 ekin = 2.48696003315341 | erot = 2.48225062557349 | epot = -21.8799685903484 | etot = -16.9107579316215 +396000 ekin = 3.18909661029635 | erot = 1.62675064803775 | epot = -21.8520000277039 | etot = -17.0361527693698 +397000 ekin = 2.39161566907255 | erot = 2.17052346752458 | epot = -21.7939512244376 | etot = -17.2318120878404 +398000 ekin = 2.29946433742664 | erot = 2.18115834594542 | epot = -21.7285069861955 | etot = -17.2478843028235 +399000 ekin = 2.65449075133045 | erot = 2.80318185995816 | epot = -21.6503181327212 | etot = -16.1926455214325 +400000 ekin = 1.800915604111 | erot = 2.76596769548035 | epot = -21.6418619272709 | etot = -17.0749786276795 +401000 ekin = 2.35073130822393 | erot = 3.1229922205774 | epot = -21.6675586342212 | etot = -16.1938351054199 +402000 ekin = 3.95550191914708 | erot = 3.58855023837881 | epot = -21.5840051268208 | etot = -14.0399529692949 +403000 ekin = 3.59615502379622 | erot = 3.44558176696768 | epot = -21.5781150073617 | etot = -14.5363782165978 +404000 ekin = 2.50360365952137 | erot = 3.01285184176069 | epot = -21.6258060641303 | etot = -16.1093505628483 +405000 ekin = 2.77241560720113 | erot = 3.10596549510783 | epot = -21.704678917892 | etot = -15.826297815583 +406000 ekin = 2.33934923007339 | erot = 2.04671975867729 | epot = -21.819104286388 | etot = -17.4330352976373 +407000 ekin = 2.34277955096234 | erot = 1.89301717692526 | epot = -21.8450916691373 | etot = -17.6092949412497 +408000 ekin = 1.91561948833426 | erot = 2.19551604353608 | epot = -21.8744041835349 | etot = -17.7632686516646 +409000 ekin = 1.98819074442449 | erot = 1.93870533007334 | epot = -21.921903026697 | etot = -17.9950069521992 +410000 ekin = 1.59047218684375 | erot = 1.93259851333214 | epot = -21.969890787558 | etot = -18.4468200873821 +411000 ekin = 1.88305362601542 | erot = 2.47249081001963 | epot = -22.0985208042931 | etot = -17.742976368258 +412000 ekin = 2.51301623282815 | erot = 2.67550740966365 | epot = -22.2078537029906 | etot = -17.0193300604988 +413000 ekin = 2.81407439938451 | erot = 3.21402559358062 | epot = -22.1310120840187 | etot = -16.1029120910536 +414000 ekin = 2.79247479268938 | erot = 2.73425265524033 | epot = -22.0977113063587 | etot = -16.570983858429 +415000 ekin = 2.47916660937974 | erot = 2.2538291443672 | epot = -22.1646477745644 | etot = -17.4316520208175 +416000 ekin = 3.33232223339091 | erot = 1.56386062957 | epot = -22.1461937000839 | etot = -17.250010837123 +417000 ekin = 3.95877285814837 | erot = 2.43917045295873 | epot = -22.0789469190762 | etot = -15.6810036079691 +418000 ekin = 2.77978041892218 | erot = 2.67961998913593 | epot = -21.9429456651673 | etot = -16.4835452571092 +419000 ekin = 2.38024484823696 | erot = 2.99229133054455 | epot = -21.8677152868896 | etot = -16.4951791081081 +420000 ekin = 1.80871194953159 | erot = 1.84151089264678 | epot = -21.8596865313185 | etot = -18.2094636891401 +421000 ekin = 1.25971024821532 | erot = 1.84154088985399 | epot = -21.8144945739243 | etot = -18.713243435855 +422000 ekin = 1.38801644153196 | erot = 2.76287955544763 | epot = -21.9448046693442 | etot = -17.7939086723646 +423000 ekin = 1.61378102360038 | erot = 3.08643589903684 | epot = -21.9876910184367 | etot = -17.2874740957995 +424000 ekin = 2.38187559636676 | erot = 2.03497345340564 | epot = -22.0529622043822 | etot = -17.6361131546098 +425000 ekin = 2.30172600419957 | erot = 2.56124787306544 | epot = -22.0909144547264 | etot = -17.2279405774613 +426000 ekin = 2.08135734353848 | erot = 3.11029155110106 | epot = -22.0318884881515 | etot = -16.8402395935119 +427000 ekin = 2.14905284759742 | erot = 2.44063059706749 | epot = -21.9221859408584 | etot = -17.3325024961935 +428000 ekin = 1.77884336055357 | erot = 1.65616500997461 | epot = -21.9003025672496 | etot = -18.4652941967214 +429000 ekin = 1.64634843235491 | erot = 2.54977814749917 | epot = -21.8505053104909 | etot = -17.6543787306368 +430000 ekin = 2.66566369380165 | erot = 2.85826638798746 | epot = -21.8749831872768 | etot = -16.3510531054877 +431000 ekin = 2.77262842672213 | erot = 1.57008239418362 | epot = -21.8682859290024 | etot = -17.5255751080967 +432000 ekin = 2.55459213758159 | erot = 1.62943387255927 | epot = -21.8357562133881 | etot = -17.6517302032472 +433000 ekin = 1.99645419170627 | erot = 2.46386731011038 | epot = -21.9426115259012 | etot = -17.4822900240846 +434000 ekin = 3.03855037499723 | erot = 2.70114732868002 | epot = -22.0521183162706 | etot = -16.3124206125934 +435000 ekin = 3.56249359412514 | erot = 1.3916907800745 | epot = -22.1907087359577 | etot = -17.236524361758 +436000 ekin = 2.9919519436941 | erot = 2.00780906096746 | epot = -22.1944569501235 | etot = -17.194695945462 +437000 ekin = 3.22983002449305 | erot = 1.78457838368284 | epot = -22.2079862630257 | etot = -17.1935778548498 +438000 ekin = 2.89357954274282 | erot = 1.84712438388029 | epot = -22.1640149633625 | etot = -17.4233110367394 +439000 ekin = 2.43548109922482 | erot = 2.69725667220989 | epot = -22.15552566419 | etot = -17.0227878927552 +440000 ekin = 2.2623759777343 | erot = 3.0053291392984 | epot = -22.1911581748161 | etot = -16.9234530577834 +441000 ekin = 2.91169601545459 | erot = 2.87109172357543 | epot = -22.3349024428918 | etot = -16.5521147038618 +442000 ekin = 2.09099397022228 | erot = 1.73520313922453 | epot = -22.4051258365299 | etot = -18.5789287270831 +443000 ekin = 1.89190436364779 | erot = 2.00338805773041 | epot = -22.4571595679749 | etot = -18.5618671465967 +444000 ekin = 2.07260612589383 | erot = 2.15261859961606 | epot = -22.4762155543905 | etot = -18.2509908288806 +445000 ekin = 2.10794043544074 | erot = 2.27849500108989 | epot = -22.5289113655649 | etot = -18.1424759290343 +446000 ekin = 2.43249129570082 | erot = 2.85798785841701 | epot = -22.5578450371516 | etot = -17.2673658830337 +447000 ekin = 2.18427449291498 | erot = 2.99487058702881 | epot = -22.633209665243 | etot = -17.4540645852992 +448000 ekin = 2.33125251154888 | erot = 2.9537271150568 | epot = -22.6544934614541 | etot = -17.3695138348484 +449000 ekin = 2.34830834177129 | erot = 2.93433423081578 | epot = -22.6524261630772 | etot = -17.3697835904901 +450000 ekin = 1.83059864091627 | erot = 1.69583085832556 | epot = -22.5959718193007 | etot = -19.0695423200588 +451000 ekin = 1.97008420530444 | erot = 1.93005789483906 | epot = -22.6042016377466 | etot = -18.7040595376031 +452000 ekin = 1.36031716300771 | erot = 1.88416646481667 | epot = -22.5654500281941 | etot = -19.3209664003698 +453000 ekin = 2.08394677326601 | erot = 2.55637003071468 | epot = -22.3996731437447 | etot = -17.759356339764 +454000 ekin = 1.46122132979162 | erot = 2.1932504558799 | epot = -22.2559783518549 | etot = -18.6015065661834 +455000 ekin = 1.66159562683808 | erot = 2.72214658377912 | epot = -22.1100881227337 | etot = -17.7263459121165 +456000 ekin = 2.35139002285135 | erot = 1.99736695780608 | epot = -22.0265180206658 | etot = -17.6777610400084 +457000 ekin = 2.02337666353787 | erot = 2.36288174917835 | epot = -21.9870419865869 | etot = -17.6007835738707 +458000 ekin = 1.74388716034853 | erot = 2.25704341258625 | epot = -22.0124765184275 | etot = -18.0115459454927 +459000 ekin = 2.51302694941202 | erot = 2.31610812350976 | epot = -22.0905335599533 | etot = -17.2613984870315 +460000 ekin = 2.20235980851235 | erot = 2.00073208070752 | epot = -22.0624281815267 | etot = -17.8593362923069 +461000 ekin = 2.27697813860512 | erot = 2.92153186175593 | epot = -22.0043780203814 | etot = -16.8058680200203 +462000 ekin = 2.61751250591993 | erot = 1.79446367088042 | epot = -22.034566251344 | etot = -17.6225900745436 +463000 ekin = 2.59076396942114 | erot = 3.29959067151568 | epot = -21.9680597931617 | etot = -16.0777051522249 +464000 ekin = 2.18897688760924 | erot = 2.37342380725927 | epot = -21.9014176363544 | etot = -17.3390169414859 +465000 ekin = 2.55336811292171 | erot = 3.60208553232432 | epot = -21.8218243406516 | etot = -15.6663706954055 +466000 ekin = 1.98087073364117 | erot = 2.88377492118972 | epot = -21.8240279062597 | etot = -16.9593822514288 +467000 ekin = 1.63963444033068 | erot = 2.61720118783829 | epot = -21.9072568806945 | etot = -17.6504212525255 +468000 ekin = 1.11353612829142 | erot = 3.36362638075105 | epot = -21.9675488944805 | etot = -17.490386385438 +469000 ekin = 1.72228182007047 | erot = 2.77659856111655 | epot = -21.9967286251288 | etot = -17.4978482439417 +470000 ekin = 1.86957223270987 | erot = 2.88200736733016 | epot = -22.0532435258199 | etot = -17.3016639257798 +471000 ekin = 2.73889257490363 | erot = 2.33805868565127 | epot = -22.1018048913227 | etot = -17.0248536307678 +472000 ekin = 2.69336835751318 | erot = 2.14497398823592 | epot = -22.1783319655624 | etot = -17.3399896198133 +473000 ekin = 2.2834012228809 | erot = 2.08779065134065 | epot = -22.2062566289287 | etot = -17.8350647547071 +474000 ekin = 2.23753393343421 | erot = 2.18021358366907 | epot = -22.2186470965394 | etot = -17.8008995794361 +475000 ekin = 2.52144972759887 | erot = 2.10742888877791 | epot = -22.2200376200674 | etot = -17.5911590036907 +476000 ekin = 2.21750839437398 | erot = 1.76993465858266 | epot = -22.1228407781581 | etot = -18.1353977252014 +477000 ekin = 2.49639604606981 | erot = 2.38997154938614 | epot = -22.0914213950017 | etot = -17.2050537995458 +478000 ekin = 1.92476411077776 | erot = 2.05068061613981 | epot = -22.1165013146126 | etot = -18.141056587695 +479000 ekin = 2.27814065534966 | erot = 3.09902158675158 | epot = -22.1039609371193 | etot = -16.726798695018 +480000 ekin = 1.67684718675217 | erot = 2.75298455656157 | epot = -22.107572084908 | etot = -17.6777403415942 +481000 ekin = 1.82004035403442 | erot = 2.94243611851488 | epot = -22.0570042571709 | etot = -17.2945277846216 +482000 ekin = 2.15620792762657 | erot = 2.07225318674483 | epot = -22.0195504604851 | etot = -17.7910893461137 +483000 ekin = 1.49597937205778 | erot = 1.99748154603235 | epot = -21.9846691787552 | etot = -18.4912082606651 +484000 ekin = 1.84801031899852 | erot = 2.3383930614213 | epot = -22.057622803598 | etot = -17.8712194231781 +485000 ekin = 1.63994449952444 | erot = 2.49474020960602 | epot = -22.0873319631203 | etot = -17.9526472539898 +486000 ekin = 1.86878710017944 | erot = 2.15121977781065 | epot = -22.0738722433192 | etot = -18.0538653653291 +487000 ekin = 2.36575535267025 | erot = 3.10125401276719 | epot = -22.1449283981519 | etot = -16.6779190327145 +488000 ekin = 2.28442246943194 | erot = 3.25683393002513 | epot = -22.0988506325681 | etot = -16.557594233111 +489000 ekin = 2.42271484675 | erot = 2.54542145912102 | epot = -22.0089541135478 | etot = -17.0408178076768 +490000 ekin = 2.15700463004959 | erot = 3.54046810332719 | epot = -21.9046622319151 | etot = -16.2071894985383 +491000 ekin = 2.21877065503535 | erot = 2.48745097433189 | epot = -21.7908019627883 | etot = -17.084580333421 +492000 ekin = 2.42517437413502 | erot = 2.76311171529555 | epot = -21.7601749752715 | etot = -16.5718888858409 +493000 ekin = 1.78704503482097 | erot = 2.27560531894265 | epot = -21.8193757259442 | etot = -17.7567253721806 +494000 ekin = 2.08676036701357 | erot = 2.99995787427429 | epot = -21.8611051542237 | etot = -16.7743869129358 +495000 ekin = 2.13526814465422 | erot = 2.49327519100043 | epot = -21.9512664264056 | etot = -17.322723090751 +496000 ekin = 2.04396376951351 | erot = 2.616205394925 | epot = -21.9926597066748 | etot = -17.3324905422363 +497000 ekin = 2.5138400992253 | erot = 1.7082513952147 | epot = -21.9316573881385 | etot = -17.7095658936985 +498000 ekin = 2.15599563393455 | erot = 1.7954584756616 | epot = -21.8684844569259 | etot = -17.9170303473298 +499000 ekin = 3.01748439271979 | erot = 1.75754764004202 | epot = -21.8933218662966 | etot = -17.1182898335348 +500000 ekin = 2.75260982901106 | erot = 2.51842805388796 | epot = -21.8943946135574 | etot = -16.6233567306584 +501000 ekin = 2.67931288903133 | erot = 3.01160406637169 | epot = -21.7750232065095 | etot = -16.0841062511065 +502000 ekin = 1.89360306182664 | erot = 3.89791941021244 | epot = -21.6573468922303 | etot = -15.8658244201912 +503000 ekin = 1.79321931974651 | erot = 2.94204976962205 | epot = -21.4684952360274 | etot = -16.7332261466588 +504000 ekin = 1.67757593959819 | erot = 3.03667519772553 | epot = -21.3740498051044 | etot = -16.6597986677806 +505000 ekin = 2.71879314198246 | erot = 2.13553052885653 | epot = -21.3748517524097 | etot = -16.5205280815707 +506000 ekin = 2.26416011641767 | erot = 2.0398390357387 | epot = -21.3744734731022 | etot = -17.0704743209458 +507000 ekin = 3.1361217829786 | erot = 2.43598082432092 | epot = -21.4637546760327 | etot = -15.8916520687332 +508000 ekin = 2.50986106907072 | erot = 2.54739392181407 | epot = -21.6231060681634 | etot = -16.5658510772786 +509000 ekin = 2.11468804004737 | erot = 2.82565642150503 | epot = -21.7737120459513 | etot = -16.8333675843989 +510000 ekin = 2.15001055304937 | erot = 1.42727017491937 | epot = -21.8417870574445 | etot = -18.2645063294758 +511000 ekin = 2.52545394756595 | erot = 2.75161712587392 | epot = -21.9086876613652 | etot = -16.6316165879253 +512000 ekin = 2.30866784309731 | erot = 2.74554976662385 | epot = -21.9096028664776 | etot = -16.8553852567564 +513000 ekin = 2.48902345599678 | erot = 2.14823762928075 | epot = -21.8729373600799 | etot = -17.2356762748023 +514000 ekin = 2.80071109914887 | erot = 2.54489890263222 | epot = -22.0260959105663 | etot = -16.6804859087852 +515000 ekin = 2.54951114466539 | erot = 1.81830545608794 | epot = -22.1182236024141 | etot = -17.7504070016608 +516000 ekin = 2.82429114749713 | erot = 2.22223190254033 | epot = -22.2027443448738 | etot = -17.1562212948364 +517000 ekin = 2.0440652856654 | erot = 2.05268379810237 | epot = -22.2270328001489 | etot = -18.1302837163811 +518000 ekin = 2.19098614618396 | erot = 2.7523349010516 | epot = -22.2209877154936 | etot = -17.2776666682581 +519000 ekin = 2.24036502705842 | erot = 2.22532553600967 | epot = -22.3180679614818 | etot = -17.8523773984137 +520000 ekin = 1.89058003919379 | erot = 2.20041260684313 | epot = -22.4024099853452 | etot = -18.3114173393082 +521000 ekin = 2.59235690452872 | erot = 1.87867658572832 | epot = -22.562076955749 | etot = -18.0910434654919 +522000 ekin = 3.47612340255834 | erot = 1.7709131526267 | epot = -22.6560013672146 | etot = -17.4089648120295 +523000 ekin = 2.8697331156896 | erot = 2.45931135481363 | epot = -22.7015468187877 | etot = -17.3725023482845 +524000 ekin = 2.43256318748704 | erot = 2.35726786724124 | epot = -22.6382055947878 | etot = -17.8483745400596 +525000 ekin = 1.5862220801759 | erot = 2.67712917770356 | epot = -22.6016118927226 | etot = -18.3382606348432 +526000 ekin = 1.68941966580457 | erot = 1.5638733848976 | epot = -22.5489288531345 | etot = -19.2956358024323 +527000 ekin = 2.25322718958956 | erot = 1.91908592764601 | epot = -22.4417549635527 | etot = -18.2694418463171 +528000 ekin = 2.66412422381676 | erot = 2.81704928468163 | epot = -22.4249217233809 | etot = -16.9437482148825 +529000 ekin = 2.68379060052796 | erot = 3.01205280488721 | epot = -22.4295574265689 | etot = -16.7337140211537 +530000 ekin = 2.58073227215729 | erot = 2.12870295195894 | epot = -22.2883086480464 | etot = -17.5788734239302 +531000 ekin = 2.96770457160389 | erot = 2.35391742452841 | epot = -22.1856711738739 | etot = -16.8640491777416 +532000 ekin = 2.56038964370913 | erot = 2.30878740571672 | epot = -22.1997799918585 | etot = -17.3306029424327 +533000 ekin = 2.47143825522096 | erot = 2.96338918263318 | epot = -22.2065233272061 | etot = -16.7716958893519 +534000 ekin = 2.10112886915673 | erot = 2.06170735341251 | epot = -22.2366529232829 | etot = -18.0738167007137 +535000 ekin = 3.76894732289841 | erot = 2.64646203076619 | epot = -22.2276744548843 | etot = -15.8122651012197 +536000 ekin = 2.7696162230836 | erot = 1.95805234771211 | epot = -22.1654529173378 | etot = -17.4377843465421 +537000 ekin = 2.84154244437419 | erot = 2.62704512023094 | epot = -22.0849688339382 | etot = -16.6163812693331 +538000 ekin = 2.68442563578381 | erot = 2.11441739965432 | epot = -22.0125688846837 | etot = -17.2137258492456 +539000 ekin = 2.71421145807769 | erot = 2.40915133591281 | epot = -22.1313332530722 | etot = -17.0079704590817 +540000 ekin = 2.43518407250594 | erot = 2.49363815768251 | epot = -22.2749632551308 | etot = -17.3461410249423 +541000 ekin = 3.40444579850308 | erot = 2.79359613706622 | epot = -22.3466180642397 | etot = -16.1485761286704 +542000 ekin = 2.43275262454037 | erot = 2.8926712949891 | epot = -22.3556133688796 | etot = -17.0301894493501 +543000 ekin = 2.33375802900842 | erot = 2.87822266703542 | epot = -22.354503031092 | etot = -17.1425223350481 +544000 ekin = 2.20372430185484 | erot = 1.45976141003991 | epot = -22.3227611685585 | etot = -18.6592754566638 +545000 ekin = 2.44172510086271 | erot = 2.14426798374485 | epot = -22.3064237448696 | etot = -17.720430660262 +546000 ekin = 1.97339115566054 | erot = 2.22847557914697 | epot = -22.2636677476263 | etot = -18.0618010128188 +547000 ekin = 2.54002001617723 | erot = 1.88945501268906 | epot = -22.2158143598027 | etot = -17.7863393309365 +548000 ekin = 1.68526456618955 | erot = 1.65049155866197 | epot = -22.1214578510425 | etot = -18.785701726191 +549000 ekin = 1.87014690614356 | erot = 2.68376307045224 | epot = -22.3040985050477 | etot = -17.7501885284519 +550000 ekin = 1.81229877740871 | erot = 1.59166644509217 | epot = -22.4560870327802 | etot = -19.0521218102793 +551000 ekin = 2.18773128797504 | erot = 2.27087388044657 | epot = -22.5158361799812 | etot = -18.0572310115596 +552000 ekin = 2.05249497087455 | erot = 2.50761265901319 | epot = -22.5719393540102 | etot = -18.0118317241225 +553000 ekin = 2.95454924363313 | erot = 2.14558063826841 | epot = -22.6616695566088 | etot = -17.5615396747072 +554000 ekin = 2.82907288726943 | erot = 1.93583607418193 | epot = -22.8114472173086 | etot = -18.0465382558572 +555000 ekin = 2.39144194814065 | erot = 2.2690346714923 | epot = -22.8607776699892 | etot = -18.2003010503562 +556000 ekin = 2.29377130416531 | erot = 2.58082229477443 | epot = -22.9123559572369 | etot = -18.0377623582971 +557000 ekin = 2.83942594504113 | erot = 1.46630323732685 | epot = -22.9955247836668 | etot = -18.6897956012988 +558000 ekin = 2.74466783679159 | erot = 2.01704787654692 | epot = -23.0269943374553 | etot = -18.2652786241168 +559000 ekin = 3.32013685758138 | erot = 2.33070588278053 | epot = -23.0724440783111 | etot = -17.4216013379492 +560000 ekin = 3.06575014862304 | erot = 2.3240772361437 | epot = -23.058452120381 | etot = -17.6686247356143 +561000 ekin = 2.86678914129224 | erot = 2.08494050984238 | epot = -22.9757329649367 | etot = -18.0240033138021 +562000 ekin = 3.27279507804287 | erot = 2.51484206553918 | epot = -22.8763400547029 | etot = -17.0887029111208 +563000 ekin = 2.66038070150058 | erot = 1.64116530766161 | epot = -22.8496252506975 | etot = -18.5480792415353 +564000 ekin = 2.80463843262516 | erot = 2.5266606313835 | epot = -22.8040898690867 | etot = -17.4727908050781 +565000 ekin = 2.64623234011006 | erot = 2.04560086917498 | epot = -22.7528472206811 | etot = -18.061014011396 +566000 ekin = 2.31861442156789 | erot = 2.17941765713979 | epot = -22.7559143900141 | etot = -18.2578823113064 +567000 ekin = 1.93226018038665 | erot = 2.82020539323088 | epot = -22.7113049006743 | etot = -17.9588393270567 +568000 ekin = 2.20139908423163 | erot = 2.2173471641442 | epot = -22.7309883250972 | etot = -18.3122420767214 +569000 ekin = 2.47190977966691 | erot = 2.65968832242268 | epot = -22.6724326928842 | etot = -17.5408345907946 +570000 ekin = 2.43697670060318 | erot = 1.88669477532771 | epot = -22.6652860601546 | etot = -18.3416145842237 +571000 ekin = 2.89014026085716 | erot = 2.95617526869999 | epot = -22.6585089246084 | etot = -16.8121933950513 +572000 ekin = 1.93596118948626 | erot = 3.77290573984751 | epot = -22.617986049283 | etot = -16.9091191199493 +573000 ekin = 2.4045463471171 | erot = 2.31316721466246 | epot = -22.5941857447927 | etot = -17.8764721830131 +574000 ekin = 1.69171540489496 | erot = 2.32939319863948 | epot = -22.6485181547002 | etot = -18.6274095511658 +575000 ekin = 1.84147438222145 | erot = 1.86451086977537 | epot = -22.7257563443532 | etot = -19.0197710923563 +576000 ekin = 3.22125710715105 | erot = 2.95826776175095 | epot = -22.6735851458116 | etot = -16.4940602769096 +577000 ekin = 2.86653117003728 | erot = 2.88010628292138 | epot = -22.6061554079341 | etot = -16.8595179549754 +578000 ekin = 2.38032268318987 | erot = 2.76710196021751 | epot = -22.4015577816723 | etot = -17.2541331382649 +579000 ekin = 2.40088404436444 | erot = 1.99411758494037 | epot = -22.2441807849414 | etot = -17.8491791556366 +580000 ekin = 2.62022193893445 | erot = 1.97772953708398 | epot = -22.0981459564787 | etot = -17.5001944804602 +581000 ekin = 2.04609920382364 | erot = 3.0202197191752 | epot = -21.9713515823037 | etot = -16.9050326593048 +582000 ekin = 2.17556767215606 | erot = 3.10885810822424 | epot = -21.8451828402321 | etot = -16.5607570598518 +583000 ekin = 2.12792577884129 | erot = 2.7142175246668 | epot = -21.8090540347999 | etot = -16.9669107312918 +584000 ekin = 2.99197492146328 | erot = 2.6185428756741 | epot = -21.8014711662179 | etot = -16.1909533690805 +585000 ekin = 2.41600413666429 | erot = 2.49968403996098 | epot = -21.7582079751419 | etot = -16.8425197985166 +586000 ekin = 3.57880609498067 | erot = 1.99026777936244 | epot = -21.7793800190221 | etot = -16.210306144679 +587000 ekin = 3.53569318795882 | erot = 1.96660845702856 | epot = -21.7574182658133 | etot = -16.255116620826 +588000 ekin = 2.80385841316338 | erot = 1.58927534150911 | epot = -21.7290695763864 | etot = -17.3359358217139 +589000 ekin = 2.31178332958482 | erot = 2.19605556561577 | epot = -21.7771889269559 | etot = -17.2693500317553 +590000 ekin = 2.57159955455667 | erot = 1.71441305781987 | epot = -21.7801644206484 | etot = -17.4941518082718 +591000 ekin = 1.90027597697965 | erot = 3.80794292513097 | epot = -21.8693595444135 | etot = -16.1611406423028 +592000 ekin = 2.10287592275467 | erot = 2.85572724854609 | epot = -21.913245820329 | etot = -16.9546426490283 +593000 ekin = 1.6630679389305 | erot = 2.45937970675131 | epot = -21.9499391362603 | etot = -17.8274914905785 +594000 ekin = 1.85147249869391 | erot = 2.37596539021724 | epot = -22.0748010854883 | etot = -17.8473631965771 +595000 ekin = 1.62801913987931 | erot = 2.13760745860405 | epot = -22.2650343535207 | etot = -18.4994077550374 +596000 ekin = 1.8507787756783 | erot = 1.55277904845736 | epot = -22.3618759263936 | etot = -18.9583181022579 +597000 ekin = 2.21873580046471 | erot = 2.31247364510899 | epot = -22.4218283315557 | etot = -17.890618885982 +598000 ekin = 1.87152940931079 | erot = 3.02770945247868 | epot = -22.4928956008977 | etot = -17.5936567391082 +599000 ekin = 2.84160333456022 | erot = 2.19202304201413 | epot = -22.5210806388342 | etot = -17.4874542622599 +600000 ekin = 2.63824255094171 | erot = 2.13280883838531 | epot = -22.4361553764614 | etot = -17.6651039871344 +601000 ekin = 2.95991744971104 | erot = 3.20891387142304 | epot = -22.3089419175364 | etot = -16.1401105964023 +602000 ekin = 2.94287171911394 | erot = 2.6801544694314 | epot = -22.2205146380182 | etot = -16.5974884494729 +603000 ekin = 2.59651768027528 | erot = 2.70994674634417 | epot = -22.1626040385702 | etot = -16.8561396119508 +604000 ekin = 1.79237423166219 | erot = 2.11638057359598 | epot = -22.1934477586593 | etot = -18.2846929534011 +605000 ekin = 1.83068473031177 | erot = 2.2795743818689 | epot = -22.2254684973409 | etot = -18.1152093851602 +606000 ekin = 2.3318585405123 | erot = 2.19626289047853 | epot = -22.1692552740621 | etot = -17.6411338430713 +607000 ekin = 2.71184010988538 | erot = 2.97108975720824 | epot = -22.1536579122904 | etot = -16.4707280451968 +608000 ekin = 2.42009843612052 | erot = 2.41609650030392 | epot = -22.110570505977 | etot = -17.2743755695526 +609000 ekin = 1.88829617874732 | erot = 2.63290748875975 | epot = -21.9999822454274 | etot = -17.4787785779203 +610000 ekin = 3.00361337450473 | erot = 2.17709909276457 | epot = -21.9226199750059 | etot = -16.7419075077366 +611000 ekin = 2.45804405292799 | erot = 2.74756316868512 | epot = -21.9190479764513 | etot = -16.7134407548382 +612000 ekin = 2.52217588638913 | erot = 2.13391253924555 | epot = -21.9544188877756 | etot = -17.2983304621409 +613000 ekin = 3.03676008822021 | erot = 2.11841016157454 | epot = -22.0017416346015 | etot = -16.8465713848068 +614000 ekin = 2.28555718180926 | erot = 3.0054092802111 | epot = -22.0761965028491 | etot = -16.7852300408287 +615000 ekin = 1.68510287809685 | erot = 2.62386193001633 | epot = -22.0327006368424 | etot = -17.7237358287293 +616000 ekin = 1.93880828018173 | erot = 2.84237691352502 | epot = -22.0612297066235 | etot = -17.2800445129167 +617000 ekin = 2.16704933019324 | erot = 2.51662857724103 | epot = -22.0595683849495 | etot = -17.3758904775152 +618000 ekin = 3.09933970351517 | erot = 2.74545743402536 | epot = -22.0170483082271 | etot = -16.1722511706866 +619000 ekin = 3.43176670397203 | erot = 2.12195823326365 | epot = -21.9875785418916 | etot = -16.4338536046559 +620000 ekin = 4.28780554984769 | erot = 2.22709196760532 | epot = -21.9605251543896 | etot = -15.4456276369365 +621000 ekin = 3.08171244822519 | erot = 2.57159564010567 | epot = -21.9025163812385 | etot = -16.2492082929076 +622000 ekin = 2.7316886075754 | erot = 2.62820058118157 | epot = -21.8412338594045 | etot = -16.4813446706475 +623000 ekin = 2.85452079274903 | erot = 2.89943500147414 | epot = -21.6852443941174 | etot = -15.9312885998942 +624000 ekin = 2.03273271064347 | erot = 3.41737453659275 | epot = -21.5180611078538 | etot = -16.0679538606176 +625000 ekin = 2.93860287466086 | erot = 2.6777302302364 | epot = -21.3855450802948 | etot = -15.7692119753975 +626000 ekin = 2.62772208534213 | erot = 2.18165419852424 | epot = -21.3747765229082 | etot = -16.5654002390418 +627000 ekin = 2.31977818310487 | erot = 2.39484209061113 | epot = -21.4372090577008 | etot = -16.7225887839848 +628000 ekin = 2.22183190227213 | erot = 2.76412054255638 | epot = -21.5969078027883 | etot = -16.6109553579598 +629000 ekin = 2.21761787409423 | erot = 1.98066149405245 | epot = -21.7578561859453 | etot = -17.5595768177986 +630000 ekin = 2.47350494176362 | erot = 2.13931642231374 | epot = -21.7773766650218 | etot = -17.1645553009445 +631000 ekin = 2.05047278007876 | erot = 1.79296462014617 | epot = -21.7869475538217 | etot = -17.9435101535968 +632000 ekin = 1.64845667747476 | erot = 3.28396465847893 | epot = -21.8333012025329 | etot = -16.9008798665792 +633000 ekin = 2.3500132343185 | erot = 2.3390975332878 | epot = -21.9539301797825 | etot = -17.2648194121762 +634000 ekin = 2.35704893279043 | erot = 2.46483254513169 | epot = -22.0204072629832 | etot = -17.1985257850611 +635000 ekin = 1.98907577162676 | erot = 3.37071781675284 | epot = -22.0690924871448 | etot = -16.7092988987652 +636000 ekin = 2.50984196335062 | erot = 2.48688994533939 | epot = -22.0714906026256 | etot = -17.0747586939356 +637000 ekin = 2.77501317112847 | erot = 2.80709332215511 | epot = -21.9923972278242 | etot = -16.4102907345407 +638000 ekin = 2.43799129572064 | erot = 2.7900719850463 | epot = -22.0591413868446 | etot = -16.8310781060777 +639000 ekin = 1.88073995546173 | erot = 2.09679843998312 | epot = -22.0499554202513 | etot = -18.0724170248065 +640000 ekin = 2.08188045172846 | erot = 3.35894090591918 | epot = -21.9976614802368 | etot = -16.5568401225891 +641000 ekin = 2.09182367506332 | erot = 2.24091541077085 | epot = -22.0969663672431 | etot = -17.7642272814089 +642000 ekin = 2.29630816296813 | erot = 2.69496533496291 | epot = -22.1529742829376 | etot = -17.1617007850065 +643000 ekin = 2.73580847855276 | erot = 2.20074971448877 | epot = -22.0965451673466 | etot = -17.1599869743051 +644000 ekin = 2.877547382531 | erot = 3.41752705378106 | epot = -22.1314614085221 | etot = -15.8363869722101 +645000 ekin = 2.42917363330758 | erot = 2.10617126422418 | epot = -22.0684179655268 | etot = -17.533073067995 +646000 ekin = 2.69471397724187 | erot = 1.80009045225372 | epot = -21.8990804127739 | etot = -17.4042759832783 +647000 ekin = 2.47700110999565 | erot = 1.99221351689819 | epot = -21.6986646197608 | etot = -17.229449992867 +648000 ekin = 2.27330015032657 | erot = 1.67398094476719 | epot = -21.7984825454864 | etot = -17.8512014503927 +649000 ekin = 2.5628574039565 | erot = 1.74923984575743 | epot = -22.1937498986979 | etot = -17.881652648984 +650000 ekin = 2.76035969172866 | erot = 2.20984080080438 | epot = -22.3536470081185 | etot = -17.3834465155854 +651000 ekin = 2.262551545237 | erot = 3.27496991661067 | epot = -22.4274148303114 | etot = -16.8898933684638 +652000 ekin = 2.3727982819665 | erot = 2.29630046443082 | epot = -22.4456643066011 | etot = -17.7765655602038 +653000 ekin = 2.07651844100825 | erot = 2.14699861111497 | epot = -22.4487464586908 | etot = -18.2252294065676 +654000 ekin = 2.31499263290336 | erot = 1.84798657187726 | epot = -22.471548114837 | etot = -18.3085689100564 +655000 ekin = 2.12344600536595 | erot = 1.79742316518918 | epot = -22.4407504825061 | etot = -18.519881311951 +656000 ekin = 2.44238672537433 | erot = 2.33314467296101 | epot = -22.4050518721077 | etot = -17.6295204737724 +657000 ekin = 2.44684720738067 | erot = 2.87010904355218 | epot = -22.3954429054341 | etot = -17.0784866545012 +658000 ekin = 2.49369435044193 | erot = 2.86933833355583 | epot = -22.3577847118898 | etot = -16.9947520278921 +659000 ekin = 3.38707666874149 | erot = 2.79117377884123 | epot = -22.2233688708269 | etot = -16.0451184232442 +660000 ekin = 2.69464750718905 | erot = 1.98877163007961 | epot = -22.0868371976707 | etot = -17.403418060402 +661000 ekin = 2.2148438610813 | erot = 2.52686187560576 | epot = -21.9324475602905 | etot = -17.1907418236035 +662000 ekin = 2.04483468145689 | erot = 2.52786214958084 | epot = -21.8656118118386 | etot = -17.2929149808009 +663000 ekin = 2.25554994547888 | erot = 2.29981193022507 | epot = -21.812115133329 | etot = -17.256753257625 +664000 ekin = 2.38378154392877 | erot = 1.87242521142835 | epot = -21.7163692740767 | etot = -17.4601625187195 +665000 ekin = 2.64936843119576 | erot = 2.2989986114753 | epot = -21.6597356727187 | etot = -16.7113686300476 +666000 ekin = 1.64494457505824 | erot = 2.30638161556456 | epot = -21.5641898301393 | etot = -17.6128636395165 +667000 ekin = 1.65735220589392 | erot = 2.82614341732318 | epot = -21.4751653585362 | etot = -16.9916697353191 +668000 ekin = 2.49844825113869 | erot = 3.27950898400314 | epot = -21.3387145475146 | etot = -15.5607573123727 +669000 ekin = 1.61611201967415 | erot = 2.67203522811057 | epot = -21.2655442255718 | etot = -16.9773969777871 +670000 ekin = 2.23077474650818 | erot = 2.61363425835144 | epot = -21.2008892493679 | etot = -16.3564802445083 +671000 ekin = 2.26765830930916 | erot = 2.16388121545907 | epot = -21.1515274648835 | etot = -16.7199879401153 +672000 ekin = 1.94916146819698 | erot = 1.65479713709716 | epot = -21.0650678898704 | etot = -17.4611092845762 +673000 ekin = 1.92556066199439 | erot = 2.07900172108796 | epot = -21.0394363569888 | etot = -17.0348739739065 +674000 ekin = 2.12432357869025 | erot = 2.16781085660272 | epot = -21.0725830613714 | etot = -16.7804486260784 +675000 ekin = 2.06851819258986 | erot = 2.48317287761026 | epot = -21.1036073609477 | etot = -16.5519162907476 +676000 ekin = 2.45484997181755 | erot = 2.79183078710855 | epot = -21.1301283632782 | etot = -15.8834476043521 +677000 ekin = 2.20334154136532 | erot = 2.62444584525113 | epot = -21.1495626618894 | etot = -16.321775275273 +678000 ekin = 2.1472401432145 | erot = 2.79545747432262 | epot = -21.0405241444794 | etot = -16.0978265269423 +679000 ekin = 2.17033413623502 | erot = 2.18513653140294 | epot = -20.9421185444833 | etot = -16.5866478768454 +680000 ekin = 2.0995303513191 | erot = 2.68744418062154 | epot = -20.96987060062 | etot = -16.1828960686793 +681000 ekin = 2.18304447310098 | erot = 1.84812119436561 | epot = -21.0743862151371 | etot = -17.0432205476705 +682000 ekin = 3.04278123794939 | erot = 2.40409586716963 | epot = -21.0797568548333 | etot = -15.6328797497143 +683000 ekin = 2.86269023881706 | erot = 2.09728443896194 | epot = -21.0991655055583 | etot = -16.1391908277793 +684000 ekin = 1.98767037715953 | erot = 2.99591968828981 | epot = -21.1362036730577 | etot = -16.1526136076083 +685000 ekin = 1.57295457528713 | erot = 2.03034771002018 | epot = -21.146987158564 | etot = -17.5436848732567 +686000 ekin = 2.37743960028747 | erot = 2.54064910359146 | epot = -21.1479154694211 | etot = -16.2298267655421 +687000 ekin = 1.90905424981708 | erot = 2.87649471802563 | epot = -21.1390488337729 | etot = -16.3534998659302 +688000 ekin = 2.6274055742777 | erot = 2.25087525520177 | epot = -21.1259808926564 | etot = -16.2477000631769 +689000 ekin = 2.6802663035185 | erot = 2.65264291183039 | epot = -21.2405393346747 | etot = -15.9076301193258 +690000 ekin = 2.56393304559926 | erot = 2.48495065222978 | epot = -21.4016015121778 | etot = -16.3527178143488 +691000 ekin = 2.1927043501829 | erot = 2.52704457861404 | epot = -21.506826556612 | etot = -16.787077627815 +692000 ekin = 2.34077396593209 | erot = 3.24867065054243 | epot = -21.5176021816804 | etot = -15.9281575652059 +693000 ekin = 2.29029075483228 | erot = 3.0057489559252 | epot = -21.5358866889499 | etot = -16.2398469781924 +694000 ekin = 2.65674046511192 | erot = 2.58629868712489 | epot = -21.7490636357026 | etot = -16.5060244834658 +695000 ekin = 2.43126197328691 | erot = 1.19706323700546 | epot = -21.9401398969726 | etot = -18.3118146866802 +696000 ekin = 1.81474808623754 | erot = 1.46920096781106 | epot = -21.9089223337524 | etot = -18.6249732797038 +697000 ekin = 2.39476771383886 | erot = 2.11183502257124 | epot = -21.9420332766104 | etot = -17.4354305402003 +698000 ekin = 2.35926337724266 | erot = 1.92783320549514 | epot = -22.0277191263435 | etot = -17.7406225436058 +699000 ekin = 2.48176872675362 | erot = 2.56000644090342 | epot = -22.0212596021869 | etot = -16.9794844345298 +700000 ekin = 2.14129959772679 | erot = 2.29861037684922 | epot = -21.9318234409146 | etot = -17.4919134663386 +701000 ekin = 2.17049668499625 | erot = 2.20225192400486 | epot = -21.8245513288874 | etot = -17.4518027198863 +702000 ekin = 1.5627527155292 | erot = 2.01171151000641 | epot = -21.7865003044461 | etot = -18.2120360789105 +703000 ekin = 2.06065227779357 | erot = 2.17329473717683 | epot = -21.8026608939335 | etot = -17.5687138789631 +704000 ekin = 2.81952809577903 | erot = 1.94266087393333 | epot = -21.8212186788769 | etot = -17.0590297091645 +705000 ekin = 2.82050127519937 | erot = 2.18154028834385 | epot = -21.7752102636878 | etot = -16.7731687001446 +706000 ekin = 1.98267828238497 | erot = 2.32706466032389 | epot = -21.7893242385512 | etot = -17.4795812958423 +707000 ekin = 1.9119199256382 | erot = 2.05897787647106 | epot = -21.8430722730707 | etot = -17.8721744709615 +708000 ekin = 2.5016490217549 | erot = 2.18383615173375 | epot = -21.8544847432183 | etot = -17.1689995697297 +709000 ekin = 2.87304116461984 | erot = 2.56843564623617 | epot = -21.904442472254 | etot = -16.462965661398 +710000 ekin = 2.19867234802447 | erot = 2.26714812026436 | epot = -21.8819798989583 | etot = -17.4161594306695 +711000 ekin = 2.3389229861775 | erot = 1.44633862250317 | epot = -21.9197827259336 | etot = -18.1345211172529 +712000 ekin = 2.57005480809076 | erot = 2.28706559960511 | epot = -22.0346026838636 | etot = -17.1774822761678 +713000 ekin = 1.98393390580317 | erot = 2.33525788511068 | epot = -22.1280127822608 | etot = -17.8088209913469 +714000 ekin = 2.59844561627729 | erot = 2.10769412707773 | epot = -22.1916311346269 | etot = -17.4854913912719 +715000 ekin = 2.41851974197058 | erot = 3.7488852557719 | epot = -22.1607861798611 | etot = -15.9933811821187 +716000 ekin = 2.8418023132582 | erot = 2.85971600497616 | epot = -22.0686589684412 | etot = -16.3671406502068 +717000 ekin = 3.4484144493586 | erot = 3.22605040091157 | epot = -21.9727882885698 | etot = -15.2983234382996 +718000 ekin = 3.10436184228427 | erot = 3.94950630255782 | epot = -21.8709253031511 | etot = -14.817057158309 +719000 ekin = 2.37806574336789 | erot = 2.95502686702168 | epot = -21.8563367317646 | etot = -16.523244121375 +720000 ekin = 2.2124258408194 | erot = 3.13473166149202 | epot = -21.832964450767 | etot = -16.4858069484555 +721000 ekin = 1.6946894391771 | erot = 2.23193742756367 | epot = -21.7424084526643 | etot = -17.8157815859235 +722000 ekin = 1.90287140868432 | erot = 2.80483524098531 | epot = -21.7497487144859 | etot = -17.0420420648163 +723000 ekin = 2.36731223380046 | erot = 2.56327951769445 | epot = -21.6831418267135 | etot = -16.7525500752186 +724000 ekin = 1.73555921199202 | erot = 2.45238016332295 | epot = -21.6581802464112 | etot = -17.4702408710962 +725000 ekin = 2.29059437023039 | erot = 2.94575894857246 | epot = -21.7174261464808 | etot = -16.481072827678 +726000 ekin = 1.63483147798521 | erot = 2.30383185500799 | epot = -21.7564933587679 | etot = -17.8178300257747 +727000 ekin = 2.48240653489464 | erot = 3.20354227059193 | epot = -21.7912108634863 | etot = -16.1052620579997 +728000 ekin = 2.22769215153326 | erot = 2.1648907299462 | epot = -21.7890771091799 | etot = -17.3964942277004 +729000 ekin = 1.89768095869013 | erot = 1.65721672588089 | epot = -21.828690265207 | etot = -18.273792580636 +730000 ekin = 1.81050835100381 | erot = 2.15777747975243 | epot = -21.8264469741817 | etot = -17.8581611434255 +731000 ekin = 2.19898236908282 | erot = 2.98408098832205 | epot = -21.78613179764 | etot = -16.6030684402352 +732000 ekin = 2.43355047343304 | erot = 2.27170844305628 | epot = -21.6883863408736 | etot = -16.9831274243842 +733000 ekin = 3.07212273972684 | erot = 2.56783751855608 | epot = -21.7364921079322 | etot = -16.0965318496493 +734000 ekin = 2.38307322516835 | erot = 2.02726646964742 | epot = -21.7939757502944 | etot = -17.3836360554786 +735000 ekin = 2.14195880954704 | erot = 1.55624807241878 | epot = -21.8426856981853 | etot = -18.1444788162195 +736000 ekin = 2.14667447582536 | erot = 3.43698049451811 | epot = -21.9502105525335 | etot = -16.36655558219 +737000 ekin = 1.74866123585724 | erot = 3.5826697540454 | epot = -21.968815658378 | etot = -16.6374846684753 +738000 ekin = 2.03996249374858 | erot = 2.50844136963082 | epot = -22.0013918784186 | etot = -17.4529880150392 +739000 ekin = 1.85238190118677 | erot = 2.20010970404146 | epot = -22.0186271684577 | etot = -17.9661355632295 +740000 ekin = 2.8386294530065 | erot = 2.79090377324796 | epot = -22.0338814904879 | etot = -16.4043482642334 +741000 ekin = 2.46678702773208 | erot = 2.91050038280044 | epot = -22.0853235069127 | etot = -16.7080360963801 +742000 ekin = 2.7152902937519 | erot = 3.273956530725 | epot = -22.2140748190892 | etot = -16.2248279946123 +743000 ekin = 2.22536600879677 | erot = 3.2117924712642 | epot = -22.3431375024118 | etot = -16.9059790223509 +744000 ekin = 2.01371736615449 | erot = 3.7760139384218 | epot = -22.4261509869247 | etot = -16.6364196823485 +745000 ekin = 3.15730296333415 | erot = 2.31558796250712 | epot = -22.4108926873302 | etot = -16.9380017614889 +746000 ekin = 2.9774013013854 | erot = 2.63107362961469 | epot = -22.3694265664286 | etot = -16.7609516354285 +747000 ekin = 2.34209064832563 | erot = 2.04683419375202 | epot = -22.3628627944521 | etot = -17.9739379523744 +748000 ekin = 2.37156256463875 | erot = 2.40538773919509 | epot = -22.3979208424336 | etot = -17.6209705385998 +749000 ekin = 2.06136855553991 | erot = 2.76585915349199 | epot = -22.3831536512816 | etot = -17.5559259422497 +750000 ekin = 1.64656775002689 | erot = 2.38368935068671 | epot = -22.444703911786 | etot = -18.4144468110724 +751000 ekin = 1.78122844885826 | erot = 2.81833836133587 | epot = -22.533438976529 | etot = -17.9338721663349 +752000 ekin = 1.34730592473948 | erot = 1.45838401317446 | epot = -22.6090848823224 | etot = -19.8033949444084 +753000 ekin = 1.87571626319838 | erot = 2.4535466519722 | epot = -22.5588053116254 | etot = -18.2295423964548 +754000 ekin = 1.7497031355263 | erot = 2.74314075044427 | epot = -22.4698920344377 | etot = -17.9770481484671 +755000 ekin = 2.42081076696332 | erot = 2.41217357398055 | epot = -22.3964223120253 | etot = -17.5634379710815 +756000 ekin = 1.85475003398 | erot = 2.78259891044772 | epot = -22.3205962727121 | etot = -17.6832473282843 +757000 ekin = 1.97578050121357 | erot = 2.51781218539581 | epot = -22.1263927786386 | etot = -17.6328000920292 +758000 ekin = 1.22826853890876 | erot = 2.60763168332874 | epot = -21.9863700054334 | etot = -18.1504697831958 +759000 ekin = 2.21637457917735 | erot = 1.43949125248239 | epot = -22.1514665432947 | etot = -18.495600711635 +760000 ekin = 2.68033406797323 | erot = 2.41719679588396 | epot = -22.2590376675296 | etot = -17.1615068036724 +761000 ekin = 2.1753744063555 | erot = 2.27171718649737 | epot = -22.3344047362676 | etot = -17.8873131434147 +762000 ekin = 2.18577068124737 | erot = 1.66829735822053 | epot = -22.3621686129861 | etot = -18.5081005735182 +763000 ekin = 2.45478818575913 | erot = 3.35299551820638 | epot = -22.4281249366375 | etot = -16.620341232672 +764000 ekin = 2.82872579097199 | erot = 2.78775814269904 | epot = -22.4216595904294 | etot = -16.8051756567583 +765000 ekin = 1.82575545759014 | erot = 2.7623896973924 | epot = -22.3222506299713 | etot = -17.7341054749887 +766000 ekin = 2.64667028577447 | erot = 2.30816231818549 | epot = -22.1784504992491 | etot = -17.2236178952891 +767000 ekin = 2.5751886312018 | erot = 2.85636091304187 | epot = -22.0829371218307 | etot = -16.651387577587 +768000 ekin = 1.86419535586237 | erot = 2.77038508826208 | epot = -22.1032134089885 | etot = -17.4686329648641 +769000 ekin = 2.39682103653439 | erot = 2.30725355924694 | epot = -22.1808553751715 | etot = -17.4767807793902 +770000 ekin = 2.47007838986712 | erot = 3.23244425991329 | epot = -22.2845706013469 | etot = -16.5820479515665 +771000 ekin = 2.32978280625416 | erot = 2.29082247939232 | epot = -22.3223780040389 | etot = -17.7017727183924 +772000 ekin = 2.26109456847871 | erot = 3.00930315380545 | epot = -22.420252339108 | etot = -17.1498546168239 +773000 ekin = 2.23291379974972 | erot = 1.81993150945886 | epot = -22.4876821856977 | etot = -18.4348368764892 +774000 ekin = 2.82112723374611 | erot = 2.20399964233337 | epot = -22.478004597296 | etot = -17.4528777212165 +775000 ekin = 1.80765894464447 | erot = 1.85918506821001 | epot = -22.4072882679054 | etot = -18.7404442550509 +776000 ekin = 1.40021367363829 | erot = 3.15411215412014 | epot = -22.3650958887673 | etot = -17.8107700610088 +777000 ekin = 1.64184304615234 | erot = 2.80565056199556 | epot = -22.2758630382018 | etot = -17.8283694300539 +778000 ekin = 1.48552010960747 | erot = 2.23385655322065 | epot = -22.280627961357 | etot = -18.5612512985288 +779000 ekin = 1.8612416844269 | erot = 1.89467011122749 | epot = -22.3098169150752 | etot = -18.5539051194208 +780000 ekin = 1.69992943470698 | erot = 2.31253245347 | epot = -22.3678364729486 | etot = -18.3553745847716 +781000 ekin = 2.09952906112345 | erot = 2.56012058482576 | epot = -22.4462778123775 | etot = -17.7866281664283 +782000 ekin = 2.5656681981454 | erot = 1.9584872929859 | epot = -22.3478635193415 | etot = -17.8237080282102 +783000 ekin = 2.16529384416182 | erot = 2.88344914114146 | epot = -22.2446053910143 | etot = -17.1958624057111 +784000 ekin = 2.82003342353258 | erot = 2.22795791523759 | epot = -22.2211041777196 | etot = -17.1731128389495 +785000 ekin = 3.1175846654813 | erot = 2.90935771938994 | epot = -22.2344563156641 | etot = -16.2075139307928 +786000 ekin = 2.80016717549673 | erot = 3.42867564957491 | epot = -22.2496451559719 | etot = -16.0208023309003 +787000 ekin = 2.38498105317564 | erot = 3.01080705704523 | epot = -22.1644901078413 | etot = -16.7687019976204 +788000 ekin = 1.98689482841944 | erot = 2.00265266168408 | epot = -22.1102205855985 | etot = -18.120673095495 +789000 ekin = 2.4429381578802 | erot = 2.28303571912852 | epot = -22.0438356575627 | etot = -17.317861780554 +790000 ekin = 3.54942607073523 | erot = 2.80791853998027 | epot = -21.9672470303852 | etot = -15.6099024196697 +791000 ekin = 3.07978044254695 | erot = 2.4184479370232 | epot = -21.9558944305006 | etot = -16.4576660509305 +792000 ekin = 3.91878473045569 | erot = 1.9731825502165 | epot = -21.8851857762129 | etot = -15.9932184955407 +793000 ekin = 2.24379464034279 | erot = 2.58359475602037 | epot = -21.774610681239 | etot = -16.9472212848759 +794000 ekin = 2.14799943871595 | erot = 2.45378042225321 | epot = -21.6055963838422 | etot = -17.0038165228731 +795000 ekin = 1.62858645550717 | erot = 2.41208539626204 | epot = -21.4428264365968 | etot = -17.4021545848276 +796000 ekin = 2.20626767900772 | erot = 2.13905661758329 | epot = -21.3317362060421 | etot = -16.9864119094511 +797000 ekin = 1.82996184067328 | erot = 1.99906119944911 | epot = -21.3393574083459 | etot = -17.5103343682236 +798000 ekin = 2.25667499558209 | erot = 2.51245793531 | epot = -21.3768565865699 | etot = -16.6077236556778 +799000 ekin = 1.90911035219009 | erot = 2.87369878279891 | epot = -21.3617435253194 | etot = -16.5789343903304 +800000 ekin = 2.1677625897713 | erot = 2.34740172956008 | epot = -21.2761013083254 | etot = -16.7609369889941 +801000 ekin = 1.87638787205728 | erot = 1.64434088909028 | epot = -21.119685062831 | etot = -17.5989563016834 +802000 ekin = 2.22686790237101 | erot = 2.21112245128271 | epot = -21.0065136937552 | etot = -16.5685233401014 +803000 ekin = 2.68797844582697 | erot = 1.9055042783616 | epot = -20.977533512373 | etot = -16.3840507881845 +804000 ekin = 2.34860603481643 | erot = 2.89571698053518 | epot = -20.9203141084123 | etot = -15.6759910930607 +805000 ekin = 1.76197291834029 | erot = 2.71253740465393 | epot = -20.7889998983483 | etot = -16.3144895753541 +806000 ekin = 1.7473508020381 | erot = 2.06758975379032 | epot = -20.7361939926422 | etot = -16.9212534368137 +807000 ekin = 1.56935370454674 | erot = 1.70438269927346 | epot = -20.7922156879383 | etot = -17.5184792841181 +808000 ekin = 2.10918656723178 | erot = 2.39856508826456 | epot = -20.8730295437323 | etot = -16.3652778882359 +809000 ekin = 2.64218178293791 | erot = 1.51718119689586 | epot = -20.8620425969582 | etot = -16.7026796171244 +810000 ekin = 3.0961523233869 | erot = 2.66382304688042 | epot = -20.7945446198551 | etot = -15.0345692495878 +811000 ekin = 3.04477285154901 | erot = 3.63336291459452 | epot = -20.8540215443024 | etot = -14.1758857781589 +812000 ekin = 2.15160716251188 | erot = 2.79673763715996 | epot = -20.9409883926875 | etot = -15.9926435930157 +813000 ekin = 2.1868093512261 | erot = 3.1736283575579 | epot = -21.1408022790474 | etot = -15.7803645702634 +814000 ekin = 1.7209257269681 | erot = 2.995751260245 | epot = -21.2437075371712 | etot = -16.5270305499581 +815000 ekin = 2.15299829462668 | erot = 2.27035656487164 | epot = -21.2458654890398 | etot = -16.8225106295415 +816000 ekin = 2.708122450654 | erot = 1.52125307187336 | epot = -21.2616781989935 | etot = -17.0323026764662 +817000 ekin = 2.58901717437677 | erot = 2.58536627670115 | epot = -21.3956545078514 | etot = -16.2212710567734 +818000 ekin = 2.27875756856437 | erot = 2.24624264725757 | epot = -21.4318935062254 | etot = -16.9068932904035 +819000 ekin = 2.10656184615865 | erot = 3.01130039050673 | epot = -21.4327594058408 | etot = -16.3148971691754 +820000 ekin = 2.45661353119087 | erot = 2.7077529494413 | epot = -21.3798106611917 | etot = -16.2154441805595 +821000 ekin = 2.56789243532195 | erot = 2.54922758508947 | epot = -21.3170915318809 | etot = -16.1999715114695 +822000 ekin = 3.57333066089329 | erot = 2.21054956102185 | epot = -21.2861057645663 | etot = -15.5022255426512 +823000 ekin = 3.55383413213106 | erot = 2.72435850620162 | epot = -21.2727846567927 | etot = -14.99459201846 +824000 ekin = 4.1160622349429 | erot = 3.29139599112171 | epot = -21.2039659493683 | etot = -13.7965077233036 +825000 ekin = 2.91568774544338 | erot = 3.47057612959321 | epot = -21.0618933558847 | etot = -14.6756294808481 +826000 ekin = 1.71667097443836 | erot = 1.97830555981831 | epot = -20.8776766681461 | etot = -17.1827001338894 +827000 ekin = 1.87676981471836 | erot = 2.56467088925009 | epot = -20.7862250182709 | etot = -16.3447843143025 +828000 ekin = 2.38071607948713 | erot = 2.54624446499464 | epot = -20.7057379171108 | etot = -15.778777372629 +829000 ekin = 2.23087866970087 | erot = 1.78456567522682 | epot = -20.6078136299299 | etot = -16.5923692850022 +830000 ekin = 2.54758016482261 | erot = 2.32440405635605 | epot = -20.4881081818274 | etot = -15.6161239606488 +831000 ekin = 2.68445862644274 | erot = 2.08263260479755 | epot = -20.3542193485845 | etot = -15.5871281173442 +832000 ekin = 2.63412360308726 | erot = 2.01244922883234 | epot = -20.215817212176 | etot = -15.5692443802564 +833000 ekin = 2.52816532834198 | erot = 2.59604450500368 | epot = -20.1546011863619 | etot = -15.0303913530162 +834000 ekin = 2.89178882882708 | erot = 2.32656568068785 | epot = -20.154457994043 | etot = -14.9361034845281 +835000 ekin = 2.77377023733645 | erot = 2.76167763911259 | epot = -20.2925945781538 | etot = -14.7571467017048 +836000 ekin = 2.5461758373878 | erot = 2.86272526489883 | epot = -20.4572179712235 | etot = -15.0483168689368 +837000 ekin = 1.73852270651188 | erot = 1.97943492340463 | epot = -20.5100877279363 | etot = -16.7921300980198 +838000 ekin = 1.97190789156808 | erot = 2.79058337256635 | epot = -20.5305299708184 | etot = -15.7680387066839 +839000 ekin = 1.97773711155226 | erot = 2.72413991034567 | epot = -20.5265807034224 | etot = -15.8247036815245 +840000 ekin = 1.7232963874871 | erot = 2.96738113282628 | epot = -20.6321231069653 | etot = -15.9414455866519 +841000 ekin = 2.83071457484449 | erot = 2.84941397463216 | epot = -20.7926258530586 | etot = -15.112497303582 +842000 ekin = 2.59731855411368 | erot = 2.84178819703383 | epot = -20.8313063579289 | etot = -15.3921996067814 +843000 ekin = 2.04928376150596 | erot = 2.6128843549826 | epot = -20.8099267672999 | etot = -16.1477586508114 +844000 ekin = 1.54583411960153 | erot = 1.93893729147582 | epot = -20.8613105352918 | etot = -17.3765391242145 +845000 ekin = 2.313825406008 | erot = 2.32466241883302 | epot = -20.9823282893206 | etot = -16.3438404644796 +846000 ekin = 2.08903634512998 | erot = 2.31578856009952 | epot = -21.0646153757685 | etot = -16.659790470539 +847000 ekin = 2.4800137362118 | erot = 2.63006614696695 | epot = -21.0262265568772 | etot = -15.9161466736984 +848000 ekin = 2.15184282735255 | erot = 1.47311006297176 | epot = -21.0583979355086 | etot = -17.4334450451843 +849000 ekin = 2.01842760273387 | erot = 2.48110730715332 | epot = -21.0805165806607 | etot = -16.5809816707735 +850000 ekin = 2.55741512224125 | erot = 2.68263416508461 | epot = -21.0773082596903 | etot = -15.8372589723645 +851000 ekin = 2.18005669935449 | erot = 2.93569398882535 | epot = -21.0924777064982 | etot = -15.9767270183184 +852000 ekin = 2.4696261459638 | erot = 2.4702657660563 | epot = -21.121182921383 | etot = -16.1812910093629 +853000 ekin = 2.39950550338299 | erot = 2.98750142132015 | epot = -21.0612995182632 | etot = -15.67429259356 +854000 ekin = 2.33465924490093 | erot = 2.85274307519464 | epot = -20.968723969517 | etot = -15.7813216494214 +855000 ekin = 2.34227388182979 | erot = 2.06894784165371 | epot = -20.9841257021182 | etot = -16.5729039786347 +856000 ekin = 2.50117711580693 | erot = 2.74791206324422 | epot = -20.8738269143244 | etot = -15.6247377352733 +857000 ekin = 2.54090672086302 | erot = 3.01990349760065 | epot = -20.7453092144205 | etot = -15.1844989959569 +858000 ekin = 3.06946696795817 | erot = 2.15496603972173 | epot = -20.6851307548641 | etot = -15.4606977471842 +859000 ekin = 2.8502330341827 | erot = 2.24419946408453 | epot = -20.6787263175177 | etot = -15.5842938192505 +860000 ekin = 2.81341243833324 | erot = 1.5197461937082 | epot = -20.6783502445099 | etot = -16.3451916124685 +861000 ekin = 2.27419936469317 | erot = 2.84736568193217 | epot = -20.6476685348769 | etot = -15.5261034882516 +862000 ekin = 2.99814535919906 | erot = 1.87200304458178 | epot = -20.6714218686896 | etot = -15.8012734649088 +863000 ekin = 2.82320132781549 | erot = 1.77959785908837 | epot = -20.7642045825074 | etot = -16.1614053956036 +864000 ekin = 2.91892607599648 | erot = 2.64325528924267 | epot = -20.9317153856013 | etot = -15.3695340203621 +865000 ekin = 3.32989545880503 | erot = 2.25510784979563 | epot = -21.0557741374338 | etot = -15.4707708288331 +866000 ekin = 2.85710406140164 | erot = 3.16185395635697 | epot = -21.1425088224093 | etot = -15.1235508046507 +867000 ekin = 2.74742982523498 | erot = 3.06773761977147 | epot = -21.134531707449 | etot = -15.3193642624426 +868000 ekin = 2.1948650568198 | erot = 2.22458860510737 | epot = -21.0697126630058 | etot = -16.6502590010787 +869000 ekin = 2.92239964068215 | erot = 2.50065925324415 | epot = -21.0149378764857 | etot = -15.5918789825594 +870000 ekin = 2.48931117933877 | erot = 2.13038554226924 | epot = -20.9976655364141 | etot = -16.3779688148061 +871000 ekin = 2.19107246828585 | erot = 2.37839051284131 | epot = -20.8765191273408 | etot = -16.3070561462136 +872000 ekin = 1.55081886521514 | erot = 2.09762459684259 | epot = -20.8521940121747 | etot = -17.2037505501169 +873000 ekin = 1.3896067615701 | erot = 2.27757856660909 | epot = -20.9255865429236 | etot = -17.2584012147444 +874000 ekin = 1.41282979514325 | erot = 2.76881886831623 | epot = -21.0901483490343 | etot = -16.9084996855748 +875000 ekin = 1.18979270807644 | erot = 2.71872907877545 | epot = -21.2270266717576 | etot = -17.3185048849058 +876000 ekin = 1.81100671707876 | erot = 2.98963277694409 | epot = -21.2472610575188 | etot = -16.4466215634959 +877000 ekin = 2.36243541111364 | erot = 2.03609143795483 | epot = -21.3277863705839 | etot = -16.9292595215154 +878000 ekin = 2.1245196182468 | erot = 1.75451707226955 | epot = -21.3222506595257 | etot = -17.4432139690093 +879000 ekin = 2.2716997631568 | erot = 2.70191568133046 | epot = -21.3119311913778 | etot = -16.3383157468906 +880000 ekin = 2.68326313012635 | erot = 2.77340532358103 | epot = -21.3535728447366 | etot = -15.8969043910292 +881000 ekin = 2.87483307600208 | erot = 2.33652901733377 | epot = -21.3292700652532 | etot = -16.1179079719173 +882000 ekin = 2.32758906799515 | erot = 2.16795489269516 | epot = -21.2584233833351 | etot = -16.7628794226448 +883000 ekin = 2.35908631800798 | erot = 1.97904048991531 | epot = -21.0655746410777 | etot = -16.7274478331544 +884000 ekin = 2.52269362644082 | erot = 2.25025361307445 | epot = -20.9641879640375 | etot = -16.1912407245222 +885000 ekin = 2.8471189843883 | erot = 2.26506458535077 | epot = -20.9641383727441 | etot = -15.8519548030051 +886000 ekin = 3.18322288605135 | erot = 1.73470875511279 | epot = -21.0012427194847 | etot = -16.0833110783206 +887000 ekin = 2.68813414464725 | erot = 2.50204216522368 | epot = -21.067976555709 | etot = -15.8778002458381 +888000 ekin = 2.15187544250473 | erot = 2.83221089603913 | epot = -21.17639007923 | etot = -16.1923037406862 +889000 ekin = 2.16956995574787 | erot = 2.20198656261183 | epot = -21.1017572530618 | etot = -16.7302007347021 +890000 ekin = 1.78556825977743 | erot = 2.98410700070926 | epot = -21.186208638226 | etot = -16.4165333777393 +891000 ekin = 1.64917016933854 | erot = 2.27750403923458 | epot = -21.3189640243096 | etot = -17.3922898157365 +892000 ekin = 1.96583947510742 | erot = 2.36271973263346 | epot = -21.4596361006042 | etot = -17.1310768928633 +893000 ekin = 1.79314340564254 | erot = 1.8411107489992 | epot = -21.5470179462123 | etot = -17.9127637915705 +894000 ekin = 2.81442382935654 | erot = 2.80759818283316 | epot = -21.6538835081476 | etot = -16.0318614959579 +895000 ekin = 2.0070369904664 | erot = 2.75374249882318 | epot = -21.7499760057857 | etot = -16.9891965164961 +896000 ekin = 1.6507008342202 | erot = 2.56296228195539 | epot = -21.8927812332095 | etot = -17.6791181170339 +897000 ekin = 1.78139405234358 | erot = 2.35356223356246 | epot = -22.0286409132692 | etot = -17.8936846273632 +898000 ekin = 1.85207490030026 | erot = 2.3928555728648 | epot = -22.0495390022753 | etot = -17.8046085291102 +899000 ekin = 1.66216066819287 | erot = 3.04222938639382 | epot = -21.9579747350567 | etot = -17.25358468047 +900000 ekin = 2.15165827067079 | erot = 2.62356927804175 | epot = -21.9156104880732 | etot = -17.1403829393607 +901000 ekin = 2.41248642142908 | erot = 2.69714418093217 | epot = -21.9837417963999 | etot = -16.8741111940386 +902000 ekin = 2.57545214239909 | erot = 2.40635843208183 | epot = -21.996436412966 | etot = -17.0146258384851 +903000 ekin = 2.40335601179059 | erot = 2.4057541752901 | epot = -22.0230111828253 | etot = -17.2139009957446 +904000 ekin = 1.99365997109403 | erot = 3.12264199705152 | epot = -22.0954468558152 | etot = -16.9791448876697 +905000 ekin = 2.45160047861299 | erot = 2.11889478277434 | epot = -22.0620083174753 | etot = -17.4915130560879 +906000 ekin = 2.69446662881178 | erot = 1.66991631401456 | epot = -22.0555442490735 | etot = -17.6911613062471 +907000 ekin = 2.5734498863711 | erot = 2.16877319112329 | epot = -22.0376984236082 | etot = -17.2954753461138 +908000 ekin = 2.9646776076989 | erot = 2.40252252045294 | epot = -22.0191047803794 | etot = -16.6519046522276 +909000 ekin = 3.12793409264582 | erot = 2.12009742665766 | epot = -22.0610667288554 | etot = -16.8130352095519 +910000 ekin = 2.92206025021313 | erot = 3.50302372345592 | epot = -22.1277774480557 | etot = -15.7026934743867 +911000 ekin = 1.85381948048669 | erot = 2.73401011795404 | epot = -22.1683975531304 | etot = -17.5805679546896 +912000 ekin = 2.64405242900445 | erot = 1.86324838607163 | epot = -22.2002570143971 | etot = -17.692956199321 +913000 ekin = 2.46824283660223 | erot = 2.0308633546605 | epot = -22.3203806242275 | etot = -17.8212744329647 +914000 ekin = 2.01871966356282 | erot = 2.94283156821207 | epot = -22.3513452914152 | etot = -17.3897940596404 +915000 ekin = 2.82676643872102 | erot = 2.11643553756712 | epot = -22.3640471312087 | etot = -17.4208451549205 +916000 ekin = 2.54227707175729 | erot = 3.23335822897873 | epot = -22.4652663102875 | etot = -16.6896310095515 +917000 ekin = 2.31676859881433 | erot = 2.2427200582576 | epot = -22.463585281336 | etot = -17.9040966242641 +918000 ekin = 2.08681780124233 | erot = 2.05685815910104 | epot = -22.3748058531193 | etot = -18.231129892776 +919000 ekin = 2.60282015977208 | erot = 2.38968293687319 | epot = -22.3822670579485 | etot = -17.3897639613032 +920000 ekin = 3.21847224306531 | erot = 2.75010700480466 | epot = -22.4646189595793 | etot = -16.4960397117093 +921000 ekin = 2.67829101318104 | erot = 1.98386933580364 | epot = -22.5250186592845 | etot = -17.8628583102998 +922000 ekin = 1.43283799739773 | erot = 1.5210967069851 | epot = -22.5925015236451 | etot = -19.6385668192623 +923000 ekin = 1.69052063428542 | erot = 1.88300391650268 | epot = -22.66377714455 | etot = -19.0902525937619 +924000 ekin = 2.14340021014736 | erot = 1.52248843908134 | epot = -22.6402388027506 | etot = -18.9743501535219 +925000 ekin = 2.26091939109784 | erot = 1.33050454776921 | epot = -22.5227280014394 | etot = -18.9313040625724 +926000 ekin = 2.00930540350536 | erot = 2.07372939007629 | epot = -22.4428200376094 | etot = -18.3597852440277 +927000 ekin = 2.53289082621251 | erot = 1.99783542507574 | epot = -22.5727269691716 | etot = -18.0420007178833 +928000 ekin = 2.57275295957812 | erot = 2.50503787417693 | epot = -22.7397714760282 | etot = -17.6619806422732 +929000 ekin = 2.66131598383108 | erot = 1.82871097568713 | epot = -22.7889092091996 | etot = -18.2988822496814 +930000 ekin = 2.41369096322635 | erot = 2.00598415451171 | epot = -22.802343205586 | etot = -18.3826680878479 +931000 ekin = 3.02636364754007 | erot = 2.115962250161 | epot = -22.7562575819635 | etot = -17.6139316842625 +932000 ekin = 2.34573343934799 | erot = 1.88269819474441 | epot = -22.8028018252265 | etot = -18.5743701911341 +933000 ekin = 2.16951834533283 | erot = 2.85677231086964 | epot = -22.8240172791919 | etot = -17.7977266229894 +934000 ekin = 2.17177152489559 | erot = 2.1194660688678 | epot = -22.8652321779361 | etot = -18.5739945841727 +935000 ekin = 2.34485090948927 | erot = 2.23417606918545 | epot = -22.85888707632 | etot = -18.2798600976452 +936000 ekin = 2.28188124919415 | erot = 2.53015822921572 | epot = -22.9782518612072 | etot = -18.1662123827973 +937000 ekin = 2.3061925494295 | erot = 2.82857457174385 | epot = -23.071665648819 | etot = -17.9368985276457 +938000 ekin = 2.44229226509271 | erot = 2.00737414808353 | epot = -23.1363676072136 | etot = -18.6867011940373 +939000 ekin = 2.97744015155649 | erot = 2.1021287084213 | epot = -23.1206613400026 | etot = -18.0410924800248 +940000 ekin = 3.74219661265262 | erot = 2.68184060115531 | epot = -23.0494489680042 | etot = -16.6254117541962 +941000 ekin = 3.1130700754106 | erot = 2.2870034463699 | epot = -22.9451834918749 | etot = -17.5451099700944 +942000 ekin = 3.46654816859628 | erot = 1.87509182259239 | epot = -22.9048558084884 | etot = -17.5632158172997 +943000 ekin = 3.79224818385641 | erot = 2.70927084823339 | epot = -22.8698482349086 | etot = -16.3683292028188 +944000 ekin = 2.65995525590795 | erot = 2.74912726816423 | epot = -22.8317889960132 | etot = -17.422706471941 +945000 ekin = 2.54659137616624 | erot = 2.02239421261018 | epot = -22.725938832337 | etot = -18.1569532435606 +946000 ekin = 2.46388617435412 | erot = 1.67037983156324 | epot = -22.5545307163887 | etot = -18.4202647104713 +947000 ekin = 2.40803821488282 | erot = 1.99424876436282 | epot = -22.4581247656853 | etot = -18.0558377864397 +948000 ekin = 3.53604042034895 | erot = 2.57997877434838 | epot = -22.3226574127033 | etot = -16.206638218006 +949000 ekin = 2.98854271807069 | erot = 2.434764866082 | epot = -22.1081978358246 | etot = -16.6848902516719 +950000 ekin = 1.85098760333696 | erot = 3.0113849918017 | epot = -21.9481390655564 | etot = -17.0857664704178 +951000 ekin = 2.24140231384639 | erot = 2.36101456496684 | epot = -21.9054305662226 | etot = -17.3030136874094 +952000 ekin = 2.1767459614223 | erot = 1.66164476273624 | epot = -21.8857446244283 | etot = -18.0473539002697 +953000 ekin = 2.32434436644844 | erot = 1.96780923551529 | epot = -21.864089307184 | etot = -17.5719357052203 +954000 ekin = 1.49071594272054 | erot = 3.34931219540537 | epot = -21.7966718941878 | etot = -16.9566437560618 +955000 ekin = 1.88457697665867 | erot = 2.69006961792184 | epot = -21.7221575712775 | etot = -17.147510976697 +956000 ekin = 1.69307087749046 | erot = 2.16469646035311 | epot = -21.6721199805376 | etot = -17.814352642694 +957000 ekin = 1.73487330688787 | erot = 1.64307450157792 | epot = -21.6559256952543 | etot = -18.2779778867885 +958000 ekin = 1.60385894866933 | erot = 2.19168737006627 | epot = -21.6476897105175 | etot = -17.8521433917819 +959000 ekin = 2.59262245343361 | erot = 2.48219361032086 | epot = -21.6596277279706 | etot = -16.5848116642161 +960000 ekin = 2.55386671368679 | erot = 2.05771846301768 | epot = -21.6626200672138 | etot = -17.0510348905093 +961000 ekin = 2.27765806186204 | erot = 2.17958354193562 | epot = -21.6544957188758 | etot = -17.1972541150782 +962000 ekin = 1.66004639932187 | erot = 3.51004740828816 | epot = -21.6650529510449 | etot = -16.4949591434349 +963000 ekin = 1.98935936955203 | erot = 1.50490949194663 | epot = -21.6088711497269 | etot = -18.1146022882282 +964000 ekin = 2.17983717879189 | erot = 2.29031074234418 | epot = -21.5586262428098 | etot = -17.0884783216737 +965000 ekin = 2.10787439045543 | erot = 2.3221077885109 | epot = -21.5497920382512 | etot = -17.1198098592849 +966000 ekin = 3.1408040905672 | erot = 3.41823133718854 | epot = -21.5836404263088 | etot = -15.024604998553 +967000 ekin = 3.0568623124503 | erot = 2.1733206632131 | epot = -21.5260931467358 | etot = -16.2959101710724 +968000 ekin = 2.05064192877792 | erot = 2.14124924922397 | epot = -21.4479972163209 | etot = -17.256106038319 +969000 ekin = 2.21517858837652 | erot = 2.21735686304378 | epot = -21.3822587820383 | etot = -16.949723330618 +970000 ekin = 2.44665062708039 | erot = 2.63919176763313 | epot = -21.3192840477868 | etot = -16.2334416530733 +971000 ekin = 2.47241679333997 | erot = 2.68621090896417 | epot = -21.3036698600044 | etot = -16.1450421577003 +972000 ekin = 3.18976408247808 | erot = 2.45901954667695 | epot = -21.2523934460448 | etot = -15.6036098168898 +973000 ekin = 3.35475115149161 | erot = 2.61012752320778 | epot = -21.183068859057 | etot = -15.2181901843576 +974000 ekin = 2.71127807449815 | erot = 2.12974355852032 | epot = -21.0816906098712 | etot = -16.2406689768528 +975000 ekin = 1.81295894463494 | erot = 2.0759564976921 | epot = -20.9964165264669 | etot = -17.1075010841398 +976000 ekin = 2.37619926790761 | erot = 1.37981441384236 | epot = -20.8930101654836 | etot = -17.1369964837336 +977000 ekin = 2.85555210767404 | erot = 3.03619369635208 | epot = -21.0095574945917 | etot = -15.1178116905656 +978000 ekin = 3.13849116757388 | erot = 3.01118356119965 | epot = -21.0732326779663 | etot = -14.9235579491928 +979000 ekin = 3.64170438280054 | erot = 2.4612126795782 | epot = -20.9593695826044 | etot = -14.8564525202257 +980000 ekin = 3.43680535726821 | erot = 3.27333588575053 | epot = -20.9004670674903 | etot = -14.1903258244715 +981000 ekin = 2.95806185202903 | erot = 2.46811293942083 | epot = -20.9868038459701 | etot = -15.5606290545202 +982000 ekin = 2.05823037945997 | erot = 2.23573651589999 | epot = -21.0420814071854 | etot = -16.7481145118254 +983000 ekin = 2.5553610304344 | erot = 1.97272050888114 | epot = -21.0434200461188 | etot = -16.5153385068032 +984000 ekin = 2.32140326985734 | erot = 2.58284655378618 | epot = -21.0826601835729 | etot = -16.1784103599294 +985000 ekin = 2.30327577152247 | erot = 3.01569210622987 | epot = -21.1731422974947 | etot = -15.8541744197424 +986000 ekin = 2.0247579133688 | erot = 2.17885674714069 | epot = -21.2745593334952 | etot = -17.0709446729857 +987000 ekin = 2.38610984160001 | erot = 1.60437579739602 | epot = -21.2569575649582 | etot = -17.2664719259622 +988000 ekin = 2.73926231299059 | erot = 2.71146350841208 | epot = -21.1552791211025 | etot = -15.7045532996999 +989000 ekin = 2.26697151561908 | erot = 2.87750604798637 | epot = -21.0937789068058 | etot = -15.9493013432004 +990000 ekin = 2.20943106152859 | erot = 2.59684886899357 | epot = -21.0203331776818 | etot = -16.2140532471596 +991000 ekin = 2.18249266283082 | erot = 2.54649657411172 | epot = -20.9130337682104 | etot = -16.1840445312679 +992000 ekin = 1.6979885228163 | erot = 2.49592807829765 | epot = -20.97584958751 | etot = -16.781932986396 +993000 ekin = 1.37413745875443 | erot = 1.97736806672932 | epot = -21.0653195519547 | etot = -17.713814026471 +994000 ekin = 1.46489942286098 | erot = 2.9578292103502 | epot = -21.126186746174 | etot = -16.7034581129629 +995000 ekin = 2.313206084368 | erot = 1.68064795849453 | epot = -21.1907262676309 | etot = -17.1968722247684 +996000 ekin = 2.91635623044139 | erot = 2.86817278212845 | epot = -21.1749728841882 | etot = -15.3904438716184 +997000 ekin = 3.14117227050211 | erot = 2.13892951607983 | epot = -21.1714996184258 | etot = -15.8913978318439 +998000 ekin = 2.24297046385175 | erot = 3.02327291553881 | epot = -21.1032039558864 | etot = -15.8369605764958 +999000 ekin = 2.61553981530106 | erot = 1.7387289184571 | epot = -21.0217257279766 | etot = -16.6674569942185 +1000000 ekin = 2.34012577497833 | erot = 2.86436388995813 | epot = -21.0201566044041 | etot = -15.8156669394676 + 1000000 0.10400559 -1.3746133 0.060853481 -1.1675019 0.00013752759 +Loop time of 59.4195 on 4 procs for 1000000 steps with 16 atoms + +Performance: 14540.686 tau/day, 16829.497 timesteps/s +96.3% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.0304 | 20.212 | 37.839 | 369.5 | 34.02 +Bond | 0.12844 | 0.57006 | 0.95643 | 49.6 | 0.96 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 4.3935 | 5.5635 | 6.7052 | 44.2 | 9.36 +Output | 2.3e-05 | 3.575e-05 | 4.1e-05 | 0.0 | 0.00 +Modify | 0.3513 | 3.4695 | 6.4366 | 144.3 | 5.84 +Other | | 29.6 | | | 49.82 + +Nlocal: 4 ave 8 max 0 min +Histogram: 1 1 0 0 0 0 0 0 1 1 +Nghost: 11 ave 14 max 8 min +Histogram: 1 1 0 0 0 0 0 0 1 1 +Neighs: 46 ave 89 max 0 min +Histogram: 1 1 0 0 0 0 0 0 0 2 + +Total # of neighbors = 184 +Ave neighs/atom = 11.5 +Ave special neighs/atom = 3.75 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:59 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.1 b/examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.1 deleted file mode 100644 index ba36d696fb..0000000000 --- a/examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.1 +++ /dev/null @@ -1,178 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 2 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex2 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 16 atoms - reading velocities ... - 16 velocities - 16 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 13 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 4 = max # of 1-4 neighbors - 6 = max # of special neighbors - -set atom * mass 3.1575 - 16 settings made for mass - -group all type 1 4 -16 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna2/fene -bond_coeff * 2.0 0.25 0.7564 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh -pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna2/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 -pair_coeff * * oxdna2/dh 0.1 1.0 0.815 - -# NVE ensemble -#fix 1 all nve/dot -fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.6274 - ghost atom cutoff = 2.6274 - binsize = 1.3137, bins = 31 31 31 - 6 neighbor lists, perpetual/occasional/extra = 6 0 0 - (1) pair oxdna2/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna2/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna2/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna2/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna2/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (6) pair oxdna2/dh, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 3.025 | 3.025 | 3.025 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.5358787 0.0096742456 -1.5262045 -7.9568629e-05 -1000 ekin = 1.54282272464468 | erot = 1.71757897250772 | epot = -24.4403527731341 | etot = -21.1799510759817 -2000 ekin = 1.86109566690716 | erot = 1.93804145796026 | epot = -24.3759816748265 | etot = -20.5768445499591 -3000 ekin = 2.68769182431188 | erot = 2.14559269500086 | epot = -24.2916556822451 | etot = -19.4583711629324 -4000 ekin = 2.04710303757243 | erot = 1.48774072590987 | epot = -24.190371461807 | etot = -20.6555276983247 -5000 ekin = 1.77654023802719 | erot = 2.534186505221 | epot = -24.1246365663843 | etot = -19.8139098231361 -6000 ekin = 3.12253137872527 | erot = 2.04028266818831 | epot = -24.0491248750916 | etot = -18.886310828178 -7000 ekin = 3.22418765752177 | erot = 2.72037570174023 | epot = -23.9458569915548 | etot = -18.0012936322928 -8000 ekin = 2.83204202112963 | erot = 2.67060276413777 | epot = -23.9211291529766 | etot = -18.4184843677092 -9000 ekin = 2.69585642754481 | erot = 2.59559820250212 | epot = -23.8340823338302 | etot = -18.5426277037833 -10000 ekin = 2.66058119525512 | erot = 1.95965933336077 | epot = -23.7132443170725 | etot = -19.0930037884566 - 10000 0.11824805 -1.4953627 0.013284973 -1.3157914 -0.00012999454 -Loop time of 0.32781 on 1 procs for 10000 steps with 16 atoms - -Performance: 26356.746 tau/day, 30505.493 timesteps/s -99.9% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.24211 | 0.24211 | 0.24211 | 0.0 | 73.86 -Bond | 0.0075173 | 0.0075173 | 0.0075173 | 0.0 | 2.29 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0014515 | 0.0014515 | 0.0014515 | 0.0 | 0.44 -Output | 5.4836e-06 | 5.4836e-06 | 5.4836e-06 | 0.0 | 0.00 -Modify | 0.073331 | 0.073331 | 0.073331 | 0.0 | 22.37 -Other | | 0.003398 | | | 1.04 - -Nlocal: 16 ave 16 max 16 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 116 ave 116 max 116 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 116 -Ave neighs/atom = 7.25 -Ave special neighs/atom = 3.75 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.4 b/examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.4 deleted file mode 100644 index 3237d4849e..0000000000 --- a/examples/USER/cgdna/examples/oxDNA2/duplex2/log.27Nov18.duplex2.g++.4 +++ /dev/null @@ -1,178 +0,0 @@ -LAMMPS (27 Nov 2018) - using 1 OpenMP thread(s) per MPI task -variable number equal 2 -variable ofreq equal 1000 -variable efreq equal 1000 - -units lj - -dimension 3 - -newton off - -boundary p p p - -atom_style hybrid bond ellipsoid -atom_modify sort 0 1.0 - -# Pair interactions require lists of neighbours to be calculated -neighbor 1.0 bin -neigh_modify every 1 delay 0 check yes - -read_data data.duplex2 - orthogonal box = (-20 -20 -20) to (20 20 20) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 16 atoms - reading velocities ... - 16 velocities - 16 ellipsoids - scanning bonds ... - 2 = max bonds/atom - reading bonds ... - 13 bonds - 2 = max # of 1-2 neighbors - 2 = max # of 1-3 neighbors - 4 = max # of 1-4 neighbors - 6 = max # of special neighbors - -set atom * mass 3.1575 - 16 settings made for mass - -group all type 1 4 -16 atoms in group all - -# oxDNA bond interactions - FENE backbone -bond_style oxdna2/fene -bond_coeff * 2.0 0.25 0.7564 - -# oxDNA pair interactions -pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh -pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 -pair_coeff * * oxdna2/stk seqav 0.1 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 -pair_coeff * * oxdna2/hbond seqav 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 1 4 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff 2 3 oxdna2/hbond seqav 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 -pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 -pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 -pair_coeff * * oxdna2/dh 0.1 1.0 0.815 - -# NVE ensemble -#fix 1 all nve/dot -fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 -#fix 1 all nve/asphere -#fix 2 all langevin 0.1 0.1 0.03 457145 angmom 10 - -timestep 1e-5 - -#comm_style tiled -#fix 3 all balance 10000 1.1 rcb - -#compute mol all chunk/atom molecule -#compute mychunk all vcm/chunk mol -#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector - -#dump pos all xyz ${ofreq} traj.${number}.xyz - -#compute quat all property/atom quatw quati quatj quatk -#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] -#dump_modify quat sort id -#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" - -compute erot all erotate/asphere -compute ekin all ke -compute epot all pe -variable erot equal c_erot -variable ekin equal c_ekin -variable epot equal c_epot -variable etot equal c_erot+c_ekin+c_epot -fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes -fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes - -#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz -#dump_modify out sort id -#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" - -run 10000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.6274 - ghost atom cutoff = 2.6274 - binsize = 1.3137, bins = 31 31 31 - 6 neighbor lists, perpetual/occasional/extra = 6 0 0 - (1) pair oxdna2/excv, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard - (2) pair oxdna2/stk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (3) pair oxdna2/hbond, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (4) pair oxdna2/xstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (5) pair oxdna2/coaxstk, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none - (6) pair oxdna2/dh, perpetual, copy from (1) - attributes: half, newton off - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 7.777 | 7.959 | 8.142 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -1.5358787 0.0096742456 -1.5262045 -7.9568629e-05 -1000 ekin = 1.34554291364716 | erot = 2.30525041754444 | epot = -24.3924150888896 | etot = -20.741621757698 -2000 ekin = 2.15972469811184 | erot = 2.1628675965276 | epot = -24.3548203354875 | etot = -20.0322280408481 -3000 ekin = 3.26433550542939 | erot = 2.76107866472085 | epot = -24.2947953202752 | etot = -18.269381150125 -4000 ekin = 1.9203212531997 | erot = 2.13339438425299 | epot = -24.234098584123 | etot = -20.1803829466703 -5000 ekin = 1.35481075814721 | erot = 2.00854026688447 | epot = -24.1768963201279 | etot = -20.8135452950963 -6000 ekin = 2.18974627635306 | erot = 1.73271671162435 | epot = -24.1096616118305 | etot = -20.1871986238531 -7000 ekin = 2.65472853187395 | erot = 1.73258720631296 | epot = -24.0561118130561 | etot = -19.6687960748691 -8000 ekin = 2.51192327964357 | erot = 2.34132844779952 | epot = -23.9708695663488 | etot = -19.1176178389058 -9000 ekin = 2.24554900802464 | erot = 2.0522939078286 | epot = -23.874757758319 | etot = -19.5769148424658 -10000 ekin = 2.36227360512089 | erot = 1.80185994066737 | epot = -23.7793375260418 | etot = -19.6152039802535 - 10000 0.10498994 -1.5020657 0.015857071 -1.3385665 -8.8930899e-05 -Loop time of 0.291642 on 4 procs for 10000 steps with 16 atoms - -Performance: 29625.313 tau/day, 34288.557 timesteps/s -96.6% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.0035026 | 0.1107 | 0.20674 | 28.3 | 37.96 -Bond | 0.00062203 | 0.0029532 | 0.0049176 | 3.6 | 1.01 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.016712 | 0.018041 | 0.01914 | 0.7 | 6.19 -Output | 5.0306e-05 | 5.424e-05 | 5.579e-05 | 0.0 | 0.02 -Modify | 0.0013862 | 0.020914 | 0.039594 | 11.7 | 7.17 -Other | | 0.139 | | | 47.65 - -Nlocal: 4 ave 8 max 0 min -Histogram: 1 1 0 0 0 0 0 0 1 1 -Nghost: 11 ave 14 max 8 min -Histogram: 1 1 0 0 0 0 0 0 1 1 -Neighs: 46 ave 89 max 0 min -Histogram: 1 1 0 0 0 0 0 0 0 2 - -Total # of neighbors = 184 -Ave neighs/atom = 11.5 -Ave special neighs/atom = 3.75 -Neighbor list builds = 0 -Dangerous builds = 0 - -#write_restart config.${number}.* -Total wall time: 0:00:00 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex3/data.duplex3 b/examples/USER/cgdna/examples/oxDNA2/duplex3/data.duplex3 new file mode 100644 index 0000000000..bbd584163b --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex3/data.duplex3 @@ -0,0 +1,73 @@ +# LAMMPS data file +10 atoms +10 ellipsoids +8 bonds + +4 atom types +1 bond types + +# System size +-20.000000 20.000000 xlo xhi +-20.000000 20.000000 ylo yhi +-20.000000 20.000000 zlo zhi + +Masses + +1 1.0 +2 1.0 +3 1.0 +4 1.0 + +# Atom-ID, type, position, molecule-ID, ellipsoid flag, density +Atoms + +1 1 -6.000000000000001e-01 0.000000000000000e+00 0.000000000000000e+00 1 1 1 +2 2 -4.860249842674776e-01 -3.518234140414736e-01 3.897628551303122e-01 1 1 1 +3 3 -1.874009511073395e-01 -5.699832309147915e-01 7.795257102606244e-01 1 1 1 +4 4 1.824198365552941e-01 -5.715968887521518e-01 1.169288565390937e+00 1 1 1 +5 1 4.829362784135484e-01 -3.560513319622209e-01 1.559051420521249e+00 1 1 1 +6 4 -4.829362784135484e-01 3.560513319622209e-01 1.559051420521249e+00 2 1 1 +7 1 -1.824198365552941e-01 5.715968887521516e-01 1.169288565390937e+00 2 1 1 +8 2 1.874009511073395e-01 5.699832309147913e-01 7.795257102606243e-01 2 1 1 +9 3 4.860249842674775e-01 3.518234140414733e-01 3.897628551303121e-01 2 1 1 +10 4 5.999999999999996e-01 -1.332267629550188e-16 -1.110223024625157e-16 2 1 1 + +# Atom-ID, translational velocity, angular momentum +Velocities + +1 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +2 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +3 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +4 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +5 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +6 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +7 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +8 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +9 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +10 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 + +# Atom-ID, shape, quaternion +Ellipsoids + +1 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 1.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +2 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 9.513258223252946e-01 0.000000000000000e+00 0.000000000000000e+00 3.081869234362515e-01 +3 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 8.100416404457962e-01 0.000000000000000e+00 0.000000000000000e+00 5.863723567357894e-01 +4 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 5.899012371043606e-01 0.000000000000000e+00 0.000000000000000e+00 8.074754054847398e-01 +5 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 3.123349185122326e-01 0.000000000000000e+00 0.000000000000000e+00 9.499720515246527e-01 +6 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 0.000000000000000e+00 9.499720515246527e-01 -3.123349185122326e-01 -0.000000000000000e+00 +7 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 0.000000000000000e+00 8.074754054847401e-01 -5.899012371043604e-01 0.000000000000000e+00 +8 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 0.000000000000000e+00 5.863723567357896e-01 -8.100416404457959e-01 0.000000000000000e+00 +9 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 -0.000000000000000e+00 -3.081869234362514e-01 9.513258223252947e-01 0.000000000000000e+00 +10 3.1622776601683795+00 3.1622776601683795+00 3.1622776601683795+00 -0.000000000000000e+00 1.110223024625157e-16 1.000000000000000e+00 -0.000000000000000e+00 + +# Bond topology +Bonds + +1 1 1 2 +2 1 2 3 +3 1 3 4 +4 1 4 5 +5 1 6 7 +6 1 7 8 +7 1 8 9 +8 1 9 10 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 b/examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 new file mode 100644 index 0000000000..51d6334f55 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 @@ -0,0 +1,79 @@ +variable number equal 1 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex3 + +set atom * mass 1.0 + +group all type 1 4 + +# oxDNA bond interactions - FENE backbone +bond_style oxdna2/fene +bond_coeff * 2.0 0.25 0.7564 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh +pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna2/stk seqdep ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/hbond seqdep 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 + +# NVE ensemble +fix 1 all nve/dot +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 + +#write_restart config.${number}.* diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.1 b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.1 new file mode 100644 index 0000000000..6b8b7161d5 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.1 @@ -0,0 +1,1172 @@ +LAMMPS (18 Jun 2019) +variable number equal 1 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex3 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 10 atoms + reading velocities ... + 10 velocities + 10 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 8 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 2 = max # of 1-4 neighbors + 4 = max # of special neighbors + special bonds CPU = 0.000113 secs + read_data CPU = 0.00275 secs + +set atom * mass 1.0 + 10 settings made for mass + +group all type 1 4 +10 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna2/fene +bond_coeff * 2.0 0.25 0.7564 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh +pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna2/stk seqdep ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqdep 0.1 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/hbond seqdep 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 +pair_coeff * * oxdna2/dh 0.1 1.0 0.815 + +# NVE ensemble +fix 1 all nve/dot +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.6274 + ghost atom cutoff = 2.6274 + binsize = 1.3137, bins = 31 31 31 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 3.023 | 3.023 | 3.023 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.4720158 0.009525411 -1.4624904 3.1370518e-06 +1000 ekin = 0.00366431201929618 | erot = 0.00193726360267488 | epot = -14.630505317301 | etot = -14.624903741679 +2000 ekin = 0.0144775076075466 | erot = 0.00770914672938582 | epot = -14.6470903960565 | etot = -14.6249037417196 +3000 ekin = 0.0319122186081549 | erot = 0.0171972328649101 | epot = -14.6740131932573 | etot = -14.6249037417842 +4000 ekin = 0.0551283043509704 | erot = 0.0302085305548002 | epot = -14.7102405767754 | etot = -14.6249037418696 +5000 ekin = 0.0830285165715823 | erot = 0.0464820547541705 | epot = -14.7544143132963 | etot = -14.6249037419705 +6000 ekin = 0.114331121546757 | erot = 0.0656980211282096 | epot = -14.8049328847556 | etot = -14.6249037420806 +7000 ekin = 0.147653866561892 | erot = 0.0874894888755386 | epot = -14.860047097631 | etot = -14.6249037421936 +8000 ekin = 0.181602099560207 | erot = 0.111456095727703 | epot = -14.9179619375911 | etot = -14.6249037423032 +9000 ekin = 0.214852894725919 | erot = 0.137179311245174 | epot = -14.9769359483746 | etot = -14.6249037424035 +10000 ekin = 0.246227151956033 | erot = 0.164238435218395 | epot = -15.0353693296648 | etot = -14.6249037424904 +11000 ekin = 0.274743080419051 | erot = 0.192226420003239 | epot = -15.0918732429829 | etot = -14.6249037425607 +12000 ekin = 0.2996471417657 | erot = 0.220764512146651 | epot = -15.1453153965252 | etot = -14.6249037426128 +13000 ekin = 0.320421918860966 | erot = 0.249514690530541 | epot = -15.1948403520385 | etot = -14.624903742647 +14000 ekin = 0.33677373488436 | erot = 0.27818893373049 | epot = -15.2398664112793 | etot = -14.6249037426645 +15000 ekin = 0.348605413762901 | erot = 0.306554508009418 | epot = -15.2800636644399 | etot = -14.6249037426675 +16000 ekin = 0.355980829097854 | erot = 0.334434770083744 | epot = -15.3153193418402 | etot = -14.6249037426586 +17000 ekin = 0.35908770105941 | erot = 0.361705441666512 | epot = -15.3456968853664 | etot = -14.6249037426405 +18000 ekin = 0.358203710992239 | erot = 0.388286889516313 | epot = -15.3713943431242 | etot = -14.6249037426156 +19000 ekin = 0.353668912555234 | erot = 0.414133518537107 | epot = -15.3927061736788 | etot = -14.6249037425864 +20000 ekin = 0.345865220775291 | erot = 0.439221805285432 | epot = -15.4099907686153 | etot = -14.6249037425546 +21000 ekin = 0.335201981146472 | erot = 0.463538642606515 | epot = -15.4236443662748 | etot = -14.6249037425218 +22000 ekin = 0.322105588834903 | erot = 0.487071492273063 | epot = -15.4340808235971 | etot = -14.6249037424892 +23000 ekin = 0.307010918596165 | erot = 0.509801406229371 | epot = -15.4417160672832 | etot = -14.6249037424577 +24000 ekin = 0.290352786033169 | erot = 0.531699400501692 | epot = -15.446955928963 | etot = -14.6249037424281 +25000 ekin = 0.272556500902037 | erot = 0.552726088759198 | epot = -15.4501863320622 | etot = -14.624903742401 +26000 ekin = 0.254027484079049 | erot = 0.572834017299018 | epot = -15.4517652437547 | etot = -14.6249037423766 +27000 ekin = 0.23514066521633 | erot = 0.591971851501221 | epot = -15.4520162590729 | etot = -14.6249037423553 +28000 ekin = 0.216230835846198 | erot = 0.610089455964333 | epot = -15.4512240341478 | etot = -14.6249037423373 +29000 ekin = 0.197585285158555 | erot = 0.627142960082633 | epot = -15.4496319875635 | etot = -14.6249037423223 +30000 ekin = 0.179439940173318 | erot = 0.643099062793407 | epot = -15.4474427452769 | etot = -14.6249037423102 +31000 ekin = 0.161979935826124 | erot = 0.657938056392308 | epot = -15.4448217345186 | etot = -14.6249037423001 +32000 ekin = 0.145345108983022 | erot = 0.671655297433962 | epot = -15.4419041487086 | etot = -14.6249037422916 +33000 ekin = 0.12964040034519 | erot = 0.684261083518556 | epot = -15.4388052261475 | etot = -14.6249037422838 +34000 ekin = 0.114950474500008 | erot = 0.695779112936504 | epot = -15.4356333297121 | etot = -14.6249037422756 +35000 ekin = 0.10135710346033 | erot = 0.706243888527894 | epot = -15.4325047342544 | etot = -14.6249037422662 +36000 ekin = 0.088957633457107 | erot = 0.715697403164625 | epot = -15.4295587788764 | etot = -14.6249037422546 +37000 ekin = 0.0778817390290652 | erot = 0.72418563863568 | epot = -15.4269711199052 | etot = -14.6249037422404 +38000 ekin = 0.068303709154812 | erot = 0.731755309647473 | epot = -15.4249627610255 | etot = -14.6249037422232 +39000 ekin = 0.0604476327394706 | erot = 0.738451228922909 | epot = -15.4238026038659 | etot = -14.6249037422035 +40000 ekin = 0.0545835914676979 | erot = 0.7443145576821 | epot = -15.4238018913318 | etot = -14.624903742182 +41000 ekin = 0.0510142787133839 | erot = 0.749382063190735 | epot = -15.4253000840641 | etot = -14.6249037421599 +42000 ekin = 0.0500531571157636 | erot = 0.753686350478931 | epot = -15.428643249734 | etot = -14.6249037421393 +43000 ekin = 0.0519969858278391 | erot = 0.757256889238991 | epot = -15.4341576171885 | etot = -14.6249037421217 +44000 ekin = 0.0570968352184469 | erot = 0.760121540481399 | epot = -15.4421221178085 | etot = -14.6249037421087 +45000 ekin = 0.065532155346979 | erot = 0.762308219230476 | epot = -15.4527441166789 | etot = -14.6249037421014 +46000 ekin = 0.077391880036746 | erot = 0.763846321567568 | epot = -15.4661419437049 | etot = -14.6249037421006 +47000 ekin = 0.0926650518887463 | erot = 0.764767599959976 | epot = -15.4823363939546 | etot = -14.6249037421059 +48000 ekin = 0.111241466891021 | erot = 0.76510628368957 | epot = -15.5012514926977 | etot = -14.6249037421171 +49000 ekin = 0.132920935183101 | erot = 0.764898395951945 | epot = -15.5227230732685 | etot = -14.6249037421334 +50000 ekin = 0.157428432862297 | erot = 0.764180392178817 | epot = -15.5465125671951 | etot = -14.624903742154 +51000 ekin = 0.184431879186394 | erot = 0.762987403181186 | epot = -15.5723230245453 | etot = -14.6249037421777 +52000 ekin = 0.213559336999611 | erot = 0.761351471408957 | epot = -15.5998145506125 | etot = -14.6249037422039 +53000 ekin = 0.244412677541745 | erot = 0.759300175100897 | epot = -15.6286165948748 | etot = -14.6249037422322 +54000 ekin = 0.276574826726797 | erot = 0.756855909736049 | epot = -15.6583344787255 | etot = -14.6249037422626 +55000 ekin = 0.30960770869724 | erot = 0.754035838659133 | epot = -15.6885472896526 | etot = -14.6249037422962 +56000 ekin = 0.343038597242155 | erot = 0.750852192167397 | epot = -15.7187945317444 | etot = -14.6249037423348 +57000 ekin = 0.376334705011604 | erot = 0.747312289063754 | epot = -15.7485507364561 | etot = -14.6249037423808 +58000 ekin = 0.408870193943412 | erot = 0.743417624903535 | epot = -15.7771915612832 | etot = -14.6249037424363 +59000 ekin = 0.439895666476021 | erot = 0.739161690570186 | epot = -15.803961099549 | etot = -14.6249037425028 +60000 ekin = 0.468524372325726 | erot = 0.734526514748657 | epot = -15.8279546296536 | etot = -14.6249037425792 +61000 ekin = 0.493750804630799 | erot = 0.729479048550173 | epot = -15.8481335958428 | etot = -14.6249037426618 +62000 ekin = 0.514511417905549 | erot = 0.723968952963015 | epot = -15.8633841136119 | etot = -14.6249037427433 +63000 ekin = 0.529785687820656 | erot = 0.717929490923262 | epot = -15.8726189215586 | etot = -14.6249037428146 +64000 ekin = 0.538722043349821 | erot = 0.711282639870032 | epot = -15.874908426086 | etot = -14.6249037428661 +65000 ekin = 0.540763046401741 | erot = 0.703948378732647 | epot = -15.8696151680245 | etot = -14.6249037428901 +66000 ekin = 0.535742115226795 | erot = 0.69585678068686 | epot = -15.856502638796 | etot = -14.6249037428824 +67000 ekin = 0.523930969354056 | erot = 0.686960578434575 | epot = -15.8357952906315 | etot = -14.6249037428429 +68000 ekin = 0.506029704478054 | erot = 0.677245632040232 | epot = -15.8081790792936 | etot = -14.6249037427753 +69000 ekin = 0.483104826199992 | erot = 0.666737270644537 | epot = -15.774745839531 | etot = -14.6249037426865 +70000 ekin = 0.456490218293252 | erot = 0.655501536743317 | epot = -15.7368954976212 | etot = -14.6249037425847 +71000 ekin = 0.427669918862549 | erot = 0.643641521526345 | epot = -15.6962151828672 | etot = -14.6249037424783 +72000 ekin = 0.398160338931557 | erot = 0.631289876691081 | epot = -15.654353957998 | etot = -14.6249037423754 +73000 ekin = 0.369405258276815 | erot = 0.618599034382849 | epot = -15.6129080349415 | etot = -14.6249037422819 +74000 ekin = 0.342691749042209 | erot = 0.605730669564501 | epot = -15.5733261608092 | etot = -14.6249037422025 +75000 ekin = 0.31909052680686 | erot = 0.59284563490598 | epot = -15.5368399038529 | etot = -14.62490374214 +76000 ekin = 0.299420611427412 | erot = 0.580095163563671 | epot = -15.5044195170868 | etot = -14.6249037420957 +77000 ekin = 0.284235504574989 | erot = 0.567613716752661 | epot = -15.4767529633973 | etot = -14.6249037420697 +78000 ekin = 0.273826140866561 | erot = 0.555513536864305 | epot = -15.454243419792 | etot = -14.6249037420611 +79000 ekin = 0.268234635497613 | erot = 0.54388078034572 | epot = -15.4370191579124 | etot = -14.624903742069 +80000 ekin = 0.267272602906451 | erot = 0.532773036269929 | epot = -15.4249493812687 | etot = -14.6249037420923 +81000 ekin = 0.270538934182559 | erot = 0.522218059775773 | epot = -15.4176607360884 | etot = -14.6249037421301 +82000 ekin = 0.277434574359295 | erot = 0.512213638248342 | epot = -15.4145519547894 | etot = -14.6249037421818 +83000 ekin = 0.287175732620333 | erot = 0.50272864056942 | epot = -15.414808115436 | etot = -14.6249037422462 +84000 ekin = 0.298811175848678 | erot = 0.493705451301681 | epot = -15.4174203694717 | etot = -14.6249037423214 +85000 ekin = 0.311252369949697 | erot = 0.485064122067565 | epot = -15.4212202344211 | etot = -14.6249037424038 +86000 ekin = 0.323325626375984 | erot = 0.476708618161036 | epot = -15.424937987025 | etot = -14.624903742488 +87000 ekin = 0.333851795518747 | erot = 0.468535420697862 | epot = -15.4272909587828 | etot = -14.6249037425662 +88000 ekin = 0.341751109758396 | erot = 0.460444399763919 | epot = -15.427099252152 | etot = -14.6249037426296 +89000 ekin = 0.346159825920001 | erot = 0.452351304178873 | epot = -15.4234148727693 | etot = -14.6249037426704 +90000 ekin = 0.346534667470265 | erot = 0.444200535918399 | epot = -15.4156389460718 | etot = -14.6249037426831 +91000 ekin = 0.342715665475867 | erot = 0.435976333753397 | epot = -15.4035957418967 | etot = -14.6249037426674 +92000 ekin = 0.3349227158513 | erot = 0.427710377227648 | epot = -15.3875368357071 | etot = -14.6249037426282 +93000 ekin = 0.323677844433752 | erot = 0.419484336039963 | epot = -15.3680659230484 | etot = -14.6249037425747 +94000 ekin = 0.30966978292125 | erot = 0.411426964072553 | epot = -15.3460004895119 | etot = -14.6249037425181 +95000 ekin = 0.293600014861622 | erot = 0.403706586473099 | epot = -15.3222103438021 | etot = -14.6249037424674 +96000 ekin = 0.276058284884091 | erot = 0.396520701306161 | epot = -15.2974827286175 | etot = -14.6249037424272 +97000 ekin = 0.25746445629565 | erot = 0.390084510982946 | epot = -15.2724527096753 | etot = -14.6249037423967 +98000 ekin = 0.238086767082953 | erot = 0.384619533405539 | epot = -15.2476100428595 | etot = -14.624903742371 +99000 ekin = 0.218116994125883 | erot = 0.380342481668092 | epot = -15.2233632181382 | etot = -14.6249037423442 +100000 ekin = 0.197764845956536 | erot = 0.377453964065333 | epot = -15.2001225523339 | etot = -14.624903742312 +101000 ekin = 0.177333852671335 | erot = 0.376126621697227 | epot = -15.1783642166414 | etot = -14.6249037422728 +102000 ekin = 0.157255732179445 | erot = 0.376493003927733 | epot = -15.1586524783356 | etot = -14.6249037422284 +103000 ekin = 0.138079925448889 | erot = 0.378634329970018 | epot = -15.1416179976015 | etot = -14.6249037421826 +104000 ekin = 0.120430234291316 | erot = 0.382571791335251 | epot = -15.1279057677665 | etot = -14.6249037421399 +105000 ekin = 0.10494672239352 | erot = 0.388261944551333 | epot = -15.118112409049 | etot = -14.6249037421041 +106000 ekin = 0.0922291289493497 | erot = 0.395597086392468 | epot = -15.11272995742 | etot = -14.6249037420782 +107000 ekin = 0.0827918191991084 | erot = 0.404410579138465 | epot = -15.112106140401 | etot = -14.6249037420634 +108000 ekin = 0.0770336430609741 | erot = 0.414486225075992 | epot = -15.116423610197 | etot = -14.62490374206 +109000 ekin = 0.075221312117861 | erot = 0.425570202879186 | epot = -15.1256952570646 | etot = -14.6249037420675 +110000 ekin = 0.0774826364247882 | erot = 0.437383858086522 | epot = -15.1397702365965 | etot = -14.6249037420852 +111000 ekin = 0.0838057148048547 | erot = 0.449635759436015 | epot = -15.1583452163526 | etot = -14.6249037421117 +112000 ekin = 0.0940411317710077 | erot = 0.462031808376879 | epot = -15.1809766822946 | etot = -14.6249037421467 +113000 ekin = 0.107905661684195 | erot = 0.474282718869093 | epot = -15.2070921227426 | etot = -14.6249037421893 +114000 ekin = 0.124987416380568 | erot = 0.486108767327343 | epot = -15.2359999259468 | etot = -14.6249037422389 +115000 ekin = 0.14475347442169 | erot = 0.497242253023055 | epot = -15.2668994697394 | etot = -14.6249037422947 +116000 ekin = 0.166561593123301 | erot = 0.507428522971045 | epot = -15.2988938584499 | etot = -14.6249037423555 +117000 ekin = 0.189677527330859 | erot = 0.516426638198687 | epot = -15.3310079079495 | etot = -14.6249037424199 +118000 ekin = 0.213298790897302 | erot = 0.524010758771369 | epot = -15.3622132921543 | etot = -14.6249037424857 +119000 ekin = 0.23658457696156 | erot = 0.529973112381439 | epot = -15.3914614318934 | etot = -14.6249037425504 +120000 ekin = 0.25869030185824 | erot = 0.534129034925715 | epot = -15.4177230793952 | etot = -14.6249037426113 +121000 ekin = 0.278804196532859 | erot = 0.536324108799716 | epot = -15.4400320479982 | etot = -14.6249037426656 +122000 ekin = 0.296182819519396 | erot = 0.536442962870823 | epot = -15.4575295251008 | etot = -14.6249037427106 +123000 ekin = 0.310182446405815 | erot = 0.534418915104236 | epot = -15.4695051042542 | etot = -14.6249037427442 +124000 ekin = 0.320283972930007 | erot = 0.530243389137678 | epot = -15.4754311048322 | etot = -14.6249037427645 +125000 ekin = 0.326110081462184 | erot = 0.523973945236141 | epot = -15.474987769469 | etot = -14.6249037427707 +126000 ekin = 0.327434709614433 | erot = 0.515739832556637 | epot = -15.4680782849335 | etot = -14.6249037427625 +127000 ekin = 0.324186046690112 | erot = 0.505744172152634 | epot = -15.4548339615826 | etot = -14.6249037427399 +128000 ekin = 0.316445106703942 | erot = 0.49426218578474 | epot = -15.4356110351922 | etot = -14.6249037427035 +129000 ekin = 0.304442167762443 | erot = 0.481635256753056 | epot = -15.4109811671698 | etot = -14.6249037426543 +130000 ekin = 0.288552887156219 | erot = 0.468261006625427 | epot = -15.381717636375 | etot = -14.6249037425933 +131000 ekin = 0.269294696165104 | erot = 0.454579955598623 | epot = -15.3487783942857 | etot = -14.624903742522 +132000 ekin = 0.247322351785515 | erot = 0.44105966132284 | epot = -15.3132857555502 | etot = -14.6249037424419 +133000 ekin = 0.223419723871429 | erot = 0.428177456066543 | epot = -15.276500922293 | etot = -14.6249037423551 +134000 ekin = 0.198483666316777 | erot = 0.416402982921072 | epot = -15.2397903915022 | etot = -14.6249037422644 +135000 ekin = 0.173495806295108 | erot = 0.40618164100245 | epot = -15.2045811894712 | etot = -14.6249037421736 +136000 ekin = 0.149479658252647 | erot = 0.397919790440824 | epot = -15.1723031907806 | etot = -14.6249037420871 +137000 ekin = 0.127443476996608 | erot = 0.391972186713592 | epot = -15.1443194057199 | etot = -14.6249037420097 +138000 ekin = 0.10831297052536 | erot = 0.388631700836367 | epot = -15.1218484133082 | etot = -14.6249037419464 +139000 ekin = 0.0928612988418002 | erot = 0.388121053034821 | epot = -15.1058860937783 | etot = -14.6249037419017 +140000 ekin = 0.0816456573910084 | erot = 0.390586148388801 | epot = -15.0971355476587 | etot = -14.6249037418789 +141000 ekin = 0.0749596349872437 | erot = 0.396090706683564 | epot = -15.0959540835505 | etot = -14.6249037418797 +142000 ekin = 0.0728085537690405 | erot = 0.404612196534891 | epot = -15.1023244922084 | etot = -14.6249037419044 +143000 ekin = 0.0749117535383842 | erot = 0.416039504837645 | epot = -15.1158550003269 | etot = -14.6249037419509 +144000 ekin = 0.0807320498020964 | erot = 0.43017313668478 | epot = -15.1358089285024 | etot = -14.6249037420156 +145000 ekin = 0.08952902558338 | erot = 0.446728893938156 | epot = -15.1611616616151 | etot = -14.6249037420935 +146000 ekin = 0.100429851263191 | erot = 0.465345829669622 | epot = -15.1906794231115 | etot = -14.6249037421787 +147000 ekin = 0.112509264558581 | erot = 0.485598823528122 | epot = -15.2230118303515 | etot = -14.6249037422648 +148000 ekin = 0.124869425792591 | erot = 0.507015469189552 | epot = -15.2567886373282 | etot = -14.6249037423461 +149000 ekin = 0.136710750658436 | erot = 0.529096273051187 | epot = -15.290710766127 | etot = -14.6249037424174 +150000 ekin = 0.147386480806171 | erot = 0.551336607352345 | epot = -15.323626830634 | etot = -14.6249037424755 +151000 ekin = 0.156436378416032 | erot = 0.573248570645276 | epot = -15.3545886915794 | etot = -14.6249037425181 +152000 ekin = 0.163597998371653 | erot = 0.594380933602923 | epot = -15.3828826745196 | etot = -14.624903742545 +153000 ekin = 0.168796920199611 | erot = 0.614335653334474 | epot = -15.4080363160912 | etot = -14.6249037425571 +154000 ekin = 0.172119667637745 | erot = 0.63277992909172 | epot = -15.4298033392862 | etot = -14.6249037425567 +155000 ekin = 0.173774602206285 | erot = 0.649453329865168 | epot = -15.448131674618 | etot = -14.6249037425466 +156000 ekin = 0.174046854480021 | erot = 0.664170048550552 | epot = -15.4631206455605 | etot = -14.62490374253 +157000 ekin = 0.173253451016122 | erot = 0.676816762702534 | epot = -15.4749739562284 | etot = -14.6249037425097 +158000 ekin = 0.171704281293749 | erot = 0.687346881268012 | epot = -15.48395490505 | etot = -14.6249037424883 +159000 ekin = 0.169673443699862 | erot = 0.695772131173121 | epot = -15.4903493173403 | etot = -14.6249037424673 +160000 ekin = 0.167383826014546 | erot = 0.702152502586509 | epot = -15.4944400710487 | etot = -14.6249037424476 +161000 ekin = 0.165005624031702 | erot = 0.706585545944493 | epot = -15.4964949124054 | etot = -14.6249037424292 +162000 ekin = 0.162667154471752 | erot = 0.709195914790859 | epot = -15.4967668116741 | etot = -14.6249037424115 +163000 ekin = 0.160474189581485 | erot = 0.710125892129829 | epot = -15.4955038241048 | etot = -14.6249037423935 +164000 ekin = 0.158532578972596 | erot = 0.709527441008927 | epot = -15.4929637623557 | etot = -14.6249037423742 +165000 ekin = 0.156968465370669 | erot = 0.707556101121189 | epot = -15.4894283088449 | etot = -14.624903742353 +166000 ekin = 0.155941053191124 | erot = 0.704366832058078 | epot = -15.4852116275794 | etot = -14.6249037423302 +167000 ekin = 0.155644496809548 | erot = 0.700111698658369 | epot = -15.4806599377741 | etot = -14.6249037423062 +168000 ekin = 0.156297672988182 | erot = 0.694939119112873 | epot = -15.4761405343834 | etot = -14.6249037422823 +169000 ekin = 0.158122923325456 | erot = 0.688994262094025 | epot = -15.4720209276801 | etot = -14.6249037422606 +170000 ekin = 0.161316852937676 | erot = 0.682420091513849 | epot = -15.4686406866943 | etot = -14.6249037422428 +171000 ekin = 0.166017619146822 | erot = 0.675358520304806 | epot = -15.4662798816825 | etot = -14.6249037422309 +172000 ekin = 0.172273671159511 | erot = 0.667951149520835 | epot = -15.4651285629069 | etot = -14.6249037422266 +173000 ekin = 0.180018623556049 | erot = 0.660339136127854 | epot = -15.4652615019149 | etot = -14.624903742231 +174000 ekin = 0.189056055744924 | erot = 0.65266185183192 | epot = -15.4666216498214 | etot = -14.6249037422445 +175000 ekin = 0.199056860650113 | erot = 0.645054167286172 | epot = -15.4690147702031 | etot = -14.6249037422668 +176000 ekin = 0.209570701317552 | erot = 0.637642422787005 | epot = -15.4721168664013 | etot = -14.6249037422967 +177000 ekin = 0.220052442974625 | erot = 0.630539423737628 | epot = -15.4754956090443 | etot = -14.6249037423321 +178000 ekin = 0.229904071991194 | erot = 0.623839102439311 | epot = -15.4786469168001 | etot = -14.6249037423696 +179000 ekin = 0.238532114427982 | erot = 0.617611757777875 | epot = -15.4810476146108 | etot = -14.624903742405 +180000 ekin = 0.245419064060292 | erot = 0.611900922402653 | epot = -15.4822237288957 | etot = -14.6249037424328 +181000 ekin = 0.250203926055771 | erot = 0.606722796615248 | epot = -15.4818304651186 | etot = -14.6249037424476 +182000 ekin = 0.252761402919565 | erot = 0.602068750131856 | epot = -15.4797338954959 | etot = -14.6249037424445 +183000 ekin = 0.253262634974054 | erot = 0.597910660168588 | epot = -15.4760770375641 | etot = -14.6249037424214 +184000 ekin = 0.252195762131878 | erot = 0.594208023726969 | epot = -15.4713075282387 | etot = -14.6249037423799 +185000 ekin = 0.250326113306321 | erot = 0.59091517967259 | epot = -15.4661450353052 | etot = -14.6249037423263 +186000 ekin = 0.248586758541649 | erot = 0.587986907734566 | epot = -15.4614774085478 | etot = -14.6249037422716 +187000 ekin = 0.247909630265846 | erot = 0.585381224303701 | epot = -15.4581945967982 | etot = -14.6249037422286 +188000 ekin = 0.2490290523945 | erot = 0.583059148733781 | epot = -15.4569919433378 | etot = -14.6249037422095 +189000 ekin = 0.252303803181127 | erot = 0.580982165409763 | epot = -15.4581897108128 | etot = -14.6249037422219 +190000 ekin = 0.25760376351551 | erot = 0.579108718145144 | epot = -15.4616162239281 | etot = -14.6249037422675 +191000 ekin = 0.264292655598098 | erot = 0.577391223758838 | epot = -15.4665876216975 | etot = -14.6249037423406 +192000 ekin = 0.271315385056409 | erot = 0.575774831089113 | epot = -15.4719939585751 | etot = -14.6249037424296 +193000 ekin = 0.277374539132748 | erot = 0.574198584868256 | epot = -15.4764768665202 | etot = -14.6249037425192 +194000 ekin = 0.281161076019677 | erot = 0.572598913484698 | epot = -15.478663732098 | etot = -14.6249037425936 +195000 ekin = 0.281592637347121 | erot = 0.570914645865623 | epot = -15.4774110258523 | etot = -14.6249037426396 +196000 ekin = 0.278011867235596 | erot = 0.569092314484759 | epot = -15.4720079243693 | etot = -14.624903742649 +197000 ekin = 0.270307527592762 | erot = 0.567090473639989 | epot = -15.4623017438531 | etot = -14.6249037426204 +198000 ekin = 0.258940359975855 | erot = 0.564882125458807 | epot = -15.4487262279927 | etot = -14.6249037425581 +199000 ekin = 0.244877476699234 | erot = 0.562454912721902 | epot = -15.4322361318925 | etot = -14.6249037424713 +200000 ekin = 0.229456931018641 | erot = 0.559809284042077 | epot = -15.4141699574324 | etot = -14.6249037423716 +201000 ekin = 0.214214012278847 | erot = 0.556955381706859 | epot = -15.3960731362566 | etot = -14.6249037422709 +202000 ekin = 0.200701376135036 | erot = 0.553909032488863 | epot = -15.3795141508034 | etot = -14.6249037421795 +203000 ekin = 0.190329688710817 | erot = 0.550687503827512 | epot = -15.3659209346435 | etot = -14.6249037421052 +204000 ekin = 0.184246973275337 | erot = 0.547306655840007 | epot = -15.356457371168 | etot = -14.6249037420527 +205000 ekin = 0.183262973705813 | erot = 0.543779043729278 | epot = -15.3519457594592 | etot = -14.6249037420241 +206000 ekin = 0.187816949073515 | erot = 0.540113432736619 | epot = -15.3528341238291 | etot = -14.624903742019 +207000 ekin = 0.197980929490512 | erot = 0.536315658388676 | epot = -15.3592003299145 | etot = -14.6249037420353 +208000 ekin = 0.213487612677366 | erot = 0.53239049820727 | epot = -15.3707818529549 | etot = -14.6249037420703 +209000 ekin = 0.233772362712521 | erot = 0.528344018725095 | epot = -15.3870201235584 | etot = -14.6249037421208 +210000 ekin = 0.258021408692355 | erot = 0.524185756556833 | epot = -15.4071109074329 | etot = -14.6249037421837 +211000 ekin = 0.285222208429996 | erot = 0.519930104708342 | epot = -15.4300560553942 | etot = -14.6249037422558 +212000 ekin = 0.314215813604987 | erot = 0.515596398128489 | epot = -15.454715954067 | etot = -14.6249037423335 +213000 ekin = 0.343753634043937 | erot = 0.511207450608882 | epot = -15.4798648270658 | etot = -14.624903742413 +214000 ekin = 0.372561594270316 | erot = 0.506786560075337 | epot = -15.5042518968352 | etot = -14.6249037424895 +215000 ekin = 0.399412456462858 | erot = 0.502353347158712 | epot = -15.5266695461799 | etot = -14.6249037425583 +216000 ekin = 0.423202666203616 | erot = 0.497919155944113 | epot = -15.5460255647623 | etot = -14.6249037426146 +217000 ekin = 0.443025226540025 | erot = 0.493483013679004 | epot = -15.5614119828738 | etot = -14.6249037426548 +218000 ekin = 0.458227302378849 | erot = 0.489029294856436 | epot = -15.5721603399122 | etot = -14.6249037426769 +219000 ekin = 0.46844301918404 | erot = 0.484528125251435 | epot = -15.5778748871159 | etot = -14.6249037426804 +220000 ekin = 0.473598483116685 | erot = 0.479939108990801 | epot = -15.5784413347739 | etot = -14.6249037426664 +221000 ekin = 0.473894168318713 | erot = 0.475218183432529 | epot = -15.5740160943878 | etot = -14.6249037426366 +222000 ekin = 0.46977401404952 | erot = 0.470326483973494 | epot = -15.565004240616 | etot = -14.624903742593 +223000 ekin = 0.461887320397438 | erot = 0.465239349169368 | epot = -15.552030412105 | etot = -14.6249037425382 +224000 ekin = 0.45104133642262 | erot = 0.459953336121611 | epot = -15.5358984150202 | etot = -14.624903742476 +225000 ekin = 0.438137198422833 | erot = 0.454489515561399 | epot = -15.5175304563959 | etot = -14.6249037424116 +226000 ekin = 0.424086332826247 | erot = 0.448892294163513 | epot = -15.4978823693413 | etot = -14.6249037423516 +227000 ekin = 0.409717105195145 | erot = 0.443224250669953 | epot = -15.4778450981665 | etot = -14.6249037423014 +228000 ekin = 0.395692916861505 | erot = 0.437558473222737 | epot = -15.4581551323492 | etot = -14.6249037422649 +229000 ekin = 0.382463318564619 | erot = 0.431970318931211 | epot = -15.4393373797385 | etot = -14.6249037422426 +230000 ekin = 0.370258116730603 | erot = 0.426530223272752 | epot = -15.421692082236 | etot = -14.6249037422326 +231000 ekin = 0.359118625017489 | erot = 0.421298440292615 | epot = -15.4053208075415 | etot = -14.6249037422314 +232000 ekin = 0.348949729121418 | erot = 0.416321816462733 | epot = -15.3901752878198 | etot = -14.6249037422357 +233000 ekin = 0.339575284188205 | erot = 0.411632247273789 | epot = -15.3761112737045 | etot = -14.6249037422425 +234000 ekin = 0.330784909163314 | erot = 0.407246384303571 | epot = -15.362935035717 | etot = -14.6249037422501 +235000 ekin = 0.322367248495157 | erot = 0.403166248673602 | epot = -15.350437239426 | etot = -14.6249037422572 +236000 ekin = 0.314129851889501 | erot = 0.399380677843556 | epot = -15.3384142719966 | etot = -14.6249037422635 +237000 ekin = 0.305908300164827 | erot = 0.395867600047935 | epot = -15.3266796424818 | etot = -14.624903742269 +238000 ekin = 0.297568064657773 | erot = 0.39259715720464 | epot = -15.3150689641361 | etot = -14.6249037422737 +239000 ekin = 0.289002756414808 | erot = 0.389535643317172 | epot = -15.3034421420093 | etot = -14.6249037422773 +240000 ekin = 0.280132201614557 | erot = 0.386650129641611 | epot = -15.291686073536 | etot = -14.6249037422798 +241000 ekin = 0.270903172980175 | erot = 0.383913574227223 | epot = -15.2797204894877 | etot = -14.6249037422803 +242000 ekin = 0.261294311101929 | erot = 0.381310019034114 | epot = -15.2675080724141 | etot = -14.624903742278 +243000 ekin = 0.251325265433967 | erot = 0.378839435319614 | epot = -15.255068443025 | etot = -14.6249037422714 +244000 ekin = 0.241068460184099 | erot = 0.376521662813181 | epot = -15.2424938652571 | etot = -14.6249037422598 +245000 ekin = 0.230660579660543 | erot = 0.374398842117411 | epot = -15.2299631640205 | etot = -14.6249037422425 +246000 ekin = 0.220310176855077 | erot = 0.372535772164605 | epot = -15.2177496912391 | etot = -14.6249037422194 +247000 ekin = 0.21029792040831 | erot = 0.371017759432739 | epot = -15.2062194220324 | etot = -14.6249037421913 +248000 ekin = 0.200966973970282 | erot = 0.369945779906298 | epot = -15.1958164960366 | etot = -14.62490374216 +249000 ekin = 0.19270275205643 | erot = 0.369429135338942 | epot = -15.1870356295232 | etot = -14.6249037421279 +250000 ekin = 0.18590352409262 | erot = 0.369576201101644 | epot = -15.1803834672921 | etot = -14.6249037420978 +251000 ekin = 0.180945546219597 | erot = 0.370484246994953 | epot = -15.1763335352872 | etot = -14.6249037420727 +252000 ekin = 0.178147956309677 | erot = 0.372229589272508 | epot = -15.1752812876371 | etot = -14.624903742055 +253000 ekin = 0.177743031465493 | erot = 0.374859230993345 | epot = -15.1775060045052 | etot = -14.6249037420463 +254000 ekin = 0.179856300055144 | erot = 0.378385037101541 | epot = -15.1831450792041 | etot = -14.6249037420475 +255000 ekin = 0.184498455786623 | erot = 0.382781080046676 | epot = -15.1921832778916 | etot = -14.6249037420583 +256000 ekin = 0.191568141873245 | erot = 0.387983970946509 | epot = -15.2044558548979 | etot = -14.6249037420781 +257000 ekin = 0.200862084874684 | erot = 0.39389562099413 | epot = -15.2196614479746 | etot = -14.6249037421058 +258000 ekin = 0.212087875567067 | erot = 0.400387498987617 | epot = -15.2373791166953 | etot = -14.6249037421406 +259000 ekin = 0.22487530619229 | erot = 0.407305396776974 | epot = -15.2570844451511 | etot = -14.6249037421818 +260000 ekin = 0.238784314763371 | erot = 0.414473950040919 | epot = -15.2781620070334 | etot = -14.6249037422291 +261000 ekin = 0.253310397642053 | erot = 0.42170059668304 | epot = -15.2999147366073 | etot = -14.6249037422822 +262000 ekin = 0.267890750412286 | erot = 0.428779149459046 | epot = -15.3215736422117 | etot = -14.6249037423403 +263000 ekin = 0.281915541777785 | erot = 0.435493571930371 | epot = -15.3423128561102 | etot = -14.6249037424021 +264000 ekin = 0.294748319449044 | erot = 0.441622773940652 | epot = -15.3612748358547 | etot = -14.624903742465 +265000 ekin = 0.305757851305137 | erot = 0.446947232466447 | epot = -15.3776088262971 | etot = -14.6249037425255 +266000 ekin = 0.314361275702132 | erot = 0.451257984268096 | epot = -15.3905230025497 | etot = -14.6249037425794 +267000 ekin = 0.320075758813841 | erot = 0.454368036195507 | epot = -15.3993475376314 | etot = -14.624903742622 +268000 ekin = 0.322573111285627 | erot = 0.456125517716869 | epot = -15.403602371651 | etot = -14.6249037426485 +269000 ekin = 0.321728949456794 | erot = 0.456427019949868 | epot = -15.403059712062 | etot = -14.6249037426553 +270000 ekin = 0.31765519820333 | erot = 0.45522869606994 | epot = -15.3977876369143 | etot = -14.624903742641 +271000 ekin = 0.310703151367432 | erot = 0.452552178355822 | epot = -15.3881590723309 | etot = -14.6249037426077 +272000 ekin = 0.301426233536413 | erot = 0.448482664562071 | epot = -15.3748126406594 | etot = -14.6249037425609 +273000 ekin = 0.290499502093209 | erot = 0.443158007811074 | epot = -15.3585612524138 | etot = -14.6249037425095 +274000 ekin = 0.278606962226069 | erot = 0.436750209657617 | epot = -15.3402609143468 | etot = -14.6249037424631 +275000 ekin = 0.26632348034077 | erot = 0.429443553158618 | epot = -15.3206707759287 | etot = -14.6249037424293 +276000 ekin = 0.254026977158081 | erot = 0.421415402004818 | epot = -15.3003461215739 | etot = -14.624903742411 +277000 ekin = 0.241871064453538 | erot = 0.412825312322111 | epot = -15.2796001191811 | etot = -14.6249037424054 +278000 ekin = 0.229828041579721 | erot = 0.403815416629946 | epot = -15.2585472006151 | etot = -14.6249037424054 +279000 ekin = 0.217786141146189 | erot = 0.394521119096963 | epot = -15.2372110026452 | etot = -14.624903742402 +280000 ekin = 0.205666064593732 | erot = 0.38508770303191 | epot = -15.2156575100133 | etot = -14.6249037423876 +281000 ekin = 0.19351860427424 | erot = 0.375686870762611 | epot = -15.194109217395 | etot = -14.6249037423581 +282000 ekin = 0.181576720747694 | erot = 0.366527860021383 | epot = -15.1730083230829 | etot = -14.6249037423139 +283000 ekin = 0.170254050626048 | erot = 0.357859944223912 | epot = -15.1530177371086 | etot = -14.6249037422586 +284000 ekin = 0.16009863107041 | erot = 0.349965713705531 | epot = -15.1349680869742 | etot = -14.6249037421982 +285000 ekin = 0.151720356670754 | erot = 0.343146625519695 | epot = -15.1197707243297 | etot = -14.6249037421393 +286000 ekin = 0.145712559183906 | erot = 0.337703485420487 | epot = -15.1083197866921 | etot = -14.6249037420877 +287000 ekin = 0.142584250545045 | erot = 0.33391483609244 | epot = -15.1014028286853 | etot = -14.6249037420479 +288000 ekin = 0.14271294134083 | erot = 0.33201595204223 | epot = -15.0996326354053 | etot = -14.6249037420222 +289000 ekin = 0.146320998448773 | erot = 0.332180585089635 | epot = -15.1034053255502 | etot = -14.6249037420118 +290000 ekin = 0.153472816921521 | erot = 0.334506983378674 | epot = -15.1128835423164 | etot = -14.6249037420162 +291000 ekin = 0.16408646566307 | erot = 0.339009144348004 | epot = -15.1279993520452 | etot = -14.6249037420341 +292000 ekin = 0.177952173600894 | erot = 0.345613807734655 | epot = -15.1484697233998 | etot = -14.6249037420642 +293000 ekin = 0.194750859969321 | erot = 0.354163344443058 | epot = -15.1738179465174 | etot = -14.624903742105 +294000 ekin = 0.214068309159694 | erot = 0.364424408222029 | epot = -15.2033964595369 | etot = -14.6249037421551 +295000 ekin = 0.23540371040359 | erot = 0.376101928511103 | epot = -15.2364093811279 | etot = -14.6249037422133 +296000 ekin = 0.258174229753498 | erot = 0.388857685536646 | epot = -15.2719356575678 | etot = -14.6249037422776 +297000 ekin = 0.281719360135706 | erot = 0.402332315571764 | epot = -15.3089554180538 | etot = -14.6249037423463 +298000 ekin = 0.305309684523697 | erot = 0.416169191335652 | epot = -15.3463826182759 | etot = -14.6249037424165 +299000 ekin = 0.328164426016654 | erot = 0.430038291827268 | epot = -15.3831064603292 | etot = -14.6249037424853 +300000 ekin = 0.349480947255048 | erot = 0.443657997414315 | epot = -15.4180426872181 | etot = -14.6249037425488 +301000 ekin = 0.368477349759193 | erot = 0.456812763608568 | epot = -15.4501938559701 | etot = -14.6249037426023 +302000 ekin = 0.384446573101124 | erot = 0.469364841860938 | epot = -15.4787151576043 | etot = -14.6249037426422 +303000 ekin = 0.396817065634558 | erot = 0.481258609604811 | epot = -15.5029794179039 | etot = -14.6249037426646 +304000 ekin = 0.405211709647007 | erot = 0.492516637287636 | epot = -15.5226320896017 | etot = -14.624903742667 +305000 ekin = 0.409494186865868 | erot = 0.503227368870062 | epot = -15.5376252983853 | etot = -14.6249037426493 +306000 ekin = 0.409791521882642 | erot = 0.513525227982917 | epot = -15.5482204924792 | etot = -14.6249037426137 +307000 ekin = 0.406484029567507 | erot = 0.523565033268454 | epot = -15.5549528054007 | etot = -14.6249037425647 +308000 ekin = 0.400159443093576 | erot = 0.533493670193517 | epot = -15.5585568557963 | etot = -14.6249037425092 +309000 ekin = 0.391535685673409 | erot = 0.543422788904487 | epot = -15.5598622170328 | etot = -14.6249037424549 +310000 ekin = 0.381364662749467 | erot = 0.553406603763533 | epot = -15.559675008922 | etot = -14.624903742409 +311000 ekin = 0.370335174700701 | erot = 0.563428434509133 | epot = -15.5586673515868 | etot = -14.624903742377 +312000 ekin = 0.358994462073939 | erot = 0.573398378860855 | epot = -15.5572965832959 | etot = -14.6249037423611 +313000 ekin = 0.347704062021925 | erot = 0.583162598674903 | epot = -15.5557704030573 | etot = -14.6249037423605 +314000 ekin = 0.33663740290675 | erot = 0.592522528333923 | epot = -15.5540636736116 | etot = -14.6249037423709 +315000 ekin = 0.325816357219143 | erot = 0.601260411441213 | epot = -15.5519805110473 | etot = -14.6249037423869 +316000 ekin = 0.31517501281672 | erot = 0.60916645196768 | epot = -15.5492452071863 | etot = -14.6249037424019 +317000 ekin = 0.304633856553889 | erot = 0.616062831072119 | epot = -15.5456004300365 | etot = -14.6249037424105 +318000 ekin = 0.294167456686821 | erot = 0.621820866636781 | epot = -15.5408920657325 | etot = -14.6249037424089 +319000 ekin = 0.283852816310689 | erot = 0.626369338624031 | epot = -15.5351258973307 | etot = -14.6249037423959 +320000 ekin = 0.273891844373646 | erot = 0.62969394858388 | epot = -15.5284895353295 | etot = -14.624903742372 +321000 ekin = 0.264607615830763 | erot = 0.631829520445007 | epot = -15.5213408786157 | etot = -14.6249037423399 +322000 ekin = 0.256418665980724 | erot = 0.632847556381818 | epot = -15.5141699646656 | etot = -14.6249037423031 +323000 ekin = 0.249797892887888 | erot = 0.632842055921319 | epot = -15.5075436910747 | etot = -14.6249037422655 +324000 ekin = 0.245223011939643 | erot = 0.631916211662829 | epot = -15.5020429658332 | etot = -14.6249037422308 +325000 ekin = 0.243124676660885 | erot = 0.630171930979599 | epot = -15.4982003498433 | etot = -14.6249037422029 +326000 ekin = 0.243837159968202 | erot = 0.62770331019607 | epot = -15.4964442123487 | etot = -14.6249037421844 +327000 ekin = 0.247555458534598 | erot = 0.624594349329564 | epot = -15.4970535500418 | etot = -14.6249037421777 +328000 ekin = 0.254302069317208 | erot = 0.620920422826662 | epot = -15.5001262343276 | etot = -14.6249037421837 +329000 ekin = 0.263906382978448 | erot = 0.616752378549749 | epot = -15.5055625037309 | etot = -14.6249037422027 +330000 ekin = 0.275999298196581 | erot = 0.612161709808553 | epot = -15.513064750239 | etot = -14.6249037422339 +331000 ekin = 0.290024872454518 | erot = 0.6072251384784 | epot = -15.5221537532081 | etot = -14.6249037422752 +332000 ekin = 0.305269328205317 | erot = 0.602027230533175 | epot = -15.5322003010622 | etot = -14.6249037423237 +333000 ekin = 0.32090561137506 | erot = 0.59666030333851 | epot = -15.5424696570894 | etot = -14.6249037423759 +334000 ekin = 0.336049438962957 | erot = 0.59122171045733 | epot = -15.5521748918481 | etot = -14.6249037424278 +335000 ekin = 0.349821102707528 | erot = 0.585809355783074 | epot = -15.5605342009664 | etot = -14.6249037424758 +336000 ekin = 0.361406827299004 | erot = 0.580516763971273 | epot = -15.5668273337865 | etot = -14.6249037425162 +337000 ekin = 0.370114335989199 | erot = 0.575429096256477 | epot = -15.570447174792 | etot = -14.6249037425463 +338000 ekin = 0.375418963131835 | erot = 0.570621177508979 | epot = -15.5709438832047 | etot = -14.6249037425639 +339000 ekin = 0.376998306684161 | erot = 0.566157982091391 | epot = -15.5680600313428 | etot = -14.6249037425673 +340000 ekin = 0.374754278532076 | erot = 0.562097189039027 | epot = -15.561755210127 | etot = -14.6249037425559 +341000 ekin = 0.368821588409674 | erot = 0.558493134368603 | epot = -15.5522184653082 | etot = -14.6249037425299 +342000 ekin = 0.359561251230654 | erot = 0.555400700218385 | epot = -15.5398656939398 | etot = -14.6249037424907 +343000 ekin = 0.347537853254552 | erot = 0.552877785918206 | epot = -15.5253193816135 | etot = -14.6249037424408 +344000 ekin = 0.333480374963866 | erot = 0.5509852684009 | epot = -15.5093693857484 | etot = -14.6249037423837 +345000 ekin = 0.318228359784356 | erot = 0.549783918348281 | epot = -15.4929160204566 | etot = -14.6249037423239 +346000 ekin = 0.302667555547469 | erot = 0.549328430110417 | epot = -15.4768997279243 | etot = -14.6249037422664 +347000 ekin = 0.28766105744341 | erot = 0.549659363310447 | epot = -15.4622241629696 | etot = -14.6249037422157 +348000 ekin = 0.273982878354205 | erot = 0.550794243902763 | epot = -15.4496808644331 | etot = -14.6249037421761 +349000 ekin = 0.262260631617843 | erot = 0.552719272009514 | epot = -15.439883645778 | etot = -14.6249037421507 +350000 ekin = 0.252932884528192 | erot = 0.555383042233133 | epot = -15.4332196689026 | etot = -14.6249037421413 +351000 ekin = 0.246225113234617 | erot = 0.55869341876511 | epot = -15.4298222741477 | etot = -14.624903742148 +352000 ekin = 0.242146418558379 | erot = 0.562518344425243 | epot = -15.4295685051533 | etot = -14.6249037421697 +353000 ekin = 0.240507191582831 | erot = 0.566690733134613 | epot = -15.4321016669209 | etot = -14.6249037422035 +354000 ekin = 0.240955911174275 | erot = 0.571016874087082 | epot = -15.4368765275071 | etot = -14.6249037422458 +355000 ekin = 0.243030568944454 | erot = 0.575286990707861 | epot = -15.4432213019444 | etot = -14.624903742292 +356000 ekin = 0.246218336341954 | erot = 0.579286102670435 | epot = -15.4504081813504 | etot = -14.6249037423381 +357000 ekin = 0.250015504867581 | erot = 0.58280308408374 | epot = -15.4577223313315 | etot = -14.6249037423802 +358000 ekin = 0.253980003728839 | erot = 0.585636256510467 | epot = -15.4645200026551 | etot = -14.6249037424158 +359000 ekin = 0.257771924238821 | erot = 0.587595069854197 | epot = -15.4702707365363 | etot = -14.6249037424433 +360000 ekin = 0.261178006692924 | erot = 0.588498175296143 | epot = -15.4745799244512 | etot = -14.6249037424621 +361000 ekin = 0.264121303804436 | erot = 0.588169931158563 | epot = -15.4771949774355 | etot = -14.6249037424725 +362000 ekin = 0.26665626894814 | erot = 0.586437607933123 | epot = -15.4779976193568 | etot = -14.6249037424755 +363000 ekin = 0.268947338174106 | erot = 0.583131261384995 | epot = -15.4769823420322 | etot = -14.6249037424731 +364000 ekin = 0.271226723299596 | erot = 0.578087502910441 | epot = -15.4742179686788 | etot = -14.6249037424688 +365000 ekin = 0.273728224388818 | erot = 0.571157191000725 | epot = -15.469789157857 | etot = -14.6249037424674 +366000 ekin = 0.27660157052003 | erot = 0.562216266683608 | epot = -15.4637215796777 | etot = -14.624903742474 +367000 ekin = 0.279824898676208 | erot = 0.551178529879214 | epot = -15.4559071710475 | etot = -14.6249037424921 +368000 ekin = 0.283144751011421 | erot = 0.538009090150606 | epot = -15.446057583683 | etot = -14.624903742521 +369000 ekin = 0.286073979195429 | erot = 0.522737270878628 | epot = -15.43371499263 | etot = -14.6249037425559 +370000 ekin = 0.287962637923178 | erot = 0.50546765170011 | epot = -15.4183340322108 | etot = -14.6249037425875 +371000 ekin = 0.288129562576893 | erot = 0.486387667907303 | epot = -15.3994209730894 | etot = -14.6249037426052 +372000 ekin = 0.286016270828215 | erot = 0.465769998081936 | epot = -15.3766900115109 | etot = -14.6249037426008 +373000 ekin = 0.281314492917267 | erot = 0.443968246943336 | epot = -15.3501864824312 | etot = -14.6249037425706 +374000 ekin = 0.274029637541304 | erot = 0.421405384813941 | epot = -15.3203387648723 | etot = -14.6249037425171 +375000 ekin = 0.264468317323927 | erot = 0.398555847613352 | epot = -15.2879279073837 | etot = -14.6249037424464 +376000 ekin = 0.253165169267974 | erot = 0.375923572596667 | epot = -15.2539924842319 | etot = -14.6249037423673 +377000 ekin = 0.240780733674519 | erot = 0.354018931407049 | epot = -15.2197034073693 | etot = -14.6249037422878 +378000 ekin = 0.228003530692849 | erot = 0.333337224177657 | epot = -15.1862444970844 | etot = -14.6249037422138 +379000 ekin = 0.215478669427367 | erot = 0.314340303318035 | epot = -15.1547227148943 | etot = -14.6249037421489 +380000 ekin = 0.203769466320298 | erot = 0.297441561967809 | epot = -15.1261147703827 | etot = -14.6249037420946 +381000 ekin = 0.193344913038602 | erot = 0.282993579610754 | epot = -15.1012422347007 | etot = -14.6249037420513 +382000 ekin = 0.1845790971167 | erot = 0.271277560103436 | epot = -15.0807603992401 | etot = -14.62490374202 +383000 ekin = 0.177749902922622 | erot = 0.26249431847454 | epot = -15.0651479633984 | etot = -14.6249037420012 +384000 ekin = 0.173031383434508 | erot = 0.256757595375745 | epot = -15.0546927208059 | etot = -14.6249037419956 +385000 ekin = 0.170483112154869 | erot = 0.254091341095724 | epot = -15.049478195254 | etot = -14.6249037420034 +386000 ekin = 0.170046361592442 | erot = 0.254432809989109 | epot = -15.0493829136049 | etot = -14.6249037420233 +387000 ekin = 0.171558026227206 | erot = 0.257642587604648 | epot = -15.0541043558835 | etot = -14.6249037420517 +388000 ekin = 0.174787865439128 | erot = 0.263521131370077 | epot = -15.0632127388927 | etot = -14.6249037420835 +389000 ekin = 0.179494526901848 | erot = 0.271829477565643 | epot = -15.0762277465811 | etot = -14.6249037421136 +390000 ekin = 0.185484901052496 | erot = 0.282310127810724 | epot = -15.0926987710012 | etot = -14.624903742138 +391000 ekin = 0.192654775276086 | erot = 0.294703495236184 | epot = -15.1122620126683 | etot = -14.624903742156 +392000 ekin = 0.200990711955861 | erot = 0.308756153372879 | epot = -15.1346506074993 | etot = -14.6249037421705 +393000 ekin = 0.210524629688573 | erot = 0.324219483681282 | epot = -15.1596478555577 | etot = -14.6249037421878 +394000 ekin = 0.22125039811835 | erot = 0.340840530849664 | epot = -15.1869946711827 | etot = -14.6249037422146 +395000 ekin = 0.233028912153826 | erot = 0.358349828151301 | epot = -15.2162824825616 | etot = -14.6249037422565 +396000 ekin = 0.2455168348482 | erot = 0.376452447324096 | epot = -15.2468730244869 | etot = -14.6249037423146 +397000 ekin = 0.25814964628924 | erot = 0.394827815017667 | epot = -15.2778812036919 | etot = -14.624903742385 +398000 ekin = 0.270192540270399 | erot = 0.4131410333725 | epot = -15.3082373161018 | etot = -14.6249037424589 +399000 ekin = 0.280849396853854 | erot = 0.431064534842813 | epot = -15.3368176742223 | etot = -14.6249037425256 +400000 ekin = 0.289399657315509 | erot = 0.448305349545533 | epot = -15.3626087494363 | etot = -14.6249037425752 +401000 ekin = 0.295323233787914 | erot = 0.464631356382232 | epot = -15.3848583327717 | etot = -14.6249037426015 +402000 ekin = 0.298377750401429 | erot = 0.479890206670972 | epot = -15.4031716996757 | etot = -14.6249037426033 +403000 ekin = 0.298608046776847 | erot = 0.494016844836358 | epot = -15.4175286341982 | etot = -14.624903742585 +404000 ekin = 0.296288720276099 | erot = 0.507028747324982 | epot = -15.4282212101551 | etot = -14.624903742554 +405000 ekin = 0.29181945089068 | erot = 0.519011022290344 | epot = -15.4357342157007 | etot = -14.6249037425197 +406000 ekin = 0.285604695316787 | erot = 0.530095491696252 | epot = -15.440603929503 | etot = -14.62490374249 +407000 ekin = 0.27795179501284 | erot = 0.540438449781457 | epot = -15.4432939872644 | etot = -14.6249037424701 +408000 ekin = 0.269015012492725 | erot = 0.550201084797105 | epot = -15.4441198397503 | etot = -14.6249037424605 +409000 ekin = 0.258799683406998 | erot = 0.559535019811799 | epot = -15.4432384456764 | etot = -14.6249037424576 +410000 ekin = 0.247223943172304 | erot = 0.568573648692186 | epot = -15.4407013343195 | etot = -14.624903742455 +411000 ekin = 0.234219542826644 | erot = 0.577428429926533 | epot = -15.4365517151989 | etot = -14.6249037424457 +412000 ekin = 0.219842320368382 | erot = 0.5861883861288 | epot = -15.4309344489209 | etot = -14.6249037424237 +413000 ekin = 0.204359948374925 | erot = 0.594920843620856 | epot = -15.4241845343826 | etot = -14.6249037423868 +414000 ekin = 0.188290368309528 | erot = 0.603671832826723 | epot = -15.4168659434726 | etot = -14.6249037423363 +415000 ekin = 0.17237708181679 | erot = 0.612465324291743 | epot = -15.4097461483867 | etot = -14.6249037422781 +416000 ekin = 0.157503657630917 | erot = 0.621301324615619 | epot = -15.4037087244673 | etot = -14.6249037422208 +417000 ekin = 0.144565276806003 | erot = 0.630153567596961 | epot = -15.3996225865765 | etot = -14.6249037421735 +418000 ekin = 0.134326161306162 | erot = 0.638967960411851 | epot = -15.3981978638625 | etot = -14.6249037421445 +419000 ekin = 0.127295713866961 | erot = 0.647663024756136 | epot = -15.3998624807615 | etot = -14.6249037421384 +420000 ekin = 0.123652074078926 | erot = 0.656133267678405 | epot = -15.404689083913 | etot = -14.6249037421557 +421000 ekin = 0.123230332545423 | erot = 0.664256043547052 | epot = -15.4123901182846 | etot = -14.6249037421921 +422000 ekin = 0.125576493084645 | erot = 0.671901405101299 | epot = -15.4223816404261 | etot = -14.6249037422401 +423000 ekin = 0.130051930466291 | erot = 0.678943694027994 | epot = -15.4338993667851 | etot = -14.6249037422908 +424000 ekin = 0.135961143238941 | erot = 0.68527308622734 | epot = -15.4461379718019 | etot = -14.6249037423356 +425000 ekin = 0.142671659965653 | erot = 0.690804983811737 | epot = -15.4583803861463 | etot = -14.6249037423689 +426000 ekin = 0.149699767318955 | erot = 0.69548556134855 | epot = -15.4700890710557 | etot = -14.6249037423882 +427000 ekin = 0.156747049208564 | erot = 0.699292628464386 | epot = -15.4809434200676 | etot = -14.6249037423947 +428000 ekin = 0.163686553654653 | erot = 0.702231990285693 | epot = -15.4908222863327 | etot = -14.6249037423924 +429000 ekin = 0.170509683514881 | erot = 0.704330315301697 | epot = -15.4997437412031 | etot = -14.6249037423865 +430000 ekin = 0.177252892951705 | erot = 0.705626025883602 | epot = -15.5077826612176 | etot = -14.6249037423823 +431000 ekin = 0.183925691222895 | erot = 0.706159951516283 | epot = -15.5149893851227 | etot = -14.6249037423835 +432000 ekin = 0.19045785108011 | erot = 0.705966883793978 | epot = -15.5213284772661 | etot = -14.624903742392 +433000 ekin = 0.196676887389506 | erot = 0.705069371776843 | epot = -15.5266500015735 | etot = -14.6249037424072 +434000 ekin = 0.202317433899842 | erot = 0.703474477741428 | epot = -15.5306956540681 | etot = -14.6249037424269 +435000 ekin = 0.207056046506956 | erot = 0.701173837003811 | epot = -15.5331336259585 | etot = -14.6249037424477 +436000 ekin = 0.210560164857125 | erot = 0.698146912242933 | epot = -15.5336108195661 | etot = -14.6249037424661 +437000 ekin = 0.212539330538931 | erot = 0.694366864819831 | epot = -15.5318099378377 | etot = -14.624903742479 +438000 ekin = 0.212789433625871 | erot = 0.689808070113593 | epot = -15.5275012462235 | etot = -14.624903742484 +439000 ekin = 0.211224885327214 | erot = 0.684454087056214 | epot = -15.5205827148631 | etot = -14.6249037424797 +440000 ekin = 0.207897417438809 | erot = 0.678304934040255 | epot = -15.5111060939441 | etot = -14.624903742465 +441000 ekin = 0.203002684917561 | erot = 0.671382822496918 | epot = -15.4992892498548 | etot = -14.6249037424403 +442000 ekin = 0.196876783893415 | erot = 0.66373594678721 | epot = -15.4855164730867 | etot = -14.6249037424061 +443000 ekin = 0.189984458135294 | erot = 0.655440346227568 | epot = -15.4703285467262 | etot = -14.6249037423634 +444000 ekin = 0.182899715135625 | erot = 0.646600090308741 | epot = -15.4544035477581 | etot = -14.6249037423138 +445000 ekin = 0.176278659807151 | erot = 0.637346059016373 | epot = -15.4385284610832 | etot = -14.6249037422597 +446000 ekin = 0.170824489262207 | erot = 0.627833490901199 | epot = -15.4235617223673 | etot = -14.6249037422039 +447000 ekin = 0.16724611578148 | erot = 0.618238375507256 | epot = -15.4103882334382 | etot = -14.6249037421495 +448000 ekin = 0.166214016011086 | erot = 0.608752709243579 | epot = -15.3998704673542 | etot = -14.6249037420995 +449000 ekin = 0.1683180025474 | erot = 0.599578546514547 | epot = -15.3928002911186 | etot = -14.6249037420567 +450000 ekin = 0.174030350885976 | erot = 0.590920601688637 | epot = -15.3898546945984 | etot = -14.6249037420238 +451000 ekin = 0.183674309612486 | erot = 0.582976972209394 | epot = -15.3915550238252 | etot = -14.6249037420033 +452000 ekin = 0.197394458885248 | erot = 0.575927582956616 | epot = -15.39822578384 | etot = -14.6249037419981 +453000 ekin = 0.215124290963754 | erot = 0.569920414705972 | epot = -15.4099484476811 | etot = -14.6249037420114 +454000 ekin = 0.236549344238332 | erot = 0.565056494271021 | epot = -15.4265095805559 | etot = -14.6249037420465 +455000 ekin = 0.261070666492934 | erot = 0.561375729612865 | epot = -15.4473501382115 | etot = -14.6249037421057 +456000 ekin = 0.287780783019101 | erot = 0.558846520705115 | epot = -15.4715310459133 | etot = -14.6249037421891 +457000 ekin = 0.315469350479039 | erot = 0.557362227354604 | epot = -15.4977353201268 | etot = -14.6249037422931 +458000 ekin = 0.342675461161211 | erot = 0.556746783054113 | epot = -15.5243259866255 | etot = -14.6249037424101 +459000 ekin = 0.367796771324328 | erot = 0.556770049266128 | epot = -15.5494705631189 | etot = -14.6249037425284 +460000 ekin = 0.3892528364295 | erot = 0.557171234683844 | epot = -15.5713278137471 | etot = -14.6249037426338 +461000 ekin = 0.405683830372718 | erot = 0.557686417732241 | epot = -15.5882739908163 | etot = -14.6249037427113 +462000 ekin = 0.416150509763905 | erot = 0.558074591842708 | epot = -15.5991288443566 | etot = -14.6249037427499 +463000 ekin = 0.420292029665246 | erot = 0.558136338549459 | epot = -15.6033321109587 | etot = -14.624903742744 +464000 ekin = 0.418399545178514 | erot = 0.557720582601952 | epot = -15.6010238704768 | etot = -14.6249037426963 +465000 ekin = 0.411377435968826 | erot = 0.55671776612672 | epot = -15.5929989447132 | etot = -14.6249037426177 +466000 ekin = 0.400588481170777 | erot = 0.555041504869193 | epot = -15.5805337285653 | etot = -14.6249037425253 +467000 ekin = 0.387608315925912 | erot = 0.552604267015981 | epot = -15.5651163253807 | etot = -14.6249037424389 +468000 ekin = 0.373939506071419 | erot = 0.549294716065778 | epot = -15.5481379645134 | etot = -14.6249037423762 +469000 ekin = 0.360748545285941 | erot = 0.544964338611031 | epot = -15.5306166262458 | etot = -14.6249037423488 +470000 ekin = 0.348685397522481 | erot = 0.539428754142283 | epot = -15.5130178940239 | etot = -14.6249037423591 +471000 ekin = 0.33782542530965 | erot = 0.53248528288589 | epot = -15.495214450596 | etot = -14.6249037424005 +472000 ekin = 0.327743216876187 | erot = 0.523944004295118 | epot = -15.4765909636299 | etot = -14.6249037424586 +473000 ekin = 0.317695625905249 | erot = 0.513665869846711 | epot = -15.4562652382675 | etot = -14.6249037425155 +474000 ekin = 0.306866206292903 | erot = 0.501599410558902 | epot = -15.4333693594053 | etot = -14.6249037425535 +475000 ekin = 0.294611572516014 | erot = 0.487807694339925 | epot = -15.4073230094157 | etot = -14.6249037425598 +476000 ekin = 0.280654133645735 | erot = 0.472479343853221 | epot = -15.3780372200274 | etot = -14.6249037425284 +477000 ekin = 0.265182667318346 | erot = 0.455920989277164 | epot = -15.3460073990571 | etot = -14.6249037424615 +478000 ekin = 0.248846579355896 | erot = 0.438532535944716 | epot = -15.3122828576688 | etot = -14.6249037423682 +479000 ekin = 0.232654569020801 | erot = 0.420770062233786 | epot = -15.2783283735167 | etot = -14.6249037422621 +480000 ekin = 0.217807844646274 | erot = 0.403103245642895 | epot = -15.2458148324472 | etot = -14.624903742158 +481000 ekin = 0.205508255202274 | erot = 0.385974572360121 | epot = -15.2163865696318 | etot = -14.6249037420694 +482000 ekin = 0.196781566941766 | erot = 0.36976631024765 | epot = -15.1914516191951 | etot = -14.6249037420057 +483000 ekin = 0.19234694356787 | erot = 0.354778814406374 | epot = -15.1720294999463 | etot = -14.6249037419721 +484000 ekin = 0.192548846646396 | erot = 0.341220938396507 | epot = -15.1586735270111 | etot = -14.6249037419682 +485000 ekin = 0.197351634264796 | erot = 0.329210924265182 | epot = -15.1514663005207 | etot = -14.6249037419907 +486000 ekin = 0.206384571112674 | erot = 0.318784712513058 | epot = -15.1500730256597 | etot = -14.624903742034 +487000 ekin = 0.219018661981128 | erot = 0.309908337315953 | epot = -15.1538307413883 | etot = -14.6249037420912 +488000 ekin = 0.234457053485615 | erot = 0.302491737711597 | epot = -15.1618525333532 | etot = -14.6249037421559 +489000 ekin = 0.251825722282228 | erot = 0.296402451840807 | epot = -15.1731319163449 | etot = -14.6249037422219 +490000 ekin = 0.270257579252373 | erot = 0.291478772534408 | epot = -15.1866400940707 | etot = -14.6249037422839 +491000 ekin = 0.288968023940477 | erot = 0.287542686829702 | epot = -15.2014144531066 | etot = -14.6249037423364 +492000 ekin = 0.307321746939982 | erot = 0.28441316533236 | epot = -15.2166386546473 | etot = -14.624903742375 +493000 ekin = 0.32488919226749 | erot = 0.281920128741024 | epot = -15.2317130634052 | etot = -14.6249037423967 +494000 ekin = 0.341487883386483 | erot = 0.279918789013753 | epot = -15.2463104147992 | etot = -14.624903742399 +495000 ekin = 0.35720080106069 | erot = 0.278303167954071 | epot = -15.2604077113969 | etot = -14.6249037423821 +496000 ekin = 0.372363075866133 | erot = 0.277016625443694 | epot = -15.274283443659 | etot = -14.6249037423491 +497000 ekin = 0.387510424729673 | erot = 0.276056483801325 | epot = -15.288470650837 | etot = -14.624903742306 +498000 ekin = 0.403287744735438 | erot = 0.275469725413168 | epot = -15.3036612124104 | etot = -14.6249037422618 +499000 ekin = 0.42032292393259 | erot = 0.275337682298044 | epot = -15.320564348458 | etot = -14.6249037422274 +500000 ekin = 0.43907820686993 | erot = 0.275749832423184 | epot = -15.3397317815074 | etot = -14.6249037422143 +501000 ekin = 0.459699055393576 | erot = 0.27677002458897 | epot = -15.3613728222153 | etot = -14.6249037422327 +502000 ekin = 0.481887975238202 | erot = 0.278401857022776 | epot = -15.3851935745495 | etot = -14.6249037422885 +503000 ekin = 0.504836001700849 | erot = 0.28056227342693 | epot = -15.410302017509 | etot = -14.6249037423813 +504000 ekin = 0.527242963721984 | erot = 0.283072520273731 | epot = -15.4352192264977 | etot = -14.624903742502 +505000 ekin = 0.547444055756082 | erot = 0.285672032586838 | epot = -15.458019830977 | etot = -14.6249037426341 +506000 ekin = 0.563636138784674 | erot = 0.288055811209927 | epot = -15.47659569275 | etot = -14.6249037427554 +507000 ekin = 0.574166796919909 | erot = 0.289928574131153 | epot = -15.4889991138946 | etot = -14.6249037428436 +508000 ekin = 0.577825151301095 | erot = 0.29106332686132 | epot = -15.4937922210437 | etot = -14.6249037428812 +509000 ekin = 0.574066827021787 | erot = 0.291350176078735 | epot = -15.4903207459605 | etot = -14.6249037428599 +510000 ekin = 0.563118031118052 | erot = 0.290823209378379 | epot = -15.478844983279 | etot = -14.6249037427826 +511000 ekin = 0.545937816053849 | erot = 0.289659846600108 | epot = -15.4605014053159 | etot = -14.624903742662 +512000 ekin = 0.524051924661522 | erot = 0.288153919329358 | epot = -15.4371095865082 | etot = -14.6249037425174 +513000 ekin = 0.49930007419802 | erot = 0.286670443869403 | epot = -15.4108742604374 | etot = -14.6249037423699 +514000 ekin = 0.473556830410389 | erot = 0.285593013544029 | epot = -15.3840535861934 | etot = -14.624903742239 +515000 ekin = 0.448481344234872 | erot = 0.285274677057468 | epot = -15.3586597634305 | etot = -14.6249037421382 +516000 ekin = 0.425336124988155 | erot = 0.286000471485139 | epot = -15.3362403385481 | etot = -14.6249037420748 +517000 ekin = 0.404895133580943 | erot = 0.2879658116616 | epot = -15.3177646872915 | etot = -14.6249037420489 +518000 ekin = 0.38744137195972 | erot = 0.291271247088022 | epot = -15.303616361103 | etot = -14.6249037420552 +519000 ekin = 0.372839035852851 | erot = 0.295931281214127 | epot = -15.2936740591517 | etot = -14.6249037420847 +520000 ekin = 0.360656186943069 | erot = 0.301893194868317 | epot = -15.2874531239377 | etot = -14.6249037421263 +521000 ekin = 0.350310207443456 | erot = 0.30906098360489 | epot = -15.284274933218 | etot = -14.6249037421697 +522000 ekin = 0.341208800539667 | erot = 0.3173194084493 | epot = -15.2834319511953 | etot = -14.6249037422063 +523000 ekin = 0.332862997936835 | erot = 0.326553653087588 | epot = -15.284320393256 | etot = -14.6249037422315 +524000 ekin = 0.324955020060083 | erot = 0.336661144000867 | epot = -15.2865199063051 | etot = -14.6249037422441 +525000 ekin = 0.317352570821523 | erot = 0.347553686772997 | epot = -15.2898099998415 | etot = -14.624903742247 +526000 ekin = 0.310071537936527 | erot = 0.359150063852877 | epot = -15.2941253440357 | etot = -14.6249037422463 +527000 ekin = 0.30319969763022 | erot = 0.371361343285068 | epot = -15.2994647831647 | etot = -14.6249037422494 +528000 ekin = 0.296802852838113 | erot = 0.38407297047912 | epot = -15.3057795655799 | etot = -14.6249037422627 +529000 ekin = 0.290839689447243 | erot = 0.397128838352394 | epot = -15.31287227009 | etot = -14.6249037422904 +530000 ekin = 0.285110822260533 | erot = 0.410322608856898 | epot = -15.3203371734496 | etot = -14.6249037423322 +531000 ekin = 0.279260366287321 | erot = 0.423400398731777 | epot = -15.3275645074024 | etot = -14.6249037423833 +532000 ekin = 0.2728357059054 | erot = 0.436076588369062 | epot = -15.3338160367096 | etot = -14.6249037424351 +533000 ekin = 0.265395406955423 | erot = 0.448061330488706 | epot = -15.3383604799205 | etot = -14.6249037424763 +534000 ekin = 0.25664035180014 | erot = 0.45909504502717 | epot = -15.3406391393241 | etot = -14.6249037424968 +535000 ekin = 0.24653363369425 | erot = 0.468982742180589 | epot = -15.3404201183648 | etot = -14.62490374249 +536000 ekin = 0.235373881374767 | erot = 0.477620282696299 | epot = -15.3378979065254 | etot = -14.6249037424543 +537000 ekin = 0.223795203401825 | erot = 0.485006039595742 | epot = -15.3337049853926 | etot = -14.624903742395 +538000 ekin = 0.212682661997717 | erot = 0.491234540507922 | epot = -15.32882094483 | etot = -14.6249037423243 +539000 ekin = 0.203011536568094 | erot = 0.496472671628212 | epot = -15.324387950454 | etot = -14.6249037422577 +540000 ekin = 0.195638496925756 | erot = 0.500922912276288 | epot = -15.3214651514142 | etot = -14.6249037422122 +541000 ekin = 0.191090437373868 | erot = 0.504781043299473 | epot = -15.3207752228743 | etot = -14.624903742201 +542000 ekin = 0.189407567632351 | erot = 0.508197267609666 | epot = -15.3225085774711 | etot = -14.6249037422291 +543000 ekin = 0.190094034780963 | erot = 0.511249275631094 | epot = -15.3262470527038 | etot = -14.6249037422917 +544000 ekin = 0.192205662500001 | erot = 0.513933300996131 | epot = -15.3310427058706 | etot = -14.6249037423745 +545000 ekin = 0.194562943958398 | erot = 0.516174993404786 | epot = -15.3356416798198 | etot = -14.6249037424566 +546000 ekin = 0.196033343259865 | erot = 0.517857026727595 | epot = -15.3387941125054 | etot = -14.624903742518 +547000 ekin = 0.195801439086576 | erot = 0.518856237019659 | epot = -15.3395614186507 | etot = -14.6249037425445 +548000 ekin = 0.193552178457624 | erot = 0.519081068513043 | epot = -15.3375369895016 | etot = -14.6249037425309 +549000 ekin = 0.189527872077782 | erot = 0.518500763845595 | epot = -15.3329323784042 | etot = -14.6249037424808 +550000 ekin = 0.18446469719282 | erot = 0.517160608016848 | epot = -15.326529047614 | etot = -14.6249037424043 +551000 ekin = 0.17944751961377 | erot = 0.515181377053922 | epot = -15.3195326389815 | etot = -14.6249037423138 +552000 ekin = 0.175731062295071 | erot = 0.512744588095586 | epot = -15.3133793926126 | etot = -14.6249037422219 +553000 ekin = 0.174564310046339 | erot = 0.510067400325356 | epot = -15.3095354525118 | etot = -14.6249037421401 +554000 ekin = 0.177036897101121 | erot = 0.507372062614127 | epot = -15.309312701793 | etot = -14.6249037420777 +555000 ekin = 0.183953653121541 | erot = 0.50485506124058 | epot = -15.3137124564044 | etot = -14.6249037420423 +556000 ekin = 0.195740677804154 | erot = 0.502660902828886 | epot = -15.3233053226714 | etot = -14.6249037420384 +557000 ekin = 0.212389174813395 | erot = 0.500864749566249 | epot = -15.3381576664467 | etot = -14.6249037420671 +558000 ekin = 0.233445020972978 | erot = 0.499466731744177 | epot = -15.3578154948427 | etot = -14.6249037421256 +559000 ekin = 0.258048678278145 | erot = 0.498398734229532 | epot = -15.381351154715 | etot = -14.6249037422073 +560000 ekin = 0.285022157939727 | erot = 0.497541950864641 | epot = -15.4074678511075 | etot = -14.6249037423031 +561000 ekin = 0.312990622171893 | erot = 0.496751658908829 | epot = -15.4346460234834 | etot = -14.6249037424027 +562000 ekin = 0.340519848730057 | erot = 0.495884310852853 | epot = -15.461307902079 | etot = -14.6249037424961 +563000 ekin = 0.366249237356341 | erot = 0.494821962715706 | epot = -15.4859749426471 | etot = -14.6249037425751 +564000 ekin = 0.389003340228864 | erot = 0.493490109026347 | epot = -15.5073971918896 | etot = -14.6249037426344 +565000 ekin = 0.407871381975787 | erot = 0.491866632343088 | epot = -15.5246417569901 | etot = -14.6249037426712 +566000 ekin = 0.422251605413063 | erot = 0.489981232303539 | epot = -15.537136580402 | etot = -14.6249037426854 +567000 ekin = 0.431863045464991 | erot = 0.487906470955931 | epot = -15.5446732590994 | etot = -14.6249037426785 +568000 ekin = 0.436733840918529 | erot = 0.485743252286281 | epot = -15.5473808358582 | etot = -14.6249037426534 +569000 ekin = 0.437172173179269 | erot = 0.483603786385196 | epot = -15.5456797021777 | etot = -14.6249037426133 +570000 ekin = 0.43372713864672 | erot = 0.48159597879343 | epot = -15.5402268600018 | etot = -14.6249037425617 +571000 ekin = 0.42714180814445 | erot = 0.479812578148079 | epot = -15.5318581287948 | etot = -14.6249037425023 +572000 ekin = 0.418294466662065 | erot = 0.478326721683348 | epot = -15.5215249307851 | etot = -14.6249037424397 +573000 ekin = 0.408121101336508 | erot = 0.477193277919927 | epot = -15.5102181216365 | etot = -14.6249037423801 +574000 ekin = 0.397514818218918 | erot = 0.476453234966625 | epot = -15.4988717955165 | etot = -14.624903742331 +575000 ekin = 0.387207144490505 | erot = 0.476137354469736 | epot = -15.4882482412605 | etot = -14.6249037423002 +576000 ekin = 0.377649119218454 | erot = 0.476266044932873 | epot = -15.4788189064457 | etot = -14.6249037422944 +577000 ekin = 0.368920817133122 | erot = 0.476844730976094 | epot = -15.4706692904255 | etot = -14.6249037423163 +578000 ekin = 0.360700785231361 | erot = 0.47785688313413 | epot = -15.4634614107286 | etot = -14.6249037423631 +579000 ekin = 0.352319179858645 | erot = 0.479258927576455 | epot = -15.4564818498607 | etot = -14.6249037424256 +580000 ekin = 0.342901425190256 | erot = 0.480981430412058 | epot = -15.4487865980916 | etot = -14.6249037424893 +581000 ekin = 0.331586894252413 | erot = 0.482939076923234 | epot = -15.4394297137118 | etot = -14.6249037425361 +582000 ekin = 0.317784488003658 | erot = 0.485048781538909 | epot = -15.427737012092 | etot = -14.6249037425495 +583000 ekin = 0.301409490235786 | erot = 0.487252029394123 | epot = -15.4135652621474 | etot = -14.6249037425175 +584000 ekin = 0.283039202393456 | erot = 0.489535511255409 | epot = -15.3974784560865 | etot = -14.6249037424376 +585000 ekin = 0.263933313486932 | erot = 0.491944128119358 | epot = -15.3807811839248 | etot = -14.6249037423185 +586000 ekin = 0.245890887800014 | erot = 0.494582820570716 | epot = -15.36537745055 | etot = -14.6249037421793 +587000 ekin = 0.230956405619767 | erot = 0.497607010278002 | epot = -15.3534671579441 | etot = -14.6249037420464 +588000 ekin = 0.221033841917334 | erot = 0.501205839010304 | epot = -15.3471434228726 | etot = -14.6249037419449 +589000 ekin = 0.217504428503198 | erot = 0.505584588307916 | epot = -15.3479927587054 | etot = -14.6249037418943 +590000 ekin = 0.220953423088802 | erot = 0.510952138425678 | epot = -15.3568093034149 | etot = -14.6249037419004 +591000 ekin = 0.231083134064877 | erot = 0.517515644130037 | epot = -15.3735025201503 | etot = -14.6249037419554 +592000 ekin = 0.246829245753809 | erot = 0.525479282586983 | epot = -15.3972122703829 | etot = -14.6249037420421 +593000 ekin = 0.266628949730648 | erot = 0.535039778666154 | epot = -15.4265724705373 | etot = -14.6249037421405 +594000 ekin = 0.288743434935948 | erot = 0.546371032865159 | epot = -15.4600182100359 | etot = -14.6249037422348 +595000 ekin = 0.311533695301854 | erot = 0.559594229359111 | epot = -15.4960316669784 | etot = -14.6249037423174 +596000 ekin = 0.333624348261494 | erot = 0.574736425374244 | epot = -15.5332645160249 | etot = -14.6249037423892 +597000 ekin = 0.353943370598259 | erot = 0.591686591895167 | epot = -15.5705337049495 | etot = -14.6249037424561 +598000 ekin = 0.371670846224399 | erot = 0.610160828223706 | epot = -15.6067354169733 | etot = -14.6249037425252 +599000 ekin = 0.386151688530232 | erot = 0.629687420924543 | epot = -15.6407428520551 | etot = -14.6249037426004 +600000 ekin = 0.396824670884392 | erot = 0.649618644309618 | epot = -15.6713470578743 | etot = -14.6249037426803 +601000 ekin = 0.403202067553724 | erot = 0.669171693344937 | epot = -15.6972775036568 | etot = -14.6249037427581 +602000 ekin = 0.404908528299605 | erot = 0.687495721385225 | epot = -15.7173079925077 | etot = -14.6249037428229 +603000 ekin = 0.401765041348441 | erot = 0.703757265562351 | epot = -15.7304260497729 | etot = -14.6249037428621 +604000 ekin = 0.393886240081566 | erot = 0.717231476889447 | epot = -15.7360214598369 | etot = -14.6249037428659 +605000 ekin = 0.381750384954784 | erot = 0.727382711583162 | epot = -15.7340368393681 | etot = -14.6249037428302 +606000 ekin = 0.366205114567235 | erot = 0.733917584159895 | epot = -15.725026441486 | etot = -14.6249037427589 +607000 ekin = 0.348389460815329 | erot = 0.736798185090343 | epot = -15.7100913885696 | etot = -14.624903742664 +608000 ekin = 0.329579787369629 | erot = 0.73621262347853 | epot = -15.6906961534103 | etot = -14.6249037425622 +609000 ekin = 0.310994196072014 | erot = 0.732511274794253 | epot = -15.6684092133371 | etot = -14.6249037424709 +610000 ekin = 0.29360483588481 | erot = 0.726125549058504 | epot = -15.644634127347 | etot = -14.6249037424037 +611000 ekin = 0.278004208602607 | erot = 0.717488389874772 | epot = -15.6203963408453 | etot = -14.624903742368 +612000 ekin = 0.264353214553523 | erot = 0.706972008379557 | epot = -15.5962289652967 | etot = -14.6249037423637 +613000 ekin = 0.252415280668682 | erot = 0.694851301360247 | epot = -15.5721703244136 | etot = -14.6249037423847 +614000 ekin = 0.241662201717183 | erot = 0.681294462599197 | epot = -15.5478604067366 | etot = -14.6249037424202 +615000 ekin = 0.231427318529533 | erot = 0.666377599991891 | epot = -15.5227086609789 | etot = -14.6249037424574 +616000 ekin = 0.221078258759054 | erot = 0.650117838828839 | epot = -15.496099840071 | etot = -14.6249037424831 +617000 ekin = 0.21018039046722 | erot = 0.632518274251072 | epot = -15.4676024072045 | etot = -14.6249037424862 +618000 ekin = 0.198621509656023 | erot = 0.613617132100535 | epot = -15.4371423842165 | etot = -14.6249037424599 +619000 ekin = 0.18667044221321 | erot = 0.593532504056809 | epot = -15.405106688674 | etot = -14.624903742404 +620000 ekin = 0.174951539061334 | erot = 0.572493952083576 | epot = -15.3723492334691 | etot = -14.6249037423242 +621000 ekin = 0.164335257151748 | erot = 0.550854196820334 | epot = -15.3400931962044 | etot = -14.6249037422324 +622000 ekin = 0.155768039681223 | erot = 0.529078173717901 | epot = -15.3097499555421 | etot = -14.6249037421429 +623000 ekin = 0.150083571178067 | erot = 0.507711807337581 | epot = -15.2826991205843 | etot = -14.6249037420687 +624000 ekin = 0.147843467415026 | erot = 0.487337070698877 | epot = -15.2600842801327 | etot = -14.6249037420188 +625000 ekin = 0.149245521580685 | erot = 0.468521842126521 | epot = -15.2426711057039 | etot = -14.6249037419967 +626000 ekin = 0.154116108891011 | erot = 0.451772481731706 | epot = -15.230792332623 | etot = -14.6249037420003 +627000 ekin = 0.161979086426243 | erot = 0.437494698740521 | epot = -15.2243775271906 | etot = -14.6249037420239 +628000 ekin = 0.172174902879429 | erot = 0.425965324893993 | epot = -15.2230439698331 | etot = -14.6249037420597 +629000 ekin = 0.183995029152745 | erot = 0.417314987668754 | epot = -15.2262137589225 | etot = -14.624903742101 +630000 ekin = 0.196798066695247 | erot = 0.411519917957055 | epot = -15.2332217267955 | etot = -14.6249037421432 +631000 ekin = 0.210082131922237 | erot = 0.408400457424511 | epot = -15.2433863315318 | etot = -14.6249037421851 +632000 ekin = 0.223500184826661 | erot = 0.407624312389748 | epot = -15.2560282394451 | etot = -14.6249037422287 +633000 ekin = 0.236818662197368 | erot = 0.40871410814115 | epot = -15.2704365126172 | etot = -14.6249037422787 +634000 ekin = 0.249833574953511 | erot = 0.411060882467202 | epot = -15.2857981997609 | etot = -14.6249037423402 +635000 ekin = 0.262270239999869 | erot = 0.413946987960319 | epot = -15.3011209703766 | etot = -14.6249037424164 +636000 ekin = 0.273700147362094 | erot = 0.41658241201687 | epot = -15.3151863018853 | etot = -14.6249037425063 +637000 ekin = 0.283507856899951 | erot = 0.418156955202178 | epot = -15.3265685547055 | etot = -14.6249037426034 +638000 ekin = 0.290930324554581 | erot = 0.417906927432974 | epot = -15.3337409946828 | etot = -14.6249037426952 +639000 ekin = 0.295171730169445 | erot = 0.415189912095163 | epot = -15.3352653850311 | etot = -14.6249037427665 +640000 ekin = 0.295573453214757 | erot = 0.409556450349425 | epot = -15.330033646366 | etot = -14.6249037428018 +641000 ekin = 0.291798784614159 | erot = 0.400805216305592 | epot = -15.3175077437094 | etot = -14.6249037427896 +642000 ekin = 0.283982821763191 | erot = 0.389009767281871 | epot = -15.2978963317709 | etot = -14.6249037427259 +643000 ekin = 0.272803834295014 | erot = 0.374510198235057 | epot = -15.2722177751454 | etot = -14.6249037426153 +644000 ekin = 0.259451287281783 | erot = 0.357870303235152 | epot = -15.242225332988 | etot = -14.6249037424711 +645000 ekin = 0.245490538509252 | erot = 0.339807577758131 | epot = -15.2102018585797 | etot = -14.6249037423123 +646000 ekin = 0.232646751226996 | erot = 0.321107525182603 | epot = -15.1786580185706 | etot = -14.624903742161 +647000 ekin = 0.22254581022401 | erot = 0.302534738054871 | epot = -15.1499842903174 | etot = -14.6249037420385 +648000 ekin = 0.216457466201459 | erot = 0.284752019408104 | epot = -15.1261132275716 | etot = -14.624903741962 +649000 ekin = 0.215087078764693 | erot = 0.268256849270417 | epot = -15.1082476699768 | etot = -14.6249037419417 +650000 ekin = 0.218457489209268 | erot = 0.253342374384922 | epot = -15.0967036055725 | etot = -14.6249037419783 +651000 ekin = 0.225910420497663 | erot = 0.240087663214968 | epot = -15.090901825775 | etot = -14.6249037420623 +652000 ekin = 0.236236377394858 | erot = 0.228379019530766 | epot = -15.0895191391013 | etot = -14.6249037421757 +653000 ekin = 0.247915496412395 | erot = 0.217959688822015 | epot = -15.0907789275287 | etot = -14.6249037422943 +654000 ekin = 0.259425494352476 | erot = 0.208500305716241 | epot = -15.0928295424619 | etot = -14.6249037423932 +655000 ekin = 0.26955455820855 | erot = 0.199677958220202 | epot = -15.0941362588805 | etot = -14.6249037424517 +656000 ekin = 0.277652649609351 | erot = 0.191249336850371 | epot = -15.0938057289177 | etot = -14.624903742458 +657000 ekin = 0.283765747905513 | erot = 0.183104207684416 | epot = -15.0917736980008 | etot = -14.6249037424109 +658000 ekin = 0.288620908153495 | erot = 0.175289536735997 | epot = -15.0888141872111 | etot = -14.6249037423216 +659000 ekin = 0.293459924910638 | erot = 0.168001027405567 | epot = -15.0863646945267 | etot = -14.6249037422105 +660000 ekin = 0.299750121924058 | erot = 0.16154591329551 | epot = -15.0861997773236 | etot = -14.624903742104 +661000 ekin = 0.30882794580118 | erot = 0.15628680849445 | epot = -15.0900184963236 | etot = -14.624903742028 +662000 ekin = 0.321550844182007 | erot = 0.152579955314563 | epot = -15.0990345414996 | etot = -14.624903742003 +663000 ekin = 0.338040404322879 | erot = 0.150721656676574 | epot = -15.1136658030369 | etot = -14.6249037420375 +664000 ekin = 0.357588696379433 | erot = 0.150913925254324 | epot = -15.1334063637592 | etot = -14.6249037421255 +665000 ekin = 0.378766116435926 | erot = 0.153254852725576 | epot = -15.1569247114086 | etot = -14.6249037422471 +666000 ekin = 0.399716130930416 | erot = 0.157752003176736 | epot = -15.1823718764813 | etot = -14.6249037423741 +667000 ekin = 0.418564373573455 | erot = 0.164350192887448 | epot = -15.2078183089391 | etot = -14.6249037424782 +668000 ekin = 0.433827740573898 | erot = 0.172960630436554 | epot = -15.2316921135493 | etot = -14.6249037425388 +669000 ekin = 0.444701001629873 | erot = 0.183478145302767 | epot = -15.2530828894839 | etot = -14.6249037425513 +670000 ekin = 0.451136418416049 | erot = 0.195778468141822 | epot = -15.2718186290842 | etot = -14.6249037425263 +671000 ekin = 0.453701004148981 | erot = 0.209695862328768 | epot = -15.2883006089635 | etot = -14.6249037424857 +672000 ekin = 0.453273827001077 | erot = 0.224990306458558 | epot = -15.3031678759134 | etot = -14.6249037424538 +673000 ekin = 0.450699702661522 | erot = 0.241319095058617 | epot = -15.3169225401686 | etot = -14.6249037424485 +674000 ekin = 0.446523488450417 | erot = 0.258227823778676 | epot = -15.3296550547043 | etot = -14.6249037424752 +675000 ekin = 0.44088962459253 | erot = 0.275170305159689 | epot = -15.3409636722772 | etot = -14.624903742525 +676000 ekin = 0.433624481153454 | erot = 0.291558306506453 | epot = -15.350086530239 | etot = -14.6249037425791 +677000 ekin = 0.424453634856828 | erot = 0.306833290383679 | epot = -15.3561906678562 | etot = -14.6249037426157 +678000 ekin = 0.41326517646593 | erot = 0.320546114279227 | epot = -15.3587150333616 | etot = -14.6249037426165 +679000 ekin = 0.400321537247193 | erot = 0.332428088763687 | epot = -15.3576533685842 | etot = -14.6249037425733 +680000 ekin = 0.386341988793522 | erot = 0.342437977068841 | epot = -15.3536837083529 | etot = -14.6249037424906 +681000 ekin = 0.372417408219175 | erot = 0.350774050474234 | epot = -15.3480952010788 | etot = -14.6249037423854 +682000 ekin = 0.35976964508921 | erot = 0.357847594354926 | epot = -15.342520981727 | etot = -14.6249037422829 +683000 ekin = 0.349419724484302 | erot = 0.364223142873746 | epot = -15.3385466095668 | etot = -14.6249037422088 +684000 ekin = 0.341867426589136 | erot = 0.370539083005818 | epot = -15.3373102517758 | etot = -14.6249037421809 +685000 ekin = 0.336892967752833 | erot = 0.37742728588017 | epot = -15.3392239958362 | etot = -14.6249037422032 +686000 ekin = 0.333560575456658 | erot = 0.385449795148896 | epot = -15.343914112869 | etot = -14.6249037422634 +687000 ekin = 0.330440845244727 | erot = 0.395064019974615 | epot = -15.3504086075565 | etot = -14.6249037423372 +688000 ekin = 0.325996654362847 | erot = 0.406617593545496 | epot = -15.3575179903034 | etot = -14.624903742395 +689000 ekin = 0.319023752377333 | erot = 0.420363991129467 | epot = -15.3642914859188 | etot = -14.624903742412 +690000 ekin = 0.309020969988424 | erot = 0.436483939357874 | epot = -15.3704086517213 | etot = -14.624903742375 +691000 ekin = 0.296388973948975 | erot = 0.455097572739774 | epot = -15.3763902889748 | etot = -14.6249037422861 +692000 ekin = 0.282408410636019 | erot = 0.476257707732204 | epot = -15.3835698605304 | etot = -14.6249037421622 +693000 ekin = 0.269008530851688 | erot = 0.499923033173812 | epot = -15.393835306056 | etot = -14.6249037420305 +694000 ekin = 0.258387685788622 | erot = 0.525918285140571 | epot = -15.4092097128506 | etot = -14.6249037419214 +695000 ekin = 0.25257627520821 | erot = 0.553894058809888 | epot = -15.43137407588 | etot = -14.6249037418619 +696000 ekin = 0.253038186235009 | erot = 0.583300660396584 | epot = -15.4612425885012 | etot = -14.6249037418696 +697000 ekin = 0.260392018277579 | erot = 0.613388418368988 | epot = -15.4986841785954 | etot = -14.6249037419489 +698000 ekin = 0.274304391463509 | erot = 0.64324187918294 | epot = -15.5424500127365 | etot = -14.6249037420901 +699000 ekin = 0.293570250406769 | erot = 0.671848180609457 | epot = -15.5903221732877 | etot = -14.6249037422715 +700000 ekin = 0.316355070233514 | erot = 0.698191700483047 | epot = -15.639450513181 | etot = -14.6249037424644 +701000 ekin = 0.340538337282332 | erot = 0.721359481466447 | epot = -15.6868015613885 | etot = -14.6249037426397 +702000 ekin = 0.364075443764615 | erot = 0.740637254695032 | epot = -15.7296164412337 | etot = -14.6249037427741 +703000 ekin = 0.385294321874606 | erot = 0.75557636945477 | epot = -15.7657744341848 | etot = -14.6249037428555 +704000 ekin = 0.40306671671928 | erot = 0.766018576887906 | epot = -15.7939890364911 | etot = -14.6249037428839 +705000 ekin = 0.416833588997184 | erot = 0.772075474100319 | epot = -15.8138128059668 | etot = -14.6249037428693 +706000 ekin = 0.426510451501955 | erot = 0.774072055032491 | epot = -15.8254862493611 | etot = -14.6249037428266 +707000 ekin = 0.432328070473605 | erot = 0.772470813770598 | epot = -15.8297026270152 | etot = -14.624903742771 +708000 ekin = 0.434671210546145 | erot = 0.767794279505844 | epot = -15.8273692327653 | etot = -14.6249037427133 +709000 ekin = 0.433963855683832 | erot = 0.760560754832635 | epot = -15.8194283531753 | etot = -14.6249037426588 +710000 ekin = 0.430621214402396 | erot = 0.751241421805773 | epot = -15.8067663788157 | etot = -14.6249037426076 +711000 ekin = 0.42506102881634 | erot = 0.740240555545717 | epot = -15.7902053269187 | etot = -14.6249037425567 +712000 ekin = 0.417748693286703 | erot = 0.727895913280697 | epot = -15.7705483490698 | etot = -14.6249037425024 +713000 ekin = 0.409245407745788 | erot = 0.714493617369859 | epot = -15.7486427675576 | etot = -14.624903742442 +714000 ekin = 0.400233112897398 | erot = 0.700290376394005 | epot = -15.7254272316667 | etot = -14.6249037423753 +715000 ekin = 0.391499218630518 | erot = 0.685535269234734 | epot = -15.7019382301705 | etot = -14.6249037423053 +716000 ekin = 0.383874653287396 | erot = 0.67048382480872 | epot = -15.6792622203348 | etot = -14.6249037422387 +717000 ekin = 0.378129665172728 | erot = 0.655399296057203 | epot = -15.6584327034143 | etot = -14.6249037421843 +718000 ekin = 0.374843116814185 | erot = 0.640539821856989 | epot = -15.640286680823 | etot = -14.6249037421519 +719000 ekin = 0.374271424141624 | erot = 0.626134666228549 | epot = -15.6253098325193 | etot = -14.6249037421492 +720000 ekin = 0.376249546442097 | erot = 0.612356169201246 | epot = -15.6135094578233 | etot = -14.62490374218 +721000 ekin = 0.380155783156075 | erot = 0.599295758360148 | epot = -15.6043552837583 | etot = -14.6249037422421 +722000 ekin = 0.38496276143876 | erot = 0.586951574249477 | epot = -15.5968180780148 | etot = -14.6249037423265 +723000 ekin = 0.389379823381561 | erot = 0.57523200329734 | epot = -15.5895155690971 | etot = -14.6249037424182 +724000 ekin = 0.392071125783968 | erot = 0.563975606696704 | epot = -15.5809504749797 | etot = -14.624903742499 +725000 ekin = 0.391913283458913 | erot = 0.552983740178136 | epot = -15.5698007661881 | etot = -14.624903742551 +726000 ekin = 0.388241956532947 | erot = 0.542058916015296 | epot = -15.5552046151089 | etot = -14.6249037425607 +727000 ekin = 0.381032991792247 | erot = 0.531040454531364 | epot = -15.5369771888453 | etot = -14.6249037425217 +728000 ekin = 0.370971903191936 | erot = 0.51982908237483 | epot = -15.5157047280045 | etot = -14.6249037424377 +729000 ekin = 0.359388263612697 | erot = 0.508395729808055 | epot = -15.4926877357429 | etot = -14.6249037423222 +730000 ekin = 0.348057580439693 | erot = 0.496773021024349 | epot = -15.4697343436589 | etot = -14.6249037421949 +731000 ekin = 0.338902689199426 | erot = 0.48503267140759 | epot = -15.4488391026866 | etot = -14.6249037420796 +732000 ekin = 0.333649662945475 | erot = 0.473255762296962 | epot = -15.4318091672413 | etot = -14.6249037419988 +733000 ekin = 0.333505576676606 | erot = 0.461504910073432 | epot = -15.4199142287184 | etot = -14.6249037419684 +734000 ekin = 0.338924758984327 | erot = 0.449807254483215 | epot = -15.4136357554618 | etot = -14.6249037419943 +735000 ekin = 0.349515468577354 | erot = 0.438154711902627 | epot = -15.412573922551 | etot = -14.624903742071 +736000 ekin = 0.364111355274983 | erot = 0.426523255164317 | epot = -15.4155383526214 | etot = -14.6249037421821 +737000 ekin = 0.380995719774913 | erot = 0.414906900972836 | epot = -15.4208063630518 | etot = -14.6249037423041 +738000 ekin = 0.398229414671756 | erot = 0.403356227833025 | epot = -15.4264893849167 | etot = -14.6249037424119 +739000 ekin = 0.41400586007365 | erot = 0.392007798568608 | epot = -15.4309174011284 | etot = -14.6249037424862 +740000 ekin = 0.426948743963044 | erot = 0.381091720704502 | epot = -15.4329442071847 | etot = -14.6249037425172 +741000 ekin = 0.436283647683231 | erot = 0.370910229391922 | epot = -15.4320976195822 | etot = -14.6249037425071 +742000 ekin = 0.441850001827036 | erot = 0.361789064611271 | epot = -15.4285428089074 | etot = -14.6249037424691 +743000 ekin = 0.443963491147379 | erot = 0.354012421291793 | epot = -15.4228796548618 | etot = -14.6249037424227 +744000 ekin = 0.443178108515845 | erot = 0.347758127978261 | epot = -15.4158399788819 | etot = -14.6249037423878 +745000 ekin = 0.440021184885117 | erot = 0.343050543545259 | epot = -15.4079754708099 | etot = -14.6249037423795 +746000 ekin = 0.434779146250806 | erot = 0.339744491074207 | epot = -15.3994273797282 | etot = -14.6249037424032 +747000 ekin = 0.427396883605164 | erot = 0.337545938413876 | epot = -15.3898465644715 | etot = -14.6249037424524 +748000 ekin = 0.417523045840964 | erot = 0.336066252171354 | epot = -15.378493040523 | etot = -14.6249037425106 +749000 ekin = 0.404692764111769 | erot = 0.334898725161342 | epot = -15.3644952318284 | etot = -14.6249037425553 +750000 ekin = 0.38859628761696 | erot = 0.333700338300268 | epot = -15.3472003684814 | etot = -14.6249037425641 +751000 ekin = 0.369348367994352 | erot = 0.332259621152217 | epot = -15.3265117316697 | etot = -14.6249037425232 +752000 ekin = 0.347662572337044 | erot = 0.330533807749388 | epot = -15.3031001225185 | etot = -14.6249037424321 +753000 ekin = 0.32485637347094 | erot = 0.328645172901279 | epot = -15.2784052886778 | etot = -14.6249037423055 +754000 ekin = 0.302664104351826 | erot = 0.326836116135493 | epot = -15.2544039626575 | etot = -14.6249037421702 +755000 ekin = 0.282898405306331 | erot = 0.32539267738901 | epot = -15.2331948247533 | etot = -14.6249037420579 +756000 ekin = 0.267052130149665 | erot = 0.324553861438981 | epot = -15.216509733585 | etot = -14.6249037419963 +757000 ekin = 0.255952872034765 | erot = 0.32442748097694 | epot = -15.2052840950137 | etot = -14.624903742002 +758000 ekin = 0.24956686325818 | erot = 0.324931841855881 | epot = -15.1994024471896 | etot = -14.6249037420755 +759000 ekin = 0.247007285742243 | erot = 0.325777353497121 | epot = -15.1976883814409 | etot = -14.6249037422016 +760000 ekin = 0.246749335490674 | erot = 0.326494279608963 | epot = -15.1981473574513 | etot = -14.6249037423517 +761000 ekin = 0.247004464362755 | erot = 0.32650345690093 | epot = -15.1984116637543 | etot = -14.6249037424906 +762000 ekin = 0.246168267682973 | erot = 0.325217160867496 | epot = -15.196289171135 | etot = -14.6249037425846 +763000 ekin = 0.243236270174414 | erot = 0.32214932288445 | epot = -15.1902893356681 | etot = -14.6249037426092 +764000 ekin = 0.238083572627797 | erot = 0.31701054114624 | epot = -15.1799978563308 | etot = -14.6249037425568 +765000 ekin = 0.231530329805837 | erot = 0.309765883620828 | epot = -15.1661999558649 | etot = -14.6249037424383 +766000 ekin = 0.225163449189513 | erot = 0.300642577937803 | epot = -15.1507097694085 | etot = -14.6249037422812 +767000 ekin = 0.22094703764136 | erot = 0.290087936283322 | epot = -15.1359387160482 | etot = -14.6249037421235 +768000 ekin = 0.220714417705591 | erot = 0.278690999515505 | epot = -15.1243091592243 | etot = -14.6249037420032 +769000 ekin = 0.225674230585282 | erot = 0.267090069999639 | epot = -15.1176680425329 | etot = -14.6249037419479 +770000 ekin = 0.236066860406118 | erot = 0.255889903618327 | epot = -15.1168605059916 | etot = -14.6249037419672 +771000 ekin = 0.251070223471381 | erot = 0.245606888556436 | epot = -15.1215808540782 | etot = -14.6249037420503 +772000 ekin = 0.268985032795184 | erot = 0.236650197272858 | epot = -15.130538972238 | etot = -14.6249037421699 +773000 ekin = 0.287649902236207 | erot = 0.229335047808925 | epot = -15.1418886923348 | etot = -14.6249037422896 +774000 ekin = 0.304971347443521 | erot = 0.223914516380439 | epot = -15.1537896061995 | etot = -14.6249037423755 +775000 ekin = 0.319422560281353 | erot = 0.220611402282044 | epot = -15.1649377049685 | etot = -14.6249037424051 +776000 ekin = 0.330375903029014 | erot = 0.219632840721417 | epot = -15.1749124861243 | etot = -14.6249037423739 +777000 ekin = 0.338182326481318 | erot = 0.221157252264488 | epot = -15.1842433210425 | etot = -14.6249037422967 +778000 ekin = 0.34398099350531 | erot = 0.22529363977163 | epot = -15.1941783754801 | etot = -14.6249037422031 +779000 ekin = 0.349294202147492 | erot = 0.232023926337254 | epot = -15.2062218706139 | etot = -14.6249037421291 +780000 ekin = 0.355517983707864 | erot = 0.241146781675322 | epot = -15.2215685074905 | etot = -14.6249037421074 +781000 ekin = 0.36344584750217 | erot = 0.25224414994015 | epot = -15.2405937395998 | etot = -14.6249037421575 +782000 ekin = 0.372957766808887 | erot = 0.264688770758124 | epot = -15.2625502798461 | etot = -14.6249037422791 +783000 ekin = 0.38296926774882 | erot = 0.277702579812121 | epot = -15.2855755900113 | etot = -14.6249037424504 +784000 ekin = 0.391670514066059 | erot = 0.290462881206425 | epot = -15.3070371379046 | etot = -14.6249037426321 +785000 ekin = 0.397003136152363 | erot = 0.302237882822127 | epot = -15.3241447617524 | etot = -14.6249037427779 +786000 ekin = 0.397244540913185 | erot = 0.312520082335045 | epot = -15.3346683660963 | etot = -14.6249037428481 +787000 ekin = 0.391525061079143 | erot = 0.321121025638669 | epot = -15.33754982954 | etot = -14.6249037428222 +788000 ekin = 0.380116514494114 | erot = 0.328198366844194 | epot = -15.3332186240437 | etot = -14.6249037427054 +789000 ekin = 0.364402868102804 | erot = 0.334204933643257 | epot = -15.323511544273 | etot = -14.6249037425269 +790000 ekin = 0.346547882835914 | erot = 0.339772664564402 | epot = -15.3112242897307 | etot = -14.6249037423304 +791000 ekin = 0.328969533926533 | erot = 0.345562661329726 | epot = -15.2994359374168 | etot = -14.6249037421606 +792000 ekin = 0.313783234687151 | erot = 0.352120250332853 | epot = -15.290807227072 | etot = -14.624903742052 +793000 ekin = 0.302371973145348 | erot = 0.359769001653092 | epot = -15.2870447168183 | etot = -14.6249037420198 +794000 ekin = 0.295192752069156 | erot = 0.368565036951925 | epot = -15.2886615310787 | etot = -14.6249037420576 +795000 ekin = 0.291854072001083 | erot = 0.378316728407065 | epot = -15.2950745425492 | etot = -14.624903742141 +796000 ekin = 0.291420477240231 | erot = 0.388659220599418 | epot = -15.3049834400759 | etot = -14.6249037422363 +797000 ekin = 0.292835767594049 | erot = 0.399160677915359 | epot = -15.3169001878201 | etot = -14.6249037423107 +798000 ekin = 0.295321690655136 | erot = 0.40942991973209 | epot = -15.3296553527312 | etot = -14.624903742344 +799000 ekin = 0.298615606685619 | erot = 0.419195269464138 | epot = -15.3427146184843 | etot = -14.6249037423346 +800000 ekin = 0.302963113079283 | erot = 0.428333265393292 | epot = -15.3562001207729 | etot = -14.6249037423003 +801000 ekin = 0.308869807419017 | erot = 0.436842111958073 | epot = -15.3706156616482 | etot = -14.6249037422711 +802000 ekin = 0.316711643346418 | erot = 0.444773620895252 | epot = -15.3863890065178 | etot = -14.6249037422762 +803000 ekin = 0.326365730602249 | erot = 0.452151664704984 | epot = -15.403421137639 | etot = -14.6249037423317 +804000 ekin = 0.337019280358016 | erot = 0.458909057451227 | epot = -15.4208320802433 | etot = -14.6249037424341 +805000 ekin = 0.347244531512768 | erot = 0.464865921886024 | epot = -15.4370141959588 | etot = -14.62490374256 +806000 ekin = 0.355321558015419 | erot = 0.469755825324061 | epot = -15.449981126015 | etot = -14.6249037426755 +807000 ekin = 0.359699244804511 | erot = 0.473288399899576 | epot = -15.457891387451 | etot = -14.6249037427469 +808000 ekin = 0.35944291943687 | erot = 0.475225772200724 | epot = -15.4595724343888 | etot = -14.6249037427512 +809000 ekin = 0.354532149711152 | erot = 0.475448148012716 | epot = -15.4548840404063 | etot = -14.6249037426824 +810000 ekin = 0.34592712151575 | erot = 0.473990365430488 | epot = -15.4448212294989 | etot = -14.6249037425527 +811000 ekin = 0.335391497319932 | erot = 0.47104235524006 | epot = -15.4313375949483 | etot = -14.6249037423883 +812000 ekin = 0.325122479809716 | erot = 0.466917662640269 | epot = -15.4169438846729 | etot = -14.624903742223 +813000 ekin = 0.317281832618796 | erot = 0.462001954841414 | epot = -15.4041875295496 | etot = -14.6249037420894 +814000 ekin = 0.313538689251802 | erot = 0.456696276151744 | epot = -15.3951387074161 | etot = -14.6249037420126 +815000 ekin = 0.314725301427551 | erot = 0.451368238943745 | epot = -15.3909972823755 | etot = -14.6249037420042 +816000 ekin = 0.320674745952841 | erot = 0.446320054204994 | epot = -15.3918985422197 | etot = -14.6249037420619 +817000 ekin = 0.330264402530169 | erot = 0.441777145070237 | epot = -15.3969452897705 | etot = -14.6249037421701 +818000 ekin = 0.341643112116294 | erot = 0.437896324121931 | epot = -15.4044431785426 | etot = -14.6249037423044 +819000 ekin = 0.352584467965985 | erot = 0.434788688971306 | epot = -15.4122768993744 | etot = -14.6249037424371 +820000 ekin = 0.360890006680584 | erot = 0.432549774287109 | epot = -15.4183435235104 | etot = -14.6249037425427 +821000 ekin = 0.364764924967109 | erot = 0.43128829359489 | epot = -15.420956961164 | etot = -14.624903742602 +822000 ekin = 0.363101323048021 | erot = 0.431144612410221 | epot = -15.419149678064 | etot = -14.6249037426058 +823000 ekin = 0.355627506071419 | erot = 0.43229307921143 | epot = -15.4128243278382 | etot = -14.6249037425554 +824000 ekin = 0.342909507999076 | erot = 0.434926118199362 | epot = -15.4027393686599 | etot = -14.6249037424615 +825000 ekin = 0.326218347990279 | erot = 0.439222871854997 | epot = -15.390344962187 | etot = -14.6249037423417 +826000 ekin = 0.307298067026364 | erot = 0.445309293137064 | epot = -15.3775111023799 | etot = -14.6249037422164 +827000 ekin = 0.288081469809457 | erot = 0.453218819733404 | epot = -15.3662040316486 | etot = -14.6249037421057 +828000 ekin = 0.270403517643933 | erot = 0.462862712071296 | epot = -15.358169971741 | etot = -14.6249037420258 +829000 ekin = 0.255756724313351 | erot = 0.474017347276038 | epot = -15.3546778135762 | etot = -14.6249037419868 +830000 ekin = 0.245120383539822 | erot = 0.48633201659407 | epot = -15.3563561421258 | etot = -14.624903741992 +831000 ekin = 0.238883956789673 | erot = 0.499357971990034 | epot = -15.3631456708166 | etot = -14.6249037420369 +832000 ekin = 0.236868645663221 | erot = 0.512595315427615 | epot = -15.3743677032019 | etot = -14.6249037421111 +833000 ekin = 0.238435989569064 | erot = 0.525550909042522 | epot = -15.3888906408114 | etot = -14.6249037421998 +834000 ekin = 0.242658569128244 | erot = 0.537797737790336 | epot = -15.405360049206 | etot = -14.6249037422874 +835000 ekin = 0.248518315376458 | erot = 0.549024910269567 | epot = -15.4224469680061 | etot = -14.62490374236 +836000 ekin = 0.255095050223297 | erot = 0.559068449138061 | epot = -15.4390672417691 | etot = -14.6249037424078 +837000 ekin = 0.261712817640754 | erot = 0.567916383627862 | epot = -15.4545329436951 | etot = -14.6249037424265 +838000 ekin = 0.268023056778799 | erot = 0.575686784519135 | epot = -15.468613583716 | etot = -14.6249037424181 +839000 ekin = 0.274018270323247 | erot = 0.582582979366575 | epot = -15.481504992079 | etot = -14.6249037423892 +840000 ekin = 0.279983100774044 | erot = 0.588834754839254 | epot = -15.493721597963 | etot = -14.6249037423497 +841000 ekin = 0.286398274628748 | erot = 0.594637024330571 | epot = -15.5059390412695 | etot = -14.6249037423102 +842000 ekin = 0.293816650983671 | erot = 0.600098453280244 | epot = -15.5188188465455 | etot = -14.6249037422816 +843000 ekin = 0.302726774569864 | erot = 0.605208920748267 | epot = -15.5328394375906 | etot = -14.6249037422725 +844000 ekin = 0.313421069061913 | erot = 0.609833296484503 | epot = -15.5481581078352 | etot = -14.6249037422888 +845000 ekin = 0.325887895395929 | erot = 0.613733577818103 | epot = -15.5645252155455 | etot = -14.6249037423314 +846000 ekin = 0.33975240096389 | erot = 0.616615984720062 | epot = -15.5812721280797 | etot = -14.6249037423957 +847000 ekin = 0.354292335350613 | erot = 0.618194079532099 | epot = -15.5973901573538 | etot = -14.624903742471 +848000 ekin = 0.368542667425734 | erot = 0.618254639141467 | epot = -15.6117010491094 | etot = -14.6249037425422 +849000 ekin = 0.381474241846711 | erot = 0.616711095272622 | epot = -15.6230890797133 | etot = -14.624903742594 +850000 ekin = 0.392198266664605 | erot = 0.613631554978577 | epot = -15.6307335642585 | etot = -14.6249037426153 +851000 ekin = 0.400129367739792 | erot = 0.609234588534973 | epot = -15.6342676988789 | etot = -14.6249037426041 +852000 ekin = 0.405049998800082 | erot = 0.603854451145949 | epot = -15.6338081925133 | etot = -14.6249037425673 +853000 ekin = 0.407056563943438 | erot = 0.597885334647268 | epot = -15.6298456411094 | etot = -14.6249037425187 +854000 ekin = 0.406415158940066 | erot = 0.591718979209663 | epot = -15.623037880623 | etot = -14.6249037424732 +855000 ekin = 0.403390043513582 | erot = 0.585690332508252 | epot = -15.6139841184641 | etot = -14.6249037424422 +856000 ekin = 0.398116166002876 | erot = 0.580042463524147 | epot = -15.6030623719562 | etot = -14.6249037424292 +857000 ekin = 0.39056801615961 | erot = 0.574915889724005 | epot = -15.5903876483121 | etot = -14.6249037424285 +858000 ekin = 0.380638245095305 | erot = 0.570361176879803 | epot = -15.5759031644036 | etot = -14.6249037424285 +859000 ekin = 0.368297168913566 | erot = 0.566367903414504 | epot = -15.5595688147431 | etot = -14.624903742415 +860000 ekin = 0.353771484485059 | erot = 0.56289933566622 | epot = -15.5415745625294 | etot = -14.6249037423781 +861000 ekin = 0.33766818907467 | erot = 0.559921190515333 | epot = -15.5224931219057 | etot = -14.6249037423157 +862000 ekin = 0.320982687533336 | erot = 0.557415114411014 | epot = -15.5033015441806 | etot = -14.6249037422363 +863000 ekin = 0.304965814690107 | erot = 0.555372641471618 | epot = -15.485242198319 | etot = -14.6249037421573 +864000 ekin = 0.290872653002407 | erot = 0.5537720825734 | epot = -15.4695484776756 | etot = -14.6249037420998 +865000 ekin = 0.27966077424891 | erot = 0.552546988654679 | epot = -15.4571115049861 | etot = -14.6249037420825 +866000 ekin = 0.271730646598884 | erot = 0.551558423385933 | epot = -15.4481928120997 | etot = -14.6249037421148 +867000 ekin = 0.266795961580335 | erot = 0.550582916185739 | epot = -15.442282619959 | etot = -14.6249037421929 +868000 ekin = 0.263936467175558 | erot = 0.549323573879739 | epot = -15.4381637833552 | etot = -14.6249037422999 +869000 ekin = 0.261831470221842 | erot = 0.547444696243082 | epot = -15.4341799088743 | etot = -14.6249037424094 +870000 ekin = 0.259116433169414 | erot = 0.544622620095275 | epot = -15.4286427957584 | etot = -14.6249037424937 +871000 ekin = 0.254766113418661 | erot = 0.540599894777671 | epot = -15.4202697507265 | etot = -14.6249037425302 +872000 ekin = 0.248397230691804 | erot = 0.535228153627548 | epot = -15.4085291268285 | etot = -14.6249037425092 +873000 ekin = 0.240403953826285 | erot = 0.528487826572583 | epot = -15.3937955228344 | etot = -14.6249037424355 +874000 ekin = 0.231884125783745 | erot = 0.520479317821078 | epot = -15.3772671859334 | etot = -14.6249037423285 +875000 ekin = 0.224371090313998 | erot = 0.511388489700788 | epot = -15.3606633222313 | etot = -14.6249037422165 +876000 ekin = 0.219440883380304 | erot = 0.501436812694108 | epot = -15.3457814382033 | etot = -14.6249037421289 +877000 ekin = 0.218302972736541 | erot = 0.490831150818269 | epot = -15.3340378656425 | etot = -14.6249037420877 +878000 ekin = 0.221492456263516 | erot = 0.479728387736696 | epot = -15.3261245861012 | etot = -14.624903742101 +879000 ekin = 0.228756262275047 | erot = 0.468225594693746 | epot = -15.3218855991288 | etot = -14.62490374216 +880000 ekin = 0.23916916008879 | erot = 0.456378166082174 | epot = -15.3204510684128 | etot = -14.6249037422418 +881000 ekin = 0.251443176614632 | erot = 0.444238659513065 | epot = -15.3205855784454 | etot = -14.6249037423177 +882000 ekin = 0.264330844663881 | erot = 0.43190128969608 | epot = -15.3211358767216 | etot = -14.6249037423616 +883000 ekin = 0.276992343361879 | erot = 0.419534292632584 | epot = -15.3214303783539 | etot = -14.6249037423594 +884000 ekin = 0.289210952362963 | erot = 0.407386172192775 | epot = -15.3215008668683 | etot = -14.6249037423126 +885000 ekin = 0.301394205511005 | erot = 0.395760928443894 | epot = -15.3220588761927 | etot = -14.6249037422378 +886000 ekin = 0.31436859920589 | erot = 0.384968165379889 | epot = -15.3242405067469 | etot = -14.6249037421611 +887000 ekin = 0.329038341775477 | erot = 0.375262338090619 | epot = -15.3292044219764 | etot = -14.6249037421103 +888000 ekin = 0.346015111155314 | erot = 0.366788650328168 | epot = -15.3377075035892 | etot = -14.6249037421057 +889000 ekin = 0.365329693883282 | erot = 0.35955094737734 | epot = -15.3497843834164 | etot = -14.6249037421558 +890000 ekin = 0.386310696216818 | erot = 0.353410826838142 | epot = -15.3646252653079 | etot = -14.6249037422529 +891000 ekin = 0.407668087054666 | erot = 0.348119126036796 | epot = -15.3806909554674 | etot = -14.6249037423759 +892000 ekin = 0.427761236102702 | erot = 0.343372786942168 | epot = -15.396037765541 | etot = -14.6249037424962 +893000 ekin = 0.444977236018704 | erot = 0.338883525692821 | epot = -15.4087645042964 | etot = -14.6249037425849 +894000 ekin = 0.458112158679596 | erot = 0.334441343917346 | epot = -15.4174572452184 | etot = -14.6249037426214 +895000 ekin = 0.466648008330968 | erot = 0.329956933565266 | epot = -15.4215086844955 | etot = -14.6249037425992 +896000 ekin = 0.470850232518833 | erot = 0.325472374552695 | epot = -15.421226349598 | etot = -14.6249037425264 +897000 ekin = 0.471664510487189 | erot = 0.321137893833246 | epot = -15.4177061467443 | etot = -14.6249037424239 +898000 ekin = 0.470447771985121 | erot = 0.31716128210791 | epot = -15.4125127964118 | etot = -14.6249037423187 +899000 ekin = 0.468609320535131 | erot = 0.31374324783162 | epot = -15.4072563106044 | etot = -14.6249037422377 +900000 ekin = 0.467255363896452 | erot = 0.311015004595572 | epot = -15.4031741106926 | etot = -14.6249037422006 +901000 ekin = 0.466923299456765 | erot = 0.308993431077939 | epot = -15.4008204727507 | etot = -14.624903742216 +902000 ekin = 0.467466399705909 | erot = 0.307564919774022 | epot = -15.3999350617589 | etot = -14.624903742279 +903000 ekin = 0.468112799245423 | erot = 0.30650258938551 | epot = -15.3995191310034 | etot = -14.6249037423724 +904000 ekin = 0.467682260081114 | erot = 0.305513914729626 | epot = -15.3980999172821 | etot = -14.6249037424714 +905000 ekin = 0.464906903208319 | erot = 0.304308207539406 | epot = -15.3941188532968 | etot = -14.6249037425491 +906000 ekin = 0.458775313350499 | erot = 0.302667437698498 | epot = -15.3863464936332 | etot = -14.6249037425842 +907000 ekin = 0.448811106797387 | erot = 0.300501710925559 | epot = -15.3742165602889 | etot = -14.624903742566 +908000 ekin = 0.435212888278633 | erot = 0.297873922704189 | epot = -15.3579905534804 | etot = -14.6249037424975 +909000 ekin = 0.418821166579361 | erot = 0.294986492955396 | epot = -15.3387114019291 | etot = -14.6249037423944 +910000 ekin = 0.400928155652502 | erot = 0.292134043124591 | epot = -15.3179659410567 | etot = -14.6249037422796 +911000 ekin = 0.38299073131904 | erot = 0.289635345607532 | epot = -15.2975298191036 | etot = -14.624903742177 +912000 ekin = 0.366329155570265 | erot = 0.287762457046 | epot = -15.2789953547218 | etot = -14.6249037421055 +913000 ekin = 0.351888443631644 | erot = 0.286683662572436 | epot = -15.263475848279 | etot = -14.6249037420749 +914000 ekin = 0.340111462795988 | erot = 0.286431278414276 | epot = -15.2514464832956 | etot = -14.6249037420854 +915000 ekin = 0.330936398540546 | erot = 0.286898247266849 | epot = -15.2427383879358 | etot = -14.6249037421284 +916000 ekin = 0.32389927160205 | erot = 0.287861143478129 | epot = -15.2366641572708 | etot = -14.6249037421907 +917000 ekin = 0.318302399047882 | erot = 0.289022784864801 | epot = -15.2322289261694 | etot = -14.6249037422567 +918000 ekin = 0.313403328232211 | erot = 0.290065205370544 | epot = -15.2283722759156 | etot = -14.6249037423128 +919000 ekin = 0.308582994047746 | erot = 0.290702987753655 | epot = -15.2241897241503 | etot = -14.6249037423489 +920000 ekin = 0.303462620955297 | erot = 0.290727692024701 | epot = -15.2190940553404 | etot = -14.6249037423604 +921000 ekin = 0.297952758523176 | erot = 0.290036267627134 | epot = -15.2128927684984 | etot = -14.624903742348 +922000 ekin = 0.292232329167479 | erot = 0.288639696922892 | epot = -15.2057757684081 | etot = -14.6249037423177 +923000 ekin = 0.286668877938219 | erot = 0.286652137103033 | epot = -15.1982247573198 | etot = -14.6249037422785 +924000 ekin = 0.281701868658443 | erot = 0.284264668755385 | epot = -15.1908702796542 | etot = -14.6249037422404 +925000 ekin = 0.277717553237889 | erot = 0.281710557644916 | epot = -15.1843318530949 | etot = -14.6249037422121 +926000 ekin = 0.274945509179126 | erot = 0.279230091666523 | epot = -15.1790793430443 | etot = -14.6249037421987 +927000 ekin = 0.273402631519641 | erot = 0.277042382113033 | epot = -15.1753487558335 | etot = -14.6249037422009 +928000 ekin = 0.272900230271313 | erot = 0.27532923254522 | epot = -15.1731332050308 | etot = -14.6249037422143 +929000 ekin = 0.273115271900815 | erot = 0.274232799537056 | epot = -15.1722518136686 | etot = -14.6249037422307 +930000 ekin = 0.273710515355576 | erot = 0.273865029643896 | epot = -15.1724792872395 | etot = -14.6249037422401 +931000 ekin = 0.274474107139751 | erot = 0.274323617228769 | epot = -15.1737014666023 | etot = -14.6249037422338 +932000 ekin = 0.275440857683152 | erot = 0.275707340216854 | epot = -15.176051940107 | etot = -14.624903742207 +933000 ekin = 0.276957575781874 | erot = 0.278123705988361 | epot = -15.1799850239313 | etot = -14.6249037421611 +934000 ekin = 0.279664435383878 | erot = 0.281683992543418 | epot = -15.1862521700318 | etot = -14.6249037421045 +935000 ekin = 0.284382433296915 | erot = 0.286484503522641 | epot = -15.1957706788708 | etot = -14.6249037420512 +936000 ekin = 0.291920557579979 | erot = 0.292577187598074 | epot = -15.2094014871964 | etot = -14.6249037420184 +937000 ekin = 0.302840159169775 | erot = 0.299936553990588 | epot = -15.2276804551825 | etot = -14.6249037420221 +938000 ekin = 0.317231541763407 | erot = 0.308432066638773 | epot = -15.2505673504752 | etot = -14.6249037420731 +939000 ekin = 0.334562734704664 | erot = 0.317815317270636 | epot = -15.2772817941479 | etot = -14.6249037421726 +940000 ekin = 0.353649521805238 | erot = 0.327729086105133 | epot = -15.3062823502217 | etot = -14.6249037423114 +941000 ekin = 0.372770367646981 | erot = 0.337741122003566 | epot = -15.3354152321204 | etot = -14.6249037424699 +942000 ekin = 0.389915662531947 | erot = 0.347399749799135 | epot = -15.3622191549531 | etot = -14.6249037426221 +943000 ekin = 0.403126345739486 | erot = 0.356302369934052 | epot = -15.3843324584141 | etot = -14.6249037427406 +944000 ekin = 0.410851754406517 | erot = 0.364163156178947 | epot = -15.3999186533885 | etot = -14.624903742803 +945000 ekin = 0.412247920960694 | erot = 0.370864511414574 | epot = -15.4080161751724 | etot = -14.6249037427972 +946000 ekin = 0.407348747780355 | erot = 0.376479254457633 | epot = -15.4087317449614 | etot = -14.6249037427235 +947000 ekin = 0.397071124217177 | erot = 0.381256899558804 | epot = -15.4032317663713 | etot = -14.6249037425953 +948000 ekin = 0.383053455726579 | erot = 0.385576026491136 | epot = -15.3935332246539 | etot = -14.6249037424362 +949000 ekin = 0.367364810070546 | erot = 0.389872987609663 | epot = -15.382141539954 | etot = -14.6249037422738 +950000 ekin = 0.352149150211141 | erot = 0.394562514443112 | epot = -15.371615406789 | etot = -14.6249037421348 +951000 ekin = 0.339280178143099 | erot = 0.399966938641359 | epot = -15.3641508588234 | etot = -14.6249037420389 +952000 ekin = 0.330096120379237 | erot = 0.406268489131811 | epot = -15.3612683515071 | etot = -14.6249037419961 +953000 ekin = 0.325261831669684 | erot = 0.413492937870729 | epot = -15.3636585115451 | etot = -14.6249037420047 +954000 ekin = 0.324774911929383 | erot = 0.421526046053159 | epot = -15.3712047000361 | etot = -14.6249037420535 +955000 ekin = 0.328098170459405 | erot = 0.43015685816017 | epot = -15.3831587707447 | etot = -14.6249037421252 +956000 ekin = 0.334370903123805 | erot = 0.439135698166764 | epot = -15.3984103434923 | etot = -14.6249037422018 +957000 ekin = 0.342633913360331 | erot = 0.448231239799098 | epot = -15.415768895429 | etot = -14.6249037422696 +958000 ekin = 0.352004139469646 | erot = 0.457271615167415 | epot = -15.4341794969597 | etot = -14.6249037423226 +959000 ekin = 0.361755395785228 | erot = 0.466159587643494 | epot = -15.4528187257923 | etot = -14.6249037423635 +960000 ekin = 0.371296348402955 | erot = 0.474860087932416 | epot = -15.4710601787363 | etot = -14.6249037424009 +961000 ekin = 0.380073790912418 | erot = 0.483367158174937 | epot = -15.4883446915324 | etot = -14.624903742445 +962000 ekin = 0.387455548950117 | erot = 0.491663490520803 | epot = -15.5040227819739 | etot = -14.624903742503 +963000 ekin = 0.392654097311874 | erot = 0.49968729563245 | epot = -15.5172451355191 | etot = -14.6249037425748 +964000 ekin = 0.394737939559185 | erot = 0.507318071995981 | epot = -15.5269597542072 | etot = -14.624903742652 +965000 ekin = 0.392748486467115 | erot = 0.514386334667554 | epot = -15.5320385638537 | etot = -14.6249037427191 +966000 ekin = 0.38590547325284 | erot = 0.520705106527849 | epot = -15.5315143225377 | etot = -14.624903742757 +967000 ekin = 0.373852021645421 | erot = 0.526114369234909 | epot = -15.5248701336288 | etot = -14.6249037427485 +968000 ekin = 0.356869417135994 | erot = 0.530525868585158 | epot = -15.5122990284054 | etot = -14.6249037426842 +969000 ekin = 0.335986889834556 | erot = 0.533955228284217 | epot = -15.4948458606857 | etot = -14.624903742567 +970000 ekin = 0.312927788672648 | erot = 0.536531428461786 | epot = -15.4743629595477 | etot = -14.6249037424133 +971000 ekin = 0.289872105907182 | erot = 0.538479668129509 | epot = -15.4532555162878 | etot = -14.6249037422511 +972000 ekin = 0.269070232407033 | erot = 0.540080898361602 | epot = -15.4340548728818 | etot = -14.6249037421131 +973000 ekin = 0.252397022945933 | erot = 0.54161782723094 | epot = -15.4189185922051 | etot = -14.6249037420282 +974000 ekin = 0.240964852823081 | erot = 0.543321042152107 | epot = -15.4091896369882 | etot = -14.624903742013 +975000 ekin = 0.23490216482483 | erot = 0.545328986458791 | epot = -15.4051348933517 | etot = -14.6249037420681 +976000 ekin = 0.233353466622718 | erot = 0.547671994180028 | epot = -15.4059292029808 | etot = -14.624903742178 +977000 ekin = 0.23469220109011 | erot = 0.550284513867316 | epot = -15.4098804572738 | etot = -14.6249037423163 +978000 ekin = 0.236887903181319 | erot = 0.553043053342949 | epot = -15.4148346989756 | etot = -14.6249037424513 +979000 ekin = 0.237945797132614 | erot = 0.555821040963938 | epot = -15.4186705806485 | etot = -14.624903742552 +980000 ekin = 0.236334546964098 | erot = 0.558547250125554 | epot = -15.4197855396836 | etot = -14.624903742594 +981000 ekin = 0.231322843924842 | erot = 0.561252158433111 | epot = -15.4174787449233 | etot = -14.6249037425653 +982000 ekin = 0.223154169545187 | erot = 0.564087592075058 | epot = -15.4121455040898 | etot = -14.6249037424696 +983000 ekin = 0.213008719539848 | erot = 0.567310103887051 | epot = -15.405222565754 | etot = -14.6249037423271 +984000 ekin = 0.202740628548823 | erot = 0.571227590062905 | epot = -15.3988719607832 | etot = -14.6249037421715 +985000 ekin = 0.19443566515497 | erot = 0.576119771488149 | epot = -15.395459178685 | etot = -14.6249037420419 +986000 ekin = 0.189894304519326 | erot = 0.582152858152867 | epot = -15.3969509046438 | etot = -14.6249037419716 +987000 ekin = 0.190182835425093 | erot = 0.589313613953994 | epot = -15.4044001913574 | etot = -14.6249037419783 +988000 ekin = 0.195390213187501 | erot = 0.597385005524193 | epot = -15.4176789607687 | etot = -14.624903742057 +989000 ekin = 0.204671362362471 | erot = 0.605974905403898 | epot = -15.4355500099488 | etot = -14.6249037421824 +990000 ekin = 0.216563394578787 | erot = 0.614593273597699 | epot = -15.4560604104926 | etot = -14.6249037423161 +991000 ekin = 0.229465191862139 | erot = 0.622757127490779 | epot = -15.4771260617733 | etot = -14.6249037424204 +992000 ekin = 0.242114271128949 | erot = 0.630092599917091 | epot = -15.4971106135164 | etot = -14.6249037424704 +993000 ekin = 0.253902581480084 | erot = 0.636403793831659 | epot = -15.5152101177729 | etot = -14.6249037424612 +994000 ekin = 0.264939510335902 | erot = 0.641689105048086 | epot = -15.5315323577919 | etot = -14.6249037424079 +995000 ekin = 0.275864888579236 | erot = 0.646102898208602 | epot = -15.5468715291263 | etot = -14.6249037423384 +996000 ekin = 0.287497820770256 | erot = 0.649877086441226 | epot = -15.5622786494954 | etot = -14.6249037422839 +997000 ekin = 0.300450307467438 | erot = 0.65322742357329 | epot = -15.5785814733092 | etot = -14.6249037422685 +998000 ekin = 0.314829914377602 | erot = 0.656270894957618 | epot = -15.5960045516385 | etot = -14.6249037423033 +999000 ekin = 0.330110494517114 | erot = 0.658973630822449 | epot = -15.6139878677246 | etot = -14.624903742385 +1000000 ekin = 0.345190458650495 | erot = 0.661138339466907 | epot = -15.6312325406154 | etot = -14.624903742498 + 1000000 0.025569664 -1.5839232 0.020799898 -1.5286042 -3.5789082e-06 +Loop time of 20.5464 on 1 procs for 1000000 steps with 10 atoms + +Performance: 42051.215 tau/day, 48670.388 timesteps/s +98.3% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 16.716 | 16.716 | 16.716 | 0.0 | 81.36 +Bond | 0.6285 | 0.6285 | 0.6285 | 0.0 | 3.06 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.187 | 0.187 | 0.187 | 0.0 | 0.91 +Output | 6e-06 | 6e-06 | 6e-06 | 0.0 | 0.00 +Modify | 2.7186 | 2.7186 | 2.7186 | 0.0 | 13.23 +Other | | 0.2965 | | | 1.44 + +Nlocal: 10 ave 10 max 10 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 45 ave 45 max 45 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 45 +Ave neighs/atom = 4.5 +Ave special neighs/atom = 3.6 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:20 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.4 b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.4 new file mode 100644 index 0000000000..60722d1063 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.18Jun19.duplex3.g++.4 @@ -0,0 +1,1172 @@ +LAMMPS (18 Jun 2019) +variable number equal 1 +variable ofreq equal 1000 +variable efreq equal 1000 +variable T equal 0.1 + +units lj + +dimension 3 + +newton off + +boundary p p p + +atom_style hybrid bond ellipsoid +atom_modify sort 0 1.0 + +# Pair interactions require lists of neighbours to be calculated +neighbor 1.0 bin +neigh_modify every 1 delay 0 check yes + +read_data data.duplex3 + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 10 atoms + reading velocities ... + 10 velocities + 10 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 8 bonds + 2 = max # of 1-2 neighbors + 2 = max # of 1-3 neighbors + 2 = max # of 1-4 neighbors + 4 = max # of special neighbors + special bonds CPU = 0.000189 secs + read_data CPU = 0.003302 secs + +set atom * mass 1.0 + 10 settings made for mass + +group all type 1 4 +10 atoms in group all + +# oxDNA bond interactions - FENE backbone +bond_style oxdna2/fene +bond_coeff * 2.0 0.25 0.7564 + +# oxDNA pair interactions +pair_style hybrid/overlay oxdna2/excv oxdna2/stk oxdna2/hbond oxdna2/xstk oxdna2/coaxstk oxdna2/dh +pair_coeff * * oxdna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxdna2/stk seqdep ${T} 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/stk seqdep 0.1 1.3523 2.6717 6.0 0.4 0.9 0.32 0.6 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 2.0 0.65 2.0 0.65 +pair_coeff * * oxdna2/hbond seqdep 0.0 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 1 4 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff 2 3 oxdna2/hbond seqdep 1.0678 8.0 0.4 0.75 0.34 0.7 1.5 0 0.7 1.5 0 0.7 1.5 0 0.7 0.46 3.141592653589793 0.7 4.0 1.5707963267948966 0.45 4.0 1.5707963267948966 0.45 +pair_coeff * * oxdna2/xstk 47.5 0.575 0.675 0.495 0.655 2.25 0.791592653589793 0.58 1.7 1.0 0.68 1.7 1.0 0.68 1.5 0 0.65 1.7 0.875 0.68 1.7 0.875 0.68 +pair_coeff * * oxdna2/coaxstk 58.5 0.4 0.6 0.22 0.58 2.0 2.891592653589793 0.65 1.3 0 0.8 0.9 0 0.95 0.9 0 0.95 40.0 3.116592653589793 +pair_coeff * * oxdna2/dh ${T} 1.0 0.815 +pair_coeff * * oxdna2/dh 0.1 1.0 0.815 + +# NVE ensemble +fix 1 all nve/dot +#fix 1 all nve/dotc/langevin ${T} ${T} 0.03 457145 angmom 10 +#fix 1 all nve/asphere +#fix 2 all langevin ${T} ${T} 0.03 457145 angmom 10 + +timestep 1e-5 + +#comm_style tiled +#fix 3 all balance 10000 1.1 rcb + +#compute mol all chunk/atom molecule +#compute mychunk all vcm/chunk mol +#fix 4 all ave/time 10000 1 10000 c_mychunk[1] c_mychunk[2] c_mychunk[3] file vcm.txt mode vector + +#dump pos all xyz ${ofreq} traj.${number}.xyz + +#compute quat all property/atom quatw quati quatj quatk +#dump quat all custom ${ofreq} quat.${number}.txt id c_quat[1] c_quat[2] c_quat[3] c_quat[4] +#dump_modify quat sort id +#dump_modify quat format line "%d %13.6le %13.6le %13.6le %13.6le" + +compute erot all erotate/asphere +compute ekin all ke +compute epot all pe +variable erot equal c_erot +variable ekin equal c_ekin +variable epot equal c_epot +variable etot equal c_erot+c_ekin+c_epot +fix 5 all print ${efreq} "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes +fix 5 all print 1000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +#dump out all custom ${ofreq} out.${number}.txt id x y z vx vy vz fx fy fz tqx tqy tqz +#dump_modify out sort id +#dump_modify out format line "%d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le" + +run 1000000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.6274 + ghost atom cutoff = 2.6274 + binsize = 1.3137, bins = 31 31 31 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.652 | 7.834 | 8.016 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.4720158 0.009525411 -1.4624904 3.1370518e-06 +1000 ekin = 0.00366431201929595 | erot = 0.00193726360268106 | epot = -14.630505317301 | etot = -14.624903741679 +2000 ekin = 0.0144775076075461 | erot = 0.00770914672939826 | epot = -14.6470903960565 | etot = -14.6249037417196 +3000 ekin = 0.0319122186081537 | erot = 0.017197232864929 | epot = -14.6740131932573 | etot = -14.6249037417842 +4000 ekin = 0.055128304350968 | erot = 0.0302085305548261 | epot = -14.7102405767754 | etot = -14.6249037418696 +5000 ekin = 0.0830285165715777 | erot = 0.0464820547542036 | epot = -14.7544143132963 | etot = -14.6249037419705 +6000 ekin = 0.11433112154675 | erot = 0.0656980211282502 | epot = -14.8049328847556 | etot = -14.6249037420806 +7000 ekin = 0.14765386656188 | erot = 0.0874894888755877 | epot = -14.8600470976311 | etot = -14.6249037421936 +8000 ekin = 0.18160209956019 | erot = 0.111456095727761 | epot = -14.9179619375912 | etot = -14.6249037423032 +9000 ekin = 0.214852894725897 | erot = 0.137179311245239 | epot = -14.9769359483746 | etot = -14.6249037424035 +10000 ekin = 0.246227151956005 | erot = 0.164238435218469 | epot = -15.0353693296649 | etot = -14.6249037424904 +11000 ekin = 0.274743080419017 | erot = 0.192226420003323 | epot = -15.091873242983 | etot = -14.6249037425607 +12000 ekin = 0.299647141765663 | erot = 0.220764512146746 | epot = -15.1453153965252 | etot = -14.6249037426128 +13000 ekin = 0.320421918860927 | erot = 0.249514690530647 | epot = -15.1948403520386 | etot = -14.624903742647 +14000 ekin = 0.336773734884323 | erot = 0.278188933730603 | epot = -15.2398664112794 | etot = -14.6249037426645 +15000 ekin = 0.34860541376287 | erot = 0.306554508009539 | epot = -15.2800636644399 | etot = -14.6249037426675 +16000 ekin = 0.355980829097832 | erot = 0.334434770083873 | epot = -15.3153193418403 | etot = -14.6249037426586 +17000 ekin = 0.359087701059401 | erot = 0.361705441666651 | epot = -15.3456968853665 | etot = -14.6249037426405 +18000 ekin = 0.358203710992248 | erot = 0.388286889516457 | epot = -15.3713943431244 | etot = -14.6249037426157 +19000 ekin = 0.353668912555266 | erot = 0.414133518537258 | epot = -15.3927061736789 | etot = -14.6249037425864 +20000 ekin = 0.345865220775347 | erot = 0.439221805285588 | epot = -15.4099907686155 | etot = -14.6249037425546 +21000 ekin = 0.335201981146553 | erot = 0.463538642606666 | epot = -15.423644366275 | etot = -14.6249037425218 +22000 ekin = 0.322105588835009 | erot = 0.487071492273222 | epot = -15.4340808235974 | etot = -14.6249037424892 +23000 ekin = 0.307010918596293 | erot = 0.509801406229522 | epot = -15.4417160672835 | etot = -14.6249037424577 +24000 ekin = 0.290352786033317 | erot = 0.53169940050183 | epot = -15.4469559289633 | etot = -14.6249037424281 +25000 ekin = 0.272556500902201 | erot = 0.552726088759337 | epot = -15.4501863320625 | etot = -14.624903742401 +26000 ekin = 0.254027484079225 | erot = 0.572834017299149 | epot = -15.451765243755 | etot = -14.6249037423766 +27000 ekin = 0.235140665216512 | erot = 0.591971851501351 | epot = -15.4520162590732 | etot = -14.6249037423553 +28000 ekin = 0.216230835846381 | erot = 0.610089455964456 | epot = -15.4512240341482 | etot = -14.6249037423373 +29000 ekin = 0.197585285158732 | erot = 0.627142960082751 | epot = -15.4496319875638 | etot = -14.6249037423223 +30000 ekin = 0.179439940173485 | erot = 0.643099062793524 | epot = -15.4474427452772 | etot = -14.6249037423102 +31000 ekin = 0.161979935826275 | erot = 0.657938056392414 | epot = -15.4448217345188 | etot = -14.6249037423001 +32000 ekin = 0.145345108983154 | erot = 0.671655297434073 | epot = -15.4419041487088 | etot = -14.6249037422916 +33000 ekin = 0.129640400345301 | erot = 0.684261083518649 | epot = -15.4388052261477 | etot = -14.6249037422838 +34000 ekin = 0.114950474500096 | erot = 0.695779112936577 | epot = -15.4356333297123 | etot = -14.6249037422756 +35000 ekin = 0.101357103460395 | erot = 0.706243888527945 | epot = -15.4325047342545 | etot = -14.6249037422661 +36000 ekin = 0.0889576334571495 | erot = 0.715697403164658 | epot = -15.4295587788764 | etot = -14.6249037422546 +37000 ekin = 0.0778817390290869 | erot = 0.724185638635694 | epot = -15.4269711199052 | etot = -14.6249037422404 +38000 ekin = 0.0683037091548152 | erot = 0.731755309647459 | epot = -15.4249627610255 | etot = -14.6249037422232 +39000 ekin = 0.0604476327394574 | erot = 0.738451228922887 | epot = -15.4238026038658 | etot = -14.6249037422035 +40000 ekin = 0.0545835914676698 | erot = 0.744314557682062 | epot = -15.4238018913317 | etot = -14.624903742182 +41000 ekin = 0.0510142787133431 | erot = 0.749382063190686 | epot = -15.425300084064 | etot = -14.6249037421599 +42000 ekin = 0.0500531571157122 | erot = 0.753686350478873 | epot = -15.4286432497339 | etot = -14.6249037421393 +43000 ekin = 0.0519969858277791 | erot = 0.757256889238925 | epot = -15.4341576171884 | etot = -14.6249037421217 +44000 ekin = 0.0570968352183795 | erot = 0.760121540481331 | epot = -15.4421221178083 | etot = -14.6249037421086 +45000 ekin = 0.0655321553469052 | erot = 0.762308219230389 | epot = -15.4527441166787 | etot = -14.6249037421014 +46000 ekin = 0.077391880036667 | erot = 0.763846321567477 | epot = -15.4661419437046 | etot = -14.6249037421005 +47000 ekin = 0.0926650518886644 | erot = 0.764767599959881 | epot = -15.4823363939543 | etot = -14.6249037421058 +48000 ekin = 0.111241466890937 | erot = 0.765106283689481 | epot = -15.5012514926974 | etot = -14.624903742117 +49000 ekin = 0.132920935183018 | erot = 0.764898395951864 | epot = -15.5227230732682 | etot = -14.6249037421333 +50000 ekin = 0.157428432862217 | erot = 0.764180392178735 | epot = -15.5465125671948 | etot = -14.6249037421538 +51000 ekin = 0.184431879186323 | erot = 0.762987403181098 | epot = -15.572323024545 | etot = -14.6249037421776 +52000 ekin = 0.213559336999553 | erot = 0.761351471408863 | epot = -15.5998145506122 | etot = -14.6249037422038 +53000 ekin = 0.244412677541706 | erot = 0.759300175100794 | epot = -15.6286165948746 | etot = -14.6249037422321 +54000 ekin = 0.276574826726782 | erot = 0.756855909735936 | epot = -15.6583344787253 | etot = -14.6249037422625 +55000 ekin = 0.309607708697251 | erot = 0.754035838659022 | epot = -15.6885472896524 | etot = -14.6249037422961 +56000 ekin = 0.343038597242195 | erot = 0.750852192167276 | epot = -15.7187945317442 | etot = -14.6249037423347 +57000 ekin = 0.376334705011675 | erot = 0.747312289063632 | epot = -15.748550736456 | etot = -14.6249037423806 +58000 ekin = 0.408870193943514 | erot = 0.743417624903406 | epot = -15.7771915612831 | etot = -14.6249037424361 +59000 ekin = 0.439895666476151 | erot = 0.739161690570044 | epot = -15.8039610995489 | etot = -14.6249037425027 +60000 ekin = 0.468524372325882 | erot = 0.734526514748492 | epot = -15.8279546296535 | etot = -14.6249037425791 +61000 ekin = 0.493750804630977 | erot = 0.729479048549992 | epot = -15.8481335958426 | etot = -14.6249037426617 +62000 ekin = 0.514511417905742 | erot = 0.723968952962828 | epot = -15.8633841136118 | etot = -14.6249037427432 +63000 ekin = 0.529785687820863 | erot = 0.717929490923054 | epot = -15.8726189215585 | etot = -14.6249037428146 +64000 ekin = 0.538722043350041 | erot = 0.711282639869802 | epot = -15.8749084260858 | etot = -14.624903742866 +65000 ekin = 0.540763046401972 | erot = 0.703948378732391 | epot = -15.8696151680244 | etot = -14.62490374289 +66000 ekin = 0.535742115227036 | erot = 0.695856780686584 | epot = -15.8565026387959 | etot = -14.6249037428823 +67000 ekin = 0.523930969354304 | erot = 0.68696057843429 | epot = -15.8357952906313 | etot = -14.6249037428428 +68000 ekin = 0.506029704478312 | erot = 0.677245632039928 | epot = -15.8081790792934 | etot = -14.6249037427752 +69000 ekin = 0.483104826200259 | erot = 0.666737270644213 | epot = -15.7747458395309 | etot = -14.6249037426864 +70000 ekin = 0.456490218293525 | erot = 0.655501536742973 | epot = -15.7368954976211 | etot = -14.6249037425846 +71000 ekin = 0.427669918862827 | erot = 0.643641521525979 | epot = -15.696215182867 | etot = -14.6249037424782 +72000 ekin = 0.398160338931837 | erot = 0.631289876690699 | epot = -15.6543539579978 | etot = -14.6249037423753 +73000 ekin = 0.369405258277091 | erot = 0.618599034382457 | epot = -15.6129080349413 | etot = -14.6249037422818 +74000 ekin = 0.342691749042478 | erot = 0.605730669564096 | epot = -15.573326160809 | etot = -14.6249037422024 +75000 ekin = 0.319090526807116 | erot = 0.592845634905565 | epot = -15.5368399038526 | etot = -14.6249037421399 +76000 ekin = 0.299420611427649 | erot = 0.580095163563256 | epot = -15.5044195170865 | etot = -14.6249037420956 +77000 ekin = 0.284235504575202 | erot = 0.567613716752232 | epot = -15.476752963397 | etot = -14.6249037420696 +78000 ekin = 0.273826140866745 | erot = 0.555513536863883 | epot = -15.4542434197916 | etot = -14.624903742061 +79000 ekin = 0.268234635497765 | erot = 0.54388078034531 | epot = -15.437019157912 | etot = -14.6249037420689 +80000 ekin = 0.267272602906572 | erot = 0.532773036269537 | epot = -15.4249493812683 | etot = -14.6249037420922 +81000 ekin = 0.270538934182649 | erot = 0.522218059775401 | epot = -15.417660736088 | etot = -14.62490374213 +82000 ekin = 0.27743457435936 | erot = 0.512213638247992 | epot = -15.414551954789 | etot = -14.6249037421817 +83000 ekin = 0.287175732620383 | erot = 0.502728640569106 | epot = -15.4148081154356 | etot = -14.6249037422461 +84000 ekin = 0.298811175848726 | erot = 0.493705451301405 | epot = -15.4174203694714 | etot = -14.6249037423213 +85000 ekin = 0.311252369949757 | erot = 0.485064122067327 | epot = -15.4212202344208 | etot = -14.6249037424038 +86000 ekin = 0.323325626376074 | erot = 0.476708618160845 | epot = -15.4249379870248 | etot = -14.6249037424879 +87000 ekin = 0.33385179551888 | erot = 0.468535420697723 | epot = -15.4272909587828 | etot = -14.6249037425662 +88000 ekin = 0.341751109758587 | erot = 0.460444399763838 | epot = -15.427099252152 | etot = -14.6249037426296 +89000 ekin = 0.346159825920252 | erot = 0.452351304178841 | epot = -15.4234148727694 | etot = -14.6249037426704 +90000 ekin = 0.346534667470577 | erot = 0.444200535918418 | epot = -15.4156389460721 | etot = -14.6249037426831 +91000 ekin = 0.342715665476236 | erot = 0.435976333753466 | epot = -15.4035957418971 | etot = -14.6249037426674 +92000 ekin = 0.334922715851711 | erot = 0.427710377227768 | epot = -15.3875368357076 | etot = -14.6249037426281 +93000 ekin = 0.323677844434189 | erot = 0.419484336040122 | epot = -15.368065923049 | etot = -14.6249037425747 +94000 ekin = 0.309669782921695 | erot = 0.411426964072737 | epot = -15.3460004895125 | etot = -14.624903742518 +95000 ekin = 0.293600014862055 | erot = 0.403706586473305 | epot = -15.3222103438027 | etot = -14.6249037424673 +96000 ekin = 0.2760582848845 | erot = 0.396520701306389 | epot = -15.297482728618 | etot = -14.6249037424272 +97000 ekin = 0.257464456296026 | erot = 0.390084510983188 | epot = -15.2724527096758 | etot = -14.6249037423966 +98000 ekin = 0.238086767083294 | erot = 0.384619533405776 | epot = -15.24761004286 | etot = -14.6249037423709 +99000 ekin = 0.218116994126189 | erot = 0.380342481668315 | epot = -15.2233632181387 | etot = -14.6249037423442 +100000 ekin = 0.197764845956813 | erot = 0.377453964065525 | epot = -15.2001225523343 | etot = -14.6249037423119 +101000 ekin = 0.177333852671588 | erot = 0.37612662169739 | epot = -15.1783642166417 | etot = -14.6249037422727 +102000 ekin = 0.157255732179676 | erot = 0.376493003927858 | epot = -15.1586524783359 | etot = -14.6249037422283 +103000 ekin = 0.138079925449103 | erot = 0.378634329970109 | epot = -15.1416179976017 | etot = -14.6249037421825 +104000 ekin = 0.120430234291513 | erot = 0.38257179133531 | epot = -15.1279057677667 | etot = -14.6249037421398 +105000 ekin = 0.104946722393699 | erot = 0.388261944551355 | epot = -15.1181124090491 | etot = -14.6249037421041 +106000 ekin = 0.0922291289495077 | erot = 0.395597086392455 | epot = -15.1127299574201 | etot = -14.6249037420781 +107000 ekin = 0.0827918191992449 | erot = 0.404410579138415 | epot = -15.112106140401 | etot = -14.6249037420633 +108000 ekin = 0.0770336430610872 | erot = 0.414486225075909 | epot = -15.116423610197 | etot = -14.62490374206 +109000 ekin = 0.0752213121179505 | erot = 0.425570202879076 | epot = -15.1256952570645 | etot = -14.6249037420675 +110000 ekin = 0.077482636424855 | erot = 0.437383858086389 | epot = -15.1397702365963 | etot = -14.6249037420851 +111000 ekin = 0.0838057148049012 | erot = 0.449635759435866 | epot = -15.1583452163524 | etot = -14.6249037421117 +112000 ekin = 0.094041131771038 | erot = 0.462031808376727 | epot = -15.1809766822944 | etot = -14.6249037421466 +113000 ekin = 0.107905661684216 | erot = 0.47428271886895 | epot = -15.2070921227424 | etot = -14.6249037421893 +114000 ekin = 0.124987416380585 | erot = 0.486108767327206 | epot = -15.2359999259466 | etot = -14.6249037422388 +115000 ekin = 0.144753474421712 | erot = 0.497242253022929 | epot = -15.2668994697393 | etot = -14.6249037422947 +116000 ekin = 0.166561593123338 | erot = 0.507428522970937 | epot = -15.2988938584497 | etot = -14.6249037423555 +117000 ekin = 0.189677527330919 | erot = 0.516426638198595 | epot = -15.3310079079494 | etot = -14.6249037424199 +118000 ekin = 0.213298790897393 | erot = 0.524010758771299 | epot = -15.3622132921543 | etot = -14.6249037424856 +119000 ekin = 0.236584576961686 | erot = 0.529973112381402 | epot = -15.3914614318934 | etot = -14.6249037425503 +120000 ekin = 0.258690301858407 | erot = 0.5341290349257 | epot = -15.4177230793954 | etot = -14.6249037426112 +121000 ekin = 0.278804196533067 | erot = 0.536324108799723 | epot = -15.4400320479983 | etot = -14.6249037426655 +122000 ekin = 0.296182819519644 | erot = 0.536442962870851 | epot = -15.4575295251011 | etot = -14.6249037427106 +123000 ekin = 0.310182446406097 | erot = 0.534418915104283 | epot = -15.4695051042545 | etot = -14.6249037427441 +124000 ekin = 0.320283972930319 | erot = 0.530243389137748 | epot = -15.4754311048325 | etot = -14.6249037427644 +125000 ekin = 0.326110081462518 | erot = 0.523973945236228 | epot = -15.4749877694694 | etot = -14.6249037427707 +126000 ekin = 0.32743470961478 | erot = 0.515739832556742 | epot = -15.468078284934 | etot = -14.6249037427624 +127000 ekin = 0.324186046690464 | erot = 0.505744172152755 | epot = -15.4548339615831 | etot = -14.6249037427398 +128000 ekin = 0.316445106704291 | erot = 0.494262185784872 | epot = -15.4356110351926 | etot = -14.6249037427034 +129000 ekin = 0.304442167762781 | erot = 0.481635256753188 | epot = -15.4109811671702 | etot = -14.6249037426542 +130000 ekin = 0.288552887156539 | erot = 0.468261006625544 | epot = -15.3817176363753 | etot = -14.6249037425933 +131000 ekin = 0.269294696165401 | erot = 0.45457995559872 | epot = -15.3487783942861 | etot = -14.6249037425219 +132000 ekin = 0.247322351785784 | erot = 0.441059661322916 | epot = -15.3132857555505 | etot = -14.6249037424418 +133000 ekin = 0.223419723871666 | erot = 0.428177456066593 | epot = -15.2765009222933 | etot = -14.624903742355 +134000 ekin = 0.19848366631698 | erot = 0.416402982921093 | epot = -15.2397903915024 | etot = -14.6249037422643 +135000 ekin = 0.173495806295277 | erot = 0.406181641002432 | epot = -15.2045811894713 | etot = -14.6249037421736 +136000 ekin = 0.149479658252776 | erot = 0.397919790440761 | epot = -15.1723031907806 | etot = -14.6249037420871 +137000 ekin = 0.127443476996694 | erot = 0.391972186713497 | epot = -15.1443194057198 | etot = -14.6249037420096 +138000 ekin = 0.108312970525399 | erot = 0.38863170083623 | epot = -15.121848413308 | etot = -14.6249037419464 +139000 ekin = 0.0928612988417865 | erot = 0.388121053034643 | epot = -15.1058860937781 | etot = -14.6249037419017 +140000 ekin = 0.0816456573909381 | erot = 0.390586148388578 | epot = -15.0971355476584 | etot = -14.6249037418789 +141000 ekin = 0.074959634987115 | erot = 0.396090706683305 | epot = -15.0959540835502 | etot = -14.6249037418797 +142000 ekin = 0.072808553768854 | erot = 0.404612196534598 | epot = -15.1023244922079 | etot = -14.6249037419044 +143000 ekin = 0.0749117535381453 | erot = 0.416039504837322 | epot = -15.1158550003263 | etot = -14.6249037419509 +144000 ekin = 0.0807320498018154 | erot = 0.430173136684429 | epot = -15.1358089285018 | etot = -14.6249037420155 +145000 ekin = 0.0895290255830711 | erot = 0.44672889393778 | epot = -15.1611616616143 | etot = -14.6249037420935 +146000 ekin = 0.100429851262872 | erot = 0.46534582966922 | epot = -15.1906794231108 | etot = -14.6249037421787 +147000 ekin = 0.112509264558272 | erot = 0.485598823527704 | epot = -15.2230118303508 | etot = -14.6249037422648 +148000 ekin = 0.124869425792311 | erot = 0.507015469189125 | epot = -15.2567886373275 | etot = -14.6249037423461 +149000 ekin = 0.136710750658201 | erot = 0.529096273050756 | epot = -15.2907107661264 | etot = -14.6249037424174 +150000 ekin = 0.147386480805994 | erot = 0.551336607351909 | epot = -15.3236268306334 | etot = -14.6249037424755 +151000 ekin = 0.156436378415923 | erot = 0.573248570644847 | epot = -15.3545886915789 | etot = -14.6249037425181 +152000 ekin = 0.163597998371616 | erot = 0.594380933602504 | epot = -15.3828826745191 | etot = -14.624903742545 +153000 ekin = 0.168796920199645 | erot = 0.614335653334077 | epot = -15.4080363160909 | etot = -14.6249037425571 +154000 ekin = 0.172119667637843 | erot = 0.632779929091333 | epot = -15.4298033392859 | etot = -14.6249037425567 +155000 ekin = 0.173774602206439 | erot = 0.649453329864798 | epot = -15.4481316746178 | etot = -14.6249037425466 +156000 ekin = 0.174046854480218 | erot = 0.664170048550206 | epot = -15.4631206455604 | etot = -14.62490374253 +157000 ekin = 0.17325345101635 | erot = 0.67681676270221 | epot = -15.4749739562283 | etot = -14.6249037425097 +158000 ekin = 0.171704281293994 | erot = 0.687346881267705 | epot = -15.48395490505 | etot = -14.6249037424883 +159000 ekin = 0.169673443700116 | erot = 0.695772131172833 | epot = -15.4903493173403 | etot = -14.6249037424673 +160000 ekin = 0.167383826014799 | erot = 0.702152502586226 | epot = -15.4944400710487 | etot = -14.6249037424476 +161000 ekin = 0.165005624031947 | erot = 0.706585545944227 | epot = -15.4964949124054 | etot = -14.6249037424292 +162000 ekin = 0.162667154471987 | erot = 0.7091959147906 | epot = -15.4967668116741 | etot = -14.6249037424115 +163000 ekin = 0.160474189581708 | erot = 0.710125892129571 | epot = -15.4955038241048 | etot = -14.6249037423935 +164000 ekin = 0.158532578972808 | erot = 0.709527441008673 | epot = -15.4929637623557 | etot = -14.6249037423742 +165000 ekin = 0.156968465370873 | erot = 0.707556101120943 | epot = -15.4894283088449 | etot = -14.624903742353 +166000 ekin = 0.155941053191322 | erot = 0.704366832057858 | epot = -15.4852116275794 | etot = -14.6249037423302 +167000 ekin = 0.15564449680974 | erot = 0.700111698658167 | epot = -15.4806599377741 | etot = -14.6249037423062 +168000 ekin = 0.156297672988367 | erot = 0.694939119112688 | epot = -15.4761405343834 | etot = -14.6249037422823 +169000 ekin = 0.158122923325633 | erot = 0.688994262093866 | epot = -15.4720209276801 | etot = -14.6249037422606 +170000 ekin = 0.161316852937839 | erot = 0.682420091513715 | epot = -15.4686406866943 | etot = -14.6249037422428 +171000 ekin = 0.166017619146964 | erot = 0.675358520304694 | epot = -15.4662798816826 | etot = -14.6249037422309 +172000 ekin = 0.172273671159624 | erot = 0.667951149520755 | epot = -15.465128562907 | etot = -14.6249037422266 +173000 ekin = 0.180018623556126 | erot = 0.660339136127817 | epot = -15.465261501915 | etot = -14.624903742231 +174000 ekin = 0.189056055744959 | erot = 0.652661851831919 | epot = -15.4666216498214 | etot = -14.6249037422446 +175000 ekin = 0.199056860650102 | erot = 0.645054167286212 | epot = -15.4690147702031 | etot = -14.6249037422668 +176000 ekin = 0.209570701317496 | erot = 0.637642422787083 | epot = -15.4721168664013 | etot = -14.6249037422968 +177000 ekin = 0.220052442974529 | erot = 0.630539423737744 | epot = -15.4754956090444 | etot = -14.6249037423321 +178000 ekin = 0.229904071991068 | erot = 0.623839102439468 | epot = -15.4786469168001 | etot = -14.6249037423696 +179000 ekin = 0.238532114427838 | erot = 0.617611757778078 | epot = -15.4810476146109 | etot = -14.624903742405 +180000 ekin = 0.245419064060145 | erot = 0.611900922402911 | epot = -15.4822237288958 | etot = -14.6249037424328 +181000 ekin = 0.250203926055637 | erot = 0.606722796615544 | epot = -15.4818304651187 | etot = -14.6249037424476 +182000 ekin = 0.252761402919458 | erot = 0.602068750132192 | epot = -15.4797338954962 | etot = -14.6249037424445 +183000 ekin = 0.253262634973987 | erot = 0.597910660168958 | epot = -15.4760770375644 | etot = -14.6249037424214 +184000 ekin = 0.252195762131854 | erot = 0.594208023727366 | epot = -15.4713075282391 | etot = -14.6249037423799 +185000 ekin = 0.250326113306337 | erot = 0.590915179672999 | epot = -15.4661450353057 | etot = -14.6249037423263 +186000 ekin = 0.248586758541696 | erot = 0.587986907734991 | epot = -15.4614774085483 | etot = -14.6249037422716 +187000 ekin = 0.247909630265907 | erot = 0.585381224304124 | epot = -15.4581945967987 | etot = -14.6249037422287 +188000 ekin = 0.249029052394555 | erot = 0.583059148734203 | epot = -15.4569919433383 | etot = -14.6249037422095 +189000 ekin = 0.25230380318116 | erot = 0.580982165410166 | epot = -15.4581897108133 | etot = -14.624903742222 +190000 ekin = 0.257603763515512 | erot = 0.579108718145525 | epot = -15.4616162239286 | etot = -14.6249037422675 +191000 ekin = 0.264292655598072 | erot = 0.577391223759195 | epot = -15.4665876216979 | etot = -14.6249037423406 +192000 ekin = 0.271315385056371 | erot = 0.575774831089445 | epot = -15.4719939585754 | etot = -14.6249037424296 +193000 ekin = 0.277374539132726 | erot = 0.574198584868558 | epot = -15.4764768665205 | etot = -14.6249037425192 +194000 ekin = 0.281161076019698 | erot = 0.572598913484966 | epot = -15.4786637320983 | etot = -14.6249037425936 +195000 ekin = 0.28159263734721 | erot = 0.570914645865857 | epot = -15.4774110258526 | etot = -14.6249037426396 +196000 ekin = 0.278011867235767 | erot = 0.569092314484949 | epot = -15.4720079243697 | etot = -14.624903742649 +197000 ekin = 0.270307527593016 | erot = 0.567090473640134 | epot = -15.4623017438535 | etot = -14.6249037426204 +198000 ekin = 0.258940359976181 | erot = 0.564882125458909 | epot = -15.4487262279932 | etot = -14.6249037425581 +199000 ekin = 0.244877476699608 | erot = 0.562454912721969 | epot = -15.432236131893 | etot = -14.6249037424714 +200000 ekin = 0.229456931019031 | erot = 0.559809284042109 | epot = -15.4141699574328 | etot = -14.6249037423717 +201000 ekin = 0.214214012279214 | erot = 0.556955381706857 | epot = -15.396073136257 | etot = -14.6249037422709 +202000 ekin = 0.200701376135343 | erot = 0.553909032488835 | epot = -15.3795141508038 | etot = -14.6249037421796 +203000 ekin = 0.190329688711031 | erot = 0.550687503827458 | epot = -15.3659209346438 | etot = -14.6249037421053 +204000 ekin = 0.184246973275431 | erot = 0.547306655839924 | epot = -15.3564573711681 | etot = -14.6249037420528 +205000 ekin = 0.183262973705765 | erot = 0.543779043729182 | epot = -15.3519457594592 | etot = -14.6249037420242 +206000 ekin = 0.187816949073314 | erot = 0.5401134327365 | epot = -15.3528341238289 | etot = -14.6249037420191 +207000 ekin = 0.197980929490155 | erot = 0.536315658388532 | epot = -15.3592003299141 | etot = -14.6249037420354 +208000 ekin = 0.213487612676859 | erot = 0.532390498207104 | epot = -15.3707818529543 | etot = -14.6249037420704 +209000 ekin = 0.23377236271188 | erot = 0.528344018724915 | epot = -15.3870201235577 | etot = -14.6249037421209 +210000 ekin = 0.258021408691598 | erot = 0.524185756556645 | epot = -15.4071109074321 | etot = -14.6249037421838 +211000 ekin = 0.285222208429149 | erot = 0.519930104708152 | epot = -15.4300560553932 | etot = -14.6249037422559 +212000 ekin = 0.314215813604078 | erot = 0.515596398128299 | epot = -15.454715954066 | etot = -14.6249037423336 +213000 ekin = 0.343753634042999 | erot = 0.511207450608694 | epot = -15.4798648270648 | etot = -14.6249037424131 +214000 ekin = 0.372561594269383 | erot = 0.506786560075164 | epot = -15.5042518968341 | etot = -14.6249037424896 +215000 ekin = 0.399412456461965 | erot = 0.502353347158559 | epot = -15.5266695461789 | etot = -14.6249037425584 +216000 ekin = 0.423202666202795 | erot = 0.497919155943979 | epot = -15.5460255647614 | etot = -14.6249037426146 +217000 ekin = 0.443025226539309 | erot = 0.49348301367888 | epot = -15.561411982873 | etot = -14.6249037426548 +218000 ekin = 0.458227302378268 | erot = 0.48902929485633 | epot = -15.5721603399116 | etot = -14.624903742677 +219000 ekin = 0.468443019183614 | erot = 0.484528125251351 | epot = -15.5778748871154 | etot = -14.6249037426804 +220000 ekin = 0.473598483116428 | erot = 0.479939108990727 | epot = -15.5784413347736 | etot = -14.6249037426664 +221000 ekin = 0.473894168318623 | erot = 0.475218183432471 | epot = -15.5740160943877 | etot = -14.6249037426366 +222000 ekin = 0.469774014049581 | erot = 0.470326483973439 | epot = -15.5650042406161 | etot = -14.6249037425931 +223000 ekin = 0.461887320397625 | erot = 0.465239349169327 | epot = -15.5520304121052 | etot = -14.6249037425383 +224000 ekin = 0.451041336422898 | erot = 0.459953336121568 | epot = -15.5358984150205 | etot = -14.6249037424761 +225000 ekin = 0.438137198423164 | erot = 0.454489515561359 | epot = -15.5175304563962 | etot = -14.6249037424117 +226000 ekin = 0.424086332826599 | erot = 0.448892294163476 | epot = -15.4978823693417 | etot = -14.6249037423516 +227000 ekin = 0.409717105195494 | erot = 0.443224250669919 | epot = -15.4778450981669 | etot = -14.6249037423015 +228000 ekin = 0.395692916861841 | erot = 0.437558473222699 | epot = -15.4581551323495 | etot = -14.624903742265 +229000 ekin = 0.382463318564939 | erot = 0.431970318931165 | epot = -15.4393373797388 | etot = -14.6249037422427 +230000 ekin = 0.37025811673091 | erot = 0.426530223272703 | epot = -15.4216920822363 | etot = -14.6249037422326 +231000 ekin = 0.359118625017792 | erot = 0.42129844029256 | epot = -15.4053208075418 | etot = -14.6249037422314 +232000 ekin = 0.348949729121723 | erot = 0.416321816462675 | epot = -15.3901752878201 | etot = -14.6249037422357 +233000 ekin = 0.339575284188518 | erot = 0.411632247273729 | epot = -15.3761112737048 | etot = -14.6249037422426 +234000 ekin = 0.330784909163637 | erot = 0.407246384303507 | epot = -15.3629350357173 | etot = -14.6249037422502 +235000 ekin = 0.322367248495492 | erot = 0.403166248673538 | epot = -15.3504372394263 | etot = -14.6249037422572 +236000 ekin = 0.314129851889848 | erot = 0.399380677843492 | epot = -15.3384142719969 | etot = -14.6249037422636 +237000 ekin = 0.305908300165184 | erot = 0.395867600047875 | epot = -15.3266796424821 | etot = -14.624903742269 +238000 ekin = 0.297568064658136 | erot = 0.392597157204584 | epot = -15.3150689641364 | etot = -14.6249037422737 +239000 ekin = 0.289002756415172 | erot = 0.389535643317114 | epot = -15.3034421420096 | etot = -14.6249037422774 +240000 ekin = 0.280132201614914 | erot = 0.386650129641556 | epot = -15.2916860735363 | etot = -14.6249037422798 +241000 ekin = 0.270903172980511 | erot = 0.383913574227165 | epot = -15.2797204894881 | etot = -14.6249037422804 +242000 ekin = 0.261294311102232 | erot = 0.381310019034049 | epot = -15.2675080724143 | etot = -14.6249037422781 +243000 ekin = 0.251325265434219 | erot = 0.378839435319532 | epot = -15.2550684430252 | etot = -14.6249037422715 +244000 ekin = 0.241068460184283 | erot = 0.376521662813082 | epot = -15.2424938652572 | etot = -14.6249037422598 +245000 ekin = 0.230660579660644 | erot = 0.374398842117291 | epot = -15.2299631640205 | etot = -14.6249037422425 +246000 ekin = 0.220310176855083 | erot = 0.372535772164452 | epot = -15.217749691239 | etot = -14.6249037422195 +247000 ekin = 0.210297920408214 | erot = 0.371017759432552 | epot = -15.2062194220322 | etot = -14.6249037421914 +248000 ekin = 0.200966973970082 | erot = 0.36994577990608 | epot = -15.1958164960362 | etot = -14.6249037421601 +249000 ekin = 0.192702752056133 | erot = 0.369429135338683 | epot = -15.1870356295227 | etot = -14.6249037421279 +250000 ekin = 0.185903524092239 | erot = 0.369576201101353 | epot = -15.1803834672915 | etot = -14.6249037420979 +251000 ekin = 0.180945546219151 | erot = 0.370484246994623 | epot = -15.1763335352865 | etot = -14.6249037420727 +252000 ekin = 0.178147956309189 | erot = 0.372229589272153 | epot = -15.1752812876364 | etot = -14.624903742055 +253000 ekin = 0.177743031464987 | erot = 0.374859230992971 | epot = -15.1775060045044 | etot = -14.6249037420464 +254000 ekin = 0.179856300054645 | erot = 0.378385037101156 | epot = -15.1831450792033 | etot = -14.6249037420475 +255000 ekin = 0.184498455786156 | erot = 0.382781080046288 | epot = -15.1921832778908 | etot = -14.6249037420584 +256000 ekin = 0.191568141872831 | erot = 0.387983970946124 | epot = -15.2044558548971 | etot = -14.6249037420782 +257000 ekin = 0.20086208487434 | erot = 0.39389562099376 | epot = -15.2196614479739 | etot = -14.6249037421058 +258000 ekin = 0.212087875566807 | erot = 0.400387498987271 | epot = -15.2373791166947 | etot = -14.6249037421406 +259000 ekin = 0.224875306192123 | erot = 0.407305396776656 | epot = -15.2570844451507 | etot = -14.6249037421819 +260000 ekin = 0.238784314763303 | erot = 0.414473950040634 | epot = -15.2781620070332 | etot = -14.6249037422292 +261000 ekin = 0.253310397642086 | erot = 0.421700596682803 | epot = -15.2999147366071 | etot = -14.6249037422822 +262000 ekin = 0.26789075041242 | erot = 0.428779149458854 | epot = -15.3215736422117 | etot = -14.6249037423404 +263000 ekin = 0.281915541778016 | erot = 0.435493571930236 | epot = -15.3423128561104 | etot = -14.6249037424021 +264000 ekin = 0.294748319449364 | erot = 0.441622773940569 | epot = -15.3612748358549 | etot = -14.624903742465 +265000 ekin = 0.305757851305535 | erot = 0.446947232466421 | epot = -15.3776088262975 | etot = -14.6249037425255 +266000 ekin = 0.314361275702592 | erot = 0.451257984268131 | epot = -15.3905230025502 | etot = -14.6249037425794 +267000 ekin = 0.320075758814341 | erot = 0.454368036195608 | epot = -15.399347537632 | etot = -14.624903742622 +268000 ekin = 0.322573111286139 | erot = 0.456125517717021 | epot = -15.4036023716517 | etot = -14.6249037426486 +269000 ekin = 0.321728949457285 | erot = 0.456427019950081 | epot = -15.4030597120627 | etot = -14.6249037426554 +270000 ekin = 0.317655198203759 | erot = 0.455228696070215 | epot = -15.397787636915 | etot = -14.624903742641 +271000 ekin = 0.310703151367757 | erot = 0.452552178356157 | epot = -15.3881590723317 | etot = -14.6249037426077 +272000 ekin = 0.3014262335366 | erot = 0.448482664562447 | epot = -15.37481264066 | etot = -14.624903742561 +273000 ekin = 0.290499502093233 | erot = 0.443158007811504 | epot = -15.3585612524143 | etot = -14.6249037425096 +274000 ekin = 0.278606962225926 | erot = 0.436750209658098 | epot = -15.3402609143472 | etot = -14.6249037424632 +275000 ekin = 0.266323480340475 | erot = 0.429443553159133 | epot = -15.320670775929 | etot = -14.6249037424294 +276000 ekin = 0.254026977157675 | erot = 0.421415402005373 | epot = -15.3003461215741 | etot = -14.6249037424111 +277000 ekin = 0.241871064453077 | erot = 0.412825312322701 | epot = -15.2796001191813 | etot = -14.6249037424055 +278000 ekin = 0.229828041579266 | erot = 0.403815416630584 | epot = -15.2585472006154 | etot = -14.6249037424055 +279000 ekin = 0.217786141145793 | erot = 0.394521119097645 | epot = -15.2372110026455 | etot = -14.6249037424021 +280000 ekin = 0.205666064593437 | erot = 0.385087703032635 | epot = -15.2156575100138 | etot = -14.6249037423877 +281000 ekin = 0.193518604274061 | erot = 0.375686870763365 | epot = -15.1941092173957 | etot = -14.6249037423582 +282000 ekin = 0.18157672074763 | erot = 0.366527860022155 | epot = -15.1730083230837 | etot = -14.624903742314 +283000 ekin = 0.170254050626075 | erot = 0.357859944224688 | epot = -15.1530177371095 | etot = -14.6249037422587 +284000 ekin = 0.160098631070491 | erot = 0.349965713706295 | epot = -15.1349680869751 | etot = -14.6249037421983 +285000 ekin = 0.151720356670846 | erot = 0.34314662552044 | epot = -15.1197707243306 | etot = -14.6249037421394 +286000 ekin = 0.145712559183964 | erot = 0.337703485421193 | epot = -15.1083197866929 | etot = -14.6249037420878 +287000 ekin = 0.142584250545026 | erot = 0.333914836093095 | epot = -15.1014028286861 | etot = -14.624903742048 +288000 ekin = 0.1427129413407 | erot = 0.33201595204283 | epot = -15.0996326354059 | etot = -14.6249037420224 +289000 ekin = 0.146320998448507 | erot = 0.332180585090171 | epot = -15.1034053255506 | etot = -14.6249037420119 +290000 ekin = 0.153472816921105 | erot = 0.334506983379138 | epot = -15.1128835423165 | etot = -14.6249037420163 +291000 ekin = 0.164086465662505 | erot = 0.339009144348392 | epot = -15.1279993520451 | etot = -14.6249037420342 +292000 ekin = 0.177952173600193 | erot = 0.345613807734964 | epot = -15.1484697233995 | etot = -14.6249037420643 +293000 ekin = 0.194750859968512 | erot = 0.354163344443286 | epot = -15.1738179465169 | etot = -14.6249037421051 +294000 ekin = 0.214068309158811 | erot = 0.364424408222176 | epot = -15.2033964595362 | etot = -14.6249037421552 +295000 ekin = 0.235403710402673 | erot = 0.376101928511166 | epot = -15.2364093811272 | etot = -14.6249037422133 +296000 ekin = 0.258174229752594 | erot = 0.388857685536638 | epot = -15.2719356575669 | etot = -14.6249037422777 +297000 ekin = 0.28171936013486 | erot = 0.402332315571688 | epot = -15.308955418053 | etot = -14.6249037423465 +298000 ekin = 0.30530968452295 | erot = 0.416169191335505 | epot = -15.3463826182751 | etot = -14.6249037424166 +299000 ekin = 0.328164426016042 | erot = 0.430038291827055 | epot = -15.3831064603285 | etot = -14.6249037424854 +300000 ekin = 0.349480947254597 | erot = 0.443657997414049 | epot = -15.4180426872175 | etot = -14.6249037425489 +301000 ekin = 0.368477349758915 | erot = 0.456812763608253 | epot = -15.4501938559697 | etot = -14.6249037426025 +302000 ekin = 0.384446573101029 | erot = 0.469364841860584 | epot = -15.478715157604 | etot = -14.6249037426423 +303000 ekin = 0.396817065634643 | erot = 0.481258609604428 | epot = -15.5029794179037 | etot = -14.6249037426647 +304000 ekin = 0.405211709647263 | erot = 0.492516637287232 | epot = -15.5226320896016 | etot = -14.6249037426671 +305000 ekin = 0.409494186866275 | erot = 0.503227368869637 | epot = -15.5376252983854 | etot = -14.6249037426495 +306000 ekin = 0.409791521883174 | erot = 0.513525227982492 | epot = -15.5482204924795 | etot = -14.6249037426138 +307000 ekin = 0.406484029568133 | erot = 0.523565033268022 | epot = -15.554952805401 | etot = -14.6249037425649 +308000 ekin = 0.400159443094258 | erot = 0.533493670193094 | epot = -15.5585568557967 | etot = -14.6249037425093 +309000 ekin = 0.391535685674106 | erot = 0.543422788904079 | epot = -15.5598622170332 | etot = -14.624903742455 +310000 ekin = 0.381364662750139 | erot = 0.553406603763137 | epot = -15.5596750089224 | etot = -14.6249037424091 +311000 ekin = 0.370335174701307 | erot = 0.563428434508751 | epot = -15.5586673515872 | etot = -14.6249037423771 +312000 ekin = 0.358994462074446 | erot = 0.573398378860501 | epot = -15.5572965832962 | etot = -14.6249037423613 +313000 ekin = 0.347704062022306 | erot = 0.583162598674582 | epot = -15.5557704030575 | etot = -14.6249037423606 +314000 ekin = 0.336637402906986 | erot = 0.592522528333631 | epot = -15.5540636736117 | etot = -14.624903742371 +315000 ekin = 0.325816357219225 | erot = 0.601260411440956 | epot = -15.5519805110472 | etot = -14.624903742387 +316000 ekin = 0.315175012816655 | erot = 0.609166451967456 | epot = -15.5492452071862 | etot = -14.6249037424021 +317000 ekin = 0.304633856553691 | erot = 0.616062831071924 | epot = -15.5456004300362 | etot = -14.6249037424106 +318000 ekin = 0.294167456686513 | erot = 0.62182086663663 | epot = -15.5408920657322 | etot = -14.624903742409 +319000 ekin = 0.283852816310304 | erot = 0.626369338623922 | epot = -15.5351258973303 | etot = -14.624903742396 +320000 ekin = 0.273891844373217 | erot = 0.629693948583815 | epot = -15.5284895353292 | etot = -14.6249037423721 +321000 ekin = 0.264607615830326 | erot = 0.631829520444979 | epot = -15.5213408786153 | etot = -14.62490374234 +322000 ekin = 0.256418665980307 | erot = 0.632847556381831 | epot = -15.5141699646654 | etot = -14.6249037423032 +323000 ekin = 0.249797892887523 | erot = 0.632842055921361 | epot = -15.5075436910745 | etot = -14.6249037422657 +324000 ekin = 0.245223011939351 | erot = 0.631916211662891 | epot = -15.5020429658331 | etot = -14.6249037422309 +325000 ekin = 0.243124676660684 | erot = 0.630171930979688 | epot = -15.4982003498434 | etot = -14.624903742203 +326000 ekin = 0.243837159968099 | erot = 0.627703310196172 | epot = -15.4964442123488 | etot = -14.6249037421845 +327000 ekin = 0.247555458534595 | erot = 0.624594349329669 | epot = -15.4970535500421 | etot = -14.6249037421778 +328000 ekin = 0.254302069317299 | erot = 0.620920422826771 | epot = -15.5001262343279 | etot = -14.6249037421838 +329000 ekin = 0.263906382978619 | erot = 0.616752378549859 | epot = -15.5055625037313 | etot = -14.6249037422028 +330000 ekin = 0.275999298196813 | erot = 0.612161709808654 | epot = -15.5130647502395 | etot = -14.624903742234 +331000 ekin = 0.290024872454789 | erot = 0.607225138478484 | epot = -15.5221537532086 | etot = -14.6249037422753 +332000 ekin = 0.305269328205604 | erot = 0.602027230533244 | epot = -15.5322003010627 | etot = -14.6249037423238 +333000 ekin = 0.320905611375339 | erot = 0.596660303338559 | epot = -15.5424696570899 | etot = -14.624903742376 +334000 ekin = 0.33604943896321 | erot = 0.591221710457376 | epot = -15.5521748918485 | etot = -14.6249037424279 +335000 ekin = 0.349821102707738 | erot = 0.585809355783106 | epot = -15.5605342009668 | etot = -14.624903742476 +336000 ekin = 0.361406827299164 | erot = 0.580516763971287 | epot = -15.5668273337868 | etot = -14.6249037425163 +337000 ekin = 0.370114335989308 | erot = 0.575429096256479 | epot = -15.5704471747923 | etot = -14.6249037425465 +338000 ekin = 0.375418963131897 | erot = 0.570621177508977 | epot = -15.5709438832049 | etot = -14.624903742564 +339000 ekin = 0.37699830668418 | erot = 0.566157982091382 | epot = -15.568060031343 | etot = -14.6249037425674 +340000 ekin = 0.374754278532065 | erot = 0.562097189039008 | epot = -15.5617552101272 | etot = -14.6249037425561 +341000 ekin = 0.368821588409643 | erot = 0.558493134368575 | epot = -15.5522184653083 | etot = -14.62490374253 +342000 ekin = 0.359561251230613 | erot = 0.555400700218343 | epot = -15.5398656939398 | etot = -14.6249037424909 +343000 ekin = 0.34753785325451 | erot = 0.55287778591816 | epot = -15.5253193816136 | etot = -14.6249037424409 +344000 ekin = 0.33348037496383 | erot = 0.55098526840084 | epot = -15.5093693857485 | etot = -14.6249037423838 +345000 ekin = 0.318228359784329 | erot = 0.549783918348214 | epot = -15.4929160204567 | etot = -14.6249037423241 +346000 ekin = 0.302667555547452 | erot = 0.54932843011035 | epot = -15.4768997279244 | etot = -14.6249037422666 +347000 ekin = 0.287661057443402 | erot = 0.549659363310377 | epot = -15.4622241629697 | etot = -14.6249037422159 +348000 ekin = 0.273982878354199 | erot = 0.550794243902694 | epot = -15.4496808644332 | etot = -14.6249037421763 +349000 ekin = 0.262260631617831 | erot = 0.552719272009444 | epot = -15.4398836457781 | etot = -14.6249037421509 +350000 ekin = 0.252932884528162 | erot = 0.555383042233064 | epot = -15.4332196689026 | etot = -14.6249037421414 +351000 ekin = 0.246225113234554 | erot = 0.558693418765032 | epot = -15.4298222741477 | etot = -14.6249037421482 +352000 ekin = 0.242146418558272 | erot = 0.56251834442516 | epot = -15.4295685051533 | etot = -14.6249037421699 +353000 ekin = 0.240507191582667 | erot = 0.566690733134521 | epot = -15.4321016669209 | etot = -14.6249037422037 +354000 ekin = 0.240955911174045 | erot = 0.571016874086999 | epot = -15.436876527507 | etot = -14.6249037422459 +355000 ekin = 0.243030568944153 | erot = 0.575286990707781 | epot = -15.4432213019441 | etot = -14.6249037422922 +356000 ekin = 0.246218336341581 | erot = 0.579286102670368 | epot = -15.4504081813502 | etot = -14.6249037423382 +357000 ekin = 0.250015504867143 | erot = 0.582803084083675 | epot = -15.4577223313313 | etot = -14.6249037423804 +358000 ekin = 0.253980003728345 | erot = 0.585636256510411 | epot = -15.4645200026548 | etot = -14.6249037424161 +359000 ekin = 0.257771924238285 | erot = 0.587595069854159 | epot = -15.470270736536 | etot = -14.6249037424435 +360000 ekin = 0.261178006692362 | erot = 0.588498175296126 | epot = -15.4745799244509 | etot = -14.6249037424624 +361000 ekin = 0.264121303803865 | erot = 0.588169931158578 | epot = -15.4771949774352 | etot = -14.6249037424728 +362000 ekin = 0.266656268947586 | erot = 0.586437607933159 | epot = -15.4779976193564 | etot = -14.6249037424757 +363000 ekin = 0.268947338173594 | erot = 0.583131261385069 | epot = -15.4769823420319 | etot = -14.6249037424733 +364000 ekin = 0.271226723299151 | erot = 0.578087502910549 | epot = -15.4742179686787 | etot = -14.624903742469 +365000 ekin = 0.273728224388467 | erot = 0.571157191000871 | epot = -15.4697891578569 | etot = -14.6249037424676 +366000 ekin = 0.276601570519792 | erot = 0.562216266683795 | epot = -15.4637215796778 | etot = -14.6249037424742 +367000 ekin = 0.279824898676098 | erot = 0.551178529879434 | epot = -15.4559071710478 | etot = -14.6249037424923 +368000 ekin = 0.283144751011445 | erot = 0.538009090150866 | epot = -15.4460575836835 | etot = -14.6249037425212 +369000 ekin = 0.286073979195581 | erot = 0.522737270878923 | epot = -15.4337149926306 | etot = -14.6249037425561 +370000 ekin = 0.287962637923446 | erot = 0.505467651700438 | epot = -15.4183340322116 | etot = -14.6249037425877 +371000 ekin = 0.288129562577258 | erot = 0.486387667907668 | epot = -15.3994209730903 | etot = -14.6249037426054 +372000 ekin = 0.286016270828658 | erot = 0.46576999808234 | epot = -15.3766900115119 | etot = -14.6249037426009 +373000 ekin = 0.28131449291777 | erot = 0.44396824694377 | epot = -15.3501864824323 | etot = -14.6249037425708 +374000 ekin = 0.274029637541844 | erot = 0.421405384814399 | epot = -15.3203387648735 | etot = -14.6249037425173 +375000 ekin = 0.264468317324484 | erot = 0.398555847613824 | epot = -15.2879279073849 | etot = -14.6249037424466 +376000 ekin = 0.253165169268526 | erot = 0.375923572597148 | epot = -15.2539924842331 | etot = -14.6249037423675 +377000 ekin = 0.240780733675043 | erot = 0.354018931407531 | epot = -15.2197034073705 | etot = -14.6249037422879 +378000 ekin = 0.228003530693319 | erot = 0.333337224178132 | epot = -15.1862444970855 | etot = -14.624903742214 +379000 ekin = 0.215478669427759 | erot = 0.314340303318484 | epot = -15.1547227148953 | etot = -14.624903742149 +380000 ekin = 0.203769466320592 | erot = 0.297441561968215 | epot = -15.1261147703835 | etot = -14.6249037420947 +381000 ekin = 0.193344913038784 | erot = 0.28299357961111 | epot = -15.1012422347014 | etot = -14.6249037420515 +382000 ekin = 0.184579097116762 | erot = 0.271277560103732 | epot = -15.0807603992407 | etot = -14.6249037420202 +383000 ekin = 0.177749902922565 | erot = 0.262494318474771 | epot = -15.0651479633987 | etot = -14.6249037420014 +384000 ekin = 0.173031383434342 | erot = 0.256757595375907 | epot = -15.0546927208061 | etot = -14.6249037419958 +385000 ekin = 0.170483112154611 | erot = 0.254091341095815 | epot = -15.049478195254 | etot = -14.6249037420036 +386000 ekin = 0.170046361592112 | erot = 0.254432809989126 | epot = -15.0493829136047 | etot = -14.6249037420235 +387000 ekin = 0.171558026226825 | erot = 0.257642587604582 | epot = -15.0541043558832 | etot = -14.6249037420518 +388000 ekin = 0.174787865438713 | erot = 0.263521131369935 | epot = -15.0632127388923 | etot = -14.6249037420836 +389000 ekin = 0.179494526901415 | erot = 0.271829477565432 | epot = -15.0762277465806 | etot = -14.6249037421138 +390000 ekin = 0.185484901052056 | erot = 0.282310127810448 | epot = -15.0926987710007 | etot = -14.6249037421382 +391000 ekin = 0.192654775275645 | erot = 0.294703495235847 | epot = -15.1122620126676 | etot = -14.6249037421561 +392000 ekin = 0.200990711955422 | erot = 0.308756153372483 | epot = -15.1346506074986 | etot = -14.6249037421707 +393000 ekin = 0.210524629688135 | erot = 0.324219483680835 | epot = -15.1596478555569 | etot = -14.624903742188 +394000 ekin = 0.221250398117909 | erot = 0.340840530849171 | epot = -15.1869946711819 | etot = -14.6249037422148 +395000 ekin = 0.233028912153377 | erot = 0.358349828150776 | epot = -15.2162824825608 | etot = -14.6249037422566 +396000 ekin = 0.24551683484774 | erot = 0.376452447323546 | epot = -15.246873024486 | etot = -14.6249037423147 +397000 ekin = 0.258149646288765 | erot = 0.394827815017102 | epot = -15.277881203691 | etot = -14.6249037423851 +398000 ekin = 0.270192540269911 | erot = 0.413141033371924 | epot = -15.3082373161009 | etot = -14.624903742459 +399000 ekin = 0.280849396853359 | erot = 0.431064534842246 | epot = -15.3368176742213 | etot = -14.6249037425257 +400000 ekin = 0.289399657315015 | erot = 0.448305349544995 | epot = -15.3626087494354 | etot = -14.6249037425754 +401000 ekin = 0.295323233787434 | erot = 0.464631356381723 | epot = -15.3848583327708 | etot = -14.6249037426017 +402000 ekin = 0.298377750400983 | erot = 0.479890206670516 | epot = -15.403171699675 | etot = -14.6249037426035 +403000 ekin = 0.298608046776455 | erot = 0.49401684483596 | epot = -15.4175286341975 | etot = -14.6249037425851 +404000 ekin = 0.296288720275777 | erot = 0.507028747324647 | epot = -15.4282212101546 | etot = -14.6249037425541 +405000 ekin = 0.291819450890444 | erot = 0.519011022290083 | epot = -15.4357342157004 | etot = -14.6249037425198 +406000 ekin = 0.285604695316647 | erot = 0.530095491696055 | epot = -15.4406039295028 | etot = -14.6249037424901 +407000 ekin = 0.2779517950128 | erot = 0.540438449781317 | epot = -15.4432939872644 | etot = -14.6249037424703 +408000 ekin = 0.269015012492784 | erot = 0.550201084797022 | epot = -15.4441198397505 | etot = -14.6249037424607 +409000 ekin = 0.258799683407146 | erot = 0.559535019811769 | epot = -15.4432384456767 | etot = -14.6249037424578 +410000 ekin = 0.247223943172528 | erot = 0.568573648692213 | epot = -15.4407013343199 | etot = -14.6249037424552 +411000 ekin = 0.234219542826923 | erot = 0.577428429926601 | epot = -15.4365517151993 | etot = -14.6249037424458 +412000 ekin = 0.219842320368698 | erot = 0.586188386128906 | epot = -15.4309344489214 | etot = -14.6249037424238 +413000 ekin = 0.20435994837526 | erot = 0.594920843620994 | epot = -15.4241845343832 | etot = -14.6249037423869 +414000 ekin = 0.188290368309867 | erot = 0.603671832826878 | epot = -15.4168659434732 | etot = -14.6249037423364 +415000 ekin = 0.17237708181712 | erot = 0.6124653242919 | epot = -15.4097461483873 | etot = -14.6249037422783 +416000 ekin = 0.157503657631228 | erot = 0.621301324615769 | epot = -15.4037087244679 | etot = -14.6249037422209 +417000 ekin = 0.144565276806289 | erot = 0.630153567597092 | epot = -15.399622586577 | etot = -14.6249037421736 +418000 ekin = 0.134326161306418 | erot = 0.638967960411968 | epot = -15.398197863863 | etot = -14.6249037421446 +419000 ekin = 0.127295713867183 | erot = 0.647663024756225 | epot = -15.3998624807619 | etot = -14.6249037421385 +420000 ekin = 0.123652074079106 | erot = 0.656133267678458 | epot = -15.4046890839134 | etot = -14.6249037421558 +421000 ekin = 0.123230332545554 | erot = 0.664256043547071 | epot = -15.4123901182848 | etot = -14.6249037421922 +422000 ekin = 0.125576493084721 | erot = 0.671901405101286 | epot = -15.4223816404263 | etot = -14.6249037422402 +423000 ekin = 0.130051930466301 | erot = 0.678943694027942 | epot = -15.4338993667852 | etot = -14.6249037422909 +424000 ekin = 0.135961143238876 | erot = 0.685273086227244 | epot = -15.4461379718019 | etot = -14.6249037423358 +425000 ekin = 0.142671659965505 | erot = 0.69080498381162 | epot = -15.4583803861461 | etot = -14.624903742369 +426000 ekin = 0.149699767318722 | erot = 0.695485561348404 | epot = -15.4700890710554 | etot = -14.6249037423883 +427000 ekin = 0.156747049208244 | erot = 0.699292628464214 | epot = -15.4809434200673 | etot = -14.6249037423948 +428000 ekin = 0.163686553654253 | erot = 0.702231990285515 | epot = -15.4908222863323 | etot = -14.6249037423925 +429000 ekin = 0.170509683514413 | erot = 0.70433031530151 | epot = -15.4997437412025 | etot = -14.6249037423866 +430000 ekin = 0.177252892951188 | erot = 0.705626025883397 | epot = -15.507782661217 | etot = -14.6249037423824 +431000 ekin = 0.183925691222352 | erot = 0.706159951516081 | epot = -15.5149893851221 | etot = -14.6249037423836 +432000 ekin = 0.190457851079565 | erot = 0.70596688379378 | epot = -15.5213284772654 | etot = -14.6249037423921 +433000 ekin = 0.196676887388984 | erot = 0.705069371776661 | epot = -15.5266500015729 | etot = -14.6249037424073 +434000 ekin = 0.202317433899364 | erot = 0.703474477741261 | epot = -15.5306956540676 | etot = -14.624903742427 +435000 ekin = 0.207056046506538 | erot = 0.701173837003675 | epot = -15.533133625958 | etot = -14.6249037424478 +436000 ekin = 0.210560164856777 | erot = 0.698146912242834 | epot = -15.5336108195658 | etot = -14.6249037424662 +437000 ekin = 0.212539330538657 | erot = 0.69436686481977 | epot = -15.5318099378375 | etot = -14.6249037424791 +438000 ekin = 0.212789433625669 | erot = 0.689808070113577 | epot = -15.5275012462234 | etot = -14.6249037424842 +439000 ekin = 0.211224885327081 | erot = 0.684454087056256 | epot = -15.5205827148631 | etot = -14.6249037424798 +440000 ekin = 0.207897417438738 | erot = 0.678304934040362 | epot = -15.5111060939442 | etot = -14.6249037424651 +441000 ekin = 0.203002684917544 | erot = 0.671382822497087 | epot = -15.4992892498551 | etot = -14.6249037424404 +442000 ekin = 0.196876783893444 | erot = 0.663735946787442 | epot = -15.485516473087 | etot = -14.6249037424062 +443000 ekin = 0.189984458135359 | erot = 0.655440346227863 | epot = -15.4703285467267 | etot = -14.6249037423634 +444000 ekin = 0.182899715135716 | erot = 0.646600090309095 | epot = -15.4544035477587 | etot = -14.6249037423138 +445000 ekin = 0.176278659807256 | erot = 0.637346059016788 | epot = -15.4385284610839 | etot = -14.6249037422598 +446000 ekin = 0.170824489262319 | erot = 0.627833490901675 | epot = -15.4235617223679 | etot = -14.6249037422039 +447000 ekin = 0.167246115781588 | erot = 0.618238375507795 | epot = -15.4103882334389 | etot = -14.6249037421495 +448000 ekin = 0.166214016011178 | erot = 0.608752709244163 | epot = -15.3998704673549 | etot = -14.6249037420996 +449000 ekin = 0.168318002547464 | erot = 0.599578546515158 | epot = -15.3928002911194 | etot = -14.6249037420568 +450000 ekin = 0.174030350885997 | erot = 0.590920601689278 | epot = -15.3898546945991 | etot = -14.6249037420239 +451000 ekin = 0.183674309612449 | erot = 0.582976972210044 | epot = -15.3915550238259 | etot = -14.6249037420034 +452000 ekin = 0.197394458885136 | erot = 0.575927582957288 | epot = -15.3982257838406 | etot = -14.6249037419982 +453000 ekin = 0.21512429096355 | erot = 0.569920414706644 | epot = -15.4099484476817 | etot = -14.6249037420115 +454000 ekin = 0.236549344238021 | erot = 0.565056494271684 | epot = -15.4265095805563 | etot = -14.6249037420466 +455000 ekin = 0.26107066649251 | erot = 0.561375729613514 | epot = -15.4473501382118 | etot = -14.6249037421058 +456000 ekin = 0.287780783018564 | erot = 0.558846520705737 | epot = -15.4715310459135 | etot = -14.6249037421892 +457000 ekin = 0.315469350478398 | erot = 0.557362227355198 | epot = -15.4977353201268 | etot = -14.6249037422932 +458000 ekin = 0.342675461160486 | erot = 0.556746783054669 | epot = -15.5243259866254 | etot = -14.6249037424102 +459000 ekin = 0.367796771323547 | erot = 0.556770049266648 | epot = -15.5494705631187 | etot = -14.6249037425286 +460000 ekin = 0.389252836428699 | erot = 0.557171234684316 | epot = -15.5713278137469 | etot = -14.6249037426338 +461000 ekin = 0.405683830371934 | erot = 0.557686417732654 | epot = -15.588273990816 | etot = -14.6249037427114 +462000 ekin = 0.41615050976317 | erot = 0.558074591843087 | epot = -15.5991288443563 | etot = -14.62490374275 +463000 ekin = 0.420292029664587 | erot = 0.558136338549784 | epot = -15.6033321109585 | etot = -14.6249037427441 +464000 ekin = 0.418399545177946 | erot = 0.557720582602229 | epot = -15.6010238704766 | etot = -14.6249037426964 +465000 ekin = 0.411377435968348 | erot = 0.556717766126943 | epot = -15.592998944713 | etot = -14.6249037426177 +466000 ekin = 0.400588481170385 | erot = 0.555041504869352 | epot = -15.5805337285651 | etot = -14.6249037425254 +467000 ekin = 0.387608315925592 | erot = 0.552604267016079 | epot = -15.5651163253806 | etot = -14.6249037424389 +468000 ekin = 0.373939506071155 | erot = 0.549294716065804 | epot = -15.5481379645132 | etot = -14.6249037423763 +469000 ekin = 0.360748545285724 | erot = 0.544964338610985 | epot = -15.5306166262455 | etot = -14.6249037423488 +470000 ekin = 0.348685397522308 | erot = 0.539428754142175 | epot = -15.5130178940236 | etot = -14.6249037423592 +471000 ekin = 0.337825425309533 | erot = 0.532485282885717 | epot = -15.4952144505958 | etot = -14.6249037424005 +472000 ekin = 0.327743216876142 | erot = 0.523944004294882 | epot = -15.4765909636297 | etot = -14.6249037424587 +473000 ekin = 0.317695625905302 | erot = 0.513665869846428 | epot = -15.4562652382673 | etot = -14.6249037425156 +474000 ekin = 0.306866206293077 | erot = 0.501599410558585 | epot = -15.4333693594052 | etot = -14.6249037425536 +475000 ekin = 0.294611572516325 | erot = 0.487807694339578 | epot = -15.4073230094157 | etot = -14.6249037425598 +476000 ekin = 0.280654133646186 | erot = 0.472479343852861 | epot = -15.3780372200275 | etot = -14.6249037425285 +477000 ekin = 0.265182667318923 | erot = 0.45592098927681 | epot = -15.3460073990573 | etot = -14.6249037424616 +478000 ekin = 0.248846579356572 | erot = 0.438532535944384 | epot = -15.3122828576692 | etot = -14.6249037423683 +479000 ekin = 0.232654569021534 | erot = 0.420770062233477 | epot = -15.2783283735172 | etot = -14.6249037422622 +480000 ekin = 0.217807844647013 | erot = 0.403103245642619 | epot = -15.2458148324477 | etot = -14.6249037421581 +481000 ekin = 0.205508255202962 | erot = 0.385974572359883 | epot = -15.2163865696323 | etot = -14.6249037420695 +482000 ekin = 0.19678156694235 | erot = 0.369766310247464 | epot = -15.1914516191956 | etot = -14.6249037420058 +483000 ekin = 0.192346943568308 | erot = 0.354778814406232 | epot = -15.1720294999467 | etot = -14.6249037419722 +484000 ekin = 0.192548846646656 | erot = 0.341220938396417 | epot = -15.1586735270114 | etot = -14.6249037419683 +485000 ekin = 0.197351634264863 | erot = 0.329210924265139 | epot = -15.1514663005208 | etot = -14.6249037419908 +486000 ekin = 0.20638457111255 | erot = 0.318784712513067 | epot = -15.1500730256597 | etot = -14.6249037420341 +487000 ekin = 0.219018661980825 | erot = 0.30990833731601 | epot = -15.1538307413881 | etot = -14.6249037420913 +488000 ekin = 0.234457053485159 | erot = 0.302491737711703 | epot = -15.1618525333529 | etot = -14.624903742156 +489000 ekin = 0.251825722281652 | erot = 0.296402451840958 | epot = -15.1731319163445 | etot = -14.6249037422219 +490000 ekin = 0.270257579251709 | erot = 0.291478772534598 | epot = -15.1866400940702 | etot = -14.6249037422839 +491000 ekin = 0.288968023939754 | erot = 0.287542686829926 | epot = -15.2014144531061 | etot = -14.6249037423365 +492000 ekin = 0.307321746939228 | erot = 0.284413165332613 | epot = -15.2166386546469 | etot = -14.6249037423751 +493000 ekin = 0.324889192266724 | erot = 0.281920128741297 | epot = -15.2317130634048 | etot = -14.6249037423968 +494000 ekin = 0.34148788338571 | erot = 0.279918789014045 | epot = -15.2463104147988 | etot = -14.6249037423991 +495000 ekin = 0.357200801059907 | erot = 0.27830316795437 | epot = -15.2604077113965 | etot = -14.6249037423822 +496000 ekin = 0.372363075865331 | erot = 0.277016625443997 | epot = -15.2742834436586 | etot = -14.6249037423492 +497000 ekin = 0.387510424728836 | erot = 0.276056483801624 | epot = -15.2884706508366 | etot = -14.6249037423061 +498000 ekin = 0.40328774473455 | erot = 0.275469725413449 | epot = -15.3036612124099 | etot = -14.6249037422619 +499000 ekin = 0.420322923931638 | erot = 0.275337682298311 | epot = -15.3205643484574 | etot = -14.6249037422275 +500000 ekin = 0.439078206868906 | erot = 0.275749832423424 | epot = -15.3397317815068 | etot = -14.6249037422144 +501000 ekin = 0.459699055392479 | erot = 0.27677002458918 | epot = -15.3613728222145 | etot = -14.6249037422328 +502000 ekin = 0.481887975237045 | erot = 0.278401857022953 | epot = -15.3851935745487 | etot = -14.6249037422887 +503000 ekin = 0.504836001699661 | erot = 0.280562273427077 | epot = -15.4103020175081 | etot = -14.6249037423814 +504000 ekin = 0.527242963720809 | erot = 0.283072520273854 | epot = -15.4352192264968 | etot = -14.6249037425021 +505000 ekin = 0.547444055754969 | erot = 0.285672032586941 | epot = -15.4580198309761 | etot = -14.6249037426342 +506000 ekin = 0.563636138783675 | erot = 0.288055811210013 | epot = -15.4765956927492 | etot = -14.6249037427555 +507000 ekin = 0.574166796919079 | erot = 0.289928574131231 | epot = -15.488999113894 | etot = -14.6249037428437 +508000 ekin = 0.57782515130048 | erot = 0.291063326861402 | epot = -15.4937922210432 | etot = -14.6249037428813 +509000 ekin = 0.574066827021413 | erot = 0.291350176078827 | epot = -15.4903207459603 | etot = -14.6249037428601 +510000 ekin = 0.563118031117931 | erot = 0.290823209378486 | epot = -15.4788449832791 | etot = -14.6249037427827 +511000 ekin = 0.545937816053972 | erot = 0.289659846600232 | epot = -15.4605014053163 | etot = -14.6249037426621 +512000 ekin = 0.52405192466186 | erot = 0.2881539193295 | epot = -15.4371095865088 | etot = -14.6249037425175 +513000 ekin = 0.499300074198536 | erot = 0.28667044386956 | epot = -15.4108742604381 | etot = -14.62490374237 +514000 ekin = 0.473556830411034 | erot = 0.285593013544196 | epot = -15.3840535861943 | etot = -14.6249037422391 +515000 ekin = 0.448481344235602 | erot = 0.285274677057636 | epot = -15.3586597634315 | etot = -14.6249037421383 +516000 ekin = 0.425336124988924 | erot = 0.286000471485298 | epot = -15.3362403385491 | etot = -14.6249037420749 +517000 ekin = 0.404895133581714 | erot = 0.287965811661741 | epot = -15.3177646872924 | etot = -14.624903742049 +518000 ekin = 0.387441371960463 | erot = 0.29127124708814 | epot = -15.3036163611039 | etot = -14.6249037420553 +519000 ekin = 0.372839035853544 | erot = 0.295931281214217 | epot = -15.2936740591526 | etot = -14.6249037420848 +520000 ekin = 0.360656186943702 | erot = 0.301893194868378 | epot = -15.2874531239385 | etot = -14.6249037421264 +521000 ekin = 0.350310207444023 | erot = 0.30906098360492 | epot = -15.2842749332187 | etot = -14.6249037421697 +522000 ekin = 0.341208800540165 | erot = 0.317319408449295 | epot = -15.2834319511959 | etot = -14.6249037422064 +523000 ekin = 0.332862997937259 | erot = 0.326553653087547 | epot = -15.2843203932564 | etot = -14.6249037422316 +524000 ekin = 0.324955020060425 | erot = 0.336661144000779 | epot = -15.2865199063054 | etot = -14.6249037422442 +525000 ekin = 0.317352570821777 | erot = 0.347553686772866 | epot = -15.2898099998417 | etot = -14.6249037422471 +526000 ekin = 0.310071537936686 | erot = 0.359150063852697 | epot = -15.2941253440357 | etot = -14.6249037422464 +527000 ekin = 0.30319969763028 | erot = 0.371361343284829 | epot = -15.2994647831646 | etot = -14.6249037422495 +528000 ekin = 0.296802852838071 | erot = 0.384072970478812 | epot = -15.3057795655796 | etot = -14.6249037422627 +529000 ekin = 0.290839689447108 | erot = 0.397128838352017 | epot = -15.3128722700896 | etot = -14.6249037422905 +530000 ekin = 0.285110822260319 | erot = 0.410322608856454 | epot = -15.320337173449 | etot = -14.6249037423323 +531000 ekin = 0.279260366287054 | erot = 0.423400398731268 | epot = -15.3275645074017 | etot = -14.6249037423834 +532000 ekin = 0.272835705905111 | erot = 0.4360765883685 | epot = -15.3338160367088 | etot = -14.6249037424352 +533000 ekin = 0.265395406955148 | erot = 0.448061330488109 | epot = -15.3383604799197 | etot = -14.6249037424764 +534000 ekin = 0.256640351799918 | erot = 0.459095045026538 | epot = -15.3406391393234 | etot = -14.6249037424969 +535000 ekin = 0.246533633694114 | erot = 0.46898274217995 | epot = -15.3404201183641 | etot = -14.62490374249 +536000 ekin = 0.235373881374739 | erot = 0.477620282695672 | epot = -15.3378979065248 | etot = -14.6249037424544 +537000 ekin = 0.223795203401919 | erot = 0.485006039595133 | epot = -15.3337049853922 | etot = -14.6249037423951 +538000 ekin = 0.212682661997928 | erot = 0.491234540507361 | epot = -15.3288209448297 | etot = -14.6249037423244 +539000 ekin = 0.203011536568405 | erot = 0.496472671627705 | epot = -15.3243879504539 | etot = -14.6249037422578 +540000 ekin = 0.195638496926135 | erot = 0.50092291227584 | epot = -15.3214651514142 | etot = -14.6249037422123 +541000 ekin = 0.191090437374276 | erot = 0.504781043299091 | epot = -15.3207752228744 | etot = -14.624903742201 +542000 ekin = 0.189407567632742 | erot = 0.508197267609352 | epot = -15.3225085774713 | etot = -14.6249037422292 +543000 ekin = 0.190094034781292 | erot = 0.511249275630852 | epot = -15.326247052704 | etot = -14.6249037422918 +544000 ekin = 0.192205662500225 | erot = 0.513933300995961 | epot = -15.3310427058708 | etot = -14.6249037423746 +545000 ekin = 0.194562943958487 | erot = 0.516174993404676 | epot = -15.3356416798199 | etot = -14.6249037424567 +546000 ekin = 0.196033343259802 | erot = 0.517857026727554 | epot = -15.3387941125054 | etot = -14.624903742518 +547000 ekin = 0.19580143908636 | erot = 0.518856237019682 | epot = -15.3395614186506 | etot = -14.6249037425445 +548000 ekin = 0.193552178457268 | erot = 0.519081068513129 | epot = -15.3375369895014 | etot = -14.624903742531 +549000 ekin = 0.189527872077315 | erot = 0.518500763845738 | epot = -15.332932378404 | etot = -14.6249037424809 +550000 ekin = 0.184464697192282 | erot = 0.517160608017039 | epot = -15.3265290476137 | etot = -14.6249037424044 +551000 ekin = 0.179447519613205 | erot = 0.515181377054168 | epot = -15.3195326389812 | etot = -14.6249037423139 +552000 ekin = 0.175731062294521 | erot = 0.512744588095886 | epot = -15.3133793926124 | etot = -14.624903742222 +553000 ekin = 0.174564310045835 | erot = 0.510067400325703 | epot = -15.3095354525117 | etot = -14.6249037421402 +554000 ekin = 0.177036897100683 | erot = 0.507372062614515 | epot = -15.309312701793 | etot = -14.6249037420778 +555000 ekin = 0.183953653121175 | erot = 0.504855061241007 | epot = -15.3137124564046 | etot = -14.6249037420424 +556000 ekin = 0.195740677803854 | erot = 0.502660902829331 | epot = -15.3233053226717 | etot = -14.6249037420385 +557000 ekin = 0.212389174813147 | erot = 0.500864749566708 | epot = -15.338157666447 | etot = -14.6249037420672 +558000 ekin = 0.23344502097276 | erot = 0.499466731744655 | epot = -15.357815494843 | etot = -14.6249037421256 +559000 ekin = 0.258048678277938 | erot = 0.498398734230019 | epot = -15.3813511547153 | etot = -14.6249037422074 +560000 ekin = 0.285022157939512 | erot = 0.49754195086514 | epot = -15.4074678511078 | etot = -14.6249037423032 +561000 ekin = 0.312990622171654 | erot = 0.496751658909336 | epot = -15.4346460234837 | etot = -14.6249037424027 +562000 ekin = 0.340519848729776 | erot = 0.495884310853372 | epot = -15.4613079020793 | etot = -14.6249037424961 +563000 ekin = 0.366249237356 | erot = 0.494821962716246 | epot = -15.4859749426474 | etot = -14.6249037425751 +564000 ekin = 0.389003340228442 | erot = 0.493490109026911 | epot = -15.5073971918898 | etot = -14.6249037426344 +565000 ekin = 0.407871381975258 | erot = 0.491866632343677 | epot = -15.5246417569902 | etot = -14.6249037426713 +566000 ekin = 0.422251605412405 | erot = 0.489981232304148 | epot = -15.537136580402 | etot = -14.6249037426854 +567000 ekin = 0.431863045464181 | erot = 0.48790647095657 | epot = -15.5446732590993 | etot = -14.6249037426785 +568000 ekin = 0.436733840917554 | erot = 0.485743252286935 | epot = -15.5473808358579 | etot = -14.6249037426534 +569000 ekin = 0.437172173178126 | erot = 0.483603786385869 | epot = -15.5456797021773 | etot = -14.6249037426133 +570000 ekin = 0.433727138645419 | erot = 0.481595978794116 | epot = -15.5402268600013 | etot = -14.6249037425617 +571000 ekin = 0.427141808143026 | erot = 0.479812578148763 | epot = -15.5318581287941 | etot = -14.6249037425023 +572000 ekin = 0.418294466660563 | erot = 0.478326721684033 | epot = -15.5215249307844 | etot = -14.6249037424398 +573000 ekin = 0.408121101334992 | erot = 0.477193277920611 | epot = -15.5102181216358 | etot = -14.6249037423802 +574000 ekin = 0.397514818217457 | erot = 0.476453234967311 | epot = -15.4988717955158 | etot = -14.6249037423311 +575000 ekin = 0.387207144489171 | erot = 0.476137354470425 | epot = -15.4882482412599 | etot = -14.6249037423003 +576000 ekin = 0.377649119217314 | erot = 0.476266044933562 | epot = -15.4788189064453 | etot = -14.6249037422944 +577000 ekin = 0.368920817132226 | erot = 0.476844730976786 | epot = -15.4706692904254 | etot = -14.6249037423164 +578000 ekin = 0.360700785230741 | erot = 0.477856883134822 | epot = -15.4634614107288 | etot = -14.6249037423632 +579000 ekin = 0.352319179858308 | erot = 0.479258927577157 | epot = -15.4564818498611 | etot = -14.6249037424256 +580000 ekin = 0.342901425190187 | erot = 0.480981430412776 | epot = -15.4487865980922 | etot = -14.6249037424893 +581000 ekin = 0.331586894252575 | erot = 0.482939076923953 | epot = -15.4394297137127 | etot = -14.6249037425362 +582000 ekin = 0.317784488003998 | erot = 0.485048781539638 | epot = -15.4277370120932 | etot = -14.6249037425495 +583000 ekin = 0.301409490236239 | erot = 0.487252029394849 | epot = -15.4135652621486 | etot = -14.6249037425175 +584000 ekin = 0.283039202393957 | erot = 0.489535511256142 | epot = -15.3974784560878 | etot = -14.6249037424377 +585000 ekin = 0.263933313487419 | erot = 0.491944128120081 | epot = -15.380781183926 | etot = -14.6249037423185 +586000 ekin = 0.245890887800433 | erot = 0.494582820571413 | epot = -15.3653774505512 | etot = -14.6249037421793 +587000 ekin = 0.230956405620081 | erot = 0.497607010278675 | epot = -15.3534671579451 | etot = -14.6249037420464 +588000 ekin = 0.221033841917523 | erot = 0.501205839010948 | epot = -15.3471434228734 | etot = -14.624903741945 +589000 ekin = 0.21750442850326 | erot = 0.505584588308524 | epot = -15.3479927587061 | etot = -14.6249037418943 +590000 ekin = 0.220953423088753 | erot = 0.510952138426249 | epot = -15.3568093034155 | etot = -14.6249037419005 +591000 ekin = 0.231083134064746 | erot = 0.517515644130575 | epot = -15.3735025201508 | etot = -14.6249037419554 +592000 ekin = 0.246829245753635 | erot = 0.525479282587494 | epot = -15.3972122703833 | etot = -14.6249037420422 +593000 ekin = 0.26662894973047 | erot = 0.535039778666637 | epot = -15.4265724705377 | etot = -14.6249037421406 +594000 ekin = 0.288743434935807 | erot = 0.546371032865614 | epot = -15.4600182100362 | etot = -14.6249037422348 +595000 ekin = 0.311533695301779 | erot = 0.559594229359546 | epot = -15.4960316669788 | etot = -14.6249037423175 +596000 ekin = 0.3336243482615 | erot = 0.574736425374656 | epot = -15.5332645160253 | etot = -14.6249037423892 +597000 ekin = 0.353943370598348 | erot = 0.591686591895555 | epot = -15.57053370495 | etot = -14.6249037424561 +598000 ekin = 0.371670846224556 | erot = 0.610160828224063 | epot = -15.6067354169738 | etot = -14.6249037425252 +599000 ekin = 0.386151688530433 | erot = 0.629687420924883 | epot = -15.6407428520557 | etot = -14.6249037426004 +600000 ekin = 0.396824670884606 | erot = 0.649618644309941 | epot = -15.6713470578748 | etot = -14.6249037426803 +601000 ekin = 0.403202067553919 | erot = 0.669171693345246 | epot = -15.6972775036573 | etot = -14.6249037427582 +602000 ekin = 0.40490852829975 | erot = 0.687495721385519 | epot = -15.7173079925082 | etot = -14.6249037428229 +603000 ekin = 0.401765041348506 | erot = 0.703757265562631 | epot = -15.7304260497733 | etot = -14.6249037428622 +604000 ekin = 0.393886240081525 | erot = 0.717231476889702 | epot = -15.7360214598372 | etot = -14.624903742866 +605000 ekin = 0.38175038495462 | erot = 0.727382711583425 | epot = -15.7340368393683 | etot = -14.6249037428302 +606000 ekin = 0.366205114566941 | erot = 0.733917584160155 | epot = -15.725026441486 | etot = -14.6249037427589 +607000 ekin = 0.348389460814908 | erot = 0.736798185090599 | epot = -15.7100913885695 | etot = -14.624903742664 +608000 ekin = 0.329579787369096 | erot = 0.736212623478789 | epot = -15.6906961534101 | etot = -14.6249037425622 +609000 ekin = 0.310994196071395 | erot = 0.73251127479451 | epot = -15.6684092133368 | etot = -14.6249037424709 +610000 ekin = 0.293604835884145 | erot = 0.726125549058765 | epot = -15.6446341273466 | etot = -14.6249037424037 +611000 ekin = 0.278004208601941 | erot = 0.717488389875027 | epot = -15.620396340845 | etot = -14.624903742368 +612000 ekin = 0.264353214552908 | erot = 0.706972008379807 | epot = -15.5962289652964 | etot = -14.6249037423637 +613000 ekin = 0.252415280668165 | erot = 0.694851301360494 | epot = -15.5721703244133 | etot = -14.6249037423847 +614000 ekin = 0.241662201716805 | erot = 0.681294462599433 | epot = -15.5478604067365 | etot = -14.6249037424203 +615000 ekin = 0.231427318529322 | erot = 0.666377599992121 | epot = -15.5227086609789 | etot = -14.6249037424574 +616000 ekin = 0.221078258759027 | erot = 0.650117838829056 | epot = -15.4960998400712 | etot = -14.6249037424831 +617000 ekin = 0.210180390467373 | erot = 0.632518274251274 | epot = -15.4676024072048 | etot = -14.6249037424862 +618000 ekin = 0.19862150965634 | erot = 0.61361713210071 | epot = -15.437142384217 | etot = -14.6249037424599 +619000 ekin = 0.186670442213662 | erot = 0.593532504056955 | epot = -15.4051066886746 | etot = -14.6249037424039 +620000 ekin = 0.174951539061879 | erot = 0.572493952083693 | epot = -15.3723492334697 | etot = -14.6249037423241 +621000 ekin = 0.164335257152339 | erot = 0.550854196820419 | epot = -15.3400931962051 | etot = -14.6249037422323 +622000 ekin = 0.15576803968181 | erot = 0.529078173717942 | epot = -15.3097499555427 | etot = -14.6249037421429 +623000 ekin = 0.150083571178598 | erot = 0.507711807337566 | epot = -15.2826991205848 | etot = -14.6249037420687 +624000 ekin = 0.147843467415458 | erot = 0.487337070698791 | epot = -15.2600842801331 | etot = -14.6249037420188 +625000 ekin = 0.149245521580975 | erot = 0.468521842126362 | epot = -15.242671105704 | etot = -14.6249037419967 +626000 ekin = 0.154116108891131 | erot = 0.451772481731462 | epot = -15.2307923326229 | etot = -14.6249037420003 +627000 ekin = 0.161979086426179 | erot = 0.437494698740194 | epot = -15.2243775271902 | etot = -14.6249037420239 +628000 ekin = 0.172174902879175 | erot = 0.425965324893585 | epot = -15.2230439698325 | etot = -14.6249037420598 +629000 ekin = 0.183995029152314 | erot = 0.417314987668265 | epot = -15.2262137589216 | etot = -14.624903742101 +630000 ekin = 0.196798066694665 | erot = 0.411519917956496 | epot = -15.2332217267944 | etot = -14.6249037421432 +631000 ekin = 0.210082131921541 | erot = 0.408400457423892 | epot = -15.2433863315305 | etot = -14.6249037421851 +632000 ekin = 0.223500184825895 | erot = 0.407624312389087 | epot = -15.2560282394437 | etot = -14.6249037422287 +633000 ekin = 0.236818662196578 | erot = 0.408714108140466 | epot = -15.2704365126158 | etot = -14.6249037422787 +634000 ekin = 0.249833574952738 | erot = 0.411060882466515 | epot = -15.2857981997594 | etot = -14.6249037423402 +635000 ekin = 0.262270239999152 | erot = 0.413946987959646 | epot = -15.3011209703752 | etot = -14.6249037424164 +636000 ekin = 0.273700147361468 | erot = 0.416582412016232 | epot = -15.315186301884 | etot = -14.6249037425063 +637000 ekin = 0.283507856899438 | erot = 0.418156955201586 | epot = -15.3265685547044 | etot = -14.6249037426034 +638000 ekin = 0.290930324554196 | erot = 0.417906927432445 | epot = -15.3337409946819 | etot = -14.6249037426952 +639000 ekin = 0.295171730169193 | erot = 0.415189912094696 | epot = -15.3352653850304 | etot = -14.6249037427665 +640000 ekin = 0.29557345321463 | erot = 0.409556450349033 | epot = -15.3300336463655 | etot = -14.6249037428018 +641000 ekin = 0.291798784614145 | erot = 0.400805216305268 | epot = -15.3175077437091 | etot = -14.6249037427896 +642000 ekin = 0.283982821763269 | erot = 0.389009767281603 | epot = -15.2978963317707 | etot = -14.6249037427259 +643000 ekin = 0.272803834295158 | erot = 0.374510198234827 | epot = -15.2722177751453 | etot = -14.6249037426153 +644000 ekin = 0.259451287281963 | erot = 0.35787030323495 | epot = -15.242225332988 | etot = -14.6249037424711 +645000 ekin = 0.24549053850944 | erot = 0.339807577757951 | epot = -15.2102018585798 | etot = -14.6249037423124 +646000 ekin = 0.232646751227162 | erot = 0.321107525182429 | epot = -15.1786580185707 | etot = -14.6249037421611 +647000 ekin = 0.222545810224123 | erot = 0.302534738054695 | epot = -15.1499842903174 | etot = -14.6249037420386 +648000 ekin = 0.216457466201495 | erot = 0.28475201940792 | epot = -15.1261132275715 | etot = -14.624903741962 +649000 ekin = 0.215087078764636 | erot = 0.268256849270223 | epot = -15.1082476699766 | etot = -14.6249037419418 +650000 ekin = 0.218457489209105 | erot = 0.253342374384717 | epot = -15.0967036055721 | etot = -14.6249037419783 +651000 ekin = 0.225910420497396 | erot = 0.240087663214758 | epot = -15.0909018257745 | etot = -14.6249037420624 +652000 ekin = 0.236236377394498 | erot = 0.228379019530553 | epot = -15.0895191391008 | etot = -14.6249037421757 +653000 ekin = 0.247915496411967 | erot = 0.217959688821804 | epot = -15.0907789275281 | etot = -14.6249037422943 +654000 ekin = 0.259425494352017 | erot = 0.20850030571605 | epot = -15.0928295424613 | etot = -14.6249037423932 +655000 ekin = 0.269554558208103 | erot = 0.199677958220037 | epot = -15.0941362588799 | etot = -14.6249037424518 +656000 ekin = 0.277652649608963 | erot = 0.191249336850249 | epot = -15.0938057289172 | etot = -14.624903742458 +657000 ekin = 0.283765747905228 | erot = 0.183104207684344 | epot = -15.0917736980005 | etot = -14.6249037424109 +658000 ekin = 0.288620908153343 | erot = 0.175289536735983 | epot = -15.088814187211 | etot = -14.6249037423216 +659000 ekin = 0.293459924910629 | erot = 0.16800102740562 | epot = -15.0863646945268 | etot = -14.6249037422106 +660000 ekin = 0.299750121924184 | erot = 0.161545913295631 | epot = -15.0861997773238 | etot = -14.624903742104 +661000 ekin = 0.30882794580141 | erot = 0.156286808494636 | epot = -15.0900184963241 | etot = -14.624903742028 +662000 ekin = 0.321550844182293 | erot = 0.152579955314811 | epot = -15.0990345415002 | etot = -14.6249037420031 +663000 ekin = 0.338040404323162 | erot = 0.150721656676881 | epot = -15.1136658030376 | etot = -14.6249037420375 +664000 ekin = 0.35758869637966 | erot = 0.150913925254683 | epot = -15.1334063637598 | etot = -14.6249037421255 +665000 ekin = 0.378766116436051 | erot = 0.153254852725981 | epot = -15.1569247114091 | etot = -14.6249037422471 +666000 ekin = 0.399716130930405 | erot = 0.157752003177184 | epot = -15.1823718764818 | etot = -14.6249037423742 +667000 ekin = 0.418564373573293 | erot = 0.16435019288794 | epot = -15.2078183089394 | etot = -14.6249037424782 +668000 ekin = 0.433827740573583 | erot = 0.172960630437096 | epot = -15.2316921135496 | etot = -14.6249037425389 +669000 ekin = 0.444701001629416 | erot = 0.183478145303361 | epot = -15.2530828894841 | etot = -14.6249037425513 +670000 ekin = 0.451136418415458 | erot = 0.195778468142474 | epot = -15.2718186290843 | etot = -14.6249037425264 +671000 ekin = 0.453701004148267 | erot = 0.209695862329476 | epot = -15.2883006089635 | etot = -14.6249037424858 +672000 ekin = 0.453273827000247 | erot = 0.224990306459319 | epot = -15.3031678759134 | etot = -14.6249037424539 +673000 ekin = 0.450699702660583 | erot = 0.241319095059427 | epot = -15.3169225401685 | etot = -14.6249037424485 +674000 ekin = 0.446523488449384 | erot = 0.258227823779524 | epot = -15.3296550547041 | etot = -14.6249037424752 +675000 ekin = 0.440889624591433 | erot = 0.275170305160563 | epot = -15.3409636722771 | etot = -14.6249037425251 +676000 ekin = 0.43362448115233 | erot = 0.29155830650734 | epot = -15.3500865302388 | etot = -14.6249037425792 +677000 ekin = 0.424453634855728 | erot = 0.306833290384575 | epot = -15.356190667856 | etot = -14.6249037426157 +678000 ekin = 0.413265176464919 | erot = 0.320546114280114 | epot = -15.3587150333616 | etot = -14.6249037426165 +679000 ekin = 0.400321537246337 | erot = 0.33242808876456 | epot = -15.3576533685843 | etot = -14.6249037425734 +680000 ekin = 0.386341988792883 | erot = 0.342437977069693 | epot = -15.3536837083532 | etot = -14.6249037424906 +681000 ekin = 0.372417408218802 | erot = 0.350774050475061 | epot = -15.3480952010793 | etot = -14.6249037423855 +682000 ekin = 0.359769645089127 | erot = 0.357847594355724 | epot = -15.3425209817278 | etot = -14.624903742283 +683000 ekin = 0.349419724484513 | erot = 0.364223142874507 | epot = -15.3385466095678 | etot = -14.6249037422088 +684000 ekin = 0.341867426589617 | erot = 0.370539083006542 | epot = -15.3373102517771 | etot = -14.6249037421809 +685000 ekin = 0.336892967753541 | erot = 0.377427285880855 | epot = -15.3392239958376 | etot = -14.6249037422032 +686000 ekin = 0.333560575457532 | erot = 0.385449795149527 | epot = -15.3439141128706 | etot = -14.6249037422635 +687000 ekin = 0.330440845245698 | erot = 0.395064019975185 | epot = -15.3504086075581 | etot = -14.6249037423373 +688000 ekin = 0.325996654363842 | erot = 0.406617593545993 | epot = -15.3575179903049 | etot = -14.6249037423951 +689000 ekin = 0.31902375237829 | erot = 0.420363991129875 | epot = -15.3642914859202 | etot = -14.6249037424121 +690000 ekin = 0.309020969989285 | erot = 0.436483939358184 | epot = -15.3704086517225 | etot = -14.624903742375 +691000 ekin = 0.296388973949697 | erot = 0.455097572739975 | epot = -15.3763902889758 | etot = -14.6249037422861 +692000 ekin = 0.282408410636572 | erot = 0.476257707732277 | epot = -15.383569860531 | etot = -14.6249037421622 +693000 ekin = 0.26900853085206 | erot = 0.499923033173746 | epot = -15.3938353060564 | etot = -14.6249037420305 +694000 ekin = 0.258387685788816 | erot = 0.525918285140374 | epot = -15.4092097128507 | etot = -14.6249037419215 +695000 ekin = 0.252576275208241 | erot = 0.553894058809539 | epot = -15.4313740758797 | etot = -14.624903741862 +696000 ekin = 0.253038186234903 | erot = 0.583300660396082 | epot = -15.4612425885006 | etot = -14.6249037418696 +697000 ekin = 0.260392018277369 | erot = 0.613388418368354 | epot = -15.4986841785946 | etot = -14.6249037419489 +698000 ekin = 0.274304391463235 | erot = 0.643241879182175 | epot = -15.5424500127355 | etot = -14.6249037420901 +699000 ekin = 0.293570250406476 | erot = 0.671848180608583 | epot = -15.5903221732866 | etot = -14.6249037422715 +700000 ekin = 0.316355070233252 | erot = 0.698191700482076 | epot = -15.6394505131798 | etot = -14.6249037424645 +701000 ekin = 0.340538337282147 | erot = 0.721359481465404 | epot = -15.6868015613873 | etot = -14.6249037426397 +702000 ekin = 0.364075443764542 | erot = 0.740637254693957 | epot = -15.7296164412326 | etot = -14.6249037427741 +703000 ekin = 0.385294321874673 | erot = 0.755576369453691 | epot = -15.7657744341838 | etot = -14.6249037428555 +704000 ekin = 0.403066716719495 | erot = 0.766018576886853 | epot = -15.7939890364902 | etot = -14.6249037428839 +705000 ekin = 0.416833588997526 | erot = 0.772075474099313 | epot = -15.8138128059661 | etot = -14.6249037428693 +706000 ekin = 0.426510451502379 | erot = 0.774072055031553 | epot = -15.8254862493606 | etot = -14.6249037428266 +707000 ekin = 0.432328070474044 | erot = 0.772470813769757 | epot = -15.8297026270148 | etot = -14.624903742771 +708000 ekin = 0.434671210546527 | erot = 0.76779427950511 | epot = -15.827369232765 | etot = -14.6249037427133 +709000 ekin = 0.433963855684076 | erot = 0.760560754832016 | epot = -15.8194283531749 | etot = -14.6249037426588 +710000 ekin = 0.430621214402443 | erot = 0.751241421805289 | epot = -15.8067663788153 | etot = -14.6249037426076 +711000 ekin = 0.425061028816158 | erot = 0.740240555545361 | epot = -15.7902053269182 | etot = -14.6249037425567 +712000 ekin = 0.417748693286293 | erot = 0.727895913280463 | epot = -15.7705483490692 | etot = -14.6249037425024 +713000 ekin = 0.409245407745191 | erot = 0.714493617369743 | epot = -15.748642767557 | etot = -14.624903742442 +714000 ekin = 0.400233112896686 | erot = 0.700290376393996 | epot = -15.725427231666 | etot = -14.6249037423753 +715000 ekin = 0.391499218629782 | erot = 0.685535269234813 | epot = -15.7019382301699 | etot = -14.6249037423053 +716000 ekin = 0.38387465328674 | erot = 0.670483824808895 | epot = -15.6792622203343 | etot = -14.6249037422387 +717000 ekin = 0.37812966517224 | erot = 0.655399296057453 | epot = -15.6584327034141 | etot = -14.6249037421844 +718000 ekin = 0.374843116813924 | erot = 0.640539821857324 | epot = -15.6402866808232 | etot = -14.6249037421519 +719000 ekin = 0.374271424141617 | erot = 0.626134666228947 | epot = -15.6253098325198 | etot = -14.6249037421492 +720000 ekin = 0.376249546442333 | erot = 0.612356169201708 | epot = -15.6135094578241 | etot = -14.62490374218 +721000 ekin = 0.38015578315651 | erot = 0.599295758360665 | epot = -15.6043552837594 | etot = -14.6249037422422 +722000 ekin = 0.384962761439327 | erot = 0.586951574250039 | epot = -15.5968180780159 | etot = -14.6249037423266 +723000 ekin = 0.38937982338218 | erot = 0.575232003297926 | epot = -15.5895155690983 | etot = -14.6249037424182 +724000 ekin = 0.392071125784558 | erot = 0.563975606697306 | epot = -15.5809504749809 | etot = -14.6249037424991 +725000 ekin = 0.391913283459399 | erot = 0.552983740178749 | epot = -15.5698007661892 | etot = -14.6249037425511 +726000 ekin = 0.388241956533271 | erot = 0.542058916015903 | epot = -15.5552046151099 | etot = -14.6249037425608 +727000 ekin = 0.381032991792366 | erot = 0.531040454531963 | epot = -15.5369771888461 | etot = -14.6249037425218 +728000 ekin = 0.370971903191828 | erot = 0.519829082375402 | epot = -15.515704728005 | etot = -14.6249037424378 +729000 ekin = 0.359388263612358 | erot = 0.50839572980859 | epot = -15.4926877357432 | etot = -14.6249037423222 +730000 ekin = 0.348057580439132 | erot = 0.496773021024845 | epot = -15.4697343436589 | etot = -14.6249037421949 +731000 ekin = 0.338902689198661 | erot = 0.485032671408036 | epot = -15.4488391026864 | etot = -14.6249037420797 +732000 ekin = 0.333649662944534 | erot = 0.473255762297357 | epot = -15.4318091672407 | etot = -14.6249037419988 +733000 ekin = 0.333505576675517 | erot = 0.461504910073763 | epot = -15.4199142287177 | etot = -14.6249037419685 +734000 ekin = 0.338924758983124 | erot = 0.44980725448349 | epot = -15.4136357554609 | etot = -14.6249037419943 +735000 ekin = 0.34951546857607 | erot = 0.438154711902834 | epot = -15.41257392255 | etot = -14.6249037420711 +736000 ekin = 0.364111355273647 | erot = 0.426523255164468 | epot = -15.4155383526203 | etot = -14.6249037421822 +737000 ekin = 0.38099571977356 | erot = 0.414906900972945 | epot = -15.4208063630506 | etot = -14.6249037423041 +738000 ekin = 0.398229414670415 | erot = 0.403356227833102 | epot = -15.4264893849155 | etot = -14.624903742412 +739000 ekin = 0.414005860072354 | erot = 0.392007798568672 | epot = -15.4309174011272 | etot = -14.6249037424862 +740000 ekin = 0.426948743961824 | erot = 0.381091720704565 | epot = -15.4329442071836 | etot = -14.6249037425172 +741000 ekin = 0.43628364768211 | erot = 0.370910229391996 | epot = -15.4320976195812 | etot = -14.6249037425071 +742000 ekin = 0.44185000182603 | erot = 0.361789064611378 | epot = -15.4285428089066 | etot = -14.6249037424692 +743000 ekin = 0.443963491146499 | erot = 0.354012421291944 | epot = -15.4228796548611 | etot = -14.6249037424227 +744000 ekin = 0.4431781085151 | erot = 0.347758127978473 | epot = -15.4158399788814 | etot = -14.6249037423879 +745000 ekin = 0.440021184884499 | erot = 0.343050543545547 | epot = -15.4079754708096 | etot = -14.6249037423796 +746000 ekin = 0.434779146250304 | erot = 0.339744491074578 | epot = -15.3994273797281 | etot = -14.6249037424032 +747000 ekin = 0.427396883604757 | erot = 0.337545938414333 | epot = -15.3898465644716 | etot = -14.6249037424525 +748000 ekin = 0.417523045840628 | erot = 0.336066252171896 | epot = -15.3784930405232 | etot = -14.6249037425107 +749000 ekin = 0.404692764111473 | erot = 0.334898725161965 | epot = -15.3644952318288 | etot = -14.6249037425554 +750000 ekin = 0.388596287616679 | erot = 0.333700338300972 | epot = -15.3472003684819 | etot = -14.6249037425642 +751000 ekin = 0.369348367994066 | erot = 0.332259621152988 | epot = -15.3265117316703 | etot = -14.6249037425233 +752000 ekin = 0.347662572336739 | erot = 0.330533807750213 | epot = -15.3031001225191 | etot = -14.6249037424322 +753000 ekin = 0.324856373470614 | erot = 0.328645172902147 | epot = -15.2784052886784 | etot = -14.6249037423056 +754000 ekin = 0.302664104351481 | erot = 0.326836116136386 | epot = -15.2544039626582 | etot = -14.6249037421703 +755000 ekin = 0.28289840530598 | erot = 0.325392677389915 | epot = -15.2331948247539 | etot = -14.624903742058 +756000 ekin = 0.267052130149329 | erot = 0.324553861439878 | epot = -15.2165097335856 | etot = -14.6249037419964 +757000 ekin = 0.255952872034472 | erot = 0.324427480977821 | epot = -15.2052840950144 | etot = -14.6249037420021 +758000 ekin = 0.24956686325796 | erot = 0.324931841856735 | epot = -15.1994024471903 | etot = -14.6249037420756 +759000 ekin = 0.247007285742123 | erot = 0.325777353497946 | epot = -15.1976883814417 | etot = -14.6249037422016 +760000 ekin = 0.246749335490671 | erot = 0.326494279609754 | epot = -15.1981473574522 | etot = -14.6249037423518 +761000 ekin = 0.247004464362874 | erot = 0.326503456901681 | epot = -15.1984116637553 | etot = -14.6249037424907 +762000 ekin = 0.246168267683208 | erot = 0.325217160868209 | epot = -15.1962891711361 | etot = -14.6249037425847 +763000 ekin = 0.243236270174742 | erot = 0.322149322885115 | epot = -15.1902893356692 | etot = -14.6249037426093 +764000 ekin = 0.238083572628182 | erot = 0.31701054114686 | epot = -15.1799978563319 | etot = -14.6249037425569 +765000 ekin = 0.231530329806237 | erot = 0.309765883621403 | epot = -15.166199955866 | etot = -14.6249037424384 +766000 ekin = 0.225163449189886 | erot = 0.300642577938324 | epot = -15.1507097694095 | etot = -14.6249037422813 +767000 ekin = 0.220947037641663 | erot = 0.29008793628379 | epot = -15.1359387160491 | etot = -14.6249037421236 +768000 ekin = 0.220714417705789 | erot = 0.278690999515915 | epot = -15.1243091592251 | etot = -14.6249037420034 +769000 ekin = 0.225674230585351 | erot = 0.267090069999984 | epot = -15.1176680425334 | etot = -14.6249037419481 +770000 ekin = 0.23606686040605 | erot = 0.255889903618604 | epot = -15.1168605059919 | etot = -14.6249037419673 +771000 ekin = 0.251070223471186 | erot = 0.245606888556646 | epot = -15.1215808540782 | etot = -14.6249037420504 +772000 ekin = 0.268985032794879 | erot = 0.236650197272996 | epot = -15.1305389722379 | etot = -14.62490374217 +773000 ekin = 0.287649902235825 | erot = 0.229335047808992 | epot = -15.1418886923345 | etot = -14.6249037422897 +774000 ekin = 0.304971347443094 | erot = 0.223914516380436 | epot = -15.1537896061991 | etot = -14.6249037423756 +775000 ekin = 0.319422560280909 | erot = 0.220611402281974 | epot = -15.1649377049681 | etot = -14.6249037424052 +776000 ekin = 0.330375903028573 | erot = 0.21963284072128 | epot = -15.1749124861238 | etot = -14.624903742374 +777000 ekin = 0.338182326480891 | erot = 0.221157252264285 | epot = -15.184243321042 | etot = -14.6249037422968 +778000 ekin = 0.343980993504904 | erot = 0.225293639771365 | epot = -15.1941783754794 | etot = -14.6249037422032 +779000 ekin = 0.349294202147107 | erot = 0.232023926336935 | epot = -15.2062218706133 | etot = -14.6249037421292 +780000 ekin = 0.355517983707508 | erot = 0.241146781674954 | epot = -15.2215685074899 | etot = -14.6249037421074 +781000 ekin = 0.363445847501857 | erot = 0.252244149939742 | epot = -15.2405937395992 | etot = -14.6249037421576 +782000 ekin = 0.372957766808644 | erot = 0.264688770757683 | epot = -15.2625502798455 | etot = -14.6249037422792 +783000 ekin = 0.382969267748679 | erot = 0.277702579811651 | epot = -15.2855755900109 | etot = -14.6249037424505 +784000 ekin = 0.391670514066047 | erot = 0.290462881205936 | epot = -15.3070371379042 | etot = -14.6249037426322 +785000 ekin = 0.397003136152503 | erot = 0.30223788282162 | epot = -15.3241447617521 | etot = -14.624903742778 +786000 ekin = 0.397244540913489 | erot = 0.312520082334536 | epot = -15.3346683660962 | etot = -14.6249037428482 +787000 ekin = 0.391525061079608 | erot = 0.321121025638165 | epot = -15.3375498295401 | etot = -14.6249037428223 +788000 ekin = 0.380116514494719 | erot = 0.328198366843703 | epot = -15.3332186240439 | etot = -14.6249037427055 +789000 ekin = 0.364402868103514 | erot = 0.334204933642789 | epot = -15.3235115442733 | etot = -14.624903742527 +790000 ekin = 0.34654788283668 | erot = 0.339772664563971 | epot = -15.3112242897311 | etot = -14.6249037423304 +791000 ekin = 0.328969533927298 | erot = 0.345562661329334 | epot = -15.2994359374173 | etot = -14.6249037421606 +792000 ekin = 0.313783234687856 | erot = 0.352120250332508 | epot = -15.2908072270725 | etot = -14.6249037420521 +793000 ekin = 0.302371973145943 | erot = 0.359769001652795 | epot = -15.2870447168187 | etot = -14.6249037420199 +794000 ekin = 0.295192752069597 | erot = 0.368565036951676 | epot = -15.288661531079 | etot = -14.6249037420577 +795000 ekin = 0.291854072001344 | erot = 0.378316728406861 | epot = -15.2950745425493 | etot = -14.6249037421411 +796000 ekin = 0.291420477240303 | erot = 0.388659220599258 | epot = -15.3049834400759 | etot = -14.6249037422364 +797000 ekin = 0.292835767593939 | erot = 0.39916067791523 | epot = -15.3169001878199 | etot = -14.6249037423108 +798000 ekin = 0.295321690654866 | erot = 0.409429919731993 | epot = -15.329655352731 | etot = -14.6249037423441 +799000 ekin = 0.298615606685225 | erot = 0.41919526946406 | epot = -15.3427146184839 | etot = -14.6249037423347 +800000 ekin = 0.302963113078809 | erot = 0.428333265393227 | epot = -15.3562001207724 | etot = -14.6249037423004 +801000 ekin = 0.30886980741851 | erot = 0.436842111958024 | epot = -15.3706156616477 | etot = -14.6249037422712 +802000 ekin = 0.316711643345927 | erot = 0.444773620895207 | epot = -15.3863890065174 | etot = -14.6249037422763 +803000 ekin = 0.326365730601817 | erot = 0.452151664704948 | epot = -15.4034211376386 | etot = -14.6249037423318 +804000 ekin = 0.337019280357668 | erot = 0.458909057451191 | epot = -15.4208320802431 | etot = -14.6249037424342 +805000 ekin = 0.347244531512514 | erot = 0.464865921885975 | epot = -15.4370141959586 | etot = -14.6249037425601 +806000 ekin = 0.355321558015248 | erot = 0.469755825323994 | epot = -15.4499811260149 | etot = -14.6249037426756 +807000 ekin = 0.359699244804389 | erot = 0.47328839989947 | epot = -15.4578913874509 | etot = -14.624903742747 +808000 ekin = 0.359442919436746 | erot = 0.475225772200574 | epot = -15.4595724343886 | etot = -14.6249037427513 +809000 ekin = 0.354532149710961 | erot = 0.475448148012512 | epot = -15.454884040406 | etot = -14.6249037426825 +810000 ekin = 0.345927121515436 | erot = 0.473990365430211 | epot = -15.4448212294985 | etot = -14.6249037425528 +811000 ekin = 0.335391497319453 | erot = 0.471042355239708 | epot = -15.4313375949476 | etot = -14.6249037423884 +812000 ekin = 0.325122479809057 | erot = 0.466917662639856 | epot = -15.416943884672 | etot = -14.6249037422231 +813000 ekin = 0.31728183261798 | erot = 0.462001954840949 | epot = -15.4041875295485 | etot = -14.6249037420896 +814000 ekin = 0.313538689250887 | erot = 0.456696276151244 | epot = -15.3951387074148 | etot = -14.6249037420127 +815000 ekin = 0.314725301426621 | erot = 0.451368238943233 | epot = -15.3909972823742 | etot = -14.6249037420043 +816000 ekin = 0.320674745952002 | erot = 0.446320054204494 | epot = -15.3918985422185 | etot = -14.624903742062 +817000 ekin = 0.330264402529528 | erot = 0.441777145069773 | epot = -15.3969452897695 | etot = -14.6249037421702 +818000 ekin = 0.341643112115936 | erot = 0.437896324121525 | epot = -15.404443178542 | etot = -14.6249037423045 +819000 ekin = 0.352584467965967 | erot = 0.43478868897098 | epot = -15.4122768993742 | etot = -14.6249037424372 +820000 ekin = 0.360890006680921 | erot = 0.432549774286878 | epot = -15.4183435235106 | etot = -14.6249037425428 +821000 ekin = 0.364764924967774 | erot = 0.431288293594747 | epot = -15.4209569611646 | etot = -14.624903742602 +822000 ekin = 0.36310132304895 | erot = 0.431144612410167 | epot = -15.419149678065 | etot = -14.6249037426059 +823000 ekin = 0.355627506072524 | erot = 0.432293079211457 | epot = -15.4128243278395 | etot = -14.6249037425555 +824000 ekin = 0.342909508000251 | erot = 0.43492611819946 | epot = -15.4027393686613 | etot = -14.6249037424616 +825000 ekin = 0.326218347991422 | erot = 0.439222871855163 | epot = -15.3903449621884 | etot = -14.6249037423418 +826000 ekin = 0.307298067027383 | erot = 0.445309293137298 | epot = -15.3775111023813 | etot = -14.6249037422166 +827000 ekin = 0.288081469810276 | erot = 0.453218819733682 | epot = -15.3662040316499 | etot = -14.6249037421059 +828000 ekin = 0.270403517644502 | erot = 0.462862712071626 | epot = -15.358169971742 | etot = -14.6249037420259 +829000 ekin = 0.255756724313645 | erot = 0.474017347276416 | epot = -15.354677813577 | etot = -14.624903741987 +830000 ekin = 0.245120383539843 | erot = 0.486332016594477 | epot = -15.3563561421264 | etot = -14.6249037419921 +831000 ekin = 0.238883956789448 | erot = 0.499357971990473 | epot = -15.3631456708169 | etot = -14.624903742037 +832000 ekin = 0.236868645662797 | erot = 0.512595315428093 | epot = -15.3743677032021 | etot = -14.6249037421112 +833000 ekin = 0.238435989568506 | erot = 0.525550909043033 | epot = -15.3888906408115 | etot = -14.6249037421999 +834000 ekin = 0.242658569127625 | erot = 0.537797737790879 | epot = -15.405360049206 | etot = -14.6249037422875 +835000 ekin = 0.248518315375854 | erot = 0.549024910270133 | epot = -15.4224469680061 | etot = -14.6249037423601 +836000 ekin = 0.255095050222772 | erot = 0.559068449138662 | epot = -15.4390672417693 | etot = -14.6249037424078 +837000 ekin = 0.261712817640357 | erot = 0.567916383628495 | epot = -15.4545329436954 | etot = -14.6249037424265 +838000 ekin = 0.268023056778553 | erot = 0.575686784519793 | epot = -15.4686135837165 | etot = -14.6249037424181 +839000 ekin = 0.27401827032314 | erot = 0.582582979367263 | epot = -15.4815049920797 | etot = -14.6249037423893 +840000 ekin = 0.279983100774025 | erot = 0.588834754839967 | epot = -15.4937215979637 | etot = -14.6249037423497 +841000 ekin = 0.286398274628728 | erot = 0.59463702433131 | epot = -15.5059390412703 | etot = -14.6249037423103 +842000 ekin = 0.293816650983536 | erot = 0.600098453281003 | epot = -15.5188188465462 | etot = -14.6249037422817 +843000 ekin = 0.302726774569486 | erot = 0.605208920749049 | epot = -15.5328394375911 | etot = -14.6249037422726 +844000 ekin = 0.313421069061172 | erot = 0.609833296485301 | epot = -15.5481581078353 | etot = -14.6249037422889 +845000 ekin = 0.325887895394733 | erot = 0.613733577818912 | epot = -15.5645252155452 | etot = -14.6249037423315 +846000 ekin = 0.339752400962196 | erot = 0.616615984720894 | epot = -15.5812721280789 | etot = -14.6249037423958 +847000 ekin = 0.354292335348444 | erot = 0.61819407953295 | epot = -15.5973901573525 | etot = -14.6249037424711 +848000 ekin = 0.368542667423182 | erot = 0.618254639142345 | epot = -15.6117010491079 | etot = -14.6249037425423 +849000 ekin = 0.381474241843926 | erot = 0.616711095273524 | epot = -15.6230890797115 | etot = -14.6249037425941 +850000 ekin = 0.392198266661771 | erot = 0.613631554979492 | epot = -15.6307335642567 | etot = -14.6249037426155 +851000 ekin = 0.40012936773711 | erot = 0.609234588535909 | epot = -15.6342676988772 | etot = -14.6249037426042 +852000 ekin = 0.405049998797733 | erot = 0.603854451146916 | epot = -15.633808192512 | etot = -14.6249037425674 +853000 ekin = 0.407056563941561 | erot = 0.597885334648249 | epot = -15.6298456411086 | etot = -14.6249037425187 +854000 ekin = 0.406415158938748 | erot = 0.591718979210661 | epot = -15.6230378806227 | etot = -14.6249037424733 +855000 ekin = 0.403390043512858 | erot = 0.585690332509252 | epot = -15.6139841184645 | etot = -14.6249037424423 +856000 ekin = 0.398116166002726 | erot = 0.580042463525136 | epot = -15.6030623719571 | etot = -14.6249037424293 +857000 ekin = 0.390568016159967 | erot = 0.574915889724967 | epot = -15.5903876483136 | etot = -14.6249037424286 +858000 ekin = 0.380638245096081 | erot = 0.570361176880736 | epot = -15.5759031644054 | etot = -14.6249037424286 +859000 ekin = 0.368297168914653 | erot = 0.566367903415377 | epot = -15.5595688147452 | etot = -14.6249037424151 +860000 ekin = 0.353771484486348 | erot = 0.56289933566704 | epot = -15.5415745625316 | etot = -14.6249037423782 +861000 ekin = 0.337668189076058 | erot = 0.55992119051608 | epot = -15.522493121908 | etot = -14.6249037423159 +862000 ekin = 0.320982687534733 | erot = 0.55741511441171 | epot = -15.5033015441828 | etot = -14.6249037422364 +863000 ekin = 0.304965814691443 | erot = 0.555372641472256 | epot = -15.4852421983211 | etot = -14.6249037421574 +864000 ekin = 0.290872653003623 | erot = 0.553772082573975 | epot = -15.4695484776774 | etot = -14.6249037420998 +865000 ekin = 0.279660774249956 | erot = 0.552546988655193 | epot = -15.4571115049878 | etot = -14.6249037420826 +866000 ekin = 0.271730646599716 | erot = 0.551558423386406 | epot = -15.448192812101 | etot = -14.6249037421149 +867000 ekin = 0.266795961580917 | erot = 0.550582916186157 | epot = -15.44228261996 | etot = -14.624903742193 +868000 ekin = 0.263936467175858 | erot = 0.549323573880104 | epot = -15.4381637833559 | etot = -14.6249037422999 +869000 ekin = 0.261831470221839 | erot = 0.547444696243376 | epot = -15.4341799088748 | etot = -14.6249037424095 +870000 ekin = 0.259116433169107 | erot = 0.544622620095519 | epot = -15.4286427957584 | etot = -14.6249037424938 +871000 ekin = 0.25476611341807 | erot = 0.540599894777859 | epot = -15.4202697507262 | etot = -14.6249037425303 +872000 ekin = 0.248397230690975 | erot = 0.535228153627688 | epot = -15.4085291268279 | etot = -14.6249037425092 +873000 ekin = 0.240403953825284 | erot = 0.528487826572668 | epot = -15.3937955228335 | etot = -14.6249037424356 +874000 ekin = 0.23188412578265 | erot = 0.52047931782111 | epot = -15.3772671859324 | etot = -14.6249037423286 +875000 ekin = 0.224371090312889 | erot = 0.51138848970078 | epot = -15.3606633222303 | etot = -14.6249037422166 +876000 ekin = 0.219440883379249 | erot = 0.501436812694071 | epot = -15.3457814382023 | etot = -14.624903742129 +877000 ekin = 0.218302972735591 | erot = 0.490831150818216 | epot = -15.3340378656416 | etot = -14.6249037420878 +878000 ekin = 0.221492456262699 | erot = 0.479728387736622 | epot = -15.3261245861005 | etot = -14.6249037421012 +879000 ekin = 0.228756262274367 | erot = 0.468225594693664 | epot = -15.3218855991281 | etot = -14.6249037421601 +880000 ekin = 0.239169160088235 | erot = 0.456378166082075 | epot = -15.3204510684122 | etot = -14.6249037422419 +881000 ekin = 0.251443176614178 | erot = 0.444238659512956 | epot = -15.3205855784449 | etot = -14.6249037423178 +882000 ekin = 0.264330844663498 | erot = 0.431901289695958 | epot = -15.3211358767212 | etot = -14.6249037423617 +883000 ekin = 0.276992343361542 | erot = 0.419534292632451 | epot = -15.3214303783535 | etot = -14.6249037423595 +884000 ekin = 0.289210952362652 | erot = 0.407386172192625 | epot = -15.321500866868 | etot = -14.6249037423127 +885000 ekin = 0.301394205510712 | erot = 0.395760928443729 | epot = -15.3220588761924 | etot = -14.6249037422379 +886000 ekin = 0.314368599205627 | erot = 0.384968165379708 | epot = -15.3242405067466 | etot = -14.6249037421612 +887000 ekin = 0.329038341775269 | erot = 0.375262338090432 | epot = -15.3292044219761 | etot = -14.6249037421104 +888000 ekin = 0.3460151111552 | erot = 0.366788650327974 | epot = -15.337707503589 | etot = -14.6249037421058 +889000 ekin = 0.365329693883301 | erot = 0.359550947377142 | epot = -15.3497843834163 | etot = -14.6249037421559 +890000 ekin = 0.386310696217007 | erot = 0.353410826837943 | epot = -15.364625265308 | etot = -14.6249037422531 +891000 ekin = 0.40766808705505 | erot = 0.348119126036606 | epot = -15.3806909554677 | etot = -14.624903742376 +892000 ekin = 0.427761236103282 | erot = 0.343372786941987 | epot = -15.3960377655415 | etot = -14.6249037424963 +893000 ekin = 0.444977236019449 | erot = 0.33888352569265 | epot = -15.4087645042971 | etot = -14.624903742585 +894000 ekin = 0.458112158680458 | erot = 0.334441343917185 | epot = -15.4174572452192 | etot = -14.6249037426215 +895000 ekin = 0.466648008331883 | erot = 0.329956933565113 | epot = -15.4215086844963 | etot = -14.6249037425993 +896000 ekin = 0.470850232519732 | erot = 0.325472374552551 | epot = -15.4212263495988 | etot = -14.6249037425265 +897000 ekin = 0.471664510488006 | erot = 0.321137893833118 | epot = -15.4177061467451 | etot = -14.624903742424 +898000 ekin = 0.470447771985807 | erot = 0.317161282107798 | epot = -15.4125127964124 | etot = -14.6249037423188 +899000 ekin = 0.468609320535655 | erot = 0.313743247831532 | epot = -15.407256310605 | etot = -14.6249037422378 +900000 ekin = 0.467255363896805 | erot = 0.311015004595507 | epot = -15.403174110693 | etot = -14.6249037422007 +901000 ekin = 0.466923299456955 | erot = 0.308993431077898 | epot = -15.4008204727509 | etot = -14.624903742216 +902000 ekin = 0.467466399705958 | erot = 0.307564919774008 | epot = -15.3999350617591 | etot = -14.6249037422791 +903000 ekin = 0.468112799245358 | erot = 0.306502589385531 | epot = -15.3995191310034 | etot = -14.6249037423725 +904000 ekin = 0.467682260080958 | erot = 0.305513914729679 | epot = -15.398099917282 | etot = -14.6249037424714 +905000 ekin = 0.464906903208091 | erot = 0.304308207539486 | epot = -15.3941188532968 | etot = -14.6249037425492 +906000 ekin = 0.458775313350218 | erot = 0.302667437698602 | epot = -15.386346493633 | etot = -14.6249037425842 +907000 ekin = 0.448811106797068 | erot = 0.300501710925682 | epot = -15.3742165602888 | etot = -14.624903742566 +908000 ekin = 0.435212888278286 | erot = 0.297873922704326 | epot = -15.3579905534802 | etot = -14.6249037424976 +909000 ekin = 0.418821166578994 | erot = 0.294986492955548 | epot = -15.338711401929 | etot = -14.6249037423944 +910000 ekin = 0.400928155652122 | erot = 0.292134043124749 | epot = -15.3179659410565 | etot = -14.6249037422796 +911000 ekin = 0.382990731318649 | erot = 0.289635345607696 | epot = -15.2975298191034 | etot = -14.6249037421771 +912000 ekin = 0.366329155569864 | erot = 0.28776245704618 | epot = -15.2789953547216 | etot = -14.6249037421055 +913000 ekin = 0.351888443631227 | erot = 0.286683662572629 | epot = -15.2634758482788 | etot = -14.624903742075 +914000 ekin = 0.340111462795541 | erot = 0.286431278414487 | epot = -15.2514464832954 | etot = -14.6249037420854 +915000 ekin = 0.330936398540049 | erot = 0.286898247267082 | epot = -15.2427383879356 | etot = -14.6249037421284 +916000 ekin = 0.323899271601486 | erot = 0.287861143478391 | epot = -15.2366641572706 | etot = -14.6249037421907 +917000 ekin = 0.318302399047232 | erot = 0.289022784865087 | epot = -15.2322289261691 | etot = -14.6249037422568 +918000 ekin = 0.313403328231463 | erot = 0.290065205370856 | epot = -15.2283722759152 | etot = -14.6249037423129 +919000 ekin = 0.308582994046901 | erot = 0.290702987753991 | epot = -15.2241897241499 | etot = -14.624903742349 +920000 ekin = 0.303462620954368 | erot = 0.290727692025052 | epot = -15.2190940553399 | etot = -14.6249037423605 +921000 ekin = 0.297952758522196 | erot = 0.290036267627498 | epot = -15.2128927684978 | etot = -14.6249037423481 +922000 ekin = 0.29223232916649 | erot = 0.28863969692327 | epot = -15.2057757684075 | etot = -14.6249037423178 +923000 ekin = 0.286668877937277 | erot = 0.286652137103424 | epot = -15.1982247573193 | etot = -14.6249037422786 +924000 ekin = 0.28170186865761 | erot = 0.28426466875578 | epot = -15.1908702796539 | etot = -14.6249037422405 +925000 ekin = 0.277717553237222 | erot = 0.281710557645316 | epot = -15.1843318530947 | etot = -14.6249037422121 +926000 ekin = 0.274945509178671 | erot = 0.279230091666927 | epot = -15.1790793430443 | etot = -14.6249037421988 +927000 ekin = 0.273402631519431 | erot = 0.277042382113437 | epot = -15.1753487558338 | etot = -14.624903742201 +928000 ekin = 0.272900230271358 | erot = 0.275329232545622 | epot = -15.1731332050314 | etot = -14.6249037422144 +929000 ekin = 0.273115271901108 | erot = 0.274232799537457 | epot = -15.1722518136694 | etot = -14.6249037422308 +930000 ekin = 0.273710515356084 | erot = 0.273865029644295 | epot = -15.1724792872405 | etot = -14.6249037422402 +931000 ekin = 0.274474107140427 | erot = 0.274323617229163 | epot = -15.1737014666035 | etot = -14.6249037422339 +932000 ekin = 0.275440857683932 | erot = 0.275707340217243 | epot = -15.1760519401082 | etot = -14.624903742207 +933000 ekin = 0.276957575782685 | erot = 0.278123705988738 | epot = -15.1799850239326 | etot = -14.6249037421612 +934000 ekin = 0.279664435384645 | erot = 0.281683992543778 | epot = -15.186252170033 | etot = -14.6249037421046 +935000 ekin = 0.284382433297568 | erot = 0.286484503522986 | epot = -15.1957706788719 | etot = -14.6249037420513 +936000 ekin = 0.291920557580458 | erot = 0.292577187598382 | epot = -15.2094014871973 | etot = -14.6249037420184 +937000 ekin = 0.302840159170039 | erot = 0.299936553990847 | epot = -15.2276804551831 | etot = -14.6249037420222 +938000 ekin = 0.317231541763436 | erot = 0.308432066638964 | epot = -15.2505673504756 | etot = -14.6249037420732 +939000 ekin = 0.334562734704465 | erot = 0.317815317270747 | epot = -15.277281794148 | etot = -14.6249037421728 +940000 ekin = 0.35364952180483 | erot = 0.327729086105148 | epot = -15.3062823502215 | etot = -14.6249037423115 +941000 ekin = 0.372770367646405 | erot = 0.337741122003473 | epot = -15.3354152321199 | etot = -14.62490374247 +942000 ekin = 0.389915662531244 | erot = 0.34739974979893 | epot = -15.3622191549524 | etot = -14.6249037426222 +943000 ekin = 0.403126345738701 | erot = 0.356302369933728 | epot = -15.3843324584131 | etot = -14.6249037427407 +944000 ekin = 0.410851754405684 | erot = 0.364163156178504 | epot = -15.3999186533874 | etot = -14.6249037428032 +945000 ekin = 0.41224792095984 | erot = 0.370864511414023 | epot = -15.4080161751712 | etot = -14.6249037427973 +946000 ekin = 0.407348747779498 | erot = 0.376479254456982 | epot = -15.4087317449601 | etot = -14.6249037427236 +947000 ekin = 0.397071124216324 | erot = 0.381256899558077 | epot = -15.4032317663699 | etot = -14.6249037425955 +948000 ekin = 0.38305345572573 | erot = 0.385576026490354 | epot = -15.3935332246524 | etot = -14.6249037424363 +949000 ekin = 0.367364810069699 | erot = 0.389872987608877 | epot = -15.3821415399525 | etot = -14.624903742274 +950000 ekin = 0.352149150210297 | erot = 0.394562514442363 | epot = -15.3716154067876 | etot = -14.6249037421349 +951000 ekin = 0.339280178142264 | erot = 0.399966938640697 | epot = -15.364150858822 | etot = -14.6249037420391 +952000 ekin = 0.330096120378427 | erot = 0.406268489131276 | epot = -15.3612683515059 | etot = -14.6249037419962 +953000 ekin = 0.32526183166892 | erot = 0.413492937870355 | epot = -15.3636585115441 | etot = -14.6249037420048 +954000 ekin = 0.324774911928697 | erot = 0.421526046052984 | epot = -15.3712047000353 | etot = -14.6249037420537 +955000 ekin = 0.328098170458837 | erot = 0.430156858160225 | epot = -15.3831587707443 | etot = -14.6249037421253 +956000 ekin = 0.334370903123397 | erot = 0.439135698167057 | epot = -15.3984103434923 | etot = -14.6249037422019 +957000 ekin = 0.342633913360124 | erot = 0.44823123979963 | epot = -15.4157688954295 | etot = -14.6249037422697 +958000 ekin = 0.352004139469675 | erot = 0.457271615168161 | epot = -15.4341794969606 | etot = -14.6249037423228 +959000 ekin = 0.361755395785515 | erot = 0.466159587644429 | epot = -15.4528187257936 | etot = -14.6249037423637 +960000 ekin = 0.37129634840351 | erot = 0.474860087933521 | epot = -15.4710601787381 | etot = -14.624903742401 +961000 ekin = 0.380073790913227 | erot = 0.483367158176183 | epot = -15.4883446915346 | etot = -14.6249037424452 +962000 ekin = 0.387455548951145 | erot = 0.491663490522134 | epot = -15.5040227819764 | etot = -14.6249037425031 +963000 ekin = 0.392654097313064 | erot = 0.499687295633833 | epot = -15.5172451355218 | etot = -14.6249037425749 +964000 ekin = 0.394737939560465 | erot = 0.507318071997362 | epot = -15.52695975421 | etot = -14.6249037426522 +965000 ekin = 0.392748486468401 | erot = 0.514386334668901 | epot = -15.5320385638565 | etot = -14.6249037427192 +966000 ekin = 0.385905473254046 | erot = 0.520705106529118 | epot = -15.5315143225403 | etot = -14.6249037427571 +967000 ekin = 0.373852021646475 | erot = 0.526114369236053 | epot = -15.5248701336312 | etot = -14.6249037427486 +968000 ekin = 0.356869417136842 | erot = 0.530525868586128 | epot = -15.5122990284073 | etot = -14.6249037426844 +969000 ekin = 0.335986889835165 | erot = 0.533955228285004 | epot = -15.4948458606873 | etot = -14.6249037425671 +970000 ekin = 0.312927788673001 | erot = 0.536531428462375 | epot = -15.4743629595488 | etot = -14.6249037424134 +971000 ekin = 0.289872105907279 | erot = 0.538479668129898 | epot = -15.4532555162884 | etot = -14.6249037422512 +972000 ekin = 0.269070232406882 | erot = 0.5400808983618 | epot = -15.4340548728819 | etot = -14.6249037421133 +973000 ekin = 0.252397022945549 | erot = 0.54161782723096 | epot = -15.4189185922049 | etot = -14.6249037420284 +974000 ekin = 0.240964852822479 | erot = 0.543321042151966 | epot = -15.4091896369876 | etot = -14.6249037420132 +975000 ekin = 0.23490216482404 | erot = 0.545328986458525 | epot = -15.4051348933507 | etot = -14.6249037420682 +976000 ekin = 0.233353466621782 | erot = 0.547671994179659 | epot = -15.4059292029795 | etot = -14.6249037421781 +977000 ekin = 0.234692201089083 | erot = 0.550284513866881 | epot = -15.4098804572724 | etot = -14.6249037423164 +978000 ekin = 0.236887903180263 | erot = 0.553043053342472 | epot = -15.4148346989741 | etot = -14.6249037424514 +979000 ekin = 0.237945797131594 | erot = 0.555821040963433 | epot = -15.4186705806471 | etot = -14.6249037425521 +980000 ekin = 0.236334546963168 | erot = 0.558547250125055 | epot = -15.4197855396823 | etot = -14.6249037425941 +981000 ekin = 0.231322843924042 | erot = 0.561252158432646 | epot = -15.4174787449221 | etot = -14.6249037425654 +982000 ekin = 0.223154169544533 | erot = 0.564087592074629 | epot = -15.4121455040889 | etot = -14.6249037424697 +983000 ekin = 0.213008719539339 | erot = 0.567310103886669 | epot = -15.4052225657532 | etot = -14.6249037423272 +984000 ekin = 0.202740628548441 | erot = 0.571227590062575 | epot = -15.3988719607827 | etot = -14.6249037421716 +985000 ekin = 0.194435665154694 | erot = 0.576119771487871 | epot = -15.3954591786846 | etot = -14.624903742042 +986000 ekin = 0.189894304519126 | erot = 0.58215285815263 | epot = -15.3969509046435 | etot = -14.6249037419717 +987000 ekin = 0.190182835424942 | erot = 0.589313613953793 | epot = -15.4044001913571 | etot = -14.6249037419783 +988000 ekin = 0.195390213187374 | erot = 0.597385005524008 | epot = -15.4176789607685 | etot = -14.6249037420571 +989000 ekin = 0.204671362362343 | erot = 0.605974905403727 | epot = -15.4355500099486 | etot = -14.6249037421825 +990000 ekin = 0.216563394578633 | erot = 0.614593273597528 | epot = -15.4560604104923 | etot = -14.6249037423162 +991000 ekin = 0.229465191861939 | erot = 0.622757127490605 | epot = -15.477126061773 | etot = -14.6249037424204 +992000 ekin = 0.24211427112869 | erot = 0.630092599916922 | epot = -15.4971106135161 | etot = -14.6249037424704 +993000 ekin = 0.253902581479766 | erot = 0.636403793831493 | epot = -15.5152101177725 | etot = -14.6249037424612 +994000 ekin = 0.264939510335544 | erot = 0.641689105047928 | epot = -15.5315323577914 | etot = -14.6249037424079 +995000 ekin = 0.275864888578878 | erot = 0.646102898208469 | epot = -15.5468715291258 | etot = -14.6249037423384 +996000 ekin = 0.287497820769962 | erot = 0.649877086441122 | epot = -15.562278649495 | etot = -14.6249037422839 +997000 ekin = 0.300450307467282 | erot = 0.653227423573226 | epot = -15.578581473309 | etot = -14.6249037422685 +998000 ekin = 0.314829914377661 | erot = 0.656270894957595 | epot = -15.5960045516386 | etot = -14.6249037423033 +999000 ekin = 0.330110494517446 | erot = 0.658973630822486 | epot = -15.613987867725 | etot = -14.6249037423851 +1000000 ekin = 0.345190458651126 | erot = 0.66113833946702 | epot = -15.6312325406162 | etot = -14.624903742498 + 1000000 0.025569664 -1.5839232 0.020799898 -1.5286042 -3.5789082e-06 +Loop time of 30.1999 on 4 procs for 1000000 steps with 10 atoms + +Performance: 28609.339 tau/day, 33112.661 timesteps/s +96.4% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.90762 | 10.291 | 18.476 | 234.3 | 34.08 +Bond | 0.11783 | 0.39332 | 0.61914 | 34.0 | 1.30 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 2.8711 | 3.8042 | 4.7159 | 34.0 | 12.60 +Output | 2e-05 | 3.15e-05 | 3.6e-05 | 0.0 | 0.00 +Modify | 0.27052 | 1.1583 | 1.9428 | 63.9 | 3.84 +Other | | 14.55 | | | 48.19 + +Nlocal: 2.5 ave 5 max 0 min +Histogram: 1 0 1 0 0 0 0 0 1 1 +Nghost: 7.5 ave 10 max 5 min +Histogram: 1 0 1 0 0 0 0 0 1 1 +Neighs: 18.5 ave 35 max 0 min +Histogram: 1 0 1 0 0 0 0 0 1 1 + +Total # of neighbors = 74 +Ave neighs/atom = 7.4 +Ave special neighs/atom = 3.6 +Neighbor list builds = 0 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:30 -- GitLab From e2a7cdc4f75ea7f316bf9b555fa5198afd5eab9b Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 19 Jul 2019 12:20:56 +0100 Subject: [PATCH 269/469] Updated extended documentation --- doc/src/PDF/USER-CGDNA.pdf | Bin 4230705 -> 4230823 bytes 1 file changed, 0 insertions(+), 0 deletions(-) diff --git a/doc/src/PDF/USER-CGDNA.pdf b/doc/src/PDF/USER-CGDNA.pdf index 7fcf3660156a903ec1ea7ec984ef4f8b11c73bbe..2577875f687a372fd334748c1eabc0e44fba7f6a 100644 GIT binary patch delta 71735 zcmdlur-^C#+$N?8DvT!6C+0b5*0)A^m)|+I@!sq3Gg|C6?MGNIRNT9|R5LPA=yac_ z{Cw$1Zh?$*3db0dZCrfoYG18hb?i()!ls$;^uBD~B^Mv+zu{(H)7jtVjnnSi?)f?Y z{oxwnWBWQUXMFy!h4b(Q|4TWOmoAiF^6=Thdo`cl{VI}pd-nIj9INQ~yEAk?zMK7b zYCY%Pox01Hy>Gc@@A>oF%7;qmKD@AfS>`jU0qYxkRy>t{{0o)%=x?piLB z8vJwFhi((EncRhM#3T3Z?92#0)gpiU+3C<^~LudRaPmmD!?KsWr`Sx!GQ(fXLeM)}4 ze5KYGWM^_}e%bMjE01Mo9bH&nFIu(#Ps!A$_ug);`M)%K-;KnaWsjfk_?@}Kt0&xV z_bS_KVaNC9pDw&@zqsD}+1~!8*&jac^(%`{^s(Q1#7Xw!>G-D-$1YqIjXWk}ocZv$ zs~`Kh=0{H(&qr1Zs~$72beekRywls?|HCccu3^kxd}#OF?Vl|!%Brb-xOYC7S?|A? z%QLNWO1l~w&-sYUSN)&#?|yQL{j}2k#~v7T{k;(&`D5ec7r(Qve?I8p@TlHET&{KI ztq&`d(U7NG?akr|+ znS(B|s^8~T&Hb?Meb((>vDjDtH^|ABO+HdLYwwOH{C6!(FWU$vKXNJS7kZqrmyJo~ z_F1m?dG0(iTc7Kiod^%SR#tB#&)554;$*s;k!_j(<*k3vor?<7JgY6g{JSwxeZ~o?-7}-Ey?Yy2-_p$EAh!3$*>>CaZDNfP zlaeOvSeUeDS~&alNfW*{9@(<`_dBWQe&;xh-u%1nQ{}e(|Bh+1lC@|46ZW5U<-GFp zx^qry2X7Z``ue}?#-G%@h0KPrfrY(YAC-huUWs)*IH1pJ>E|@>SjwsEk&;tc9tk|& z@!`ZOf2UQsu0c9qy<~pYU$ZRw@+KkX`KqmduUxT``Zqa;|L6HYj@?3gPy831=jWPN zdE=AJo*YZh$GS3+0_mrB zWZ9x4H*w!MoszBSfA-!!iCdFYe61DxLT}!>DE_~6_xpo-a&EI!_s$Nye(+g6qsqG0 zIIf?Q3Y9_+9*yn$);}|+X|E)|NlSv$)jwh_hAu{@TNdtQ5ZW>|QSxkz+_K6Iix)>L zzAxCLd}X_&=#LNI7rycMxOMHmxi8LG3LHrfOpX6^RBoy3wd8dfvXj1kUaNhd-?{z) z_x2^T4qr(ySK~QykG+*$aW@N$6=a{#Q0(&Wo$%TGf6poHw_2T9*uy zLFdu~iRmR`oCmi&nb5!Zs;h+Lg+1;O@Bi)!~y z(75@Vb(fl$>JHwJpqRfE>-JQxI@J*8e`sRXwZJuBuQ;=QP^r)QvBGPX^NX!5KW+s{ z3B*l_STCcsW{2>p&+9Dn-x=gg`887~p>t#W?wRT_%R4ppEIi9&t|ToaE%4yRB**2P z+3_)NnAxc)3O^{+LFry7|^mlNm)!FOZpFs5Cnyv&E~({qm+_`IgFx(i`E@Fw{7aQ#ortjTR)TE8n??w?!1~oS`JSN+XKd3cf>A=U%OcE^Y%sd z9+CMA8#R>N_bEPp-Y(+KsifG+>D-lKS5x!j=P8Nz$G7jlW6O|T_haI-pF4!SRfX~b zeV#6VcBozIYldM-$70oW_9xBv6@`4WO<=N{=n>S~k}#uS?@V*g{^QH`2O3|OJNcaX zy;RWuqLREl9*w&-l{`fzbZBy(eI&fpwSMco=_}UOiJ#2GVDRxszy2k#Xp+IHzwGYJ+cJvo>czP;#_`%^1Ptwl3J z6q_BoLnE%12H$U4A8J22_L^Y=*Yr2-fyo>9#Dsnh-B4dr^1pII_uhU@zZF#yKi79Z zWb{?q8o_FR(MM8)OXN;Og-M89Wa67!p7QN=_ukDZ5np*viPPt@rdD0c6xpTwvbXKt zc9F4{`2bh`{5P8q-B;I)Y*n6g$bNxlmcWT!>p#_8IwDc1+3UGNhGE_UVNS`skBwh^ zw{Dc&qWj%RbVk{UdOm-J)*m%1Kd(#AICSdM)QArnNuI8ec3lT&31)J2I^8!=ov)_L zG~sr3VK)z-V=&LFUy~+fJx`yOFmL)(&f5RoS_Y41vIJfEF!LCny0?pb`IGsQQ=Wvd zwmn+6);LCHRlwWkB#9G34`-z2mG=L=#pg9~&PNA5pJi^(9!@lneXd+T$6<5H)Ld;- zvrt>tFPCBt?TtCK_sZEQ^QZTU*w|bqP20+A@veDeil8!Y+hODLsY3QD8zgpESa|LK znzvG((=qc8ooAYMv-sJ|r>Dw~EUSzv@+}OS!y30XVy;PmZU{HKQ{@gW(bK{q zGE*(Q^k2Nnp68dM)@W^G*fTYCTfNhBoiv90;N44}DijDy=1MG{^}W?@O-YPk?cuMX zGCi6TPZ!ojO|@}LJFAqcnYjO!pNOmH+*EN<|nMcbSs&5NQBOfuY%!o+=S1xs^5s7C!= z)f(m3XG(?6s7Cp4==YqR_x`|7rVDD(joX+{OMlvYL$0yc_0rAY#fw)Q`e1!ORd?@# z(>5oyZ(AHZFe9(y>WpXEOHV!$YdM{J#PLaOmmRbIk)7YqIYutqKcjO-_|5Bjv-OzW zq(01IR#+#)QsUm`z_+|%#+`DR{gy`=deb~62-Qb4nJE9rNZok&g8#Occ`oruTq{l< zHpy{(yye1&Stqviu6tg^(rRrxyQTEwARcwk?X-}Fp z%07L*VDaB@f`jL&#qW<8NE_*uo$t!#SU$Cs*S)7D*Uh4#RYq~={>jfBge!Lccb=DY z>u2iI^ZVmvzF#`%YIxT?8@6O0N?;5<@qzh$*Hz=nBa;IQ`BF|;Guj8<`QckLXSQ(P z#K!qNJ+VP9?-VOdr$nlGIE$Uy{avf=NwGKP^!Qwj?G;#pI)#)E3nDa!k+U z_IM%Hw#S7}t>mC{hl%Xbl$7x4{HB#MepZdVPs27Xon<9<+CIa7)3fypT+BXpYU=e* zn;@8%yK=$-k#iyowB9e|C}z+8`uf2$2{EtUFBeWtVyY@)&=g`$;@t32ho70X@cuNe z*Id(@L;@BiE$=y?#ubwgT+tLYQTffb`o1gc7eAcH$Mx>QIf=W{5jmflgi04{9@Kwv zR_M%v$mm-_#b(!RwoKeGm*4-Kh<;o3Pn&Of>x!z59uey2+;)HO^iMX@@~+3C?@exG zX8&sup0nfQO{WE4Pq7}ltTN5A(|tnmE3ZX=bJYEhqo2;KRsGpmlA@?hYN631z&iOt3lfOJQU{#&@C{XfZFVkm- z^o-6^+8f?TzlnGGm9pZvo9m@Vg4Slw*E&A;Y4e`Ca8tdzlj;-Si(5Cl$3zxuL~8oH zSZ5y7@J&$W_0L54wARm?zI?4@=XGEEv|RJblb{t!lJ5hhYEnZcc~*oTRn@<9elef* zX$@{I2G>Bw`YR?IX9x)I?fF}=FYfax?m1l(?m1+ohrT}PdP4DJ@vrE3A!{4Y7jXgvwX1M>5n{nn3>k; zX}#ha+CRgWFn+x+u=ClzfX(rik_rp9pNQu^b}H-8YqLEoge{+~nYcxaWR~s^IGz<*VDe)xOPZD|)?Y<0QfRI~uG$J&ti#dg^iT z;g08LSXOjJ9s}-KSM{+3c92_c3qUbW6XbyJR%yv0JjL z?6x^SWm1fek)N+n@ZJq+UzePI9IpNM_wkE-kJ3FCTC9xaIA-|E$o-HdW6(jl56j}@ zjAOa;(@j>Az5mc211mv!&Gs-Ps)_UfOeh?DQ~gVDGT`WD&H*OKM})F)tOS zeu>8|)kH$Nx!x{wo^z ze%`fW^}D{!b-~eEfA1u}Kb3S^-ZkO*@sCgcy9KRh^VOAqzLi~b_oN4BBh^-vzvutE zEph#!mx8Z$ShSjkSoeRr_r1ejDp&R7srO9@OF#Qhst)@2Nj3D7_N2HltKcc>`8^ZU zbe-M@|B1Y>Tm3ga$SZKKkoyFAg)atrKg$~y{!7`@rqBCdQQ_KuwPWwra~H1r-a37{ z+rJNm_qaQ{l~z>V4U2J0K32)ayd>si{bMl|fBBOOYA%{ynC75R_Fl^+(DJ*!)6>m7 z2lq2pFL^O>y5bQtVMdGTg7(b9Or|E29fXYQFDUc6aJ^5yw`b?EZi|zCHqERyl?ybY zl$<6;$rbMTy`jGL_3Bm2G zwe!!Hw}%VrUHA9@m|ng#f&a^7tK6#$)*S0!n z=U;Yp&73$*Q#z+`h4 z#K$LXpZIylYOa!ZOR}eb|CE}ic4NBty~gTYKOXBXS7s}Gapmg1dZ|@u+G{`gU*|sM z^m~K;pT2g*|7EV}x=Vd`U+LTThDGbvUpZ+>=~-*vMHUA(`Ux_u>R2kJ@?lg8SdsGk?1L*0e6JUhqlnuh3^Jq#Q*`W^OY*=&s!w4(H@p8j6GwlL|4#kgy7r8R!g~Lliu%kyQ-fiO;1@>$ z}4KHRnV^OYxCX2wN*k4xBp zYL(`zLS=uGGc9rqa@tk8{!INk-VChqcJ(nondIfCZh61=!%~Mh7Ph{aXSUM6UtH#4 zieWh2rBK2aP$H0{`6O$}ayNf<+tQmk?Q;*X+mTi78zri>Hoh+t z{h_QPd5t%;v3|GnV(qWLc02BF)#p%nHT|!G!D)RdW!*HzUu(a$&)Tu};cs=n&vV|o zZq&KFOmTB`(G=^J#B0A5d*-mIUvd4ucly35a{T(z8lh@y7c5`d>X=h9|B00Cg%iGW z?x!|!iA%V;v@R0iiLY@9KlFrYOZvs-TAs(dA6;O~O}0Db*zrERKJd+x(6#xp8LMx^ zeeOFI_wv7QyeG%X(@otCJ0CszW_*g`=Ac-Wlnwx}@>s z#P_+)`;M&&7i3mhC%NA%tWEnb!ii;JAoCNBQsy;~r;DPXp~UQf_+X=%qT3Udk= zW=&mmc3n!z>KnFf{YP@X224CupQIJ={q_0%(bvyf2ijkC_*MSKYsJ!zyrq8}!&+?q zpD2Eru$RHL?!@&_-B;5L4~rTz9N1{t5Wa>xcgms(5{XVv)_+^-P&A)qhB{BgJcGN@ zUccVuEqDHT@bT4;6PDL$eBZV;q|C)Yz)eH9;OVTHTc)_#PsmAr=-Pbk#*N7(XX2#m zccrb7u`Jo~KGgbK+rpC_8|Ai6a=tV@JLcHr1B=oUIl}&@X$af$_RMK1+*F>>y+`oM zmSU3y9qpNoWmT_UoPIm!YR=EK6FF-B|NQ=3>B9W(0~Q^f8(p{@w=By2uq42v?Wyn8 z&HHXKNE?=3_qi7gc)Xo^fBjoS1NCFZGhcgGr>QroHn;St9Dn#u zTJ3rX(}Gj-DThOR_1DVUKXlKG5wLOVV@Xk*yMk}3<$=c*jxQv0-^|;f{m}nS`bU{;Jmuxkm>`orq>rGy5>y%yYFWA*OLr?nfs?&&X&nm%+Z%{>e*@%Q#f(z zM9F}_J*S`AZb??JxOK<%;%=31YF$PrPwrTBoU8c?>ul~epQ$khHExp1969}=C5Pmc z68p^aqBpdrDcL26H|wmO`(j;-&O}FpQ(tqOf;Uep4>da`Eci6d>PuXEmiM#zcWgQj zTF)(CHpTGg!FQjog(lV*{@P>3rr9-Z-RA5Yf18%ASn#ekYWcaFd4iwvJ}sTGJ6K1> z&~Zv>98YTa)^DZdKeyFr>iqP$v~tSf)vs7DbX{PYA)j`eB}u3`rQoW2U7tlmv%JuY zvfH`w8_oLWH01<7OEO96a;h=OlCP_On_6$+VjI|VKz1vK>Ax9QIHD%+QQ9H@w(XeR z`v~#w{UIxlACBL4*ZkU-_4imGDyf!szqoo>sVIEmbKMLXrUtu1zpm=@w`L#9{s|K=@8&u@g*m}fN;0}>?~iQ-D1>=Vv|01kAK7G8&DqCj%amlVp&SCdd3_Y7P&4o6pzg{Cg!8V2A(;ne) z8Ox5!JKZ18=mx)J(c*oxDgBd6ME-|r?&QTg7wSGZ?62NDf$5{_1@RVx_p9GcTvt9b z-|T9k`HyLjjrQK1Bi^R)z1Y}DU{k4t#C1`JpUms_?s(T&|F9xx9Qw5JQOTdptSshRSBg+O9=>~+hZU4|2wC8l``$AtgO)`{H8pdYqKdp1+j@#nF(dZznc zza)4)v{1!MsVr?mOVyfsl}8rZ?LUGxPPnM~aq+Hc(-M?pyO-TH>Q^}yoH@Jq?(PKB znSPUMj%A$5?END4HpTf+%*%OS7SH*qocd3x>F@-B;#0hH%CCkg`n!df+TKc)TWM11 zKGWWHIp>x=lX-5^$OeyJRi6&Wb!aDDaNsXp~((`V(K z^x1WwQ+4ObI>AyKrCSk_x?TBlrt5fiXv^Q2w6t-D@VsB?afkL!uTAxp==dvnG}uOE z+VzyOlU9@7&py5(!D!c47X!wXO`NA@C5s;rEpv5WCKSnfLG{VSJDD1$U-lZuan*i5 z;eEtxeILJk?D2N}+?)rS!l!5!GbhZmtglS%Ir^Q)^G$1rNBp5E;ryu|_~!^)&dgf7 zzP|FNuj0awtJZi5O!R4R4R_#Hnf$b9%Da{+whTt=%oD<|h-vOyeDBkv3{h7@-ILyb zKgDeRxmv}~r(Wn($ku&^LZLakTPD>AB<}h0s6_Nfx)kTZn>RK!mrVWl^(%9nLfp}X z`#-FxKWtw7`=rZGU4luU=Tz?~!J!i4AgSFq}{kwWY)MhoUUAO#r`j@4X)r8W1 zoX-Ap-@R7zb-CKg3)u|LTPhBP&nnw z&ZzzOYCvja$Qun6ycQKT?`d;JY*c7YkrSHgh4?J9l2$CE!#^{fBv`L#vG|KiccTM=_!@hlREVLGgM?S`^dVlF4k&Pj7u7#y9I ztu(K5YPi9txwV#H}Q6SmAya0Rq}MU>)GBlKCG5kp4nI%N0%CH`tZtsKhraxm4)lh*Ngiz-2FU3 z>Xv$>QkMAI3v-*(rd@rg^IJh6`tYHf8OjU?j!A4k_tje{?Kd+D zD^XfdegC)Cgdazb&peeEfA-7<$Ob`6sXlFPNmjE=cB(%!TdaF>_19gt2K^Iy zw?5WA!NHL`|BhU!OGdTi?{iA@a?YE6@R_7h(W{R z{*lvrj=T`iw_PZFOK7(+u0lKw->igy7~2_Xwv(MHOimkEVrt>oBMHw!I?+L zc6J`^y?kN%MAdB)*H$LZoZ;2_WM<`RxgCNfMiTyi?ikhE^x5p5KL6L-wJpInqIHhV zWcQ1DrlVIlD}*yV&!)e5$%eHLdkgnjY-Lr;;80%>EZn2e;+oH3`?B}xQHhR=8krCF zOtCp|riP;_Bxl;>U(;tj4NOQXdQtQJ+vDhijxGnTDR}!oYQA!s)9GYX)QTHhdMz|L zZeM(0_1;sVyMu92d%et^Zv#vd)qoE745{Z2CO~J}It${jXmAJoob6MVil~6m54ac9$7%suWweCwH&S=PMKC z_9x?pMy4Eve3?II^-@2%4|Om}O(vYN&GFb_{^R_~^e$IT7(F5KHiuZN~RDt=I2RrgIx_HkF+ zLeJCQq6~Aw8aOt;^g(z291dI6WlS;*x~H6f_-YQH zqRGO?^HfWw91oPLE{R!EbWW6=Z~vU&ZS7L3hV=$hMdwXWpZCTlY?-00)U^9Sf}*>Z zUBP&Ihxr((A)&lcsPLtO@zDJNDk&+ig5HtJh6?G+)Q)le$gc{8RcS zr{}erEoRbWyma!q((^<6-|WjUZFqKSxzoD`Dy+U|CErhrDnH=I?pHsLfAUSQjFoKH zl~^}?yr;Kf%MsCeoZ{;x(xxmjRakmvdd1@FT#2<|3}$T4&v$LEY^kep6u+Lkd2K+r zTHtmQgM%`2+Krjm^1n6TS)Q`6VeYB>9M6_)6wALQv_Ez2)z2sXOsh6t7*cN#c1qR9 zjZ4v4Ik(xN+wJ1p-%+x!+2i#qBMm(m4!7Sd?9^`l+|suoZL6wOb@H3$KXv<+*3K&r zweI3!e|JY`$D4C!xTa(!s?@y?+MnySO5(ZShQH%zYbyOwm4HXO&g1Gd93@sFlj9_eY1tVh^ z+f2d81jaU1FfxU)jTDT`U~EGLBXbzrK*7iY%C=N6vIH~j?DPYQ@(WUnN-|T66>My{ z^n*+lj13eF6eb^06=pQtd_&cVm(g%CzrE$=5aV6kj7FRJ?TrN{OBq{juJO0vpUh`( zwfSA#G@i*${#Kj!W!Ldd-V$fExvZ+;>g1MetL+8>jK{?%TUS|cH_Bi>#9B-x}qaf7?rF-}CSn z9*ly{X5V*K%2=Oo)|q$XAkT#7j2f#{Ke{T-RhxNa`OnwE(Zv&2@bE<3y;@y*HQf7h z^c%5zkM6GCZ@;gqc($IAd3WfZiaUCX6bh2h$E#%WY$^D-BeJHn>FMRi_HmU)X&bqO zGrn9p>gD=Dx?uUHsC7*~mfP#S?`xL7D-zW{|MBDX^Kkf%Qa!WY zeXGt{ov&x_2I}6sw*DVyec7$4XLd{Z`uzF6*p=&yTVDR#M~PxP0%blP%zJ;2QNB6C zlB-VHzU1E*CH?mLfA^=YHt3$yp2Yd*_G{%i`yQ;5-qXHJcQupbA(NEiXD`Y)|JOg_ zSi6$-N7vT)eEYaU_c{L;B(}XRdTOn^?n?2U;=}bfp7%bj@LwqZ_(M;d_PWOvJ676G z$}~CUC}dqOy3PIZ(+#ua`E2;!NxNrEKD}<@jVWvMmMC{zJY&~YRjQ#qSK1<8#KQjj ztrvS9a&=AUy0T$Ol2xaO*_z^{d*;&)?z;5XVnyG!rrJX7>5_sjHrisd#Fn3(lb^aZ z+3SA$j!#WJN9(PPzWRl0@0+>n)|b2IBO5mhX+JY__%*d+g+f%>zC^EkkJi7Rur6`$ zEm@OOfiEuFu66Bm(3yLDuTSvRt64`vrP6tLuC6}$Y0s~~&uM|z8(O3Pr7mqf)G@Un zLC}4{>7z*>7kus&x&15U$2PO$H4>)t>e_^l%k)jMsK2@;_h`=XL-iZi%y?#P9c;Y6 z@VdQ+pn&=$pBYQ$eEM!@WUn_CFE$N`}YWr2oD{1CUze5tAG@RHO(KYw{ zubEu-hqEt%8H5-V92#Xf%Zt}c)J zdq>Avxs)ufy5KX%g$@J>?5b1is6Sscp_Tbw(A$pP{tSng_C31%TC|a6;`hqKtc|5i zk}LA8nU5RBINrRzf<-4l`{q%J3qRBNw#vx9H|&bAQwo{z=t8bZxYXahmqQnZpEb^% zn5K8i-qyaQlDbVmjqg``>@C^%*n>uV;v|ol)=OwCm zJlzzuXASd4zFXHyTr#g&&h*rn99SQ}=jr1&y$h5Ms^}=XNAej6O|9yV zcp0hjZH_aa!R4Zv>@(a1t}+Xs-2Zdo%E}u1JnrwA%b5h`-ekSYw!m%k^1FX>cAPpf zbxFeXo{Oz-RW2;tc}lBqubO+?E`>0)4%5x={1Q@*Fz@m*+r!J%b4ldtq8~$nM+{lH>XSH>*z8k4kw6QLJ80R%_ zo@UdI1W~M> zz3FU>Z@wkQaO>ssO$n1_HuyK~ud!5o(46G-{<>h?{++ysCT2_2?+O%Q^iyAV>WJ~4 z!-?PQeV+baaIC-nj)IZPx!>A1zO?gy=a1R@yWs!7XNS)oKc3q5YTD9skMAz;?>RO< z@1?=a_iQU?NloI=D}oc7hfIK6QFn@iVIcFQ`YMtsz@Sn%SJ0P}U( zX^pGb@BApXJ#et8?awAqj%*nezU&Qz7WCx;nB zcy`a0*eqeP;oi0-%Qb|1COfE3Y>&@Q)4IL$@!pB2w4|Yd>zbm*r)MhT#dc+xm_K;Ce|NopSLc-7({>AbIohVTx}RpXiD0&` z=ie-~!BvNmquh+g=jy_9p6VVsE1&)q^=6y4-{ydi`TXz-|MLMNYa^RJJhwhud&B>r z&;zkq?`EcQ7uw#m{UoZ-v{!yd)|Um3w>n<^Q2WjQ;djOzG0$TDd3?Wpe$x8%UWeRI zVt->VojB2+oM6NFx&A9N$M-N!5y@K*x>&|ZFxIUz=S*J7E8 zW*x7qy5{!ATi(cQOXPm2dBQzf?$kE(-3no?n)7eBJxV(N^SaO!x8m-Lo7?YfIxN!B zdMGHn{`;wd5UXq z%?W5cyYpsD$o_Ogu_gM}d~@#Iak^l{;PztY#zP77*lK=!`SEE-96F8mCJ%80T z`KuTIWVp&O@6z*E5C8SgK5rb%I#arJ@=65}&RmOPqjZ6to=fenQ0(rRT2ZtCMRlxRy%X|^9)F}|y{{HYlARvsR*44}NM`F_4ix!>+x>tT*y;0vE zz{{Q5x~o5_@vgvv30b?kxL-t_m*$BQl)0C=gCqSxz{UsHg!MNhYJC>rvZ%Gcyz~c) zj*T0;V4RF^<5JHLhnM8)KAI~ieSrN@mq&5gsmGG8p>a=^X>C+sOg~*;VE&=OjUn;3 zui3BV%l{Pr{la|xbzr*C!~Jfo{;E|6FQtanyLAQIpKO`xvGw2GuIn>%Ry<#K=+FC$ zMw7Bk7^nG3bgCq(Z0AxIjdI}pxbe^b%F0(~U%!8_^SpuZX}?eP0~L0 zZ28XP{`ye;3if4Bd1TMsoZGhU(^Ze6>O6lPHHrBAge5aK?>!Y7XR(;+aixOBhsAZK zm68U#o_F!O^Xu1gY;*7_Vy<~35zWD+>C_;VJ3CaNop-REi9;3}*9#<@guGa`QCUBw>DL3N)|)=-%sypE-`HW6bY;s0%fqwh z#_J13zFjC?VY+$RGY?MaDHr z%b4|d*3FggdYANu_m$|v%D{=z?w^bb)E{hW4(Q#ivvEgdL_;)_(F5ayd_naZmEy^t zf*_<0-_EKpMk)$EnE z_Y6x^4?Y)n+`{IFhW^K=SG^mrJMNR6=3Mjp#hYN&ZCizwxBb!RYTbG^CHbk2qWR`; zDz@d!_jXQ9k=ys9V3)=0W!;REP283ouK%r_`qQLe`rf2Z-ik^ewfG|5PuZ)q#An?L z*Q(G<9yhnNoo44;t7&sI`hep1ynCyIIX8ch1O5@a7-Y_Y`?`K>sdlnDhnnfUwKU`nP}2s=_P+ak~MCM z2(R+KOy`wb4AN$>Y1zs-)`lA?Ka>Bx_DVoWccnzlp8Cm$TN$P&7<$F9pB9;LApe|w z&Hb2X-khBAH$z#Aulej^<}R;#m)i1f`(t0O2aoyFT|b0xaa`J1YdYzPg_4QtoP8m_ z>GKkA7ld!PZQ`=tC9!YW)4~V(Z^{J9ih9H6m^0s+vcyU2i-lcO^0Us#$y%GL=37<2 zy!7Gy`C5J1xc!Os8ho#2UkaZ4g`s(8+lLaf71PW!W{0Q$KAk9S$f?V2@1^d{#dPbf zcgUglGjIIadss)MwmM-xr|;G+?+m{EST#vqu2^wbi}gA4%Q{nAU5bJNx1Tp=$nr2M zU#p_%$sQd4&Lx8VYx3PKF_#v!7bYH@l$r7_cz^l&@|?mIo^k7*`_zj?x#Vh@)p5Fg zv0m)CLb&plmx1`|uWgq$IxOM0?a|ZO?(wQo?_8=^5l`tU#&yqFEbSZa<=n7o(e{~t z}(P{D0Pgl>++o6(qBIn=Qj49QsEyk+p+txnqKl16ekCP0q zrP#V4hf4)Bg>pu^%8w^4ov*1F~yqIF!x8Lg|}ZH&-9N?mzf+MSG!%j zA-+X{&9!asnRQo~7HyxUz<*@h%QZqtz5C5P+B7O>f1d2Dw5GXfNnYyilPST)r*AF} zm^8bBsWmzGzDKdzluONT_{82cXYIUb)D{r@m7jIr<8y1v)%~{pyLvmWaB8*xt}RpQ z?^y=~S5!`{Q}$ii+r#5fugEf!1lK4siI34O<+0mRF7q@ z&tmc5Z%3a^T=pcq^}=R<<&b|X>bI4KPBIt&(kYko@cPUHzf@UnD4Xw`CirKg!@MHB&mJrntC!_3 zFz`}YzVKnccWz6r=vH@x|t1X)Dyow5^GUj%o@9HUj5t8@0a~iU82Zs z^4a4|KxK9o5*U#uW2Z)xGg& zMq}%wmT&u-a#-3K_sczAZ=tj1nR4rfK5k1Zo5wd2H|vBKRNUXEfBTBf?Nc|(?OyBF zom_mu)O-F4j*0s3?N8s)@DraG{F?ny(VzCu>|VXX9P^})bJhRKGxm3%IXms5U2*$YP2&~cOLjLk;yHgjo+9`wIyBJkxtaZ!Zqej-vmgCu zR1E)MJar?p@Z$+zCPh?SnA4% zmW$ygbAnP;kAFI~)Z%2+y_~6ULJ~Q6*tLZu7#Emq-f#E((gB8)&x|Q z=(+Rff3nX{JhVQZ!!T;b1+}hRuFaR%@Rm#J-*r{mSX=$_`HOX2^Omlf%^S|k-KHjy zvQ5CvHAq^c!(;Xl|9~}{*VXj@ZWP?&m+&xmdZ_n*7TuG3BFeVLcTRbH^jN)T${Nc} z5rT)OY~gxV7vBa)9)v`vnOq2s(0}?6a6mcccIb0$U|8VmUeGy(mRlpw@pKA z$E=EcNnOA7SN_~J`+T`nbr088gQJrhR=m2ezKR zuxf4Ce1|t1y^J;<*V@UsPNVJFN=^aAa~`VaBOX(X#Z37whZNjQ+VT4RqD=J@;t6UHAT% zl7FrS^@?xfGBhtON-9#j@#5^EBZf2iH{RbdA>m?Z*CP$3%j>@%4!vj~5a^J)Mc*N% zeBP5CE1z^YPx{=x;MbCLAJYwY?>4`+-f@7_c-gw+mBy0I^F!v(z8qYhKAF?yq?AkP zC8KK>9y}4$OMAUZx4tOvMq~4&2M?M)daqg(u}k*O0gu3?#~$An5pcU4d$q%gql@WB zL~;A;WoxEAE&V^^u7E?^CD~&+i;r`!e)O~ZxZhbpf7XRuO>r-S8XWf@aSB&$mVPPo zo_n_5>$I2Mccv-v9M}7K?RvTCf4k@Mi+Ia2cB^TJhqE*$NZdHCw1tPOo^g{}{C%UG zUl*ptx<~lEth~k+!TqV(CfI7z#;1;PEJx2o9$jN9yu&(mZA)v#Q98e+c;sqOAm|M zR;Hws2dlh~eQq;bb5KW3MgLRWwHW`4FF8LhxRm#0ncJgPi&?}LDJx!i=Wx&@AZPV2i~@4ST-#Gq31tGJoIkjo<&>FUr9=g z%(oDX4xh28^~d4#s-=sQTRjgv5MHm4-udIro12`TjMw^hetx(r=23mo`UL5X3!PbH zU+?tSGM`hn?1+9_Vdc&{>o&LjcDmxSn;|>#>GKDwZVkuI#tZi*1`3GoyDe7N8fiQy z)q|nHS|snf$aY5QUkiF3`FB0!;ydG&Bz$!H*I9?}{F!~=kSY)Vz9gYFe}%Mbr@gn7 zTL1P4>+gqx5wHKbyi#_2e#AVwsD9Ujg|4&aG))dVAos;*`HMZ5{F^8Ljqr2nyy|Y) z$TMr*lkUTwg=%UOz8_%us3IkkyTv@@oy}WIDHGL~8cXF*e^BhXk}eo#<0Hqj(A{Y1 zYQcpOH#$x*wK&cZ_&&+1>+dr4nnJHviF~WsJ>)yISGTu+n5|WEtg&*}7oWc#B8-Oh zxrtZ4RP0Dqm|-<5_#AqzxqbirEd0*CLEIS$-Vb6Vja zd=Y#yy=TGRSEuTCZtq!J`@{J9?-`p}D?}2%glyes^-Sh#<+(tcEyX>GQmq%|4_RtW zcRP2Zy83wi(#HQq_dd#f`#YoSuh@d4;$Ql{2OLYjp3;|kM#0VZtV`V2jXg615&g<%(SuRbq7++wLCTTRi9Z zLq|PlZ9}7-yZPP2cRt$tT2$|vil&-^W`(=S(kJYT*z!+Ik8EZCR(~trN%se1g`J8` z*Qzg(T0Z>=ueWKpZ?5l6e-?A1yZdccXqa~0lIB{S4;sFfw*2L`rY&*5s@raz`uTO+ z$DJFu9Z0TS-ZDKcL&yC3>!iow##NpCSEK75WHb79DvMWoL~RZY3)9VLzFM|p#_R{I zF>5rm_o>f(VC%V_dtYk)uW$7yAGwJMV*SmuK7ApFFc?$EWz@*4*9yGjDdOYq0Ev5vg;m2)$=lGe^ASxxAyg_2W(NF&(5!_Id=B&D(B$+6F;usAgy|*!rbe{Pqq4L z?@1RvC2z~i*2{g#rz!H{o#CHPP75wD#nyJZYyC=}v}<2}g5*Cn_S{){GamfYP(P8n zp>D=J7qzA-k`ZsS_t*q|=KHycw&+G|iZ>_Cg$;`TPpSewAjaFu^ z&(}GxD|}J}BK{dRCmk%0+%S3ngnO|cAD22aeb{%VQskfzv+hyfZJh69)G{rnNB!EZ zdnS0rkDtrm|EvD^_PdVnhnl%RLzx23gt;DB=AXIeaDw2prnBt+9pMQKuPxrk>}Ora z$tY7D8Jllizfa)Hq8RbtZNefZT?b1ZZT)l4e&3PPwnksY>s8|ZM6QoCK3V5^wYX>Y z=S{JBx67U{6}x;yc3J24(|O)|TE7Q$sNeO9QoP@)q-?)XWY$X4No-fqp*h`jCIAJ1+EL;m&inrbRR!Hg~LVlvLk-e^TO!#R2>G zFK&7;ujJMKl#F|aCNl<2)zFIgziP#*H7CXG8{TH@T&4Nv(}w5Uw5&~LUGnRZHA|h7 zZ=c_od^6~C`1yZ-p6~y6{rJ_9^VdbA|-xkGQkzJvC{o^Fz2PaGuOy3`$F|Bid^|t3)2X7xxyLs*E z1OCsfJ9H&4EGZJxh5Bk094?dckqqdfJcXK92MFuH77#yCCoLPbjb z7LAt&qQ1rpt(mpYC28uCHE9=~ep;t`Twn88?&8#9*Zn5;Zjpth$NJ@%QY#BWb>m!E zZZF8Ge-gSr-`w@EDaS57qe;)Vi~oHnXU;fdRaa{GKK+yJcRq#Ir2gLBFQ)%5HvX;R zk|pjLFP2R{`RL8cb3wZ7{o8Yvaf-N@uGng3IPub} zjB7oMPJ2#EFq+@Q;j*l$P3YF)pWAl3I=cSd{Yk0kY4@&AOC4`9_qk^6`ekzS*m(i% ziL)f%`z?I1cyaxl`5%}x|82XS9pZfd=5F`HB?_Ci9o9@a-qgPKb*OAgDD$O;_nz

KkN0azxuhzEi_gAW4kg{&>2IX;yLyMVnDi0;_-s5bIr@cCt-lYg$~7wTB{ukTP`L4Q5l(vsjW_h0$_P!?cW^-$>L0r`Ck zA4#j9p5Q)n+2a%UYJ)v81$Zw0SbkPdQ?$cS{So^ufh*OApOiOkPj|?UpDLqWrxAV1 z!y%-m^IUe3_ep>A$OYkxZJeKFInVFDq@Qe;eE3!FyDQRNbGi;$eG2+gb#{O4>1~JJ z8#qZlyZS@OzTW5K{b>v}E__e-GDRmcoSJ-ODO0Q9{(_~e?Gz^S?q__pC-!;FyQ#V< z;f}jB<(^OBI`&jXZ_%P8UB;N%zt(793o-rwOv95mTIxl?M&0X`r+qm#8O7&y9V~5` z98vq`@!F1Wp0kfRZ>+jq7-O^Jk)6-3!?|)T`rFU$OjCIywh#G5^u-*h$V4RZrO9QHpd6dbv7?*1iyhvOL!ew%M|d#>C*o!h4$ zraMQ}w%G)HZ+7stJaf;6#qaP$q1T(QE;v2&xy`h1%a7*=1pO4aY%R%YI`{9T=hK%J zzlv}*^OR5Ulf8YSGsQ}C*)--PoktdvoZkL;EvKIIYfb;9T8Tvxxk4XS>~w0in{u$8 z-|xwjiY%+mElYWy3mj5OwR}k-=xZZ#`~4k8FnmdRx_=*#?!dUr$)g0=j`3noho?}9635QFMO;J z_{Os({lCo2{q^OY?ZK_G>#f_GSd5v3_?L(~`7gbaKfy(As~Gp)x21-K`M;KIs6MZ1 zXnv+OP)?vxL%reU{KA4(_mdYU2Q7$@NV#JF+efFIi+!52(KX`^`#9B0ca~ndo$t3> z@YEKW66K)T8io81-3nAL*C!gE`gO&;a_Y(T`ic$-71l?-F1}koFJej4-xKU7eIEum z{kn5ylb)Ww`nG}&<^$hm@0%jAx_p}5BK@P&+NbM1*65R0ncwtXAm$CNw;M)E6kQhx#etnb|U6--S^a_9;M$3$C%qEX<7DnD&O^; zzv<%plV4j8|B>0KE!nZ^OP^L}+^@&Q(oIL~Zb*kEvS+Mr^>kF7QkXeuRq?T_7bh$* z^PICJ%(KIJi}zaDWAfYw3q)7^XI=MCxZ>iv^68U4bEz>K8=8ZTc+#quI$dVbGJ2}$W`VWTvd~l@b)XF1MW3wkao3VE^xJ+?uV04K7a(#I`vw(=l%B0^LLSHvu zynOkx@#XiKS`l~jn~w5}-@hAE^ZS-wkbQ6Io*g@*U5@=ITp-rj%P6jw_vz^SxRRg8 z&-RNquKD?`R6>4DL|fql>B)N2tm;2qKJa1E1%AEh6Z>qQx_eGovhiZ!q&BnOx3uJ+O$?Mdp&IU6SgxM_%>TsvXNv2M|GxdT zt$ts&Y=YDj==nrrFiCW{0|x2LIvf;m)wsnbS?OA-uK_} zvBAXkXT>{YPG}hPD<8L4lQ-;ZUsta$?#H(9@Y6;0%XySPJif?xsD$CMhr`>~FZTFd zlKgw{-nEq(25kqq9zEWvnf-c-@#Y6N7Cd^<5&GcvM<@RrlRJsKp1jwz^AeKJdGT4a zzh}|~JO7WX)uc=1Zw7vE_CD@EyW!gLsLOueZf*bkt9S9{y41ceDY6sfe0$W&v($Lb z{W9PPJvv$VpYPv#$+y~nS+Ar|ng8l}rhfeH)2rP5l0;hUMKL17={|$m^4PkS zU2C-UrmOMp-Stv`s(N$X+^-yx`q69krk~1=nsMgzuefK@^WI+H^kDgP`~QDVTf60L z-sXHta^m*gt6nsm+Obsa%O+kGmAMtJw^K{+8GhRDC{n}xUsElwJ2$$%#I<(i+Uv%y zq1Rab?`?Daw(s-vZ@;&`@mg?w;iJC-1@5jpR?g%-ROx&?;;k9$y&2z6{o1s$((bTI z*8#P~J7dGn=2o&Vih6aUV)im!39W30JQ-~VgVhoJNBTY5^z*)cc=gu%?dBlG4bd00 zrtL59Hu%OYt?Te+0`Jk1xSs_zslD~zwO$)v@p!UVPy3?q+nyEWuKRBry?bWlYa62R zChTlPU+2L+rV)N`)Hmi7HDB7Iux^goMk}_dD>n$eSta;!YU%MAYgWxzqr2+S;Z%{z znU~f4%4>H=f3@DSiD&8gMX`@G&urA*c5~T_gHb<}%BQEyW#NBzW9n@02fJ2#EDE1~ z+Q6fJ?EvPY{n zN=PgHPCI>P^|QM38q2mTpIx@HOVsMv)jRuK#Iytge|joB5zwl(aD6`MwUJ+*>$7Gi z1F@bpZ@f1|&HCS9?0Qw;CYM@4y^{8?t80uWp5xV#ol`G+E+B7P=tfPodr41vEbMRS zFMdC3mC}{teb4oQZ3i9nld}I^kL3n_5k6 zXYI1?hBdqOU(ZU?t$*ZkyWQnY5r^gU**@QW{jJyv&ZVWdI9MNq_|&3wH`K+DIs<7L-8M!r7=ms6$P|JLlB5z;KTy6ASjY3jYeKLPh% zdvmOpDcLgpWBQf|nT-dTC%ivkFDKEq;>Oh2dL{Eqc@uO=%4r%!y@Rlc=)-ma%h zc(+7MFX6GuR5)|V!Q<$jBdqGow;1o7`Sw`V(C)~hT85C0`!5b~Y51wc9r`R&ptSx( zm_+e)n@19&yCql|b}|K-^t?E+^!ZA3BNyU@*vXu>_i^j&JCqI5Bc7k ztWso^`l>d@xa_P+Gbhs=^G$qS^Jf~T#JX=~u==tqqkHvY4TFflM{D*^-BDOB!78Ph z#q<8|n^iSJDiyxbPpk#lMWbEycGd-{u!YQ0Yuxi|>Xhe8Zr%)^ARwbrw(h~SqW{zS z>VIndl+XPoEoEmlvGvIK*NwQ&AF{agZC3QJD zVben0xZ-osud~i)%uhsv#T&f{P zF|mBYDr>poIovTnMP#P>_e{R6_^;9MN%@iW2V6pe&p7^BV=0&Nuij3#XQ|x1JmoJ9 zSGgEp7y0RJ?*5i{F;48IKv`&(;PMX@UW<*r?RPGnU-2^erQ5!)r7QnzdUgHmJGnzW zoeNg1c@Q}1eSIav%7y9=8GN=$?hKkL5WUJ~alj?ZsFW#1D@3F^p9|XVNz>bx>$yq( z0P794&A)rhta!quJJMavdjs4z=6qNj{H*Ky)MJ;3V z61KK#HY-Aw$OwjaMy&iHb*8xJ{_8VO4Va&DXa82_U*@m-m`jeCmA`G$Q|UdgwA~V9 zLc)KYGEkh^A@@$S;;3_*>+v~9mW%2h^ICIg&9qNioG~BRGlYIh9JOA(x*$(=|9|O< zRi8hHzmQ+|O`?6ho$T6~+K=m>a<*O%xHmiekE`03cSjl@@$Y8cci~juLeY@mP0W18 ziV~O7!YuQ&PQ7zK*L6$Scw*oE8!uYlaFKe>`W7W!SiaLU+I&r{!c zDP1zUVA7Whg$(I`uDJO>c*fj%WXtxW%zK|M+BnNhaKB2=!KiC{S(9tL4>!!e?D3`X zP^qe|$`{KGX=>qd$4#!78tZ*yW;nP!$MS+gJIAVbS>b24F>YWu>K=P)t_Vw)efi9W z6O#KGMGRJ6lKCjmxNyzeD!DbYvbL|3t&uS6s6W0ZyHJ3!zw2=VkHRB^&g?Z0pUimp zlCyn9-CZ%G)3eL@{1?s4E_X=0UwGGXQ7c2ios|XiQkG6ki_vlPnffqSaME5unQvyx zojthwJygjs3d9I0{0unHDALmRLXza)WzA=wQ+84R;Herp?E>e&NB0CA z`LXTg(svW<%}g8@uy@^vFgiJ1jw>X=b6w;{Yqtf3Rb6IJS3NMC9{Vt&tn||VC$qXf z`Iqi`z0}$Ey1`-28``U9CcS7>__l9Fw^&W-`Ql5}+AC9AIc|yWyW@20^CCsIGjdOt zui3l&N}YgCfQZ$RB!(xqPgWt(BbfCZ^m`cKe4D_P}T7r#-qKjvvhUv$}Qj9OiiDjdsGO^Y^a2dj7si*I|o4R;hjUEH|#F z`ZjWQXaC7`>FxK;=5Km=cb?&-7=EdPP4oZkNOb1EU8*(VyO;paRd&7u>!xj%z0bQf z`^-mgwSq`nix*28AL?IZUU7uI>v0o{wb>>w=breFk<8bZa>^~Qul})5u&DG;i{q7u z&%*O_6k_@37`g|t|0s~N<$ipk<=ffSef5T4g!ui!RM%x^{bb)&P~`XXEaNAi?>(=c zSYLl={eM!xJN?diHBvnFIVHy&)$032>aITe+cxWy!ZeoZ(;xa$fBPqD0+J{O*qz~9*}ZqB=8 zR`1^W*!Zvv@4ZX>juaNJc+42t`(dW#@%nqQ|Equg<-hWuNAzEjQg7j(ldt6JS$&zl zdo;YvyE^UmyoYZde7BVO-j{Lx?0*lZo4l9ZqEjNaEB5Sv7;;pI{SimU+1Yn>6Lyxz zb4)tVky5U^jbDIu>w$;!OLo2gdiH3%n6fGxS885Lamn=B|6EE;<`&Zz{^v5Oj}9-H zdsLC3sekp#l|@PFvu}4APp{ZyKK(3v)RLTannBJ%+os0X|7H5RNGShk{F-CU4$Lpg zw>O_Wt1@Fx<;PF2j{2{k?D=Z>#6Gp~&z-%0G)yO3bS}`I6Z3TP`M8o#PhahiXZghW zXJ*#x<&6(7Zi-v?Yx2rY<@fU&xmGtl{AaefKJInt>B%eo_9TTps<^nbaOMrs`gL7Z zYHQb=lgwDSJLm43HEuEm*-QUiIF|Q%-T75ouTL*)t2|b5R_6KNFIGL<&WW_{<8%5k z!){f0_tRPFx$-gY`!=2O{gk;oQ|iaDs9PpiH@y^9l5^X5eeG*ui}3ljMZ4ep_%2u7 zU8cMFmzj2ceO~6XJ(=ctq|BYAv-ti;izKY=E&)4H0 z@Z738U0UD$z5j!6pm^>zal079(myqKZG?Wt#O(d?ne|@2L7?!|da3&?FICz;v#QNG zBc^Xxj~b7*7jWVOlcvv$pph@Z)_AnVh|qyG)|zEfCw=>-2_mT6pnj&K|``&=3R zW&a1skR7JBA$3Bp8pYiFIMcW6<9c-W^#96jyY$kP)f=T7FZ(Pq`I;;9|AJ@8Bk9E% zn!=~|J-(jqWWVYBrsbV~Ej-KWzpv@~wQT>?>whaBoM$%K(#PIXFTkJ6WZ!cs*5+BN z>9*BZ>lRE(zbP6o6<3jd-6~pSzs#xjm0rRQhAa=o1vztD8hx48M}Add%bhbx;lRH3 zZEt=rdgjJ=DCb&ucHUGSE2+FxBh}Z&aR)hrW?Cun)Y(>lf499~{qhNw11H}qy{`W| zd8LsV>y(1}H|mCs4DW7uy~ zo<-+nZNJYl3Ap_1k~fz)<28p3Zs9)1H4-jd3hc_7R-av0-Lm`LpHDsx7b;8nSTfgs zT36xxGof>r)YkBptN=UJsm1k4Yo|}W`r_Hm($E7{iW(cPt9x?%I6S@4?cBlnd?68` zbCQ@(>|0TPDl#n5nN!P#d)*T4-Se)>_FUBbkbUG&NzQG@$UI5ShC>O@51e>s`#3{w zzJMQ3cxr5o_u{C^C*k?)&hed0^?$$5b&Ip=iPkLXodLp@iSIY*PV2irwVi+JWL<{f zb)HAxuid2BFL5%tXZmG{87ieE)&Kr|pT0k?CuqATn`pI`Oa0p5cZ5^rt;G3HO`AKG5wu* zQE1}{0h=CJ)w>kaL4x9ILzSzUkd{YQPt=A6yeQDw&~o35&__uF=`{6*-B zU!ogg4Wqv{ndM|BTV@>R6=N~`bfYMDm(Ws{K<&P3OeVRS*UvgXP)YgvBJy)u<1Di) zf)U#beyV6KbZl|@Bfn^AG`IYNfWt-|KHs&XKk@8}{-d|}`Qgmsf3YUHhX3j>N$zEz z;2CRh;o;dbrvqIs;{Tq_UgsF6=J_br%(iyLTm%0rjX`2dH{?j~+7LN${R^(-r=0)q zmEOt8+QT87{am@@?D<+rf2B=%jT{f|MHU^3h-=vLX6}*$CuRSC%Sh$_GxddKBb(!R;g|d6qSI_sXRqsT$wiZR5t=M1R@;SC<#=b+F_dQ(Ap1S=^T18^Hx`Xdc-$I}Aw8iRb zXVp5g*H@gm!xn4W6=bU^9NHFS}=KbiOrpnldxUoz`hqBn!8!n?e9`MkWiO$WWr8| z*FlXdYTpO=uAQUCyVpN;`>6+aZwT6(%;jB^!5eul>-wB48+@4E&0KFMYCBCja*lQ1 zDXwz?UsLy=;+8uy`N4|G!m*XHqMN!D+AbeZnAgS3?=hqP?rr8^$M?%&4q(UNh8&ad$2>m}0`@0K=|wu}8MtA8x=8PDXClY%M~o_%20 z<{;ZRVL4~C38St6=Ze5R^^Mmr?6~RS`R_*Ge~ZTLj+dA>ehd(DU1Sxj+n{pFk1db; zk(tB}*%pUQuC<+sLG_Jx?P6uI<*wEBSF{eNcmHsf?G*Kt-Eml1P{vIB%nZwWdgo>@ zoN=U4v7~YD8?lSLraApjY*w%NJ}sTstV#GYfBdCqU%xLhSMZg)9xwSK;#laVem`kB zu805sKK?Huu*_v<(qY-XJk3kboJ+A4Yd(Hry}sOUO)15U=mlAVomZLaWz#f%ZoGVv z_s|+vfv5$Cy7qoO*RCSB(pFBHxp(^H#5Zp`B|f_8DSn@@W0lx9C*!G#oQhiyO|IRX zz_C@+`HzrwbIrt0FE#c~STA_ucw)ld0mWzENHUmra0$;tjM ztH4N!QAvwQXs6Y(d1mi>oF<-0>FchyJld}!Uagl<7N2&1d)ue0Nhh~Wcr>4^ho zg#D@CVr*hGVb#I4&Q7dLd7sz|?`}xd&-%ZNRVMXl6x;E8Hz&TE!Z~@1iih#V*6yCC zU3==T>$J$Ft>$}XE$h}?YN)-7&$n8jdHMbF`({TLeD7!!zrUQF$1|bjz#?mqQn*E!@!*Xu7t{}}-nHcWwhsb7CSBgH!FSHz;Eap#x;s8gOkXUU zAQEluvt(kv^WOK&jXasze2xnw_n$PH;C#S7)_CqhMT1w&?QKkMO+R_&91M+@kuzw~ z?qE}|m|)vby+*RU-YH0R;rs^6{py=`hhE)mky3xyfIp9ztu8CKMD#I$kThU`InNq*C+ZH?~LhzLBq!^tM03Xc4H>AndM~ z{=nz{qN!r5TzE>0Qr26_&Efg@pq@o!K6jZz^5J_w?#`)KRcBP%J30TvrqJ1Q4$QFa z=G-rRaY8V6pV?9KM>CXFSl+6s1a4VZ`Cyl*_I%|jSEg@XG2xn;f79A+FE*NkUG)swiQLu_A-O`i;{Sf;^9LeaY{0_~xmgDI!y}Kk{lKOZ3u)_*#_@m(5n! z&yE(WOrDmU!Pv83dkt@c@}Vl7?MAG8Ugexg?rvhaoAs49a)&(dkKA6etNOpfZtpu& zzuprn_y3Vqx#45cm(|rD{ANa!e`H-dC-nHtfTMK+h08eZ{E$y_lKo-zAY>w!>KeC- z4OL-m6_;y-Up{P`*RiGZuS)3oCKDaer9y#2R(cLVDlaAN-z2(lE81`}Vn`~Xtd2ilv>)Y(o*ANoEnSRsU zHTd|Ox7z(B3npAR-c$CJpMCve4&E?WhcbrcyY%d~`I}cnL&F~-5d|gPW&`s<+XeHF|Vf9YIU>EN!oMX>hGb+triB4 zEM@t_Qor`}NiUmpacPa{pL(}A<;uIWcJEGW-6?(OOzoxvdp|NQJFRti*Jjpwt(6@D z+OIZc+3qucJAFx#1>=U_RW{pVlFG!a4c;v?`Tf`;L~qk{-8x6V96OP>ed-(Kpr&KX3Jly9 z#T0&B`l!5n>*`Bansp}3QDW`dSYN2Zy!(+yy~2e(M)Ais`9%G86bjDM@I2C1`TOM3 znRT|iYl=Uyl^UKrUpZ8C=YM`(B{W4vh-&H+9M#v&m z@7c-2xs}1s7WW@ouUpCdBj>E9`|}@+>|cCu7cRf@zUlqv1DvayqAMRR+OE`EG|&FZ z6o#5}thTA=GKF?7yBKowcj(mZseRj*uT7lT%wX#g?eR}CxwyPO#?58AW3ZicYfUSk z)=9ZH(IydT4et+{ch;(83;tLpu;@)$*4>?#1-LWbold(N$RvAfl9&I^L+s0h`1MZB zyA$r&`l)mFq(|3R+9;oS8RM*?gn@=+q%HLUiZDRd*{&1UxrdlmU74>bj?j){^$3k{g2ICzpZ{a zd-2jR1!d#%6^(B;%6BI6xtvhd3EMqO@WO(fpP%n6IhYl0c&M?y(>%eRt-3$ONIQ~+ z)8f&tEL~I6XAkDsaD2HaI%Q&VD@&}jTF0L9)YdZHui~5X!X`#8ZY=vc{i4ge`lZGh z39nbZ(0D2#xv@0h?U5Qmo}dJl`g}`H$=zO}!WUnEo>BANKlRY(@8NeWlFD}o|7(5E zFZ$qvfl$_=e}xNG#io^JFWwAq=uZTA~`uho90Ei%XJj*xTc!5^z{cqg9@IJWuXD#4XEmtOMvxMspH6~=d5Rr~qA?r)s*UpLTt>$_9_=Kq~dKHWLC zJ#*84d$()bJyqsyzxh*Mxmn9t=2eo}dPy%&p1xX*XD?zU%sK+%7l>Z|@Stqvscll7 zF7xHgLjtQ?PHFP$%s%`qMo+0;@$Hm~N7Hw3eq1)E$x@zO=DG5jIp<4fEVTNj&mOJA zAEwJ~l+CXx%{DVH&^70zu8hQ!X~w%g=TECt?zjCU{dv-b?Wwa8AKsZIvoG&?{G&VX zk6!Km&+gzZn>YQrAh!mi(R9XJ=9=|eqa!EZF`HC(ef^5*Hxt}T0vQ+up17T9&hg${ zbmH5ZE7ro&k1G?xH}2ZG&RfMh==}Qodk!q-x;iO&??rxA6$cqkh0muKUwxFgP^`Z4 zX_+xhcy}v)4PMYiAzftq)=%uO` ztGeos8Wn%Y{xRA2^V77KM$BDS0MaVhI<^;`Qn{eEit{oK`m zo&T=9S?s&?*P;bH(-U-ZV{-~5lFDzK+$HjDM!wwc=PR$NmjA!=rQh5;*{A5n^@t6g z*Wbu*GZn56y;b+nF^$Jk`e~%!8vehpo^H>7dp{#Qa$fzdqJ73Ujr~7NjeYbg=GpVr zdv8HIs%LDex`mR`m;MlqNm*O1wqAYJncdF&pYQDNU&i7I`jQu3w{LsJ zpIh#II_{CsnVP%vH_F%LZeC*hc4xpx|M+s->0zPjwPEeG*Gp{YFkR2&d?-A(q`!UJ z{??*6wclx_lYc%jub-88_U^Uisc+(BwwunGxY5<3==J0#&hI9sLVcl^%Y6QXS}rYC zyX@z`I=A-4?9#iAll>AmE%LZ$Vs2GAq3hwj4GwSq@9frX{uy!R2G7>m-sg_TH>P?0 zzai(x-@i~P{w@F8b+^o7Uu?}YyLdP6!OOSdJ67BHzssL?KxNj#TB*T1see(8o< zxo7>0)w-8o)!wzU`MC8`Rnht_t<@`yX7nwq)Q!Eubfnpwwd~`{LcTEO@8K@oJT;Zh zTYW=k>Z;u}Yd2f7;$?;B@l|hUi@q0Fx5>ZzvwPvKFx^c`i(?OM`=)*8?&Eb?_0GE* zmv4H;cgRK9tjpx4M){lbzc}y9&8nSJf4q9v!edgq79Kk_-Qz%Z-N`+Be0uHD=g!=? z?#wAxj`X)XF0bcWa!9p%x>o5uy=j%JYCg*Jhh{Y-n!P_=d~1T~==z z&Q>hkV3xD+^~Ayg_1mQ`|6Z=~*=n9>tnvRvkI@A4$cN`8OvBkfn?BPzd#X{pcwteu zJJs?MoLBa7u}Ynpa&p<) z*IyIMyPXe5+Zu$5EsXf0^t3(x-HwJgpMuL0&C{m)%k8W`zjC#;Ug*Z1(G@(K3i)@f z|5qV&kkK@XF=qPDcN-rDa>=*rmKSW5vAM~w@wetvrF`f)-Q1(9xp(Jov+a!1=9gcw zxWvjJ@ooc?na1fCQ6B5l*rOKP6|K$w7kb*_LsW@R+Ej(CPY>6*-Q#@WWxnOVTt zMMPcgKK#tNwLo;Uld5djTK5U@?U(DtmgX*OUiS3cFYm3dw)@{{y0A9S-caVS?V*o% zCYl{zx7wNe{k+tZiTnE=FJ@+b@3o=gei-ipg_^(H?=XE>|MPkyD^u|mwcBa>4YE@$ z{;euWJ3r_DzJ1k=R_?lA4n56`ld6c((%llfrcB>%pGWVenG5+QE19;QZ~5@)?Kzz~ zi#_!}{C{x!dP^2rN>1)Es8C_uBWtqL?C_oi(|Z`cnCJhWw1{nUr{lAO$L?LPnB2Hf z^`msuG7f>)%6&(q7KPODCAbB)|1Pe8#%rx z2p_9k{9?x0&O;~WozGA+uDWnsqnRso-r~78PYJxucv7Fm75*(J)3|S1=EQ7=Dd&D0 zEVw*z>dY&mi+A+v^5&)dT&w-Nt@R~OL%dzABnQVa@0qN3n+qftMA;b%8W}ipG%5aD zbZd9G{ogOw`D2#3_p`DvJY`^*vF#y~hy0-!o$?KgDK|837ue|vnG!W}3mHyat(W+F-sI4Ko+y{9tq4>f3PP_zK2PjqwrFH zNwDRMWhWdPl3rXgwm%bcx2rIh=Z%Y9(cDd=zd7+h>o+ElM3UwKe#WklZO zXTM7hiz!~*`FK^{@2`cT20~ z1M#Ti`|p}{{CgYxV(-euuXg6XNIo!sv1RhfWmDs$7;j7q-rUCVnf1U~-Gt5mOXt+f zxt?P_yvF$C#GIqe3`I*=oiDZCWvYLgwEY6dtIsSAPdc+>W8Yi-{39@X>O!}(5Auq$ z5+{XeePLNUXTpx4s75n~)HA;Ggtx3@s0+P&!`|qsM*W(T`q%Spb{)UNdHw!%+3&Yx zC9XE=UK7el@R9!GeS!I!h`m$Pij%rAe(ic&f_sZt_BpULp1Pmjxg+ewH={EdOIu^v z>chkuRLj&EELK<-s)zV6_-uSXDktUu`rg$UKijx zYQ}b#@BHbf6>Dm$o4XF`1;c=Hy}v?I!g@0_%>(?|j#G z-Qkhg`mC=C^+)bAtZ%w@bTzk>;*1AZzfGIn+I`Xa#nXFcIiGesxL>q5`n2Djs5R|r zclMP`S$IYJ^pmU19h-08SaPt{+s^Xe9#*@z8P^>qmrt-}G)r&Gei>{lbz{Glu%T+V zNa(MO-BQilw4J=AzQ^vp-);Te-Js3tqsXFJNzWG)J+YZ>&HkOY{na zINl_<^vk}qEUaNo(A_J+HSuv}S&OiLWJphE`r)Qi>fs$VCq)F$nnf(V#@n=YDtlA; zRdI!{OVq39ms?D!P>KFGLH4oP&zJ2#d*}sa$JwUxJ!O34&ZOp%I4{95&%my6XJ-F> z-erHM-rdB1y4~2dTtWK4LsO@Pho`gUPtPqZQ`$7~t>gw@>+8ARHVsN&;*UP&YK}kL zkRkb3Dq^xjn@vPW+R}%~N3ZR>*Sb99>+%o0j2o1iv$xo-eYHZN=KJFyJu|7R^+#TM zX~o_xZrphIrm>Dr#H_>8yLZ<#t6J49t25Zqru8hac%?4;pMUSCGpDXR-(J?6cPFTS zLbI5Mo8Q7nNp6)k?_E=$^QZ;qoja)NZDlGrBj)}ViMGhVhUU9=`%>Pr^}fz3e-a_I zQ(?x_1rI)lHZaI;=WQ3?ebY2EP&_>+Y*~F;$r(kBu8-R!Vl!XNzO2?+rTux!24P2u zk2|L>R+YDweY0Ty*8+oA9lw+AWu3lev-aIg*JrbwxX$Yb{f`&7EVy!KlbhTgcZMt} zvDFQ;A6`9h`xLj>%$nMqY17Pp@OB%Y%qh~Jm%(u8ZsvC9`*N#|&hrb@X+}ideY|>W z<)^T^#QHWrJD!4N(*&FQQewpSx~lixerXdqKWg7(s|Dg39g7_1Z;xeVSG(YOu3y%6 zCsP977dC~xH)XdMZq86Qx8Y&y3fc01l~v%LskzE6Tns(^y7v5HwpVVjv5S13m2vmo zfop#MC8i$9ZC%*#q@HO-Y~$Vw0<-sUep|8qgV@Q%9Y+q~!zqBpKW@dT8FKkB_r5<@!0vTEt>n1w{SBlJoIjD?~ep%^%A`7f0xg0pjbabjp)1xY(#wVT^&rhf_O^I+lC;UM&Cd9OHqS_AL z4Id8cm!E#W@kN_!`yAn)CEKQ~mNwEdO+J$xaWhpYLM52_!$Qf3#w@-yeg8YEcX#}C z?5gjwFlD&9Iyqu%s6y1ab(8l@>PnSmckZ3#@_9mpp|8#QCnt~m+7+i*GTo15Vu*pt zLV+Lbwuf^iFUc{j)-#%-;l;S?&*hHU^JZ*X8&xtTVdDGTw!Y|n+dYmbT;CdDe`3j- zn;!d5-ksShtTK7-;)2JY1TVIqT$Vi3L|(AgQQMiv zD#iPyNpPjg#T1{AQ^y*P&){l(%3$mE#Pw#9S@KCC8+Api2_IkHDVno5>iw*LUGKBb z&a2TrXIf!jw=0nKQ^^A>%O^%WKkiv`j#xi&i2H4LfaQF;t?&Jk(-j$ z>2~8m;GTtBEWRzSXEJShwr8PCr^mN>p9L3YJPf@zzbbE8fvwn)lMgMjIqM%Xf4i}} z>Cme;@#R9>9_PQxpKw?)y+8IAf9d%aMVbC9Wl~n((>_ex+$)?^x)+{p7m?wSWflPZZR?9^meG3$R%&T7={^{MaMt6}% zqC0(Dez&e+)9Ts9dE3*R@wk1#SDO#QGhgaeoO+h0tS}+FLvN3pw5QBAUCW&t=34OV zFMmErzZ(oY1BO-gr;D!U)MHQ?U$DgQc;U9+|3IKi6g@>0ZX$9$iF*vLZ3 zt~pc zCdbim(V0L02c&$`S*F=7HFy5;ZSUCL%e*#D*X$@b_l{@HIzi2J1rO$$hPFV@L}o3` zOS808R2e7MpMJP*5r_M(xjhDw+xLF*_;zr&qF+z!SJyvRtvzSTd{zB2Ib#?9$$p1f zDLegwbk1I9VM%Ie*tODz?eiv&1CkkUL_a=x`m%n;mB2aQs!W)7ggw*xskftd&Z8I1 z|2C;IuzvGO;7tB7CGUNRo?79AD38oVI~U5U-`p&AU%*Q72CL?|lRip^b<@oi7Dla~ zeenE(qhA{)u6*s-q<4hJ)7W46vJ&??*4>6qmw4`VCrWrGpNTx2{J{EE+fBiuL#F4C zC^G+W_xry*wm$3Q_teeWouzO89clIKYo4~|n85XoI<@om8s-%xt9f!7pXgI`boge^ zzMGltxW%trkBR9P$tm$0=REVg@MdE3>Qmls9uF)ix zGmT0f5)2D9WF{yjnuPXcw{8l3+YPo0~WMtE>EfdG-AL$JZRWq`JPY?&~|Y3vcS{ zD}F0Z%jjpG`lY_xP9?KVN8qt#@$6)K*7QS(78C!SXF9x6B=TY3^hjaZawTCN>)7wh zzY2e^)pO=!G50uAb-L5!a!Oa%zxPZlmqZy)e37^4LF_WiTh5KL0*kL-l`-T!W4tMG z&S{rb37u`_mk-!oOZso$TJkB>%DC~{KV}!S>mzLhZ9vg}2XE74dq_WNbd!QAnfyY;<(-<6|4^ z?#CaTzGQ)xpmq6~C9iDO>@7>Wp64gD+D|UW-a*A>k=Pyyg{{--Yj-VAcW7u@z#Xyj zvl2tEHq$pB%Z(Yo z?=;+eX2X@#Ia5A!C(C^O{IB|?Rrcm95f5HWm)Y~L>X%^9(y-Ut^H!^SX;d(X+_-(M zJh9%tW?AEm%Gr z*&^@PS4=YhT^cA}^8P$CqtwLjTdk!XPIBrf_4y_UPJH%OC(2>Q0i|PaZ%1yK_rFYR z?QTx?X&W#9@r^oBA6+xe^CJJP2l=7B^yZZ@V}@yt4Mygy}E4 z+5Q_lhl+c%Mp#-XcuP)>bX$5~-^ckygXSjtgPQW1N7P)>%@19*=odf0vW1bW#Ew%f z?rbuPnuG@1yBG?UVDDH9UVLsZCz#tp2C|lD<%1Z0M$@*7@!7CHr9(d)s=A!TlQjAl{ky-mP4oGRYFR)EIEA7gk zP`Mo7zoPT7BI}+5?FWUNT0a(+ zD{Z+WEB3zjbe;XR)%)x8nNJwDy0bKD+9cW3`#-qI_Dn?1@Q~UEi=Q1{va>BtnzSwN z^Z&i@*;ku+dJB3lY99Gnzw!LO6Yr9PUcZwo?v{PISzpOQZENvCJ!#LZ=>js7qrx}n zFIX5M?U^Mma93^XybPTMtyB6MVNhG*XSyOu z$Y;;2;~YL7vuC}zq@m~*@JMKOzsALzHcc&Zt5x+B&6|$Y&x|oO>fYUPr$bP7r<~Fb zx#kXTk37Xi+LD4!JYIbqAI(l4=D0ZVPf^2zZTte?A{%B1Ouu_$T9KB+0l_jmUWK@` z$teQrCLi9keEmP)@{Yu*7$;`I)Ll{@OG}lN|97A0)wn!;HgE5ts3|*J?sOQ*?vzVS za8}kRW<05Tszmj-Rej5D!6}uqpCnFs=~2ge>V)x>i{}@fX?gIDiADZ-VV_aIsocJf zs}JmEaxXqUTRVFa|NWX@@3Qoaru~_4>EmHrz9U^$@uDt2g7UhZckXD@UOlO*`~?5g zyxHON7EHF4n{;>KjYm9h1D=Tr^mu=IJ87Q%0b$X(Vz(E?*m+d9(Nukf#E6zxBpSkWR(|1p@w>11;o#}Na_1nK6)&4p1dSmPJ zhbt{-L>*o95)-`xE=8qA>E`p&cx-6Y4#bZZ)08)-&07hc>y`!S_(&EA$X-VRRt&gY+AWi!RqdCFZ`xuY*7H`Q#t-S)b= zX3q-g55^yij+R_{@IBc2j_8|=b01%~2B?VqWRlJ2_4k^t(|tDYwv5BfxEWhK<@(}n z&#&SNskh2GmAmsKbFaH|Ql4tG=l6d>tTIaptwv@umE}-txbrWH+cSYB?8l{0L9hr4Z}?trzp( zAF!|yu5)~T<^HKTpTz^tyFU6YZh3r@yUFACo;A`+LPs+Gt5vM%ddoGhr|$N|_pE73 zh5`8pIs5-Ki2OXbl3#23n)M$qDSA{EH5ApHF;J@AdAB)oOHhiK%G%Rccco8$XO9y|m-A27xrZX#Ee_o?r>cpYHm-AtVnn{Do(`9Qu&C19+F|Yp4Pq$Z+ z)oBSk#flsGPiEvke|vgv^QQp57uPqelTD01*ym6lS6IN*wYWNNr`i+GE2`;^(+i6E zwY0?BlVvSkdoPG8y=a*Dk@?En?NcVKFxV3(n>~NWM2Uss@5JsEw=C)9UhlEz&g9lz z2^{9HA5Y7B{&C~_5M7?U}y=!hR?^je<*m5M|97oP(7SU}7?>h4o{aw&g&rFSv9>e@Wv)nT3T zW6^&%fzH)TMJ-KhN+X^}+e~KZ^!W8Ud6NAl^ha(oS!gMyb64>hJuTrV5X?{)Kj!_uu)u~{N=a!7569wqS2>4+;@_%2 zP29sbCE~}r&wH0|SaLJBYyIm#0`pez->_QY>KQw~ZH`Eu?yE!7Z~6b|-F)xZy}nB3 z*vGoFzBaxK*XY1htt$_nPjWbTVQWMw>5qf88#t z;?jlsujhmQdi`kYXgE5_V=Kr1DZei-yr;NLYvrW0iQ%bx8s5rES*h-=Og+7?aqq*1 zXM0)uzP!4YnjHB*xOh({?pq{$ za$Vt$SDkaeOLj&4FS}6x`9nv`q9xN49^8B0U(CP0JxTu7&w!Q#x8`tstjludFn>rGDjFPx+|?cU3X6)2J7Q}6Q6aJA znZAV!E=T0W3W^kpe&O9NP`P^5iWjRIuB3^nzIflrQ5yL4qb|GY2JXeiQqMcTef?uU z!_8)a_bSDLzz(4W2em7`p6j~Z=3aW~hq33DjOXp*_jHdJgq*1Uzv=$-X-gm6|M>5J z!tQxT*RTD}YA$kFf5q!3FOSdMmN(sa@-CnHD6Nx%jjCU6Kl_tDZ_Va2OPs#!w|MCt zwDOcfjem~8#OCXNf1g^lM4?w^w$hK18Cs{_)fZX|K0j$^oO0pb=FN*X@cdQaO}dym zgL`vu!D0V>ad(@H*VdHn-p|!*trKOJ^VxUj2VUkdY0;E|EY)P52U;%O2U#30YoxL% zw7gjU&9gr7cgdIL($qcjW%Cwy|K8LlwCa$bu>L|xzT%&)@`sdnmu{53b$lad@kRkn zC1wMqdv=pFd@nM2ly~pqX_~%en_l?SO|!R_?K=}=C$M&X{Gx|4H5uCX*{&?zkv8Gm z#x5QI-lxnH7yihp@oL|CFeIb?exaeK^8G!XDLUyd*Sxs5zJ8UfYxGy!%hMmK?B#s? zz`!?sMuzh#{)xR$SrnOG@0wTAA9vUO$~)gj`tqv0%N8Dz(Amx9!#BZ4De9OZXOMBr zu3rIHu5VfPxW1r&8_ScT=EpOx^?5H6`th^g?;C@K!kkM}`?8GRt{3;QuQL|AQ(C@e z+Ln~yC(*kYd2A$%WT%SPhnGKhzq_sV9`|9b#Tk#qxO`?!ne6;n*2J%VT4VIB7CrTE zGcEZpzEInE>Ok$ZIvrDmUzhtoKi+mkDkSQr+k@mISM|;siEezICZMYO+Hu`OPU#0N z%HM^#{yjBRmr<~HKwX<}k;ky6Zmdn?F&1k9) zpWbbteP%uC#BbZmv+j{dQ>p4^eSuTB>vUi z-o;TC6HMmh20xr|sIakO<-VCVXTRM1xksafbG)S*&%gM$f5hy&12PtgqCEJ-QYT|Cv2mSfG8tY5N0{ zhwalCWe!C7MqXZRA^SM7Ey0(kFLlS8qWq34nSV0>c&dlUICK7e`FO&EgU9&8uD!@g+Tb_84+LNTQ74vD26>h zom}&*P`dGos@k%j37^;cVC+ zRLYf&u8DxUcX;IEHxxeE&A@g^+DN-b^O9ACkmcjn^(U2{vPxafKm9y(x+T%+(cX>X&dDphE7-#Ck5q1(mF})xbne)??^hLC zWB0y&owcGoNY>is?5^2&UCwzm9+XYOs;Ox>;5D%>jGWhV4YpZd)&EEwr5^!K|<_n6B*tq zE(`nK=b35dzIU{{R_k#l}MEKg_rtL5_}?Q2VZY|7tezU6QA z%KB}l+#*vW7Q9&L+~WG;#Ab`_XSYd38hJ3;n@<(FwX5>R`OR<6?Y+Q%)*#7mnZ`{0 zE8ir8SFmS__swcGkQRFOuJ6?B2QO!eFrD3DaGu3y#qM7V*Q@n9vDhVLSY-3Z8P2O# zz3{7v*{Su;!+>RK(fsZ~>QOoW;=DUkPp`P<*m$k7zI;Xhk^d@cdmn~gbDi&e)&9zs zLVdX~@0=S>Ngs@kbVP>yUUo`+gVUDKQ&Bnh)fP5?3h;Kmp7ia{Ia&F-u!I%q8^1)z zbR8&(Sfvocsk=t*)wS#dC4=ghk>Sw+-}l|t`7hv}?)fQeMM!42>`azcYXfG%QseF_ zBVVm+YnMKso>qUyJ9DSsm0r)S2lu%=bwF6q$tJ}<=cuVd+&6}g#JX9Mi)>yxH^duKlTA79*# zl-k|tvvwNgzBszZ@$`)c4;I|G&TchBX{F9gm&ckmuL6axceIkDqUlVh-jBz{ZCjV zJ95orAFEXx7HJ&PdN0Tv_4a}N&&72`-UiR#b~i@{pWDs9`7{&5#;3;~1)X2C{Z0AH zrTtzyHCMhW923a(y5-2qj-WUC}IyPamPGVm{{zHzg%OC4? zb9lDxzJ4Rm_;}9t$XBlGMMc@SdG9Xs5q)L&_7zJCQ{n~9lQ|DtShh&XL<+1aJ>~AM zVW4fp!xC8{BlT<6)%HU>-)g*FQ#9wD@vh1RY>RG*hWjZPSacsX)K7A2)0_9qVTz>G zqGQTp8~Z$3GhMXKUzo7^|Kh|(ftA%xv+ulHQm=4-*`Xy%ca$+ca7+ zScD$b1>7n~m@;L(`!!Y<#WxXxZkH}^_-MT2lHIzHw~tTN*luV%p2cR{wV-R7v%4)< z4)4l`JAd$9s(=5lMuBfv^OX~Frf;fW1TfmIRJ1-P(4f-OyZQ9=FxB+*6O0idyU)g! zE~r&q$sls#GPi)&`;9-BrAG_La5&pBJnP-K^q1ns1BW*=?*zL*u-uiV-+8w_MZr8GILGKH{-^cRnPrP8gUt+=IbA*f_ePJ?4x^bqv%|W(-u;eiNIcweXPVd@rNXb1-?mi9Uu#WT zday2A*7MOm>oWe*=$1m#@f;^J!8~;QY)*5-*h_pzzmes#&oYy>S`TGXuj#S%| z3#R7=FI%!hWLb&2{+H%2Uv4uhiu}~N>U*r%Kcf7&o=|Pel(2%CYfjEOcz(Xll=@G{ zHp~?6pFd|uvai_JlhU?=J!vX?*Bg1nwta3ncrlY>p@vZPm&#i!YD-h%pGGfttluD` z9eZKpS=%#GE0!1QYm0?X(n$I4`DFX0gAAY8#W}?tzTZ7mDifNQ5LWl&$Km7q`HEc> z7Sz_~NxDV^E<08c;l!h8=(qW6J=dNEU*Fl?XSi`vZ{lZTo%k*PT%D_)bq9zX+`pns zT~RwtQTg%NUtMeWHwf&`b6c3B{dSRsuae-+oV#BhhB^p^ELyE9LA?PcANGWnChFM74rN zO)|;UYu*361)>=ree!L))}(2zzPW3{@w=W=Oit|z(sISZidJ2 zBBm6D?*1uqTlf)^&Vnk)vucK?D&NpI-Y0EUM*X= z?2~Dt#l>A;I@j;_pXBObx$yi=i>3UZ*;iI;?VT3*+~`!-o$`qdQI!vc7MwFYXVG>` z;q%!l_v4#a>u426KM1aro5&S^Q^PyRUS;nQ+0U-~b&O25@y)cEKdC!r-z^=x<_sCl zQ}Km;EU~#hF)pcz>-?V9dv0j_7&nX{E#+?b3{cxsrx(cB3F>OXlmhBkur&{FH2v}P^$Mjbv&0q7EyxcuM-~7H;;mJemj_)~mRH$yYj7ZSgiQbNyc6d83EgF=O*FX8fWjUY4H&gdTOz4-)V#X zxxZJa&HX;fu6XNn>toM%olnV140Aq`)W%DeY9!Vw>?7dm7_yUu6vkm;U>RDK3sNtPQ4T3VB9AZnzZ$!()8B;Bl?9~ zeJ0gUSlvA_eciOq>fY6ob5HQ!jp*LLe3#+J44R>p5wZ>6tRQ9eyM%SQBU!;bnR%Wpkmn0@o9Y>m18zfXA@ zRhAx$R=$1mvtV6S>&eo!mKqN|dXC)NXc@9MWE$7PYwLTiE|+HAzENi5(P+izdnc~B zD59il-yrcSx#OBw$ z|7mcQ?q>g97Sz18xqg3LM#Tp8g-&J0v(M{)J?s3rDB)S2WZr>k&)#{xFTST8yr<_` ztTV&0NnMkA&)f_s@J^WBxX)rjs@fc}b7vIQ_DwFhG*|EVuN+;j&nsTtR?-pm(b0Px zHaV&GMXhI2%sy_V_oaK4!`KV!mim2RN?cUcXyABZ#U*?1dqGq0x0lD)>-XyXnj6U$ z_~^2@gz?5J^CJ7auHUf~X1^fN^`SWR(GtfUo)H^uKS){o87QY@O570mHer!c7}FJB z?R2ZpFOP3{Z*3w_nQ}nqA-gtXr0Z#61GP&VXUDXh-WU42;Mw7dtJ*6HqxvdTv(@|U z&zT(GH+4&gub9ooMN2-0%+s(j%&a$h{<6o^V6%Z!N+vV&sj>*^^^=|ET^3leq2oev zlC_rc?ZDYL{B)iRZ0xn&zjo>ht+_AKx-Y!yerGi0;hb8Rv#Ww?x5b`wUtoP#GIZ$~ z%N37LuVs9BWAD35txe*E3%Opd*Oh(tvFBpr<2$orpO!q-N}iU!^HF2MPmNaP+ygtW z^VPqab9}nwt_fCLHC3ts6EopJnu!J|XHtf=bizHBuK=Uwkgp=JNJJ&8$i7 zf7bfVs|%i$AaF0c4?l=3D3^^1~txsK`j~Tf6vc* zs$O|9Q(zKT)oPXc_}@Ks`tLujowPt|$_}?%d`^<4&8e9g~>zp?fD?Lw&0q@_0jgqGi#>A?O9wbXL{mI@ceBd8qe+q zsOEWo-yYSr_Tiofey=)za($bA`P%*YU45s+>xIdl-#s(W{Ma=qKD=CfO3c6|C(kR$OV!$j0ytgfBbLlo1pl&QYSlAxoSDg?Y~~O{Bkp=<(U;<*NK&0M~-K>6>>Xos{Nq1IQjd; z;QcYngx3qCuX*MjX}R;BjI_b3FDo7UgY4c)UJ=y&dAq*0b+>Wp{TAc(lWuC=Idt~P zZSyUyr#>a6RVIph75?A#vUS_)<;qLq_=Pyvn#EPB9lTvo^35jZvb5TN+fS&6@3LgI46m>I!V{-3wRykQtYaTb%XVFOQ_^GcQJqmo zvU;<#tlgO&V|}C9MfE4A>^u-C@Z+6;;EL~)rxf_R-riEYxc2Du*(t74?Vs;T?3?Ce zvDNbI!p4)EOS-GI8MxZ3s_iPC2lGw(Jk#{8a`sJ@$@4a|UY&hF>P==*AY;m3^ zOqf(=Tykoclj76p>bi5yj%msJce5J(UVQs{h5vWM(!D2Mig&8;eEsC3z2s($z|8zp zCtYW|=-)acC_iOot%RkdiWJk9f`8plOq=$dymsH_Pgq{)Afu5=2jScg~_SS5_DJ^ zDP3Q$G5`1Kyu>)!_)X%;X7b|O4boQpw8&8H7ykXSBecW+nSksL`|Lkg@`F#zq^>f#mGwiKy zSY179+T8qaXXk71kE8Xg`qtiK-Z?A1Z-Zu|cKRZdLh;FG^`FhM+*}m+==Y2R zO=g86&wpl3cFml(cgG@|qK%P~OwGsAuWy)l#I3STv3UE5CHsDUemmR#o`Rvk`bkr} zbDwZ+_A+vpFI@fhWBu9u{l{0!nqE?K-=-55zvK19W8Ief%On1NdKUlmyr=l?Z^tVQ=59esc3ZvRsD5;kZh=XF5$V-Zp=HkBRD?dw44*9HgOsDGBiWAFQD&=PcdOeyNe`0}ONBy_TkKyYy zww?^)c<%D!>Yh_GX2_{-+vE2n#;2QQ=@Px!uIK;#e4cSdX?C!ao%{ZjsZVeG-x}ff zUw`*0c~zrVi>z-<`{}R$Z(7=h`yVWI`daTfJZi{zv10m`pU3>aI5+4|+hMbmN19h_ zWm>f&%M+7Z#^oOzWq$Tw5_K2OR{p*JR{e|BizDOSeBQh>j%BC0XJa&XU#|N*|A{Uk zjYT4dr>^`SvtDBQBsP=D6>Ti~-H%M>yDH4ER$00E=aITYE{^}63;&;gbe1>cq=>*U z7uJ=x|Lb$=Wu_gi>3lHrhg#njF3!TtH>a)EH%z#^Zi0uJ>#teol&dF*gmNU-ix{)zn!dt9UY5}UvY&NrRCNFCW1@B6*I)2v)JyQQ5HGT*EPi{#;{sdmE?2o% zb_J^ITv~)uCw)r$Uwb}R!|TzpvH+b8HpS2EiuLYWF3#B+o4T5R{lBXJuXcZbs;9U5lV7}fxBt8S-cw8Xw{BZ~<%w3xwAp_uc6hJdcCvm) zHro;(qbsjBzHIqhl74DQ+OHeeoogMAo#4@!f2;6;(|3cgvkUKiQ1Cyyqnr8qj*d{R z$=PdT-c^3$WB>j4?)iM4Ev0rh%ga}OJh?1y=bsy2Jwyx?O_ppeiP@ZKmv-yg-%8sH zSru(tU!<)0e)xO&%FmHOo~)Z*`!D~s;n~rY@YnSfEzhp0A7;pQ+~gzoJMa7%uIifa zaj$PCPLE36*OIv6_wh4N?!0*96vA1%#Pe6c+T*+OcRgNr>zd7n9jo2u<%IJV>iv52 z{(;DYjM-EA`QB~OIsA0i@yl$-KemOxFAb9I&)vN4!zZ?NnS3#u^RLx@zYwCkdG%qp z9~FAB(d+$luNv29M=$qQFIjOs&Gv-NMr--(|1(ouw6eE`mS@hK?y1@xvHdQi7?X4H z%-QRYudA<}{wz|Fck79$+oyC6U$VM(_uq|c%3ez@e%#m5bKP6jM(EF?4}yh%zDLWp zttMAU%u3J?peoNVA z{kq%Fmp+#Mcq-xBKIzpPm&M+Aa`v%@6vLk``@@-=SMvK@)^%-c^H;9fus86@s*hK$ zFG)=-V!HnQn~ekejP*R8zMJlEUBe`u)+NfurJKy@%~IRF=GldwoXZQC@}z8zCq8?8V&PredQK~W*ZUNm>mHcBS=8|2br*k1 zpwmesi|ixktyV9eIlGH}3cx*|=!E*;!Aijo+Dm|GE?2J^48E&PgSU zr=C}L{O1~#qRk+1Z`zGRtM@nJW_v#4!&RmOj?b5MKWX=0zARVn*Rw6p+2+45y0G<|OPzuE&I4Q$NfR7* zwKMKjHLGEG8@o$u8`FwS>#i94v@T^gQ*;SW3iG_UO(*t%o9GXnHkSI+<_4TIjYBH~ zW7xi#$x7wTY_rVy(8!=~wQ2UIqRPCwSE_d=Su!ssQ&xuv(~NADmmEu ziPiAqDfS&(BUks&Eag7*X3AODC>FW@Z0oZR%#T&#tcx*m-(APgg5*qxFZ9U96t2vsMapaW@xj6kPAM<9p=d*{poc z^$N+d5BAwOJ@&E8?5+D$R{Eg0_xkn;e?M^~ZpdWTWM{Ux%c8fj<=v!xZ(cinDLupL zEqEY^;RsWwC-Z~b^$N?G`8)e2Y_;1uQ!8Qbo*dnK1=kZNFJF2zda3iz{}z$)uYR6X znrGL`a)iNT({5L-TjICwOnVTKscs;CLxzEUjigJx?gKvmOHYpNXebU*ygog;S8bWV zPc0qGB#md0$DX!Z_b_JZE$Dynt3Ps{t<1yy&!mhVga`+wB%ZrAt9$vv&faGZDcj_% zDmYza7nmRV(`aZv&2o;bR+p0%$GOPGou%0;WhGhusEJ8hCe&=dP;Hkz<)F>$lRKPe z{Ha)Uz@0fQw?5(dUnv=ucb`mumj&MZW?6gq?Z(ey0(Tp`=Xxv>xqjA!!T5%HvVc8r z$^H@ni#Kw5b6P_WUHth#LbcwCamA8@j)!bpjK4p6yrAe5XMn|RZtwfa9h{c z_MMf?ksCd8)rB@iSxlIAhX36?hW2g7*$%fA+g8LkKWa_gXSrlq{p{5nPCl_t4CL;9 z*v(TkamMiu@y?Dg_B-h!4I3XGEa(hd_iUlyT$JP*epSr2n|)HS=xJW#u7j30e#lt2z7T%UazG;O zU(vx}o7O|ACzT|X@3D0*ymdY1s+*v}IaLAk%X5=iPdB|#|CY$f`Y2{|%hq?2l1&AU z?TrVPK968_eA4o%`1}mXeI1`HCzTqWoK*aXBk=jl4SiFC@6_?WU*}}9Kyk}5;resM zWljRBiWf?E9Z9&BWU#yCJonP`9}l1Yp1JOwa9Z`G7KTerU8=uYRRiMQlkOcJ81;fpq#w&XKwE}K1Rx&X`R$e*7h6~C)U_Dq`{{>O5gz~NB!yh|qn zf?6|w#mBi$`eP~)cmq-+xLXjTfTY4^z_xEvTDDlPgSMrR#)7JFZYc$ z*7W=Es)n1J{rUb#+rk5qc8AVx(LFsOL6$e{_nECI9AI%du^n%vOiVHW1# za-2_P*0qIVc2Z{gc9+;}UpM^PCDJ1NgyZBw>6sG0gU^bze{_h^Ffv-kbx*`nO2>bu zmXE*_w)!b%eEZjlUFQG#UO{onMBSs?6biS+O!?AOd?@DBq-_g-Opl-R|Bv@4`6y1`HTmSbT*&;kYR?XGwjXRfS8B*}&4##u7Pe)_ixftRnO6WW> zk8&?F)IPb`(vR88D_@wMfdO;1%W8N4&-b+~^rBA%^9K=9eO>_ay>3p_2-d|VugcWA4L*-XD->bU;E zg4|s*eim*od@uhnD8Pk%WA@DXfA8k#SiiK@`fU(rahD_Dk(a?YDfh~x`ot-1_f_*( zcE^YssP8)X$NSx+y{UEIrdhnIjZt{S=R{E(4opW!BeUo8{KEcRP`rCrjXX9q; zzBP&o)ABY>PWWuYsIlR0pbjHz?4MRnBh$a!{qmn@6pO7YczNo;?-VX6!?ipI%#Z1x zneyY4kyyl;P@!);WpZ~|)o%)VpD?Sx)6?u<_h*yq)+fUJg6G+)%e1-ISzi~pSzdep zrO;dAe zYL%>*VA=N3eBGl8g%90xo_C1euE+Ha~@|kN4275FH|SLVAV>$ z$ocS`MZt81Q9jJfu#ox6Bz{+Eqz&$)7z{kXyN zr|-uNW6#iQQqHQ6eGETud6?>NE&VIizgzO0QE{<7Ld=`$oJ;S zLMx>^w@M!$km1VY{@rAJk?+ldpUbYSu;7vT%=52snR}n;L#Nn))D!EAZEAHrCq^r; ze7lyxdt2+Dwz7*iqOFU+-fGf5^KtHiGl#Zr+<&7fIIP;_d+_1y>nr0nn{2pvYKOh~ z8`q}esz)z<*cNcD{+GS^zDJzz&TAZ9xn|D^y*>@G^N&{iEEM~k(eHC@&b>+3Z%ey0 z>F-)m#U@;}`TpO4MK^xD)a1&nl#MITZQmAluZLZ3|Gn$?^_OmC$yxBV=9c2CW81a+ zp2+;{i})Q@l)U*CKaaD@*)VUt8%IC4t=j(l--GG<%*v1PvjiV-@P8&)|2#3~^!jP7 zf7n{Hz*?OVf@{CW?0+j?#&tvcp(?v3-Wut{4vCi4H8dfokl&x4vdsFC$nM!LxVcvh~|PISHvKHR)IVnqDs~S|1+#wL)#4Tvs>4iuraQMWsCU#p`p5 zJrVC<`0_`1Yhzt@OU(pMyPvA|Kkfgx`xLj|bCYks=cdqp&rPxYo|{tpJvZg{du}T2 z_uN$5@42b9-*Z!MzvrgWe$P#_{hpgv`#m@9_IqwR+wZyQI#)27P2cEjuUWq~%DeyZ zF~NQB*I!6w)w@XFJHaqigx@|hfS-0zkM}- zW>ES6UH?z7cDfh2c5Qg&+P_(AW8=izcGmlyE!+_uy?FDpj{R!CFTDAzwLiLg^`_s) z-Kvh;$+V~CSUs%T5uH8%=r@9=i}y}P5OpKmI-lXN)Ed9%IQhi!LTl=*D7`JX9#@#}<6?dJS#J~ceP=U*S_ z%R7GMZA1NIy_$E|4~afj_TvmIXevE$YP=$QQef*Cak%{5bjYWw(b;SrLK79n9vpFT79If8rituq7+w?n<4W zKMvVV?--vmd=CF};{-?hj@&~M;`VFzyB`5 zYN4(BjG3FQeh2;t;IZA@lrwQfVs*uv4=;u7FXl|#&42ru%?a_cJ3H&6=5VcHR%f=o zUlWkE%*E|#>#ByiH|oUt>XTTlp8B@R*p)ABzE~7({p^U{I3ZL>tXzCT@u8z6-t!n0Geje`bt*&v} zlf`}u7yq~!wR(@ny6d|lqgJna{WGdRww@!`*d=DuDz%q~za?js-*LLR=%{0Tb<`Yx zv!&1b^32m8ERL~`Soz6ZJ2%rQcp|Of;SF zy>0e)zK6w|H5}Pz8byTcwW)v2dz&{Q;p@vb$2STSJ*b{rO?&#$Wg4j5kzH@B4Y(X?Oke_7|VH?g>sal}>)|Xn50LQq;lE68tA4 zCaF5qe$^9xr(NmBq?s$>;!wM8^{1+9w>#MWbxca)w&5+3bJbPjkm|QMa(UbPZy$F& zJNvdT`Ud;Ew&rUVYr7vY2-bwiOf%!`cWy4__;O9yUgbI~vvH$;v0C7+FOP0t`1l}L zy4~?!y;^eb7N&iNw>+_&P-SQK_)*Lu%`eJPLHyIS-#PDp>bN#_<90L2Bn6WVPwvlp zYq{l4<00b(lIyjMrg>O@JzKb0XU%f4+-;YoVg>3JZ@RgxJ@%EfP+|?w@#OYrdzc#E zJkC$a`)M&Vu_5{B@%qbdIjMV+d1_^j9bGS%yt#gl#F}^YJwmx>KmT=owC+9M9ih+1 z+IM>bs3L$GxUv4D+M|5 zIdUD%X8XeJtGzbdvHr-w zHlaREad$@A?iH{07(6}2a8FlwU%=DPy<03L4t?!;`&U{nWRa@CBCE~cOoci3oxD>eE~#_%9UnQj-+a^lZj!NJ%qO>ND{Od5ls9kan&xs^T~a%J`FTqTrMM=K zCwsX*P2BL7dB*%S=e{X%2j;3Z@1C(~K@7`-SqJQ`CFUF|XRzBQAeCsIljV zY0)VS9YGqNaR)ehdCuj{iTb#KCo%urb{1bAj$hxFOyyW|lXF>Ik!roFlJlhejE9~K zlO*_lI63_9>X*Lr>v*O{)z=gIcbxA&$$Zk-qoHg6Z*@=21Cy7_`nK^_GyjkIw(gXO zE4RzkyUepr@t)yzo^be4qJq~(*JY>fsO?h;SbDauFIQj!&uW{t%O7s^GTU?QF_Vx9 zoKuyTxsO@cF?5=aYYwC2gN_$g^~YL$E*$7mxk@)itemR-d6Sv;hetd0?_?EMeEk@j$F-W*@XV|$Q{#jWncK@bbnbr}_m}ry z(EX@mG3VKqnye~%@zVRutar=!rF+6f-ydn0-+w$H{N)-oo2az=ZWBE?c4_`>ojYe; z{RPe11hv4K<$jBt+>VHB_J8g4H0pkoGV^T4YbPczbllByZT*SYyY_5y3(sy4lUOeq zJfY`FRC8{i!K0|gylI{%k8U{Q%YND{vS-=y4A$Fcr#xidyHe1vWA4tf^GVegY_3i& z{uDZG$MadOpC{x_)9Gzo@$L(^#*^yM)4|eh%uB24A0~FlpBJpkygkt&E4|ktVfAGD z73$RsH)ZeKZF;Yzx`$Oqd6EB*>C+euev~8yTP89c=Iium;BaTFn7wYQxWwLHFHW{HJ3gBkbT%%>gGM0QsD1O?~xT$^;Z-|Lv=TX{21h8mmY4lHk_ zD?2UfH=ihpte6J4}mx>~6uhvSQr8gHLvt(vzo zQ>wC7^4HE;e)F%}>0jQsabDDxrL1lt1s(P7)#2*Z$LAJ5)^L-lm&|i$?n}|#?Wuoe zQl4=ot7VF!iRjV47giX~57`|3en)zD#_5J+ua_b!_qsG5xgV~dHsjaU2Cd|@Q|tGf z?`>Use)Xb#tfAq%lZ%@*FG)VGmYaTB`@_Pbm(0t~)P~mH{jpO*Vr{X1kj?EC)n*-i zlXLx(tR{wZ#g;_!ywa0@dtd*pUZX3sJZ^IBd7m4ZD&%c#+*+*5iqglewOQdwsS;uR! zRq6%dw-X-qdA9TI`Li>&#cICPss_;+^SdWDgd`eos7Rb5vc{3$<0kj>A2T|g>;K4o zn_R}o`$w+TZ_=`@nuayAWe&b&5~;T9(l(m*I^Uy~@5@B58-jJgu`e`Ie!6~X%##i_ z`QHDj@5WQtH9sXRjy>;L`fwA&Kd(nmJLf0-pKZp$ooJjK^!7|suvhQhq^3iYzy7+r zzgH$Nbm!{zpNtkLEl-=Gzg(bw{yHUvRWsy* z=Z0?LE>*1zt(YfXXmRKHtjTA$Za%-7^I0TMpNQbP*^4Z``51Igx;CToNeUa&l&#FU zf7shAPiWV#+`{^BWocgTzr%-=g@VI(Zu@3-&e6@QwHTbl#Ltu0IsWxTz&#s+Q^^o{ zP5w`b;;|J;yo%xuO-v?Vj5le<0^SoIezOn+OP|N8m%suK$wI4tiz zmQ>MEZE5RWy=Otwi#Mj`ZO$3DHGUqMk~5{gsKew!n(iSJvy`aiznxdkt4?e0;;ht} z8l1{CXR2Vwg5Dc_R_pU7>Su0SYjirY@#Up8bM?+H^A7f4I#@W_ ze3L#$pHYJM-v9PDE;%La`QVe){(Yz1u?rV;&1+_r910Wf4c~Sqzj;PVIM1{CJ%#1= zlgh1&$h;26kVa{GrQ@N+^PpS=vbv-*s-ZHrZA_^nK~ZS9Vjbb0F?wGEnzIyNuQ z9oSUfC9^m#Pu3?=B2_gsS9tcpY_^ic44uz~FKdV|jk{2BMsd1;Xw5~*EUq19v6tHAxAI~~?)jJhR!r+zy6yT=z4J%c9X)?8 zf8w46Q>IjWxfY|qt&=(BXw~Vbj^|z1I7TF%eJVjVTs|)(=uPzw0zq(-9{_28J`>PAa?XNDFY=3pZbm?stGebl0@j8rW zr|(%~CRHC4>3?eFrny?%j=WpuE_8dzmdBp|YR<7f@J-l$%y#7yR~APB27bPCKhLph z<;mrB&91Nd{QG-;-S@ToH9ueSs{Z`%-?1BaroB2=$sPLZ+2421+I>#ko`3KE=h;eo znC+!AKWz&5^W(;s_J3u`Th6UocdY5;D&g>&JyY$nck|bjS3Rk(s@QkGIJEfBMuBHB z^4m*ugm=AIb$9KFS;gnKzqR#aIxePk{n*DF{PTCcy0Yc?pR(kwXZO{w>EA9LD{?dW zYKi~Zjn8+>a|dscowo4!<8|xGW8!7=m!7u!cy^oZqa6RM-;U_M&olq9<=zrDyTssM zyQH3J8%cyk&Al61d-re#Q@(F~+5NKi?Kirgzdy9gz2@cRb=mT-9<#MGFv*sm{iyiG z!Sw5v|H}J4He0KwZ@zo|?aG^1zwAuCX20!j=H}d8Z+BWI&efRl=*NU*CtTzBbuJ!C ze7N$J-ybFc8m7mHpZN{jt?`6;Iq3cCWiP zcl$!lD|Vk_x#avaIZpFU-8Ms*E81}3gT=j5ZdTX-a+@PzCsif2Y~8Vy>Tb*UCvN6% zv`*sO@$U9SR_k?ESJ{`<@aoU8PEuZRFYMvf1G{UQ=eX1`JpFZD<+k11)z3PrFLF$* z%_;cHTOe1EvH9t#mrkD#tH*_9Tx1sXdcLXN_LFd$K*h?|py|(UKIW4Q)5zdC#CkH6 zEsf>bn_1Q?Z0e0QKQIb$tY2(!(E5SYj$00St1LpR_5QsTtJryK{%g@H=eO_oi6$u( zw4UKkU#MyNGdm;jPQ#zlQ_0-ZrLz|-kD0FKVVh?<^|syidv|8Tb7gAef!P+ zSL=@UPgh$PeD&k8miDs~qvai}iaI%tJYqC6*_@IQ^3gi>^MyAr>a7=Uk2z?Q7JqxI z30E2WqxTyR{j|6zRlpc`{rIzx&zBRccTU=QiFKU|ufwIg)r@!IJ}-Xu;fRw|oNxXr zQ^o~3o>LCK*36SrT2^-1RnYaFw|w~0Lq}P!y`Hr#TQ75c%(|YQ-p&U%>Unc|q!~_! z@;hx`Uv7EXJ7d1L@%&Hmx7IDI*FC=FoyVqCYm)6mZ!*_4oS5L{mU`Q`ZvVu{)2v6m zIYgJcM^$NDytj5yTQk?RPXQGiR@x=K$qh$-Oj-2gZsq@nmvwzuo-GdOzv>vN8U7)x zA^Ut1Qz%d9<#P>(?DzdvGqETYEfSlyyDHwdCFTv=$|*5kmlS2auk5rrASEUpVO77a z#+6k(>hQkSol3twc;8%R;pCIvXKz|O@kz6Z-Ta6(D|?pCVtKgr?)-8V$p?KRF}v;M zUwts~$gO++SlL5w#zW=%W*(1pC+<+&TD|lC(t=7x)9aiJd$kx!@MV z;eScrOm)rdhqp776DK}A%2?lA^Wq1ir{fO4`Xvf?J{B?QSRUP1_SHH3`seZtc{SIM zPw!pX*I?Jwq-e+@`uy)o%Mf)p5e4R?!~6cJHn{Ckp2_GRzQOChuyR&H(}|7f1+IppgX!T1rF1m+*b95A{C(it?Ijvy+ri{bZO~O|c4s^0~R*GHS z_j0AV!tI^u9J;z)*=t@p`YQb0=;PhX%5d`Xb~lqosX193U+NEUQn@+pDBqr(?wn(7I@|{Q(*!Cj^ompq-FY>*o)Ehmvwtu&YM`Sg{W z&5Rh|O~13*OtQXzHRG({n=x5Gy&B#X#h%b~_-~cUbHL+}({(+KkJg{|{Q3BIcKkgB z7mYlYEf;rwf5o=u@EwcF&9-}fK3x7Njh(-7(oUuuzb4L-%WFBc^m@RZ`!(O6-M?{D z`Ag283)2}H-n-t(o1Sbnm3xE!23dur>1|gkUmmSFqA7Z;uPbK7B=-6(oL)C#EZAMN zOG9cn4^6KOxy@++Q}``4E4u|M<+{>_p##=~l(c#kuYC zd>?jPOk201SA=2xmUboyMx}rc$~Weha=re!M~7`i`Sc{A*QbBXVQB74a`v8Q68iP) z;e~c=jE$lyNn3hy-AfpC{=aOfx9XBny>-%YU4Z@7e@B!UD(+0--q@a}c}MDnF5`w` zwY8ZC>QsD{7q92jI+6Et>KEo~&CgWtZd*Q=RYKLV%jp@j>bB0UR~`H;nfJaA$hR~T zniey)`r+~i-(PdomFkI4TI+E}tw`7O$M4gODevAS@SfVgAX7}1A>u)6<6K*v9_9Lz zy#3!U9&_?;u#E}0y+ntRarWt3MF-_J|BY%&kl;Bh&#fx7Wx@gH$1#Z+7n+YV_y2C* z^j}sdAfd3o##*)all{|`ol_m|o!n5^fA%lG+fL2rr;IF?Y`CDz%8)eCwq;v#V8ctn ziZ2$EIxL0n|8SgYU&uMtKgo~l+oYhvBjwX~Yu7YqvSXJ;<03Qp_oOV_#biGoxS-yVeu#J+kVXD*w-u&Es|c z)3`-v4!9nxo_GC7_5vG+n`QlSSv5uX+g9?+Z>~HqnsfQmach37(v4F&FJ;+ES-jm> z%Mr$BP|wL(m&FiNC;h@^M%jf2>~S)>7xI~I@u&p}uaJvb?zy_>ZiVuTtHI`S;VR+> z86PJ6&J{_}{O;v{qGQV!?TOPEE4d$^bb8*pX}xolb3D@x-}TD6+_SmO_+K4oy0w=n zt972s$|C9HQo*dVC!RVMc~6}FbOUP&7w>a7CMSj&!7TOhkze%;>(>{r{Ss=zESi6( zDXrKt_|Q7D53E+@PUo&Z3NrJS5ZbUtVxObxPxc656%&DDXTJaD5@3;vI(csMCI1Br z>KVCab+BAMBvInG@`zKV?$#Zh=bdAY_wG9E8r_{_Gtd0?g@g{aq$wUZ-b9z&pQOO4 zxI^UIhMnd~N~~v})-O3D!j_}Pv4_=E#M*x7as1i!YR8{1@9PCp zHQufMcY&vOw!puqD`HRGyry=Mah7KMouysc^Cf(r-h266Oju`%;f#i^&=qGySZ}XA zuxq2=5*3p&ppfncCRJbb0)94b}r@e^vG!O$|cvcgicpjyS{9VOmi=IYQwt7AeqZ0(dkpG zq>{KR%X;w%+`&9qTt|Ow(P62H?#uYA<-GF!!~b?-sQB7*bv?DaBwl?gbUfTAvf#(X zg88qP8Xn?YQ2wZ9&aeLC1*b%e`adei)#{i%JX^T;;=(ym`K%`{9&U=xKA>}9zWU>b zuQ%0u=mMrb@ua$sHtY+3}OjlI~zl5cvs2&u4npva7|MdZ$e16_t_r3c*a%j z^Hgrc2(qtl$ohZVp_HrKGyAx1@z%cBJe$xN&&}`oWS*M-CnY}XK5szPzBG>Kj=SRy zsDhlr63zR* zbiH}o@p4U!1b_eJC&pp3Ufi1`_c`QOS>L=}&)(H=b!g@Ca@6m&Ojy^j`*HfhS^m!U z=M&FKmI$vpF?YWD92>zS+O7q&xT<*d=ENR7%4qR0wj;w)lc6oduU@j|){mpVPv>tu zu;XdSl0P-?mY?LkVf%C527?yw!|p3&Dr!|d-2+2*ShcB4oN&L2&r*$PiC@F5p0_(I zJ)|V>xKC!8)Y(8=X_m6p7p*c_@bIB^OZoZEV;UE)Ux|EkvdMFCuFrQjl_gzo z&VPR?F>TA?@){3K!9bo{S+k5q0_H(futp;?k~T2y)|b1{2p#>BUCs(4o) zpXac1)x@j%SKsqXGe7Fx=PAPZR)?o&HSe*?qPJ&{oZlYk>T^gh$;zB{pV~GC8;dP7 ztS^2%d*D@o+{V2co9(TJ8_$= zImf--+~*~48GZ7qGbyf%sWO;4SKa19%7m&FEIJyDKC_zq7oRz!z*o@z@~eZ%vOi(| zA2j`cFYEjM(Q9UC-mLY#S8q>a6ioL@JUfxU!D4$EQ$l+;!?W){IoF%5aXeG1^Csoy z2OV$kpBw5gKQC@)vQ;eSx&1N3IjC#)GXEJ2ZqaJ&xsCu9CGz&6E3j=dUky zD^$PstaY%Jp8eP7;?FFxAH)jIR=GV;37u)&{Bi}S*sssBYX2vDb6Gvk;ixha zyq#>lZS8ZVUGlqqR4)lz@PvK#x}dqLCGyS7%=)x1o#vqz>Uj-+h34P-eRkn1=lI>r z>_cDd_j`J@k?D1Wq^Qz?5TA>O>NNP*hBV*iIISqK&ghL?;$p6wZz878Vz_2s9@ElO zA6NNfQs?}Jzx4qUfdW=S6NKjf3a*_|C7cl_bIW_>5uqObfHMjLbBxccXLZcP``BJX%Lu>I9vuRnx8s_BvHW8V7HDqOcj25X z!Ehx%&SF9P%*uC79EK*|+tzJgzKvT<@=AM3^S;h~p28}tW4Yy-=D#xBtXt~VwxOU$ z)@X-$uwv@TRQXz_WlMZ^&U}*n$*R8NoPr;(yzqpjeO7GU4;RW=AD7;??yFI}#O>|f z-;afKPv!ZL@O?9bySs~5L-c+X<)h{A7Ef33bYs`fyThF_#n{MA{BSUjsH*P0-U6|l zqpfql&W`k&+&f)>&A5`|N5tVC@0DS#jgt&?GuC+-h%toNEAuT--Y&o%9BJ|8No-tw zSJAV>bGi+=Ux>cUm^YPgmyUhBold*fQ=jLo+KwllEO?JoOICsTh{nBnj~<*~*;!w|ibb zzv!{(P4hJk8Q-mrmu_+kOMibWxI*2{klRmqN&VxJg{!}G2D$xJP@ZW% zXkT}uPk~*p{KDH=$)#S+!Aw;uT89<+O^lx@h`x?#(~cE1ogf-i!4tfUy>d(2u|KL( z(QTdHJ3H!SFV3u(dB&wN?H?=umVKvMH+sBc@m8N&(=gw{d#Bz9joT~V@ue7SvMW+B zIMsUIn5pKB8xOm3P1*g>k4MT4cDyi5F0CzeVa$$5OxS$TTHYtL;)YG}p`5y9?#GpF zBkbiOxc4t%{k&AWp17w)6AxHk3Yy9k zd#3qj`@2sCf45a0Sbu!c;cgx^fjiSB${TDChiD$H2#D?pOV*70k=^-nqm`lD4Cx#_ z!CXDVuVqQy2OmiFZOXmv{7E3g(0ud1s*_*&as)ixWxv?in8)e|M7PeCFNrwYKV`}; z!@IpLk--xW3;AePO4eJ>*?ooa({%lhld3zX`{=ESI>r{hr`zI@(TdNh8r$SpuJ4>^ ze5v;9r6b#>3qPLBtM9XB#@Uw>qFkBNj-+ULtP-8gv-ZgJ-mL$N0(m)>3cO;w;IQuK z>z=I6g|#oZdUibOzIEkks97mXNBoHuaf$nH-du7%d4GtFqd>`A8LwYisrA_j-YeIc z$ecAk#-`A>lKuPYltpvZo9%Bs(Cps-Wy+!o*86)>J|CZ_mSZgS_Z!#Z|5*|C>Zfg9 zr+7|JPg%78Q_tke#Kq^`j2}(9Z*U_???>*@#Epzs9?xC$zwl7ci;L-s^FK%WTz#BS z$bY=X=I=`P>+Qle9Se529Ls-s{ISDbj(X>f|0epUKekl#>(x1(u-^Y(Wa(t#1N`on zQY|v%Y}e(TSa>Mi=FATPp7~PA+zU57`=9kG?bDx{irG?A(#$QqUgcR_TX*J=VV|kQ zbdM$fDmGoY#=MeGCut+kl1npr1a(y2*gTP5VUexDv!k>2`v%LkzOv8dYffBx+2FKs zk_=}+y|LBnjb&d9cT6>w;duDx#oQk{4wmOD*hCEM4@_LZ_pGh=r;m2~5u3zSkFMV1 zTY5+I9^Vb6^VQZqj7%38BJ>h(M}FtZKYl@2ZsLVU|4-dE6z&#Ji4yGAICOgYkw@Kv ztX8*IZj@zTeyle0QCPzvfg=ldPyHV@d!NB3%R4Hv)yG`w^L88Td08)F_ISS9lK;<= ztu5bJeA^@SO8RoQkKpC*9U;Yu&(hxPD^-WFx zmovy;mfLZro@K$t=G@yC<$nf<@HDS7@VYzK!kjni&&TO=xQoMow5sqH2K9W`tmEwI zU8%R|_lM_>TC4f}|I{B(nSW@$z{wx?)jt^gDU{f|p?<~tU0ttlf6i1b^DEmnbyADm zjg2?W{gY?iUH|9B_k6=zU;cW@w3qgcZOlv?+dr<~|6WpC38zBbe&mA*wi|1JC&huTb%d#>s`jX`yQ|+}a?~S!jZvD(+ z= z@-}q|;R{#oOcM20$zJm9dVbu4z}{(U*QB{hA9@HmD82VdoBdercFpfc`uXuSKYe$u zytL}V(PwWHlS^lcRXsk%)b{D@?Z40FcN&%dull`Re5TFjo6r1~PA!|gc3b9D$+lk? z>U;P(zCShh(v4f;n{`@9PG!M-R;Akqe$UkuJhW6S?A9ui^(hA*-@PVsa(-Lm!s)+* zQ@i?g8(x35+m8^;_odOt=eu*)`4-hLkNtGw?fU!t zn%nEn=7b%TKN@@IrO7&@IX{@#J}JHYD<*z7M|-kZeZz&dO-t82UfOp0uGsWjy_?d0 zSA@@Eku!CR>+1b@Fj?8Z?5^a&V^!v#&Ma(CV_xikaY@d^XFItntXw`!S-w;|yrN6t z#L}sei=M0I+??9kr^lIa`Rtzq0(lz~W~SZzl~gwI`jgCQ>%+IWR@{E|s^MRV=rnK1 zvsR~rCMz>$TgjfS|7)HkT97fTR}b@6PkLDOsaj4#{*@tv`QN3M{C94b z|EYeLvg_gN4;9=+r#I}L?XC9irc~%DTc>1+eZL-_zfr;&>~P&~UQPe^b)lEO@|fD+ zI5^q%aJww$nhhKZiCdS=IdI_NEwiSi;H8z8cdzW`$lJVSiyDK@g@*O@Zv+e3wv|3$ zv=TRK`=t`R)?WTNdxF^1gHQi%b+)M$@Y_(~{Q7UzKK>&P>$qQ8Jv+b?f1l^htJ-Mc z)fP#jQqr?7Fa7!{Ve|LW+dLH$E5p>P?=zd^Ea3Ag>Rz$ezVvzGo7WflHI%s==W4Er z5$E~(b>GfYCi5iK`}=M8PjUMmXHoxik9>vQzB{(}&F*HeOlb{LcX7Wi{4Z5tS6;({ zrwj=Pe=?unP|~1T*~zv2$lL7VecuA(^4Zo?JwDHVHp6I5kWG=p zrz4HC>N_g`{9bMU-lo5#eMZiTl2v&whk1>)jWs7vuc&uT+N@Ks)px7r_2&so-bUT; ztuJ_gL{K!x?(2r+Xts@!X-(W2yS)UsX7BkH$hqv&q8Z^U#E7NlvnNj*cm2~u69~TX^Bn%3(uU1C)O7Ts^=&KT1*Modik`G*}lM8 zLNZ?KT*-Hp7qi}3DXf2RL9!uqQ?DTF21oNl|FyI0cXXX!eHUJp1WB+O*!rS^ za-w-_$?a?IrL6U<>;rBeIe&GF;Kp1n!S6Q|Zn;d@W@)0wVImN|uC9?Bq z25$~ab+Xs4sj86-oDENxi*ox_2yP*xeZs(mdLyv z)c!Z-m!F2mYMCSPTix#FD|~tI!}Wlz!0E3=iH;YG=NERm9QgD%ZTFk+MPime@ zZM6IKW9|VzqSrR>(#n05aipPsN64P<4{tqscuHoi8Pm$0*14>08QM>Sb}PHwEx*2F z?$VN|1E;w+aQbKb;5fCBF@bG4*Su4kTYNWZ&G25({f_UVni`*_(r-_E^dj{tCEpAGhwpD zk%jy0AZ}GM6SL1`A_HTPZ;}tTJxj!)0$uBpGa0b+U$Je#KU{> zvoEq=jacd$ddJGA+T5(iU)3;Q$v5Utrexb!<=1!-B6D<~jy1&Yby@<%)>E$(PyOj~7hcc3AAz+3Ig90$mvl(g|g` zj;H@#Q}|kc*}*n0(!jN>L7k?k^79TN-czUaxd{VHgy-kJV%+=qu z%@&SThyK~h|NqEK`|LfcgFQEV+s^Ox~6kcS{y* z^W3~C%2R8xn1jYj1DpBFS4DWQy1MSul>b2YwOwTrW4{e-|-CEE=7CKf*vYHYkbYwOD`c8$kY zd}jGP$=S+klM;vD(>&K(y#IV33LFf58m9F2nUt)Fn1lZNHM3ow6cuxAIVqE>=q$Ez zQ@+QSFY`9GIvRJ$gr@8cQ(@KWQw_V?QyF~l_LPJ;-}?7Uer#u4p3L>#?ygaQn!_EI z^lLpF8X?62aydVp9woiFA9L}3qwd6QrvgkK{-WaIbBW^Z`>YGSOOn)Ht~z_I z@k&(wf2#=xT<({CYU7XXuFGd-OP#U%N^R|@1P|VN7Iov*lm73rn^T$f;rPkk&KOIH zRmc3;_xH=loG_SQ&k&b2!JJQL<7IKhrp%zpQ(wn^4sGR7)8g3T`~PinNBBxp;q%ug ze*L^)y+E}&LV@58Iz@%Q%p``BJ@?tgZt?u=H+2V9@exXx=o!ZKm<>CY`eR*lj} zC5{%_SpDl`oS?)euQ~G>gQ~h=_k}-)GCR55E*I@y$Hrb%{l@i)$W-qat`GV@b;oQ< zXXk&but>XQW^8X$^D>V8ul?TC&YL~)?AweE**TlCql5pkl>Mw&=YKZu!9Bek+1+}Q z7wY?6^*huwUAPzD|NHaz`}(TG$$Rg|m)E@Y-&}uU+Jom@Y!`KpysN$Yop;hiQFp0& z*P^7!^PT;zWcEMhJoVAUz30H9V~>M*^7q*HyDcww&9qf0{4_`Rj?Y~$ z4a~t-()O2AD6wN6QPwL{KG*g1*|X?p_jKyHLY(BfovSLI zq&vl!Y%}0ERd+D8+Vgqe*V@aAR34oYJ-RV{&ZB0nGtzvEQ|dJvdh%5M7X)mnpHe<| zLsP>;u{ScVhnY99{{gE z`<^lLqC;c_ztOEZXAgu2#;90qno@5$A;ebf@`JAVX@~D@TzX@h2E$7Ab_ea9&s?@Y znN%!3NyXs9U;p*n@6OZ`Uf>>;^IPZs+Aq>aD~g1^sD+>2#4<(2a@X71a$CC(Ulf)v zarqm_U=yohw%++m)r>WclODM;ON9Gky>H&USN~+gLM$`|85sT-wo4w-Jjd_c zSpP+8lX9`pHM_b{75maa0ohlF+Dg=TKb|;P|KQ)g-{!4P5_^`qdNYR3*turY1C9m` z`PUC+pRO^CdDH&lmrU@&BNe8`B3~Yyk=eU2LGw}ZI=zFDf(s)>jXpoU^z6XLrDq#2 z_pUhwNnU@djbt{tCvHH2P zb>t`Gx3^XtU3YPl=g(hp{WhJi<{ogL`0$D8ffk)plT$wDccycS8Hz^E{^;;4IDAr* zOJ~v%`_^~LN3%2gtwKBx=J>B)zr11Jv={r=rOn`LH9GECs`_ac>*W8Ei9e65GTAxh z%aeuo)b+(qEKFHcpLB$Q<*qJ60m}yUV5TB4J6(l!%!%zc1_Gu44Cj z+IqS$V99F*Ps6?y>*cDSb)*_(scRQ`%}RLGd@1S1BANUX?L9^kpBfVaM^(MvLm${ZQ=P_$EpTrE~Loy6!x6TbdkWs$PuA%Y=X|SE zw?y}KUZ&JEA;roQ;RhuCKRdZnu2OTCki?9puaPU_Pkowt$NElU;{pxEIZvDvgkIfX zUE|jJe`4j00$V}08Qbr?cWItif5WGWXX>)O2R{FsbvivHjj^S0=N1PI<@AmN6GiVm zFDp;fVn4uqv!v41F?WvivtJvVGWp$ar>zU?(hP`yoL!RIGG$wEz~fA*MMoAX{r$OX z9cM~4|ChJFm+iK>qEqZEaC*Vdy2_fxzZ6>c1I-{_biR~A>?-N9GK`Z17ghO*CrYc(~_Q{{uscs*5E zl9^Dls5(|9agCgN{jMISTOS`d>xv2={;}q@cRkxf;qKm!zXzV!HqNcRvTmNt+aTR5 zZNgg_gI4G)b>dT0d#$AZH6_;LyXDps`?ei3T5kL{Q0d7m^Uk9>G1Gk7*vd{WXv=ia zi7~%t^DWEME|8UT`f7XOx(PcpJQB{yEuI?nL}z+p$%nUzyU*<6`eGWAV7Mb=#=56l zES6o~@o1At{n8YMeDPzCKOTN0{PpX!rCxVWM8D6D<9oL@@0TOnVoRNSN4%yUzZ_}) zbm59sKP7%>@7gzMQmRZ+6Yph}&Bd#Bb0^FGKPP&_aDK~0=Tg06xB&SsCUFKLvV_o}?EG;#jf>fKjnW<>@|P7;cmy=Bw0n?;$iJ5`+%uGg=b$g|>B z)7w1XroK~MJKCD_c^j9{@{pPH>cr2<+;w*A%-QSZX6^LT+J3~aQR%hZYm=3SPR_s4 z`Sh1Hm$KoG3BP6@=D+6hVpdMQ^vdc<2R0dTU&;FOOx5`GCFX?RN@0Cm(;k#De$z@Y z_m9m~igRRqS0)&J`9;Xi|Cc9e?w{(hHsC-~ZgGvk{*4?Hy~WCJ^iJ=dt+O@qr~KvF zr-H(tdN(OQXS+UEgUMQH$@W!SeoVYFYx&YIX2nk?uwB1U&vIA)rPho|>rIW0Pm8GU z>{=l2dHLXsikZfWibpn?sHu4`$&vLI*lA$MvT8vg|1{3&(=IMow%M`&ln!U0cw7u=ZK=T<3^ICmdb|9qGv|?Rzd(pm#x7;n57<4>uPs)_2h17WEDlIWKB8 z_r?o$_N*QE`eiy3WF4=n?v~=7Q!$}WKE|Z#QGHl+YmqO*yjN-YbCoA-&|u@9`=|8R zf}=XC^enkfC2u|Bn`iUYgS|z_Pfj9x=IpE=JET=#SM**?w~y;KkiB+KH$fw7#UXZ% zs!+S5RWANjEmmu~ugyA~`SVS})R3mVFGB9mn%ZMfXujS$a+;61da9v(d5F|@{`YZW zQxok!91*YoBYV2NJ+0{L+<9Kx=AAFdFcyEGW%#ZjC(yko@$`F(ODw`Mr&)N{r8c>D zY`v(r{pTOQFoO#ckEZ2*2<53wG)c<%?DLJ)tC5{^?&BwK0w0!pIc@A)$NJGoQ1@h$ zRn&W}XGh-MDi)ZNQzl#E{Odu$Q`=7U7Yz5`*{~L?q%B;zrheMr&|EQjHV5_z557Ol z{c5q-T<&1@p>+38m4fbzHaI<+9KULc;*_B;m`E;oBVZ~o5ttN-<%7rFE3VE=Wy zE9$x2!G2E{J&6AK%ZBB98{hVllD6ZGUrfVXThwnoi`~GU#B#mx%ohj2mTA_-S_0Lk zk895rd@yj!%1FxeaGt(Gw4*k=?{u5Ld_v#b7ZG!>{%7jUOkxC$k&0|@xMjA~htYJh zqmV}Z+vwQhTOMMy&%?jmzBP5@)%aJ_wgm;ZzLj`9<3_T_93M4)t}vl8gB=ZTj{Sc9 zJ*LsYNtfA3W#!r_k1xEMcIA297u)YXH{Xwdr!Fc#I~LJ{;}$v zalEnSjX4e*OdgeHY|wv^4ll6@3~IPp@alRPp=a!9YS6VA+67yo7$c`fB8K_m1FU1vE1_gdW&lP-GVg zQfkW;_+_fd(B>`0WOZ_(xnokx6@@<+cy2YSo)!8aaOp6M&Jz}QrcDYWlTtj|bPjOG z2^%p~H8Fo>Hp|gfN%YDKzY^rO@F=Hch_28JyOYaaaB?4HsbuG`cgo^)>d$OZ%ecg_ zJB&rzN+?SB&JpPkVu^|Fj&_Pp8Lk<#W>3B`YXO%;(2EI28t%6Eui&kesO;WS;`>iI zal@<+!aYm)eoP23%8YcHZPU12!@GEbS%^o_EEZjv@B<4DaI8J3&MA4bWlm(YlZk7h ztM7r`2IiUk|5_zErES=Z>nB|?TO#=~mQj(L`HSj~!wtVeE*-LETsUFQFP}?`><%fn zuClF<`)tMk-SG3eMdu68TFddNeM~S)sjpa#}BUun#(1ps>!bXu}xf-cmKxk zGO~3q+&^!aOTaId|1da;m+UR?@zKUuh6XiH>YxW!LAgRvkgBti`ks1KQpU< z&pP`Omw$eP`O>`tZOiYb{ED0{S#j#pnBVt~_P?L~Qr~}ln#QERbPPj>NLqBC*3f85$&)BRoVlD0GU39Uao zhrMZ$Rnu038Nav4*UAO2QDOV=>apHW`L+k47ym}y`TZxg%+vUygxvbdvz}Mpm%eU3 z|98egr?;Lp-`OTg?7Jx4&uC*P*};>XpRWH=RPV%!Ez`d3QLcY~ruwn#J@@smkH($< zefxDabN-9F#~0uGa80^0Ilo4}G&%oK?d|zq1-D)wUvOel#s&_?)YDb_K4pgP-}~ps z`W@D_+bY|4|5>h6A*!cek*cjzvEERsZg2W29T%Txv%gm7t~c&tyTC2?%Ff{Z4&Kdw zc3NhkY+x|H!49 zwR?@r+x%vABd!w_hnrDtQR9aofb-uK}GMlbM>#2)8Dr5?mt{7=KNW#{@$J0HZpUT#?(tU7PoJ4yBD0>wUS|% zagFVZhcjnH#?G;wY_#q5o8T+*!K;t{P@F!+by@7;-&;)2>g-+ImNMg8@RzOpKi2oJ z-#k5i?ip8g>n|C0Q`C&7wCYTfOiodoInl)8Y~z%3s$T3N&T>B5(K~zu*yJ~9hMm(p zSE6yD`-yw~@6GRwU)7ySIDS_6)k4Fc9e1bMCb~_j*!9=on9bRP%M}-Uu6ulb@5huc z2fn@9ez@Q8(W$2|#4N>p_D!EvGymEC{qK*LFA?_pv1jsZm%J8^7fo6}zb`ob;Bfob zkaMnKPifU`TmMU{FBZ}k(&kg)~9?vl4JJZ9D`A( zh*CsUtCrWA%iCI(Tdq1k>5ta=V?Y0J8Q!pKeVC(YxwTB4XZe=MqXj#o%gz=A*_GgV*_po za{GLh*s^L{vHRPYn-h9Jc30_zi<}dUGJMxo75OY6&+=W?!j?;6FVkbD9Em-y+r1-N z{aX6>$0tAh`*yjUcl+g!U%fm3mG{mIHE6q+`?c}={`7tK^1eE5%>Mf+`J`<4bor*=@1B0HJ+)M|du{XeH7CuY zSXSRqD?iaQ$}w`YiPEo1@Qol)I!o zoLqmQm9}lLpOW}VESf!kLm=<;l@~Te z=if9cFBP1-lI8i=l8wK%>dXk=!^mBEi!V}RTi{==NE=4wqkdVAE5kPxzndn1_FTL8XB2vG`7yU6)wQKA$s+E^b>D3!vg!pdN?zD- zTs~8zE#03~=AkQHC3^qiwPZK{oB9=-_B^%n4*I%ep^@uHGwZg6O>b^0FYNMZF5O>l z{O0m^qcx(w`;L?+%+F&fw-#xSc=AU0U50CH+0C^4o7)d;*#B)xz0Hpsv;VN!FYy0n zB***cU;J;0OxMNl#MQ3m^UQhjf9rhZg@-baY33KkN2qS8ImY}UY}(B`kEN%YsGG09 zHTT%&JGbI?ulp!l+PmK~cJjfG%L?nte(EfK7*uDvNMh#So8<@kTfSQg+SJ)Nb{^li z%IH?S(Dj@+w>Y!)()BSRS9g}yzpz=co42ZphgE|GcO8)2c=1dXw94gjm*J+Ld=D{=9>aW~Q)6-_^7)&ouO;^zZL^ z8RGWPIv^y1@|HXG z8L>a_T(!A-e)ZX~2%oi!uU-9_8p^+^?`p_Xlk0_hE33j}Ta!(1a;;ujT3C14X4Q-1 z*EY^rv+~LDvtf@zpQq{CU)%QL_{)_u)(X6sa7cZJ5g7QKi$dsx8udw_53SlHvYYIi_M$0o|W&F)Jo@H%vP?eVppZ6U7fs8 zd2M%-=6`pdFHiP(L|;k$sk`cBW|vo4QL4%A&A|)0$}UB%&7bY`X!1tyOOaWE%!h0P zf-cKjUy46hxc`cR;`d^uD{%v6|=i%>p9PW zaJH?^2d619{q3wzFa2=tNOt)H=Rg+!-^EuC?EbV>HmO{v@Y9?tt4}O`G5MS9WdEt( zx2eSJ=6%Y?dCug+a=z<{Utc^pbH6OZC%VMtPgsdd`mOEGA0C>8Pt=aSBUyIRHPdPH zzf%Qj)9gQ=ny~J3V82RMpNz3~ywQgEPo|1zOBbX%l!koT{&P{tx)hUOyZzkrPqKe_ zlC|@hcAQq|WTO~wyYReklTVr7ubmonWl7-czkAm!U;XL%bas917klO4pAMi_ym0$( zBlGs(Mi%YAjV#-L8(FpgHnML2ZDiB_+sL;4w~<}@ZzKEdzl|KGS~D40fSUT-cjY;Jvg|NL?vAN;u`f9dCsk6*9V-Ty1w;C$|>J?gis z&(HhsI^pwdrScz1|L@k{d%V9TrHwUDWoFcOkL#=A6u6yl-Fy`KbDrnPFCMwqZD(iQ zHqMbhaplV%<%%bUDq217F17@1DObO~-F!>Ieyf>0>z0`}pZxIZi?rh9`M!DWTf$#e zTKzGyl9hXJcTCPeboT52pSUNQe~VnTV%Y;`)2~ve;$AKJ9(+0H+|c)57&51 z&6)q*cW>Lm3060^TF5U>2r9aJh%MFNiA=#%v&g;mUth)_4!-&1-qIvz+xIrJV&?CY zJJ&Js>cz|HEk8fJUh}`YdCrBW83lZAI0GNup0Y1(%Kc zzPP=ceDSlnlFzijj3+z^4wnoHkfQ||5-clpIGUQ zPy4^uEw1Ot(|$Dbj9BEN`$}(bU7CDov2NG@fJ?I%uXy!;fAxO{|E1eJl<)6e(owFx z?No|K-7mc(YbSVTcAm_iSy%E^EVKU6ytnF4S4@AjN4KSR-U8K0J14jY@$7dM+`TR1 zdV}zsg_D$KSJ`ParwQzoJ1h3c%RF99|BNbY(`ny>Omp7sJyM@3y1&P~xop}qp}kIC z(H+9F1rK%wxBUu#{asTq;-ZsL?&Xu;ndZvhwS9W)?YwJO%4VzoTM={5(6gOI?un(~ zn@L6&i|nSaY1VK%?q6lB=ppA5EOvW(=wh*Z3{A-=IhRN(UC&&?xO}hBO=l%1;q$g1 z=O1(R&2F(`NaWh7=xowi@1P~duXWN#`i%`+&XMefl6wii_sHg(D6eB$a$v#ivcA3B zHpB#rm2BqYUOP?I`Gj`Mnj%f3@NZl)E4}koIJWd3U~hZ<Xk4mx@)^M z#V|LiOI_5wVzKp_RlqDimQ7g;R<8|Qe!0_G%4XXOQHB(QJ)G`B4!3*7qU$*~^(
|4gJDJ+crH&$J)nV>XnTc76pmYD&f^Z4>ztoQ|Z77H+WM5(*Y4^QJzi`byL zLQn84zv3OO!un-8iDjCc=`-_umI}>|f}KBGm?uP3X4(|@sHM;AmBg7jm1Ns?uAQpLpnbWL@mlV^ z6>NKYHXce1*I!ona`L?QdygcGs%J7L9G_MgXnd~ez~_H9-O-8aC3&7|W&+QWm)?&$ zzl|*{>eUr?KY`Z??}d!DHg$2-ls`6kBXmaRt;!)67S`8(S%T*5KE-Ahg3nZUTAkm@ z#-%)AlA@NDUH$58`L?sWr}SO<;ygw5%!yYKw@zEx2qn#J{?z*>z~!jcjR?CnZ@y-6 zl=oaZ7qalGOl_ov$4{L zZAe z))|d!RzI7(DMli#Ws2U8-nyrEX5_SOSaC40S?fVvKQlwT@yCgQIg20u>WWLxmT;^H z++PwR@Lix=;l?6wU6qAtt@W=XlXy-GXU{!wZ^ayy$2U!`$|!Wc^=k{wo#E}oQKZ8x zf5mm@f}T|MXuic4Z3nbs=CD3)=)SV_d-^G!%^Im|i+Z-OTzqG`yNGK|y+WIS zr1I{pS^YCOB#+HJkv?7N?SXdTchg;t7JDSksi=!{oD+XuuxpKi@=l*l{>qDwMAuKz zWGvKP8T3d+_uBP8(R)1KFIqdNIqa;G_|t@s`@D7;*qqgi)vcQ9?x6K>$;LCCj?;H3 zzup_O+y7+R{ipZ;F2BpHA^tjg_E$08qYsYOSHH|#E4!-sw6gUao4$sb=YmdgxP@+3 z@rcX`3TvMK@W#dd9K(f&6Mr80+L*+%X8Ob24cteUW;8WK|2&bm_ZhQ9>Dh~1Hd*sq zUhWC(bGP}uouR?v&_^+a51OZf)U>M)KYLv*m*;78TJA^I&4Bv`olCA1Uo0#>w0PRz z+=}`C{h8|j^$WLIS@zvcm|C|?#3EI4Yx=%okz-4@v^=@-_43V$+bowI+UTH?T{P$M zCl6uM(^|ietE~PZ({b6?v6!dNP}0cx#8-~`gG*;kEsR)mT2<2TYSsstj_F4t)^7JW z+EBb9=nAj=^rD_Kr{2mvGoGx@Bq|x)H{CGoVDlEO!pvu@3+naxS|7D^$!wU_oZZ}< zYx!jRn^_Xa^&%3=eV881n%kW6IYT@_eZsZId5+S(TlVw?v=+P0`HF!sFEQ=JUwT(nOwQWKP_-Y%xp%42Gy6ChQ{ zx@GfJ7fub~Y%$Gm&$H{r><*q(I(+QiO7ELa+22YgC|~(3;+o{=QpO{D_><1IrMo5< zIf|a9_f97i2)Qv7# zU6=Ld6ntEh!u)xXJDcBG2c{qY4m@1pF;ivv`K1qe?9!^A)xFRuu35r(wch*F)q`hL z&fPgJ!4)pTBU+~TmiN!B#ex=dHm&P9Z>{Mj_TA;|3?aVVuY&ehZ~v}od?u+~Qe50} zYopQAYEHk~k!A;)O3zxpI&f`HaEoVg&+4NlW|g@P3Asl~ms)&QZ{Cz0czoyNgJ#ns zMJz)+OxwBk?6_oO`o6`xQ$6Ls)9p$1Myh2ZcN+fjSQQ7ny0)c4f9+DAioT+yt~;it zi#<;5>7Aqdea=d;I`O?urt2Pu1$??c>EW~6t#dw4Gs&);z9DG(mXcy&#R*HMxajRW zzT5h(_Ub8-e~LsiJuTa_X1n~!`WGpt`}*k#BjxC{sm1#7tu`TMyYEELJiBeqnF&Ud z132n+yh0}Q={;Ze^VPH`g@vY#{zDbK1s6gjQ0C2EovtE&gUyX&zj1- zeAj8Uosya-H$>$NYMOjE3~G+m{vjKp$y{?d)4_5sD5@3-+9aLYD<&*lP{**q-X8W ztF;eKo8j6y^^{-*|Gf>tZPBKleir+-8tb?Sh@bXTc&oj0PNl1zPU`BrFGAado#&mN zp!@nB!@0B@5|4jYO?qmvzlxX3Jfr<*S@^{X)5^rEE>7Z%*)qL&X>4&5Z+Wj?{#q4} zwlkIDi4!;G^!%*%imkG}|5d?RdAshX%$9k}Ep`h{T)J!j?lYD9jV@RIhc|w*FYkP< z);eo(px*l#DHe|}o%z`5{P>90tiN;qICQ+zRbRSuis4L|wz<)o;vNSq7p?Go=Tdaz zTwdFe18*9pHU9Ooz3(F0+4yOit4xe?;ZG@Zi4WovOE_ig->`a~M zx>hFi*Yb59B?a*t_sW00?frhQO~OnYg}EETFFd-kvEqp(zxq6_OS>NJ7prK}^gJ7> zkh^iGTJPDVO2RgW=f_LE`uSdq(J-m^DFH*yD` z%`7tez!u20@6rKvyJ`A|EH(vRVDD&q>daudc%J^X3Wp~$CPC};t}l!i-7IVV_{4!| zx%SqnpRB@{ela{#-dpOGHAUiK^@1Y~mZD3KPFC1`#BO(wdv>$^_D{=&F4a%6nD?ym z^Ttd4-uW>rH+#kRJhEFTaJ_#2_4G^c@5}G0-uky+y}dua-XnW|Tip`p|AB|*%ShhQ zm-<}&`}Xsr*U#DgdK8>7HRt#2m+q&`?mJbl+IxPp$32b{M-!U(|NIN%U3bpjmu-1H zPx|AB&m%ut9elB0f8U&ETQWcXefZtrZ)yGa9|`jfYuA6N@|k;3{LYR7vpEbA39lN@ z>@{2~Z4)}zO7QNwc_IF*@4j*^jo7=UZ`Jjy3#`_jTb1~Ar`3ABRo(gK;)hpfh4ijI z{c6>&b$P2iP1mMf&HcL7w`~KbBwrc-{k_$vQ$D<2nIK$$yl;QNWB)gG^SGA1TXN{l z{p-0Ym(=P{$mH&?sQ)u*;!A-zabqK`o$ZM$xym~H?t z=Q}T0zYo2;P)+Bb+L6!q4=LWe%pG)l+ANL#afhy#vd_)+Ok2Dw^vL6jKQ~Qt5Wd&$ zYrlWXF0ska-~0ZrJX){X_|E^c`MW3APd>;gv62YhJL{g%^|ZyWS8u-fCC%o?wu~9P z`?r;bn#`W?`{}*U+pXn0?zGoe$38K$;x5a5T+VX)POvunUC&RllO85dyXTgrxPHkB zwu-n31^-t6YGx_1+3}~uY=vIF;)?AGcXLc6=J(pw=ebN}DYcmq=itJAdX`S!k_+*9 z`zva`%<6n{?NUchSXhdgtw3kcUC%|`W?IskPrsj^_jZnqk=E;}n}Q@o|HK|ST)#jl zR$VJSr@`&W#Y6A5T)ge!`@YtqqWq8cV)1L<#m)1$_}k{aa^cUanlJL%d)toQSAXYB z6m#4s!niN4x%!qz@jH9_%AMbv3g3TPFI64Q{yjkbX5Dj@$0GG?i;Ch3L!MSVJABiv zLiz62;!l50?mO}6vEI|AG0Nvo{qG6Y3s9S1zxJ}8{plZm3yN>8$X!y%ch9zN*JkAv zYwef!25q}#BNDgncDP;s<4qG!{rvGQKlC(b%EPA*N}Lu<-+TU;zgCTkhR}p{fg0wIZ)^TsUVks{ zd|UebV>Y`gCvyH#yXt8w89R5gcD1EYj+o!uJNX$qxBXXp{w?}z{d`gO>sO>#z7%(F z|6Oemcw9Dc;=1RJEtLX4JC_C5`LzlcyWFnGUDg|K|GV@*M@8$q7jYjh{c`-kb@%zB z27}X=jtjA?=s!rFVB+h&Z=2vf5BL1{?{fFIzpjz7mPxla-~RQm!W(PBx~9W6v)wB@ z-bm~rFwJr){A#ec+^q|z*FGUyizY_Bv z80{6v&OhGlDgC-v=jiR{>-)>@8(u4SNjv%Qb-m>2>Gu4MTYp|;E;h5Um-m~-e_+yy z!?zy^=I+Xwrg-nBZ5I=caA-ozy$! z^=W?f-@pB5sJyHesoYT#^EdYLu2~t!Y!68rEtPQ-ar?5x!>~RsoALUM{YGo|WNq8G zc9zcGiDh@I>wi5vd%QN_>k{KE9wKe%CM;VhYfT5+nAX)zv}2|znq!A&YnHQ{%O>U-ZO_k?rv6p-#61= z_R@Rf*&n{Y)%<5N`(1$+fAP6>h0DV?mwD@zI?uGUz18w!gT$8l$+!KD>s*y{AAU@* zdh-8K%F|O@T+RR4v;MRXtTdbDlYYY@=*!+$M-%=%tGc@T;>|Znr~XfWbnLZ$e2U(B z`RUiUuZxMh-u<-sZq3i7+((vPP2Ri5O6O@!X}He2E6=+1V}I!CuM78BzdPW2;peN< z^AAp&zFqtD@uJF{w7!~KH9w#FM=yN(G@SK(Ns@eB!q0EDr$4>=Se=wFe)_ijfx4G{ zDVaY**6YP@?|9Gs=s&|Z?{bOLr`LPTGmBmQTYkdtrO_=b6f{CoBNTix%Tg6U>NFLy3ld8*ic=F6%2JDpGxPHl%=C=)45!z( zIm~5MkBtBQX1Zd#gLM75W|Ls4DNY++b9Oo~Djjy1aZ`gSF-py}fJ;Jy|-0X{yfwie!N1sa&mt4{~v-o=j^Z0V!Lb` zzx_wggyemTc=x=mxnS+`-#}8gYvsaz+w}7swr!KsUWEK>_b#*iv+u;_FBcEBwx8|4 z87RE2RQbb;qB5hG_GzuD-u%0lTCS_-H@VIcQ*z?xS%tknt+p3DZQL$${3v6L>4Qbi zr`rFnk%-*ko_AxC^t@9$F328of)&2u_pKkyx&XYb?A?EamD?`LGi z;xi}sH0Mu0X>(rowz7rD^Bao-lTzBf|CN|)vKb%$wlrq${wFtfWXL`-^I?0u?`qY| zUqSVL(M^w^JPCarknHx^=yX#1_alDMP06o9J_zYAU%vhFOQp?UE=kvT7rl9~>hiJ& z)*?GU=181B#`m5(ZjQbQ`^@h#+ZR_e$%%Xp5Pe&y$W_37{4?vKCP`8S!Z&gw`ro%HS^kG;ue`MI0=&-_f2H!nS%bzU?5 zcUVo@ZLW&^GjkW#+Fs4mJb!J+t7tcHFFmlJY76x+O1o=4jge2Z)sf@5a=9}kSgyn z?=g5?nYxy_%f7lV{`;KYvG&z1QoCUyTfH4y?rkGD!Sj=r2fyZsm`At zG5bb(X9=#4Ui)>PvT=-w-xdd1&q-CEG$MVkDO7&l6PD>v^lnwqER#k1()_*$I+cX_ zJ~6!H6O9}g`QAJaUa*zBupYN=>5X6}2y6Sm0@9h&+m;B5o^gb!v#JSRVyGg$B zONUo)m&BL+YwIhWr2B+((^MPJZ4>qCmvrx)^im1+hiq4$AapJ>17ND=U$)6r?lgD>m@~&|9=*iNE{4WVAA#A-f1s) zfj__N7haNR`faZ%>$>628k4>U2S0lWbNsVjUBYwl@Kkf-&I`I)g~qDO1l*)d=ct{Z zB-yg@vXz;4h_Nm6yU=cdce>h&uQuQBjs4|)+3cy?mZC#%lkVt+ISO$Y*JsA59{N|d zRI6q2E~eFP7Pp@URD85<|L|n`yvx&V(zkwI!}c)!pKN{0^mZHjIhPIh@h3m+ooXI- zFQPK}X)bT3!X1li9ucY8ZaWN~U5I`5J)> z72Dbr*Na7w$@&t8pOea`@G0G2ck7noliy!VL$@71aej?Sj>yko z^{IUd|9_sEUdr?H_hT>jz!%lwnKG^07rc*>^<4Df*e3n!Gk3qMZxH90G@ZTAL4nK6 N$bd^#)z#mP3ji1oo2vi- delta 71721 zcmZ2Jw~1-voF=9TDvYMnC#aii*4IXPPQUFoY2WMc4_ElV&f{vXoq2hR_ok@Jxi=qc z+3%N(WEVK0RLsLvh>cJaacETV~ya+gw3~EX7lGW>DE`&e9pIT zJF4dM$KvFovyU&U@i^O`{p35ZwQfS|?Bi*lZ|;7-I?-gieA}tAWjlBFe!fz@p?$VR z{g-FkX64-HTw6cs)7|CPE6*%`TNd>9`CWhezn=;|KmBN*dh&w)d+J?h|I`-IzxHpHu;@I=yu8ac^bWsJKgpguSn|KSz>!OaT4t=eQ&nG7NVo2szf{ps;bXJSUw5=;?(j@rKkHj* zbyiQ`{|jM{*VVgCufOwqg2(j-m)YmOS$J$lT~=qS)uZk8Ck!9WShwy>@w13IQ|p4n zN**X_#LNAdv~_!+)bGNHL8{+B2mJo`-Ph52b3$%NRr%*UIrUwKP5Acke@;30)V@h$ zpXa9zy@UnEmyfpJ+rQ+0zr@}C(97!$Eqa9PJ6H1jIpX=ndGGt52`UPn^${HXhwgj~ zlhQF=ai{mtu6?ih)e9Q8Z7rDjt!UT0C$-7D-=0w}tA1POdO5FNf2q*_AMe&)Iq>#H z)9n(o<8QS;o^iJ4T)*V=M3c!g0#)w)wfVF2RNJC2mkstmJN)-9^GoNM)&C9DL%810 z*HMnX*M7>|e$Eo%)v{kJU(8oq_$S0yxL$U-YrK31~War(3Wk^OwTJ%#O0$H#m+o;T->iT{xqDpT(+K4KAd-l-vF zcje2w?>ie8f7^4I?WfkNV={iz4=)t7xm2=7@|f?2IpVd46*x{a#CJ6;UzhUce#QFj zE9ED=tlxd>bvf7kwp~dc!ZVsx1ye4bew@v^|4q2;w&vV2x8J(CfB!hQcs*%-Uth1i zB=ljExyR(}m$$yRcWqJf6@I^0|LOVS+b7;=ADSj!=W(p&Z^x0E@>4c_ZaLe0DE;fA7(qm#mI$wtwb%pMUYL{+`#_jZ=O8v-)@4={LGj z`KWY>-^06W+I^S{(>#N!QYNY^nl4l0oKmIhSMhv~K~lSPE59)A?_SKsVP(c$i{V1#=jm_zvHvLarCf< z_LA+grLsA43J=y^&{m8$_ES;1aQ5^)_s`dTe&ysHSLRg|kH2l-WYB2ww0@_-76F6C zZALoFXRdy1!k<=BqWr|Rue|Bi%|J))dihm-Q^Ib)n%;SC4zuGQ-cUZ#_&1(WOMVvn zzMe2AE-&_Hoy;%g_#KK{rPR9b9!XT#W~E`Pu;JPrFXsY*&{=i&gi4RhlUnR@t3!Wl z>*Px{#~K&>&$u94xAm{hHucyQkEPP;-M6ndPx-HPJIrMNq|yf#7o$RNm#4jzQLgbi zk}aB|%(FV^MecLY9b4AVINN&t>!se6(U!Xc#q=vKo)l+`$ov+*J*1-O>feb1Zxlov zLXwmghUCfpx_0GV_B+$%>#R7;7KFXsawgvT%wstt&S)35yVrDYYp?hm!5{YBhRgSx zvu(ZgXB|;X76m@<#>0DG=m<4so}4+)ZE?53s-xeNU4t%dS|AkpG)bYoYDI?Kq=H@d zjTR{Lh5G)En!Z9i!^g&}P|+rG3`9Ri9FOE|nGqYgX7(X2VCGxBk7bP)K$$Tbb1ARpfqoQ?c@+&8@b_S)NHJ&J6F{{K2v_ zgFjYx#YBT`5zZ5C&QjU9X>;znHJel{?eeHC;$;UTy`bb=73S~5D(A)0%rM1)~ z*!q{$YZdW%HeG)jF1X12QatL=q~?)yXu_fi{qyDO_jV?~e_p=-u6;d|dflIy&wg$Z zVqYqx6=?G${o_>r-m8mM0~Gs8cKlPh|Kn7k<(CG|A1+FsqC!oHhrT|$r((Np+x}4F z>+?=LXI_15$-k>F?o`ZVG!8bI_-qrap=#ouA1;}JYoDu1Exzyi$%$d9-$HTI9QAu% zIqpJkamO2HH9p$Sy+4L;m)Ev1zWS-tmEw+ae{|wM$adv%XT+jK2QRToeP&auE}WAQ zc%bf`;hlAB_pi3HmTS;6+O_5W_i1y*8r#x01ir2>;}cuh>h?}*(J=>2?%n4aFSRPi zN8buC$$a8vR9IcJv0#c=QSYnD%qW-O)ZZvd#<-!uu{yr ze$#xO;CW$QRaZw5?H^;dB6Yq6Pe_f_hg zV$W8;wk{2|&=U$5l1#%&?_M!|n0@zr%Jfp68HZGVCtiur2@h{wy7;$#lhd18CyD*< z5})kXZDTj-+$1FWCuDQX0*!!zV{5(Xc4zzd-~4u+_Q{{fa;&VYYx{&v zldpU)+n&FcZv!8L_MTd!^IY}wm!ydHd2s!2TDHPb;q|_{D&H)@>6=0x#hOb!eP_aA8m3M^wv6+rOlS@Hbp~)EBbIx z&8#gP4)5-D)kmikaLh^yxITSKh_(G@md|^1{9pXutMz31ssjz_LM|5%q#sMOh*tWw zL;e4m8A}#u8HkkU&VBeOpfyWg^pL|ej$=B-tE=B!FAL~=(&Ju~Xk@yHE&5Q&9Pa|A zvzJ1*uDx<2`>9omM*x%o_w-i$xZ4+oA^9!Kh16D zGnSdCCDTC*NH ztmrdem{jT1wOGjgC2MT$*~^`0mK3z7w{6^X#_h$NMxF<`Qqv1$SaOx5d6Tbv*mt3Q zYM=I^{2lvdH5;lHS)TJ>J*ocqi8FdZ(*(a|pK%GCawW1X@S%c6^OMt!jHOGPr!cW_ zv9nA&X|O+2S~5G_bmE3X6GKCV7ic;v9-F_yLyl>ZEL-IpTc!I}A-z*?GfnepPz{bS za8s3NS?%;v@1b>M`nt&pdKZ(tDiXJ_?_++>?J(Pi_m-T__9y8ZZJDIImuy~M@8%xZ z`p|#hX}2oJ>6Mehw-vTEa^4kKZFu&&*W{zR9Mf-mG@bY@Q_C3V!S#M`^Cq8qLt(@9 zX6s|kV%d639+)1tkFn%>(U-(zIfp5!=zig!XClldvlLyu5;`v?9dy_3mTj*y+O}J? z)>C7F8h`T5Cbh_w4^1a#O2?l6%E47$SO1E^(KxsxFxz;Y*N2EgmdOf6F)b5>_hmjX zFjt(doI7*n6@|q&wr}25bk?}Bu5Z#&eZkH*4_~cv2sp8p>0zb<*P7#f(;J;^`I}fR zCC*NamM%-XAULVw)M?`#F+%cy4Y3nM)ZL)=%3+`cOE ztp8T*r4Vm>zoriiEdS0u>iU-a@#)J?e;?1@f3GEk*X&`v+SxyAddySbv5QQ&+HO97 zKg;YkyNhXmcj%a%zw>cJ=fiEc&K{oqf715ztJT+R`OvI!=ZU81$P^WIB-ro$ zv!9?m^IKi$@6YqYkMFJjwl2`=kAISt-vjYotjtTC%H#{ed*WhT&V*^{74lfBA5iC# z-p}3N{evet<-v1_ZF;)O-`Vy^ozxLdQ9S+RFZ)!dqNC~Rc3$lJ3bjP-*^(F?6{C+X zQk&7saXpfoDo_qYYl8}43-~r#;o`bbK&AxsC zO?f7&-&pVJZRDBNyHM9KUD((8c)ifp&ks*df3)$v!u;d+&W8G~mk@tsxbWL={-8Lu z$BQ+-Oq>bY1gFm{Wneu7e*HSm3h9QC3Vhm zX}(!f6InK1Fx8zuKk;$O&Q-!4Vk&yi{ghv{XrJD9#C-JMQ_bXiC$h zo`)-XUbs0{E->EY@>DeBo9q{T<=VHGlNT#Re(d-=tN7Z2Vx_~WrvfY$<_mpV_Ttt} z#dT{eL)M5CzF21-Q}B&b=JiisxwO{Ho4$OltoH{WmCmXL=|^8o;kPb+T`vD&XeAM zD&O~{v|`c)TZW?05_x{l)2mN>df~FvsIl#g{+5Qo$o%LV8@gpaa0evUE=l>sS{3x= zMwg36fQ-9b`onsWrT4tVr)mCDSy_ATu8lr}?X(7#rROAHYTvk}_Kl@+|Ht`8LbZhl z?$`Wy&$%WiBurOYKOpSV`V&mANE7Wr^$dBA3)*bq_r9HDEP`&8P&4^8H zIVn!*3{I(hrB;2H!hZHnPb_L!=q_{d9VyAu?Now{}HE>ADr-6wV> zKHFi6`t$91K8hN19z}kdF=v_QM|I&=jmeyxAr)sPfK=%nw$4uh@MRk9MAB z{&H#7ugAH{Hv{;-U)uarC&8}%qu8{#PN`pKWVnu49J$CB{=W3OWl3fJ%9wk$ard5D zOnw!#q(b%y&xALhi~_xiHlDCB_4N6A=*=t7>D$+b{rZ0UBG03A&xIDtW4VrXevR#G zDP~&IWc$E(uZ##SSrh!m?1Rd~(j)S_I_B@+AtB$%#3e5ux#YvcfW5yI6xdk* z|D5&1-pKk}*yI%9{ij_P-T&&XTW(xcDAl4ev1Oml>w7m!=dSO&D#qV1Enlg7;)+W% zy8pjAQU90mvdP-+U9a9*yf)vu^wN3Tuj_QS)&KElDXWu-|Cg)sS?a=-PlZv{6E>~p zxEG_+RQ3JOh4(tuqUZVojvv)rv+!2sl;`_&|0!>oETe7D-8A)_z2_^>qo=3)oP2+x zQu3wG$8|P_ZnL&<>^*-{yms50uimPzf4yWJ>l!W`-m&C9W81IIAEow1{j+yiRIlxG z$6kDr(|d0I9R09=?+b5ocXTVQsJt5%P+|f_r{0p-#otUS%Q%392gbANj1s@*`WZ$uQ2gicc zGxO)CPvLlD)U)q|+#h+DOaBi}S4=V&nJ6H_WM(#fqPn@pCic-OAH?^(r9!&mBG@*ldNKEu1@ zyW#uOSHB+eXIh^7LE7r?1oPE<>hop?eW=|nx9;zi%0v72Xs2Fr{xbi`YwxDZCn|4+ zv081vwDoNDPa|{TH>X(38jsrMOS*OH{M&N2{k5w=yI<_vRSUDsE@}NQ*}Fhz3;*v! z?{~<5%D-OsXv(E!v03i%WlW-P^V)lRc+ZA?+h%GWd%9h6+v(S?FIdklPmC_RQ82-> zezzEVQCR9)j#*L;uiorje7C>!p6B(uvt1M0UT4^u^Xjb=pLhA)n)G}9&UPWWldo@i zdZqYVsok2}dDn$?n|oH+O9ip5Ja7Ey``>(rx?Q^uo`0?1RO7M#luW2{N0Z*=ZE3rg zE#9@yS)KKPWqe-!?w_Fr{5QiHXUutVC2(JH`RCj9rBW8(x69`*ZT}XTA%8a@;+po{ z!^NGVIoyxq_FVZ{QT*L)0sHyGj(d-M{Ih;XAwdH5O zT&nuO^gA@nH?Uv3a#5n%7lscZ7qctHDpDeuG=6;g`S_Cfj}I%B{C!a0s?YjK$)Mng z(fgY>+~=nWJYb3lV_9h2u&6n~TQOYO)?)JW90!|e93~6&W}n?4y5qR&7o#r+yW_d8 zd3W${v^bJ+K)Swt=FTQbdb<}*D3t=z+p0L)cUi#m>R!6Z#|Fk~SvtQk}(|>W_V87q` zr`|JZe%{XP<7dM@Ea*;6yptLeQkAf%{k?T{?Uc~QJ$bxs*=htsv zH@kdM>#D{pA8t&&;3s(3>u0it^hBnK&o3RUV(hA^pKl+wH6!*I&-F7549C;><2LGT z3F>kxXyKf=|JGEdleIz#^9&Ly50&I=uH5^3E#F#2!4I!0P88cuvA!Lp<)n0jQ@KQZ z$ES%iw@h)fpU{yk>DDZ_abx<+8GFr2&PG@ky(qZ9y6g?F^JLv*+bq@gCHnG(lINMa zx2Y~z|L<&o+N*jg2}{n$Den)6RVuH@e4gPT&wrWe?UySTr{A_*ee*-Kvfz(@pWi=M zx-h@{fJH~=Mi(x}EsJtL=yKoPv$85IT022`8DG`)+*t12-}eV>_fGo1ZK7hlm)Vpb zZ(}AkZ2x2RqW;Y)7EQ+E=aR!8`nsLJwDi#0;EASUOCQYKBe7qLeNw&t-UP=)g{|dv z`?noGFh}Bi$~yhGGk0=K;}MeabYa|;KQrbsXM#I(D8$WrO z-q?J~O!z?0rCg@OI)DFJ^HxaDsJETCdDX9ltL5Bn)5KOE^grNb;%z8*`B3q+1fBVk zJdc;%K2Wp0J|b3Nv18B%kN68+!h%7m0u0Zj7{a#*Y45OoqG|ls@8}Fm-QGvxKKpsO zovszmxSn;W_QY&n&WULUyIxi1ZxfiPdM9*t7OTP4-+^0y=~$%xDY|^{&udo8;u8k- zM|Yi3JhIj)Gd=HOjNu=RpoRSws+=XFp^h>V?cEKFBzEtqXe(#9-QaSf@yeC|?PoRx zCT|meb7~#qmq@n87v~fVYJ504stqlf{Y6u68it#?R{lBb_?EGIdXf#-uG!q&$;aQY zo|9YW|Llc)#pW{)QrC;$=57;6*5wVCNqd^kRv)62UtB5n_6Fy?Zxw+|`W>e`H~3U; z+W6w^A-&RrZ<`dmRmFMaLyvJV-A?wMyJ5e_jKfE7i{&g_&>?%{p+a-Eww8`!bBaKZ zk-hYlD{G!qPVN2Z?Q(o3-`;x*Z%w$mn@PQ5;pdf_sXqI*TOTM5l{nvH$3FWjlbG(^ ztm_+$*;)hZ9bf<6;x~8mPo*cZPq{Z%eH6K7q%i$iavV=;_||Ww+kY;r(VX+s#c9=) z!>ifYE_A(Nn(;pUHcQf^wv_U#?Awk7{8ZeTXa2BERQu@(%@ZoAX>QKTG>#-M{`T+t z^*FZbE5d&{?l{g2c--$fdx2@EZqx6JdHHWX^@VP#@SkdB_b0Xfc5QO&|5vdBaZ8t! z3hG3~yS_8}vPWC0z2nl7hL^viZ_RqHDDmNSwBYjj>p1`VC%S%`{N8SFP2 zS+(v7!!&bFKcSRUy)AD}depyWO{te`uz7z(w7zey_pd`gUQSzC!Zekw?544$it1^N zuqPV>9|TB!c(Hu4qetV9+mrN7TBgRA`j_nOuGzYZZ}-9NGD}~+4clwLQn_&T#KsA| zM-EhMU^pdT@a5=4exBo#m!;0PHF})jY|bmZNUCR{PTabypRUcgTX*~07XkJ>xB7|= zKfcY@+SVrS`R8y&kc-Z}eVvQX+-(dl$-S??MBnxPvqd+>QXee-i{U+u zG6y!q%zCivQ+)DCDYgnjvDlj;0?~Hw52YPmvuj%4j|frrMJh>oY@REQdnxtpDmtJq z>MS`|$ahtCCa2k@tr@p?Pd_G4ZWi!GzF zerCQ?{*qT8zX)1vU8BLj;Pur%UTUAcb$6tw#XdMa=}yY`4y$)a(8jZ?4=NwV3bznYZe~jQlU8J9*hi6!NCpZ7%biY|17ar=b|5z{ob?KV>lJj1e&QUyNlla(- zSMjaWrpfQFdd61d9GdgYbX9V@e#aHz&Yn+74NLblO#PSjV3UrP--0zI4@5FQ9i8)~ zSEWxtN2UC^x)HzG6K{)aH}AaVX10ilSd#eM#$bIH!#59KJ}!<;v8oYTfv;}XKX5QB zdU^MEhj-Wa$ucvyWUT&c?9p?0hp7AfIkyu8N_WU~SeKnOdM>x!$*6nn=SscLU%tQn z%iYiL{nT!y_zcP24?}(S>uEku`u-?he_G_UrFQ)@8t?_T2KX%W6OJ|1yr{ zHh!LDrkS3wHzUn?c3_~C?qi4I4e#^rJFC|pS^0RQqHoFHB~q`eL+w1p-TRV1elq4r zHPG^z5z)NxMax}vfsE<0n!!hBomSe`J2lqu({bqwUzL5UK68JGurfb(!N&L)OKskB zM(w2e4W8L&rhiT2xuw*n@GaTJ?Mn=&?wOzq_P6xEMIM{w99UeeA3T+b)$Y91*|521 zY&qsVu3z6^`Oxy5VV~6P^{dm^9`?hQJa$UE1g~D_P^-Tw+y9YguczMAlagWa?pTn&}lRHea7#3(x%$Rq_@sL81CZpCC zm+c}#b3Q-5k~Y&^z4%;3J!Aj1yku_Ay&*Zy8Rqv}&h0s(A)s$N>2!v-1ph-9*+~+z z$?|#pGG6PhtCx4!dVK0XeJj+^pd~bIwZ@MANyYBP6l!bfp6skHF`0Dcp zFn)h7|0!;HS?hXNPMaq^dST%|TaF0UOG@vRlAGtf=X7~<#jk^=U37Q|n6){!r9#=BdKU%6z-|^Y%=YP+~vy z<3#;c(K9#yI)C{py+7#-+UDW^4@j^2K}$V%))y@zPKTJ`JVq`G~QGmowlO&2oW zvm*QOmzWIZOim4NPS!nDYd7k2-E=G8Krc;&Q~Of_`#zo7FpWX&@$&QP(q=Zi zk#T;v=ShmpaTb~^+xvLNrUy56^zbhHc(m^RR+Y-gdgj8cdp=H2o%WtOvut1LX<*h37BGb=zdRz(BwTs?P~A(9yrN~nn>{Bkx71~r zJm3E3odbvVbncNT+bQ;7#=KP%=XF-t#1uInC@wJw|0-#9EoO3xT>cc5zxP5SE1c$47=4MDdF)F@M4fkO$eUSGeCH#-wnTI3u)1t4uSlGp z{7PfBWq*8ou%{&B@>8{^5{X<^B|h-FI{v$_jBHLvy=ysrCUXqQYTKdf0+0uq-&w%cbzSgq9?c~`0W$46#tj{-&LF0 zB+>3_8M}LBM%KBC?N_8&zF8G~s+n;n%*nfPhnP-7Z+V&H($Mti#3rd&PKPZ)VzHWKkcs{;cws$K1PisyY~2;^zqa3*$+=XhWn++4;-w%C38_qJmMDj=y!+R^BJF=vJv)|h zgE2DUhe5Pnd1}GDtAbb7oO3xG*AsjC{rBukxvwh2w=OkNK9Lk^5w|30=FZI;4>hhAJzz1g|)y{~q{gtmMb#1R6^n(m76pTz@Y;y%8QyAM!!N?58HdQb(hp~+mj4WVmLj@yC z7~4R>*Z|75R4_IKGwtm31B&tsQj1D5Q;QXBY`FA;Ocjic6buw5FIE+1G~T>j)rohq zqQBKvOuy>SXtjB6b{*gJ>*drIoq-0-@yZ1w^widWOavgCHwb? z)d%{8j8MjZ0_>yKKk&$=T)=PB%)8O z6uc2OHySdGW5P^^XTpp#w z1Z8v9Do$bkdb+)0- zk27Yf#>OKY3r<`4Ft6V@bz*bAL{Q0()d}@4ukUVlH0)wZx;(ifaE;UZLjBWMeCzkl z6PWrek~{cpRp#%-4=*oT$H=+;kN1%S$6BToBn!GXa3^o9G&t%uE4J9E_V$fr!*jFr z_Lod!dN--6-lQb&Y{~Is8&^p#+cP(J#)FDi@0W07s9%a%v1IS7A7>sV>~8WuZ+!dQ zx76#mA04QO4tB`@s8Hc2dsMDtPXF2?zt7rSK2|?-`%CX9{7l=oSsFbGm#uA1exdTM zF68dKMxA91$DbR1i`c4rTAAUl-1YMB+)0)FY#Z-3`<%_af9F9G_nM#;e=N>bDxG$e zTWIli)hs>ky~=WSU(MWpY1lPKP3%?pAQ#Fny(TaxdBN_tx_6Ehv8Uc&Ahf|@?Nbr2 zpMi5eY0fZguXoGq%jroL>z5E+V)I4%@Z4*EuFl?N^7`A%J`e5bSKl{wCCm?+;GrIT z(X)jiJCJ+j-s5-U+&<2eNpbc%HKlIR*SX7-p4$=<9`?h{G&*3%k?o4y| zG&6JVo0CbiT{Sw}yYv~^WRDs!KW5S6Q#JEHa3i#2wQc_f)e|lCk&;HQ9hNk2RNu9T zXLi#b6%)^e1+Oky))^XcM{f8x_1d5P+69Sm=Z~bQ8S>8j;oJU9fz?(0V5jn=oMSUO zd&JHQu68Md7P!g=J=B}|9oxB zI)9(~@Jd?l?YC_&%d6k%cy$X~UD|U=@~z{sBXbfDOFi&DdfM29N6(`5^yYK5U+Yz` zb~Y>tZmmE3>urc+`(33+C6AxPOwAMxvMGs42@QC!q!PG$OSv`g5rs95x!ebD&3wKp zWx7m}N7Mc@b2#2KryUTuHgRuVv9#Od69!DbWt!(+tDEGNP|<$*PJM)zX29d)@%a~w zj@)a{w)k?q|2zMky}v8|KYaH1?DFHQWv=R;uitZg_xbrZr0VxAJ^kbqzp-t3^8ED) zAM2A=xRqJ;)?5(c*rROEscN;qEPB84^|up4+hpq-e+WCvC_M=7&t32;TW-(MWRqanf)4|$F=VET{e)c0qHey4EOR)bozhL{YS(}b>SR=%baS9JPgkOm)D^xWTfXJ0E2 zUemkrL2mRrq5p?t9-D65U;L?Ec4J|(!mE;(XLcJV9bV?S=;Mjk(L!7;g(`B2^Dkby zWB((^^<3yf!TehrqP0C+&z=ca3OOWd#IJC3LsD?TG?U{ci%$EAX2jk&>ndAQFV^np zwfXUrmuGb&CSS~QX`G*N=6U9!0f*^XhN@x-eSv0kp?)ebTu8Q^iDv zGdmOoSe`jrU0lp;bN|Pc?c()^zC;|q*PVI2{`j+mQ~wMaMcx`eyQ{n)zc+UJZr|8B z@?T@FT`N2zvf$Xp0)_O>jkX+|<>sPo;VE7lyh~C{CK@#9{d&3YZTI1sJJNzYcO9#8 zkq9{AJW<4C|Kh+W7dEDz5IDY1?w51Kc>yz);E>wDpp(j~g?^0oN49AEN>=k{HvKO& zagvIJ31fYu@TG+5Woi{0SKOI2t9L6Kr^;;mm$RHLotf;k5^S8W^!{Vi@pU&A?)(?O zV%n7(zSe8Z*SCdyEfV2ZWSrV+5Vd4cOIMJ1pIT;D=|aU#ZZ<|aH&$d_sS)9Jah7fk zxPAT3fd^GL(=YT1d^#uWwu4!{TeW}Qkw#tTnaeI5c-lU-UN2SS!4pIKj){d^Shl6T zTZx-xlkDB{>IoIEW z4VIf_{+nu5sQu*LrZ?H>TFh_H^d&AUx<6dobN-D3bE)YL##42j6Rs>~-B9Y}!NRFn zDZ8$6QezlfyHva0l6Y7*t7a zt9y`iZp{(Py_-*5_wrY%Q22f(zlodgP~)Vslg!!jM`|2Jm%V;*Bz&>=)OvNMY_?T9 zj(quGq>`+?#kZ~_pD)Uo&DE3Ud4-3Zd^?w$Tn##Kp`zYnrBn3^&7%`f zaX3BvvMI~q9Q(oY#OTd+`71jeOMG_KPitA}{%dB-%I6dFm2tnfjQ+f^m9lQ@^W1OP~k$0sC2A_grU)F(gH) z^oey&ijXSUX3NUT`OJN3X0-Wdr_2lw^O7n0SMnY=^ffm7htHT&$-&;i~+F zdW92_B{uG>yc%taLj|(Gy$!Nd^!dYaf{o2*xsdk0(#k)&VeBz^dX1uHa*}*op8VVW zDBzp;=E4h`B=+*AJ>K}_eR)!H*@QiXH&rLD;Fmt2%8>jdeml>?thlDDKAI$ojH?gzmzQC1$nxY<+$%u^}VDsd2Y%&LDzyS6-7&P-^>YpA@*(F)z^6n5!-|A z9#&UaC;$BOFT)vX&6ckOn()=nT1+wJ*dp9IsEjc}#^(Uk$F?266|1*hs*}fY!%cHs`M|E#|El%EImKQisseIc!}TDG1`s3m#zw6!5E=a-qD zmw27R%bcUE^W4+^?iAg9cl2EMx3&rvA8-m=7Sm|i^# zbCxlBt@pfeKh&oqsnA{Bbjq8gR5tm~Pl^O*cz=)(eb=0O%KyRk2lCI%x6jlRycymX zb8zlf;}V63c@v)>xj&D;UXx9}eurPv{zbf2+;@#9g`B?V6wLX``|h`Il6|~;nl7ga zvZ+h0Hj_QyydiOWv(A+2J&!j@8*Eb&y%c!h3i+02;OJ4qc=63NZ)9UNru)pMJ zV|FeMx!-f|9SgI}GvSog-Im*IymmWT|BgTRsKeuh<&UXWvf4rh@8&HFs=Hr*B=HOP zyMq_5h3m;3Te#lp@39lhBbSMsY}|P?Ep9{6wh2ukA+J7rHORd_TdV%nBWRxwr*TW# z1$(pHS!*vp3?4Os56ju|EBQjZgXVq{#U)mq$Cv+Ym7oaO4_Y-xKMBG;X|X1l1BbA_HvQsHvGoQm`lCmQ!` z+Z$|M|K{U&wwE*1^118EJX+H(O!%}`#(eJFG{<|^t9&GS3IB_}Q z@ZObS(#pjr{9ZlW=ur9Z(${w?Ys~D~^R*9t6tE8GGdjXtl@}1llD|l)cdF&XNeX%s zZ{CgGz245G_M4Mm|3asho(_i$-Q-ZytBV9!j--khO{?cw>>k{=Z`$LYu6VIU2WbgwA;^$9m5^*#4&G+se~l4!X{3e7kIwWexA;i+(-# zPc1p;w`2QK3t8SgLYsCT*x}U66A4>T|(oO&Kj6=Fb~^ zf84(EsMOGA;@+pK^DjI}W|TBMZR)cnW=s3L_lox=6z1IBpE9#z&Av4LMe4J3vU~dV zI)1F%FgJ7cQ=xThChhWP@CuXEedoCO;PLsvp_iXnYV^pp^PX73Fvs+2{kv?In9D1# z3z>6q@mvm^up!v1=)}VnH;n&ecnaP567x)uW6^h?c*n#zk3^@_mp=#_R<5uJuPuD` z=HBU*m&MN8*J&kw7vgsj&S%xQe*PV2Metvd3laY!D^!1+vE+2^mAU_HQi-`}uglIF zZc+Bl`3o89bndV>JXvBORd!!RsjS}8a}6hh%w7=<1IxL!3$+#|N6+wIlXQarF4K*?fo`| zK3E-KXZl-QoNvp#Fg_-GPm_N<8QlIJ7py9KqF3JWU!1e_ugm|xpR^d1{4UHpH~svd z`jVQHlh3nW*%H)pF)TLhe5*G1Uy-*Fs|~)EO6a8=n-Eae+?cs!nu48SP_e6Qm*{ny z6DN(n-1oYAXs?5osqReIjq*LJ#=A=lr>f=cnPmGTZi9EP&ipC1UnG{SviMReGJl%V z@~IOzL?pUr|1oQ}tuu4Jz2yL>=n@6~kN0K5ST}?{J<#?)E{b`Hp+&3{>*^!tFB>fO zUsdZHKk-N4JG+R;6;GZQEUz(j{AJ70bkz9w%2WS0|GlRdO)Sn< zFfnb<3}9~03}9)`3}9`~3}9=|3}A214B%+b4B*_J8Nk)wHCbOp1+06!=54OEEYmOk zG81Mou`sd#t!C1!kBOdq+pVnb`uYUbP`>o=mW$yG_kvV6T`zib$x8h6&5)CRqHPBz zba*7NG!&m)e|~34GQ%cI=d(RiYEPWraPjVo(>v>)mn1*BnI(3{N- zzcW+o>`>0uIpZ!H$9k+$&W*>G$+=!7a8}yBzuRvdX><&kqIT z9(k;oV*OA2`^2IvnT*`qgzDS!DifTzlO^pF6ZB*yRnv?%8SO6DW1O@>qSV@6=9G() zulsLt4YAA_(>zste(lWA{IVikD$=&#t;-`NWL5E^fbPp8R31)vFa0StL~d)$`9;zX$85W$oDz+OacIOIJ&wG@|Jf4xcfWc^o-1xB}~yL&={N!hZgD=lUK=(LB)DI&IpYEw}Aj6@B5C_{^@PneQI9?TJ&$JHhi-n5)6yR^45NR}C8lZ3MC!`KITF z>aX_xKjVJ=6xr$P1oEbw-j})iMNVRxZZ9(Q`U4mg#l9AQkH+!^3)>9OeZ zso)a+#j`vZXRkP2&nDvBc-=wo(7h#d9yJ&?ssz-tt+_UH@zeXP-&mVHIO-+D73_^R z^Ly@VjPoqw+HCse$}_u@-;;fJ%6?d^eDHfAGppsaJK1Hks?W+jj8j*dfCl5OqN*TdbJ{AM*l(9(hc(`s{Bh%xcneQ=Yp+emwLs1qf6I5KI>O} z$+$XoQt+7;5zWjCoQoE3@;LEE?xN(edauwalD|6_F~3)NnSOZh_wK&RO)q9Nyx>@1 zr_f?id!_Em!8$o*D`9IsJ>9vTJZ5j6{rcVTrr|zAVtj{6*VM-k&4q33@BVQ*IH&52 zuVfDc!-5x6COL1Mey9E$V*|@!u8fBtSNsV$dq9l)GsD_PDz<#LRVUUgNq@5QV&pM( zRc^m}UWGT!NnIM5QuFWb+)%qh@O8D%r|DcJnFrNfc1`>9bn$0B{?!UIOcu^dXSxxr z!)6dPrSx+0mPK1nUrtKAnPbU&`^t<3tuLA%t0)Ga`sa6ub$S`ArT3Ba^z(5JS({SM z%za(D^~lq8iP9TqCYvlxwk_9uI&Jc~Dc_DNtXnZ{x9`3BqWF%P8R7}LYyQaWIr8KD zlF#KX$q^z)TI9=@Mkl^|bKFUS^G9y~p}TF1%o3XUPip*H!m;kjhBZoNfhD(dEKca| zo>uUUD+wSNyDD4x+=re#@pc3O>|MaD!`{)L{J z3H()QNsNh|RZ_D`lIvgc1g!sF;I7cfGi%+G?pb;*ERS3~6yzB>A9)&B+U0jf8wAaFiTG&a#=g+qXz6Ofg#kAj&Zs^R7QJy>$CBf(+L}v+Zm$yiRugjk2}m&IS}AA7q+E6L<8 ztv32mz!x2q_C@%dMqj$w`=A?EONs?@q<^ONoK_doUo&^3@4l3{9~xhean>ouw#CbC zd8hBYWPzl^H(TAh6Y=-v`(9a?lXN5gUb27*%a^Py0jF;cPHUFhpN-ApeZBcR+l381 zA@d*UioR3*>yq8TSn|!4zmMU|%K9h9Y#02Bj|S$?ocm07^YW_GH*P(*FRbk`jc#xk zbhAFY=`v5i1@mqG#a1X_GicHTSg@nGmo&;sc+vqPe^F_ls!^ke~R%u(f$wV-=!+;RBTS|DvH$d=}&mQZhc$*y{cWeB)L}S zgGR2X4e#;hA4_+qu2?%K{$12`>DOL1SNx|IT;l1y`mHE9?{1cx{>O<`$N6hC7pyIK zvWesD%=MpEy>pOW!?yQ8`TCD@+q75B%J)>O@V@l2Dcf?!zUs{fG0WcpTpy=yZPjPxeVIee$1uuNP#xn|mz05c5G_pM^{ILjBdL6-zGJPrmYV zUt{WyYMCvWyW*REFP@_?{ot>}DxsMiL2L?D|M=GTne1`ir`7cL)WfG6=Oi56IeDV$ zwYANM_MW}XU-49>Gt$L-mll(M?0)T4n<_d>rc`_s(>}}ebI*h5JrRL#9PZ`q@R>cq z?DO2-q|x6oH6;hRsO_%_BDm-)>qK|M_vMH&a2Vs7+Tw zXXCU_YWLa7`6idl@m_o9tk^TnkUzgpfB(Pl$2<0EY8Cs=+|^>#c(&Ro>GE=uxWo+{ z-UpvGs~_Pukh-wybHRPa>n#j@eu2u%uKe-d`Lx5UJlTA-&Ku?Ft;*Z^de`3RR%e92&rrXo`&-sf{GPMsypq)!oi(Ce zYyLE{-ciVP_#YXva6{e%wd;QlENOO%jSKFIikd$0UG(y<-Kj6{EfJr)?$G0+$>p*i zncDN4g^bVT)hnD1a9Lb;?KpqEEAK(umpz@Ax5z)JKgqCCYl`Ta`siz=_r$vAAE+pa zxjHSc@^RRy*@p6U&MSb;aojI%3w|c4O?biRPSUxpbnYaJRjZMK4Oh)t zU0hcpp`qWj`qc+Hr5kLie`kho-g$SL?sbJ%R_8tE+0XfX**1^KBy{@eeY;kj=)CjE zwo$4dj-|rKlQ~LVPrNibm$F^E1^!IhYI=~DI9*WpRdawFp}Anx!UkYec|l@zE_Fs6{jo+-jc|=JGUf6mHpwl>V4ZR&kAeI zbUUJV`nPs2NAk}-D`PV!d}~Ob zXtgQR=q_~6juruiTKY5XhO?H%HL{pL^i!zBuv$_^W*oNsDhJ3Cak zJ|&dUkwLA?2X@&5Jcxbw@v|xW2`9deT3^z#65`^=~dd zjyBrzwcROrw5%cg^z6C~JU@Jn72R2=ceioJ<3D^U3!kcW{I23Ty=4Q(jIVP( zx<8KkTo(E%!SecrGN)}*%$5hUSC-6@Id`jweb%Jzb9VZ(b5Fj1b74ah*VA0rgPLXe zudbfHFh%26&)a&V@^(M^3;DCPYT7B`qeRt%|Hb^!J)lXn#+BI)Z>FLmY zC->idm!_fW_3Zqy<&0a(JEFKxMc&Pn**4XoZi~;2R~;ORNhf=M zK7IPEOweuKl(Pb#w?DXbYW1pT>gSh*&feY6FT}C@U)Q0)qJFWZCDGSh8|;}J7f9(% zjKK$azcze66 z`RMCai>I)(92I}DNA3EQJ0+7@txUCwQr4M$*{bo^=$WzEntRXu_AWfJQ)7*?zUzAP zKd+<9OzYYNFBvR9CjKL~>-QFx2g*e&K5*rP3IJG`*UFGyI&1H+y1bv_?#D9 zUvN`9`oy}Xl3<5(mZCgoEMr_;k47==Fe}asU$avBpKidUsBI<}9@d2CcJ<8`NO`*M z&a~#&9O)Zt-aKB@Q5HG-n&ZZ_>%|E+JCfwp?mjeQKQw*!w-95Y4`;kwwL*E(~KAd?PdUMyJ2lE%*d9qzNeQ!+t^waz?d%kkMTzUVPhtAx0y~aHb zZ@KKb7VTg&e$r9c8uvCTKPBbW~+;06nDY}SbvFE*o!3O3#bc;8ASb4f; z>8xhUElTDy?mj-h&GZmUh=InIpU<#6s`Int z8~5~tS?5+Ji{4bJZnG@SSsbEr+0$^lj6kyB@rfc?=i{sAZ1@@}zqD3jkwmW0hm0Lg zt#(rm^7}n`Qj=x1xn(IYyWk;}G_I_B|BjrWlE~R9xJE`Id(+EPnf19R!ujeqd}050 zaP1BjPnXNKEKzlNRZQoONylf}>@)jZ7}0Zn&YH`1I?ue?-e<%*aBml#T_wf(#!UL) zf&Y#U`&X%Lw6Lo_bNN$fh?Bs^U9Zmz^{US2cw+R*bf?<7f_*2RYV7R$V!L5l@-6v~ z7Z2_>eZFvMcYvzwqXqWMY=xE-*GIqDF|{-0nad8vQQ)B5ANo*Fi=Dyl4V zIR4o2M)8Gthnt`1bRE6W+An)7uAGOJGmS+>&Z9p*#b?Qt+zBpnTgABlzD>0(%>PyI zm{>l~J1K7l_hK6bra(W2%l{ue;A)?=P<^SxMuQV8s>^0Zyc6NmX-`>`EKtAOYspUU zrRDc+-neO8F1pg|k-JExme0INd1i=AO6{!Ki_Sg0E-s*8ut)aMuZwx|5lfo>o=89G z`!L|p{73q;KRrrH;%>KK$l3pK>5+)N+rJ3bYSwSF*;gXzUie4nr^ud;3BU4Z@LkG^ zH*dJhw&qz!+&!K3J05A@Yv@ebRc`ZWSJ~h8ldE6v=9#;Cr{u00(KFtK>r*G+f72hj zruK#FbMN-$neHdmgM=f$>KL%MUpl<<599Oy1uX^2ogOs@)t;^UxWdPHs#Enb@7Cs$ zna!0`q`W>|tZ!kStg*II?9jo0jr&ji6nMyXt^BFG)wAcl7RA}`%~s00@5phHI?p@5 zJaDpwYF|+NiEmOy#TSaEocXTzY(lwN#8(fsw3^9ZBr7$VUfN8g7%hjt_*ROiDew8<$7=L%d$ID0iw~On?&2)XFKCwq^`}ghuO?$2* zN@ju|zC1FE{`0Q&w0++HO2He3`f)EaOp=x!zQNyIP``1~!uc#+?JTE5HJtT7B)h-p z(0t0Rd&tFYA(yX^`YVT^-(_$3cWABIA#|wSv?A_dd!c~(#7Tj3GA6qO+SmU$`#7*p zRVeu-PPvF9r2lJTpo78C4b_DKri_S&Mz63=_N8(v-N9|tp8j0iDYj2 zZ~j~G++yL6XC^MWdi%fZ%iR`}ey%TFVvxlCBhCL%=aU}wzqy|_&ihh-rR@FN#>e-{ z3U_&#ljP{Oi+KXJda8t7g4(kX zH0kn~k8kElIBu_>mG><`LG-{zU-Np+&s)w;*PfcOe%0=!A95DoULqTG%KQ53r(PAM z%yT0HZEyUWRlU1c_QU6^v(5MKNq&}mYm0{E;xB38&vZRB%|kNv?>ebW**M)iH!4-v zxcXzQGd9xpPR<7Nm{i^GCaL+xDoZwftmp;8S>HC6JQ+uXtUpsrw%0*1iuKBX^ z%+s3G{K0tQziw~a*!_Da*-3}KY-L=%i1WSpgnAY>xq23^eR<5+?Q-HJp2jYZ?GoeM z8}6F<)swjtS42Hql6o@9H}0AI^u!lS&&{}Tx9n`*-M1G`28GyVm$lBWC=;JuGQ0eNPEFr$ zRZI1Yd(F2UE#ur=|IRDu#nYmt%}2EV$e0KpTolP?tsT93qIJNQkFR3QeT`slzfDWl!LCZ_AZZnxbWagWF7_O3J6EA;iAUsE;Ib#OhJ z?){J_YDS^>+tYH>E5C(2v0cHCdf<51I)>#-|MlOPJl(W&?Ly}3>KpgeN1wl^x@l+A z!oRWYwj#HW8{L04`ShYUavS%T$EV%Dp6a>AU-!HG#j@Lti^d?uWkC&!d zMqXT3o;y4JjGk87WVZ67H1vP z$A?d_o`0jWEs}qu``fLSZTGaTgQQ>AZ}+%S$nP2|ctxpyjjh-t?e;0VizdHY_wK|o zhjTyQ^ay3Np18o+Wy)w`#;G-7!#bB6J#T%zTplGJSTS=?GRN~{&Ij*>HU{HOQsR~Vvrc48@BE&5_zv&sFM1p$VYdq>{5I#i&b0mVoYb+K`>#O7 zpNdVL){$l3wq~=|yS2@oyotZj`qs0}H|jUM$ba#pqLYW^`ZNxg=dp)%?r?uTajUwo zwnP1fx4G~yz9LI8@q5p1mP9f#EO+=U`f7)@+*C%9SL;q_Z050$dN5sIQDBBo++L9k zhlP9V_e`1g>*dl-SKfN}o>XIF6#aVq$i@nvn24+kT>{-2jZ>^S-_EUHd&*XN^SU*P zH$_)ma=vF2cEoUVR>n=quL+^ccKuDZ%inphfPK<=UyG=Q#T7ygWr{i51vW(I8Q)^n z>tteajkh_WGa=ulri@2)pX)#2x6Fh0@nI*tzMbFESaoPmYlpAl z_9Jf=?3Lc~pP#L^tl94Kg2}t~YSr)d-CNDDB2ZCfn(7|!O}6F=HYH2M7M!$qp1w}# z@x)E%18z^~i<4C2nI3j5smddN{mi@eW=k&j7x3OtzT7@VOv?G1n1OEoa*fi4^uMuI zPuG~WS0286cIvBNRq+|#f$X=Z#tQ|+3tebuO5b6dvb{ys_DWxav*hdJr+ofM{QNFk zpIrTD%hN??<|#|H{C$3EQsbv)4zol19u`#X@~sJOJ;eEQTb8HYMrF;~Chp6l2D z9QAzhwv+du{64WCUfNO1u1yHMDY{{1RHI$VvZb?qTV5VE*t~%2Xw18Sn+o$krJfeZ zic~-I-hIBH@VdUXA1BX;HAMd4&*3fRU+a0@W6yt?{d4~waXNY9-uBQ3*)u!#U0D9e zpyS-U2;aKI=9Tq5eJ=KeG7_d!W;r^3dUAwK&(mn1#ev|uq(k~2{Fsj3{?mD{_~C@W z)f3`{y%OzS-)k1!w|wD2|16PT9tE+tjD%dzuS+O=xK+ow)%fWKc@Bp8ixL+clyo|= z=X9)HG}i$Y5&1IC@Zbq2?B4`=KRWY+SE19hCFO`Sn^WZFvO5vi>!0RDTUPN%n;idh zHA$dRTGaI*gTl8%N7ij?o9mpjJY8nfF5k(w(v0J9ernTiCxx?2CZ)<8}YIWq9&s(qI3%U!kqnbfuVxxO_ynzJ+vSRBos`F!(U&w6S@&W6a(wLAx(e34t* zU3xC}-0m+E%C~M~JLM_Ly5LjAOYbbpaMQzl5!!1b7U{Prd{lW-1 zHOdJ6Q6!srzPUjLLY?*x*QKP=~$ZItUeU+tYAY;sgiI&l8V zpl4t1?LA(}!g(P_^IFsCy>B=AzdUx$d}mM9nkX;TU9qNN@jAz*^-Qh^dfzd*quBn9 z#M8PH|3eyX2e!K&^nSK|_LWp~H**z^? zO~ZV-H_tnEt<`<{rfQYm^Uv}e>8yFWNA-jHp@JWuJ0=^m?_)`=Vhd0-LEE`p8w}i;+A$(Yrz}r;v8RIvYQ=P zA6BfsY>o@-s}GvOJ2uGmoXULgLwgV7l*i3S65X0orLDb~j;*g;->7|w#r^UB9~nQi z&wb%-UZePOdF7?JlFR3N47*MpcwDz9vO`(;=Jo5k#V<7LYN9pQm1O;Jx3ayt{O?1? zM?TfZeE(jY`qR%|wdJ?*vXAk~yWXFDdvv~k)X~XP^SL#cObkGC*c$a~t+R`7TTHtD zSvw>;JiH|Kh$2H%|LT=1iyo=W-rH$x{xL1zY&QQEmzy!cOWKya$*BALmHP^}mr-hc z&|=0%7hjY+Uwo1#X-PhNfWh+5*L*`Bjh8@klPKc8H#VEMb| z>-O}CHJ=W@wz&CIVV2KU-p?mKMAX-sZN0_TRlg*)fJtU$h{WwF?z8qzywr8~gw7SM z=Zy;w&onsy#=PM7@`I|m8C%Yjlunzuz;^a56V6{*J6Ekf+7^8{SMxd(i{`%ukofUy1hJ=h>ditZW=HLp&op&o1Qf z+WL|UeGD4=MNA}3yVA}bs9KRwU26Iu&#dQn_>xDv-t4@ncgM!y-0rFS>npy#{_=Eo z_vz1@GuM1d2t89!T%LZ7?WnKhJm1S6?BP53-@HqY-6|!a_i7g3zYE3H1lk*4IJ=f}N4IDz z^xc^}U4^eyV?M+2T&X=17XCQ& zcGdIy)kmh?b#r5^4_!SwT54y;Zg!Tgyniw+`dv-gDzbdi+ctl5-uY$jw)OuseoooW zI_c<x+qE_Lq$BvkRQZ z`F!X3%4NJLN^(jyYIt?BJ^labQ^ongTKr9|qDy}t`Cqtg-@3GUlNnqem`rwYO-$SDKG!96p<&lDuQdWU{q2Mgcc@2R zUXnN~^>_BQ)MDd1r{4avIQ9IZ*_L|0XE(s*{!f>{0~Y`L>0D>>Y84(D~gS&+Uobf^ah|&Wrd5o2Mj!vJQs2QDcGX1k_QrWDHN)~& zEw=HwRP&$hoc*2}@2-wgCjp%Qdv`L2LB@d-HIp&&+>-=V9 z=eAHPybbzk5nft2?9TuT}Cl z9yrR+W!isiu6_OYs=#wG?{;WzXuWvZkv+Tr+>PiH>RZ&?Ua!*Je|Xuv{WZm<|9qGK z(#^9D+q5&{ZJyq>BYqvRrB6?J?&12d=)~^Biq}(~@Tc9};pAsFyv8?LKfFEq zd;k6)Kc`OL?Q14=^ZB7GR_zSVvJ=I>`0*Gz9khRJ8?|=Z_YT`P6PW4^;+ymTwI+Vr zY4rSw(&5ydjSHC1RbS%VuUA!~t@}ZKr!J?qEz>Wdykfl#27RSHT?crU=P6nhc;!c) zdb{|rd-2vfyR7Od>&{$S^yBm+HAk20{5?-YI~g8KxEm&-aHmLqzS+&tyDfHeK16@= zey33Vwr~2~!hOx|Pp_S{{$W>FThEykeomq8QSRYQW>cHL-AQmwP~7wQ#+vm3-U8c` z@|7KKhdSlGYcg1vu_t}*cJD1)H$G!nuNun9nVm9)0EMD zU$mrl)?%AKvD;!_?tj_zj`_wCP01G%H|;gppmeo$|7YE-E7K#Vu};@Lnmx1ZluhvR z`ZJ$iX+(uJo_HU7{_M7unvbsOc?qnaU&zX@wC!C3XT!TSmJ9RanzqTzS$5!{?SH-( zNfpW>oU^~0m6@{1NZ(UoExvGd3o|qK4(@wqJhP^jo_!$|QqsT6&g@|Krgo40&lMe7 z?s>C$DozkAzF7NTW^HRx*ja}Uyw4B+kUsw^so-e6VMUi=MU&wV&D)U`{yx)u&DNEF zV!NQg>D;^|`Qw|OutTRV@J`G&Zg-dveXjP1;_W$1WjcGF@6FwvsQ)E9!e6KRUEk7O z(Tfj>H@lSaDc5eia4hrUCh_IGf2Q#q5&!HjprZO26h5Wt75dp{cJf@^ zaIA*E>`~-~>zQ5qcCGWC>AJ1$@Bz(vUIP5L4Ss)NE|-SdVNIQIS1UJs3LXctI&)^ua-XErc&A5cRP?b z#rn^5Nzde$h0z_m-kp9|7k@D=dOy#4-G}_8N_8rV1+Dr=if+Vg$~ZT1mqlJ%myq?b zFRV$HCQ4je-%LDH8FE#|=e$|{8E4LE3Tl_WecNnv`|N`TyPunWHaE`O8lzjmbLT?< z$N&5J|5F@}2yN}^{jOtN5@xh(!q06dJ>-A$KAoP}mB&#fo)P1cUV5N?%4+8&kEL5~ z@+oX_ne6)V_*{NZ$DrHu)tP6Tt6#rSDWdsKdTEQ3%cNCqN4RA}+f;h5bo%hkV5@iO z5MIXd(f3WMk>bV z33pgDR;pZ-VgCK)*|&Ltx|0^4*=d;mYvR*O2UO3#Tm9(vzY8^cW8SJ>zn6_4RWunk44E$?NIlF_^P3{_F>huY$`e zE!%Dsh%e=4v<*4EN&Zx*{>JM+W45finwT?*d3pC9vm*I3W~xpfn(9w~aO1IFePGu5 zvS*WC3EWUz+;o%e+x*V-1G~iE*55uTmwL?2>aS*f+Fea!wVR$7(vof#sft~y+F z!gbR6Yl;*8pZOQqnfv`Rp>X997e=zJi zU#mIyk#`)d580Gzt{6RaaO^G1V`UKXO>>spKlybHoF8x9n||CeZ}_K)=<9R z*?vo!ca_x^pVm76-1nH+fiJVGZZo{NczfTh(;_Mw|GWBhc7F?SSK@l}h~IU8(X~Gx z6n+QasSiDSP^A3+$E&Y09)`Z;)_Sj)l$v(;zW$CCuC-Adp;B&~VG|;nIG7j~KY4KF7;-QSs+?Y#Ew9QJy^{ARb{r>j~5QPHy`h>dF`~Keo5#rmDh*PK5CxwxAbA# z-q%fvhMl#ON)@+kDB%A6`jo1yq)LzVaVAHBy884>2{rE9=O1sn?|J9oej9w=9<%_cIHc%}HNHbdAWWLqi-@laQ zU$c8_|;gSUp`#ip$jCuV)ypAQTX3Z&fnWQFv ztN&-3TP+Rvt-dbb(3R$PytjDemmpd0y2%TsR^=alu`f2c!OgmOzD{AT%7Kzl@gGXL zC+B;0DjnNi=DPRedf(TnJFA6f%HNTz|GqXXVyi1l+T$sE(vPgmio7$$$W`^Q|J6xP zCNhN?Ptw@2)LZg&dxId?<-mn6<>sB;so8HOEU3&fEjRYuwbF})lgr=PKC6)NdFu3~ z;p6L{!~F z;#~coPkcci41eC_n{JSJ!0{n-`nvb}zZ0g9{tNAcg^_=;$>fdvf6gCQ( zZ1d*|PB~?||8z)A{>rlV=3iHEFS+LNGWm!;zxL)u=GW)Qv&;*Bwt4-pC8ZLn3+xYG zdor{7Ao zbvL#&`0QSp^V4;YvizveIXu-v{AVKrPwsW&Ah~Z&9}b`2i^}uv?))rq|LUFax4V|_vf8rr(7exwxy6MbV@x>+bipNQLn+a_;BVQo0iM1-l6S!Ri;|6W%YzR-rr9@c-R`Yl;@tDW*>9l zsu_|ivdUJZPMxgJ(6}y2{h zx9&;5OnG%Ji7hWy#;b8muvHsK?-w8GehMafpzMm}rAEdUgqW);Fa9+Fh!}u9> z8UK&fcTbEFe)QMNTSn*g8a4$tr5nlq>bK*Cp1Q=$wUKXq`{3+?0{sO?AD{g=Uohs{ z`Om_V#XdWpUzG6F(OTKKL7~z~TJnAQ+tM@ZGd_y9vL1Oioj>E3^RbP3Obr>ji@(ok zFVN6_bSd$7OMjDTPttQoQ8u2npI5MK{5?Y<>1V5L?SuMfPmhQ5Ea+D_qxJiP&hb@7 z$I}gFC?s_r`nKwY!@eDQefnB6g?4Jcd%x?Dm3`=)^V|7_1mAfT_@>ugKl3-#ana0* z?-PEA6|YX+A89VJ{`ZEQ+jrip9_r)Xviqq17dE-=SMG?r$?FtDk}a%+kj`CGBIGen;kw zoNe#8wAA|VdTkLr%f7F0@7ue7H_!gvn(*&G<0V_J+Ucyq+!{<~CXn%@t*ZCPi;A~`OmY&^2a@%#Y^+K<};tYXOolv zZ<@&V`uZQ=rcNr)dzZ`Dd+Pq3biVp|ZPuo5bDvG#Sodc2#@Fq)tCMRkef=XdKd&^X zxboeNp6!tnZIpLA$j!&0@9ZuXmdxdFEBz>nppO(t{Egd&}0vyh>ctA0s`h{*r;&PfyL>_{zU-uUVD1T*`cDQZsv>Wzlri)jqGh%UHsJb5>IjV z#68FL?w&WfGEMqk;?tR@YisX>&t6vhWK~XaihtY2tnKxo{PPXYsn!4apTFUOUPWWC zwVuU{Zy#5_o9(;xd0X<;{%;?=xl%1{^w4=_tl;K+@n`rrEguGZ|}>Jt#wtL zHFXEe{Y%$e&sYAgcu~)1q+eR;aQ@ndg^h0)mX@!b^OvzKZ-3JD{l`0V&GX{we_i@F zJ8bIHmAcopC!2m|kdJ)2_gwIF(bti7cd8=P;^r$gmOl&#JG^rJOb7KN(-iE?W(#vn zNnf{+;n4Fdcdp6rC{VlgZe84#mtMDYUi#~bYt{8A)b7}_lI`VYM$cT-ypWpkn;psLH8{vBwFL*G#^m3Bwu-9B( zaxNw6C8u7bx!LWi1~p!$lU4KgIA;FQ5Iwv%vFXPD!v$ZJlAg29URbuG&_2U@n~&uD zU+=#B5YhS+cKd64)_tCZ*SFnt4d-rJU!P~bW0ej2&60j4d3TA-v?F>!j2BKVQgrXM zniRkob@$re$HhL35f;<6xS9S*zg(2(@Llv+@^mFuL)OiWpS5QR+0|4!ZS@V!%oDpC zA$PGS;Lf8d5j#F|J@gP?S^m0o-ZxP#?)ev$5<_*ho1L%z?N(Xpw=}w=tri@U3cD0`&xL8;C+~YtQ?tHUK0nh{oEp}|c6RGyzXh$nEr-8r zmA3BPc|JJw$MlFbLEKI%-j0%NtvqR6p8u*|=PDK7En$CPG*5kvueZWgmUQW@mzVyy z962*fKs!sUev7MQ$J{gG={-@|&0l4Tr=~qUGIgs@{m#R>U%h$fi>~SV*txyz^wD)s z(_8y(el{*WBrL-_H|Ob>6AsybyY;1_)p&0OWH@<-&O6j=WGVZyBzJWn$DXGP+k;Q) ztEXJ^n9kFl`!o5%rc`DABQEk@r6DF8)`qL?-nVZ1-G_Yc7gC-pgg#po!Jy3ABc`_@ zaMJ^+vgCE5Cxz?3Tk@tTI;`yKy?c1>gsGj0gpoW^8kn`2Rgk8Clc>Bv&w-N@9qdNoxzw&bP2K#*v&3SEf zv#BxMx9`TCg_F|E)_5Lw61~>_$m04*apxZa!lFD&cpcZ}-gIdd;#_g4ReDDE`+x<{ zXfsZpx1`yd60Gaqv=Y^}m09o;|D`V*ASN{tlb72W3tsh)K?Qb@t&^ z{q;eMbJA8EUgY8X&{T0xUA2LEeEIr+O#3gC=+Cd;6JIlV0_zSHxp#bzICdMX(+hny z)uX{Y|Nn$VYMVP9-yJ+vx8kD)v%7ba#TFf2$2I4lsa(5I@w7VYN|M3bm{oswer0p( zY~CH$A)vFzjeD`qXXDFzzh>Um zGZ$W6JaJ9r+?)EFSHg63gXd=(=)?xL@LS2woas4t{?po=tPO=vm!EqhthUV9fZ_Ag zGY(E0?oNpeu*R~-w)cF~Y zw%bV`^^Rtk!?tw!-?MxD_nLG6%xbo6X8qW5L5nfD$CpQ-y<^Wpmm^x8GoE^D@PDjo zT6lfSLCb<9O}$?ei?r0AZn?vLv*H5J;i!VOU)TP)q2|3gM&#Y?iECZsy1c9oExu=d zH&ej)Q>XfxNnNbwEA5UkwVtb&H7~Uf%VE$CoV8%z(F;M0N?W+!${fCy_B?E3eT)CM zH46?%Fp0d-Nqork&-vDY^NI2)|NmKjxpy`2?;Z0V*wuP#!yJ2)NgYdYiMy~EE^Lp63+ z@tRAs{uHq;b69g`Zh>gBZNYlyGbCNkvHQAP zJN16t`TmyslN}eQz0(e6{&INh#F)5Ompt0HJ$_!;mU2N`#bjMpbG^k+%MZ`C<(Gvs z{C%JnDrB(XR{P!SjK-IqCVg)_wY&e@&Y+XhM;J4HFSy;qlx%MlwmAB7&V>JZ%zBfz zzWK4}kZ}F;`<%XSb|+?>5ZHRJ>+aiv^)Y?Xr=FW@NWNhzV!qz*u9}eiPHG7+`={8= z`NtUcd|tU^xs1N}92Ny#Nmgb><_CFyMFj(2-j+RHWp!8KgVxFp>!!~ga{Y`gD!Y%& zfa@Ud`fufT>UDB@@{VYMoOQ+N zvmDc76=K$Og}vE#`|r{p6EUC%b9Kbe5+27 zt@TZNP2ocI+ODYDZ}Gj3|3%k&|9V$mdYfz0XI%@I=7hEtD<#xI`Uh3vmYJvLW3+#WUG)%VLe?nlV@4o+5bwMoJii%58Ev*=)N$uVB(PQ31 zx4#EpoHzb{^WoBWJ7dBbI}Y~=GYRjWlcILR)8>27>TOeFj92hz2wZ4Uxn0kqc}7_0 z1m`jB4Q1~??mfA8|E8#88@o0v@8H=aER&}!!nP-~p!}wMy3It{+|FHk*4JzOZ5oum z+&`ksBfKqfPh^60#N-KWF%ef%mOjiqdTpa!%j%Hc_PIeJI zZBzfXOp!x*N3^B&=Z$v{^8E@nXMfzkL+{zzZEr4IeiJt%Wu4}(51&-N?zcYKx%gRM z>Bkm@#>C4TB3Lg==JDQHduQ{BCy$diZ`ty#E5)o*F~j7>p~Ei=9BTSQBM*uT%o8zN zd+*`et(Bj`<{2DP&}XY&Hcg*R_T;wMFCud-nwEb~sjh$Z)8|#fb_Yih)<^fsgdKbq zOrA5}T8xG5fJ6to!d^?6?}g`ID5%@i@QAF;`0rb~=!Eue_YAFu(3&?tt2Vq?c+4&# z;7s-+-u6D(c^@^kI)8H=W;|)%l(?HQeW9Y6sM?Mtt*yH~RwxOnhX}q@P?nP6k}i`y zxV3S2G^fd)g)_?P&)42)?_%2ixvGV6n@IH0pg-;N+q1kLYdl{Wz`fh3W0}mu3Z1WW9w*K@wOQcV^@dj6iaDmT3I|1dHYp|?JF>uY=eE8(#=W_W8WnZ1hyMRq z*Yf}B6n7EhAN6xp_}PA_3D491Qy9L^MA&SC;=L=*As2p|oc{Bi^=iGF4u9&E)En0) zHbs8w9)fOlmy)CWn8swwJ>15Z}~?uf)4#jdeo)>@Zn8 zf$Nu4u;-#0bJtZ|zndhN_(o~%zHqg2;?cJYjJAH}tGmL-^l<6cVjQmxc68Y0lX@?q_{H|NPZN|3gI`@eRo%pU?C4L|W9RqQ ze-`>zl*SpHtb5?fIgxb6R~~kZ&v}1n|77`BW!ISEb1~WL(5#}hO20Y3Ny>z5HBk0t z;Mt(i*>E9!R>=vwiQ(bFJ9jB84l-`HT{bgzS+naTvjcV}-6CEVa;~5D7p~~OA-`lr zM=`kOMJXKY@yLB^;5=BGt_3}TNm1NddSV!R&u&{Xl+fo)Xtes-y#Gi9QM?!H?(=k%Jz2d@(WhY zul<moEV4*>Z#eI7M8D4rr%xVlr$79B$cMr5w}s*v_LhfV-q~ebJj;D7rJt#1 z(dD*gf3GHgFI^|ei0JnG2}(t6XCqY#UiAk#_GwH~*5KIp=+#t_J*jU5TPs{AbY|?I zaMPjHb=lVR^)JsK_$a@#O0NEQXU`Xb37brFSXi3cUL45&GLdD&Th1qk${rcm$P1LQ z>3`BKJ$v-+l`OW01$`G&PaQd3bWU|Kci#z_hrUan%$hPMJE+R5^}rbqmA8&@{V_5R z_%7^Ny8KF-;$}IPTMC)cAJ2pqUH^3Szu1C3rz#tFRa|zAn9$?!$?C<6!>^0pb=5z) z(q7BOD~>Q-n9i_BeH&LbeelIrrZLi&Naa7g$w{lybk*ZqEW zp(o}}ss5k64T`~2bf$DJzMg3RZNrw9Ra*r<{oA6UtByyw4#z$Q|n+5*3i_ZM% zuVJ)P?DQ7b-UrV&u5ag@n_T-$hgI<0&AE-&>rJCiNpf6DuyZ)PX2}M|sUn%aqC%4! zPMj~YTCH(tVxD+>M9ud7MV_}B@;EvQSJa8_`K6FKdGkJ?QFa9tR%=~s}Y-`M3YE?(c}#U=Q;U2R&2YSc1UuI1HZ(~ zU2-ZCPFp6Jd^XaN{l{OTdZ|}%Qks+gvhyBV$>*fx7T*h$c;+xo_*|tb-_3^lNA^q? zw6;E|z4^)`DR%e$!o-Qs7N~AEJW{ITJzw0vCwk5d*SJHc>QjzSP>A?e&r`=|uJ>;k*FJvK z7rf5?l||+J|Ihj+cRqDVH;aBLZN|WLvoht3(%E%0K5%zB?z|H5d6HT|{Ox^e0_}Zjg6(~3LhXHO!rS}QM7&-z8csiW z)J(JfY)o|j?Gqd8zOTRF&BT{*u~zja<0pg2+nwUy(l*Pb2)=p8?Ea{SYkiyK9S8G0bPl^3g_VusyLwU>6zXe~PeK!|sOH!&=4_ayAdq>6Bb&jU-%(eIa ze40JuOyZ~CogG_Gt9{>6VtVn|(UpFQd*;;CeqL{0CA6F;K|9^P4(;@$1NW?O9j zw)OU_jvzKU2G+7|U+WLP_w>^d2;P({w0!0)pHv;8qpSDD`b_OPReGLHSXlb)xy_CR zOxkZgn`x*AM?4jZ3yt;J+GSQNRiY;5H8-_6D&xV&8s2SYJKo-&ea$HBX62gIy*+C; zufG|6clUOc?zJb+2?%}U(BBZc{OXde@4^**`#OxpuU(uUURn2QLii<7-hb1-gvKg`C8WM@P!e-mt~tGKKNt5x=4BrLS)45cI(j?K zm9@-Hlsn(RX~8CO;itxo3d4TJ83GF=W>^~gykM-KVR8H&v(J|D{)<{~8GPnA7c_Jx zAI#!VJEv%Iz$Mz?P|Ma%$%anjj=Y3L%2G{=TW3l&bYAa#*WS79#q+~0g|RaPZU!3| zDp}nYTz6@r!9>{=v=r6^F5mb}r^)u345wWncjX$(?u33**@GRXo!gjIPg=UL zuX)+Uw&rAs{1)~#l}lg5t$Eo|XLn8G>OrZOPlO|k)sEaYP;9HTVb0#9BX+JYWm41% z^)n})O<;_Ba5#Z8wdVJZyMnXwU){8}+H{|H?$!8x)8(E>99FJxI3OXXIM4k<22(Ll zzd)jLg-p$nBYr(^Qq($o=E{6u`0S~TpZEpOq~wmz{~uZY*4fSPxpr^$8Qq%)EPv}X zIR{yby}8u5q>S&N;>xY8!Hm2|Z#e{6H@{F@S?ZF^xb}_%<6p0fe?8ag{`%>u`%=yH z!{g?6;N3ufCEbOjoGOp;?ZSh(53^L(#R7K7@!jXxWN)}B@NxKY0_>XA$l zvxm${Q|7%pHlN^?xH!pMK=G}B%N)ldX2IN(9RjPuiyS(xd%kn;nD*p3bIX}s3=?fR z1(Y9clD!?(&&sjm(7EG`N4hI{Odd^Pows(wzxyu_^DaDNX(AA?Y;9vidftMk^cqJCJjdE^%L$a@QF6Ms(6Wa!I{@8-xvFMf8q{slV8|V z%a!WJQZB9V#GpTUO68iu|J@PX?;S?#jH!8~-wJ_9u_3WyuevKAJx~-u=1$Q@En(izZj2je6nYMp|X1 z8&eOh`?Ehuyu41A*D>W*RWR4bXuo9w$0Juop4oq}e#x1VFOS>j+r?$b{{6gMf4Y4Q z`#sjysFI(DpFZb)zUY6=-!D_k@BBOXEhJOIdWVwA&mDh$GR;_cC`kP5L*H`NRffWW z=cdnoG*7+!%k5QH%R1}z4;5d3GUaGho88Wcr&qVj`d^XW_wLo-KaKM4s}J<41>fms z%ReyR?FU!N?C_sOkvbP2oZ4L#*ytAivntG>wD@rNCOy8U=TS#*YlW@&XtL_FCZ|xW zq=fGhYsJOdj}k>A8{Ln{t#du6f4ICqe!|PAeCw@tEpPi)bTjgA!x7$!G#)`n%VKwPjAxemJKfOzP0kOvCPiXXK&rV|M0Qv)@F0&DF%l&^_tZ-@xNbc zDpj>L@_iNuo6xe&8sD#1KkCeP3E8*iRO!xBwr@99PDl>@lJ)m{ZREy8hAj?%&qb`S zEj(1Kb0eK?wzgu}vpsz|%-8pBMZQI4!^)*>u8A^l@@$!lmu6b!QxvI-KTMe`(R4*pi$}_t@Su@v^uw zG2~r$;}my)?R(aIH|y*Q-%_E8QHm|wQ=E1z;uLn6R1~WBxhr$o`FWQvI{x6SUY4*^ zEuBez+Ql1vZ?xw&e~SD5!dx)d`p~vLvW@RN3Jn;Jew5KP|5(cRDu`>n_l!GDU8f@V zu4h`lKyV-T&gUmi{9vwsWE$y}86t7-{yS~0Jrg7rh^KLXl37~$xJ#sSd-S#dX`aMQ zx7Jr$@%P^?-g#6S0xF6`bX})f^Z|u2h^X8enuP3j%(PVV;t4Gj9k?^Z&^}8Rq?p&X`jk|sg=c-3L z=4Fb@H@%WLVlv72{+spFkBSsusERvtKS}Pq!>hM)e~LI0^Nrl+u{^y#=e@>{UgzbE zg-^_9yerGM?o_Xy@;)U%Ex|NblEdy(rjJ^y_Hiqonl*zxI>e%;oJaJm<#l60$@w&ilLZ=IjhXs|ImNSj;nJ>#bu`>&2X%bk5n?{4aK`mTHYMsB4$ zr*pLQ1Jef!w(>RvM;x|o*;;=tc~k27W>t}03+``KUqAED#y!2iuk^e;x2l2F?DeCp zQ|KCUy{0CQJKsYBkj{Dd|mx5uYT^5ybD{BB`n@A_v63Ky4avN*T8gA zft%Y42GN3;F1e9osyA=G2;;?GvW_xw1xU#WlN!=6cG~lVv~4%KTn`aSgxC z<~vV5zbxH%%rf8VWHL*3d2`ctz;}0-xI5b)3 zX@}FVXS>dwHa*#9{cYK#y=Q+Y{fQ9Lkmy(8n%Wej;9$5WxIXETJX7eNL-%by+URcxX!m2SLQdFiC>f~}WdY>RkT@umCP{*Nchxr3VOx#da^xy;8f|N&k`*n*Jmwy zT*y?h@$)?U+23-P=I|H`i7Sd{QKcEXf1857YKa-S|-_`u#%4=c+H^bET^m?%bbx=eX;>Jxo%2gaV`T4I_l4csEU6 z*1YXd8k2?Z&)@sz_@`fGZh0UiGjSGA+o?aSo=?Twm+sH_EPb7I;rf>Oe6^c(Dz-GH zOZOj>=6GFo-1(R^ljdDkHzUgn9H|ehehTaTR8!1ob(7}48Nom zv$~AAEY|_J#VFg>U_ScPEO)M!Ua=UX>|0LwGKOx7xjr zlbYuhH2GP0eEXX!o%vDBUQcl2SG!uye&rCSk0<*xR=l+SDtV^1(thcyC3@TT$v&HV zrZ8QIBk`X3@eTD;uPf^^xV~1Nl@p$Jx@VrsM(@&NS1qe1w{0#j`g2k*SJyjf>8|~9ue^*ldMawm+(__aH~9Ti z$@t1%*4{TeufBHLa(Ka4@t^BnZkRNEdBGKN_pgaB``hk>xEpgm|6Tu}A#eW5l33>j zcY+Swi~Zqjqch8X&F4_d#haPMtMB)Cw+YE=Pcowx8&QG ziAPjKI@Uh_@oe3i1+$_aEfmgwnDA!*#xpOPxi&?Myxv#)rhK3KGscLe6CTenXEbS- z(QmjgH*~4E&GW6HmC@&J3+`ChRb2n?z?OA&Gu!T){MzG0q4TzZxBP`IG&O z$Mw35J7W^Fmu-AJXXTvWm&qJYuLjRh&IyRVRMRQ+?c;3D_v>c=Ejs5N=DP10XM%%e z*o_5yHtf3Voi#t<$6kXqL49U3U2n6NpS`)TkgfM}ZuWy|VgC*Y_sy|1yHYVJa_IxR z;;g{09smCPE!nS^{flYIY>t|q9oLR#W-*n;eqEHJR&O<7_6d(K1&6-UX@;=b zH2#9_V`U;|Bv|(NZWG{p@ML@Rul#jBTvuP26c;wlKYJ^``iH~myLV=bWwFxRbZY_M#y2htL)7by+3T~fzT9!@^hfrUItj&Meh$)yPQUr# zVDi?s=Fq~={~15ewN7XcRTgazRTgUxRTgg#RhDQERhDcIRhDWGRhDiKRhDTFRhDfJ zRhF9`sx1GA$;244rfO~U-N}#5it6w0chV1Ex^hiM6T|+XQvU4UZ*FT>@9lj4DCFm# z0~0Nj(^P}hR{q_w-|p}0ya`j-X5CS(6l`>x%&<%PFXz$K%R~44`gisE_x1aJt&5l% zI8*iJtAB-4qoh+eMm}|QGuXcC{@S|O>E-+H{(l;}=KUHoz2ygYMC4AIGOs>tLSN|r z#2vSH=tO`2x=?C%f4S$zb*x5ZzwQ_-#Pj?9F1c`U8r$TWy_XjXe}DCFd!&Mp4p8^m#F zOVZ0vY&%0aAFX_)9W{lK_v|l$DCfW1Z=~FA6Z^;-qIEs={@mNLTR&ICE~^)KaQ~5s z+^Z<7P1;gi@5R`a3MomxLxZrtM|7^SyrEnnCE6;M#9* z*-p&@-GxzzZ?=4y#oaV!u4l`9^C~w!ocUXio_E-}UTWZJf?5EIkmkXSyW;-9ApUboD@=I=?8eLYU zUdAKl<+G>UsGiVYDu1E$b(V;MKaYcdkkjoqORn3-@ov{y@BZi2!?*f|Uw=n?X#To- zL$>|;LRQm2U#01i9>MkI7ry681`BI%Qthl+uV9sOc3s$l2EV=Mg7}+xDo!RkuKcB6 z-Wt1KZQs#FE>A8yGO?9EdDK(>d0%e=KYD=CcQ!W~bCvka%Q(k^MRJWy_H+?@2G@8ccqhHv6?1hk$o zwj23w`dZMkZ(7>t?@>`Y(VbbcCK>bj+kbg{F*kh4yMB{i0bl6<5aGvpa$(*nH=L3_ z7#->G4EeqAl=%kdo=~q_PCcISwpZ(oE^Ljk-M@K5@Qd_~2|9d7i!57p+Lv-UxmxXA z-@fas)C>lnxT=x#DXq|Bq3*L56tHtBEt+>`QQk7wqo<;(x=LNM zclv*sta6p{zgX>qf;Vht$(QO|j<7wGo2~3}^;qkMHR|iEyyXthmanh*znRCRXTo~> zE%iG0=SMMqKB-m^|GzG8Ml4IpU&jN?!OhFvw{xBS8&SXL;-VcUhqs;3zasH#m*Im$ z+ZkVI1i4Ib=U=tt{}QXPE8BSXrfAHUH}u}~`|7g&jbeVXhTfCvGH*2;U2^cmjRy}F z>@1OuG~)cG@^4}MrQG=ftTtZ^{K!+S$QwcUzk2PNLmm{)gvrTM)@t{2iByAm2seJwX& zjg9zHv2}_0|3A96CtW%sHrvnYw&yw;C6+yza}k&JETuJ{eXyMW8f+gtf?(w2+Mvnz6?@u#R zHQl3ox!L6y)TC_xUNlzH`19uKPcGlNN9zUVi#Tptx>03Q>qNs#xo`ehZo0eX&U=^A zs83C=&tDCkk)Uv|Nww`}rxH^GOZ^Uc5i^+^-lwiBzh-Kh@IGQ<|B~g2kHZU=*2b*7 zb$qHw#OB81d2F^_4PDci7s;`1Ycu%}Q^S6++D5*k>79b@CU@TBa#o=Yepx5_Hgh`& z9XodOsrTwh#Rg9vM1<@<>s+d^Z&Jts(G!=s)u-G`{_J~xn_9Wzn@F_VzwO?+6K3I$XYwyx zyrJxc-|u6_DPQZaeRDI(K%Y2H1_{a0beJXry!iR*(7r`UXd z^7@^H%cA}Xm$>TlCYweY|M)t&^^<=Z&uq)iADSK3*HQxaS1eXgApDvu}InIaQ&>=2pLMf)!y=!_M|P{a2nanksgM3YeTVp#`*)99 zTa+DA<*I9Y+I?;Rj0y98stA02kiY7#=ZUV!6DKM*?@M~E@7ED)zSv>g)I}@itId_o zJfpk1`q;-~#tz!1?=t!B^4|BYIo`GAc-x7)TXKqncYMnV<8Nj#(RF-L^oS!ww#_e! z|Ej>e{_-imgQuwn`!GM468!W|ed5l2>Fu5$j_plZ!()^7;_!|1h}1tzeYxaMwa#bI z4@sVCB$9o>!dTGX=hM&I<@rJ{wU6G|IQ0n6W42{m?f2J zO>XT9&T`b7tsBkwC8PFW&8=uZ?gPi~Zq#_Xs_e7ocJ%|Tn;YIO%@92BSv0rM-0knJ zxP{5_TMsMFxpH)4;`JRmo@dRZmMvWV$@FKzqSBYb@wMq^7DXk#C^qwZdH9c`lRs;A z!)oOzpR{;AI$AwN#J&Gh^`<%^K= zGwwY)UKx3FFWJOT>W%Jte`!?f?} z^Jg5J%k5rqJes}H&eOjr=o4GEy7ozls)xy&cMBFOsyR0JebhW|EGDPEqwxkGPc?7G z&M&t=FmbaL)k{<~XQVitDRy;9nP>5Nj!$IBj?UtGk(t{xgHlusn$H~RdHnfxrJJ=! zY{-rX4!<0pRICQo4)Qpabdgt-TZwM zpG|6s?JsTaQhj7*sj+01a{8x&%!J)1`X`uwy+CI;nI<)prZ(#_FkMkyk&<(Em;0p?;#)t={UKKAJ^9b%C$T=qlRRI+ zH9Mp4?7~+|H(z1jT9>-U?#{}5>C>FidqlhL)=O(j`AP=0)OSqjx9iSW`y_nr_lu2% z6Ehc1Y>h5j$unKlMM*YSd2_2W?oY|a})4e5R!-gGaqJ6u*uKcchvanJl<=*Qm_a%J4eoke($jvW& zmz!Uh;jGr*)mL;wf9|dReD%@^ruS!@I>h969hh_MQbn4jcC2xc8e@V}TuZz*v-;74 z&Q4u#8^7P!SfP|Ub3?N8zIKzV$*S$UGM{Rs@B1UsSKH2J)L+jvL-qebFQ>4*Pfr@E zUD!C=sm1%ws#>ehnR^a#Y0a8u9GCX?$;aO_uie-lB(^clQCRzxr2o>+UFx1$&#YpT zgl9xbC~n%)$k{4;?O1m3iQ-vIvSNZ&ektzhYSvZ4H#?uqQQEd~`Sz`oLYE5P&6yar zS5nVe^xReVFKcY(Z9e^zr@mzQoIux8Q<@L$P2qJo{_g37ca@)#8oyqj#`n46*qaZJ z@62+3S|X^GJoS0=y>!<@X68_Ch5zfSvHHUe;wv_Wy3i}lX`W7 zxt>Smencm=J8qDwJ(ub6h3{BUp;v_^AgMI8Fq{(3jeQ@`N9dXp7npyq$o zRP}agp34c(&ifm$w=J8(Vd(d3zVd1QPm3qGK4uE%H}1TA{l*myiKsVcZYr>e9($iY z)l~jM?x!tJ>OY*VR6lz2((}Iz%K5A-O`pH+k+?VS_suru%!!A3{y%^7bjh^9sb7zU z9(<&b(O71sRs45)P1?_}!(rTAwlRh;{GO`GQXV*vu4k zh;{$P{cGn>++`PKp8sZ!yRYSMrxm(a4L>`sWZIs>8I^nZ(~sR#>tD=%!oT4d-*pwy zr)M*Fsb8q!i%YtEdfK_2Uu{>1Wecx=d~r@{hgE>QytJn1LjCV1D=uz%GT-adWucPv%)ZECarClG=bT?{xeH_Cwm$YUJygLmwVCHslmOR6{yST@ zpHb+|JL+6-v)yLpkLU5V>33Ht)JwPiJ}R)%`d_jPr0zjK3rHE91dD@t2_NN26Q_{L-ZdaO8Z=j^O~I`#354aXO+ z47G`T^mFaXsHV838H@j~Fkj~U*@-D-%~Vf~|J(c@|J!P?a(!8^$cdg`j!UZdeYtG- zrG9Ddlb2TKCY)GkBvfFsxTQ_;qTP=T7YjK~cJ@$IXZESVfF ztDIIhhbMY{$dZw@eZTu<>Et8FiVWWc>h0XblwE$c{?Z=xRU0Zw?t3^f<(|CF&i}de z$LuLjgR&+hhOOWT<(%KpZhvQ~N|1lhr)`FLr+;t(Sv}egj_K$H!e7WsbHPdds+@n!^Ds|bCGe^x?8}x+) z8#e6s;GP~<;xn;c`smaHd6PsXWzO*@|L8NaTzfXtPsAs2S#(TNB;+@bB-EG#?z;7iqLfE zO|(&--}G$7^?Zh-q0IYaCmx+-bSmk6RqDsJlUoWHxcaVaihEkWmr23)4;oVtlmK@zQ<)=)_ zv!?oKfhSpit&QeoQNPs_w5Yu`jeWr-p+5U5=FQiu=QDjhmSd-vmw4vF=bab4%iX zmG3wF`gwK#$@vfT%4}=3+*HGZCEhd5UbNE4`HTMIB`5SRPLo^JyGciRnoDXR*R^^! zJF&~}gbeh&dKT52p6{IN!rJ@GC}qKpoJT7>yp)`$EI%ji8>G8d@X>k4ApJcpPGX2P( zl{H`W9K^jt=ACNqRhtpA@vaBE<=H=HIP4ZG{}11_XvIdeP5-ss;^&_I)O7y*wW^69 z?#*B_myiix`guphv%L?Wtl$n`W|y~DDaMP-VCE5Hm5NA_86@KS7asB%}A+Bffl?}&=?NsWY`{v3`P5pR& z<#z8xzZV};SGOAdwf88QbW6K4POkL7%B271mhN|Rxl;2|ic5-86Tz(fq%1B=lj#R6 z-cxyt7h$<3t7NH)-h;4_EQabSeujbeZW} zY4qRjYgX4Ji_W<^JP~)V9<2+x{&@APlX>RbZ@&FKd%yjiny>5jtPKgB@#x#bmuC7Q zfj6V$#T<&Z^S{3RU(IUw@B4?po6oFa{=ZZ$JT$Gc;*MGQO5IQODc7%*uk`zN$NJ9F zWj?<6NT;nPvu()f zeMOD)tXH1ki7lVoZnrPwEE4u<__tA-x%}7hjd|a_e6J((j4PC-Z$pCe7|Yp0+=0 zS_pgVvo-zK9^}ll;r-j!`L&5@N>u8;p6kEs6^(yx<$AKJCBH?rc1?J)@s_`d(fLyI zD(+lU*59_)Ii|a=EW=vimRah>MtzObuMU0d%bs(5bDH(~$-fF-+zRcTE?%+Z?&lNh zVtM~2N0z zY~!n6wmJ1I%bwY7UVp5vf_a~sc1vLQy3)C8grs!wq@dairhZese8 zTHSc;q5bz=lhVT5V|Ujz+nRhh`uW=j)t7N*mfB&bcNL8K-RaRI1s>=#>8dJ!)nm9$%Q*lp^m2cH7Npa@URHJ+Vfva+2=P zGUk6berN26kC!&v@hwTpy#D_K&H6R(tpjS<%Xv3mE_`!j?-uJVr=~smtfVL3w7u-z zAD)Ysr8-UtFkQd%>cG-PnNl2wRa8{o-AI}Jf$eVU)RuWK3nbTmF#BDakYsyeiNEvZ z68-K(ne{wj^1lQRsm?v5mOtNZ6T^b*e}wy9mu`M;b~h*_<40yI-#+tIF}8B;^=)g` z%xZFo*)gTMn)3tWn(#1B=Uw;9bC|N#y2RVWs*VY5Fofd2d2e@s#Q~ zyR<78s~kQ?_q0;#+I`pZvPRpZe{j;>_H_NYucvC{G3;5;o_K_ktKFwQQM^S zf@>agO2hoM6{m(hQhTpouskiy;*QVJ!uo_2*WU)tu&8RRua$gt^yp#-J(If`Pd|H3 ztQYEgBi68dyJ}IzRPhzdPK7qPm|uSupqYI4ZBP4SW`}jI6CQDuoj=i_psHH4DWzjq z$i11|6P~8u)(&Np$lka2>ep{xp*OPj?R~*j$ZTrywpU{5_Ekky2lqPaKU~e)(0tHW z{N#4|`u^POc6@IOkMqobSF~X(Xl0A|-UEy?luoGpO+Jv(+0&n}*E{@Z9E0z*sa0(& zH+(;#*K%v?j!>g5yxHOtF0$BlDj)nO>f`k2Oh{blbcGBd+3h-qr*JkpiO5>|MDDaP zpI*heJ;jef)7ZPK`Ju|}*b~O^ z2cA1vHC<<|T%~pH&&ivX4>}6o8ZTST+cx3Y6V7#~m5t6#5zadqs$a&gc)g;w_r`fu zj>*349+u(F<*GmR9@nN<=|#3&K0dKPBEhY1+l{Vwt$f=RO~P(*o(_G( z+rV^=XOdV)n|tEUPr3rqp;KRfUhKwSJagJ?mGhfsC?|6jOk5=GcQO5^<+yt}bsirkwOcXdv;3^rZu@iNd5&0gpy(w9gLGHZo~b>3J&bjN?L8tN z_DcV#N({9*?Ql-^(v#)Ns&-Na+1&2(VFC&tX5?FJ>poki|1$d7@qY7$7vJu@broH@ zJ8L=Tj01*}lYe9`YTs--ciWa`?)22DIVE=HYA5CU8#FWXE)?+JJk#7_Au-2`Y06o? zdM8)Y)jwCv`2NlNlEijfzoeXF8-=AeMNV*cf5*-Iqt0 z;91A?uSM?ZQMWjryj65bJpcH7kOu3DwLV9#h1_7QU-5C>-4#udSGpKy9*&%oBsRQq89M8H4$vOP0m~A)vrC`w0yoIH# z#S?x`u?jU*YiKzjnf7l{fy8Ca5WRH^B$Y3+NiV!-YIDU^)Zm=z1hdO?A2&>ix@q%K z`dUE79Jgr;t})j$JL~ObJ2Y)xFz=BG!Y9t#I;Z_`op8Q$O}FW^Ij`L~tonb4%6wTr z#Z%wdB*Qt)SLj?ZpVI^t#dD>*=Da%K{b5hQuPJtW>gGRtWS6)#eIxiXHB2L+`Z00f76MG6^i!{H9hzvK3m<-;;?(gjCIMfLTeTu)ZY2&kY|qO^u|A#ciSRn zXd0h9zT)ILE-Awe&cdb46}^cnYOKJvH5uVU{xjS zwa0T_=3L6&Vz;)ZsefhngRe2_a*x^{)x4dp#+LBml$D^oj;r4f*~T5Bw^;6e&XJlQ zbBrlXpZn=q`J}Snk|!=reJT@KRC0QA@Zb9>Q3tD@e|(#{;&FDf?$eJ<@@;G#tMB9` z*Z<`6n|W@cY>%MNOm`jcR)t>-&v-BMe6fD{*K!+M!Q9*DPx36gp?c!l3<;lSCmgqk z&S{v@%D|}b;qnYy+nm^C0{g`u9W1r*VD{RW{mDS!=C{8mdJ8Sg?mU_#VsdVgkkB&5 zZ2?ZcH|DQe7xCs4uge09zpLVOmYVKw+P(OCYY>xay_sL)46YpsUo?I%z0kOC&mZOV zdH)Nao}4?qY{{vTRj$T%c5g4vyS}orB{-*}m-N@Y#0pV$k&S9KHVzXg|KZ zeu7(xT(!e21*Vuo^}e3IHL8y5*2yW{loro!o%(4)#{a9@lYhKE_eekVr+-fbzB?fpYK`}?kJL8+ac|;L&5b~$ZsD>tDkS$ zZm@BlouKLX`qxRJjzt@z{dOq!Pdop}o$2Oh7J)-)-kNMBB_GZ6F0|J3uD9tt6MQj} z?eJdi;EyM#cqMI={7~SNJwqe%d1cpzh=VE~Q8z2kg6lbb~SLq$Jft-9r(=bTXLSC{kLxbfKkb+L8R zST~5~N|~PyO@BW*clSbepPYE5e+QmiDDi*E#CO>6V&9jk>JhV;WF(&WT*^xAteden zm|^Z~zL`(vdCZ(N%V(05#2i)AA7>K_?;gJ3ZXm1oPpZk-L2OewPMOzrMNQ;&YW>JrkN+Al2@e9(M(&hu}aqT+_E}Z)2w#ZZ^l)ZSo$3;yT^|tew?hWJ@8}e+v5jBPL*)~<}$d%_h-S+MO`Z!+pcrzxJqIzU_wHKyGI!ycul0F#N4ah02y73ItW?at(k<>d z_fJ~)*RAS#W-;F;x!={U=;hy=QO(9(yV;(75!0rRm$^l^J-t|QwcOS!y3&i!rhaqw zzBmngt^&9BKljwTzG>2rn)AT2OSbS!oLAcBi{E)xF8y`Qqw|Jq<>3o|UsiW`&yNmz zT;9xCcG0=&Or*ixr`yjs{WEI)w~H|*&vuW&Potzu<~v%qbL^X_JnNW~=G)pTebpGB z@8AAt=T8!tsqmx3_teqFX&>KT;n|}7`Kf2^y63JXF+JHkJ>GBd+s*Yv@1XBLwp5=; z*7l$7^6fv}721EgE4Kf1S8D(1uH639U8Vh}yK4JSceVDP?&|G7-8I^Ox@)%obk}PC z>8{=W(_Lr#Pj_AC3MNbFfk|tlqx&D5O#>a6q|dveVVhE%iWl>fh1)0lZQ^E`F;nVE zq7lE&>}{=6b=@ajj{RSEzIW4`q*AM`j*O~ZHcKijr@x=$EMC5Q_oH|1=KsHbcs9HL zYwTq6sq5a!Z7W~8?z7kZox7T}s=sg8`MZ4CmB00J|9<-_*1ik7wsOzKcX>-s*YDBf z32sfUzxVci__Cs#R~~OZx9xAigIRy~uG_r)?1lG-CT7dM4-dF1Z=PJYUu*5@eb()% z`4#V&`8U6t`Hh8tdTV0q=f<6Drku)s`Qvw8R(-zuFP<-1v)0`I^!Z|cqqq8fzPBIa zQg@es*IvD9&Fg;aoK>4Y)-Bz{Ig3e*Px*RXR{e6@a@!w|lU`iD@c8y~Gt0@%?6qp(&})zDy;d7p|2^@3|NX-yHRXIu{7b$~zMv>=rN(+sDeUm4 z9q&KB72e;uZsn$f`L{l6#NQ}-{7%zSG=klaEo$G-6<3@(rKXCnVk=Vm-5wxPz94w+ z%87@briLEM*qQ6K?3UrxAaV0b*28)k9ji}2Qd$wwmYZxC?;o?#b!O_vCg%B-BD3o| zKGhufzbK0>uVLyVrtod&LX-2ip8V5jxG^I7Nv~1iMtkGd=rvo@MTkkrI0TPW#in@3+M`-CK0ju`+H>w^izcwz}Oa4;IHv-4OINFYH!pU6%QY zlS?-pIr-zs+vYdlu=ntA<#yGPiXp1I5iQ;vEhvAz$sa7p!?#qjj%)R_VCAC1E%T=*3zapmc*b?egi za;|vLe?oKHfy?y@j{{8>H7(e1T#==AO+_(d#g>de8zuRo9&gcWVxF3?_|S}7DmHw) zw+;rcSFh__#?AJO%kC_z`^!_Exz2~1^J694U;3Vsdd>BN@4D;h#;wnjtz*wG73(ed zbhu^Kl~4}BKN}u8u1(#x-ApTKMMmPu{o7|79}>=Sc;@)w>8n{&RO_$JWl&gq`3%41)5M$u)X#IFqzTbA$XDNvyj{TE&J$;jN0-%V!(&tfm+45@heXsIl(fBy}G+|mZ) zgymW{p3P5(49jHL^2! z%s8^6=jP`<~js06+FoKLa6&-jJJwHvFJEOF<(8^kE-3R2O?huF?KE#+bA2v* znajV;y&sArrvy&rusJ%*Kll2^SB0*80x#2?InLbPrQ&_1SWsn!bw1O6nOh$psGIR0 zVfqkx@zw>cI>zsh+|I8r=rNA2_4~x+XmaCy0fPKbxAn?;ZA3UlAsbR&sXkc zE<3aNkCgj}&rs@^Lak5bX$;a@3UsB`a8y| z@Lw-PR);otJ*d8(Q``D@U)TC<29K|k)-R3{ILbQz`B((Mu~lhTJE3k>A7nD>W1jwih1X~Z|qM^ZROLhNPeXDkXv!#XQ{Im1@hmH zluEx?`}vkv#)G{P49p&zC&Zd`$A3YW`59m^})SMr&g;Re6f4QmX`@VCr{rlK3LCt;auFq$1-;<6Ka|i zZg{vaV!X@oLeRflVfq^z59K)r1wMG(Gd%CDf8);bEsMDqZ&Wy_r1t-YQh?mfwmB?1 z9~4TbK4V*=pu&7!yG8%-rIvzKnF3S3tkz9PG~Aqfe7(x#RA0V5^BrRQV(!mZ*Q-#} znB4O)J5K63s@G1u9NWf<}R>ZJf$m;Yr$qdmMilG9}DMgzS;j*HBD*9leudGEhSd$Jl4ITt1sfT ztK4d_<>w70R_(Ev=u!RjN%GOO4-4vUnMww|YOwa@GMC)6AcEzA)cJm09=~_>)(rB| z9CZIbNW}p@xwqQ;))l_~{yE^v*AxDCo~L|pc*OH)!K32uDvGQX#ak8! zZcJSL{CMj7S3VQBJ8a!l9k9HJx!76!$%J|v9v97RCqky)_7Im`wdtn4({omp!&?3S zOy2#@d=lPxoo%l2r{MFlXUm^>2~3@`j6+s|Sw_(J_>>No-W-nzUgopwQtxWBwej+{ z3m3|nt&ZPf(qhrEp0Q$%-DV}a73;2Zh6d8cQql^op0F}sycmIl>EHD zHh{OgK61{Hsf(W+ckVvd8@MFKP{m^&$0s%UZC#5L3|X}%?fUyxCQ-gf_+(1NHyxwc ztD^mi&vZ_{zIg1ZP|wl1iau8_e4M+htd?_n^T%XarDdO8*xQ!ezHz)b`1+#l$3olX z`o7&!{W;tD`8J2;IxLgs9ZK8qvQB8fG+$Tq|Io-Z{x_@YZ%68Fn0tZi%G-JGLVLCa zw#vtU=;L{D>g`XBRi`8Pb|t+ne%rToiNOQO=0^9G)6_S`Og7eAE}67+gL~2C@ADdE zcdu+qcKji-2M)0WLDIWzHax7qcj zwQ?3l=O2h&+cV*N<$(JBX;b2C(}U9D1h&q%X;U(Lt^e zpKBGRRFAp5y{OTo{jnu z{b1p#Gj@Nk2EDp7!!rKE_UFnk?}Qfjty%NByoOuh*rPW*%)yNA?816q!mVPybzNS! zS*ntCa!i}d-}9X-Z|&LmE$!lp!h%^GmxG_JI^!MuPx7pFy?RPvi2lj=2f8;temds$ z`bp5NsM@b}`(4AAFFDzL?@<0@Nr^KmJxRwHJw7TX?76bwWoFN*x+8zgE_zKlXeJtK zW#K<*OYF`&H=k8Lnp{-T>zJKbfiqowh8P0_X%r~@}BJ^nz)2lTq zTFI`Kq*ZC>M*7Z*)Kt)3<3=E<-hUbTL6cj%UGPED3)hVipIx5XRTu8ZtCDX^zyi+fzx z^L7@Edxd_@$!Zlp*`>U9rUaafWjRyuvrwpPWl`>{^l6oIYVMRSmbz71R{u?PdwL0D zM|MKFME)v797>&Wfr-^<@ypr`Tf%3Q{jhJQ|xv-g;t zz5DCKv+d?PHP@KAY}5z}exojW|4&IhL*37H^`Fasbmy+Nc#&nObyt;nLfGL)A79=0 z_UUDpE$^+Ce*3=-7o1^sAbOdvf9QuTfQ!fsEHHT zy8i20ssR_@(!##J_9qYWSi`ojT(|Z}k!*mI;x2)+w<5LKnc5m%3_KFV#RYEeT&*C* z>{j13cPsNwzlgl&yY&<_N_KiFvCbhf3>>sLBK`pG`soi1gY+mysMOzhpm z8M1V`-~^L5yID>yY>G`U^ys~Mac#C9=WqRw_rxm#%uncU{gCi5MA4=~Gib75?=thn zB|D$Ed^J+nJ61PS*!1U~r;~(rkDcM-ac*e*t$u84{Va*=kB+4Z_%xONNIA^T%Ejh- zaT#CtjRTKNGNx-D2`vs`4eR{QCRO&cD(~i&C(-z2D~rOfua~wL|9O$a`^;B2+YftZ zPSOvx=`1?1%Iiq|zB4EOnbbUPGm<$Q6g8nK|6#}*)rsm?3ckrp>u>M$GKp0^`f^w5 zD#7Q!nIL2VuvP2k&|cT4wKr7LwWx!w$FOQu6F2}`vE(lgU7r% zww%B4<>94z4r#vAdZ}-3?Koh=sH>st7TMG0b#H^?;vaQSo+;)`JXn9t$=3bf0v^56 z^GlmmWS9@E>*YDU%OX+B{O`|=+^c{7yTGMzMn=nI-INZ^Q2j%Tw+eeQbRAXIS~AIV zsh%%mPJ?OgkE}C7o{y@H(%9U%Y7U3*G+Lg)K$d?WT31Cr$5Gs(lGrHskTf z5XZuaua@rU2onjc^Nn$FIn@+Vf6rpE(h0NRJVVK@UH*U81WhhXU6=j&))Ac^t$8iX z{!Np--`XbC*UZ;X2;kc}{iMs6`t?RLr$0YF=c|F5ag*fiJ^Okq1Qu;BO|$%A9pAC_ zb8AHPPLqz*g!x5fE^oNsEao|o@%$f?M65};IAhw$!>^Zbb8 zI_W)KZ1)z39_RH_<$f z4&Q0;$(D2a+^Q&I7G zCJFtgd)eyLXEXc9s_gX^%l{znKjY8(&3>1>>L6|a_F@(+Yk8wZA{@ zkH2A@qQ74{VrA5GtFMn4MM^A`>V+P=9y?r+)OW?@#WwAKswb6Y)6PuuTGX0xPQ5Gi zl4bDolByj2eF7(LYMgcS)jA>hFrt4m`>jiBJ$tosi~Fv-Y<;p~%U-uneG_ZARGGE@ z*$3WZ_&+^yt(kE9IciPPO<9`UI?Wq+SG_wJIiZJXvz2{tWTbwguh6wqGr` zEqQn4tXoHn^zq(%c2~AbFAu#|@OW4Cn^(c5Sr1ZIOpp9MZ~lC_S9T_EU;W!-|MlVC z=!vb5Hrf_0w9CubZXbTU?`GKYs^g)d{o#|pe$}^_ziaik zKM6DL@3X91;Qp}p@LRW(uVSm~<+S9s&)~1j`Ndq4ZBlaoYJ@>#>7%axA91&9AMC!& zeEsm}zw=hldd%Ny@ch?~waK$DxQ4%daC>&~`RxuXj@L(Yg%7+Q+?k|9gXdKcHcd4+3M#-^&GGG@arCm z^%7xGbMJ=M-aVYbl<)g(-&?-*8^zDxZ!P8jacOz%^?Qe{9tk)sc)ZT?Uc20iW%It( zKM~I?d;TP6+wWbrrn_g^Z9ns?eVcXeHs9^G<|jO&M0^TsJc6Gnt!JN>@o>Y3h*I@B zM$5_4S63=BH$Hs5g)*R> zeT}i%y0TGgMyu|oe+(+CGpkgMlna&Y6b?DWKCxYAYg_X6=f6hzR=r(S<@egu0;-?x z7O|OkNno0+R&Kqay2!R9r-Sa&nvQz}{J;Fkc#%0{m(=ok5;N^w&e^fN>rj2LE8ku0 z&5lVonPJO7!U+}8hlmF1&26Q>k;>6m)vIqWjG za&{K&y71@2#Ob0@Uv|825LmkTW_Pd4MtEj@n9S={XR`(4=| zA201Z9a_4_{$XPAlWXh(lVX&Z>Niels69JJQY!S1-}O7@*4NxGJ?DC6`1{tnrGXo) z+qGDpKdxv$z#0)JKRfuWe|zjRuQWgL8N#BBoR#lcUx(COk&%lGJG}bk-mPlvQ*=9x zDr}G1x*WNZw@YKuiQ1QsSB31@aiB5wa@kqcw^L6~ow(6ZQ0Djg#@U7P2|Hgoe*5;d zzVG89w~YDT!pq+L+`E5Etgp4cMuyM^4z72F&sf;D1m67CBcI3MP~iCSmgCWvjn`zn zwv?}4@o+)YQX7$X&F7TviAT0)?`ii`^Qb7lSO24g+qj`q<4SUAK-ekKJ?sx|ZJyyE z>U?#J>VgmF^Y?M``o*^Dw5Bp>Ty;5dG;e~QY4Yjtkb;G# zIT16oKlNTYVD3BN!G_DfgC}2m{am=)bn3>C$qIY6{r=piz5S@^dQR`DTR-G( zY2I++!=r}%jt2E5e;SU+$EZKze^+72IBiZ+{O(`-R=@sfy@heI(T}3wtat}`$Ac68 zG;%o{I?MP$J5%V!pN)y}|79GM?@ip$uv|N0>HAJWQv=5o7oC3ATjBu>9&Hn5T%E?} zB+O+$UpwqDFV~t^dGfao=Y*N=3W~h{Zl%kP2~T)KgfbskrKhf{tY5IVYgO*m1r@@L z);ycoBb#;yHHKvHn@->Hdk6c~o+Um8Yhtzt1y7k^q`hHpNfMK&%A4qYT@AT&Jw6L; z<$15HaBOZ%>b>O=hiXqP;(gEI7tqY0E~N4-GUWHN<@XwLp3hUk;pX_@t;`M;x?l=xol-~V-%-~{(f`6Dg; z0n*Ez9As9_h!EUWeD}%34Q?BR7)3%BG97sB-uB@4*>!4PrRE?1>)miOT8zo< zH;?9a|9qKSx-L4eBW5KxhM$PKG`H`A`aRwc{I_MA?zMLw`M%mN=BLx9g;F80wusoND&_8FOIk?4C(H){mDS6bdp=ja}Ha zbnR(Y+cysrm!D6x+S2juOv&-~YgJDSjpD<~ewklU)Y91?DZNSOfK80khXC&h98zv~ zmoI+zSlaEyHJ8cL^83E-l4q1i@{VJEyLiEu!s+f?%=GG?*UP`jeLsCpQ@-KyA4RYH z4@6J$s7v}2vnox$sCicK%9zvQOvTe*JNY&KysoKyplQ{%3tPFZ{`A=d)Ytre^*p>o zpi7!Dx8&X4U4aX(vu6Bx`|#>+`R>`WHY`rhxE{Q6&#KxXs5L##xv>88-PQH!%co!1 z{4pv1gK5<9yJeQkg6nrO>~`{;&b@YB@5;}Yx_?dxHsZ16oWJ{p=Vs2J8!;B_A==7M z@2hCUKXcVg@KAK}w->ooXlM{l~>jJXT%xyt%UvKLu5{82A^xNxzHwdD!XSIckBk6_VI@Y^X+{bJgowT<_L7_8GT z&0^zmzhq+c>(zoLo@w!(_6fEbahGzdZ$&l)3N6t{u?t9=9T7cOTQPn2E8bVS$K4K1 zT3w|7=jc19537rJPRMahGMkva@?gDv9G^mQI=gYeKi1q$89$R7#o5^8#g0vU(&qj< zBYC0f0Xe-Dxk1w!3=;OKk^r@0&Zx?Wg?bD@VK(-lyEyar{{y`{FxOic=+Jf+7^cc^z~%wO=UH;WDsg>X&nO z5Hd`EB>g_*r}FfGpDNFmBd{BKgO>WTc1OEUBv#CH^0B)HDF zb-mMe&&1aAQ)6d*J)@m4eakj8{d&fmygxqfynS>QCx2B;vzQg?8 z&Z?9i$0IL|ZdJUoZ1N8I=U8)axn(u4nb!VIZ%qoehh5((ol;}ClxNm9*QiGA?;@#e zdPes??@^0me#&@iTlJTK$CJP3&iM7gaQ60?gJ!z5dp<7+7LT5(u=d*G#>?++|4w+y zP(OLXgXL@rPq#OoYtCfnz4!4^Mq{1ug*1bSvmCxYF!qf~eY0QMas9ks?{_He> zi>gG5*O)3#XTPZH8aM5*+yqUFInta02cNFua9UecKY7M}c7-KhHfOL|-P^%>_F2=i zmfYMI-d=&{zCH@F@ID~YkoNQguhvQX1G5ztH5#Ptdl)`Jp(jVR`n;F@!KQzlIvMOb zGsKQBDD_emdzHQNxNnV|l6Bq{IlZW8k*6Q`+-+lXwh?&jawzToBIfBXo*ajkUT8nN zS5Vk8Lr*<*nL~Yov7qCkCs*St?$^sP?QZM!(BTn`6ZlzrweaUh`+o|j0`7$WT_`DK zuE=nvaQBqmYkeOz-}!O>-pVfT`4YZQ@4d|K<}^Dc;qGu%D&5p1{_$MF-3RE+^|l=n=3#1)Q7%Nz8JUp+pAZ0 zJ0jaE-ppI1aB;Pt{`tSAFWzz|{(13UIbZzO?+sZm-yhyJbANx}dx}^hSBB`aB|Ehp*z`Vr?qL>icrD4EGkMpwb0u$U6~fOuhu7>( z&%YqRePq|J^y_x_H?nHGWluj`zw*n$dmCQOOr5K8SX9fy$w&Bs4Z98-`@DX>JsSfH zPX1iVeBNKC!h#`5L(h1g*RQo|7kjP;&xxCnTE`N8Zn6TGv6`cZ+LHJgie-T=KdO`& zH%{9yZJSQQbrw^%m29T1DK$|_kD`^c_U9SAlrZ;<;$)aTk11S9|5VY*n5uh8N%aQ* z0z_P^R$S^^mUGHG#l5=X>EwASiF3uH&M2o#CwIN!e>>4sLRToS-j>DD^4ZhJyV`m+ z85neq9#Xl)`9NIINKO1pvHd5Bu$fNJ4f~GRG#pjiW4X@UYFhB?T!uu3vRexlu6g@> zr~bp+o9eyR?PH!1ZFjmqQy_YEk!Z~7OV60<6`Gktbs0?evc&Y)idI_Qsuxdw#dJVZ z;P62%#s`&*JLIag97H*aMPq*JGhf&Ip}JP~`|w1C=rnbX(7#grMQ^R?<)*gJqV6~g+gv!@dj*Wd$3?EVgI@Ec&&a$=EO><;C z!ClKKUeD&bGb>=ql!(W*39mhErpKxsDh!D^^2h37*dCvz;+Y?I@tEk98ysMMeCmAB z`q=11V~?=tTW|bj>K{*7ed8YD`P~9PaRZ+*x@-PV$e(WS>c$T~BUt98mE%x8Pn<9!qNUNsHKhp1bD?w9Yth z+U#L%r?Pg&rVsu}$^rF(OC_eKD0eTMJ1>(ZKszIJ{qHW56Rk{FW?a<@f0U(T;Pu6{ zRIEB^))#k=26vSuU2o36zkE<9v;F;#2|-GWB(_{Nsnlqw-NCe{OG19Je4LKMKa(!M zmHZsF7VRn$S*4~Geh&pzwHJ9fP7u8&x60mZ%1pD)%j|&@9j54&H&|Y*7hJjY2h)`) z&$!oK*{sAU}@rR{Y%g=bx1-kGH-(`{Wvr4^}tI z4V2Z_E0{MczWQ`*ik|+`D$do%=hc(S;5m(V&pHW3w=Ag&63qw zR9M(@p30`!YQCRYMrr$7D{l8mv#8%|W#-M1)SiE`zv^7SxBIfFh#nKkC30Gf++GZu zmp{0y;cDE$d?&HWR;kx>|5fFhQ;+wpd|bOHsB7x%w4CIx+fp5lXa+|VKbfp>Zmle9 z{f&o84We~*M^^J@3rv>dwvIHjxpFBe>CKm)ch)=jpU^)1%;xHZDUX)DoDy;%WS++YU=_7r6Mh{zj_S)OiOI4Q7Wg@()x!(-hGE z+jz16o|R2`9f=#NF7LZ9v&!zv*6d%wt$A-knq)LK^i2&^Wb!#0qif~uYT?U!Pg$qE zW5=lt)h)eRPc|pVW-&$7zrDi|`G3!+530iMjJp{Z8Z1)yqN1Q`_jUO%gHrVidn}Gk z59&-^cW_mc?d*E*#p}{@I%axVs?=I#@y!eWr}g%C-rJp z+8R%peGbMPj*9 zJ$bNb)}^)!%^tVDNnKIjuzr&Ahe&=gD?^4A>eqbNuamxTcuKIVj7!JD$W5htZMVj5 zII+MkMfQttiQg=R$hT1oxOM1{<}sCUZ*x^&ciqM#qKeG7PDqa6Z`J@tQJ;EK}>gksY+^| z`D|CkIVq)N!=q!ij&7F9$t8w1$2tNpJ-V9^*Z6_k`gM1t*W_OF%+H}-a$-BL86?*q zd7Hh7Avl25Bz!~bnXe+jFHYzlIT#|sXPe2e;n3Nd8O54ujC+-2&xXESaNOZo>CXl0 zInD%~JGA7Wmw=I_Mpd`_`&ap985WH?n?G-~EbL5_epk8gy?ip4xrFxFY9Be?e>#@? z?v?pI_*@_-v%tDXX?h|5Bnhi|rk!jP<<6!3uXjGby`Af^?oIzG^BKNhUC-;Nyn3_w zTg^Sf%`;h_b6;xQbs_XuhUVhB34-456|S}3;k23=I(M=BBssB%e^{nRI&G=7ooF5+ z|LK#Ob?wuJwOx6UIxaP8cZ{rkKYZj+{c~fN>-GDFQ=G$d+$S(kw|-G}cB9qOgPM%C zLQ@}ZVV@;gUp%3!RPXTAbsbVCxHN6rc3y6_iDFLvC)A_6_~=p{@ns5febZ02h-5t5 zud<{3;UR&~iU%)wK2><2ey(Uex6S3URlAubd)D;JaP$;C{M^GJe_7}-C+GaV?^jiP zv6hJWGGpVeeHN=5OxGA}xcOi%|1vF`oOLp$v*q7i{FuXktzW(VdQ-l_(#?s#`{wP@ zkBd1sWfs@cdCw2T*=bGsyXJA9^2hz76R!w3bTrXLVo9(m5*p-_X!DUj5kQ;^woei_WSpyXTiRY;oJY+^`UzY zH9R^kX&@RXz!JCo&-P808grlWF?~tC$GXp&9){J3Ni*2p)BIJe z?b9cBSM1ZQ+exolSl-kRLtmlJZS&gOe*1L$3YV?|aW@-hBS`!OfT6 zu*G}c<#oR^HS))?jcm@sop0p*kKL-$x%xD&J5^`ux%7?%mBiUZqxkO6}qNA@ot!PF}{E6;@Jn+&Ux-2^4y*MXnNwQN-=4M#-EXWETsna zIX;&k9+VzqUw^J_^m(rmNscg zADeu%lLS*Meol!H+5C`irE+=2FR|N&HCcD2tL3q3@D$3_?~498f9p$b<=KaQFKtiv zd9scB_UwPbiN^mLoqp-tZ=2lQpL~Ax#eIf{Ply;E?(jAhPn&ma-s^(q$E7A-ANu}# zF4EX+{403Y*DFO+(!aE8{J78c!SHS4=|9UEb}iX2`R0Xxt%g8bVW`B?cYbr`vFZN% zQGBj-r}-bJNo@g|ZGS}S_p^LE79xJJ_J^|K)T{08|0Zwpf5_jN@<(2zLgJrGPuz|B z*UMv%etr9Mi;$gq@NF+oCw`xsZ)P7iy!{Tn5%IfTs!vJp@Qm!A2M^nyyu-?VFvRt^HplG!%>EnQ+~NE3rf01+iL>qOUt^|x9MHJ(daf&Oz(Mm{kxBX4Oh55W{d4? z4i`AU&od!EVc{Jyi}}lE8cR>l(&d(}?2KZ_4PEuAX7kyg`KP1Y8Kd8wS~~Nq^yFP< zi~0Y)b^Z2*vZ!Ng3@7>b*dD(#DN6}fGtE~s+*Gv9T zPd#(_?DLgd^EO}A3uSz6)zofNe|0Ip`VUV{QR`)XTlEu;?|kt0!i(* zezhQ=nZ2~klg&JS&%Vm)<{4qqdoQl@S-Wxeos}lRN7Kr8{k*>aY8wCK`r9k6Ogs8a zwsD@of4}J$a?ID~{X2MM*S($BGvf~IUgPJhSpMOeW{|gqLO`=ucaqzx+O8``UmMQU ziw6ByZ!*Za8Sippf0xcX<&Z?i^nc-jt=%#QmZlm8{!`p!$-XA)LF=wdYbC3EW5l-Y zW0=Lcrh+flY?G|QPn-X9U!1S&`PXCIGUtBtzn~9T;UF7q8rRM3cuK$+o zxg_@Q)z#+NYZ)~rGiplC*V5+RlYMLkkD1w5*TQ<&-P$_OR-TuM-`nrC`l?;GhfaG_$jtu!ETxs_w@0Vv6qRRxdNT2L{2tk$JVhq&L-M7C z%P;Q;v-rr#vqR_QYhArvH>Wuia%pg>Ecsl-d-(8MvFW#ZH>Lfqh`zxhw>2!TtM}u+ zV{P7LcO?%VtIsn3bY@|D8uMa7&o_-_clDq8?0h`i575V+3j2}(AtwH zx3cZ_TEDi_EAM?iP!ZqDxZ|b#tj`Db)*j#g+;5rmzCNjZ$Gn;KPcCN_KAN}oYU>?k zleUMS^Z)mpwMpc9aqD>S-N$>S=a$$ypXD$6kaGS*qC1ne4wFa3T21v01v|F&&h$@x z)%9}OJ(mLRPe=Wm${N{fQu{kLZ&=IBe_`ha!w~hES+74A?qN^6$ffswz3iixa|@b| zOGmxm{_M8{kHzFb^K`zDAHV9;9)!hj7v1RPx5g>ixwtALyK=+L>!G)KDkl1gp4|72 zQOYcURc)u+m3?-l&lBIQ-Y6H~meOQ3yK<+V#H-b{#S=4ajQ!-~tLrp--(^31^11H8 z&mTqQHMdLFw@wq~nk*n2>-S^2t}sj z8G2~H!|(4kj_L2rwp&enHvOz&YQ);gCk;W1_dM%iUQ@x}iTAJ%e<%Zq?vFo8R}koco*CyZWEf^FMCg zbl;W#<<@$os!h|Ue$D<7k-;3o{9>{Lvuc!1)Q8v({z|pkOB~D&&7WDhuy|eeH09Jo zhd5ZXOg%1t;J;gAch{z;NA`ag$3%ARm)mk>uZpht=a4IGKmD@Xk!_l;caobkgdJ}^ zyVCPXO1S;Y2yu?{uw_w zPHkjN5L<3EuShF#@*19JLN6BWUij|jr-|)hY<7GL8vnmpIq?T;ZKYV5XMOUuKaOmN zJ3iMt^khu-@iE;k+aX_K8{=d!Es&*O-a5_xm-KYGHLB))c zT3fEQ2M;jEc*nn=J$DXs+cYYJBO z8W;BO{#LYV=lN2H1}m-I;UeN67N=4%Jm zKbp67(eV%8CRJYeQf&A0QSK?;E)~g6l}PsGyYfAn4#aG|Z{8uiME%YEgBRKIE-g)1 z%-zem`a;?ozkQtb1s_D;>k9O>JZpW%cvIxdfr$y_i*B-M$i1`@V7egxdBuYX%k~%@ z3zw+ACKaz9;kC8Pd9Sk2-UqyoAN`KXo6$cl@yjnQt}8v7w^unPM+5{mNBA7kbul_{ zz(#cEkSkcOuOqOZiPO$y7f+*_kr7=B`>S>gw%i3V95$>xgufc z65QG;Gq+HMN1#=-e7%WL?^!DgciA52MO&Z!y|#6a`x6(RsqGcYk};JB*oiRGQ(cbAy-^2&ErR!_ESwNzw@Fv--iQDdIJ&n9#8&po?;vj5>Oj;?%O z_A!WWezn3}qr+DoB}Uz_j&QE8cy)Sue4>UzagI&~uh=90q_+<>j;?=DzUiCNP9fIp z8#PA7^Or5~inx(3Jy%lU#iwS?1|`84*iv!P|_|=sU4Ee23 zxW3nVkTZMLq6kl|)#45sD-CSk2PI6Ox+LoDsioHv)6$CaT+Xk*5I-StVOqb?$NH#` z=N}e{8T(Jr)8SekaAFbHk_CK)-YHvxwzx?u-A%0&eHoXyc*Dz_6d5Jw^-0|vbb2v1v6o<(5{PbZ;e(@mY!ox=0iMxU{W*5|(e&4lwW7fGu@%DYzh2B#Z zP5RV$){K4Q)_ea_6*@c5y?(+cze`N^zL3r-gYN-fudZbC&ibKTF>{sAzq+0FpRWYS ztJ|v;Jx!=z8D%f~N3WOU{P9>5ObSTF+@akL!>3uB`R8Gj{U3 z{Jm>g;Qk~mQ0@Go$Lgt{ZajLW)%NmWci_hBjZ=-%m;95coa*^kWX2a)!3<`WF8%cd zHXA=`sXx%!?eJmuzO53QryWp>EX=Krm0deS{{`#qAUTo!K`%r7Bv<4Y@`W#zjQ!IPG zYG3|@o;?+perQh;p8ZE=*QJL)bo~P+Ew@bK5Hsy#mY&|@%O~Z!+2?*q?cK90!+hQ{ zc20i%=3&~Zu%t;D+6T@m+7-$Oc#80sE7c1>d6L-e^X2PO*K4iX%a?S0eRFy;H^{tcofy{?>nI<@rGWUAwZg4VRv*+TN$n zCsu!SN7RJmb>ds{8E3~QSG;)sY)`6F)r_W}6039i&em0LFJY9cRBPd2FiyVCZ=>;h zxj@?AdL3mS!-_j43q|i7-T17hm~kCT`{xXq?H#=iZ8!dXyee*gB>9kNYtp@djMpCb zcyHWa&~UtMM#H2ax7IZkGi(0cef>7wW}6+aEmu+h`|ifof6eCkbJT4NE_h|je$Ay% zMl*haN7j=@y~>tcw$>=-4F{hw@$f5WoLqIkxPRmS#y$1#YLqMAxE1M7i?+LO^gS(b zfpAe|(UNxeIyDxzWbWn#Z^UD^O|N+uao1GWOGz*GqD;*(O}iDxjyyE*`ZZnY#0&RN z{O+#5-7BwidUHtR9XuCka)&wlz_){Qrk-}_$g zc=bHFCsU@ZwC8g074JHGT41l7TK0q`6&D$fEfuy=Q9CyC@bcxW>YG*TMR#7|U~u?b z*RFX)^8&wf;}@@)p;O&b1_&hA&8ry6l2BqjG4 z^Gp9=FFqmFF46xYyZS{oEVZ2#pvJn{cJIDfO26C={a-dG(Msf$42S8`6R*X5{>}I+ zTEAIq?c`Z<;#_qx+Z^~(g-w;&6kg;pHaIuf&J;3`Ny_I<<({X1qG@i+oQR1vU;p;s z&SLio<(~d{fyZ^nO-V9A@wVU22&ykG+oZI74QHC2hJKr_*Qd6Y6B^BmiX383n{5O? z>8x>G2Gp9W1)DcZboM#`->^wAC@NtD4Z;M@~m(1 zxgRkrwsdT)xT-K=(`1f9#YD#BKd&bRn|=x^Q8h4deI2Ti5R|9-oo{=DqJ|fT`c9#a z7OOJG)qxM|>r>>m#RRknKGXefeQ|-h*ymQi`TNdVLSW_e~%k^zL8?#O%ctL6Fdc&onLAU$@dzV*sFs<%7 zbDVp(+Jv{V7s~IN-#uJ=)aW|fMxI&kkDo8;^xZLgo76L*_|Ta8P_uaxxOgO(6=vE$ z6npJtAnhm17I?uSHMOCPO{n&8h`;ZoKb4jjS+|u>x2w=i++{7l`+4a;UC;Ohi8KGq zPto!UlQO&VF5xlLiPzh6c5ISjiT{mRoia{7*IKpDq{MoBx7>PS-?oER%Z=X#Iz4GK@4TuLGu@|+t?cB2 zwoC_|81s8J-?UEJ1#)s;Umf2rKTX?8C+F!G!>E-rlXvngcD^gO?evz_4)IR)oMO%0 zZ7-wFbtl{Pdh2mVdvF;%nl%4M;>XTkS*L@RW<6P3E~?M|Ju>T<;9e``pPHC_zOR)T&zv-$cP2BrhS`c`1$743CaF*3 z{-9CcbL4^3t8_m53h9N}n{t>ensKv(Q|Ru?h1*4JZWk_Uw?7! zj-3))Br@f=*38*=DqcFYKv4O z16;Y|j?TFeTgBHj`D|WOzDK-F*7f?y6-|5}-mY7g(04?K=jzo>`?KCWI?eEcLFiR& zMYO5k`(F1Cvp(FNSQCF_qQ;sDKOQXCa^+Bc@mim`;Kjm1oRa23of*vi)%F47vJ&_t9u^)<@T+q8?Sz!wk;^Q_3e#gh8vF?6s8$f25gwLq4^+diuuj> z{r3eqRIW%&Q1r}QD$^bof93hVxtF)7KK9vg!cfp~rRC%%&DLcpw=|Z05Palpcvv^M zt<@|^DaC2Q+7FtgA;J-B)}(OFkBV6KF>}#`%+oDLXZIed7g{`1@CJ*%X`82>a+{uJ z%83mjUTZchPWGBHOVw*i0^b#vHe>clJ2sz5Mcm-Y)H%PgA3AM+-%yj#fBcJzj$lo;nCr>GAT_!>FY zQ+t=lw7T#e;oJ1GUPG$na*3-hYi8FJ8{WW)Rjlf&T&~(OF9fVq=hX*$3w&Kt?|a0H z{g$c50fuKUro{A?N)@*@+p*ki>NwEivGT!@ZEC*-16mgB+@P|?So5bs_=K$<99+7O zRC;`T4^%klb{-bks+BwO>&z0?dy8b=GIlfEJ+gG^_T?oJi=rLx9-1^)>Jq2q=CUn( zW^7tctjS?p%su;6l0^2Np6DuFf9tO67G>MXPkdNr3m%b=y5j!+$p$vTOLmiNlvS!! zJf*+6=>}K-+atDRznzNCjy`*}tq&?L$gBVT*r93h*jIOlr(5&+!+u6h>C0r#K3OL% z&%1BKb{SbUqxMN}BD)V8RD~aoZj0b!yL5B^zgc+&UDG!`KOb4ZRqyM5foJB-Z3*>> zWw%=1+}XmZ&#{?v!?HEvXFjZ%9b%t5+401dUfbr^4;NhaI`&5QhLvTiqxDatwD(3u zd;WOEC0VRFXUMVR_Z`o+ocC{jO`2OP)pKm|xedP!(k?EX^7}^lj3bZVEvOgj7v5I> z$=~yvK5J7~m&O0dpX(pUKQm=7*Ip(vqv~U7&9!=|WJlc{yYh@C_L@yDtP$@|UdELo zcXY8zs9!Q z$!xPq>`vMHWAoi6>@QI{nrh$Q|EzvZ=}vW)Nn4+vtMA!3Iewn4?@EvRZhJ3ZE0OD6 zDU$zb$|KIG`udCSdEV{%+t0J++v~r9=C4<o%ftGj#I);8$1L8J zT7Ug_Jnqnfh1V>0*7thw+`1qmtQ%AzI`WCx{8S_qZTOQTnQJOy?Qpfe(!WyHeKCe}sSZi(^ zZ|(A&@c1Lw!&e1?J8tDM+ZQ#REDU*IqTXw{oOMEDkI_u79iJCJTALBGjAg!C&h-C# zSkHK__gberado+SUYx7H+TCd?x#p9$lvZBayJ5|QZI(-dE*3?6^O?Dv;riO}=7+ZR zi{95ye)zCm@zCFTw!{0spFT0+IA05^R0Q8<4}oHXY_WrV4cg4>-&8UsU)lU-`uS(e zb61NmH2u2srS##9h3QxOuUR!;aH{58m)E#YQ~rjg|IhFL8n?*%Gd`;f-CaGuhcA!q zd*S{mA(k`EZTCw)sGnDV|7UmiMmN6r_TYP+c(%~9lFIKfzizDB%wL%AvR3VJdrXkq%u-&tP1jUT^YoolIlN8& z(Rtem|9^k<{r7Rt-0FS&N$R3t$xKh`IF#Y-Kaw*dyl=kc3tpW<`;V& ziQJ;eHE;Tk9bTWazRtX2zQVc~-uDyo9iLXuJoP>Ee|vjek-yPHm-vFB*`Im^7$XBh z|BDGo?yKHD@5Ig%-E*F^`bj=^d7xTpEwxNY_G+<4tm8fIKh>(|p4VG0PC1u1iBaT1 zs_CoeleAnmATd*Jn{rZMX`r+p=Db(X=ehQ(v)cOKfXatLAPuQ%yP7 ztxEe+e{7UFI&JY$neCg*6+M=8nCbIASAAq;a(aT!?=$yI9k=k@zUIDl>d~iFCxm9r z-}u*aV{NGBHl3_9%B?*SCu|S0)K3l6s0q#Amv=HedmcwvpZSIZFOT(BH?NqmRd;iZ z^w*e(RnMKGZROT>J^QyJc0!olvGds$^@t2d`j?Q z52qLJy9^#IDcohUqI16Lh3zgg7DY~-lKB6>;IfRqY?qve`?L>XZ{A1sBej=zIRLbn;{0^SLs+ ztgW~YZP|S1)WO98n?$Na??1el?C1CMv`OWiPj}^4RvgoqqPuzf&8ys^V(%1J8eKZ@ z{(By~?XSKz)5jl|KaqQJxic}Z{gHs*IlBZm<98cYi&Y=q*D~$z*5yy?5B`4lL;MC~ z?WXA`H_ZR?@78e-W4SUr!^uVZZSGM850akRIDKn|>ZQ*UI$E zi{E-H{XEycy=AeZAQM_4AAEj;u%H!R=p=+m30 zudly7b)|uvmX?L%ucD-Ng@!2t~`B`yscg*^< zZf*Q*F?sXUH#;ucRA1c}d%AC{_U*zl=QM4GT?Z~?9git9dUo1xTRBhIq=Q$c=LgH( zU-q%Kg%PJciB%;!P95e)Ad zCk1eXp3spQQ%>*#lxSz$GQwc8&3_}hwa<;2xbpIpqj#HngAb-k;p|Qzfa+NAg{rzbvb@RQaGp|d3zwWcjew}F2 znU~^yv9JDpC{yb1S2Z?ouJ6sNuCm%Q>ud93t8Wd{>)oaD{n^aVw=e$OEqVS;==$`- zr?=PMvbjF5xOcme6u+r}if!?o-_Pw|o>^I~_&w?SgSWRQ?`JEj3V!m9ugs5cn{m(iT8`xdO`eRxcYo4v{JZT};&E8h!^i|@!>nYB;6uDzeX|6BZD(;3grQtwTEyEpy( zf29*YeJ5JiZ2X^B|NdjVlhI)&^GQBytCwVl>Q87@e4F!eRn7S&DOF3hy`Ja0^{wPK z{*9r1I0*upQ*KA2Kb`m1-s%kyg6oo{J>wUMop zoXgi=E}zUlqwDO~`k$>Qq<`y#hA1Z|hX%LXPkFuMd+_C$!)#Bia@^|I?W!|w%9;P& zcW>Lm3060^-rzCkQd7OIn-jq1e2y_ZbMn>S;q(8Q+D!F*7prA<<@344C%?XY{jf(O zQr5QCZ3h4TbHDbRpWuw`V|#vJo`C8;-;>^tQmd|hEU2orwv_d|IrY)9!w+v}9B67Z z)Z3~1gZJX9wKF_)`W!Av)@*I-jjdP7N!+Z!wN|)jYEM>(_Lg6Xa}II&9kVs?d;KvZ zF^Yq`hPSa({FB|;7$ceAvOihpt%y>uXl+pNQvG9h-RX zM6FTPKev{Xn|jSJoVnMl&8z%nUXA$k(3czd^<-J!@BR^y(bcrH)Ar2!&tJB$I6Uot z{oe1=t_9J8=To+w5c(^Yd41YE5xLyJKkbw5$+(98|9|&4dzIE!SE--(R9*K(Zwys) z{&cxqF|Reo%iE{!^q0k}w|o2+{+?s6>AqLwd9LD{&n&tV&$QZ1O8TMObz`gRZnilO zc&3Wnyz<#m(xmys*Nklf;k$ksRVM0b3dH1bi9M)Kd9UiX`bX*>$t{~rroRvky5%(I zMFaEoxkgv^NA36TJkTXJDRZ{pKJgcSUcA%1p7(vrvTe6*KDs~s)aPlX@ zFDpv<3L{7G3Eq0iMV>4{8!G}l({3d^H%w5DV_x!^?e_Dx6^kVcMHN`t?rtf5v$gf< ztW67Mmqui4)sb|HQ%sraJ#puz@CP2TRmzSFYFX?IV$}7^Gx=3@yGs{xb67?x3O$h$ zu({abxA54?t=Aeal_*UJWsc45wVLZEbLqiG*Yykv%@2JoCNbQq&)agtYeK4wuJ2+I zjrUpn0ZUXkDvpHBeby|paZ9OBrTUqcRUb+!lrL2_BuKOhI9#$a{I$o(+2CN4u48Fu zMjgk)u+HDcshpd=JuOa`Bx|)EXfYFbmJzvvC0)zYDx14gMQY-Oh!aacuQ?ZSyRvQO zq_!2=Q(0q7i$yiKe*~a~{~PB6;4a4Nec`b z!D*V4V7H{CY5J5L-Y{>j$5Hm7(Wj$&yNV^Io3mP;Gv#e{{WfW$R_X!`?_EiHSNhvm-PmGs%VDKRDvydz+g>@n zk8--)(w(-SZmyYV>tb6GF*{+wss|gE*wkOrvK8Mc;UVzS;7smX9>$27=eRfIeReZ_ zklG`vx4X))*L(h#n)j-5t1Uda8LYSUbk8ajW108;dE^}~>xISMMjIOq~0w;#LJlHM0JaKwLTBf?7nvzCDc~JKb%Y<2*4|W>ppS)VR&NM)x zaSBg;VBp8d*xv>@_m-9{Sth?oC($kJ_@%gO4<`z|mYI^D(ypWxcJSDz#MJfS&O4H) zlx^F!ReX7~0qZ`+u6P~itc<%a8p9NJ9&A$JW$Ev5b-VTO8tW16H(UX-&pXa08!gc7 zS@JmV(WLg~;Ay$1A{muzR@}7Fp20s|CralF_Y#?D(3|X`JSN#xiQC)w-FeHaL z`#jUJu!&!1U4C;-GD7sY&Q`ZVi5Dif>ksePxLr_W&VmO@zw?SdZCv5Mp;hy>^9}6- zJSnlJ^QSyLWT3pH?dQi*j9XlJ`=mk`zgNpJ{Fv3*-;*TGdp-P%RrFzwL*2iY zE^gY<9>H=@EH+EAp3_u2=DbjH#Jq^tEZ^Losz{z+w(=Q+XHL1%nykYyLQWHsC4Vf? zJH?u+V|}woqV?a01fAb8M~aT``Shl16Z-?(J-nymx_Qs6m#Q%fJH+~J`b(S5(Gn5v zD&KC4Zq`#+wLbFN4iO`ku!oOyB-mq?=&_SS3%Udexlh7F%Dj)Q7Vp z+HC zd319>E5i}NzU>T+{(;ksB5z8Y#ozy2;5{kw+kx=YZNJ()RhG`{?wc(vxAjf_;otRt z>V-bk&oQ`ivhWSt>MzDi4``lVVf%URVgtRUsw&6V%|F+-<*cD-AFER2S;+-GCnrcct#kjut#@@z&*7w4y^{s2!kV8u>`^(EwbxaPZBFyl zMR`AVOi4}&%lmFHf2NJ#iW4)6_VjGzl3Nnm>0NIe-&$R$A)+4gq~WSejI>P7X~q4i z*N<3~9c0>_EW~jAjf~1{_uUNEja&G>@Z8E+^0c%?YmWA(H}%T7Y$xVbUlc0d*Y&2m z{nG~-XPuWmdL@aLF$=rif4+Qwqg8=+updi-T2!Q%Y3GF-ySEBxrmT3F*m$W!d%@hb zDqapVBQ|@~Z?uo!{DIR?Owz2(KlYSZ)aK>QG7IM|*AOaJ+LZi4Vp{q}-K%q_aIcC8 zJMm#+hkDeVq_z{QZda|yklq;FePhbc43&^Haf!z^`+^_6Fg3dEzR*yIRgW+xC@6PEnAJ;4Mu85noo-a+U@LAlk zfE|kxR&3zT%ztoQruV?ZDW$13_dE?Z?NHA;Hl^T3==5KAcklI|nJ8v`X2*^bD|x4A z-uEuJb#4=**qZEff$ZC!%~A51l^mnHY~#snW~OZAb=pT~+DlG}?Y25MmuK6~GmB0v zbXsK@^5E#yXDch!W4vq>f7grOnl?pq}YkSZt9`pDcZV+*4k{A z&`-{JlC$%<&(;sSUx=Hjny^ZR;F=4@XQd3txt)Ll!K&YsQDsIpY0=%eku zyP5HkOV2!-zS_h4lx4_ml}F*9&u_|z)OVjIdDCe1oa&!iPZn;v`SjkYoNZ52+NRXc zY;j5mT+~!jVrhOhe7j12_iD}>q1QJgSk9TAUdv@S`Ak7dT;+0AlZBO%Rp(}3Un662 zHP-CpSr5;)t5w||3wQQUlzJ0&@cjZW$p_NQKJ9BwO|uL7mAm%lxm#_apXcf1#+*;) z?u;zfKCa4H{;6aI(-rHiNu7Duch!{~dzk&fq5ep!;Qc8@73X%EYsyy3blW|)3_e`? z^7l-m!#ZATLi!F=e`uR)bZ3=k(V>rP=O!vP?T9F2%8Wnx^o;hWM9t{8ZtIQaNPLQE z%ZdEXR$zAcn8f+(lXZ^&yqX=b!_oT8_T61=TefVz&^^uP!J@r$wBODW&e@S&Qkkvl zXq0kpH%E6*eQNTV@K={!|6Io|DYY|qqQCMNo1-_UcIaIFdpGsm@2NA-{q~17e&S}I zi#6B0BGX$`d0geN<-5 z>tsD$aml{aby4&0uD5?z+>fhz|CI6c6ULV!Z zW6JD4Ynqv(Cpz4fChnvKVpm7Xt{SX8=`@9(M^Z+A$# zv)%h-p|fVn^_^Nv`xEzNuL%xXe1zjZvnt!El^VM9SZ=C*yP0YeCH-gT)O!1=6Q&*c zXmWmb|J1ses>fb)Lw_ZSeCKT4@$dIuyUBI`|2??7`fa_9WzC;o&QZTjzbMQ8>KFR= zpdd{OpwNmbO_F#T1BU!|6Y>|MupHM2B~clG(Jm8F5PHM@68#Dy-- ziir&izgk)v?7J${bame9^|?kZz9$McRR4H)H(ISZ-k){$59_i&ty1+#-#>>Kl&XuS z{oj{YuRPhz@ma?2qrV?d@9}B>uxrM|z>~H--l031m-f$GX?@i=>CNY?^;Rd|)VlK6 zsfo=G$zQeo>h4#yUmI`y?Ubmivfa0D(Wg&E2hOA)P+^+ye)ak5+ng>7bveQpuU7Ot zY&zBa>e&LLU3RPgrCglBxBtS9moKzAPrgYql4;tdq8Goae*M+@w#jA-7vE~Rusi== z{f#=mmV1@!U-6kHel%B{_g{?fDx3*nz`T1RF-#Y6TIo?LnSJx`Z^`D!*m1Wik zyPRJ?mtNgE!=^s}*Lm%K+MFfzv-TIN@AqR%UwrxCj8|8`Oxs~59UDKlcbWO)gWFvX z=ls~ZcJ-p0EqC<4&)a|ZXT8G{yF0IywqK0gkS)Dm`Np$(QI;?KCcU4)Bft5JSrB)n zs;lXN&rL0#nI>GI8vrIp-{ds$zmEk5`o=gZGxiyw^yC26(?%fbKOZrPlg~68)^{Rl&zn9F2-*hxL zzZtmpg{@+}u$(L*DKb0yB`N>A?%Id^=!`|f-rJ=vy}Z}v_-w|C>lyZ0^^O3&^! zIkWn@zP;RD#hkv~F6XYD)m&YFO5%*H$ozL91|OK`^Bv#p_>HanX3!z^JNqwd|MA#l zWwCcI@9Kl9bL&sOeDJC#Wjjx&S2^piY!l19d;i$T)x~~NJ@0n-WP#PJb8}BUyei4} z{lod&2PNdx{`KCtC{w#|MY2t~g}7e&Vjg|=<-$yR-_)Ab1wB-DoY+v(>$FqyzTZjv zzn{NVnc4g{d3Nz^x6cFfm42&EzIZh!_U7q{37ZSDp4T~_-ul{xcs z!*{=h)t&pzomTHUx=L*MRn9b@@Hd(JsaR{y4CPzLvW;{9{JOdRxBCI@68G;-)35P2 zg}<;9XK#s|W;e}3p^{O)c}Zr}r>(so+^njq%kzKR#yo#~wRBm}W^O+D_4-2#{jca9nd$!4^#q?;-#(sWhgV-tEVbOFR9#eQJ+HSu z@7VoSs~=h(zikv9(G)vbVUFppK&>LGtb9!?>-twT$uds$>iDAyx$s~!sOo@s7%tVk9=~%+UQBPY1y_l zxs!61#KhNG+`M0ZNX7I1;uD9LK7RFn*0rlH#_t60P0)O5u*hK1a@Ve(pQE^U9Q!vl z^J(bjuen!KUiQ{+d42D)dA{Ad=2hx*1EmA6J}3_R7qVDkRgmtYN2MRJ6NT;F|J zo67PtHLoVr&A-{QKi~i3@|z{?!Id+L%X+Q%&e|GXv{L%inU@#UTJ~naD`%rzh&*s-x-|Ib>CLa86zleEU z{ZFOh%D+4I>??ixX;++%{F`T|^X*cb3vT^Z~%fZi1>)+?n)!(mGu}t{)2jaDxyjs*-iib zpXqPI-}LDdW9)>d|7~?pW-_##uGHqBs%c?pXk=(;Ze(m|7NyCh@0*|El30?epy6U= zWMGIaIlZRMAwba3Qb8jmHA2BBvn*8sq+oS;~U7hl8Cn zBfN-7Lzy#8R_iFEWk3^43rknaOw+cWDCW)43#6Fc&e}z|G_78(p!0u^uHu{Z_3xVs zKK)C6K5LtB^M>%;>18bShnDQ=-u%aV&ht!u&j-)$>ut9;U%mZq6>|u;@bepA)|=gq z{S!4)PqgLx)qRa8nhUm7-P@bj$o1-3Tzvci`Eym!uJN_jaMTrDE%U7S9Cs@U!e)hu3Km60*6#b~LotXY| zaVt0fZ28TL)nZ<|J-GPvP0FSEGhC;q$(4B*$H-@_6WsA)!spqJRi8`q9-d;(*X-+N z-jQ{{wS5Zz??}T<1^st6sG8eMEnH~bvDfF6Yu1g)JN@%3;_`0@?0z8IXInp`kFD>W zpv&&e_It{N%~i*A^b@d6qiuDBt_ex!YKdUs?G;HO|jJfB9wCw3kcGe@uIF z<6!7=--G2EMUQV9%bvG+a`K8?1561s5YW_cQ=iZyg z%eMJknYMYa==`7CnC@8@r)R|bf891EJu~L*s`%H_7kvA;QP%jmzIWT<`;avIwbLQa z*~!Gn!r8^r!qw2+(a7A*&D`15$jQRl(Z$)o$-u(N$xgwBkdo=sx*RO)BXdGRW!OG^ zF5PvmWY@(k?XAYKkxQDc+_TEfQV zX6#UDV^f~>LqTxy5%%kUgoQWi|H?4oWpV8C-h2P}Y5n^WR_ft?l| z&Basoe9E>QNYrpzq~dqVgVWyDt*^c~f@gp7Rm0GOTc64*J_ zTMJ@&ANDfc)4eZlRBia=3%4ToUcM9ec`Uz%pAh=8RVk>aWk z?`LPXy6nzU`94`~l7j9M$hR>(4r~mZcxqoWx+*ZP)jaZE{C?d5#p%?|5)iJ8goHF_03?>V>ct>d$`+FpxK z#CU1Gb$#}#=aOB@=KET`iq@CcPI3Qsv)JqLiGB4^nf6VG(v~uFSlybcCh*1HbfHP- zgClp_d=)F!xx7?p;`i5-b=vT4_oc)qzoMrsn^^r)bnkVu2~khtYD{&mKa%`z|Mn<{ V!Svcb2L&!u10ya~RabvEE&$qqUJ?KR -- GitLab From 57fd9723a5720a62e2a4fcb81413712a8bb693ef Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 19 Jul 2019 12:30:01 +0100 Subject: [PATCH 270/469] Added comment on new duplex3 --- examples/USER/cgdna/README | 8 ++++++++ 1 file changed, 8 insertions(+) diff --git a/examples/USER/cgdna/README b/examples/USER/cgdna/README index 7b05418661..e97910d2e1 100644 --- a/examples/USER/cgdna/README +++ b/examples/USER/cgdna/README @@ -22,6 +22,14 @@ A - C - G - T - A - C - G - T | | | | | | | | T - G - C - A T - G - C - A +/examples/duplex3: +This is basically the duplex1 run with both nucleotide mass and moment +of inertia set to the values of the standalone implementation of oxDNA, +which are M=I=1. To achieve this, the masses were set directly, whereas +the diameter of the ellipsoid in the data file was changed to 3.16227766. +This allows direct comparision of e.g. trajectory data or energies on a +per-timestep basis until numerical noise leads eventually to deviations. + /util: This directory contains a simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA -- GitLab From 0ee0ea109caae1c8416c579b8db88f80fc4dbd02 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 19 Jul 2019 12:43:37 +0100 Subject: [PATCH 271/469] Removed references to pair_oxdna2_stk --- src/USER-CGDNA/Install.sh | 2 -- src/USER-CGDNA/README | 2 +- 2 files changed, 1 insertion(+), 3 deletions(-) diff --git a/src/USER-CGDNA/Install.sh b/src/USER-CGDNA/Install.sh index a0721d5bde..fa62b0daf2 100755 --- a/src/USER-CGDNA/Install.sh +++ b/src/USER-CGDNA/Install.sh @@ -48,9 +48,7 @@ action pair_oxdna2_excv.h atom_vec_ellipsoid.h action pair_oxdna_hbond.cpp atom_vec_ellipsoid.h action pair_oxdna_hbond.h atom_vec_ellipsoid.h action pair_oxdna_stk.cpp atom_vec_ellipsoid.h -action pair_oxdna2_stk.cpp atom_vec_ellipsoid.h action pair_oxdna_stk.h atom_vec_ellipsoid.h -action pair_oxdna2_stk.h atom_vec_ellipsoid.h action pair_oxdna_xstk.cpp atom_vec_ellipsoid.h action pair_oxdna_xstk.h atom_vec_ellipsoid.h action pair_oxdna2_dh.cpp atom_vec_ellipsoid.h diff --git a/src/USER-CGDNA/README b/src/USER-CGDNA/README index 8e3f16372c..48d6178d13 100644 --- a/src/USER-CGDNA/README +++ b/src/USER-CGDNA/README @@ -73,7 +73,7 @@ pair_oxdna_xstk.cpp: cross-stacking interaction between nucleotides pair_oxdna_coaxstk.cpp: coaxial stacking interaction between nucleotides -pair_oxdna2_excv.cpp, pair_oxdna2_stk.cpp, pair_oxdna2_coaxstk.cpp: +pair_oxdna2_excv.cpp, pair_oxdna2_coaxstk.cpp: corresponding pair styles in oxDNA2 (see [3]) pair_oxdna2_dh.cpp: Debye-Hueckel electrostatic interaction between backbone -- GitLab From c2643a519e1b81bed24cd862c7589bfe706974c8 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 19 Jul 2019 13:29:39 +0100 Subject: [PATCH 272/469] Clarified explanation of new example3 --- examples/USER/cgdna/README | 15 +++++++++------ 1 file changed, 9 insertions(+), 6 deletions(-) diff --git a/examples/USER/cgdna/README b/examples/USER/cgdna/README index e97910d2e1..8a9dc44359 100644 --- a/examples/USER/cgdna/README +++ b/examples/USER/cgdna/README @@ -23,12 +23,15 @@ A - C - G - T - A - C - G - T T - G - C - A T - G - C - A /examples/duplex3: -This is basically the duplex1 run with both nucleotide mass and moment -of inertia set to the values of the standalone implementation of oxDNA, -which are M=I=1. To achieve this, the masses were set directly, whereas -the diameter of the ellipsoid in the data file was changed to 3.16227766. -This allows direct comparision of e.g. trajectory data or energies on a -per-timestep basis until numerical noise leads eventually to deviations. +This is basically the duplex1 run with sequence-dependent stacking +and hydrogen-bonding strengths enabled and both nucleotide mass and +moment of inertia set to the value of the standalone implementation +of oxDNA (M = I = 1). To achieve this, the masses can be set directly +in the input and data file, whereas the moment of inertia is set via +the diameter of the ellipsoid in the data file and has a value of 3.16227766. +The change of mass and moment of inertia allows direct comparision of +e.g. trajectory data, energies or time-dependent observables on a per-timestep +basis until numerical noise causes deviations at later simulation times. /util: This directory contains a simple python setup tool which creates -- GitLab From babbdaff2c37c5d6e7fdcaa0b1b05c2cf67c55ac Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 19 Jul 2019 08:31:04 -0400 Subject: [PATCH 273/469] step version string for next patch release --- doc/lammps.1 | 2 +- doc/src/Manual.txt | 4 ++-- src/version.h | 2 +- 3 files changed, 4 insertions(+), 4 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index 7ba31bfd06..4685ad22a3 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,4 +1,4 @@ -.TH LAMMPS "18 June 2019" "2019-06-18" +.TH LAMMPS "19 July 2019" "2019-07-19" .SH NAME .B LAMMPS \- Molecular Dynamics Simulator. diff --git a/doc/src/Manual.txt b/doc/src/Manual.txt index ba6ab8aac7..80d72aac57 100644 --- a/doc/src/Manual.txt +++ b/doc/src/Manual.txt @@ -1,7 +1,7 @@ LAMMPS Users Manual - + @@ -21,7 +21,7 @@ :line LAMMPS Documentation :c,h1 -18 Jun 2019 version :c,h2 +19 Jul 2019 version :c,h2 "What is a LAMMPS version?"_Manual_version.html diff --git a/src/version.h b/src/version.h index c2f6fcaf92..8a8cbec57e 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "18 Jun 2019" +#define LAMMPS_VERSION "19 Jul 2019" -- GitLab From 4c328bf846a2f0543f06e2bae0c7ec62411d5b4d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 19 Jul 2019 10:39:06 -0400 Subject: [PATCH 274/469] add metachars '\i' and '\f' to regexp for interger and floating point number chars --- src/utils.cpp | 29 +++++++++++++++++++++++++++++ 1 file changed, 29 insertions(+) diff --git a/src/utils.cpp b/src/utils.cpp index bbda22f24c..a27a53e600 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -39,6 +39,10 @@ * '\W' Non-alphanumeric * '\d' Digits, [0-9] * '\D' Non-digits + * '\i' Integer chars, [0-9], '+' and '-' + * '\I' Non-integers + * '\f' Floating point number chars, [0-9], '.', 'e', 'E', '+' and '-' + * '\F' Non-floats * * *NOT* supported: * '[^abc]' Inverted class @@ -307,6 +311,7 @@ extern "C" { enum { UNUSED, DOT, BEGIN, END, QUESTIONMARK, STAR, PLUS, CHAR, CHAR_CLASS, INV_CHAR_CLASS, DIGIT, NOT_DIGIT, + INTEGER, NOT_INTEGER, FLOAT, NOT_FLOAT, ALPHA, NOT_ALPHA, WHITESPACE, NOT_WHITESPACE /*, BRANCH */ }; typedef struct regex_t { @@ -324,6 +329,8 @@ extern "C" { static int matchplus(regex_t p, regex_t *pattern, const char *text); static int matchone(regex_t p, char c); static int matchdigit(char c); + static int matchint(char c); + static int matchfloat(char c); static int matchalpha(char c); static int matchwhitespace(char c); static int matchmetachar(char c, const char *str); @@ -395,6 +402,10 @@ extern "C" { /* Meta-character: */ case 'd': { re_compiled[j].type = DIGIT; } break; case 'D': { re_compiled[j].type = NOT_DIGIT; } break; + case 'i': { re_compiled[j].type = INTEGER; } break; + case 'I': { re_compiled[j].type = NOT_INTEGER; } break; + case 'f': { re_compiled[j].type = FLOAT; } break; + case 'F': { re_compiled[j].type = NOT_FLOAT; } break; case 'w': { re_compiled[j].type = ALPHA; } break; case 'W': { re_compiled[j].type = NOT_ALPHA; } break; case 's': { re_compiled[j].type = WHITESPACE; } break; @@ -467,6 +478,16 @@ extern "C" { return ((c >= '0') && (c <= '9')); } + static int matchint(char c) + { + return (matchdigit(c) || (c == '-') || (c == '+')); + } + + static int matchfloat(char c) + { + return (matchint(c) || (c == '.') || (c == 'e') || (c == 'E')); + } + static int matchalpha(char c) { return ((c >= 'a') && (c <= 'z')) || ((c >= 'A') && (c <= 'Z')); @@ -502,6 +523,10 @@ extern "C" { switch (str[0]) { case 'd': return matchdigit(c); case 'D': return !matchdigit(c); + case 'i': return matchint(c); + case 'I': return !matchint(c); + case 'f': return matchfloat(c); + case 'F': return !matchfloat(c); case 'w': return matchalphanum(c); case 'W': return !matchalphanum(c); case 's': return matchwhitespace(c); @@ -544,6 +569,10 @@ extern "C" { case INV_CHAR_CLASS: return !matchcharclass(c, (const char *)p.ccl); case DIGIT: return matchdigit(c); case NOT_DIGIT: return !matchdigit(c); + case INTEGER: return matchint(c); + case NOT_INTEGER: return !matchint(c); + case FLOAT: return matchfloat(c); + case NOT_FLOAT: return !matchfloat(c); case ALPHA: return matchalphanum(c); case NOT_ALPHA: return !matchalphanum(c); case WHITESPACE: return matchwhitespace(c); -- GitLab From 4f7c95d87e77f880415405910f3e06c4b70b1ca6 Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Fri, 19 Jul 2019 17:13:38 +0200 Subject: [PATCH 275/469] Update compute.txt Addition of a few one-liners --- doc/src/compute.txt | 89 ++++++++++++++++++++++----------------------- 1 file changed, 43 insertions(+), 46 deletions(-) diff --git a/doc/src/compute.txt b/doc/src/compute.txt index 87dbee57d6..53ed373aa5 100644 --- a/doc/src/compute.txt +++ b/doc/src/compute.txt @@ -171,42 +171,40 @@ The individual style names on the "Commands compute"_Commands_compute.html doc page are followed by one or more of (g,i,k,o,t) to indicate which accelerated styles exist. -"ackland/atom"_compute_ackland_atom.html - +"ackland/atom"_compute_ackland_atom.html - determines the local lattice structure based on the Ackland formulation "adf"_compute_adf.html - angular distribution function of triples of atoms "aggregate/atom"_compute_cluster_atom.html - aggregate ID for each atom -"angle"_compute_angle.html - -"angle/local"_compute_angle_local.html - -"angle/local"_compute_bond_local.html - theta and energy of each angle +"angle"_compute_angle.html - energy of each angle sub-style +"angle/local"_compute_angle_local.html - theta and energy of each angle "angmom/chunk"_compute_angmom_chunk.html - angular momentum for each chunk -"basal/atom"_compute_basal_atom.html - +"basal/atom"_compute_basal_atom.html - calculates the hexagonal close-packed “c” lattice vector of each atom "body/local"_compute_body_local.html - attributes of body sub-particles -"bond"_compute_bond.html - values computed by a bond style +"bond"_compute_bond.html - energy of each bond sub-style "bond/local"_compute_bond_local.html - distance and energy of each bond "centro/atom"_compute_centro_atom.html - centro-symmetry parameter for each atom "chunk/atom"_compute_chunk_atom.html - assign chunk IDs to each atom "chunk/spread/atom"_compute_chunk_spread_atom.html - spreads chunk values to each atom in chunk "cluster/atom"_compute_cluster_atom.html - cluster ID for each atom "cna/atom"_compute_cna_atom.html - common neighbor analysis (CNA) for each atom -"cnp/atom"_compute_cnp_atom.html - +"cnp/atom"_compute_cnp_atom.html - common neighborhood parameter (CNP) for each atom "com"_compute_com.html - center-of-mass of group of atoms "com/chunk"_compute_com_chunk.html - center-of-mass for each chunk "contact/atom"_compute_contact_atom.html - contact count for each spherical particle "coord/atom"_compute_coord_atom.html - coordination number for each atom "damage/atom"_compute_damage_atom.html - Peridynamic damage for each atom -"dihedral"_compute_dihedral.html - +"dihedral"_compute_dihedral.html - energy of each dihedral sub-style "dihedral/local"_compute_dihedral_local.html - angle of each dihedral "dilatation/atom"_compute_dilatation_atom.html - Peridynamic dilatation for each atom -"dipole/chunk"_compute_dipole_chunk.html - +"dipole/chunk"_compute_dipole_chunk.html - dipole vector and total dipole for each chunk "displace/atom"_compute_displace_atom.html - displacement of each atom "dpd"_compute_dpd.html - "dpd/atom"_compute_dpd_atom.html - -"edpd/temp/atom"_compute_edpd_temp_atom.html - -"entropy/atom"_compute_entropy_atom.html - +"edpd/temp/atom"_compute_edpd_temp_atom.html - per-atom temperature for each eDPD particle in a group +"entropy/atom"_compute_entropy_atom.html - pair entropy fingerprint of each atom "erotate/asphere"_compute_erotate_asphere.html - rotational energy of aspherical particles "erotate/rigid"_compute_erotate_rigid.html - rotational energy of rigid bodies "erotate/sphere"_compute_erotate_sphere.html - rotational energy of spherical particles -"erotate/sphere/atom"_compute_erotate_sphere.html - rotational energy for each spherical particle -"erotate/sphere/atom"_compute_erotate_sphere_atom.html - +"erotate/sphere/atom"_compute_erotate_sphere_atom.html - rotational energy for each spherical particle "event/displace"_compute_event_displace.html - detect event on atom displacement "fep"_compute_fep.html - "force/tally"_compute_tally.html - @@ -218,17 +216,17 @@ compute"_Commands_compute.html doc page are followed by one or more of "heat/flux"_compute_heat_flux.html - heat flux through a group of atoms "heat/flux/tally"_compute_tally.html - "hexorder/atom"_compute_hexorder_atom.html - bond orientational order parameter q6 -"improper"_compute_improper.html - +"improper"_compute_improper.html - energy of each improper sub-style "improper/local"_compute_improper_local.html - angle of each improper "inertia/chunk"_compute_inertia_chunk.html - inertia tensor for each chunk "ke"_compute_ke.html - translational kinetic energy "ke/atom"_compute_ke_atom.html - kinetic energy for each atom -"ke/atom/eff"_compute_ke_atom_eff.html - -"ke/eff"_compute_ke_eff.html - +"ke/atom/eff"_compute_ke_atom_eff.html - per-atom translational and radial kinetic energy in the electron force field model +"ke/eff"_compute_ke_eff.html - kinetic energy of a group of nuclei and electrons in the electron force field model "ke/rigid"_compute_ke_rigid.html - translational kinetic energy of rigid bodies -"meso/e/atom"_compute_meso_e_atom.html - -"meso/rho/atom"_compute_meso_rho_atom.html - -"meso/t/atom"_compute_meso_t_atom.html - +"meso/e/atom"_compute_meso_e_atom.html - per-atom internal energy of Smooth-Particle Hydrodynamics atoms +"meso/rho/atom"_compute_meso_rho_atom.html - per-atom mesoscopic density of Smooth-Particle Hydrodynamics atoms +"meso/t/atom"_compute_meso_t_atom.html - per-atom internal temperature of Smooth-Particle Hydrodynamics atoms "msd"_compute_msd.html - mean-squared displacement of group of atoms "msd/chunk"_compute_msd_chunk.html - mean-squared displacement for each chunk "msd/nongauss"_compute_msd_nongauss.html - MSD and non-Gaussian parameter of group of atoms @@ -242,73 +240,72 @@ compute"_Commands_compute.html doc page are followed by one or more of "pe/tally"_compute_tally.html - "plasticity/atom"_compute_plasticity_atom.html - Peridynamic plasticity for each atom "pressure"_compute_pressure.html - total pressure and pressure tensor -"pressure/cylinder"_compute_pressure_cylinder.html - -"pressure/uef"_compute_pressure_uef.html - +"pressure/cylinder"_compute_pressure_cylinder.html - pressure tensor in cylindrical coordinates +"pressure/uef"_compute_pressure_uef.html - pressure tensor in the reference frame of an applied flow field "property/atom"_compute_property_atom.html - convert atom attributes to per-atom vectors/arrays "property/chunk"_compute_property_chunk.html - extract various per-chunk attributes "property/local"_compute_property_local.html - convert local attributes to localvectors/arrays -"ptm/atom"_compute_ptm_atom.html - +"ptm/atom"_compute_ptm_atom.html - determines the local lattice structure based on the Polyhedral Template Matching method "rdf"_compute_rdf.html - radial distribution function g(r) histogram of group of atoms "reduce"_compute_reduce.html - combine per-atom quantities into a single global value "reduce/chunk"_compute_reduce_chunk.html - reduce per-atom quantities within each chunk "reduce/region"_compute_reduce.html - same as compute reduce, within a region "rigid/local"_compute_rigid_local.html - extract rigid body attributes -"saed"_compute_saed.html - +"saed"_compute_saed.html - electron diffraction intensity on a mesh of reciprocal lattice nodes "slice"_compute_slice.html - extract values from global vector or array "smd/contact/radius"_compute_smd_contact_radius.html - -"smd/damage"_compute_smd_damage.html - +"smd/damage"_compute_smd_damage.html - damage status of SPH particles in Smooth Mach Dynamics "smd/hourglass/error"_compute_smd_hourglass_error.html - -"smd/internal/energy"_compute_smd_internal_energy.html - -"smd/plastic/strain"_compute_smd_plastic_strain.html - -"smd/plastic/strain/rate"_compute_smd_plastic_strain_rate.html - -"smd/rho"_compute_smd_rho.html - -"smd/tlsph/defgrad"_compute_smd_tlsph_defgrad.html - -"smd/tlsph/dt"_compute_smd_tlsph_dt.html - +"smd/internal/energy"_compute_smd_internal_energy.html - per-particle enthalpy in Smooth Mach Dynamics +"smd/plastic/strain"_compute_smd_plastic_strain.html - equivalent plastic strain per particle in Smooth Mach Dynamics +"smd/plastic/strain/rate"_compute_smd_plastic_strain_rate.html - time rate of the equivalent plastic strain in Smooth Mach Dynamics +"smd/rho"_compute_smd_rho.html - per-particle mass density in Smooth Mach Dynamics +"smd/tlsph/defgrad"_compute_smd_tlsph_defgrad.html - deformation gradient in Smooth Mach Dynamics +"smd/tlsph/dt"_compute_smd_tlsph_dt.html - CFL-stable time increment per particle in Smooth Mach Dynamics "smd/tlsph/num/neighs"_compute_smd_tlsph_num_neighs.html - "smd/tlsph/shape"_compute_smd_tlsph_shape.html - "smd/tlsph/strain"_compute_smd_tlsph_strain.html - "smd/tlsph/strain/rate"_compute_smd_tlsph_strain_rate.html - -"smd/tlsph/stress"_compute_smd_tlsph_stress.html - -"smd/triangle/vertices"_compute_smd_triangle_vertices.html - +"smd/tlsph/stress"_compute_smd_tlsph_stress.html - per-particle Cauchy stress tensor for SPH particles "smd/triangle/vertices"_compute_smd_triangle_vertices.html - "smd/ulsph/num/neighs"_compute_smd_ulsph_num_neighs.html - "smd/ulsph/strain"_compute_smd_ulsph_strain.html - "smd/ulsph/strain/rate"_compute_smd_ulsph_strain_rate.html - -"smd/ulsph/stress"_compute_smd_ulsph_stress.html - -"smd/vol"_compute_smd_vol.html - +"smd/ulsph/stress"_compute_smd_ulsph_stress.html - per-particle Cauchy stress tensor and von Mises equivalent stress in Smooth Mach Dynamics +"smd/vol"_compute_smd_vol.html - per-particle volumes and their sum in Smooth Mach Dynamics "sna/atom"_compute_sna_atom.html - calculate bispectrum coefficients for each atom "snad/atom"_compute_sna_atom.html - derivative of bispectrum coefficients for each atom "snav/atom"_compute_sna_atom.html - virial contribution from bispectrum coefficients for each atom -"spin"_compute_spin.html - +"spin"_compute_spin.html - magnetic quantities for a system of atoms having spins "stress/atom"_compute_stress_atom.html - stress tensor for each atom -"stress/mop"_compute_stress_mop.html - -"stress/mop/profile"_compute_stress_mop.html - +"stress/mop"_compute_stress_mop.html - normal components of the local stress tensor using the method of planes +"stress/mop/profile"_compute_stress_mop.html - profile of the normal components of the local stress tensor using the method of planes "stress/tally"_compute_tally.html - -"tdpd/cc/atom"_compute_tdpd_cc_atom.html - +"tdpd/cc/atom"_compute_tdpd_cc_atom.html - per-atom chemical concentration of a specified species for each tDPD particle "temp"_compute_temp.html - temperature of group of atoms "temp/asphere"_compute_temp_asphere.html - temperature of aspherical particles "temp/body"_compute_temp_body.html - temperature of body particles "temp/chunk"_compute_temp_chunk.html - temperature of each chunk "temp/com"_compute_temp_com.html - temperature after subtracting center-of-mass velocity -"temp/cs"_compute_temp_cs.html - +"temp/cs"_compute_temp_cs.html - temperature based on the center-of-mass velocity of atom pairs that are bonded to each other "temp/deform"_compute_temp_deform.html - temperature excluding box deformation velocity -"temp/deform/eff"_compute_temp_deform_eff.html - -"temp/drude"_compute_temp_drude.html - -"temp/eff"_compute_temp_eff.html - +"temp/deform/eff"_compute_temp_deform_eff.html - temperature excluding box deformation velocity in the electron force field model +"temp/drude"_compute_temp_drude.html - temperature of Core-Drude pairs +"temp/eff"_compute_temp_eff.html - temperature of a group of nuclei and electrons in the electron force field model "temp/partial"_compute_temp_partial.html - temperature excluding one or more dimensions of velocity "temp/profile"_compute_temp_profile.html - temperature excluding a binned velocity profile "temp/ramp"_compute_temp_ramp.html - temperature excluding ramped velocity component "temp/region"_compute_temp_region.html - temperature of a region of atoms -"temp/region/eff"_compute_temp_region_eff.html - -"temp/rotate"_compute_temp_rotate.html - +"temp/region/eff"_compute_temp_region_eff.html - temperature of a region of nuclei and electrons in the electron force field model +"temp/rotate"_compute_temp_rotate.html - temperature of a group of atoms after subtracting out their center-of-mass and angular velocities "temp/sphere"_compute_temp_sphere.html - temperature of spherical particles -"temp/uef"_compute_temp_uef.html - +"temp/uef"_compute_temp_uef.html - kinetic energy tensor in the reference frame of an applied flow field "ti"_compute_ti.html - thermodynamic integration free energy values "torque/chunk"_compute_torque_chunk.html - torque applied on each chunk "vacf"_compute_vacf.html - velocity auto-correlation function of group of atoms "vcm/chunk"_compute_vcm_chunk.html - velocity of center-of-mass for each chunk "voronoi/atom"_compute_voronoi_atom.html - Voronoi volume and neighbors for each atom -"xrd"_compute_xrd.html - :ul +"xrd"_compute_xrd.html - x-ray diffraction intensity on a mesh of reciprocal lattice nodes :ul [Restrictions:] none -- GitLab From 8526e7a4cdb16bb29e00e049e62de472eb9ee6de Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 19 Jul 2019 11:14:39 -0400 Subject: [PATCH 276/469] checking return value of ?scanf() calls to detect problems parsing files --- doc/src/Errors_messages.txt | 5 +++++ src/REPLICA/neb.cpp | 23 ++++++++++++--------- src/USER-REAXC/fix_qeq_reax.cpp | 8 +++++--- src/atom.cpp | 36 ++++++++++++++++++++------------- src/atom.h | 5 +++++ src/reader_native.cpp | 32 ++++++++++++++++++++--------- src/reader_xyz.cpp | 6 ++++-- 7 files changed, 77 insertions(+), 38 deletions(-) diff --git a/doc/src/Errors_messages.txt b/doc/src/Errors_messages.txt index 1d635ed841..c55d3743ab 100644 --- a/doc/src/Errors_messages.txt +++ b/doc/src/Errors_messages.txt @@ -5890,6 +5890,11 @@ The element names in the ADP file do not match those requested. :dd The element names in the EAM file do not match those requested. :dd +{Incorrect format of ... section in data file} :dt + +Number or type of values per line in the given section of the data file +is not consistent with the requirements for this section. :dd + {Incorrect format in COMB potential file} :dt Incorrect number of words per line in the potential file. :dd diff --git a/src/REPLICA/neb.cpp b/src/REPLICA/neb.cpp index 6b68c52dbb..4061ec6541 100644 --- a/src/REPLICA/neb.cpp +++ b/src/REPLICA/neb.cpp @@ -397,28 +397,33 @@ void NEB::readfile(char *file, int flag) open(file); while (1) { eof = fgets(line,MAXLINE,fp); - if (eof == NULL) error->one(FLERR,"Unexpected end of neb file"); + if (eof == NULL) error->one(FLERR,"Unexpected end of NEB file"); start = &line[strspn(line," \t\n\v\f\r")]; if (*start != '\0' && *start != '#') break; } - sscanf(line,"%d",&nlines); + int rv = sscanf(line,"%d",&nlines); + if (rv != 1) nlines = -1; } MPI_Bcast(&nlines,1,MPI_INT,0,uworld); - + if (nlines < 0) + error->universe_all(FLERR,"Incorrectly formatted NEB file"); } else { if (me == 0) { if (ireplica) { open(file); while (1) { eof = fgets(line,MAXLINE,fp); - if (eof == NULL) error->one(FLERR,"Unexpected end of neb file"); + if (eof == NULL) error->one(FLERR,"Unexpected end of NEB file"); start = &line[strspn(line," \t\n\v\f\r")]; if (*start != '\0' && *start != '#') break; } - sscanf(line,"%d",&nlines); + int rv = sscanf(line,"%d",&nlines); + if (rv != 1) nlines = -1; } else nlines = 0; } MPI_Bcast(&nlines,1,MPI_INT,0,world); + if (nlines < 0) + error->all(FLERR,"Incorrectly formatted NEB file"); } char *buffer = new char[CHUNK*MAXLINE]; @@ -442,7 +447,7 @@ void NEB::readfile(char *file, int flag) eofflag = comm->read_lines_from_file_universe(fp,nchunk,MAXLINE,buffer); else eofflag = comm->read_lines_from_file(fp,nchunk,MAXLINE,buffer); - if (eofflag) error->all(FLERR,"Unexpected end of neb file"); + if (eofflag) error->all(FLERR,"Unexpected end of NEB file"); buf = buffer; next = strchr(buf,'\n'); @@ -451,7 +456,7 @@ void NEB::readfile(char *file, int flag) *next = '\n'; if (nwords != ATTRIBUTE_PERLINE) - error->all(FLERR,"Incorrect atom format in neb file"); + error->all(FLERR,"Incorrect atom format in NEB file"); // loop over lines of atom coords // tokenize the line into values @@ -509,12 +514,12 @@ void NEB::readfile(char *file, int flag) int ntotal; MPI_Allreduce(&ncount,&ntotal,1,MPI_INT,MPI_SUM,uworld); if (ntotal != nreplica*nlines) - error->universe_all(FLERR,"Invalid atom IDs in neb file"); + error->universe_all(FLERR,"Invalid atom IDs in NEB file"); } else { int ntotal; MPI_Allreduce(&ncount,&ntotal,1,MPI_INT,MPI_SUM,world); if (ntotal != nlines) - error->all(FLERR,"Invalid atom IDs in neb file"); + error->all(FLERR,"Invalid atom IDs in NEB file"); } // clean up diff --git a/src/USER-REAXC/fix_qeq_reax.cpp b/src/USER-REAXC/fix_qeq_reax.cpp index faa0632608..6c0da278c2 100644 --- a/src/USER-REAXC/fix_qeq_reax.cpp +++ b/src/USER-REAXC/fix_qeq_reax.cpp @@ -200,7 +200,7 @@ void FixQEqReax::pertype_parameters(char *arg) return; } - int i,itype,ntypes; + int i,itype,ntypes,rv; double v1,v2,v3; FILE *pf; @@ -216,9 +216,11 @@ void FixQEqReax::pertype_parameters(char *arg) error->one(FLERR,"Fix qeq/reax parameter file could not be found"); for (i = 1; i <= ntypes && !feof(pf); i++) { - fscanf(pf,"%d %lg %lg %lg",&itype,&v1,&v2,&v3); + rv = fscanf(pf,"%d %lg %lg %lg",&itype,&v1,&v2,&v3); + if (rv != 4) + error->one(FLERR,"Fix qeq/reax: Incorrect format of param file"); if (itype < 1 || itype > ntypes) - error->one(FLERR,"Fix qeq/reax invalid atom type in param file"); + error->one(FLERR,"Fix qeq/reax: invalid atom type in param file"); chi[itype] = v1; eta[itype] = v2; gamma[itype] = v3; diff --git a/src/atom.cpp b/src/atom.cpp index 1f5d5a80c4..e5a982d620 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -1071,7 +1071,7 @@ void Atom::data_vels(int n, char *buf, tagint id_offset) void Atom::data_bonds(int n, char *buf, int *count, tagint id_offset, int type_offset) { - int m,tmp,itype; + int m,tmp,itype,rv; tagint atom1,atom2; char *next; int newton_bond = force->newton_bond; @@ -1079,8 +1079,10 @@ void Atom::data_bonds(int n, char *buf, int *count, tagint id_offset, for (int i = 0; i < n; i++) { next = strchr(buf,'\n'); *next = '\0'; - sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT, - &tmp,&itype,&atom1,&atom2); + rv = sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2); + if (rv != 4) + error->one(FLERR,"Incorrect format of Bonds section in data file"); if (id_offset) { atom1 += id_offset; atom2 += id_offset; @@ -1124,7 +1126,7 @@ void Atom::data_bonds(int n, char *buf, int *count, tagint id_offset, void Atom::data_angles(int n, char *buf, int *count, tagint id_offset, int type_offset) { - int m,tmp,itype; + int m,tmp,itype,rv; tagint atom1,atom2,atom3; char *next; int newton_bond = force->newton_bond; @@ -1132,8 +1134,10 @@ void Atom::data_angles(int n, char *buf, int *count, tagint id_offset, for (int i = 0; i < n; i++) { next = strchr(buf,'\n'); *next = '\0'; - sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, - &tmp,&itype,&atom1,&atom2,&atom3); + rv = sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2,&atom3); + if (rv != 5) + error->one(FLERR,"Incorrect format of Angles section in data file"); if (id_offset) { atom1 += id_offset; atom2 += id_offset; @@ -1194,7 +1198,7 @@ void Atom::data_angles(int n, char *buf, int *count, tagint id_offset, void Atom::data_dihedrals(int n, char *buf, int *count, tagint id_offset, int type_offset) { - int m,tmp,itype; + int m,tmp,itype,rv; tagint atom1,atom2,atom3,atom4; char *next; int newton_bond = force->newton_bond; @@ -1202,9 +1206,11 @@ void Atom::data_dihedrals(int n, char *buf, int *count, tagint id_offset, for (int i = 0; i < n; i++) { next = strchr(buf,'\n'); *next = '\0'; - sscanf(buf,"%d %d " - TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, - &tmp,&itype,&atom1,&atom2,&atom3,&atom4); + rv = sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2,&atom3,&atom4); + if (rv != 6) + error->one(FLERR,"Incorrect format of Dihedrals section in data file"); if (id_offset) { atom1 += id_offset; atom2 += id_offset; @@ -1283,7 +1289,7 @@ void Atom::data_dihedrals(int n, char *buf, int *count, tagint id_offset, void Atom::data_impropers(int n, char *buf, int *count, tagint id_offset, int type_offset) { - int m,tmp,itype; + int m,tmp,itype,rv; tagint atom1,atom2,atom3,atom4; char *next; int newton_bond = force->newton_bond; @@ -1291,9 +1297,11 @@ void Atom::data_impropers(int n, char *buf, int *count, tagint id_offset, for (int i = 0; i < n; i++) { next = strchr(buf,'\n'); *next = '\0'; - sscanf(buf,"%d %d " - TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, - &tmp,&itype,&atom1,&atom2,&atom3,&atom4); + rv = sscanf(buf,"%d %d " + TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2,&atom3,&atom4); + if (rv != 6) + error->one(FLERR,"Incorrect format of Impropers section in data file"); if (id_offset) { atom1 += id_offset; atom2 += id_offset; diff --git a/src/atom.h b/src/atom.h index 5cd9ca819b..81f643c007 100644 --- a/src/atom.h +++ b/src/atom.h @@ -426,6 +426,11 @@ E: Incorrect atom format in data file Number of values per atom line in the data file is not consistent with the atom style. +E: Incorrect format of ... section in data file + +Number or type of values per line in the given section of the data file +is not consistent with the requirements for this section. + E: Invalid atom type in Atoms section of data file Atom types must range from 1 to specified # of types. diff --git a/src/reader_native.cpp b/src/reader_native.cpp index 7c772ab6b8..60b7ecd764 100644 --- a/src/reader_native.cpp +++ b/src/reader_native.cpp @@ -59,8 +59,9 @@ int ReaderNative::read_time(bigint &ntimestep) if (strstr(line,"ITEM: TIMESTEP") != line) error->one(FLERR,"Dump file is incorrectly formatted"); read_lines(1); - sscanf(line,BIGINT_FORMAT,&ntimestep); - + int rv = sscanf(line,BIGINT_FORMAT,&ntimestep); + if (rv != 1) + error->one(FLERR,"Dump file is incorrectly formatted"); return 0; } @@ -73,7 +74,9 @@ void ReaderNative::skip() { read_lines(2); bigint natoms; - sscanf(line,BIGINT_FORMAT,&natoms); + int rv = sscanf(line,BIGINT_FORMAT,&natoms); + if (rv != 1) + error->one(FLERR,"Dump file is incorrectly formatted"); read_lines(5); @@ -110,8 +113,12 @@ bigint ReaderNative::read_header(double box[3][3], int &boxinfo, int &triclinic, int &xflag, int &yflag, int &zflag) { bigint natoms; + int rv; + read_lines(2); - sscanf(line,BIGINT_FORMAT,&natoms); + rv = sscanf(line,BIGINT_FORMAT,&natoms); + if (rv != 1) + error->one(FLERR,"Dump file is incorrectly formatted"); boxinfo = 1; triclinic = 0; @@ -120,14 +127,19 @@ bigint ReaderNative::read_header(double box[3][3], int &boxinfo, int &triclinic, if (line[strlen("ITEM: BOX BOUNDS ")] == 'x') triclinic = 1; read_lines(1); - if (!triclinic) sscanf(line,"%lg %lg",&box[0][0],&box[0][1]); - else sscanf(line,"%lg %lg %lg",&box[0][0],&box[0][1],&box[0][2]); + if (!triclinic) rv = 2 - sscanf(line,"%lg %lg",&box[0][0],&box[0][1]); + else rv = 3 - sscanf(line,"%lg %lg %lg",&box[0][0],&box[0][1],&box[0][2]); + if (rv != 0) error->one(FLERR,"Dump file is incorrectly formatted"); + read_lines(1); - if (!triclinic) sscanf(line,"%lg %lg",&box[1][0],&box[1][1]); - else sscanf(line,"%lg %lg %lg",&box[1][0],&box[1][1],&box[1][2]); + if (!triclinic) rv = 2 - sscanf(line,"%lg %lg",&box[1][0],&box[1][1]); + else rv = 3 - sscanf(line,"%lg %lg %lg",&box[1][0],&box[1][1],&box[1][2]); + if (rv != 0) error->one(FLERR,"Dump file is incorrectly formatted"); + read_lines(1); - if (!triclinic) sscanf(line,"%lg %lg",&box[2][0],&box[2][1]); - else sscanf(line,"%lg %lg %lg",&box[2][0],&box[2][1],&box[2][2]); + if (!triclinic) rv = 2 - sscanf(line,"%lg %lg",&box[2][0],&box[2][1]); + else rv = 3 - sscanf(line,"%lg %lg %lg",&box[2][0],&box[2][1],&box[2][2]); + if (rv != 0) error->one(FLERR,"Dump file is incorrectly formatted"); read_lines(1); diff --git a/src/reader_xyz.cpp b/src/reader_xyz.cpp index 303c25cd7a..040eb9d460 100644 --- a/src/reader_xyz.cpp +++ b/src/reader_xyz.cpp @@ -170,7 +170,7 @@ bigint ReaderXYZ::read_header(double /*box*/[3][3], int &boxinfo, int &/*triclin void ReaderXYZ::read_atoms(int n, int nfield, double **fields) { - int i,m; + int i,m,rv; char *eof; int mytype; double myx, myy, myz; @@ -180,7 +180,9 @@ void ReaderXYZ::read_atoms(int n, int nfield, double **fields) if (eof == NULL) error->one(FLERR,"Unexpected end of dump file"); ++nid; - sscanf(line,"%*s%lg%lg%lg", &myx, &myy, &myz); + rv = sscanf(line,"%*s%lg%lg%lg", &myx, &myy, &myz); + if (rv != 3) + error->one("Dump file is incorrectly formatted"); // XXX: we could insert an element2type translation here // XXX: for now we flag unrecognized types as type 0, -- GitLab From 1de00aaab0baf227c49bb7e7bc33ab5f559416cf Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 19 Jul 2019 11:16:41 -0400 Subject: [PATCH 277/469] improve parsing of data file header the header lines are now checked using regular expressions instead of strstr() which allows for stricter checking, but also is more forgiving in terms of extra or different whitespace return value of sscanf() calls is checked and on failure LAMMPS errors out --- src/read_data.cpp | 132 +++++++++++++++++++++++++++++++++------------- 1 file changed, 94 insertions(+), 38 deletions(-) diff --git a/src/read_data.cpp b/src/read_data.cpp index e70a526c38..989f989269 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -45,6 +45,7 @@ #include "irregular.h" #include "error.h" #include "memory.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -999,74 +1000,115 @@ void ReadData::header(int firstpass) // customize for new header lines // check for triangles before angles so "triangles" not matched as "angles" int extra_flag_value = 0; + int rv; - if (strstr(line,"atoms")) { - sscanf(line,BIGINT_FORMAT,&natoms); + if (utils::strmatch(line,"^\\s*\\d+\\s+atoms\\s")) { + rv = sscanf(line,BIGINT_FORMAT,&natoms); + if (rv != 1) + error->all(FLERR,"Could not parse 'atoms' line in data file header"); if (addflag == NONE) atom->natoms = natoms; else if (firstpass) atom->natoms += natoms; - } else if (strstr(line,"ellipsoids")) { + } else if (utils::strmatch(line,"^\\s*\\d+\\s+ellipsoids\\s")) { if (!avec_ellipsoid) error->all(FLERR,"No ellipsoids allowed with this atom style"); - sscanf(line,BIGINT_FORMAT,&nellipsoids); + rv = sscanf(line,BIGINT_FORMAT,&nellipsoids); + if (rv != 1) + error->all(FLERR,"Could not parse 'ellipsoids' line in data file header"); if (addflag == NONE) atom->nellipsoids = nellipsoids; else if (firstpass) atom->nellipsoids += nellipsoids; - } else if (strstr(line,"lines")) { + } else if (utils::strmatch(line,"^\\s*\\d+\\s+lines\\s")) { if (!avec_line) error->all(FLERR,"No lines allowed with this atom style"); - sscanf(line,BIGINT_FORMAT,&nlines); + rv = sscanf(line,BIGINT_FORMAT,&nlines); + if (rv != 1) + error->all(FLERR,"Could not parse 'lines' line in data file header"); if (addflag == NONE) atom->nlines = nlines; else if (firstpass) atom->nlines += nlines; - } else if (strstr(line,"triangles")) { + } else if (utils::strmatch(line,"^\\s*\\d+\\s+triangles\\s")) { if (!avec_tri) error->all(FLERR,"No triangles allowed with this atom style"); - sscanf(line,BIGINT_FORMAT,&ntris); + rv = sscanf(line,BIGINT_FORMAT,&ntris); + if (rv != 1) + error->all(FLERR,"Could not parse 'triangles' line in data file header"); if (addflag == NONE) atom->ntris = ntris; else if (firstpass) atom->ntris += ntris; - } else if (strstr(line,"bodies")) { + } else if (utils::strmatch(line,"^\\s*\\d+\\s+bodies\\s")) { if (!avec_body) error->all(FLERR,"No bodies allowed with this atom style"); - sscanf(line,BIGINT_FORMAT,&nbodies); + rv = sscanf(line,BIGINT_FORMAT,&nbodies); + if (rv != 1) + error->all(FLERR,"Could not parse 'bodies' line in data file header"); if (addflag == NONE) atom->nbodies = nbodies; else if (firstpass) atom->nbodies += nbodies; - } else if (strstr(line,"bonds")) { - sscanf(line,BIGINT_FORMAT,&nbonds); + } else if (utils::strmatch(line,"^\\s*\\d+\\s+bonds\\s")) { + rv = sscanf(line,BIGINT_FORMAT,&nbonds); + if (rv != 1) + error->all(FLERR,"Could not parse 'bonds' line in data file header"); if (addflag == NONE) atom->nbonds = nbonds; else if (firstpass) atom->nbonds += nbonds; - } else if (strstr(line,"angles")) { - sscanf(line,BIGINT_FORMAT,&nangles); + + } else if (utils::strmatch(line,"^\\s*\\d+\\s+angles\\s")) { + rv = sscanf(line,BIGINT_FORMAT,&nangles); + if (rv != 1) + error->all(FLERR,"Could not parse 'angles' line in data file header"); if (addflag == NONE) atom->nangles = nangles; else if (firstpass) atom->nangles += nangles; - } else if (strstr(line,"dihedrals")) { - sscanf(line,BIGINT_FORMAT,&ndihedrals); + + } else if (utils::strmatch(line,"^\\s*\\d+\\s+dihedrals\\s")) { + rv = sscanf(line,BIGINT_FORMAT,&ndihedrals); + if (rv != 1) + error->all(FLERR,"Could not parse 'dihedrals' line in data file header"); if (addflag == NONE) atom->ndihedrals = ndihedrals; else if (firstpass) atom->ndihedrals += ndihedrals; - } else if (strstr(line,"impropers")) { - sscanf(line,BIGINT_FORMAT,&nimpropers); + + } else if (utils::strmatch(line,"^\\s*\\d+\\s+impropers\\s")) { + rv = sscanf(line,BIGINT_FORMAT,&nimpropers); + if (rv != 1) + error->all(FLERR,"Could not parse 'impropers' line in data file header"); if (addflag == NONE) atom->nimpropers = nimpropers; else if (firstpass) atom->nimpropers += nimpropers; // Atom class type settings are only set by first data file - } else if (strstr(line,"atom types")) { - sscanf(line,"%d",&ntypes); + } else if (utils::strmatch(line,"^\\s*\\d+\\s+atom\\s+types\\s")) { + rv = sscanf(line,"%d",&ntypes); + if (rv != 1) + error->all(FLERR,"Could not parse 'atom types' line " + "in data file header"); if (addflag == NONE) atom->ntypes = ntypes + extra_atom_types; - } else if (strstr(line,"bond types")) { - sscanf(line,"%d",&nbondtypes); + + } else if (utils::strmatch(line,"\\s*\\d+\\s+bond\\s+types\\s")) { + rv = sscanf(line,"%d",&nbondtypes); + if (rv != 1) + error->all(FLERR,"Could not parse 'bond types' line " + "in data file header"); if (addflag == NONE) atom->nbondtypes = nbondtypes + extra_bond_types; - } else if (strstr(line,"angle types")) { - sscanf(line,"%d",&nangletypes); + + } else if (utils::strmatch(line,"^\\s*\\d+\\s+angle\\s+types\\s")) { + rv = sscanf(line,"%d",&nangletypes); + if (rv != 1) + error->all(FLERR,"Could not parse 'angle types' line " + "in data file header"); if (addflag == NONE) atom->nangletypes = nangletypes + extra_angle_types; - } else if (strstr(line,"dihedral types")) { - sscanf(line,"%d",&ndihedraltypes); + + } else if (utils::strmatch(line,"^\\s*\\d+\\s+dihedral\\s+types\\s")) { + rv = sscanf(line,"%d",&ndihedraltypes); + if (rv != 1) + error->all(FLERR,"Could not parse 'dihedral types' line " + "in data file header"); if (addflag == NONE) atom->ndihedraltypes = ndihedraltypes + extra_dihedral_types; - } else if (strstr(line,"improper types")) { - sscanf(line,"%d",&nimpropertypes); + + } else if (utils::strmatch(line,"^\\s*\\d+\\s+improper\\s+types\\s")) { + rv = sscanf(line,"%d",&nimpropertypes); + if (rv != 1) + error->all(FLERR,"Could not parse 'improper types' line " + "in data file header"); if (addflag == NONE) atom->nimpropertypes = nimpropertypes + extra_improper_types; @@ -1095,15 +1137,27 @@ void ReadData::header(int firstpass) // local copy of box info // so can treat differently for first vs subsequent data files - } else if (strstr(line,"xlo xhi")) { - sscanf(line,"%lg %lg",&boxlo[0],&boxhi[0]); - } else if (strstr(line,"ylo yhi")) { - sscanf(line,"%lg %lg",&boxlo[1],&boxhi[1]); - } else if (strstr(line,"zlo zhi")) { - sscanf(line,"%lg %lg",&boxlo[2],&boxhi[2]); - } else if (strstr(line,"xy xz yz")) { + } else if (utils::strmatch(line,"^\\s*\\f+\\s+\\f+\\s+xlo\\s+xhi\\s")) { + rv = sscanf(line,"%lg %lg",&boxlo[0],&boxhi[0]); + if (rv != 2) + error->all(FLERR,"Could not parse 'xlo xhi' line in data file header"); + + } else if (utils::strmatch(line,"^\\s*\\f+\\s+\\f+\\s+ylo\\s+yhi\\s")) { + rv = sscanf(line,"%lg %lg",&boxlo[1],&boxhi[1]); + if (rv != 2) + error->all(FLERR,"Could not parse 'ylo yhi' line in data file header"); + + } else if (utils::strmatch(line,"^\\s*\\f+\\s+\\f+\\s+zlo\\s+zhi\\s")) { + rv = sscanf(line,"%lg %lg",&boxlo[2],&boxhi[2]); + if (rv != 2) + error->all(FLERR,"Could not parse 'zlo zhi' line in data file header"); + + } else if (utils::strmatch(line,"^\\s*\\f+\\s+\\f+\\s+\\f+" + "\\s+xy\\s+xz\\s+yz\\s")) { triclinic = 1; - sscanf(line,"%lg %lg %lg",&xy,&xz,&yz); + rv = sscanf(line,"%lg %lg %lg",&xy,&xz,&yz); + if (rv != 3) + error->all(FLERR,"Could not parse 'xy xz yz' line in data file header"); } else break; } @@ -1638,7 +1692,7 @@ void ReadData::bonus(bigint nbonus, AtomVec *ptr, const char *type) void ReadData::bodies(int firstpass) { - int m,nchunk,nline,nmax,ninteger,ndouble,nword,ncount,onebody,tmp; + int m,nchunk,nline,nmax,ninteger,ndouble,nword,ncount,onebody,tmp,rv; char *eof; int mapflag = 0; @@ -1666,7 +1720,9 @@ void ReadData::bodies(int firstpass) while (nchunk < nmax && nline <= CHUNK-MAXBODY) { eof = fgets(&buffer[m],MAXLINE,fp); if (eof == NULL) error->one(FLERR,"Unexpected end of data file"); - sscanf(&buffer[m],"%d %d %d",&tmp,&ninteger,&ndouble); + rv = sscanf(&buffer[m],"%d %d %d",&tmp,&ninteger,&ndouble); + if (rv != 3) + error->one(FLERR,"Incorrect format in Bodies section of data file"); m += strlen(&buffer[m]); // read lines one at a time into buffer and count words -- GitLab From d730ef5b19dfe7b14327ddb9a0733f49c04baf4b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 19 Jul 2019 11:31:45 -0400 Subject: [PATCH 278/469] fix typo --- src/reader_xyz.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/reader_xyz.cpp b/src/reader_xyz.cpp index 040eb9d460..19f0ff2135 100644 --- a/src/reader_xyz.cpp +++ b/src/reader_xyz.cpp @@ -182,7 +182,7 @@ void ReaderXYZ::read_atoms(int n, int nfield, double **fields) ++nid; rv = sscanf(line,"%*s%lg%lg%lg", &myx, &myy, &myz); if (rv != 3) - error->one("Dump file is incorrectly formatted"); + error->one(FLERR,"Dump file is incorrectly formatted"); // XXX: we could insert an element2type translation here // XXX: for now we flag unrecognized types as type 0, -- GitLab From c7bccc5e7a21a53ffc595d1a30979f78f4a15cc4 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 19 Jul 2019 09:40:19 -0600 Subject: [PATCH 279/469] Workaround for GCC internal compiler error --- src/KOKKOS/pair_snap_kokkos_impl.h | 20 ++++++++++---------- 1 file changed, 10 insertions(+), 10 deletions(-) diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index 645521a17b..e53332050a 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -332,7 +332,7 @@ KOKKOS_INLINE_FUNCTION void PairSNAPKokkos::operator() (TagPairSNAPBeta,const typename Kokkos::TeamPolicy::member_type& team) const { // TODO: use RangePolicy instead, or thread over ncoeff? - const int ii = team.league_rank(); + int ii = team.league_rank(); const int i = d_ilist[ii + chunk_offset]; const int itype = type[i]; const int ielem = d_map[itype]; @@ -437,7 +437,7 @@ template KOKKOS_INLINE_FUNCTION void PairSNAPKokkos::operator() (TagPairSNAPComputeNeigh,const typename Kokkos::TeamPolicy::member_type& team) const { - const int ii = team.league_rank(); + int ii = team.league_rank(); const int i = d_ilist[ii + chunk_offset]; SNAKokkos my_sna = snaKK; const double xtmp = x(i,0); @@ -505,7 +505,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeNeigh,const typen template KOKKOS_INLINE_FUNCTION void PairSNAPKokkos::operator() (TagPairSNAPPreUi,const typename Kokkos::TeamPolicy::member_type& team) const { - const int ii = team.league_rank(); + int ii = team.league_rank(); SNAKokkos my_sna = snaKK; my_sna.pre_ui(team,ii); } @@ -516,7 +516,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeUi,const typename SNAKokkos my_sna = snaKK; // Extract the atom number - const int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); + int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); if (ii >= inum) return; // Extract the neighbor number @@ -530,7 +530,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeUi,const typename template KOKKOS_INLINE_FUNCTION void PairSNAPKokkos::operator() (TagPairSNAPComputeYi,const typename Kokkos::TeamPolicy::member_type& team) const { - const int ii = team.league_rank(); + int ii = team.league_rank(); SNAKokkos my_sna = snaKK; my_sna.compute_yi(team,ii,d_beta); } @@ -538,7 +538,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeYi,const typename template KOKKOS_INLINE_FUNCTION void PairSNAPKokkos::operator() (TagPairSNAPComputeZi,const typename Kokkos::TeamPolicy::member_type& team) const { - const int ii = team.league_rank(); + int ii = team.league_rank(); SNAKokkos my_sna = snaKK; my_sna.compute_zi(team,ii); } @@ -546,7 +546,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeZi,const typename template KOKKOS_INLINE_FUNCTION void PairSNAPKokkos::operator() (TagPairSNAPComputeBi,const typename Kokkos::TeamPolicy::member_type& team) const { - const int ii = team.league_rank(); + int ii = team.league_rank(); SNAKokkos my_sna = snaKK; my_sna.compute_bi(team,ii); } @@ -557,7 +557,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeDuidrj,const type SNAKokkos my_sna = snaKK; // Extract the atom number - const int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); + int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); if (ii >= inum) return; // Extract the neighbor number @@ -574,7 +574,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeDeidrj,const type SNAKokkos my_sna = snaKK; // Extract the atom number - const int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); + int ii = team.team_rank() + team.team_size() * (team.league_rank() % ((inum+team.team_size()-1)/team.team_size())); if (ii >= inum) return; // Extract the neighbor number @@ -595,7 +595,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeForce::value,decltype(dup_f),decltype(ndup_f)>::get(dup_f,ndup_f); auto a_f = v_f.template access::value>(); - const int ii = team.league_rank(); + int ii = team.league_rank(); const int i = d_ilist[ii + chunk_offset]; SNAKokkos my_sna = snaKK; const int ninside = d_ninside(ii); -- GitLab From e72aef2a9621118f7662f53be37a226037669d30 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 19 Jul 2019 12:01:16 -0400 Subject: [PATCH 280/469] more sscanf() return value checking --- src/procmap.cpp | 9 ++++++--- src/universe.cpp | 10 +++++----- src/variable.cpp | 4 ++-- 3 files changed, 13 insertions(+), 10 deletions(-) diff --git a/src/procmap.cpp b/src/procmap.cpp index 9d1ed83e73..8207b61f4c 100644 --- a/src/procmap.cpp +++ b/src/procmap.cpp @@ -301,7 +301,8 @@ void ProcMap::custom_grid(char *cfile, int nprocs, MPI_Bcast(&n,1,MPI_INT,0,world); MPI_Bcast(line,n,MPI_CHAR,0,world); - sscanf(line,"%d %d %d",&procgrid[0],&procgrid[1],&procgrid[2]); + int rv = sscanf(line,"%d %d %d",&procgrid[0],&procgrid[1],&procgrid[2]); + if (rv != 3) error->all(FLERR,"Processors custom grid file is inconsistent"); int flag = 0; if (procgrid[0]*procgrid[1]*procgrid[2] != nprocs) flag = 1; @@ -320,8 +321,10 @@ void ProcMap::custom_grid(char *cfile, int nprocs, for (int i = 0; i < nprocs; i++) { if (!fgets(line,MAXLINE,fp)) error->one(FLERR,"Unexpected end of custom file"); - sscanf(line,"%d %d %d %d", - &cmap[i][0],&cmap[i][1],&cmap[i][2],&cmap[i][3]); + rv = sscanf(line,"%d %d %d %d", + &cmap[i][0],&cmap[i][1],&cmap[i][2],&cmap[i][3]); + if (rv != 4) + error->one(FLERR,"Processors custom grid file is inconsistent"); } fclose(fp); } diff --git a/src/universe.cpp b/src/universe.cpp index f078590103..dba31f8b76 100644 --- a/src/universe.cpp +++ b/src/universe.cpp @@ -114,19 +114,19 @@ void Universe::reorder(char *style, char *arg) // read nprocs lines // uni2orig = inverse mapping - int me_orig,me_new; - sscanf(line,"%d %d",&me_orig,&me_new); + int me_orig,me_new,rv; + rv = sscanf(line,"%d %d",&me_orig,&me_new); if (me_orig < 0 || me_orig >= nprocs || - me_new < 0 || me_new >= nprocs) + me_new < 0 || me_new >= nprocs || rv != 2) error->one(FLERR,"Invalid entry in -reorder file"); uni2orig[me_new] = me_orig; for (int i = 1; i < nprocs; i++) { if (!fgets(line,MAXLINE,fp)) error->one(FLERR,"Unexpected end of -reorder file"); - sscanf(line,"%d %d",&me_orig,&me_new); + rv = sscanf(line,"%d %d",&me_orig,&me_new); if (me_orig < 0 || me_orig >= nprocs || - me_new < 0 || me_new >= nprocs) + me_new < 0 || me_new >= nprocs || rv != 2) error->one(FLERR,"Invalid entry in -reorder file"); uni2orig[me_new] = me_orig; } diff --git a/src/variable.cpp b/src/variable.cpp index ea7f3044d7..63a425bcf5 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -5162,8 +5162,8 @@ int VarReader::read_peratom() for (i = 0; i < nchunk; i++) { next = strchr(buf,'\n'); *next = '\0'; - sscanf(buf,TAGINT_FORMAT " %lg",&tag,&value); - if (tag <= 0 || tag > map_tag_max) + int rv = sscanf(buf,TAGINT_FORMAT " %lg",&tag,&value); + if (tag <= 0 || tag > map_tag_max || rv != 2) error->one(FLERR,"Invalid atom ID in variable file"); if ((m = atom->map(tag)) >= 0) vstore[m] = value; buf = next + 1; -- GitLab From 276e3b2df10e5f3ea160986f090651182b56aa5d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 19 Jul 2019 14:00:24 -0400 Subject: [PATCH 281/469] update fix tmd input similar to read_data --- src/fix_tmd.cpp | 32 +++++++++++++++++++------------- 1 file changed, 19 insertions(+), 13 deletions(-) diff --git a/src/fix_tmd.cpp b/src/fix_tmd.cpp index 4cbb244bc0..10315a750d 100644 --- a/src/fix_tmd.cpp +++ b/src/fix_tmd.cpp @@ -30,6 +30,7 @@ #include "force.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace FixConst; @@ -164,7 +165,7 @@ void FixTMD::init() dtv = update->dt; dtf = update->dt * force->ftm2v; - if (strstr(update->integrate_style,"respa")) + if (utils::strmatch(update->integrate_style,"^respa")) step_respa = ((Respa *) update->integrate)->step; } @@ -423,21 +424,27 @@ void FixTMD::readfile(char *file) *next = '\0'; if (firstline) { - if (strstr(bufptr,"xlo xhi")) { + if (utils::strmatch(bufptr,"^\\s*\\f+\\s+\\f+\\s+xlo\\s+xhi")) { double lo,hi; - sscanf(bufptr,"%lg %lg",&lo,&hi); + n = sscanf(bufptr,"%lg %lg",&lo,&hi); + if (n != 2) + error->all(FLERR,"Incorrect format in TMD target file"); xprd = hi - lo; bufptr = next + 1; continue; - } else if (strstr(bufptr,"ylo yhi")) { + } else if (utils::strmatch(bufptr,"^\\s*\\f+\\s+\\f+\\s+ylo\\s+yhi")) { double lo,hi; - sscanf(bufptr,"%lg %lg",&lo,&hi); + n = sscanf(bufptr,"%lg %lg",&lo,&hi); + if (n != 2) + error->all(FLERR,"Incorrect format in TMD target file"); yprd = hi - lo; bufptr = next + 1; continue; - } else if (strstr(bufptr,"zlo zhi")) { + } else if (utils::strmatch(bufptr,"^\\s*\\f+\\s+\\f+\\s+zlo\\s+zhi")) { double lo,hi; - sscanf(bufptr,"%lg %lg",&lo,&hi); + n = sscanf(bufptr,"%lg %lg",&lo,&hi); + if (n != 2) + error->all(FLERR,"Incorrect format in TMD target file"); zprd = hi - lo; bufptr = next + 1; continue; @@ -455,14 +462,13 @@ void FixTMD::readfile(char *file) } if (imageflag) - n = sscanf(bufptr,TAGINT_FORMAT " %lg %lg %lg %d %d %d", - &itag,&x,&y,&z,&ix,&iy,&iz); + n = 7 - sscanf(bufptr,TAGINT_FORMAT " %lg %lg %lg %d %d %d", + &itag,&x,&y,&z,&ix,&iy,&iz); else - n = sscanf(bufptr,TAGINT_FORMAT " %lg %lg %lg",&itag,&x,&y,&z); + n = 4 - sscanf(bufptr,TAGINT_FORMAT " %lg %lg %lg",&itag,&x,&y,&z); - if (n < 0) { - if (me == 0) error->warning(FLERR,"Ignoring empty or incorrectly" - " formatted line in target file"); + if (n != 0) { + error->all(FLERR,"Incorrectly formatted line in TMD target file"); bufptr = next + 1; continue; } -- GitLab From 502fbfb78a76b2e77b3ff32d7807deb29631ad64 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 19 Jul 2019 15:20:22 -0600 Subject: [PATCH 282/469] Fix memory issue --- src/KOKKOS/pair_snap_kokkos_impl.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index e53332050a..95afcc5ec7 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -208,7 +208,7 @@ void PairSNAPKokkos::compute(int eflag_in, int vflag_in) d_ninside = Kokkos::View("PairSNAPKokkos:ninside",inum); } - int chunk_size = 2000; + int chunk_size = MIN(2000,inum); chunk_offset = 0; snaKK.grow_rij(chunk_size,max_neighs); -- GitLab From 9239c9dedb0563aa00ffe12d08d54a44c574af47 Mon Sep 17 00:00:00 2001 From: Adrian-Diaz Date: Fri, 19 Jul 2019 17:13:44 -0600 Subject: [PATCH 283/469] patch niche rcb issue --- src/rcb.cpp | 32 ++++++++++++++++++++++++++++++++ 1 file changed, 32 insertions(+) diff --git a/src/rcb.cpp b/src/rcb.cpp index 83cdccdf80..ac7ac60b1f 100644 --- a/src/rcb.cpp +++ b/src/rcb.cpp @@ -467,6 +467,38 @@ void RCB::compute(int dimension, int n, double **x, double *wt, } } + //check if zero box width is the result due to dots being on box vertices + //select half of the box in this case along the best dim + //the best dim is chosen according to the optimum volume (to minimize surface area) + + if(largest==0.0){ + double best_volume=0; + double current_volume; + int dim1o,dim2o; + for (dim = 0; dim < dimension; dim++){ + if(dim==0){ + dim1o=1; + dim2o=2; + } + if(dim==1){ + dim1o=0; + dim2o=2; + } + if(dim==2){ + dim1o=0; + dim2o=1; + } + valuehalf = 0.5*(lo[dim] + hi[dim]); + current_volume = (hi[dim1o]-lo[dim1o]) + *(hi[dim2o]-lo[dim2o])*(valuehalf-lo[dim]); + //chose cut that minimizes surface area by maximizing volume; + if(current_volume>best_volume){ best_volume = current_volume; + valuehalf_select = valuehalf; + dim_select = dim; + } + } + } + // copy results for best dim cut into dim,valuehalf,dotmark dim = dim_select; -- GitLab From f2978475afd78e28232289b19b7bd7b1fbe2d7a2 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Sun, 21 Jul 2019 15:17:53 -0500 Subject: [PATCH 284/469] Update docs * bring homebrew install notes up-to-date * update openkim docs --- doc/src/Build_extras.txt | 18 ++++++---------- doc/src/Examples.txt | 4 +++- doc/src/Install_mac.txt | 43 +++++++++++++------------------------- doc/src/Intro_features.txt | 4 ++-- doc/src/fix_adapt.txt | 3 +-- doc/src/kim_commands.txt | 3 +++ 6 files changed, 30 insertions(+), 45 deletions(-) diff --git a/doc/src/Build_extras.txt b/doc/src/Build_extras.txt index 1d9a7abfcf..e6791de21b 100644 --- a/doc/src/Build_extras.txt +++ b/doc/src/Build_extras.txt @@ -176,19 +176,13 @@ use with LAMMPS. If you want to use the "kim_query"_kim_commands.html command, you also need to have libcurl installed with the matching development headers and the curl-config tool. -Note that in LAMMPS jargon, a KIM model driver is a pair style -(e.g. EAM or Tersoff). A KIM model is a pair style for a particular -element or alloy and set of parameters, e.g. EAM for Cu with a -specific EAM potential file. Also note that when downloading and -installing from source -the KIM API library with all its models, may take a long time (tens of -minutes to hours) to build. Of course you only need to do that once. - -See the list of KIM model drivers here: -https://openkim.org/browse/model-drivers/alphabetical +See "Obtaining KIM Models"_http://openkim.org/doc/usage/obtaining-models to +learn how to install a pre-build binary of the OpenKIM Repository of Models. +See the list of all KIM models here: https://openkim.org/browse/models -See the list of all KIM models here: -https://openkim.org/browse/models/by-model-drivers +(Also note that when downloading and installing from source +the KIM API library with all its models, may take a long time (tens of +minutes to hours) to build. Of course you only need to do that once.) [CMake build]: diff --git a/doc/src/Examples.txt b/doc/src/Examples.txt index fcf01de383..36d0ac86f9 100644 --- a/doc/src/Examples.txt +++ b/doc/src/Examples.txt @@ -73,7 +73,7 @@ granregion: use of fix wall/region/gran as boundary on granular particles hugoniostat: Hugoniostat shock dynamics hyper: global and local hyperdynamics of diffusion on Pt surface indent: spherical indenter into a 2d solid -kim: use of potentials in Knowledge Base for Interatomic Models (KIM) +kim: use of potentials from the "OpenKIM Repository"_openkim latte: examples for using fix latte for DFTB via the LATTE library meam: MEAM test for SiC and shear (same as shear examples) melt: rapid melt of 3d LJ system @@ -153,3 +153,5 @@ illustrate how to use the command(s) provided in that package. Many of the sub-directories have their own README files which give further instructions. See the "Packages_details"_Packages_details.html doc page for more info on specific USER packages. + +:link(openkim,https://openkim.org) diff --git a/doc/src/Install_mac.txt b/doc/src/Install_mac.txt index 3ab119522c..e277f7e0e4 100644 --- a/doc/src/Install_mac.txt +++ b/doc/src/Install_mac.txt @@ -10,47 +10,34 @@ Documentation"_ld - "LAMMPS Commands"_lc :c Download an executable for Mac :h3 LAMMPS can be downloaded, built, and configured for OS X on a Mac with -"Homebrew"_homebrew. Only four of the LAMMPS packages are unavailable -at this time because of additional needs not yet met: KIM, GPU, -USER-INTEL, USER-ATC. +"Homebrew"_homebrew. The following LAMMPS packages are unavailable at this +time because of additional needs not yet met: GPU, KOKKOS, LATTE, MSCG, +MESSAGE, MPIIO POEMS VORONOI. After installing Homebrew, you can install LAMMPS on your system with the following commands: -% brew tap homebrew/science -% brew install lammps # serial version -% brew install lammps --with-mpi # mpi support :pre +% brew install lammps :pre -This will install the executable "lammps", a python module named -"lammps", and additional resources with all the standard packages. To -get the location of the additional resources type this: - -% brew info lammps :pre - -This command also tells you additional installation options available. -The user-packages are available as options, just install them like -this example for the USER-OMP package: - -% brew install lammps --enable-user-omp :pre - -It is usually best to install LAMMPS with the most up to date source -files, which can be done with the "--HEAD" option: - -% brew install lammps --HEAD :pre - -To re-install the LAMMPS HEAD, run this command occasionally (make sure -to use the desired options). - -% brew install --force lammps --HEAD $\{options\} :pre +This will install the executables "lammps_serial" and "lammps_mpi", as well as +the LAMMPS "doc", "potentials", "tools", "bench", and "examples" directories. Once LAMMPS is installed, you can test the installation with the Lennard-Jones benchmark file: % brew test lammps -v :pre +The LAMMPS binary is built with the "KIM package"_Build_extras#kim which +results in homebrew also installing the `kim-api` binaries when LAMMPS is +installed. In order to use potentials from "openkim.org"_openkim, you can +install the `openkim-models` package + +% brew install openkim-models :pre + If you have problems with the installation you can post issues to "this link"_homebrew. Thanks to Derek Thomas (derekt at cello.t.u-tokyo.ac.jp) for setting up the Homebrew capability. -:link(homebrew,https://github.com/Homebrew/homebrew-science/issues) +:link(homebrew,https://github.com/Homebrew/homebrew-core/issues) +:link(openkim,https://openkim.org) diff --git a/doc/src/Intro_features.txt b/doc/src/Intro_features.txt index 629e8210b7..d133fd8064 100644 --- a/doc/src/Intro_features.txt +++ b/doc/src/Intro_features.txt @@ -92,8 +92,8 @@ commands) implicit solvent potentials: hydrodynamic lubrication, Debye force-field compatibility with common CHARMM, AMBER, DREIDING, \ OPLS, GROMACS, COMPASS options - access to "KIM archive"_http://openkim.org of potentials via \ - "pair kim"_pair_kim.html + access to the "OpenKIM Repository"_http://openkim.org of potentials via \ + "kim_init, kim_interactions, and kim_query"_kim_commands.html commands hybrid potentials: multiple pair, bond, angle, dihedral, improper \ potentials can be used in one simulation overlaid potentials: superposition of multiple pair potentials :ul diff --git a/doc/src/fix_adapt.txt b/doc/src/fix_adapt.txt index 0d862a890d..4f047ec42d 100644 --- a/doc/src/fix_adapt.txt +++ b/doc/src/fix_adapt.txt @@ -149,8 +149,7 @@ meaning of these parameters: "spin/neel"_pair_spin_neel.html: coulombic_cutoff: type global: "table"_pair_table.html: table_cutoff: type pairs: "ufm"_pair_ufm.html: epsilon,sigma: type pairs: -"soft"_pair_soft.html: a: type pairs: -"kim"_pair_kim.html: PARAM_FREE_*:i,j,...: global :tb(c=3,s=:) +"soft"_pair_soft.html: a: type pairs: :tb(c=3,s=:) NOTE: It is easy to add new pairwise potentials and their parameters to this list. All it typically takes is adding an extract() method to diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 7c88fd084a..169f96e6e8 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -116,6 +116,9 @@ See the "current list of KIM PMs and SMs archived in OpenKIM"_https://openkim.or This list is sorted by species and can be filtered to display only IMs for certain species combinations. +See "Obtaining KIM Models"_http://openkim.org/doc/usage/obtaining-models to +learn how to install a pre-build binary of the OpenKIM Repository of Models. + NOTE: It is also possible to locally install IMs not archived in OpenKIM, in which case their names do not have to conform to the KIM ID format. -- GitLab From c831cee21dad5e5009960498930e0543f692c2a2 Mon Sep 17 00:00:00 2001 From: Rupert Nash Date: Mon, 22 Jul 2019 09:46:01 +0100 Subject: [PATCH 285/469] Fix typos in documentation --- doc/src/compute_momentum.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_momentum.txt b/doc/src/compute_momentum.txt index fc5243583e..2c6ec78cf3 100644 --- a/doc/src/compute_momentum.txt +++ b/doc/src/compute_momentum.txt @@ -29,7 +29,7 @@ the mass and velocity of the particle. [Output info:] -This compute calculates a global vector (the summed momentum) on +This compute calculates a global vector (the summed momentum) of length 3. This value can be used by any command that uses a global vector value from a compute as input. See the "Howto output"_Howto_output.html doc page for an overview of LAMMPS output -- GitLab From f5beb418e8e983d6eb32908cb1da18168b0820ca Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Mon, 22 Jul 2019 10:54:53 -0500 Subject: [PATCH 286/469] Put in KIM ID for IFF model in kim_commands usage examples --- doc/src/kim_commands.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 7c88fd084a..dbe0608b5e 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -33,7 +33,7 @@ kim_interactions Si kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 metal unit_conversion_mode kim_interactions C H O -kim_init Sim_LAMMPS_IFF_OtherInfo_AuthorList_Year_Species__SM_064312669787_000 real +Sim_LAMMPS_IFF_PCFF_HeinzMishraLinEmami_2015Ver1v5_FccmetalsMineralsSolvents Polymers__SM_064312669787_000 real kim_interactions fixed_types kim_query a0 get_lattice_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\["angstrom"\] :pre -- GitLab From 320be3bcef1b9e08a9a6c4b184fe6b1f687509da Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 22 Jul 2019 14:22:36 -0400 Subject: [PATCH 287/469] undo changes to poems library and package as they fail regression testing --- lib/poems/POEMSChain.h | 99 +++--- lib/poems/SystemProcessor.h | 439 ++++++++++++----------- lib/poems/body.cpp | 15 +- lib/poems/body.h | 23 +- lib/poems/body23joint.cpp | 17 +- lib/poems/body23joint.h | 9 +- lib/poems/colmatmap.cpp | 2 - lib/poems/colmatmap.h | 6 +- lib/poems/colmatrix.cpp | 5 +- lib/poems/colmatrix.h | 45 ++- lib/poems/defines.h | 7 +- lib/poems/eulerparameters.cpp | 46 ++- lib/poems/eulerparameters.h | 9 +- lib/poems/fastmatrixops.cpp | 143 ++++---- lib/poems/fastmatrixops.h | 17 +- lib/poems/fixedpoint.cpp | 5 - lib/poems/fixedpoint.h | 5 +- lib/poems/freebodyjoint.cpp | 136 ++++--- lib/poems/freebodyjoint.h | 11 +- lib/poems/inertialframe.cpp | 6 +- lib/poems/inertialframe.h | 7 +- lib/poems/joint.cpp | 23 +- lib/poems/joint.h | 12 +- lib/poems/mat3x3.cpp | 5 +- lib/poems/mat3x3.h | 17 +- lib/poems/mat4x4.cpp | 4 - lib/poems/mat4x4.h | 15 +- lib/poems/mat6x6.cpp | 4 - lib/poems/mat6x6.h | 6 +- lib/poems/matrices.h | 13 +- lib/poems/matrix.cpp | 2 - lib/poems/matrix.h | 10 +- lib/poems/matrixfun.cpp | 58 ++- lib/poems/matrixfun.h | 35 +- lib/poems/mixedjoint.cpp | 141 ++++---- lib/poems/mixedjoint.h | 16 +- lib/poems/norm.cpp | 8 - lib/poems/norm.h | 14 +- lib/poems/onbody.cpp | 9 +- lib/poems/onbody.h | 118 +++--- lib/poems/onfunctions.cpp | 49 ++- lib/poems/onfunctions.h | 8 +- lib/poems/onsolver.cpp | 16 +- lib/poems/onsolver.h | 51 ++- lib/poems/particle.cpp | 3 +- lib/poems/particle.h | 12 +- lib/poems/poemslist.h | 74 ++-- lib/poems/poemsnodelib.h | 11 +- lib/poems/poemsobject.cpp | 2 - lib/poems/poemsobject.h | 4 +- lib/poems/poemstree.h | 4 +- lib/poems/poemstreenode.cpp | 2 - lib/poems/poemstreenode.h | 47 +-- lib/poems/point.cpp | 8 +- lib/poems/point.h | 18 +- lib/poems/prismaticjoint.cpp | 6 - lib/poems/prismaticjoint.h | 9 +- lib/poems/revolutejoint.cpp | 6 - lib/poems/revolutejoint.h | 8 +- lib/poems/rigidbody.cpp | 5 +- lib/poems/rigidbody.h | 5 +- lib/poems/rowmatrix.cpp | 4 +- lib/poems/rowmatrix.h | 6 +- lib/poems/solver.cpp | 5 +- lib/poems/solver.h | 23 +- lib/poems/sphericaljoint.cpp | 206 ++++++----- lib/poems/sphericaljoint.h | 9 +- lib/poems/system.cpp | 632 ++++++++++++++++----------------- lib/poems/system.h | 58 ++- lib/poems/vect3.cpp | 11 - lib/poems/vect3.h | 12 +- lib/poems/vect4.cpp | 4 - lib/poems/vect4.h | 13 +- lib/poems/vect6.cpp | 4 - lib/poems/vect6.h | 6 +- lib/poems/virtualcolmatrix.cpp | 2 - lib/poems/virtualcolmatrix.h | 40 +-- lib/poems/virtualmatrix.cpp | 6 +- lib/poems/virtualmatrix.h | 3 +- lib/poems/virtualrowmatrix.cpp | 2 - lib/poems/virtualrowmatrix.h | 11 +- lib/poems/workspace.cpp | 21 +- lib/poems/workspace.h | 78 ++-- src/POEMS/fix_poems.cpp | 2 +- src/POEMS/fix_poems.h | 3 +- 85 files changed, 1407 insertions(+), 1664 deletions(-) diff --git a/lib/poems/POEMSChain.h b/lib/poems/POEMSChain.h index 8baa293dbd..9f0db59333 100644 --- a/lib/poems/POEMSChain.h +++ b/lib/poems/POEMSChain.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: PoemsChain.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -19,59 +19,56 @@ #define POEMSCHAIN_H_ #include "poemslist.h" -#include -namespace POEMS { struct ChildRingData { - List * childRing; - int entranceNodeId; + List * childRing; + int entranceNodeId; }; struct POEMSChain{ - ~POEMSChain(){ - for(int i = 0; i < childChains.GetNumElements(); i++) - { - delete childChains(i); - } - listOfNodes.DeleteValues(); - } - //void printTreeStructure(int tabs); - //void getTreeAsList(List * temp); - List listOfNodes; - List childChains; - POEMSChain * parentChain; - List childRings; - - - void printTreeStructure(int tabs){ - for(int i = 0; i < tabs; i++) - { - std::cout << "\t"; - } - std::cout << "Chain: "; - for(int i = 0; i < listOfNodes.GetNumElements(); i++) - { - std::cout << *(listOfNodes(i)) << " "; - } - std::cout << std::endl; - for(int i = 0; i < childChains.GetNumElements(); i++) - { - childChains(i)->printTreeStructure(tabs + 1); - } - } - void getTreeAsList(List * temp) - { - for(int i = 0; i < listOfNodes.GetNumElements(); i++) - { - int * integer = new int; - *integer = *(listOfNodes(i)); - temp->Append(integer); - } - for(int i = 0; i < childChains.GetNumElements(); i++) - { - childChains(i)->getTreeAsList(temp); - } - } + ~POEMSChain(){ + for(int i = 0; i < childChains.GetNumElements(); i++) + { + delete childChains(i); + } + listOfNodes.DeleteValues(); + } + //void printTreeStructure(int tabs); + //void getTreeAsList(List * temp); + List listOfNodes; + List childChains; + POEMSChain * parentChain; + List childRings; + + + void printTreeStructure(int tabs){ + for(int i = 0; i < tabs; i++) + { + cout << "\t"; + } + cout << "Chain: "; + for(int i = 0; i < listOfNodes.GetNumElements(); i++) + { + cout << *(listOfNodes(i)) << " "; + } + cout << endl; + for(int i = 0; i < childChains.GetNumElements(); i++) + { + childChains(i)->printTreeStructure(tabs + 1); + } + } + void getTreeAsList(List * temp) + { + for(int i = 0; i < listOfNodes.GetNumElements(); i++) + { + int * integer = new int; + *integer = *(listOfNodes(i)); + temp->Append(integer); + } + for(int i = 0; i < childChains.GetNumElements(); i++) + { + childChains(i)->getTreeAsList(temp); + } + } }; -} #endif diff --git a/lib/poems/SystemProcessor.h b/lib/poems/SystemProcessor.h index a6001d96d0..3be168c34d 100644 --- a/lib/poems/SystemProcessor.h +++ b/lib/poems/SystemProcessor.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: SystemProcessor.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,61 +11,59 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef _SYS_PROCESSOR_H_ #define _SYS_PROCESSOR_H_ -#include #include "poemslist.h" #include "poemstree.h" #include "POEMSChain.h" -namespace POEMS { struct POEMSNode { - List links; - List taken; - int idNumber; - bool visited; - - ~POEMSNode(){ - for(int i = 0; i < taken.GetNumElements(); i++) - { - delete taken(i); - } - }; + List links; + List taken; + int idNumber; + bool visited; + + ~POEMSNode(){ + for(int i = 0; i < taken.GetNumElements(); i++) + { + delete taken(i); + } + }; }; class SystemProcessor{ private: - Tree nodes; - static void POEMSNodeDelete_cb(void *node) { - delete (POEMSNode *) node; - } - List headsOfSystems; - List > ringsInSystem; - POEMSNode * findSingleLink(TreeNode * aNode); - POEMSChain * AddNewChain(POEMSNode * currentNode); - bool setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNode); + Tree nodes; + static void POEMSNodeDelete_cb(void *node) { + delete (POEMSNode *) node; + } + List headsOfSystems; + List > ringsInSystem; + POEMSNode * findSingleLink(TreeNode * aNode); + POEMSChain * AddNewChain(POEMSNode * currentNode); + bool setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNode); public: - SystemProcessor(void); - - ~SystemProcessor(void) { - headsOfSystems.DeleteValues(); - for(int i = 0; i < ringsInSystem.GetNumElements(); i++) - { - for(int k = 0; k < ringsInSystem(i)->GetNumElements(); i++) - { - delete (*ringsInSystem(i))(k); - } - } - }; - void processArray(int** links, int numLinks); - List * getSystemData(); - int getNumberOfHeadChains(); + SystemProcessor(void); + + ~SystemProcessor(void) { + headsOfSystems.DeleteValues(); + for(int i = 0; i < ringsInSystem.GetNumElements(); i++) + { + for(int k = 0; k < ringsInSystem(i)->GetNumElements(); i++) + { + delete (*ringsInSystem(i))(k); + } + } + }; + void processArray(int** links, int numLinks); + List * getSystemData(); + int getNumberOfHeadChains(); }; SystemProcessor::SystemProcessor(void){ @@ -75,145 +73,145 @@ SystemProcessor::SystemProcessor(void){ void SystemProcessor::processArray(int** links, int numLinks) { - bool * false_var; //holds the value false; needed because a constant cannot be put into a list; the list requires a - //reference. - for(int i = 0; i < numLinks; i++) //go through all the links in the input array - { - if(!nodes.Find(links[i][0])) //if the first node in the pair is not found in the storage tree - { - POEMSNode * newNode = new POEMSNode; //make a new node -// forDeletion.Append(newNode); - newNode->idNumber = links[i][0]; //set its ID to the value - newNode->visited = false; //set it to be unvisited - nodes.Insert(links[i][0], links[i][0], (void *) newNode); //and add it to the tree storage structure - } - if(!nodes.Find(links[i][1])) //repeat process for the other half of each link - { - POEMSNode * newNode = new POEMSNode; -// forDeletion.Append(newNode); - newNode->idNumber = links[i][1]; - newNode->visited = false; - nodes.Insert(links[i][1], links[i][1], (void *) newNode); - } - POEMSNode * firstNode = (POEMSNode *)nodes.Find(links[i][0]); //now that we are sure both nodes exist, - POEMSNode * secondNode = (POEMSNode *)nodes.Find(links[i][1]); //we can get both of them out of the tree - firstNode->links.Append(secondNode); //and add the link from the first to the second... - false_var = new bool; - *false_var = false; //make a new false boolean to note that the link between these two - firstNode->taken.Append(false_var); //has not already been taken, and append it to the taken list - secondNode->links.Append(firstNode); //repeat process for link from second node to first - false_var = new bool; - *false_var = false; - secondNode->taken.Append(false_var); - } - - TreeNode * temp = nodes.GetRoot(); //get the root node of the node storage tree - POEMSNode * currentNode; - do - { - currentNode = findSingleLink(temp); //find the start of the next available chain - if(currentNode != NULL) - { - headsOfSystems.Append(AddNewChain(currentNode)); //and add it to the headsOfSystems list of chains - } - } - while(currentNode != NULL); //repeat this until all chains have been added + bool * false_var; //holds the value false; needed because a constant cannot be put into a list; the list requires a + //reference. + for(int i = 0; i < numLinks; i++) //go through all the links in the input array + { + if(!nodes.Find(links[i][0])) //if the first node in the pair is not found in the storage tree + { + POEMSNode * newNode = new POEMSNode; //make a new node +// forDeletion.Append(newNode); + newNode->idNumber = links[i][0]; //set its ID to the value + newNode->visited = false; //set it to be unvisited + nodes.Insert(links[i][0], links[i][0], (void *) newNode); //and add it to the tree storage structure + } + if(!nodes.Find(links[i][1])) //repeat process for the other half of each link + { + POEMSNode * newNode = new POEMSNode; +// forDeletion.Append(newNode); + newNode->idNumber = links[i][1]; + newNode->visited = false; + nodes.Insert(links[i][1], links[i][1], (void *) newNode); + } + POEMSNode * firstNode = (POEMSNode *)nodes.Find(links[i][0]); //now that we are sure both nodes exist, + POEMSNode * secondNode = (POEMSNode *)nodes.Find(links[i][1]); //we can get both of them out of the tree + firstNode->links.Append(secondNode); //and add the link from the first to the second... + false_var = new bool; + *false_var = false; //make a new false boolean to note that the link between these two + firstNode->taken.Append(false_var); //has not already been taken, and append it to the taken list + secondNode->links.Append(firstNode); //repeat process for link from second node to first + false_var = new bool; + *false_var = false; + secondNode->taken.Append(false_var); + } + + TreeNode * temp = nodes.GetRoot(); //get the root node of the node storage tree + POEMSNode * currentNode; + do + { + currentNode = findSingleLink(temp); //find the start of the next available chain + if(currentNode != NULL) + { + headsOfSystems.Append(AddNewChain(currentNode)); //and add it to the headsOfSystems list of chains + } + } + while(currentNode != NULL); //repeat this until all chains have been added } POEMSChain * SystemProcessor::AddNewChain(POEMSNode * currentNode){ - if(currentNode == NULL) //Termination condition; if the currentNode is null, then return null - { - return NULL; - } - int * tmp; - POEMSNode * nextNode = NULL; //nextNode stores the proposed next node to add to the chain. this will be checked to make sure no backtracking is occuring before being assigned as the current node. - POEMSChain * newChain = new POEMSChain; //make a new POEMSChain object. This will be the object returned + if(currentNode == NULL) //Termination condition; if the currentNode is null, then return null + { + return NULL; + } + int * tmp; + POEMSNode * nextNode = NULL; //nextNode stores the proposed next node to add to the chain. this will be checked to make sure no backtracking is occuring before being assigned as the current node. + POEMSChain * newChain = new POEMSChain; //make a new POEMSChain object. This will be the object returned - if(currentNode->links.GetNumElements() == 0) //if we have no links from this node, then the whole chain is only one node. Add this node to the chain and return it; mark node as visited for future reference - { - currentNode->visited = true; - tmp = new int; - *tmp = currentNode->idNumber; - newChain->listOfNodes.Append(tmp); - return newChain; - } - while(currentNode->links.GetNumElements() <= 2) //we go until we get to a node that branches, or both branches have already been taken both branches can already be taken if a loop with no spurs is found in the input data - { - currentNode->visited = true; - tmp = new int; - *tmp = currentNode->idNumber; - newChain->listOfNodes.Append(tmp); //append the current node to the chain & mark as visited - //std::cout << "Appending node " << currentNode->idNumber << " to chain" << std::endl; - nextNode = currentNode->links.GetHeadElement()->value; //the next node is the first or second value stored in the links array - //of the current node. We get the first value... - if(!setLinkVisited(currentNode, nextNode)) //...and see if it points back to where we came from. If it does... - { //either way, we set this link as visited - if(currentNode->links.GetNumElements() == 1) //if it does, then if that is the only link to this node, we're done with the chain, so append the chain to the list and return the newly created chain - { -// headsOfSystems.Append(newChain); - return newChain; - } - nextNode = currentNode->links.GetHeadElement()->next->value;//follow the other link if there is one, so we go down the chain - if(!setLinkVisited(currentNode, nextNode)) //mark link as followed, so we know not to backtrack - { - // headsOfSystems.Append(newChain); - return newChain; //This condition, where no branches have occurred but both links have already - //been taken can only occur in a loop with no spurs; add this loop to the - //system (currently added as a chain for consistency), and return. - } - } - currentNode = nextNode; //set the current node to be the next node in the chain - } - currentNode->visited = true; - tmp = new int; - *tmp = currentNode->idNumber; - newChain->listOfNodes.Append(tmp); //append the last node before branch (node shared jointly with branch chains) - //re-mark as visited, just to make sure - ListElement * tempNode = currentNode->links.GetHeadElement(); //go through all of the links, one at a time that branch - POEMSChain * tempChain = NULL; //temporary variable to hold data - while(tempNode != NULL) //when we have followed all links, stop - { - if(setLinkVisited(tempNode->value, currentNode)) //dont backtrack, or create closed loops - { - tempChain = AddNewChain(tempNode->value); //Add a new chain created out of the next node down that link - tempChain->parentChain = newChain; //set the parent to be this chain - newChain->childChains.Append(tempChain); //append the chain to this chain's list of child chains - } - tempNode = tempNode->next; //go to process the next chain - } - //headsOfSystems.Append(newChain); //append this chain to the system list - return newChain; + if(currentNode->links.GetNumElements() == 0) //if we have no links from this node, then the whole chain is only one node. Add this node to the chain and return it; mark node as visited for future reference + { + currentNode->visited = true; + tmp = new int; + *tmp = currentNode->idNumber; + newChain->listOfNodes.Append(tmp); + return newChain; + } + while(currentNode->links.GetNumElements() <= 2) //we go until we get to a node that branches, or both branches have already been taken both branches can already be taken if a loop with no spurs is found in the input data + { + currentNode->visited = true; + tmp = new int; + *tmp = currentNode->idNumber; + newChain->listOfNodes.Append(tmp); //append the current node to the chain & mark as visited + //cout << "Appending node " << currentNode->idNumber << " to chain" << endl; + nextNode = currentNode->links.GetHeadElement()->value; //the next node is the first or second value stored in the links array + //of the current node. We get the first value... + if(!setLinkVisited(currentNode, nextNode)) //...and see if it points back to where we came from. If it does... + { //either way, we set this link as visited + if(currentNode->links.GetNumElements() == 1) //if it does, then if that is the only link to this node, we're done with the chain, so append the chain to the list and return the newly created chain + { +// headsOfSystems.Append(newChain); + return newChain; + } + nextNode = currentNode->links.GetHeadElement()->next->value;//follow the other link if there is one, so we go down the chain + if(!setLinkVisited(currentNode, nextNode)) //mark link as followed, so we know not to backtrack + { + // headsOfSystems.Append(newChain); + return newChain; //This condition, where no branches have occurred but both links have already + //been taken can only occur in a loop with no spurs; add this loop to the + //system (currently added as a chain for consistency), and return. + } + } + currentNode = nextNode; //set the current node to be the next node in the chain + } + currentNode->visited = true; + tmp = new int; + *tmp = currentNode->idNumber; + newChain->listOfNodes.Append(tmp); //append the last node before branch (node shared jointly with branch chains) + //re-mark as visited, just to make sure + ListElement * tempNode = currentNode->links.GetHeadElement(); //go through all of the links, one at a time that branch + POEMSChain * tempChain = NULL; //temporary variable to hold data + while(tempNode != NULL) //when we have followed all links, stop + { + if(setLinkVisited(tempNode->value, currentNode)) //dont backtrack, or create closed loops + { + tempChain = AddNewChain(tempNode->value); //Add a new chain created out of the next node down that link + tempChain->parentChain = newChain; //set the parent to be this chain + newChain->childChains.Append(tempChain); //append the chain to this chain's list of child chains + } + tempNode = tempNode->next; //go to process the next chain + } + //headsOfSystems.Append(newChain); //append this chain to the system list + return newChain; } POEMSNode * SystemProcessor::findSingleLink(TreeNode * aNode) //This function takes the root of a search tree containing POEMSNodes and returns a POEMSNode corresponding to the start of a chain in the //system. It finds a node that has not been visited before, and only has one link; this node will be used as the head of the chain. { - if(aNode == NULL) - { - return NULL; - } - POEMSNode * returnVal = (POEMSNode *)aNode->GetAuxData(); //get the poemsnode data out of the treenode - POEMSNode * detectLoneLoops = NULL; //is used to handle a loop that has no protruding chains - if(returnVal->visited == false) - { - detectLoneLoops = returnVal; //if we find any node that has not been visited yet, save it - } - if(returnVal->links.GetNumElements() == 1 && returnVal->visited == false) //see if it has one element and hasnt been visited already - { - return returnVal; //return the node is it meets this criteria - } - returnVal = findSingleLink(aNode->Left()); //otherwise, check the left subtree - if(returnVal == NULL) //and if we find nothing... - { - returnVal = findSingleLink(aNode->Right()); //check the right subtree - } - if(returnVal == NULL) //if we could not find any chains - { - returnVal = detectLoneLoops; //see if we found any nodes at all that havent been processed - } - return returnVal; //return what we find (will be NULL if no new chains are - //found) + if(aNode == NULL) + { + return NULL; + } + POEMSNode * returnVal = (POEMSNode *)aNode->GetAuxData(); //get the poemsnode data out of the treenode + POEMSNode * detectLoneLoops = NULL; //is used to handle a loop that has no protruding chains + if(returnVal->visited == false) + { + detectLoneLoops = returnVal; //if we find any node that has not been visited yet, save it + } + if(returnVal->links.GetNumElements() == 1 && returnVal->visited == false) //see if it has one element and hasnt been visited already + { + return returnVal; //return the node is it meets this criteria + } + returnVal = findSingleLink(aNode->Left()); //otherwise, check the left subtree + if(returnVal == NULL) //and if we find nothing... + { + returnVal = findSingleLink(aNode->Right()); //check the right subtree + } + if(returnVal == NULL) //if we could not find any chains + { + returnVal = detectLoneLoops; //see if we found any nodes at all that havent been processed + } + return returnVal; //return what we find (will be NULL if no new chains are + //found) } bool SystemProcessor::setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNode) @@ -225,66 +223,65 @@ bool SystemProcessor::setLinkVisited(POEMSNode * firstNode, POEMSNode * secondNo //value for that particular link. Because each link is represented twice, (once at each node in the link), both of the boolean values need //to be set in the event that the link has to be set as visited. { - //std::cout << "Checking link between nodes " << firstNode->idNumber << " and " << secondNode->idNumber << "... "; - ListElement * tmp = firstNode->links.GetHeadElement(); //get the head element of the list of pointers for node 1 - ListElement * tmp2 = firstNode->taken.GetHeadElement(); //get the head element of the list of bool isVisited flags for node 1 - while(tmp->value != NULL || tmp2->value != NULL) //go through untill we reach the end of the lists - { - if(tmp->value == secondNode) //if we find the link to the other node - { - if(*(tmp2->value) == true) //if the link has already been visited - { - //std::cout << "visited already" << std::endl; - return false; //return false to indicate that the link has been visited before this attempt - } - else //otherwise, visit it - { - *tmp2->value = true; - } - break; - } - tmp = tmp->next; //go check next link - tmp2 = tmp2->next; - } + //cout << "Checking link between nodes " << firstNode->idNumber << " and " << secondNode->idNumber << "... "; + ListElement * tmp = firstNode->links.GetHeadElement(); //get the head element of the list of pointers for node 1 + ListElement * tmp2 = firstNode->taken.GetHeadElement(); //get the head element of the list of bool isVisited flags for node 1 + while(tmp->value != NULL || tmp2->value != NULL) //go through untill we reach the end of the lists + { + if(tmp->value == secondNode) //if we find the link to the other node + { + if(*(tmp2->value) == true) //if the link has already been visited + { + //cout << "visited already" << endl; + return false; //return false to indicate that the link has been visited before this attempt + } + else //otherwise, visit it + { + *tmp2->value = true; + } + break; + } + tmp = tmp->next; //go check next link + tmp2 = tmp2->next; + } - tmp = secondNode->links.GetHeadElement(); //now, if the link was unvisited, we need to go set the other node's list such that - //it also knows this link is being visited - tmp2 = secondNode->taken.GetHeadElement(); - while(tmp->value != NULL || tmp2->value != NULL) //go through the list - { - if(tmp->value == firstNode) //if we find the link - { - if(*(tmp2->value) == true) //and it has already been visited, then signal an error; this shouldnt ever happen - { - std::cout << "Error in parsing structure! Should never reach this condition! \n" << - "Record of visited links out of synch between two adjacent nodes.\n"; - return false; - } - else - { - *tmp2->value = true; //set the appropriate value to true to indicate this link has been visited - } - break; - } - tmp = tmp->next; - tmp2 = tmp2->next; - } - //std::cout << "not visited" << std::endl; - return true; //return true to indicate that this is the first time the link has been visited + tmp = secondNode->links.GetHeadElement(); //now, if the link was unvisited, we need to go set the other node's list such that + //it also knows this link is being visited + tmp2 = secondNode->taken.GetHeadElement(); + while(tmp->value != NULL || tmp2->value != NULL) //go through the list + { + if(tmp->value == firstNode) //if we find the link + { + if(*(tmp2->value) == true) //and it has already been visited, then signal an error; this shouldnt ever happen + { + cout << "Error in parsing structure! Should never reach this condition! \n" << + "Record of visited links out of synch between two adjacent nodes.\n"; + return false; + } + else + { + *tmp2->value = true; //set the appropriate value to true to indicate this link has been visited + } + break; + } + tmp = tmp->next; + tmp2 = tmp2->next; + } + //cout << "not visited" << endl; + return true; //return true to indicate that this is the first time the link has been visited } -List * SystemProcessor::getSystemData(void) //Gets the list of POEMSChains that comprise the system. Might eventually only - //return chains linked to the reference plane, but currently returns every chain - //in the system. +List * SystemProcessor::getSystemData(void) //Gets the list of POEMSChains that comprise the system. Might eventually only + //return chains linked to the reference plane, but currently returns every chain + //in the system. { - return &headsOfSystems; + return &headsOfSystems; } int SystemProcessor::getNumberOfHeadChains(void) //This function isnt implemented yet, and might be taken out entirely; this was a holdover - //from when I intended to return an array of chain pointers, rather than a list of chains - //It will probably be deleted once I finish figuring out exactly what needs to be returned + //from when I intended to return an array of chain pointers, rather than a list of chains + //It will probably be deleted once I finish figuring out exactly what needs to be returned { - return 0; -} + return 0; } #endif diff --git a/lib/poems/body.cpp b/lib/poems/body.cpp index 6825941b93..4ef05dd1e6 100644 --- a/lib/poems/body.cpp +++ b/lib/poems/body.cpp @@ -14,20 +14,11 @@ * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - -#include - -#include "body.h" -#include "inertialframe.h" -#include "mat3x3.h" -#include "particle.h" -#include "poemslist.h" + +#include "bodies.h" #include "point.h" -#include "rigidbody.h" -#include "vect3.h" using namespace std; -using namespace POEMS; Body::Body() { @@ -131,7 +122,7 @@ void Body::AddPoint(Point* point){ // global body functions // -Body* POEMS::NewBody(int type){ +Body* NewBody(int type){ switch( BodyType(type) ) { case INERTIALFRAME : // The inertial reference frame diff --git a/lib/poems/body.h b/lib/poems/body.h index e2394b40aa..f8e0f6a5a3 100644 --- a/lib/poems/body.h +++ b/lib/poems/body.h @@ -19,29 +19,30 @@ #ifndef BODY_H #define BODY_H -#include #include "poemslist.h" +#include #include "poemsobject.h" -#include "mat3x3.h" -#include "vect3.h" -namespace POEMS { +#include "matrices.h" + + + // emumerated type enum BodyType { INERTIALFRAME = 0, PARTICLE = 1, RIGIDBODY = 2 }; - + class Point; class Joint; - +class CompBody; class Body : public POEMSObject { public: double mass; Mat3x3 inertia; - + Vect3 r; Vect3 v; Vect3 v_k; @@ -53,13 +54,13 @@ public: Vect3 alpha; Vect3 alpha_t; double KE; - + List joints; List points; Body(); - + bool ReadIn(std::istream& in); void WriteOut(std::ostream& out); bool ReadInPoints(std::istream& in); @@ -67,7 +68,7 @@ public: Point* GetPoint(int p); void AddJoint(Joint* joint); void AddPoint(Point* point); - + virtual bool ReadInBodyData(std::istream& in) = 0; virtual void WriteOutBodyData(std::ostream& out) = 0; virtual ~Body(); @@ -76,5 +77,5 @@ public: // global body functions Body* NewBody(int type); -} + #endif diff --git a/lib/poems/body23joint.cpp b/lib/poems/body23joint.cpp index e3ef32b2a9..8cd0a95bca 100644 --- a/lib/poems/body23joint.cpp +++ b/lib/poems/body23joint.cpp @@ -14,21 +14,18 @@ * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ + -#include #include "body23joint.h" +#include "point.h" +#include "matrixfun.h" #include "body.h" -#include "colmatrix.h" -#include "eulerparameters.h" #include "fastmatrixops.h" -#include "mat3x3.h" -#include "matrixfun.h" -#include "point.h" -#include "vect3.h" -#include "virtualmatrix.h" +#include "norm.h" +#include "eulerparameters.h" +#include "matrices.h" +#include -using namespace std; -using namespace POEMS; Body23Joint::Body23Joint(){ DimQandU(4,2); diff --git a/lib/poems/body23joint.h b/lib/poems/body23joint.h index 43a727c815..60253ac8a4 100644 --- a/lib/poems/body23joint.h +++ b/lib/poems/body23joint.h @@ -18,11 +18,12 @@ #ifndef BODY23JOINT_H #define BODY23JOINT_H -#include #include "joint.h" -#include "matrix.h" +#include "vect3.h" +#include "mat3x3.h" + + -namespace POEMS { class Body23Joint : public Joint { Matrix const_sP; public: @@ -39,5 +40,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; -} + #endif diff --git a/lib/poems/colmatmap.cpp b/lib/poems/colmatmap.cpp index 34a95feb03..1954e7ff15 100644 --- a/lib/poems/colmatmap.cpp +++ b/lib/poems/colmatmap.cpp @@ -21,8 +21,6 @@ #include using namespace std; -using namespace POEMS; - ColMatMap::ColMatMap(){ numrows = 0; diff --git a/lib/poems/colmatmap.h b/lib/poems/colmatmap.h index 5a12cf487f..3a6267a247 100644 --- a/lib/poems/colmatmap.h +++ b/lib/poems/colmatmap.h @@ -19,12 +19,8 @@ #ifndef COLMATMAP_H #define COLMATMAP_H -#include - #include "virtualcolmatrix.h" -#include "virtualmatrix.h" -namespace POEMS { class ColMatrix; class ColMatMap : public VirtualColMatrix { @@ -65,5 +61,5 @@ public: friend void FastCKRK5(ColMatMap& X, ColMatrix& Xi, ColMatrix* f, double* c, double dt); friend void FastFRK5(ColMatMap& X, ColMatrix& Xi, ColMatrix* f, double* c, double dt); }; -} + #endif diff --git a/lib/poems/colmatrix.cpp b/lib/poems/colmatrix.cpp index 0cc666645a..dc6f49be2b 100644 --- a/lib/poems/colmatrix.cpp +++ b/lib/poems/colmatrix.cpp @@ -16,13 +16,12 @@ *_________________________________________________________________________*/ #include "colmatrix.h" - +#include "rowmatrix.h" #include +#include #include using namespace std; -using namespace POEMS; - ColMatrix::ColMatrix(){ numrows = 0; diff --git a/lib/poems/colmatrix.h b/lib/poems/colmatrix.h index bcfa86843a..11fd85a928 100644 --- a/lib/poems/colmatrix.h +++ b/lib/poems/colmatrix.h @@ -19,18 +19,15 @@ #ifndef COLMATRIX_H #define COLMATRIX_H -#include #include "virtualcolmatrix.h" -#include "virtualmatrix.h" +#include "colmatmap.h" -namespace POEMS { class Matrix; class Vect6; class Mat3x3; class Vect3; class ColMatrix : public VirtualColMatrix { -protected: double* elements; public: ColMatrix(); @@ -60,28 +57,28 @@ public: ColMatrix& operator=(const VirtualMatrix& A); // overloaded = ColMatrix& operator*=(double b); - void Abs(); - void BasicMax(double& value, int& index); - void BasicMin(double& value, int& index); + void Abs(); + void BasicMax(double& value, int& index); + void BasicMin(double& value, int& index); // fast matrix operations - friend void FastQuaternions(ColMatrix& q, Mat3x3& C); - friend void FastInvQuaternions(Mat3x3& C, ColMatrix& q); - friend void FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot); - friend void FastTMult(Matrix& A, Vect6& B, ColMatrix& C); - friend void FastMult(Matrix& A, ColMatrix& B, Vect6& C); - friend void FastAssign(ColMatrix& A, ColMatrix& C); + friend void FastQuaternions(ColMatrix& q, Mat3x3& C); + friend void FastInvQuaternions(Mat3x3& C, ColMatrix& q); + friend void FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot); + friend void FastTMult(Matrix& A, Vect6& B, ColMatrix& C); + friend void FastMult(Matrix& A, ColMatrix& B, Vect6& C); + friend void FastAssign(ColMatrix& A, ColMatrix& C); - friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); - friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); - friend void FastAssign(ColMatrix&A, Vect3& C); - - friend void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); - friend void EP_Transformation(ColMatrix& q, Mat3x3& C); - friend void EP_FromTransformation(ColMatrix& q, Mat3x3& C); - friend void EP_Normalize(ColMatrix& q); - friend void EPdotdot_udot(ColMatrix& Audot, ColMatrix& Aqdot, ColMatrix& Aq,ColMatrix& Aqddot); - friend void qdot_to_u(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); + friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); + friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); + friend void FastAssign(ColMatrix&A, Vect3& C); + + friend void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); + friend void EP_Transformation(ColMatrix& q, Mat3x3& C); + friend void EP_FromTransformation(ColMatrix& q, Mat3x3& C); + friend void EP_Normalize(ColMatrix& q); + friend void EPdotdot_udot(ColMatrix& Audot, ColMatrix& Aqdot, ColMatrix& Aq,ColMatrix& Aqddot); + friend void qdot_to_u(ColMatrix& q, ColMatrix& u, ColMatrix& qdot); }; -} + #endif diff --git a/lib/poems/defines.h b/lib/poems/defines.h index 877bc0fa0b..455bc298d5 100644 --- a/lib/poems/defines.h +++ b/lib/poems/defines.h @@ -15,14 +15,13 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ -#ifndef POEMS_DEFINES_H -#define POEMS_DEFINES_H +#ifndef _DEFINES_H_ +#define _DEFINES_H_ -namespace POEMS { enum SolverType { ONSOLVER = 0, PARTICLESOLVER = 1 }; -} + #endif diff --git a/lib/poems/eulerparameters.cpp b/lib/poems/eulerparameters.cpp index bb8d676796..032bc7da82 100644 --- a/lib/poems/eulerparameters.cpp +++ b/lib/poems/eulerparameters.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: eulerparameters.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,22 +11,16 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #include "eulerparameters.h" - #include -#include "colmatrix.h" -#include "mat3x3.h" - using namespace std; -using namespace POEMS; - -void POEMS::EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot){ +void EP_Derivatives(ColMatrix& q, ColMatrix& u, ColMatrix& qdot){ EP_Normalize(q); int num=u.GetNumRows(); if (3 - +#include #include "fastmatrixops.h" -#include "colmatmap.h" -#include "colmatrix.h" -#include "mat3x3.h" -#include "mat4x4.h" -#include "mat6x6.h" -#include "matrix.h" -#include "vect3.h" -#include "vect4.h" -#include "vect6.h" +#include using namespace std; -using namespace POEMS; - // // Cross Product (friend of Vect3) // -void POEMS::FastCross(Vect3& a, Vect3& b, Vect3& c){ +void FastCross(Vect3& a, Vect3& b, Vect3& c){ c.elements[0] = a.elements[1]*b.elements[2] - a.elements[2]*b.elements[1]; c.elements[1] = a.elements[2]*b.elements[0] - a.elements[0]*b.elements[2]; c.elements[2] = a.elements[0]*b.elements[1] - a.elements[1]*b.elements[0]; @@ -46,7 +35,7 @@ void POEMS::FastCross(Vect3& a, Vect3& b, Vect3& c){ // Simple Rotation (friend of Vect3 and Mat3x3) // -void POEMS::FastSimpleRotation(Vect3& v, double q, Mat3x3& C){ +void FastSimpleRotation(Vect3& v, double q, Mat3x3& C){ // intermediate quantities double cq = cos(q); double sq = sin(q); @@ -71,7 +60,7 @@ void POEMS::FastSimpleRotation(Vect3& v, double q, Mat3x3& C){ // Quaternion Functions // -void POEMS::FastQuaternions(ColMatrix& q, Mat3x3& C){ +void FastQuaternions(ColMatrix& q, Mat3x3& C){ double* e = q.elements; // normalize the quaternions @@ -96,7 +85,7 @@ void POEMS::FastQuaternions(ColMatrix& q, Mat3x3& C){ C.elements[2][1] = 2 * (e[2]*e[3] + e[0]*e[1]); } -void POEMS::FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot){ +void FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot){ double* w = omega.elements; double* e = q.elements; @@ -106,7 +95,7 @@ void POEMS::FastQuaternionDerivatives(ColMatrix& q, ColMatrix& omega, ColMatrix& qdot.elements[3] = 0.5 * ( w[2]*e[0] + w[1]*e[1] - w[0]*e[2]); } -void POEMS::FastInvQuaternions(Mat3x3& C, ColMatrix& q){ +void FastInvQuaternions(Mat3x3& C, ColMatrix& q){ } // @@ -123,7 +112,7 @@ void POEMS::FastInvQuaternions(Mat3x3& C, ColMatrix& q){ // // friend of Matrix -void POEMS::FastLDLT(Matrix& A, Matrix& C){ // C is the LD of the LDL^T decomposition of A (SPD) +void FastLDLT(Matrix& A, Matrix& C){ // C is the LD of the LDL^T decomposition of A (SPD) double Lv; int n = A.numrows; @@ -145,7 +134,7 @@ void POEMS::FastLDLT(Matrix& A, Matrix& C){ // C is the LD of the LDL^T decompos // friend of Mat6x6 -void POEMS::FastLDLT(Mat6x6& A, Mat6x6& C){ // C is the LD of the LDL^T decomposition of A (SPD) +void FastLDLT(Mat6x6& A, Mat6x6& C){ // C is the LD of the LDL^T decomposition of A (SPD) double v[6]; double Lv; @@ -167,7 +156,7 @@ void POEMS::FastLDLT(Mat6x6& A, Mat6x6& C){ // C is the LD of the LDL^T decompos } // friend of Matrix -void POEMS::FastLDLTSubs(Matrix& LD, Matrix& B, Matrix& C){ +void FastLDLTSubs(Matrix& LD, Matrix& B, Matrix& C){ int n = B.numrows; int c = B.numcols; double temp; @@ -192,7 +181,7 @@ void POEMS::FastLDLTSubs(Matrix& LD, Matrix& B, Matrix& C){ } // friend of Matrix -void POEMS::FastLDLTSubsLH(Matrix& B, Matrix& LD, Matrix& C){ +void FastLDLTSubsLH(Matrix& B, Matrix& LD, Matrix& C){ int n = B.numcols; int c = B.numrows; double temp; @@ -217,7 +206,7 @@ void POEMS::FastLDLTSubsLH(Matrix& B, Matrix& LD, Matrix& C){ } // friend of Mat6x6 -void POEMS::FastLDLTSubs(Mat6x6& LD, Mat6x6& B, Mat6x6& C){ +void FastLDLTSubs(Mat6x6& LD, Mat6x6& B, Mat6x6& C){ double temp; for(int k=0;k<6;k++){ @@ -240,7 +229,7 @@ void POEMS::FastLDLTSubs(Mat6x6& LD, Mat6x6& B, Mat6x6& C){ } // friend of Mat6x6 & Vect6 -void POEMS::FastLDLTSubs(Mat6x6& LD, Vect6& B, Vect6& C){ +void FastLDLTSubs(Mat6x6& LD, Vect6& B, Vect6& C){ double temp; for(int i=0;i<6;i++){ @@ -261,7 +250,7 @@ void POEMS::FastLDLTSubs(Mat6x6& LD, Vect6& B, Vect6& C){ } // friend of Matrix -void POEMS::FastLU(Matrix& A, Matrix& LU, int *indx){ // LU is the LU decomposition of A +void FastLU(Matrix& A, Matrix& LU, int *indx){ // LU is the LU decomposition of A int i,imax=0,j,k; int n = A.numrows; double big, dum, sum, temp; @@ -311,7 +300,7 @@ void POEMS::FastLU(Matrix& A, Matrix& LU, int *indx){ // LU is the LU decomposit } // friend of Mat3x3 -void POEMS::FastLU(Mat3x3& A, Mat3x3& LU, int *indx){ // LU is the LU decomposition of A +void FastLU(Mat3x3& A, Mat3x3& LU, int *indx){ // LU is the LU decomposition of A int i,imax=0,j,k; double big, dum, sum, temp; double vv[10000]; @@ -359,7 +348,7 @@ void POEMS::FastLU(Mat3x3& A, Mat3x3& LU, int *indx){ // LU is the LU decomposit } // friend of Mat4x4 -void POEMS::FastLU(Mat4x4& A, Mat4x4& LU, int *indx){ // LU is the LU decomposition of A +void FastLU(Mat4x4& A, Mat4x4& LU, int *indx){ // LU is the LU decomposition of A int i,imax=0,j,k; double big, dum, sum, temp; double vv[10000]; @@ -407,7 +396,7 @@ void POEMS::FastLU(Mat4x4& A, Mat4x4& LU, int *indx){ // LU is the LU decomposit } // friend of Mat6x6 -void POEMS::FastLU(Mat6x6& A, Mat6x6& LU, int *indx){ // LU is the LU decomposition of A +void FastLU(Mat6x6& A, Mat6x6& LU, int *indx){ // LU is the LU decomposition of A int i,imax=0,j,k; double big, dum, sum, temp; double vv[10000]; @@ -455,7 +444,7 @@ void POEMS::FastLU(Mat6x6& A, Mat6x6& LU, int *indx){ // LU is the LU decomposit } // friend of Matrix -void POEMS::FastLUSubs(Matrix& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution +void FastLUSubs(Matrix& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution int i,ip,j,k; int n = B.numrows; int c = B.numcols; @@ -479,7 +468,7 @@ void POEMS::FastLUSubs(Matrix& LU, Matrix& B, Matrix& C, int *indx){ // Appropri } // friend of Matrix and Mat3x3 -void POEMS::FastLUSubs(Mat3x3& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution +void FastLUSubs(Mat3x3& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution int i,ip,j,k; int n = B.numrows; int c = B.numcols; @@ -503,7 +492,7 @@ void POEMS::FastLUSubs(Mat3x3& LU, Matrix& B, Matrix& C, int *indx){ // Appropri } // friend of Matrix and Mat4x4 -void POEMS::FastLUSubs(Mat4x4& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution +void FastLUSubs(Mat4x4& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution int i,ip,j,k; int n = B.numrows; int c = B.numcols; @@ -527,7 +516,7 @@ void POEMS::FastLUSubs(Mat4x4& LU, Matrix& B, Matrix& C, int *indx){ // Appropri } // friend of Matrix and Mat6x6 -void POEMS::FastLUSubs(Mat6x6& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution +void FastLUSubs(Mat6x6& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution int i,ip,j,k; int n = B.numrows; int c = B.numcols; @@ -553,7 +542,7 @@ void POEMS::FastLUSubs(Mat6x6& LU, Matrix& B, Matrix& C, int *indx){ // Appropri // The following LUSubsLH routine is incomplete at the moment. // friend of Matrix -void POEMS::FastLUSubsLH(Matrix& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution +void FastLUSubsLH(Matrix& LU, Matrix& B, Matrix& C, int *indx){ // Appropriate Forward and Back Substitution int i,ip,j,k; int n = B.numcols; int c = B.numrows; @@ -584,13 +573,13 @@ void POEMS::FastLUSubsLH(Matrix& LU, Matrix& B, Matrix& C, int *indx){ // Approp // Triple sum // -void POEMS::FastTripleSum(Vect3& a, Vect3& b, Vect3& c, Vect3& d){ // d = a+b+c +void FastTripleSum(Vect3& a, Vect3& b, Vect3& c, Vect3& d){ // d = a+b+c d.elements[0] = a.elements[0]+b.elements[0]+c.elements[0]; d.elements[1] = a.elements[1]+b.elements[1]+c.elements[1]; d.elements[2] = a.elements[2]+b.elements[2]+c.elements[2]; } -void POEMS::FastTripleSumPPM(Vect3& a, Vect3& b, Vect3& c, Vect3& d){ // d = a+b-c +void FastTripleSumPPM(Vect3& a, Vect3& b, Vect3& c, Vect3& d){ // d = a+b-c d.elements[0] = a.elements[0]+b.elements[0]-c.elements[0]; d.elements[1] = a.elements[1]+b.elements[1]-c.elements[1]; d.elements[2] = a.elements[2]+b.elements[2]-c.elements[2]; @@ -601,7 +590,7 @@ void POEMS::FastTripleSumPPM(Vect3& a, Vect3& b, Vect3& c, Vect3& d){ // d = a+b // // friend of matrix -void POEMS::FastMult(Matrix& A, Matrix& B, Matrix& C){ // C = A*B +void FastMult(Matrix& A, Matrix& B, Matrix& C){ // C = A*B // assumes dimensions are already correct! int r = A.numrows; int ca = A.numcols; @@ -617,7 +606,7 @@ void POEMS::FastMult(Matrix& A, Matrix& B, Matrix& C){ // C = A*B } // friend of matrix -void POEMS::FastTMult(Matrix& A, Matrix& B, Matrix& C){ // C = A*B +void FastTMult(Matrix& A, Matrix& B, Matrix& C){ // C = A*B // assumes dimensions are already correct! int r = A.numcols; int ca = A.numrows; @@ -633,14 +622,14 @@ void POEMS::FastTMult(Matrix& A, Matrix& B, Matrix& C){ // C = A*B } // friend of Mat3x3 & Vect3 -void POEMS::FastMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = A*B +void FastMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = A*B C.elements[0] = A.elements[0][0]*B.elements[0] + A.elements[0][1]*B.elements[1] + A.elements[0][2]*B.elements[2]; C.elements[1] = A.elements[1][0]*B.elements[0] + A.elements[1][1]*B.elements[1] + A.elements[1][2]*B.elements[2]; C.elements[2] = A.elements[2][0]*B.elements[0] + A.elements[2][1]*B.elements[1] + A.elements[2][2]*B.elements[2]; } // friend of Mat3x3, ColMatrix, & Vect3 -void POEMS::FastMult(Mat3x3& A, ColMatrix& B, Vect3& C){ // C = A*B +void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C){ // C = A*B C.elements[0] = A.elements[0][0]*B.elements[0] + A.elements[0][1]*B.elements[1] + A.elements[0][2]*B.elements[2]; C.elements[1] = A.elements[1][0]*B.elements[0] + A.elements[1][1]*B.elements[1] + A.elements[1][2]*B.elements[2]; C.elements[2] = A.elements[2][0]*B.elements[0] + A.elements[2][1]*B.elements[1] + A.elements[2][2]*B.elements[2]; @@ -648,42 +637,42 @@ void POEMS::FastMult(Mat3x3& A, ColMatrix& B, Vect3& C){ // C = A*B // friend of Mat3x3, ColMatrix, & Vect3 -void POEMS::FastMult(Mat3x3& A, Vect3& B, ColMatrix& C){ // C = A*B +void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C){ // C = A*B C.elements[0] = A.elements[0][0]*B.elements[0] + A.elements[0][1]*B.elements[1] + A.elements[0][2]*B.elements[2]; C.elements[1] = A.elements[1][0]*B.elements[0] + A.elements[1][1]*B.elements[1] + A.elements[1][2]*B.elements[2]; C.elements[2] = A.elements[2][0]*B.elements[0] + A.elements[2][1]*B.elements[1] + A.elements[2][2]*B.elements[2]; } // friend of Mat3x3 & Vect3 -void POEMS::FastTMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = A^T*B +void FastTMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = A^T*B C.elements[0] = A.elements[0][0]*B.elements[0] + A.elements[1][0]*B.elements[1] + A.elements[2][0]*B.elements[2]; C.elements[1] = A.elements[0][1]*B.elements[0] + A.elements[1][1]*B.elements[1] + A.elements[2][1]*B.elements[2]; C.elements[2] = A.elements[0][2]*B.elements[0] + A.elements[1][2]*B.elements[1] + A.elements[2][2]*B.elements[2]; } // friend of Mat3x3 & Vect3 -void POEMS::FastNegMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = -A*B +void FastNegMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = -A*B C.elements[0] = -A.elements[0][0]*B.elements[0] - A.elements[0][1]*B.elements[1] - A.elements[0][2]*B.elements[2]; C.elements[1] = -A.elements[1][0]*B.elements[0] - A.elements[1][1]*B.elements[1] - A.elements[1][2]*B.elements[2]; C.elements[2] = -A.elements[2][0]*B.elements[0] - A.elements[2][1]*B.elements[1] - A.elements[2][2]*B.elements[2]; } // friend of Mat3x3 & Vect3 -void POEMS::FastNegTMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = -A^T*B +void FastNegTMult(Mat3x3& A, Vect3& B, Vect3& C){ // C = -A^T*B C.elements[0] = -A.elements[0][0]*B.elements[0] - A.elements[1][0]*B.elements[1] - A.elements[2][0]*B.elements[2]; C.elements[1] = -A.elements[0][1]*B.elements[0] - A.elements[1][1]*B.elements[1] - A.elements[2][1]*B.elements[2]; C.elements[2] = -A.elements[0][2]*B.elements[0] - A.elements[1][2]*B.elements[1] - A.elements[2][2]*B.elements[2]; } // friend of Vect3 -void POEMS::FastMult(double a, Vect3& B, Vect3& C){ // C = a*B +void FastMult(double a, Vect3& B, Vect3& C){ // C = a*B C.elements[0] = a*B.elements[0]; C.elements[1] = a*B.elements[1]; C.elements[2] = a*B.elements[2]; } // friend of Mat4x4 & Vect4 -void POEMS::FastMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = A*B +void FastMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = A*B C.elements[0] = A.elements[0][0]*B.elements[0] + A.elements[0][1]*B.elements[1] + A.elements[0][2]*B.elements[2] + A.elements[0][3]*B.elements[3]; C.elements[1] = A.elements[1][0]*B.elements[0] + A.elements[1][1]*B.elements[1] + A.elements[1][2]*B.elements[2] + A.elements[1][3]*B.elements[3]; C.elements[2] = A.elements[2][0]*B.elements[0] + A.elements[2][1]*B.elements[1] + A.elements[2][2]*B.elements[2] + A.elements[2][3]*B.elements[3]; @@ -691,7 +680,7 @@ void POEMS::FastMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = A*B } // friend of Mat4x4 & Vect4 -void POEMS::FastTMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = A^T*B +void FastTMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = A^T*B C.elements[0] = A.elements[0][0]*B.elements[0] + A.elements[1][0]*B.elements[1] + A.elements[2][0]*B.elements[2] + A.elements[3][0]*B.elements[3]; C.elements[1] = A.elements[0][1]*B.elements[0] + A.elements[1][1]*B.elements[1] + A.elements[2][1]*B.elements[2] + A.elements[3][1]*B.elements[3]; C.elements[2] = A.elements[0][2]*B.elements[0] + A.elements[1][2]*B.elements[1] + A.elements[2][2]*B.elements[2] + A.elements[3][2]*B.elements[3]; @@ -699,7 +688,7 @@ void POEMS::FastTMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = A^T*B } // friend of Mat4x4 & Vect4 -void POEMS::FastNegMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = -A*B +void FastNegMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = -A*B C.elements[0] = -A.elements[0][0]*B.elements[0] - A.elements[0][1]*B.elements[1] - A.elements[0][2]*B.elements[2] - A.elements[0][3]*B.elements[3]; C.elements[1] = -A.elements[1][0]*B.elements[0] - A.elements[1][1]*B.elements[1] - A.elements[1][2]*B.elements[2] - A.elements[1][3]*B.elements[3]; C.elements[2] = -A.elements[2][0]*B.elements[0] - A.elements[2][1]*B.elements[1] - A.elements[2][2]*B.elements[2] - A.elements[2][3]*B.elements[3]; @@ -707,7 +696,7 @@ void POEMS::FastNegMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = -A*B } // friend of Mat4x4 & Vect4 -void POEMS::FastNegTMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = -A^T*B +void FastNegTMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = -A^T*B C.elements[0] = -A.elements[0][0]*B.elements[0] - A.elements[1][0]*B.elements[1] - A.elements[2][0]*B.elements[2] - A.elements[3][0]*B.elements[3]; C.elements[1] = -A.elements[0][1]*B.elements[0] - A.elements[1][1]*B.elements[1] - A.elements[2][1]*B.elements[2] - A.elements[3][1]*B.elements[3]; C.elements[2] = -A.elements[0][2]*B.elements[0] - A.elements[1][2]*B.elements[1] - A.elements[2][2]*B.elements[2] - A.elements[3][2]*B.elements[3]; @@ -715,7 +704,7 @@ void POEMS::FastNegTMult(Mat4x4& A, Vect4& B, Vect4& C){ // C = -A^T*B } // friend of Vect4 -void POEMS::FastMult(double a, Vect4& B, Vect4& C){ // C = a*B +void FastMult(double a, Vect4& B, Vect4& C){ // C = a*B C.elements[0] = a*B.elements[0]; C.elements[1] = a*B.elements[1]; C.elements[2] = a*B.elements[2]; @@ -723,7 +712,7 @@ void POEMS::FastMult(double a, Vect4& B, Vect4& C){ // C = a*B } // friend of Matrix & Mat6x6 -void POEMS::FastMultT(Matrix& A, Matrix& B, Mat6x6& C){ // C = A*B^T +void FastMultT(Matrix& A, Matrix& B, Mat6x6& C){ // C = A*B^T int i,j,k,n; n = A.numcols; @@ -736,7 +725,7 @@ void POEMS::FastMultT(Matrix& A, Matrix& B, Mat6x6& C){ // C = A*B^T } // friend Matrix, Vect6, ColMatrix -void POEMS::FastMult(Matrix& A, ColMatrix& B, Vect6& C){ +void FastMult(Matrix& A, ColMatrix& B, Vect6& C){ int ca = A.numcols; int i,k; @@ -748,7 +737,7 @@ void POEMS::FastMult(Matrix& A, ColMatrix& B, Vect6& C){ } // friend of Matrix & Mat6x6 -void POEMS::FastMult(Mat6x6& A, Matrix& B, Matrix& C){ // C = A*B +void FastMult(Mat6x6& A, Matrix& B, Matrix& C){ // C = A*B // assumes dimensions are already correct! int cb = B.numcols; @@ -762,7 +751,7 @@ void POEMS::FastMult(Mat6x6& A, Matrix& B, Matrix& C){ // C = A*B } // friend Matrix, Vect6, ColMatrix -void POEMS::FastTMult(Matrix& A, Vect6& B, ColMatrix& C){ // C = A^T*B +void FastTMult(Matrix& A, Vect6& B, ColMatrix& C){ // C = A^T*B int n = C.numrows; int i,k; for(i=0;i #include -#include "virtualmatrix.h" - using namespace std; -using namespace POEMS; - FixedPoint::FixedPoint(){ } diff --git a/lib/poems/fixedpoint.h b/lib/poems/fixedpoint.h index 5da1d6d69c..b5ecb23906 100644 --- a/lib/poems/fixedpoint.h +++ b/lib/poems/fixedpoint.h @@ -19,12 +19,9 @@ #ifndef FIXEDPOINT_H #define FIXEDPOINT_H -#include - #include "point.h" #include "vect3.h" -namespace POEMS { class FixedPoint : public Point { public: FixedPoint(); @@ -36,5 +33,5 @@ public: bool ReadInPointData(std::istream& in); void WriteOutPointData(std::ostream& out); }; -} + #endif diff --git a/lib/poems/freebodyjoint.cpp b/lib/poems/freebodyjoint.cpp index 0022ebd9ff..d00f0bdb98 100644 --- a/lib/poems/freebodyjoint.cpp +++ b/lib/poems/freebodyjoint.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: freebodyjoint.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,29 +11,23 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #include "freebodyjoint.h" - -#include - +#include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" +#include "norm.h" #include "eulerparameters.h" -#include "colmatrix.h" -#include "mat3x3.h" -#include "mat6x6.h" -#include "vect3.h" -#include "virtualmatrix.h" - -using namespace POEMS; - +#include "matrices.h" +#include + FreeBodyJoint::FreeBodyJoint(){ - DimQandU(7,6); + DimQandU(7,6); } FreeBodyJoint::~FreeBodyJoint(){ @@ -51,112 +45,112 @@ void FreeBodyJoint::WriteOutJointData(std::ostream& out){ } void FreeBodyJoint::ComputeLocalTransform(){ - Mat3x3 ko_C_k; - EP_Transformation(q, ko_C_k); - FastMult(pk_C_ko,ko_C_k,pk_C_k); + Mat3x3 ko_C_k; + EP_Transformation(q, ko_C_k); + FastMult(pk_C_ko,ko_C_k,pk_C_k); } Matrix FreeBodyJoint::GetForward_sP(){ Mat6x6 sP; - //sP.Identity(); - - sP.Zeros(); + //sP.Identity(); + + sP.Zeros(); Mat3x3 temp0=T(pk_C_k); for(int i=1;i<4;i++){ sP(i,i)=1.0; for(int j=1;j<4;j++){ sP(3+i,3+j)=temp0(i,j); } - } - return sP; + } + return sP; } Matrix FreeBodyJoint::GetBackward_sP(){ Mat6x6 sP; - sP.Identity(); + sP.Identity(); sP =-1.0*sP; - std::cout<<"Did I come here in "<r); - - //COMMENT STEP3: CALCULATE QDOT + + FastAssign(r12,body2->r); + + //COMMENT STEP3: CALCULATE QDOT qdot_to_u(q, u, qdot); - - + + Vect3 WN; WN.BasicSet(0,u.BasicGet(0)); WN.BasicSet(1,u.BasicGet(1)); WN.BasicSet(2,u.BasicGet(2)); - - Vect3 VN; + + Vect3 VN; VN.BasicSet(0,u.BasicGet(3)); VN.BasicSet(1,u.BasicGet(4)); - VN.BasicSet(2,u.BasicGet(5)); - - FastAssign(WN,body2->omega_k); - + VN.BasicSet(2,u.BasicGet(5)); + + FastAssign(WN,body2->omega_k); + Vect3 pk_w_k; - FastMult(body2->n_C_k,WN,pk_w_k); + FastMult(body2->n_C_k,WN,pk_w_k); FastAssign(pk_w_k,body2->omega); - - - - //COMMENT STEP5: CALCULATE VELOCITES - FastAssign(VN,body2->v); - FastTMult(body2->n_C_k,body2->v,body2->v_k); - - - //CALCULATE KE - + + + + //COMMENT STEP5: CALCULATE VELOCITES + FastAssign(VN,body2->v); + FastTMult(body2->n_C_k,body2->v,body2->v_k); + + + //CALCULATE KE + Matrix tempke; - tempke = T(body2->v)*(body2->v); + tempke = T(body2->v)*(body2->v); double ke = 0.0; - ke = body2->mass*tempke(1,1); + ke = body2->mass*tempke(1,1); FastMult(body2->inertia,body2->omega_k,result1); - tempke= T(body2->omega_k)*result1; + tempke= T(body2->omega_k)*result1; ke = 0.5*ke + 0.5*tempke(1,1); body2->KE=ke; - - + + //COMMENT STEP6: CALCULATE STATE EXPLICIT ANGULAR ACCELERATIONS body2->alpha_t.Zeros(); - - + + //COMMENT STEP7: CALCULATE STATE EXPLICIT ACCELERATIONS - body2->a_t.Zeros(); - + body2->a_t.Zeros(); + } void FreeBodyJoint::BackwardKinematics(){ -std::cout<<"Did I come here "< - #include "joint.h" -#include "matrix.h" -namespace POEMS { + class FreeBodyJoint : public Joint{ -public: +public: FreeBodyJoint(); ~FreeBodyJoint(); - + JointType GetType(); bool ReadInJointData(std::istream& in); void WriteOutJointData(std::ostream& out); @@ -40,5 +37,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; -} + #endif diff --git a/lib/poems/inertialframe.cpp b/lib/poems/inertialframe.cpp index 19ca7cdb0b..6c97b2f584 100644 --- a/lib/poems/inertialframe.cpp +++ b/lib/poems/inertialframe.cpp @@ -16,13 +16,9 @@ *_________________________________________________________________________*/ #include "inertialframe.h" - -#include "mat3x3.h" -#include "virtualmatrix.h" +#include "fixedpoint.h" using namespace std; -using namespace POEMS; - InertialFrame::InertialFrame(){ gravity.Zeros(); diff --git a/lib/poems/inertialframe.h b/lib/poems/inertialframe.h index ae987cdc56..08d0279a1e 100644 --- a/lib/poems/inertialframe.h +++ b/lib/poems/inertialframe.h @@ -19,12 +19,9 @@ #ifndef INERTIALFRAME_H #define INERTIALFRAME_H -#include - #include "body.h" -#include "vect3.h" -namespace POEMS { + class InertialFrame : public Body { Vect3 gravity; public: @@ -36,5 +33,5 @@ public: bool ReadInBodyData(std::istream& in); void WriteOutBodyData(std::ostream& out); }; -} + #endif diff --git a/lib/poems/joint.cpp b/lib/poems/joint.cpp index 3e356337cb..3bdd7b5fcd 100644 --- a/lib/poems/joint.cpp +++ b/lib/poems/joint.cpp @@ -16,28 +16,15 @@ *_________________________________________________________________________*/ -#include -#include -#include - +#include "joints.h" #include "body.h" #include "point.h" +#include +#include "matrixfun.h" #include "fastmatrixops.h" -#include "body23joint.h" -#include "colmatrix.h" -#include "freebodyjoint.h" -#include "joint.h" -#include "mat3x3.h" -#include "matrix.h" -#include "mixedjoint.h" -#include "prismaticjoint.h" -#include "revolutejoint.h" -#include "sphericaljoint.h" -#include "virtualmatrix.h" +#include using namespace std; -using namespace POEMS; - Joint::Joint(){ body1 = body2 = 0; @@ -247,7 +234,7 @@ void Joint::ComputeBackwardGlobalTransform(){ // global joint functions // -Joint* POEMS::NewJoint(int type){ +Joint* NewJoint(int type){ switch( JointType(type) ) { case FREEBODYJOINT : return new FreeBodyJoint; diff --git a/lib/poems/joint.h b/lib/poems/joint.h index fa9b6826a7..17122af775 100644 --- a/lib/poems/joint.h +++ b/lib/poems/joint.h @@ -18,15 +18,9 @@ #ifndef JOINT_H #define JOINT_H -#include #include "poemsobject.h" -#include "colmatrix.h" -#include "mat3x3.h" -#include "matrix.h" -#include "vect3.h" - -namespace POEMS { -class VirtualMatrix; +#include +#include "matrices.h" enum JointType { XYZJOINT = 0, @@ -125,5 +119,5 @@ public: // global joint functions Joint* NewJoint(int type); -} + #endif diff --git a/lib/poems/mat3x3.cpp b/lib/poems/mat3x3.cpp index 8a5098ff59..df24d4b108 100644 --- a/lib/poems/mat3x3.cpp +++ b/lib/poems/mat3x3.cpp @@ -16,13 +16,10 @@ *_________________________________________________________________________*/ -#include -#include #include "mat3x3.h" +#include using namespace std; -using namespace POEMS; - Mat3x3::Mat3x3(){ numrows = numcols = 3; diff --git a/lib/poems/mat3x3.h b/lib/poems/mat3x3.h index bc38e6d393..4362b3ad9c 100644 --- a/lib/poems/mat3x3.h +++ b/lib/poems/mat3x3.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: mat3x3.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,19 +11,19 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef MAT3X3_H #define MAT3X3_H -#include #include "virtualmatrix.h" -namespace POEMS { + class Vect3; class Mat6x6; +class Matrix; class ColMatrix; class Mat3x3 : public VirtualMatrix { @@ -68,15 +68,16 @@ public: friend void FastMult(Mat3x3& A, Mat3x3& B, Mat3x3& C); friend void FastMultT(Mat3x3& A, Mat3x3& B, Mat3x3& C); friend void FastAssignT(Mat3x3& A, Mat3x3& C); - friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); - + friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); + friend void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC); friend void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI); friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); - + friend void EP_Transformation(ColMatrix& q, Mat3x3& C); friend void EP_FromTransformation(ColMatrix& q, Mat3x3& C); + }; -} + #endif diff --git a/lib/poems/mat4x4.cpp b/lib/poems/mat4x4.cpp index 9a0e7b8d56..4a611a6796 100644 --- a/lib/poems/mat4x4.cpp +++ b/lib/poems/mat4x4.cpp @@ -16,13 +16,9 @@ *_________________________________________________________________________*/ #include "mat4x4.h" - #include -#include using namespace std; -using namespace POEMS; - Mat4x4::Mat4x4(){ numrows = numcols = 4; diff --git a/lib/poems/mat4x4.h b/lib/poems/mat4x4.h index 3f6d97ba15..d7942b248e 100644 --- a/lib/poems/mat4x4.h +++ b/lib/poems/mat4x4.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: mat4x4.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,28 +11,27 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef MAT4X4_H #define MAT4X4_H -#include #include "virtualmatrix.h" +#include "matrix.h" + -namespace POEMS { class Vect4; -class Matrix; class Mat4x4 : public VirtualMatrix { double elements[4][4]; -public: +public: Mat4x4(); ~Mat4x4(); Mat4x4(const Mat4x4& A); // copy constructor Mat4x4(const VirtualMatrix& A); // copy constructor - + double& operator_2int (int i, int j); // array access double Get_2int(int i, int j) const; void Set_2int(int i, int j, double value); @@ -65,5 +64,5 @@ public: friend void FastMultT(Mat4x4& A, Mat4x4& B, Mat4x4& C); friend void FastAssignT(Mat4x4& A, Mat4x4& C); }; -} + #endif diff --git a/lib/poems/mat6x6.cpp b/lib/poems/mat6x6.cpp index e9dde2fe87..16bffc5026 100644 --- a/lib/poems/mat6x6.cpp +++ b/lib/poems/mat6x6.cpp @@ -16,13 +16,9 @@ *_________________________________________________________________________*/ #include "mat6x6.h" - #include -#include using namespace std; -using namespace POEMS; - Mat6x6::Mat6x6(){ numrows = numcols = 6; diff --git a/lib/poems/mat6x6.h b/lib/poems/mat6x6.h index a611bc8283..11951b0442 100644 --- a/lib/poems/mat6x6.h +++ b/lib/poems/mat6x6.h @@ -17,11 +17,9 @@ #ifndef MAT6X6_H #define MAT6X6_H -#include - #include "virtualmatrix.h" -namespace POEMS { + class Matrix; class Mat3x3; class Vect6; @@ -74,5 +72,5 @@ public: friend void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC); friend void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI); }; -} + #endif diff --git a/lib/poems/matrices.h b/lib/poems/matrices.h index 15f0d3ad23..7a7e2c4b58 100644 --- a/lib/poems/matrices.h +++ b/lib/poems/matrices.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: matrices.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -20,14 +20,23 @@ #define MATRICES_H #include "matrix.h" + #include "colmatrix.h" + #include "rowmatrix.h" + #include "mat3x3.h" + #include "vect3.h" + #include "mat4x4.h" + #include "vect4.h" + #include "mat6x6.h" + #include "vect6.h" + #include "colmatmap.h" #endif diff --git a/lib/poems/matrix.cpp b/lib/poems/matrix.cpp index f7b0c631f2..f05d6f815c 100644 --- a/lib/poems/matrix.cpp +++ b/lib/poems/matrix.cpp @@ -21,8 +21,6 @@ #include using namespace std; -using namespace POEMS; - Matrix::Matrix(){ numrows = numcols = 0; diff --git a/lib/poems/matrix.h b/lib/poems/matrix.h index c2ed92873c..63699b9835 100644 --- a/lib/poems/matrix.h +++ b/lib/poems/matrix.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: matrix.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,18 +11,15 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef MATRIX_H #define MATRIX_H -#include - #include "virtualmatrix.h" -namespace POEMS { class Mat3x3; class Mat4x4; class Mat6x6; @@ -74,6 +71,7 @@ public: friend void FastMult(Mat6x6& A, Matrix& B, Matrix& C); friend void FastMult(Matrix& A, ColMatrix& B, Vect6& C); friend void FastMultT(Matrix& A, Matrix& B, Mat6x6& C); + }; -} + #endif diff --git a/lib/poems/matrixfun.cpp b/lib/poems/matrixfun.cpp index 037e986a99..d193114679 100644 --- a/lib/poems/matrixfun.cpp +++ b/lib/poems/matrixfun.cpp @@ -16,25 +16,17 @@ *_________________________________________________________________________*/ #include "matrixfun.h" - -#include -#include - +#include #include "fastmatrixops.h" -#include "vect4.h" -#include "virtualcolmatrix.h" -#include "virtualmatrix.h" -#include "virtualrowmatrix.h" +#include using namespace std; -using namespace POEMS; - // // Create a new matrix // -VirtualMatrix* POEMS::NewMatrix(int type){ +VirtualMatrix* NewMatrix(int type){ switch( MatrixType(type) ) { case MATRIX : return new Matrix; @@ -52,7 +44,7 @@ VirtualMatrix* POEMS::NewMatrix(int type){ // Transpose // -Matrix POEMS::T(const VirtualMatrix& A){ +Matrix T(const VirtualMatrix& A){ int numrows = A.GetNumRows(); int numcols = A.GetNumCols(); Matrix C(numcols,numrows); @@ -62,8 +54,8 @@ Matrix POEMS::T(const VirtualMatrix& A){ return C; } -Mat3x3 POEMS::T(const Mat3x3& A){ - Mat3x3 C; +Mat3x3 T(const Mat3x3& A){ + Mat3x3 C; C.elements[0][0] = A.elements[0][0]; C.elements[1][1] = A.elements[1][1]; C.elements[2][2] = A.elements[2][2]; @@ -78,7 +70,7 @@ Mat3x3 POEMS::T(const Mat3x3& A){ return C; } -Mat6x6 POEMS::T(const Mat6x6& A){ +Mat6x6 T(const Mat6x6& A){ Mat6x6 C; int i,j; for(i=0;i<6;i++) @@ -88,7 +80,7 @@ Mat6x6 POEMS::T(const Mat6x6& A){ return C; } -Matrix POEMS::T(const Vect3& A){ +Matrix T(const Vect3& A){ Matrix C(1,3); C.BasicSet(0,0,A.elements[0]); C.BasicSet(0,1,A.elements[1]); @@ -97,7 +89,7 @@ Matrix POEMS::T(const Vect3& A){ return C; } -Matrix POEMS::T(const Vect6& A){ +Matrix T(const Vect6& A){ Matrix C(1,6); C.BasicSet(0,0,A.elements[0]); C.BasicSet(0,1,A.elements[1]); @@ -109,7 +101,7 @@ Matrix POEMS::T(const Vect6& A){ return C; } -RowMatrix POEMS::T(const VirtualColMatrix &A){ +RowMatrix T(const VirtualColMatrix &A){ int numele = A.GetNumRows(); RowMatrix C(numele); for(int i=0;i - +#include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" +#include "norm.h" #include "eulerparameters.h" -#include "colmatrix.h" -#include "mat3x3.h" -#include "mat6x6.h" -#include "vect3.h" -#include "virtualmatrix.h" - -using namespace POEMS; -using namespace std; +#include "matrices.h" + -MixedJoint::MixedJoint(){ +MixedJoint::MixedJoint(){ } MixedJoint::~MixedJoint(){ @@ -56,23 +49,23 @@ void MixedJoint::SetsP(Matrix& sPr, Vect6& temp_dofs, int i, int j){ numrots = i; numtrans = j; if (numrots < 2) - DimQandU(numrots+numtrans,numrots+numtrans); - else - DimQandU((4+numtrans),(numrots+numtrans)); + DimQandU(numrots+numtrans,numrots+numtrans); + else + DimQandU((4+numtrans),(numrots+numtrans)); cout<<"Check "<<4+numtrans<<" "< 1) EP_Normalize(q); // COMMENT STEP1: CALCULATE ORIENTATIONS - ComputeForwardTransforms(); - - + ComputeForwardTransforms(); + + //COMMENT STEP2: CALCULATE POSITION VECTORS - Vect3 result1, result2, result3, result4; + Vect3 result1, result2, result3, result4; result1.Zeros(); for (int k=0; k<3; k++){ if( dofs(3+k) != 0.0 ){ @@ -118,32 +111,32 @@ void MixedJoint::ForwardKinematics(){ result1.BasicSet(k,q.BasicGet(4 + k)); else result1.BasicSet(k,q.BasicGet(numrots + k)); - } + } } - - - - FastAssign(result1,r12); // r12 in parents basis i.e. Newtonian - FastNegMult(k_C_pk,r12,r21); // r21 in body basis - - FastAssign(r12,body2->r); // This is right - - //COMMENT STEP3: CALCULATE QDOT + + + + FastAssign(result1,r12); // r12 in parents basis i.e. Newtonian + FastNegMult(k_C_pk,r12,r21); // r21 in body basis + + FastAssign(r12,body2->r); // This is right + + //COMMENT STEP3: CALCULATE QDOT int pp = 0; if (numrots > 1){ ColMatrix temp_u(3+numtrans); qdot_to_u(q,temp_u,qdot); for (int k=1;k<=6;k++){ if(dofs(k) != 0.0){ - u.BasicSet(pp,temp_u.BasicGet(k-1)); + u.BasicSet(pp,temp_u.BasicGet(k-1)); pp = pp+1; - } + } } } else u = qdot; - - + + Vect3 WN; WN.Zeros(); int p = 0; for (int k=0;k<3;k++){ @@ -153,51 +146,51 @@ void MixedJoint::ForwardKinematics(){ } }// WN is in body basis - - Vect3 VN; VN.Zeros(); + + Vect3 VN; VN.Zeros(); for (int k=0;k<3;k++){ if( dofs(3+k+1) != 0.0 ) { VN.BasicSet(k,u.BasicGet(p)); p=p+1; } }// VN is the vector of translational velocities in Newtonian basis + + FastAssign(WN,body2->omega_k); - FastAssign(WN,body2->omega_k); - - // cout<<"Angular Velocity "<n_C_k,WN,pk_w_k); + FastMult(body2->n_C_k,WN,pk_w_k); FastAssign(pk_w_k,body2->omega); - - - - //COMMENT STEP5: CALCULATE VELOCITES - FastAssign(VN,body2->v); - FastTMult(body2->n_C_k,body2->v,body2->v_k); - - - //CALCULATE KE - + + + + //COMMENT STEP5: CALCULATE VELOCITES + FastAssign(VN,body2->v); + FastTMult(body2->n_C_k,body2->v,body2->v_k); + + + //CALCULATE KE + Matrix tempke; - tempke = T(body2->v)*(body2->v); + tempke = T(body2->v)*(body2->v); double ke = 0.0; - ke = body2->mass*tempke(1,1); + ke = body2->mass*tempke(1,1); FastMult(body2->inertia,body2->omega_k,result1); - tempke= T(body2->omega_k)*result1; + tempke= T(body2->omega_k)*result1; ke = 0.5*ke + 0.5*tempke(1,1); body2->KE=ke; - - + + //COMMENT STEP6: CALCULATE STATE EXPLICIT ANGULAR ACCELERATIONS body2->alpha_t.Zeros(); - - + + //COMMENT STEP7: CALCULATE STATE EXPLICIT ACCELERATIONS - body2->a_t.Zeros(); - + body2->a_t.Zeros(); + } void MixedJoint::BackwardKinematics(){ cout<<"Did I come here "< - #include "joint.h" -#include "matrix.h" -#include "vect6.h" -namespace POEMS { + class MixedJoint : public Joint{ Matrix const_sP; int numrots; int numtrans; Vect6 dofs; -public: +public: MixedJoint(); ~MixedJoint(); - + JointType GetType(); bool ReadInJointData(std::istream& in); void WriteOutJointData(std::ostream& out); @@ -46,5 +42,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; -} + #endif diff --git a/lib/poems/norm.cpp b/lib/poems/norm.cpp index 6c983dd06f..0f918cf968 100644 --- a/lib/poems/norm.cpp +++ b/lib/poems/norm.cpp @@ -16,15 +16,7 @@ *_________________________________________________________________________*/ #include - #include "norm.h" -#include "colmatrix.h" -#include "rowmatrix.h" -#include "vect3.h" -#include "vect4.h" -#include "vect6.h" - -using namespace POEMS; double Magnitude(ColMatrix& A){ double G; diff --git a/lib/poems/norm.h b/lib/poems/norm.h index 808be609e8..963a2ec5b2 100644 --- a/lib/poems/norm.h +++ b/lib/poems/norm.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: norm.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,24 +11,20 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef NORM_H #define NORM_H -namespace POEMS { -class ColMatrix; -class RowMatrix; -class Vect3; -class Vect4; -class Vect6; +#include "matrices.h" + double Magnitude(ColMatrix& A); double Magnitude(RowMatrix& A); double Magnitude(Vect3& A); double Magnitude(Vect4& A); double Magnitude(Vect6& A); -} + #endif diff --git a/lib/poems/onbody.cpp b/lib/poems/onbody.cpp index 7cea2d2f25..102900df8d 100644 --- a/lib/poems/onbody.cpp +++ b/lib/poems/onbody.cpp @@ -16,22 +16,17 @@ *_________________________________________________________________________*/ #include "onbody.h" - -#include -#include - #include "body.h" #include "inertialframe.h" #include "joint.h" #include "onfunctions.h" #include "virtualmatrix.h" #include "matrixfun.h" +#include +#include "norm.h" #include "eulerparameters.h" -#include "colmatrix.h" using namespace std; -using namespace POEMS; - OnBody::OnBody(){ diff --git a/lib/poems/onbody.h b/lib/poems/onbody.h index df82709ad5..d9923773c7 100644 --- a/lib/poems/onbody.h +++ b/lib/poems/onbody.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: onbody.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -22,14 +22,6 @@ #include "matrix.h" #include "vect6.h" #include "mat6x6.h" -#include "joint.h" -#include "mat3x3.h" -#include "vect3.h" - -namespace POEMS { -class Body; -class ColMatrix; -class InertialFrame; // emumerated type enum Direction { @@ -37,65 +29,71 @@ enum Direction { FORWARD= 1 }; -class OnBody { - Body* system_body; - Joint* system_joint; - OnBody* parent; - List children; - - Direction joint_dir; - void (Joint::*kinfun)(); // kinematics function - void (Joint::*updatesP)(Matrix&); // sP update function - Vect3* gamma; // pointer to gamma vector - Mat3x3* pk_C_k; // pointer to transformation +class Body; +class InertialFrame; +class Joint; +class OnSolver; +class OnBody { + Body* system_body; + Joint* system_joint; + OnBody* parent; + List children; - Mat6x6 sI; // spatial inertias - Mat6x6 sIhat; // recursive spatial inertias - Mat6x6 sSC; // spatial shift - Mat6x6 sT; // spatial triangularization + Direction joint_dir; + void (Joint::*kinfun)(); // kinematics function + void (Joint::*updatesP)(Matrix&); // sP update function + Vect3* gamma; // pointer to gamma vector + Mat3x3* pk_C_k; // pointer to transformation - Vect6 sF; // spatial forces - Vect6 sFhat; // recursive spatial forces - Vect6 sAhat; // recursive spatial acceleration + + Mat6x6 sI; // spatial inertias + Mat6x6 sIhat; // recursive spatial inertias + Mat6x6 sSC; // spatial shift + Mat6x6 sT; // spatial triangularization - Matrix sP; // spatial partial velocities - Matrix sM; // triangularized mass matrix diagonal elements - Matrix sMinv; // inverse of sM - Matrix sPsMinv; - Matrix sIhatsP; + Vect6 sF; // spatial forces + Vect6 sFhat; // recursive spatial forces + Vect6 sAhat; // recursive spatial acceleration - // states and state derivatives - ColMatrix* q; - ColMatrix* u; - ColMatrix* qdot; - ColMatrix* udot; - ColMatrix* qdotdot; + Matrix sP; // spatial partial velocities + Matrix sM; // triangularized mass matrix diagonal elements + Matrix sMinv; // inverse of sM + Matrix sPsMinv; + Matrix sIhatsP; - ColMatrix* r; - ColMatrix* acc; - ColMatrix* ang; + // states and state derivatives + ColMatrix* q; + ColMatrix* u; + ColMatrix* qdot; + ColMatrix* udot; + ColMatrix* qdotdot; + + ColMatrix* r; + ColMatrix* acc; + ColMatrix* ang; // friend classes friend class OnSolver; + -public: - OnBody(); - ~OnBody(); - int RecursiveSetup(InertialFrame* basebody); - int RecursiveSetup(int ID, OnBody* parentbody, Joint* sys_joint); - void RecursiveKinematics(); - void RecursiveTriangularization(); - void RecursiveForwardSubstitution(); - Mat3x3 GetN_C_K(); - Vect3 LocalCart(); - int GetBodyID(); - void CalculateAcceleration(); - void Setup(); - void SetupInertialFrame(); - void LocalKinematics(); - void LocalTriangularization(Vect3& Torque, Vect3& Force); - void LocalForwardSubstitution(); +public: + OnBody(); + ~OnBody(); + int RecursiveSetup(InertialFrame* basebody); + int RecursiveSetup(int ID, OnBody* parentbody, Joint* sys_joint); + void RecursiveKinematics(); + void RecursiveTriangularization(); + void RecursiveForwardSubstitution(); + Mat3x3 GetN_C_K(); + Vect3 LocalCart(); + int GetBodyID(); + void CalculateAcceleration(); + void Setup(); + void SetupInertialFrame(); + void LocalKinematics(); + void LocalTriangularization(Vect3& Torque, Vect3& Force); + void LocalForwardSubstitution(); }; -} + #endif diff --git a/lib/poems/onfunctions.cpp b/lib/poems/onfunctions.cpp index cfc0c60936..582ab8cf8b 100644 --- a/lib/poems/onfunctions.cpp +++ b/lib/poems/onfunctions.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: onfunction.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,25 +11,18 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #include "onfunctions.h" - -#include "mat3x3.h" -#include "mat6x6.h" -#include "vect3.h" -#include "vect6.h" -#include "virtualmatrix.h" - +#include "matrixfun.h" +#include using namespace std; -using namespace POEMS; - // friend of Vect3 & Vect6 -void POEMS::OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV){ +void OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV){ sV.elements[0] = angular.elements[0]; sV.elements[1] = angular.elements[1]; sV.elements[2] = angular.elements[2]; @@ -39,38 +32,38 @@ void POEMS::OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV){ } // friend of Vect3, Mat3x3, & Mat6x6 -void POEMS::OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC){ +void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC){ // the block diagonals - + // the gamma cross with transform Mat3x3 temp; Mat3x3 temp2; SC.Zeros(); - temp.Zeros(); + temp.Zeros(); temp2.Zeros(); - //FastTMult(C,gamma,temp); + //FastTMult(C,gamma,temp); temp(1,2)= -gamma(3); temp(1,3)= gamma(2); temp(2,1)= gamma(3); - temp(2,3)= -gamma(1); temp(3,1)= -gamma(2); temp(3,2)= gamma(1); + temp(2,3)= -gamma(1); temp(3,1)= -gamma(2); temp(3,2)= gamma(1); FastMult(temp,C,temp2); - + SC(1,4)=temp2(1,1); SC(2,4)=temp2(2,1); SC(3,4)=temp2(3,1); SC(1,5)=temp2(1,2); SC(2,5)=temp2(2,2); SC(3,5)=temp2(3,2); SC(1,6)=temp2(1,3); SC(2,6)=temp2(2,3); SC(3,6)=temp2(3,3); - + SC(1,1)=C(1,1); SC(2,1)=C(2,1); SC(3,1)=C(3,1); SC(1,2)=C(1,2); SC(2,2)=C(2,2); SC(3,2)=C(3,2); SC(1,3)=C(1,3); SC(2,3)=C(2,3); SC(3,3)=C(3,3); SC(4,4)=C(1,1); SC(5,4)=C(2,1); SC(6,4)=C(3,1); SC(4,5)=C(1,2); SC(5,5)=C(2,2); SC(6,5)=C(3,2); - SC(4,6)=C(1,3); SC(5,6)=C(2,3); SC(6,6)=C(3,3); - + SC(4,6)=C(1,3); SC(5,6)=C(2,3); SC(6,6)=C(3,3); + } // friend of Mat3x3 & Mat6x6 -void POEMS::OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI){ - - sI(4,4)=mass; sI(5,5)=mass; sI(6,6)=mass; - sI(1,1)=inertia(1,1); sI(1,2)=inertia(1,2); sI(1,3)=inertia(1,3); - sI(2,1)=inertia(2,1); sI(2,2)=inertia(2,2); sI(2,3)=inertia(2,3); - sI(3,1)=inertia(3,1); sI(3,2)=inertia(3,2); sI(3,3)=inertia(3,3); +void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI){ + + sI(4,4)=mass; sI(5,5)=mass; sI(6,6)=mass; + sI(1,1)=inertia(1,1); sI(1,2)=inertia(1,2); sI(1,3)=inertia(1,3); + sI(2,1)=inertia(2,1); sI(2,2)=inertia(2,2); sI(2,3)=inertia(2,3); + sI(3,1)=inertia(3,1); sI(3,2)=inertia(3,2); sI(3,3)=inertia(3,3); } diff --git a/lib/poems/onfunctions.h b/lib/poems/onfunctions.h index bb07425b85..8a69694095 100644 --- a/lib/poems/onfunctions.h +++ b/lib/poems/onfunctions.h @@ -18,11 +18,7 @@ #ifndef ONFUNCTIONS_H #define ONFUNCTIONS_H -namespace POEMS { -class Mat3x3; -class Mat6x6; -class Vect3; -class Vect6; +#include "matrices.h" void OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV); void OnPopulateSC(Vect3& gamma, Mat3x3& C, Mat6x6& SC); @@ -31,5 +27,5 @@ void OnPopulateSI(Mat3x3& inertia, double mass, Mat6x6& sI); void Create_Map(int MM); int ICELL(int IX,int IY,int IZ, int MM); -} + #endif diff --git a/lib/poems/onsolver.cpp b/lib/poems/onsolver.cpp index 609ef32613..ad04d7e9e3 100644 --- a/lib/poems/onsolver.cpp +++ b/lib/poems/onsolver.cpp @@ -16,25 +16,15 @@ *_________________________________________________________________________*/ -#include -#include - #include "onsolver.h" #include "system.h" #include "onbody.h" #include "body.h" -#include "colmatmap.h" -#include "colmatrix.h" -#include "defines.h" -#include "inertialframe.h" -#include "matrix.h" -#include "poemslist.h" -#include "vect3.h" -#include "virtualmatrix.h" +#include "matrixfun.h" +#include -using namespace std; -using namespace POEMS; +using namespace std; OnSolver::OnSolver(){ numbodies = 0; diff --git a/lib/poems/onsolver.h b/lib/poems/onsolver.h index 1e850b8fc1..f32b5880a9 100644 --- a/lib/poems/onsolver.h +++ b/lib/poems/onsolver.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: onsolver.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,32 +21,31 @@ #include "solver.h" #include "onbody.h" +#include -namespace POEMS { -class ColMatrix; -class Matrix; + class OnSolver : public Solver { - OnBody inertialframe; - int numbodies; - OnBody** bodyarray; - ColMatrix** q; - ColMatrix** qdot; - ColMatrix** qdotdot; - ColMatrix** u; - ColMatrix** udot; - - - - void DeleteModel(); - int CreateTopologyArray(int i, OnBody* body); - void CreateStateMatrixMaps(); - void GetType(); -public: - OnSolver(); - ~OnSolver(); - void CreateModel(); - void Solve(double time, Matrix& FF); + OnBody inertialframe; + int numbodies; + OnBody** bodyarray; + ColMatrix** q; + ColMatrix** qdot; + ColMatrix** qdotdot; + ColMatrix** u; + ColMatrix** udot; + + + + void DeleteModel(); + int CreateTopologyArray(int i, OnBody* body); + void CreateStateMatrixMaps(); + void GetType(); +public: + OnSolver(); + ~OnSolver(); + void CreateModel(); + void Solve(double time, Matrix& FF); }; -} + #endif diff --git a/lib/poems/particle.cpp b/lib/poems/particle.cpp index 37ec790666..3496bc1906 100644 --- a/lib/poems/particle.cpp +++ b/lib/poems/particle.cpp @@ -17,8 +17,7 @@ #include "particle.h" - -using namespace POEMS; +#include "fixedpoint.h" Particle::Particle(){ } diff --git a/lib/poems/particle.h b/lib/poems/particle.h index 8a7a521451..20aa4831ea 100644 --- a/lib/poems/particle.h +++ b/lib/poems/particle.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: particle.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -19,18 +19,16 @@ #ifndef PARTICLE_H #define PARTICLE_H -#include - #include "body.h" -namespace POEMS { + class Particle : public Body { -public: +public: Particle(); ~Particle(); BodyType GetType(); bool ReadInBodyData(std::istream& in); void WriteOutBodyData(std::ostream& out); }; -} + #endif diff --git a/lib/poems/poemslist.h b/lib/poems/poemslist.h index bd0c1456b4..9882af013a 100644 --- a/lib/poems/poemslist.h +++ b/lib/poems/poemslist.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: poemslist.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,7 +21,8 @@ #include #include -namespace POEMS { +using namespace std; + template class ListElement{ public: ListElement* prev; @@ -50,7 +51,7 @@ public: S* operator()(int id); void Append(List * listToAppend); void DeleteValues(); - void RemoveElementAndDeleteValue(ListElement* ele); + void RemoveElementAndDeleteValue(ListElement* ele); void PrintList(); }; @@ -89,9 +90,9 @@ template List::~List(){ template void List::Append(List * listToAppend) { - tail->next = listToAppend->head; - listToAppend->head->prev = tail; - tail = listToAppend->tail; + tail->next = listToAppend->head; + listToAppend->head->prev = tail; + tail = listToAppend->tail; } template int List::GetNumElements(){ @@ -103,17 +104,17 @@ template ListElement* List::GetHeadElement(){ } template ListElement* List::GetTailElement(){ - return tail; + return tail; } template void List::Remove(ListElement* ele){ if(!ele){ - std::cerr << "ERROR: ListElement to be removed not defined" << std::endl; + cerr << "ERROR: ListElement to be removed not defined" << endl; exit(0); } if(!numelements){ - std::cerr << "ERROR: List is empty" << std::endl; + cerr << "ERROR: List is empty" << endl; exit(0); } @@ -134,7 +135,7 @@ template void List::Remove(ListElement* ele){ template ListElement* List::Append(S* v){ if(!v){ - std::cerr << "ERROR: cannot add null Body to list" << std::endl; + cerr << "ERROR: cannot add null Body to list" << endl; exit(0); } @@ -144,22 +145,22 @@ template ListElement* List::Append(S* v){ if(numelements==1) head = tail = ele; else{ - /* + /* tail->next = ele; ele->prev = tail; - tail = ele;*/ - - ele->prev = tail; - tail = ele; - ele->prev->next = ele; - - } + tail = ele;*/ + + ele->prev = tail; + tail = ele; + ele->prev->next = ele; + + } return ele; } template ListElement* List::Prepend(S* v){ if(!v){ - std::cerr << "ERROR: cannot add null Body to list" << std::endl; + cerr << "ERROR: cannot add null Body to list" << endl; exit(0); } @@ -169,9 +170,9 @@ template ListElement* List::Prepend(S* v){ if(numelements==1) head = tail = ele; else{ - ele->next = head; - head = ele; - ele->next->prev = ele; + ele->next = head; + head = ele; + ele->next->prev = ele; } return ele; } @@ -189,15 +190,15 @@ template S** List::CreateArray(){ template S* List::operator()(int id){ if(id >= numelements){ - std::cerr << "ERROR: subscript out of bounds" << std::endl; + cerr << "ERROR: subscript out of bounds" << endl; exit(0); } - + ListElement* ele = head; for(int i=0;inext; } - + return ele->value; } @@ -213,15 +214,16 @@ template void List::RemoveElementAndDeleteValue(ListElement* ele) } template void List::PrintList(){ - std::cout << "Printing List " << std::endl; - ListElement* ele = head; - std::cout << *(ele->value) << " "; - ele = ele->next; - for(int k =2; kvalue) << " "; - ele = ele->next; - } - std::cout << *(ele->value) << std::endl; -} + cout<<"Printing List "<* ele = head; + cout<<*(ele->value)<<" "; + ele = ele->next; + for(int k =2; kvalue)<<" "; + ele = ele->next; + } + cout<<*(ele->value)< -namespace POEMS { +using namespace std; + + TreeNode *GetTreeNode(int item,TreeNode *lptr = NULL,TreeNode *rptr =NULL); void FreeTreeNode(TreeNode *p); @@ -79,7 +81,7 @@ TreeNode *GetTreeNode(int item,TreeNode *lptr,TreeNode *rptr) // if insufficient memory, terminatewith an error message if (p == NULL) { - std::cerr << "Memory allocation failure!\n"; + cerr << "Memory allocation failure!\n"; exit(1); } @@ -138,7 +140,7 @@ void IndentBlanks(int num) // const int indentblock = 6; for(int i = 0; i < num; i++) - std::cout << " "; + cout << " "; } void PrintTree (TreeNode *t, int level) @@ -151,11 +153,10 @@ void PrintTree (TreeNode *t, int level) PrintTree(t->Right(),level + 1); // indent to current level; output node data IndentBlanks(indentUnit*level); - std::cout << t->GetData() << std::endl; + cout << t->GetData() << endl; // print left branch of tree t PrintTree(t->Left(),level + 1); } } -} #endif diff --git a/lib/poems/poemsobject.cpp b/lib/poems/poemsobject.cpp index dfdd95953e..7c3f1ca872 100644 --- a/lib/poems/poemsobject.cpp +++ b/lib/poems/poemsobject.cpp @@ -19,8 +19,6 @@ #include "poemsobject.h" #include -using namespace POEMS; - POEMSObject::POEMSObject(){ name = 0; ChangeName((const char*)"unnamed"); diff --git a/lib/poems/poemsobject.h b/lib/poems/poemsobject.h index 173d9da7ab..63b2915638 100644 --- a/lib/poems/poemsobject.h +++ b/lib/poems/poemsobject.h @@ -19,7 +19,7 @@ #ifndef POEMSOBJECT_H #define POEMSOBJECT_H -namespace POEMS { + class POEMSObject { char* name; int ID; @@ -31,5 +31,5 @@ public: int GetID(); void SetID(int id); }; -} + #endif diff --git a/lib/poems/poemstree.h b/lib/poems/poemstree.h index d49a0d0a88..8f8e80ab66 100644 --- a/lib/poems/poemstree.h +++ b/lib/poems/poemstree.h @@ -21,7 +21,7 @@ #include "poemstreenode.h" #include "poemsnodelib.h" -namespace POEMS { + // constants to indicate the balance factor of a node const int leftheavy = -1; const int balanced = 0; @@ -609,5 +609,5 @@ void Tree::ClearList(void) delete current; size = 0; } -} + #endif diff --git a/lib/poems/poemstreenode.cpp b/lib/poems/poemstreenode.cpp index ca4307f69f..051e13d6e0 100644 --- a/lib/poems/poemstreenode.cpp +++ b/lib/poems/poemstreenode.cpp @@ -17,8 +17,6 @@ #include "poemstreenode.h" -using namespace POEMS; - // constructor; initialize the data and pointer fields // The pointer value NULL assigns a empty subtree TreeNode::TreeNode (const int & item, TreeNode *lptr,TreeNode *rptr, diff --git a/lib/poems/poemstreenode.h b/lib/poems/poemstreenode.h index 69f3caf958..b8f46031a5 100644 --- a/lib/poems/poemstreenode.h +++ b/lib/poems/poemstreenode.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: poemstreenode.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,37 +11,42 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef TREENODE_H #define TREENODE_H -namespace POEMS { +//#define NULL 0 + + +//Tree depends on TreeNode +class Tree; + // declares a tree node object for a binary tree class TreeNode{ private: // points to the left and right children of the node - TreeNode *left; - TreeNode *right; - - int balanceFactor; - int data; - void * aux_data; -public: - // make Tree a friend because it needs access to left and right pointer fields of a node - friend class Tree; - TreeNode * Left(); - TreeNode * Right(); - int GetData(); - void * GetAuxData() {return aux_data;}; - void SetAuxData(void * AuxData) {aux_data = AuxData;}; - int GetBalanceFactor(); - TreeNode(const int &item, TreeNode *lptr, TreeNode *rptr, int balfac = 0); - //friend class DCASolver; + TreeNode *left; + TreeNode *right; + + int balanceFactor; + int data; + void * aux_data; +public: + // make Tree a friend because it needs access to left and right pointer fields of a node + friend class Tree; + TreeNode * Left(); + TreeNode * Right(); + int GetData(); + void * GetAuxData() {return aux_data;}; + void SetAuxData(void * AuxData) {aux_data = AuxData;}; + int GetBalanceFactor(); + TreeNode(const int &item, TreeNode *lptr, TreeNode *rptr, int balfac = 0); + //friend class DCASolver; }; -} + #endif diff --git a/lib/poems/point.cpp b/lib/poems/point.cpp index f648b58d3d..4383844736 100644 --- a/lib/poems/point.cpp +++ b/lib/poems/point.cpp @@ -16,11 +16,7 @@ *_________________________________________________________________________*/ -#include "fixedpoint.h" -#include "point.h" -#include "vect3.h" - -using namespace POEMS; +#include "points.h" Point::Point(){ position.Zeros(); @@ -37,7 +33,7 @@ void Point::WriteOut(std::ostream& out){ WriteOutPointData(out); } -Point* POEMS::NewPoint(int type){ +Point* NewPoint(int type){ switch( PointType(type) ) { case FIXEDPOINT : // A Fixed Point diff --git a/lib/poems/point.h b/lib/poems/point.h index c08e92db0d..746a527cd7 100644 --- a/lib/poems/point.h +++ b/lib/poems/point.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: point.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -22,21 +22,21 @@ #include "poemsobject.h" #include "vect3.h" -namespace POEMS { + // emumerated type enum PointType { FIXEDPOINT = 0 }; class Point : public POEMSObject { -public: +public: Vect3 position; - Point(); - bool ReadIn(std::istream& in); + Point(); + bool ReadIn(std::istream& in); void WriteOut(std::ostream& out); - - virtual ~Point(); + + virtual ~Point(); virtual PointType GetType() = 0; virtual Vect3 GetPoint() = 0; virtual bool ReadInPointData(std::istream& in) = 0; @@ -45,5 +45,5 @@ public: // global point functions Point* NewPoint(int type); -} + #endif diff --git a/lib/poems/prismaticjoint.cpp b/lib/poems/prismaticjoint.cpp index 3e649f0d22..7c01667a86 100644 --- a/lib/poems/prismaticjoint.cpp +++ b/lib/poems/prismaticjoint.cpp @@ -16,16 +16,10 @@ *_________________________________________________________________________*/ #include "prismaticjoint.h" - #include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" -#include "colmatrix.h" -#include "mat3x3.h" -#include "virtualmatrix.h" - -using namespace POEMS; PrismaticJoint::PrismaticJoint(){ q.Dim(1); diff --git a/lib/poems/prismaticjoint.h b/lib/poems/prismaticjoint.h index df3ab3195c..17cf050a78 100644 --- a/lib/poems/prismaticjoint.h +++ b/lib/poems/prismaticjoint.h @@ -18,13 +18,12 @@ #ifndef PRISMATICJOINT_H #define PRISMATICJOINT_H -#include - #include "joint.h" #include "vect3.h" -#include "matrix.h" +#include "mat3x3.h" + + -namespace POEMS { class PrismaticJoint : public Joint { Vect3 axis_pk; // unit vector in body1 basis Vect3 axis_k; // unit vector in body2 basis @@ -44,5 +43,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; -} + #endif diff --git a/lib/poems/revolutejoint.cpp b/lib/poems/revolutejoint.cpp index 6b11acbf0f..ec5b1bec02 100644 --- a/lib/poems/revolutejoint.cpp +++ b/lib/poems/revolutejoint.cpp @@ -16,16 +16,10 @@ *_________________________________________________________________________*/ #include "revolutejoint.h" - #include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" -#include "colmatrix.h" -#include "mat3x3.h" -#include "virtualmatrix.h" - -using namespace POEMS; RevoluteJoint::RevoluteJoint(){ DimQandU(1); diff --git a/lib/poems/revolutejoint.h b/lib/poems/revolutejoint.h index 10a38114df..478d48dbb9 100644 --- a/lib/poems/revolutejoint.h +++ b/lib/poems/revolutejoint.h @@ -18,13 +18,11 @@ #ifndef REVOLUTEJOINT_H #define REVOLUTEJOINT_H -#include #include "joint.h" #include "vect3.h" -#include "matrix.h" +#include "mat3x3.h" + -namespace POEMS { -class VirtualMatrix; class RevoluteJoint : public Joint { Vect3 axis_pk; // unit vector in body1 basis @@ -45,5 +43,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; -} + #endif diff --git a/lib/poems/rigidbody.cpp b/lib/poems/rigidbody.cpp index a7d4f9f19f..3ac424f9e9 100644 --- a/lib/poems/rigidbody.cpp +++ b/lib/poems/rigidbody.cpp @@ -16,12 +16,9 @@ *_________________________________________________________________________*/ #include "rigidbody.h" -#include "mat3x3.h" -#include "virtualmatrix.h" +#include "fixedpoint.h" using namespace std; -using namespace POEMS; - RigidBody::RigidBody(){ } diff --git a/lib/poems/rigidbody.h b/lib/poems/rigidbody.h index d4be92ebcf..0bb2a3ece2 100644 --- a/lib/poems/rigidbody.h +++ b/lib/poems/rigidbody.h @@ -18,11 +18,8 @@ #ifndef RIGIDBODY_H #define RIGIDBODY_H -#include - #include "body.h" -namespace POEMS { class RigidBody : public Body { public: RigidBody(); @@ -31,5 +28,5 @@ public: bool ReadInBodyData(std::istream& in); void WriteOutBodyData(std::ostream& out); }; -} + #endif diff --git a/lib/poems/rowmatrix.cpp b/lib/poems/rowmatrix.cpp index eac8fbef5d..feb185070e 100644 --- a/lib/poems/rowmatrix.cpp +++ b/lib/poems/rowmatrix.cpp @@ -16,13 +16,11 @@ *_________________________________________________________________________*/ #include "rowmatrix.h" - +#include "colmatrix.h" #include #include using namespace std; -using namespace POEMS; - RowMatrix::RowMatrix(){ numcols = 0; diff --git a/lib/poems/rowmatrix.h b/lib/poems/rowmatrix.h index 8e8d7b5f99..b04113e8ed 100644 --- a/lib/poems/rowmatrix.h +++ b/lib/poems/rowmatrix.h @@ -19,12 +19,8 @@ #ifndef ROWMATRIX_H #define ROWMATRIX_H -#include - #include "virtualrowmatrix.h" -#include "virtualmatrix.h" -namespace POEMS { class RowMatrix : public VirtualRowMatrix { double* elements; public: @@ -53,5 +49,5 @@ public: RowMatrix& operator=(const VirtualMatrix& A); // overloaded = RowMatrix& operator*=(double b); }; -} + #endif diff --git a/lib/poems/solver.cpp b/lib/poems/solver.cpp index 04afb27945..67f5b607e3 100644 --- a/lib/poems/solver.cpp +++ b/lib/poems/solver.cpp @@ -15,12 +15,9 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ -#include #include "solver.h" #include "system.h" -#include "onsolver.h" - -using namespace POEMS; +#include "matrices.h" Solver::Solver(){ diff --git a/lib/poems/solver.h b/lib/poems/solver.h index 489e6d41f1..45564dd1ef 100644 --- a/lib/poems/solver.h +++ b/lib/poems/solver.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: solver.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,29 +11,28 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef SOLVER_H #define SOLVER_H - +#include #include "colmatmap.h" +#include "matrices.h" #include "defines.h" -namespace POEMS { class System; -class Matrix; class Solver{ protected: System* system; - + double time; ColMatMap state; ColMatMap statedot; - ColMatMap statedoubledot; + ColMatMap statedoubledot; SolverType type; @@ -48,13 +47,13 @@ public: virtual void DeleteModel() = 0; virtual void CreateModel() = 0; - virtual void Solve(double time, Matrix& FF) = 0; - - - + virtual void Solve(double time, Matrix& FF) = 0; + + + ColMatMap* GetState(); ColMatMap* GetStateDerivative(); ColMatMap* GetStateDerivativeDerivative(); }; -} + #endif diff --git a/lib/poems/sphericaljoint.cpp b/lib/poems/sphericaljoint.cpp index 996bb5a887..fb5330db17 100644 --- a/lib/poems/sphericaljoint.cpp +++ b/lib/poems/sphericaljoint.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: sphericaljoint.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,27 +11,21 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #include "sphericaljoint.h" - -#include - #include "point.h" #include "matrixfun.h" #include "body.h" #include "fastmatrixops.h" +#include "norm.h" #include "eulerparameters.h" -#include "colmatrix.h" -#include "mat3x3.h" -#include "vect3.h" -#include "virtualmatrix.h" +#include "matrices.h" +#include -using namespace std; -using namespace POEMS; SphericalJoint::SphericalJoint(){ DimQandU(4,3); @@ -50,24 +44,24 @@ bool SphericalJoint::ReadInJointData(std::istream& in){ void SphericalJoint::WriteOutJointData(std::ostream& out){ } -Matrix SphericalJoint::GetForward_sP(){ +Matrix SphericalJoint::GetForward_sP(){ Mat3x3 sPa,sPl; Matrix sP(6,3); - sPa.Identity(); + sPa.Identity(); sPl.Zeros(); - Vect3 temp = -(point2->position); - + Vect3 temp = -(point2->position); + sPl(1,2) = temp(3); sPl(1,3) = -temp(2); - + sPl(2,1) = -temp(3); sPl(2,3) = temp(1); - - sPl(3,1) = temp(2); + + sPl(3,1) = temp(2); sPl(3,2) = -temp(1); - - sP=Stack(sPa,sPl); - return sP; + + sP=Stack(sPa,sPl); + return sP; } void SphericalJoint::UpdateForward_sP( Matrix& sP){ @@ -81,15 +75,15 @@ Matrix SphericalJoint::GetBackward_sP(){ cout<<" -----------"<position(1)); - sPl(2,3)=-(point2->position(1)); + sPa.Identity(); + sPl.Zeros(); + sPl(3,2)=(point2->position(1)); + sPl(2,3)=-(point2->position(1)); sP=Stack(sPa,sPl); - return sP; + return sP; } -void SphericalJoint::UpdateBackward_sP( Matrix& sP){ +void SphericalJoint::UpdateBackward_sP( Matrix& sP){ // sP is constant, do nothing. } @@ -98,106 +92,106 @@ void SphericalJoint::ComputeLocalTransform(){ // Obtain the transformation matrix from euler parameters EP_Transformation(q, ko_C_k); FastMult(pk_C_ko,ko_C_k,pk_C_k); - } + } void SphericalJoint::ForwardKinematics(){ Vect3 result1,result2,result3,result4,result5; Vect3 pk_w_k; - + //cout<<"Check in spherical "<position,result1); // parents basis - FastAdd(result1,point1->position,r12); - - // compute position vector r21 - FastNegMult(k_C_pk,r12,r21); - - - + // COMPUTE POSITION VECTOR R12 aka GAMMA + + FastNegMult(pk_C_k,point2->position,result1); // parents basis + FastAdd(result1,point1->position,r12); + + // compute position vector r21 + FastNegMult(k_C_pk,r12,r21); + + + //----------------------------------// - // COMPUTE GLOBAL LOCATION - FastMult(body1->n_C_k,(body1->GetPoint(2))->position,result1); - FastAdd(result1,body1->r,result1); - FastNegMult(body2->n_C_k,(body2->GetPoint(1))->position,result2); - FastAdd(result1,result2,body2->r); - - qdot_to_u(q, u, qdot); - - - //----------------------------------- - // angular velocities - + // COMPUTE GLOBAL LOCATION + FastMult(body1->n_C_k,(body1->GetPoint(2))->position,result1); + FastAdd(result1,body1->r,result1); + FastNegMult(body2->n_C_k,(body2->GetPoint(1))->position,result2); + FastAdd(result1,result2,body2->r); + + qdot_to_u(q, u, qdot); + + + //----------------------------------- + // angular velocities + FastAssign(u,pk_w_k); - FastTMult(pk_C_k,body1->omega_k,result1); + FastTMult(pk_C_k,body1->omega_k,result1); FastAdd(result1,pk_w_k,body2->omega_k); - FastMult(body2->n_C_k,body2->omega_k,body2->omega); - - - - //----------------------------------- - - // compute velocities - FastCross(body1->omega_k,(body1->GetPoint(2))->position,result1); + FastMult(body2->n_C_k,body2->omega_k,body2->omega); + + + + //----------------------------------- + + // compute velocities + FastCross(body1->omega_k,(body1->GetPoint(2))->position,result1); FastAdd(body1->v_k,result1,result2); - FastTMult(pk_C_k,result2,result1); // In body basis - - FastCross((body2->GetPoint(1))->position,body2->omega_k,result2); - FastAdd(result1,result2,body2->v_k); // In body basis - FastMult(body2->n_C_k,body2->v_k,body2->v); - - + FastTMult(pk_C_k,result2,result1); // In body basis + + FastCross((body2->GetPoint(1))->position,body2->omega_k,result2); + FastAdd(result1,result2,body2->v_k); // In body basis + FastMult(body2->n_C_k,body2->v_k,body2->v); + + //------------------------------------------ - //Compute the KE + //Compute the KE Matrix tempke; - tempke = T(body2->v)*(body2->v); + tempke = T(body2->v)*(body2->v); double ke = 0.0; - ke = body2->mass*tempke(1,1); + ke = body2->mass*tempke(1,1); FastMult(body2->inertia,body2->omega_k,result1); - tempke= T(body2->omega_k)*result1; + tempke= T(body2->omega_k)*result1; ke = 0.5*ke + 0.5*tempke(1,1); body2->KE=ke; - //----------------------------------- - // compute state explicit angular acceleration // Has to be in body basis - FastTMult(pk_C_k,body1->alpha_t,result2); + //----------------------------------- + // compute state explicit angular acceleration // Has to be in body basis + FastTMult(pk_C_k,body1->alpha_t,result2); FastCross(body2->omega_k,pk_w_k,result1); - FastAdd(result1,result2,body2->alpha_t); - - //----------------------------------- - // compute state explicit acceleration - // NEED TO DO THIS COMPLETELY IN BODY BASIS - + FastAdd(result1,result2,body2->alpha_t); + + //----------------------------------- + // compute state explicit acceleration + // NEED TO DO THIS COMPLETELY IN BODY BASIS + FastCross(body1->omega_k,(body1->GetPoint(2))->position,result1); - FastCross(body1->omega_k,result1,result2); - FastTMult(pk_C_k,result2,result1); - - //FastCross(body2->omega_k,-(body2->GetPoint(1))->position,result3); - FastCross((body2->GetPoint(1))->position,body2->omega_k,result3); - FastCross(body2->omega_k,result3,result2); - FastAdd(result1,result2,result3); //wxwxr in body basis - - FastCross(body1->alpha_t,(body1->GetPoint(2))->position,result4); - FastTMult(pk_C_k,result4,result5); + FastCross(body1->omega_k,result1,result2); + FastTMult(pk_C_k,result2,result1); + + //FastCross(body2->omega_k,-(body2->GetPoint(1))->position,result3); + FastCross((body2->GetPoint(1))->position,body2->omega_k,result3); + FastCross(body2->omega_k,result3,result2); + FastAdd(result1,result2,result3); //wxwxr in body basis + + FastCross(body1->alpha_t,(body1->GetPoint(2))->position,result4); + FastTMult(pk_C_k,result4,result5); FastAssign(result5,result4); - - FastCross((body2->GetPoint(1))->position,body2->alpha_t,result2); - FastAdd(result2,result4,result1); //alphaxr in body basis - + + FastCross((body2->GetPoint(1))->position,body2->alpha_t,result2); + FastAdd(result2,result4,result1); //alphaxr in body basis + FastTMult(pk_C_k,body1->a_t,result2); - FastTripleSum(result3,result1,result2,body2->a_t); // in body basis - - - //----------------------------------- + FastTripleSum(result3,result1,result2,body2->a_t); // in body basis + + + //----------------------------------- } // NOTE: NOT USING BACKWARDKINEMATICS AT PRESENT @@ -208,13 +202,13 @@ void SphericalJoint::BackwardKinematics(){ // orientations ComputeBackwardTransforms(); - + // compute position vector r21 //r21 = point2->position - k_C_pk * point1->position; FastMult(k_C_pk,point1->position,result1); FastSubt(point2->position,result1,r21); - + // compute position vector r21 FastNegMult(pk_C_k,r21,r12); @@ -233,7 +227,7 @@ void SphericalJoint::BackwardKinematics(){ EP_Derivatives(q,u,qdot); // angular velocities - + FastMult(body2->n_C_k,u,result2); FastAdd(body2->omega,result2,body1->omega); FastAssign(u,k_w_pk); @@ -253,7 +247,7 @@ void SphericalJoint::BackwardKinematics(){ FastCross(body1->omega_k,k_w_pk,result1); FastMult(pk_C_k,body2->alpha_t,result2); FastAdd(result1,result2,body1->alpha_t); - + // compute state explicit acceleration FastCross(body2->alpha_t,point2->position,result1); FastCross(body2->omega_k,point2->position,result2); @@ -266,5 +260,5 @@ void SphericalJoint::BackwardKinematics(){ FastCross(body1->omega_k,result2,result3); FastTripleSum(result5,result1,result3,body1->a_t); - + } diff --git a/lib/poems/sphericaljoint.h b/lib/poems/sphericaljoint.h index db048e5544..ef29f8e38e 100644 --- a/lib/poems/sphericaljoint.h +++ b/lib/poems/sphericaljoint.h @@ -18,11 +18,12 @@ #ifndef SPHERICALJOINT_H #define SPHERICALJOINT_H -#include #include "joint.h" -#include "matrix.h" +#include "vect3.h" +#include "mat3x3.h" + + -namespace POEMS { class SphericalJoint : public Joint { Matrix const_sP; public: @@ -39,5 +40,5 @@ public: void ForwardKinematics(); void BackwardKinematics(); }; -} + #endif diff --git a/lib/poems/system.cpp b/lib/poems/system.cpp index 8515588424..369213f7d0 100644 --- a/lib/poems/system.cpp +++ b/lib/poems/system.cpp @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: system.cpp * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,37 +11,19 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #include "system.h" - -#include -#include - #include "body.h" #include "joint.h" -#include "colmatrix.h" -#include "eulerparameters.h" -#include "fixedpoint.h" -#include "freebodyjoint.h" -#include "inertialframe.h" -#include "mat3x3.h" -#include "matrix.h" -#include "matrixfun.h" -#include "rigidbody.h" -#include "sphericaljoint.h" -#include "vect3.h" -#include "virtualmatrix.h" - -namespace POEMS { class Point; } -using namespace std; -using namespace POEMS; +#include + System::System(){ - mappings = NULL; + mappings = NULL; } System::~System(){ @@ -60,7 +42,7 @@ int System::GetNumBodies(){ int * System::GetMappings() { - return mappings; + return mappings; } void System::AddBody(Body* body){ @@ -79,16 +61,16 @@ double System::GetTime(){ return time; } -void System::ComputeForces(){ - // NOT DOING ANYTHING AT THIS TIME - } - +void System::ComputeForces(){ + // NOT DOING ANYTHING AT THIS TIME + } + bool System::ReadIn(istream& in){ int numbodies; Body* body; int bodytype; char bodyname[256]; - int index; + int index; // get number of bodies in >> numbodies; @@ -166,12 +148,12 @@ bool System::ReadIn(istream& in){ delete [] bodyarray; return false; } - + joint->SetBodies(bodyarray[body1], bodyarray[body2]); bodyarray[body1]->AddJoint(joint); bodyarray[body2]->AddJoint(joint); - + in >> point1 >> point2; joint->SetPoints(bodyarray[body1]->GetPoint(point1),bodyarray[body2]->GetPoint(point2)); @@ -204,7 +186,7 @@ void System::WriteOut(ostream& out){ // set the body ID for later identification body->SetID(i); - + // write out the data body->WriteOut(out); @@ -212,7 +194,7 @@ void System::WriteOut(ostream& out){ } // number of joints - out << joints.GetNumElements() << endl; + out << joints.GetNumElements() << endl; // joints loop i = 0; @@ -227,7 +209,7 @@ void System::WriteOut(ostream& out){ // write out the data joint->WriteOut(out); - + i++; j_ele = j_ele->next; } } @@ -253,68 +235,68 @@ void System::ClearJointIDs(){ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space){ - //-------------------------------------------------------------------------// - // Declaring Temporary Entities - //-------------------------------------------------------------------------// + //-------------------------------------------------------------------------// + // Declaring Temporary Entities + //-------------------------------------------------------------------------// Body* body = NULL; Body* prev; Body* Inertial; Point* origin; Joint* joint; - Point* point_CM; - Point* point_p; - Point* point_k; + Point* point_CM; + Point* point_p; + Point* point_k; Point* point_ch = NULL; - Vect3 r1,r2,r3,v1,v2,v3; + Vect3 r1,r2,r3,v1,v2,v3; Mat3x3 IM, N, PKCK,PKCN ; ColMatrix qo, uo, q, qdot,w; - - mappings = new int[nfree]; - for(int i = 0; i < nfree; i++) - { - mappings[i] = freelist[i]; - } + + mappings = new int[nfree]; + for(int i = 0; i < nfree; i++) + { + mappings[i] = freelist[i]; + } qo.Dim(4); uo.Dim(3); q.Dim(4); - qdot.Dim(4); + qdot.Dim(4); PKCN.Identity(); PKCK.Identity(); w.Dim(3); - -//-------------------------------------------------------------------------// - // Setting up Inertial Frame, gravity and Origin + +//-------------------------------------------------------------------------// + // Setting up Inertial Frame, gravity and Origin //-------------------------------------------------------------------------// - Inertial= new InertialFrame; + Inertial= new InertialFrame; AddBody(Inertial); - - Vect3 temp1; - temp1.Zeros(); - ((InertialFrame*) Inertial)->SetGravity(temp1); + + Vect3 temp1; + temp1.Zeros(); + ((InertialFrame*) Inertial)->SetGravity(temp1); origin= new FixedPoint(temp1); - Inertial->AddPoint(origin); -//-------------------------------------------------------------------------// - double ** xh1 = new double*[nfree]; - double ** xh2 = new double*[nfree]; - - for (int i=0; iAddPoint(origin); //-------------------------------------------------------------------------// + double ** xh1 = new double*[nfree]; + double ** xh2 = new double*[nfree]; + + for (int i=0; imass=masstotal[mappings[i]-1]; IM(1,1)=inertia[mappings[i]-1][0]; IM(2,2)=inertia[mappings[i]-1][1]; @@ -325,49 +307,49 @@ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstota IM(2,1)=IM(1,2); IM(3,1)=IM(1,3); IM(3,2)=IM(2,3); - body->inertia = IM; - -//-------------------------------------------------------// - - - for (int k=0;k<3;k++){ - r1(k+1)=xh1[i][k]-xcm[mappings[i]-1][k]; - r3(k+1) = xcm[mappings[i]-1][k]; - r3(k+1)=xh2[i][k]-xcm[mappings[i]-1][k]; - } - - r2.Zeros(); - - for (int k=1;k<=3;k++){ - N(k,1)=ex_space[mappings[i]-1][k-1]; - N(k,2)=ey_space[mappings[i]-1][k-1]; - N(k,3)=ez_space[mappings[i]-1][k-1]; - } - + body->inertia = IM; + +//-------------------------------------------------------// + + + for (int k=0;k<3;k++){ + r1(k+1)=xh1[i][k]-xcm[mappings[i]-1][k]; + r3(k+1) = xcm[mappings[i]-1][k]; + r3(k+1)=xh2[i][k]-xcm[mappings[i]-1][k]; + } + + r2.Zeros(); + + for (int k=1;k<=3;k++){ + N(k,1)=ex_space[mappings[i]-1][k-1]; + N(k,2)=ey_space[mappings[i]-1][k-1]; + N(k,3)=ez_space[mappings[i]-1][k-1]; + } + PKCK=T(N); PKCN=T(N); - - q.Zeros(); + + q.Zeros(); EP_FromTransformation(q,N); - + r1=PKCN*r1; r3=PKCN*r3; - + for (int k=1;k<=3;k++){ - w(k)=omega[mappings[i]-1][k-1]; - } - + w(k)=omega[mappings[i]-1][k-1]; + } + Vect3 cart_r, cart_v; for (int k=1;k<=3;k++){ - cart_r(k)=xcm[mappings[i]-1][k-1]; - cart_v(k)=vcm[mappings[i]-1][k-1]; - } - - w=PKCN*w; - EP_Derivatives(q,w,qdot); - - -//-------------------------------------------------------------------------// + cart_r(k)=xcm[mappings[i]-1][k-1]; + cart_v(k)=vcm[mappings[i]-1][k-1]; + } + + w=PKCN*w; + EP_Derivatives(q,w,qdot); + + +//-------------------------------------------------------------------------// // Create bodies and joints with associated properties for POEMS //-------------------------------------------------------------------------// @@ -377,12 +359,12 @@ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstota body->AddPoint(point_CM); body->AddPoint(point_k); body->AddPoint(point_ch); - AddBody(body); - + AddBody(body); + Mat3x3 One; - One.Identity(); - ColMatrix qq=Stack(q,cart_r); - ColMatrix vv=Stack(qdot,cart_v); + One.Identity(); + ColMatrix qq=Stack(q,cart_r); + ColMatrix vv=Stack(qdot,cart_v); joint=new FreeBodyJoint; AddJoint(joint); joint->SetBodies(prev,body); @@ -392,225 +374,225 @@ void System::Create_DegenerateSystem(int& nfree, int*freelist, double *&masstota joint->SetZeroOrientation(One); joint->DimQandU(7,6); joint->SetInitialState(qq,vv); - joint->ForwardKinematics(); + joint->ForwardKinematics(); } for(int i = 0; i < nfree; i++) { - delete [] xh1[i]; - delete [] xh2[i]; + delete [] xh1[i]; + delete [] xh2[i]; } delete [] xh1; - delete [] xh2; + delete [] xh2; } void System::Create_System_LAMMPS(int numbodies, double *mass,double **inertia, double ** xcm, double ** xjoint,double **vcm,double **omega,double **ex_space, double **ey_space, double **ez_space, int b, int * mapping, int count){ - //-------------------------------------------------------------------------// - // Declaring Temporary Entities - //-------------------------------------------------------------------------// - - Body* body = NULL; - Body* prev; - Body* Inertial; - Point* origin; - Joint* joint; - Point* point_CM; - Point* point_p; - Point* point_k; - Point* point_ch = NULL; - Vect3 r1,r2,r3,v1,v2,v3; - Mat3x3 IM, N, PKCK,PKCN ; - ColMatrix qo, uo, q, qdot,w; - Vect3 cart_r, cart_v; - mappings = new int[b]; - for(int i = 0; i < b; i++){ - mappings[i] = mapping[i]; - } - - - qo.Dim(4); - uo.Dim(3); - q.Dim(4); - qdot.Dim(4); - PKCN.Identity(); - PKCK.Identity(); - w.Dim(3); - - //-------------------------------------------------------------------------// - // Setting up Inertial Frame, gravity and Origin - //-------------------------------------------------------------------------// - Inertial= new InertialFrame; - AddBody(Inertial); - - Vect3 temp1; - temp1.Zeros(); - ((InertialFrame*) Inertial)->SetGravity(temp1); - origin= new FixedPoint(temp1); - Inertial->AddPoint(origin); - //-------------------------------------------------------------------------// - - double ** xh1; - double ** xh2; - - xh1 = new double*[b]; - xh2 = new double*[b]; - - - for (int i=0; iSetGravity(temp1); + origin= new FixedPoint(temp1); + Inertial->AddPoint(origin); + //-------------------------------------------------------------------------// + + double ** xh1; + double ** xh2; + + xh1 = new double*[b]; + xh2 = new double*[b]; + + + for (int i=0; imass=mass[mapping[i]-1]; - IM(1,1)=inertia[mapping[i]-1][0]; - IM(2,2)=inertia[mapping[i]-1][1]; - IM(3,3)=inertia[mapping[i]-1][2]; - IM(1,2)=0.0; - IM(1,3)=0.0; - IM(2,3)=0.0; - IM(2,1)=IM(1,2); - IM(3,1)=IM(1,3); - IM(3,2)=IM(2,3); - body->inertia = IM; - - //-------------------------------------------------------// - - for (int k=0;k<3;k++){ - r1(k+1)=xh1[i][k]-xcm[mapping[i]-1][k]; - r3(k+1)=xh2[i][k]-xcm[mapping[i]-1][k]; - } - r2.Zeros(); - - for (int k=1;k<=3;k++){ - N(k,1)=ex_space[mapping[i]-1][k-1]; - N(k,2)=ey_space[mapping[i]-1][k-1]; - N(k,3)=ez_space[mapping[i]-1][k-1]; - } - - - if (i==0){ - PKCK=T(N); - PKCN=T(N); - - q.Zeros(); - EP_FromTransformation(q,N); - - r1=PKCN*r1; - r3=PKCN*r3; - - for (int k=1;k<=3;k++){ - w(k)=omega[mappings[i]-1][k-1]; - } - - for (int k=1;k<=3;k++){ - cart_r(k)=xcm[mappings[i]-1][k-1]; - cart_v(k)=vcm[mappings[i]-1][k-1]; - } - w=PKCN*w; - EP_Derivatives(q,w,qdot); - - } - else{ - PKCK=PKCN*N; - PKCN=T(N); - - q.Zeros(); - EP_FromTransformation(q,PKCK); - - r1=PKCN*r1; - r3=PKCN*r3; - - for (int k=1;k<=3;k++){ - w(k)=omega[mapping[i]-1][k-1]-omega[mapping[i-1]-1][k-1]; - } - - w=PKCN*w; - EP_Derivatives(q, w, qdot); - } - - - //-------------------------------------------------------------------------// + //-------------------------------------------------------------------------// + for(int i=0;imass=mass[mapping[i]-1]; + IM(1,1)=inertia[mapping[i]-1][0]; + IM(2,2)=inertia[mapping[i]-1][1]; + IM(3,3)=inertia[mapping[i]-1][2]; + IM(1,2)=0.0; + IM(1,3)=0.0; + IM(2,3)=0.0; + IM(2,1)=IM(1,2); + IM(3,1)=IM(1,3); + IM(3,2)=IM(2,3); + body->inertia = IM; + + //-------------------------------------------------------// + + for (int k=0;k<3;k++){ + r1(k+1)=xh1[i][k]-xcm[mapping[i]-1][k]; + r3(k+1)=xh2[i][k]-xcm[mapping[i]-1][k]; + } + r2.Zeros(); + + for (int k=1;k<=3;k++){ + N(k,1)=ex_space[mapping[i]-1][k-1]; + N(k,2)=ey_space[mapping[i]-1][k-1]; + N(k,3)=ez_space[mapping[i]-1][k-1]; + } + + + if (i==0){ + PKCK=T(N); + PKCN=T(N); + + q.Zeros(); + EP_FromTransformation(q,N); + + r1=PKCN*r1; + r3=PKCN*r3; + + for (int k=1;k<=3;k++){ + w(k)=omega[mappings[i]-1][k-1]; + } + + for (int k=1;k<=3;k++){ + cart_r(k)=xcm[mappings[i]-1][k-1]; + cart_v(k)=vcm[mappings[i]-1][k-1]; + } + w=PKCN*w; + EP_Derivatives(q,w,qdot); + + } + else{ + PKCK=PKCN*N; + PKCN=T(N); + + q.Zeros(); + EP_FromTransformation(q,PKCK); + + r1=PKCN*r1; + r3=PKCN*r3; + + for (int k=1;k<=3;k++){ + w(k)=omega[mapping[i]-1][k-1]-omega[mapping[i-1]-1][k-1]; + } + + w=PKCN*w; + EP_Derivatives(q, w, qdot); + } + + + //-------------------------------------------------------------------------// // Create bodies and joints with associated properties for POEMS - //-------------------------------------------------------------------------// - - point_CM = new FixedPoint(r2); - point_k = new FixedPoint(r1); - point_ch = new FixedPoint(r3); - body->AddPoint(point_CM); - body->AddPoint(point_k); - body->AddPoint(point_ch); - AddBody(body); - - Mat3x3 One; - One.Identity(); - if (i==0){ - ColMatrix qq=Stack(q,cart_r); - ColMatrix vv=Stack(qdot,cart_v); - joint=new FreeBodyJoint; - AddJoint(joint); - joint->SetBodies(prev,body); - body->AddJoint(joint); - prev->AddJoint(joint); - joint->SetPoints(point_p,point_k); - joint->SetZeroOrientation(One); - joint->DimQandU(7,6); - joint->SetInitialState(qq,vv); - joint->ForwardKinematics(); - } - else{ - joint= new SphericalJoint; - AddJoint(joint); - joint->SetBodies(prev,body); - body->AddJoint(joint); - prev->AddJoint(joint); - joint->SetPoints(point_p,point_k); - joint->SetZeroOrientation(One); - joint->DimQandU(4,3); - joint->SetInitialState(q,qdot); - joint->ForwardKinematics(); - } - } - for(int i = 0; i < b; i++) - { - delete [] xh1[i]; - delete [] xh2[i]; - } - delete [] xh1; - delete [] xh2; - + //-------------------------------------------------------------------------// + + point_CM = new FixedPoint(r2); + point_k = new FixedPoint(r1); + point_ch = new FixedPoint(r3); + body->AddPoint(point_CM); + body->AddPoint(point_k); + body->AddPoint(point_ch); + AddBody(body); + + Mat3x3 One; + One.Identity(); + if (i==0){ + ColMatrix qq=Stack(q,cart_r); + ColMatrix vv=Stack(qdot,cart_v); + joint=new FreeBodyJoint; + AddJoint(joint); + joint->SetBodies(prev,body); + body->AddJoint(joint); + prev->AddJoint(joint); + joint->SetPoints(point_p,point_k); + joint->SetZeroOrientation(One); + joint->DimQandU(7,6); + joint->SetInitialState(qq,vv); + joint->ForwardKinematics(); + } + else{ + joint= new SphericalJoint; + AddJoint(joint); + joint->SetBodies(prev,body); + body->AddJoint(joint); + prev->AddJoint(joint); + joint->SetPoints(point_p,point_k); + joint->SetZeroOrientation(One); + joint->DimQandU(4,3); + joint->SetInitialState(q,qdot); + joint->ForwardKinematics(); + } + } + for(int i = 0; i < b; i++) + { + delete [] xh1[i]; + delete [] xh2[i]; + } + delete [] xh1; + delete [] xh2; + } diff --git a/lib/poems/system.h b/lib/poems/system.h index 2402e5852f..1b59395de7 100644 --- a/lib/poems/system.h +++ b/lib/poems/system.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: system.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,18 +11,40 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - + #ifndef SYSTEM_H #define SYSTEM_H + #include +#include +#include +#include +#include + #include "poemslist.h" +#include "matrices.h" +#include "workspace.h" +#include "matrixfun.h" +#include "onsolver.h" +#include "system.h" +#include "inertialframe.h" +#include "rigidbody.h" +#include "revolutejoint.h" +#include "fixedpoint.h" +#include "freebodyjoint.h" +#include "sphericaljoint.h" +#include "body23joint.h" +#include "mixedjoint.h" +#include "eulerparameters.h" +#include "matrices.h" +#include "norm.h" + -namespace POEMS { class Body; class Joint; @@ -34,37 +56,37 @@ namespace POEMS { double time; List bodies; List joints; - + System(); ~System(); void Delete(); - + int GetNumBodies(); - + int * GetMappings(); void AddBody(Body* body); - + void AddJoint(Joint* joint); - + void SetTime(double t); - + double GetTime(); - + void ComputeForces(); - + bool ReadIn(std::istream& in); - + void WriteOut(std::ostream& out); - + void ClearBodyIDs(); - - void ClearJointIDs(); + + void ClearJointIDs(); void Create_System_LAMMPS(int numbodies, double *mass,double **inertia, double ** xcm, double ** xjoint,double **vh1,double **omega,double **ex_space, double **ey_space, double **ez_space, int b, int * mapping, int count); - + void Create_DegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space); }; -} + #endif diff --git a/lib/poems/vect3.cpp b/lib/poems/vect3.cpp index 66c2f902d5..03c5d7bc00 100644 --- a/lib/poems/vect3.cpp +++ b/lib/poems/vect3.cpp @@ -16,13 +16,9 @@ *_________________________________________________________________________*/ #include "vect3.h" - #include -#include using namespace std; -using namespace POEMS; - Vect3::Vect3(){ numrows = 3; numcols = 1; @@ -145,13 +141,6 @@ Vect3& Vect3::operator+=(const Vect3& A){ return *this; } -Vect3& Vect3::operator-(){ - elements[0] = -elements[0]; - elements[1] = -elements[1]; - elements[2] = -elements[2]; - return *this; -} - Vect3& Vect3::operator-=(const Vect3& A){ elements[0] -= A.elements[0]; elements[1] -= A.elements[1]; diff --git a/lib/poems/vect3.h b/lib/poems/vect3.h index 6b0efc371a..ababe18e51 100644 --- a/lib/poems/vect3.h +++ b/lib/poems/vect3.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: vect3.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,19 +11,15 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef VECT3_H #define VECT3_H -#include - #include "virtualcolmatrix.h" -#include "virtualmatrix.h" -namespace POEMS { class Matrix; class Mat3x3; class Mat6x6; @@ -56,7 +52,6 @@ public: Vect3& operator*=(double b); Vect3& operator+=(const Vect3& A); Vect3& operator-=(const Vect3& A); - Vect3& operator-(); friend Matrix T(const Vect3& A); // a wasteful transpose friend Mat3x3 CrossMat(Vect3& a); // a wasteful cross matrix implementation @@ -83,6 +78,7 @@ public: friend void FastMult(Mat3x3& A, ColMatrix& B, Vect3& C); friend void FastAssign(ColMatrix&A, Vect3& C); friend void FastMult(Mat3x3& A, Vect3& B, ColMatrix& C); + }; -} + #endif diff --git a/lib/poems/vect4.cpp b/lib/poems/vect4.cpp index 8e903d57bd..3b5afddc50 100644 --- a/lib/poems/vect4.cpp +++ b/lib/poems/vect4.cpp @@ -16,13 +16,9 @@ *_________________________________________________________________________*/ #include "vect4.h" - #include -#include using namespace std; -using namespace POEMS; - Vect4::Vect4(){ numrows = 4; numcols = 1; diff --git a/lib/poems/vect4.h b/lib/poems/vect4.h index 754706f10a..695f5e158a 100644 --- a/lib/poems/vect4.h +++ b/lib/poems/vect4.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: vect4.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,19 +11,16 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ #ifndef VECT4_H #define VECT4_H -#include - #include "virtualcolmatrix.h" -#include "virtualmatrix.h" -namespace POEMS { + class Matrix; class Mat4x4; @@ -42,7 +39,7 @@ public: void BasicSet_1int(int i, double value); void BasicIncrement_1int(int i, double value); - + void Const(double value); MatrixType GetType() const; std::ostream& WriteData(std::ostream& c) const; @@ -70,5 +67,5 @@ public: friend void FastAdd(Vect4& A, Vect4& B, Vect4& C); friend void FastSubt(Vect4& A, Vect4& B, Vect4& C); }; -} + #endif diff --git a/lib/poems/vect6.cpp b/lib/poems/vect6.cpp index 5aabe520e1..eb65d24f16 100644 --- a/lib/poems/vect6.cpp +++ b/lib/poems/vect6.cpp @@ -16,13 +16,9 @@ *_________________________________________________________________________*/ #include "vect6.h" - #include -#include using namespace std; -using namespace POEMS; - Vect6::Vect6(){ numrows = 6; numcols = 1; diff --git a/lib/poems/vect6.h b/lib/poems/vect6.h index 5def4c6b1b..c346c852ef 100644 --- a/lib/poems/vect6.h +++ b/lib/poems/vect6.h @@ -18,12 +18,8 @@ #ifndef VECT6_H #define VECT6_H -#include - #include "virtualcolmatrix.h" -#include "virtualmatrix.h" -namespace POEMS { class Matrix; class Mat6x6; class ColMatrix; @@ -70,5 +66,5 @@ public: friend void OnPopulateSVect(Vect3& angular, Vect3& linear, Vect6& sV); }; -} + #endif diff --git a/lib/poems/virtualcolmatrix.cpp b/lib/poems/virtualcolmatrix.cpp index fa430b81f7..3a6c6e22cd 100644 --- a/lib/poems/virtualcolmatrix.cpp +++ b/lib/poems/virtualcolmatrix.cpp @@ -20,8 +20,6 @@ #include using namespace std; -using namespace POEMS; - VirtualColMatrix::VirtualColMatrix(){ numcols = 1; diff --git a/lib/poems/virtualcolmatrix.h b/lib/poems/virtualcolmatrix.h index 040fce051e..1548794ca0 100644 --- a/lib/poems/virtualcolmatrix.h +++ b/lib/poems/virtualcolmatrix.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: virtualcolmatrix.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,25 +21,25 @@ #include "virtualmatrix.h" -namespace POEMS { + class VirtualColMatrix : public VirtualMatrix { -public: - VirtualColMatrix(); - ~VirtualColMatrix(); - double& operator_2int (int i, int j); // array access - double Get_2int (int i, int j) const; - void Set_2int (int i, int j, double value); - double BasicGet_2int(int i, int j) const; - void BasicSet_2int(int i, int j, double value); - void BasicIncrement_2int(int i, int j, double value); - - virtual double& operator_1int (int i) = 0; // array access - virtual double Get_1int(int i) const = 0; - virtual void Set_1int(int i, double value) = 0; - virtual double BasicGet_1int(int i) const = 0; - virtual void BasicSet_1int(int i, double value) = 0; - virtual void BasicIncrement_1int(int i, double value) = 0; +public: + VirtualColMatrix(); + ~VirtualColMatrix(); + double& operator_2int (int i, int j); // array access + double Get_2int (int i, int j) const; + void Set_2int (int i, int j, double value); + double BasicGet_2int(int i, int j) const; + void BasicSet_2int(int i, int j, double value); + void BasicIncrement_2int(int i, int j, double value); + + virtual double& operator_1int (int i) = 0; // array access + virtual double Get_1int(int i) const = 0; + virtual void Set_1int(int i, double value) = 0; + virtual double BasicGet_1int(int i) const = 0; + virtual void BasicSet_1int(int i, double value) = 0; + virtual void BasicIncrement_1int(int i, double value) = 0; }; -} + #endif diff --git a/lib/poems/virtualmatrix.cpp b/lib/poems/virtualmatrix.cpp index bfffeb3d74..19d5946961 100644 --- a/lib/poems/virtualmatrix.cpp +++ b/lib/poems/virtualmatrix.cpp @@ -21,8 +21,6 @@ #include using namespace std; -using namespace POEMS; - VirtualMatrix::VirtualMatrix(){ numrows = numcols = 0; @@ -142,14 +140,14 @@ istream& VirtualMatrix::ReadData(istream& c){ // operators and functions // -ostream& POEMS::operator<< (ostream& c, const VirtualMatrix& A){ //output +ostream& operator<< (ostream& c, const VirtualMatrix& A){ //output c << A.GetType() << ' '; A.WriteData(c); c << endl; return c; } -istream& POEMS::operator>> (istream& c, VirtualMatrix& A){ //input +istream& operator>> (istream& c, VirtualMatrix& A){ //input VirtualMatrix* vm; int matrixtype; c >> matrixtype; diff --git a/lib/poems/virtualmatrix.h b/lib/poems/virtualmatrix.h index 706b943d66..a27c7de047 100644 --- a/lib/poems/virtualmatrix.h +++ b/lib/poems/virtualmatrix.h @@ -20,7 +20,6 @@ #define VIRTUALMATRIX_H #include -namespace POEMS { enum MatrixType { MATRIX = 0, COLMATRIX = 1, @@ -84,5 +83,5 @@ protected: // overloaded operators std::ostream& operator<< (std::ostream& c, const VirtualMatrix& A); // output std::istream& operator>> (std::istream& c, VirtualMatrix& A); // input -} + #endif diff --git a/lib/poems/virtualrowmatrix.cpp b/lib/poems/virtualrowmatrix.cpp index 740c747407..1a12cfbfd9 100644 --- a/lib/poems/virtualrowmatrix.cpp +++ b/lib/poems/virtualrowmatrix.cpp @@ -21,8 +21,6 @@ #include using namespace std; -using namespace POEMS; - VirtualRowMatrix::VirtualRowMatrix(){ numrows = 1; diff --git a/lib/poems/virtualrowmatrix.h b/lib/poems/virtualrowmatrix.h index 0a3c877f64..68b39f137d 100644 --- a/lib/poems/virtualrowmatrix.h +++ b/lib/poems/virtualrowmatrix.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: virtualrowmatrix.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -21,9 +21,8 @@ #include "virtualmatrix.h" -namespace POEMS { class VirtualRowMatrix : public VirtualMatrix { -public: +public: VirtualRowMatrix(); ~VirtualRowMatrix(); double& operator_2int (int i, int j); // array access @@ -32,7 +31,7 @@ public: double BasicGet_2int(int i, int j) const; void BasicSet_2int(int i, int j, double value); void BasicIncrement_2int(int i, int j, double value); - + virtual double& operator_1int (int i) = 0; // array access virtual double Get_1int(int i) const = 0; virtual void Set_1int(int i, double value) = 0; @@ -40,5 +39,5 @@ public: virtual void BasicSet_1int(int i, double value) = 0; virtual void BasicIncrement_1int(int i, double value) = 0; }; -} + #endif diff --git a/lib/poems/workspace.cpp b/lib/poems/workspace.cpp index 03f18a7895..2b3257b0dd 100644 --- a/lib/poems/workspace.cpp +++ b/lib/poems/workspace.cpp @@ -15,31 +15,18 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ -#include -#include // IWYU pragma: keep -#include #include "workspace.h" #include "system.h" #include "solver.h" #include "SystemProcessor.h" -#include "POEMSChain.h" -#include "body.h" -#include "colmatmap.h" -#include "colmatrix.h" -#include "defines.h" -#include "joint.h" -#include "mat3x3.h" -#include "matrix.h" -#include "matrixfun.h" -#include "poemslist.h" -#include "vect3.h" -#include "virtualmatrix.h" +#include +#include +#include +#include using namespace std; -using namespace POEMS; - void Workspace::allocateNewSystem() { currentIndex++; diff --git a/lib/poems/workspace.h b/lib/poems/workspace.h index 2510b2fc3a..5faaf904dc 100644 --- a/lib/poems/workspace.h +++ b/lib/poems/workspace.h @@ -3,7 +3,7 @@ * POEMS: PARALLELIZABLE OPEN SOURCE EFFICIENT MULTIBODY SOFTWARE * * DESCRIPTION: SEE READ-ME * * FILE NAME: workspace.h * - * AUTHORS: See Author List * + * AUTHORS: See Author List * * GRANTS: See Grants List * * COPYRIGHT: (C) 2005 by Authors as listed in Author's List * * LICENSE: Please see License Agreement * @@ -11,7 +11,7 @@ * ADMINISTRATOR: Prof. Kurt Anderson * * Computational Dynamics Lab * * Rensselaer Polytechnic Institute * - * 110 8th St. Troy NY 12180 * + * 110 8th St. Troy NY 12180 * * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ @@ -19,62 +19,70 @@ #ifndef WORKSPACE_H #define WORKSPACE_H -namespace POEMS { +#include "matrices.h" +#include +#include +#include +#include +#include +#include + + class System; class Solver; struct SysData{ - System * system; - int solver; - int integrator; + System * system; + int solver; + int integrator; }; class Workspace { - SysData * system; // the multibody systems data - int currentIndex; - int maxAlloc; - + SysData * system; // the multibody systems data + int currentIndex; + int maxAlloc; + public: Workspace(); ~Workspace(); - + double Thalf; double Tfull; double ConFac; double KE_val; - int FirstTime; - + int FirstTime; + bool LoadFile(char* filename); - + bool SaveFile(char* filename, int index = -1); System* GetSystem(int index = -1); - - void AddSolver(Solver* s, int index = -1); - - - void LobattoOne(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); - - void LobattoTwo(double **&vcm,double **&omega,double **&torque, double **&fcm); - - + + void AddSolver(Solver* s, int index = -1); + + + void LobattoOne(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); + + void LobattoTwo(double **&vcm,double **&omega,double **&torque, double **&fcm); + + bool MakeSystem(int& nbody, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space, int &njoint, int **&jointbody, double **&xjoint, int& nfree, int*freelist, double dthalf, double dtv, double tempcon, double KE); - - - bool SaveSystem(int& nbody, double *&masstotal, double **&inertia, double **&xcm, double **&xjoint, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space, double **&acm, double **&alpha, double **&torque, double **&fcm, int **&jointbody, int &njoint); - - bool MakeDegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space); + + + bool SaveSystem(int& nbody, double *&masstotal, double **&inertia, double **&xcm, double **&xjoint, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space, double **&acm, double **&alpha, double **&torque, double **&fcm, int **&jointbody, int &njoint); + + bool MakeDegenerateSystem(int& nfree, int*freelist, double *&masstotal, double **&inertia, double **&xcm, double **&vcm, double **&omega, double **&ex_space, double **&ey_space, double **&ez_space); int getNumberOfSystems(); - + void SetLammpsValues(double dtv, double dthalf, double tempcon); void SetKE(int temp, double SysKE); - - void RKStep(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); - - void WriteFile(char* filename); + + void RKStep(double **&xcm, double **&vcm,double **&omega,double **&torque, double **&fcm, double **&ex_space, double **&ey_space, double **&ez_space); + + void WriteFile(char* filename); private: - void allocateNewSystem(); //helper function to handle vector resizing and such for the array of system pointers + void allocateNewSystem(); //helper function to handle vector resizing and such for the array of system pointers }; -} + #endif diff --git a/src/POEMS/fix_poems.cpp b/src/POEMS/fix_poems.cpp index 21c12f700b..c8646f5b14 100644 --- a/src/POEMS/fix_poems.cpp +++ b/src/POEMS/fix_poems.cpp @@ -263,7 +263,7 @@ FixPOEMS::FixPOEMS(LAMMPS *lmp, int narg, char **arg) : // create POEMS instance - poems = new POEMS::Workspace; + poems = new Workspace; // compute per body forces and torques inside final_integrate() by default diff --git a/src/POEMS/fix_poems.h b/src/POEMS/fix_poems.h index 87f9557ac0..7b2c77a1bd 100644 --- a/src/POEMS/fix_poems.h +++ b/src/POEMS/fix_poems.h @@ -22,7 +22,6 @@ FixStyle(poems,FixPOEMS) #include "fix.h" -namespace POEMS { class Workspace; } namespace LAMMPS_NS { class FixPOEMS : public Fix { @@ -95,7 +94,7 @@ class FixPOEMS : public Fix { // POEMS object - POEMS::Workspace *poems; + class Workspace *poems; // internal class functions -- GitLab From b6b802d0b11d75f1dd5cd58f76f3392fcb8a04c2 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 22 Jul 2019 14:36:09 -0400 Subject: [PATCH 288/469] correct forward declaration of POEMS workspace class --- src/POEMS/fix_poems.h | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/src/POEMS/fix_poems.h b/src/POEMS/fix_poems.h index 7b2c77a1bd..6892c51d7e 100644 --- a/src/POEMS/fix_poems.h +++ b/src/POEMS/fix_poems.h @@ -22,6 +22,8 @@ FixStyle(poems,FixPOEMS) #include "fix.h" +class Workspace; + namespace LAMMPS_NS { class FixPOEMS : public Fix { @@ -94,7 +96,7 @@ class FixPOEMS : public Fix { // POEMS object - class Workspace *poems; + Workspace *poems; // internal class functions -- GitLab From dd4368dd1b471134629486e590a6624a66265c8f Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Tue, 23 Jul 2019 13:40:13 -0500 Subject: [PATCH 289/469] Fix bug in pair_kim.cpp for partialParticleVirial computation --- src/KIM/pair_kim.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index 6251ebb6c7..50eef1de2b 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -826,7 +826,7 @@ void PairKIM::set_argument_pointers() } else if (KIM_SupportStatus_NotEqual(kim_model_support_for_particleVirial, KIM_SUPPORT_STATUS_notSupported)) { kimerror = kimerror || KIM_ComputeArguments_SetArgumentPointerDouble( - pargs, KIM_COMPUTE_ARGUMENT_NAME_partialParticleEnergy, &(vatom[0][0])); + pargs, KIM_COMPUTE_ARGUMENT_NAME_partialParticleVirial, &(vatom[0][0])); } if (kimerror) error->all(FLERR,"Unable to set KIM argument pointers"); -- GitLab From be86db9dd9cde416f0136b282c830e9bf231c59a Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Tue, 23 Jul 2019 21:06:02 -0500 Subject: [PATCH 290/469] Update /lib/kim stuff --- lib/kim/Install.py | 11 ++++------- lib/kim/README | 22 ++++++++++------------ 2 files changed, 14 insertions(+), 19 deletions(-) diff --git a/lib/kim/Install.py b/lib/kim/Install.py index c3588241c4..de22950639 100644 --- a/lib/kim/Install.py +++ b/lib/kim/Install.py @@ -18,7 +18,7 @@ parser = ArgumentParser(prog='Install.py', # settings thisdir = fullpath('.') -version = "kim-api-2.0.2" +version = "kim-api-2.1.1" # help message @@ -39,11 +39,8 @@ make lib-kim args="-b -a EAM_ErcolessiAdams_1994_Al__MO_324507536345_002" # Ditt make lib-kim args="-b -a everything" # install KIM API lib with all models make lib-kim args="-n -a EAM_Dynamo_Ackland_2003_W__MO_141627196590_005" # only add one model or model driver -See the list of KIM model drivers here: -https://openkim.org/browse/model-drivers/alphabetical - See the list of all KIM models here: -https://openkim.org/browse/models/by-model-drivers +https://openkim.org/browse/models """ pgroup = parser.add_mutually_exclusive_group() @@ -132,7 +129,7 @@ if buildflag: # build kim-api print("Building kim-api ...") - cmd = 'cd "%s/%s/build" && make' % (thisdir, version) + cmd = 'cd "%s/%s/build" && make -j2' % (thisdir, version) txt = subprocess.check_output(cmd, stderr=subprocess.STDOUT, shell=True) if verboseflag: print(txt.decode("UTF-8")) @@ -140,7 +137,7 @@ if buildflag: # install kim-api print("Installing kim-api ...") - cmd = 'cd "%s/%s/build" && make install' % (thisdir, version) + cmd = 'cd "%s/%s/build" && make -j2 install' % (thisdir, version) txt = subprocess.check_output(cmd, stderr=subprocess.STDOUT, shell=True) if verboseflag: print(txt.decode("UTF-8")) diff --git a/lib/kim/README b/lib/kim/README index d3327537b6..3cba4a4597 100644 --- a/lib/kim/README +++ b/lib/kim/README @@ -1,11 +1,11 @@ -This directory contains build settings for the KIM API library which -is required to use the KIM package and its pair_style kim command in a -LAMMPS input script. +This directory contains build settings for the KIM API library which is +required to use the KIM package and its kim_init, kim_interactions, kim_query, +and pair_kim commands in a LAMMPS input script. Information about the KIM project can be found at https://openkim.org. The KIM project is lead by Ellad Tadmor and Ryan Elliott (U Minn). Ryan Elliott is the main developer for the KIM API and he also -maintains the code that implements the pair_style kim command. +maintains the code that implements the KIM commands. You can type "make lib-kim" from the src directory to see help on how to download and build this library via make commands, or you can @@ -13,11 +13,9 @@ do the same thing by typing "python Install.py" from within this directory, or you can do it manually by following the instructions below. -As of KIM API version 2, the KIM package also provides a LAMMPS command -to perform queries through the OpenKIM web API. This feature requires -that the CURL library (libcurl) development package and its configuration -query tool, curl-config, are installed. The provided Makefile.lammps -is set up to automatically detect this. +Use of the kim_query command requires that the CURL library (libcurl) +development package and its configuration query tool, curl-config, are +installed. The provided Makefile.lammps is set up to automatically detect this. ----------------- @@ -40,8 +38,8 @@ $ cmake .. -DCMAKE_INSTALL_PREFIX=${PWD}/../../installed-kim-api-X.Y.Z 3. Build and install the kim-api and model -$ make -$ make install +$ make -j2 +$ make -j2 install 4. Remove source and build files @@ -53,7 +51,7 @@ $ rm -rf kim-api-X.Y.Z.txz desired value) $ source ${PWD}/kim-api-X.Y.Z/bin/kim-api-activate -$ kim-api-collections-management install system Pair_Johnson_Fe__MO_857282754307_002 +$ kim-api-collections-management install system EAM_ErcolessiAdams_1994_Al__MO_324507536345_002 ----------------- -- GitLab From 3bc4a07c74aac582a9e74ce429abb4564e224cfd Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Wed, 24 Jul 2019 11:23:51 -0500 Subject: [PATCH 291/469] Corrections to kim_query in example --- doc/src/kim_commands.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 01df0532b7..6fe7d7ba3e 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -433,7 +433,7 @@ the returned values is determined by the type of query performed. kim_init EAM_Dynamo_ErcolessiAdams_1994_Al__MO_123629422045_005 metal boundary p p p kim_query a0 get_lattice_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\["angstrom"\] -kim_query alpha get_linear_thermal_expansion_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\{"1/K"\} temperature=[293.15] temperature_units=["K"] +kim_query alpha get_linear_thermal_expansion_coefficient_cubic crystal=\["fcc"\] species=\["Al"\] units=\["1/K"\] temperature=\[293.15\] temperature_units=\["K"\] variable DeltaT equal 300 lattice fcc $\{a0\}*$\{alpha\}*$\{DeltaT\} ... :pre -- GitLab From 3887a7f3d79559eb47d82e989a71ed1abf6a0320 Mon Sep 17 00:00:00 2001 From: Ellad Tadmor Date: Wed, 24 Jul 2019 12:07:38 -0500 Subject: [PATCH 292/469] Updated KIM ID code for IFF SM --- doc/src/kim_commands.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 6fe7d7ba3e..dd61f6f5cc 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -33,7 +33,7 @@ kim_interactions Si kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 metal unit_conversion_mode kim_interactions C H O -Sim_LAMMPS_IFF_PCFF_HeinzMishraLinEmami_2015Ver1v5_FccmetalsMineralsSolvents Polymers__SM_064312669787_000 real +Sim_LAMMPS_IFF_PCFF_HeinzMishraLinEmami_2015Ver1v5_FccmetalsMineralsSolvents Polymers__SM_039297821658_000 real kim_interactions fixed_types kim_query a0 get_lattice_constant_cubic crystal=\["fcc"\] species=\["Al"\] units=\["angstrom"\] :pre -- GitLab From 440025778388c97af44d0d023673f39deb8b2672 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Wed, 24 Jul 2019 12:10:57 -0600 Subject: [PATCH 293/469] Change GPU-direct to CUDA-aware MPI and add workaround for IBM Spectrum MPI --- src/KOKKOS/comm_kokkos.cpp | 4 +-- src/KOKKOS/gridcomm_kokkos.cpp | 8 ++--- src/KOKKOS/kokkos.cpp | 58 ++++++++++++++++++---------------- src/KOKKOS/kokkos.h | 2 +- 4 files changed, 37 insertions(+), 35 deletions(-) diff --git a/src/KOKKOS/comm_kokkos.cpp b/src/KOKKOS/comm_kokkos.cpp index 87986a9ca9..d0bd978ae7 100644 --- a/src/KOKKOS/comm_kokkos.cpp +++ b/src/KOKKOS/comm_kokkos.cpp @@ -418,7 +418,7 @@ void CommKokkos::forward_comm_pair_device(Pair *pair) if (sendproc[iswap] != me) { double* buf_send_pair; double* buf_recv_pair; - if (lmp->kokkos->gpu_direct_flag) { + if (lmp->kokkos->cuda_aware_flag) { buf_send_pair = k_buf_send_pair.view().data(); buf_recv_pair = k_buf_recv_pair.view().data(); } else { @@ -436,7 +436,7 @@ void CommKokkos::forward_comm_pair_device(Pair *pair) MPI_Send(buf_send_pair,n,MPI_DOUBLE,sendproc[iswap],0,world); if (recvnum[iswap]) MPI_Wait(&request,MPI_STATUS_IGNORE); - if (!lmp->kokkos->gpu_direct_flag) { + if (!lmp->kokkos->cuda_aware_flag) { k_buf_recv_pair.modify(); k_buf_recv_pair.sync(); } diff --git a/src/KOKKOS/gridcomm_kokkos.cpp b/src/KOKKOS/gridcomm_kokkos.cpp index 14b84a5733..348217634b 100644 --- a/src/KOKKOS/gridcomm_kokkos.cpp +++ b/src/KOKKOS/gridcomm_kokkos.cpp @@ -529,7 +529,7 @@ void GridCommKokkos::forward_comm(KSpace *kspace, int which) if (swap[m].sendproc != me) { FFT_SCALAR* buf1; FFT_SCALAR* buf2; - if (lmp->kokkos->gpu_direct_flag) { + if (lmp->kokkos->cuda_aware_flag) { buf1 = k_buf1.view().data(); buf2 = k_buf2.view().data(); } else { @@ -545,7 +545,7 @@ void GridCommKokkos::forward_comm(KSpace *kspace, int which) swap[m].sendproc,0,gridcomm); MPI_Wait(&request,MPI_STATUS_IGNORE); - if (!lmp->kokkos->gpu_direct_flag) { + if (!lmp->kokkos->cuda_aware_flag) { k_buf2.modify(); k_buf2.sync(); } @@ -579,7 +579,7 @@ void GridCommKokkos::reverse_comm(KSpace *kspace, int which) if (swap[m].recvproc != me) { FFT_SCALAR* buf1; FFT_SCALAR* buf2; - if (lmp->kokkos->gpu_direct_flag) { + if (lmp->kokkos->cuda_aware_flag) { buf1 = k_buf1.view().data(); buf2 = k_buf2.view().data(); } else { @@ -595,7 +595,7 @@ void GridCommKokkos::reverse_comm(KSpace *kspace, int which) swap[m].recvproc,0,gridcomm); MPI_Wait(&request,MPI_STATUS_IGNORE); - if (!lmp->kokkos->gpu_direct_flag) { + if (!lmp->kokkos->cuda_aware_flag) { k_buf2.modify(); k_buf2.sync(); } diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 3fa84d98b2..7d2ef8e4d7 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -28,31 +28,33 @@ #ifdef KOKKOS_ENABLE_CUDA -// for detecting GPU-direct support: -// the function int have_gpu_direct() -// - returns -1 if GPU-direct support is unknown -// - returns 0 if no GPU-direct support available -// - returns 1 if GPU-direct support is available +// for detecting CUDA-aware MPI support: +// the variable int have_cuda_aware +// - is -1 if CUDA-aware MPI support is unknown +// - is 0 if no CUDA-aware MPI support available +// - is 1 if CUDA-aware MPI support is available -#define GPU_DIRECT_UNKNOWN static int have_gpu_direct() {return -1;} +#define CUDA_AWARE_UNKNOWN static int have_cuda_aware = -1; -// OpenMPI supports detecting GPU-direct as of version 2.0.0 +// OpenMPI supports detecting CUDA-aware MPI as of version 2.0.0 #if OPEN_MPI #if (OMPI_MAJOR_VERSION >= 2) #include -#if defined(MPIX_CUDA_AWARE_SUPPORT) -static int have_gpu_direct() { return MPIX_Query_cuda_support(); } +#if defined(MPIX_CUDA_AWARE_SUPPORT) && MPIX_CUDA_AWARE_SUPPORT +static int have_cuda_aware = 1; +#elif defined(MPIX_CUDA_AWARE_SUPPORT) && !MPIX_CUDA_AWARE_SUPPORT +static int have_cuda_aware = 0; #else -GPU_DIRECT_UNKNOWN +CUDA_AWARE_UNKNOWN #endif #else // old OpenMPI -GPU_DIRECT_UNKNOWN +CUDA_AWARE_UNKNOWN #endif #else // unknown MPI library -GPU_DIRECT_UNKNOWN +CUDA_AWARE_UNKNOWN #endif #endif // KOKKOS_ENABLE_CUDA @@ -146,20 +148,20 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) if (ngpus <= 0) error->all(FLERR,"Kokkos has been compiled for CUDA but no GPUs are requested"); - // check and warn about GPU-direct availability when using multiple MPI tasks + // check and warn about CUDA-aware MPI availability when using multiple MPI tasks int nmpi = 0; MPI_Comm_size(world,&nmpi); if ((nmpi > 1) && (me == 0)) { - if ( 1 == have_gpu_direct() ) { + if ( 1 == have_cuda_aware ) { ; // all good, nothing to warn about - } else if (-1 == have_gpu_direct() ) { - error->warning(FLERR,"Kokkos with CUDA assumes GPU-direct is available," + } else if ( -1 == have_cuda_aware ) { + error->warning(FLERR,"Kokkos with CUDA assumes CUDA-aware MPI is available," " but cannot determine if this is the case\n try" - " '-pk kokkos gpu/direct off' when getting segmentation faults"); - } else if ( 0 == have_gpu_direct() ) { - error->warning(FLERR,"GPU-direct is NOT available, " - "using '-pk kokkos gpu/direct off' by default"); + " '-pk kokkos cuda/aware off' when getting segmentation faults"); + } else if ( 0 == have_cuda_aware ) { + error->warning(FLERR,"CUDA-aware MPI is NOT available, " + "using '-pk kokkos cuda/aware off' by default"); } else { ; // should never get here } @@ -183,7 +185,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) // default settings for package kokkos command binsize = 0.0; - gpu_direct_flag = 1; + cuda_aware_flag = 1; neigh_thread = 0; neigh_thread_set = 0; neighflag_qeq_set = 0; @@ -207,8 +209,8 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) } #if KOKKOS_USE_CUDA - // only if we can safely detect, that GPU-direct is not available, change default - if (0 == have_gpu_direct()) gpu_direct_flag = 0; + // change default only if we can safely detect that CUDA-aware MPI is not available + if (0 == have_cuda_aware()) cuda_aware_flag = 0; #endif #ifdef KILL_KOKKOS_ON_SIGSEGV @@ -313,10 +315,10 @@ void KokkosLMP::accelerator(int narg, char **arg) reverse_comm_on_host = 0; } else error->all(FLERR,"Illegal package kokkos command"); iarg += 2; - } else if (strcmp(arg[iarg],"gpu/direct") == 0) { + } else if (strcmp(arg[iarg],"cuda/aware") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal package kokkos command"); - if (strcmp(arg[iarg+1],"off") == 0) gpu_direct_flag = 0; - else if (strcmp(arg[iarg+1],"on") == 0) gpu_direct_flag = 1; + if (strcmp(arg[iarg+1],"off") == 0) cuda_aware_flag = 0; + else if (strcmp(arg[iarg+1],"on") == 0) cuda_aware_flag = 1; else error->all(FLERR,"Illegal package kokkos command"); iarg += 2; } else if (strcmp(arg[iarg],"neigh/thread") == 0) { @@ -329,9 +331,9 @@ void KokkosLMP::accelerator(int narg, char **arg) } else error->all(FLERR,"Illegal package kokkos command"); } - // if "gpu/direct off" and "comm device", change to "comm host" + // if "cuda/aware off" and "comm device", change to "comm host" - if (!gpu_direct_flag) { + if (!cuda_aware_flag) { if (exchange_comm_classic == 0 && exchange_comm_on_host == 0) exchange_comm_on_host = 1; if (forward_comm_classic == 0 && forward_comm_on_host == 0) diff --git a/src/KOKKOS/kokkos.h b/src/KOKKOS/kokkos.h index 46044799c4..19e6297ea4 100644 --- a/src/KOKKOS/kokkos.h +++ b/src/KOKKOS/kokkos.h @@ -35,7 +35,7 @@ class KokkosLMP : protected Pointers { int nthreads,ngpus; int numa; int auto_sync; - int gpu_direct_flag; + int cuda_aware_flag; int neigh_thread; int neigh_thread_set; int newtonflag; -- GitLab From 4760cf868d7f5e0fe51f88ca83a14744a6c7c4ea Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Wed, 24 Jul 2019 12:11:26 -0600 Subject: [PATCH 294/469] Update docs to change GPU-direct to CUDA-aware MPI --- doc/src/Speed_kokkos.txt | 24 +++++++++++------------- doc/src/package.txt | 28 +++++++++++++++------------- 2 files changed, 26 insertions(+), 26 deletions(-) diff --git a/doc/src/Speed_kokkos.txt b/doc/src/Speed_kokkos.txt index fd33491253..99d29864dc 100644 --- a/doc/src/Speed_kokkos.txt +++ b/doc/src/Speed_kokkos.txt @@ -46,16 +46,15 @@ software version 7.5 or later must be installed on your system. See the discussion for the "GPU package"_Speed_gpu.html for details of how to check and do this. -NOTE: Kokkos with CUDA currently implicitly assumes that the MPI -library is CUDA-aware and has support for GPU-direct. This is not -always the case, especially when using pre-compiled MPI libraries -provided by a Linux distribution. This is not a problem when using -only a single GPU and a single MPI rank on a desktop. When running -with multiple MPI ranks, you may see segmentation faults without -GPU-direct support. These can be avoided by adding the flags "-pk -kokkos gpu/direct off"_Run_options.html to the LAMMPS command line or -by using the command "package kokkos gpu/direct off"_package.html in -the input file. +NOTE: Kokkos with CUDA currently implicitly assumes that the MPI library +is CUDA-aware. This is not always the case, especially when using +pre-compiled MPI libraries provided by a Linux distribution. This is not +a problem when using only a single GPU with a single MPI rank. When +running with multiple MPI ranks, you may see segmentation faults without +CUDA-aware MPI support. These can be avoided by adding the flags "-pk +kokkos cuda/aware off"_Run_options.html to the LAMMPS command line or by +using the command "package kokkos cuda/aware off"_package.html in the +input file. [Building LAMMPS with the KOKKOS package:] @@ -217,9 +216,8 @@ case, also packing/unpacking communication buffers on the host may give speedup (see the KOKKOS "package"_package.html command). Using CUDA MPS is recommended in this scenario. -Using a CUDA-aware MPI library with -support for GPU-direct is highly recommended. GPU-direct use can be -avoided by using "-pk kokkos gpu/direct no"_package.html. As above for +Using a CUDA-aware MPI library is highly recommended. CUDA-aware MPI use can be +avoided by using "-pk kokkos cuda/aware no"_package.html. As above for multi-core CPUs (and no GPU), if N is the number of physical cores/node, then the number of MPI tasks/node should not exceed N. diff --git a/doc/src/package.txt b/doc/src/package.txt index 6a6d17bcbc..edd409a842 100644 --- a/doc/src/package.txt +++ b/doc/src/package.txt @@ -64,7 +64,7 @@ args = arguments specific to the style :l {no_affinity} values = none {kokkos} args = keyword value ... zero or more keyword/value pairs may be appended - keywords = {neigh} or {neigh/qeq} or {neigh/thread} or {newton} or {binsize} or {comm} or {comm/exchange} or {comm/forward} or {comm/reverse} or {gpu/direct} + keywords = {neigh} or {neigh/qeq} or {neigh/thread} or {newton} or {binsize} or {comm} or {comm/exchange} or {comm/forward} or {comm/reverse} or {cuda/aware} {neigh} value = {full} or {half} full = full neighbor list half = half neighbor list built in thread-safe manner @@ -87,9 +87,9 @@ args = arguments specific to the style :l no = perform communication pack/unpack in non-KOKKOS mode host = perform pack/unpack on host (e.g. with OpenMP threading) device = perform pack/unpack on device (e.g. on GPU) - {gpu/direct} = {off} or {on} - off = do not use GPU-direct - on = use GPU-direct (default) + {cuda/aware} = {off} or {on} + off = do not use CUDA-aware MPI + on = use CUDA-aware MPI (default) {omp} args = Nthreads keyword value ... Nthread = # of OpenMP threads to associate with each MPI process zero or more keyword/value pairs may be appended @@ -520,19 +520,21 @@ pack/unpack communicated data. When running small systems on a GPU, performing the exchange pack/unpack on the host CPU can give speedup since it reduces the number of CUDA kernel launches. -The {gpu/direct} keyword chooses whether GPU-direct will be used. When +The {cuda/aware} keyword chooses whether CUDA-aware MPI will be used. When this keyword is set to {on}, buffers in GPU memory are passed directly through MPI send/receive calls. This reduces overhead of first copying -the data to the host CPU. However GPU-direct is not supported on all +the data to the host CPU. However CUDA-aware MPI is not supported on all systems, which can lead to segmentation faults and would require using a -value of {off}. If LAMMPS can safely detect that GPU-direct is not +value of {off}. If LAMMPS can safely detect that CUDA-aware MPI is not available (currently only possible with OpenMPI v2.0.0 or later), then -the {gpu/direct} keyword is automatically set to {off} by default. When -the {gpu/direct} keyword is set to {off} while any of the {comm} +the {cuda/aware} keyword is automatically set to {off} by default. When +the {cuda/aware} keyword is set to {off} while any of the {comm} keywords are set to {device}, the value for these {comm} keywords will be automatically changed to {host}. This setting has no effect if not -running on GPUs. GPU-direct is available for OpenMPI 1.8 (or later -versions), Mvapich2 1.9 (or later), and CrayMPI. +running on GPUs. CUDA-aware MPI is available for OpenMPI 1.8 (or later +versions), Mvapich2 1.9 (or later) when the "MV2_USE_CUDA" environment +variable is set to "1", CrayMPI, and IBM Spectrum MPI when the "-gpu" +flag is used. :line @@ -641,8 +643,8 @@ switch"_Run_options.html. For the KOKKOS package, the option defaults for GPUs are neigh = full, neigh/qeq = full, newton = off, binsize for GPUs = 2x LAMMPS default -value, comm = device, gpu/direct = on. When LAMMPS can safely detect -that GPU-direct is not available, the default value of gpu/direct +value, comm = device, cuda/aware = on. When LAMMPS can safely detect +that CUDA-aware MPI is not available, the default value of cuda/aware becomes "off". For CPUs or Xeon Phis, the option defaults are neigh = half, neigh/qeq = half, newton = on, binsize = 0.0, and comm = no. The option neigh/thread = on when there are 16K atoms or less on an MPI -- GitLab From 985c959a91d5701da3f8292534c024721007b21b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 14:27:29 -0400 Subject: [PATCH 295/469] include the bond length in communication cutoff considerations --- src/neighbor.cpp | 25 ++++++++++++++++++++++++- 1 file changed, 24 insertions(+), 1 deletion(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 0382624198..1cae719df1 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -35,6 +35,7 @@ #include "comm.h" #include "force.h" #include "pair.h" +#include "bond.h" #include "domain.h" #include "group.h" #include "modify.h" @@ -276,6 +277,28 @@ void Neighbor::init() // cutneigh = force cutoff + skin if cutforce > 0, else cutneigh = 0 // cutneighghost = pair cutghost if it requests it, else same as cutneigh + // also consider bonded interactions for estimating the the neighborlist + // and communication cutoff. we use the bond equilibrium distance as + // cutoff, if only a bond style exists. if also an angle style exists we + // multiply by 2, for dihedral or improper we multiply by 3. + // this plus "skin" will become the default communication cutoff, if no + // pair style is defined. otherwise the maximum of the largest pairwise + // cutoff of this is used. + + double maxbondcutoff = 0.0; + if (force->bond) { + n = atom->nbondtypes; + for (i = 1; i <= n; ++i) { + double bondcutoff = force->bond->equilibrium_distance(i); + maxbondcutoff = MAX(bondcutoff,maxbondcutoff); + } + if (force->dihedral || force->improper) { + maxbondcutoff *= 3.0; + } else if (force->angle) { + maxbondcutoff *=2.0; + } + } + triggersq = 0.25*skin*skin; boxcheck = 0; if (domain->box_change && (domain->xperiodic || domain->yperiodic || @@ -293,7 +316,7 @@ void Neighbor::init() double cutoff,delta,cut; cutneighmin = BIG; - cutneighmax = 0.0; + cutneighmax = maxbondcutoff; for (i = 1; i <= n; i++) { cuttype[i] = cuttypesq[i] = 0.0; -- GitLab From be1522d16d8ce58711537a7fdb33884f887c3f96 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 14:42:17 -0400 Subject: [PATCH 296/469] add warning to Comm class against zero communication cutoff --- src/comm_brick.cpp | 3 +++ src/comm_tiled.cpp | 4 ++++ 2 files changed, 7 insertions(+) diff --git a/src/comm_brick.cpp b/src/comm_brick.cpp index 330551aaed..eb53f89746 100644 --- a/src/comm_brick.cpp +++ b/src/comm_brick.cpp @@ -176,6 +176,9 @@ void CommBrick::setup() double *prd,*sublo,*subhi; double cut = MAX(neighbor->cutneighmax,cutghostuser); + if ((cut == 0.0) && (me == 0)) + error->warning(FLERR,"Communication cutoff is 0.0. No ghost atoms " + "will be generated. Atoms may get lost."); if (triclinic == 0) { prd = domain->prd; diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index d1d625445a..9d4c446057 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -158,6 +158,10 @@ void CommTiled::setup() // check that cutoff < any periodic box length double cut = MAX(neighbor->cutneighmax,cutghostuser); + if ((cut == 0.0) && (me == 0)) + error->warning(FLERR,"Communication cutoff is 0.0. No ghost atoms " + "will be generated. Atoms may get lost."); + cutghost[0] = cutghost[1] = cutghost[2] = cut; if ((periodicity[0] && cut > prd[0]) || -- GitLab From 20843f7476e28a37e7933b2ebc920f0a41eb2983 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 14:52:07 -0400 Subject: [PATCH 297/469] add documentation for warning added to comm styles --- doc/src/Errors_warnings.txt | 10 ++++++++++ src/comm.h | 9 +++++++++ 2 files changed, 19 insertions(+) diff --git a/doc/src/Errors_warnings.txt b/doc/src/Errors_warnings.txt index 1507d6b22c..9f346ba8c1 100644 --- a/doc/src/Errors_warnings.txt +++ b/doc/src/Errors_warnings.txt @@ -129,6 +129,16 @@ Self-explanatory. :dd Self-explanatory. :dd +{Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost} :dt + +The communication cutoff defaults to the maximum of what is inferred from +pair and bond styles (will be zero, if none are defined) and what is specified +via "comm_modify cutoff"_comm_modify.html (defaults to 0.0). If this results +to 0.0, no ghost atoms will be generated and LAMMPS may lose atoms or use +incorrect periodic images of atoms in interaction lists. To avoid, either use +"pair style zero"_pair_zero.html with a suitable cutoff or use "comm_modify +cutoff"_comm_modify.html. :dd + {Communication cutoff is too small for SNAP micro load balancing, increased to %lf} :dt Self-explanatory. :dd diff --git a/src/comm.h b/src/comm.h index 30360b1059..90a215b4a6 100644 --- a/src/comm.h +++ b/src/comm.h @@ -237,6 +237,15 @@ Self-explanatory. E: Cannot put data on ring from NULL pointer +W: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. + +The communication cutoff defaults to the maximum of what is inferred from pair and +bond styles (will be zero, if none are defined) and what is specified via +"comm_modify cutoff" (defaults to 0.0). If this results to 0.0, no ghost atoms will +be generated and LAMMPS may lose atoms or use incorrect periodic images of atoms in +interaction lists. To avoid, either define pair style zero with a suitable cutoff +or use comm_modify cutoff. + UNDOCUMENTED U: OMP_NUM_THREADS environment is not set. -- GitLab From 1d310ad73e80f220cbfc90153758b43af7700032 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 14:52:37 -0400 Subject: [PATCH 298/469] add half a bond length safety margin to bond length based cutoff estimates --- src/neighbor.cpp | 13 ++++++++----- 1 file changed, 8 insertions(+), 5 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 1cae719df1..9964b23b60 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -278,9 +278,10 @@ void Neighbor::init() // cutneighghost = pair cutghost if it requests it, else same as cutneigh // also consider bonded interactions for estimating the the neighborlist - // and communication cutoff. we use the bond equilibrium distance as - // cutoff, if only a bond style exists. if also an angle style exists we - // multiply by 2, for dihedral or improper we multiply by 3. + // and communication cutoff. we use the 1.5x the bond equilibrium distance + // as cutoff, if only a bond style exists. if also an angle style exists we + // multiply by 2.5, for dihedral or improper we multiply by 3.5. (1,2, or 3 + // bonds plus half a bond length total stretch). // this plus "skin" will become the default communication cutoff, if no // pair style is defined. otherwise the maximum of the largest pairwise // cutoff of this is used. @@ -293,9 +294,11 @@ void Neighbor::init() maxbondcutoff = MAX(bondcutoff,maxbondcutoff); } if (force->dihedral || force->improper) { - maxbondcutoff *= 3.0; + maxbondcutoff *= 3.5; } else if (force->angle) { - maxbondcutoff *=2.0; + maxbondcutoff *=2.5; + } else { + maxbondcutoff *=1.5; } } -- GitLab From afab7d99c1ea2488763f6770723b574b9e78a5b0 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Wed, 24 Jul 2019 13:10:37 -0600 Subject: [PATCH 299/469] Fix variable name --- src/KOKKOS/kokkos.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 7d2ef8e4d7..3d1cb419d6 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -208,9 +208,9 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) exchange_comm_on_host = forward_comm_on_host = reverse_comm_on_host = 0; } -#if KOKKOS_USE_CUDA +#ifdef KOKKOS_ENABLE_CUDA // change default only if we can safely detect that CUDA-aware MPI is not available - if (0 == have_cuda_aware()) cuda_aware_flag = 0; + if (0 == have_cuda_aware) cuda_aware_flag = 0; #endif #ifdef KILL_KOKKOS_ON_SIGSEGV -- GitLab From cb9facea8b3643de95b4b41df11f4b998b335828 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 24 Jul 2019 13:43:12 -0600 Subject: [PATCH 300/469] add reset of dotmark --- src/rcb.cpp | 50 ++++++++++++++++++-------------------------------- 1 file changed, 18 insertions(+), 32 deletions(-) diff --git a/src/rcb.cpp b/src/rcb.cpp index ac7ac60b1f..5cb3b697e2 100644 --- a/src/rcb.cpp +++ b/src/rcb.cpp @@ -467,44 +467,30 @@ void RCB::compute(int dimension, int n, double **x, double *wt, } } - //check if zero box width is the result due to dots being on box vertices - //select half of the box in this case along the best dim - //the best dim is chosen according to the optimum volume (to minimize surface area) - - if(largest==0.0){ - double best_volume=0; - double current_volume; - int dim1o,dim2o; - for (dim = 0; dim < dimension; dim++){ - if(dim==0){ - dim1o=1; - dim2o=2; - } - if(dim==1){ - dim1o=0; - dim2o=2; - } - if(dim==2){ - dim1o=0; - dim2o=1; - } - valuehalf = 0.5*(lo[dim] + hi[dim]); - current_volume = (hi[dim1o]-lo[dim1o]) - *(hi[dim2o]-lo[dim2o])*(valuehalf-lo[dim]); - //chose cut that minimizes surface area by maximizing volume; - if(current_volume>best_volume){ best_volume = current_volume; - valuehalf_select = valuehalf; - dim_select = dim; - } - } - } - // copy results for best dim cut into dim,valuehalf,dotmark dim = dim_select; valuehalf = valuehalf_select; if (ndot > 0) memcpy(dotmark,dotmark_select,ndot*sizeof(int)); + // special case for zero box width + // can occur when all dots are on corner vertices of this sub-box + // split box on longest dimension + // reset dotmark for that cut + + if (largest == 0.0) { + dim = 0; + if (hi[1]-lo[1] > hi[0]-lo[0]) dim = 1; + if (dimension == 3 && hi[2]-lo[2] > hi[dim]-lo[dim]) dim = 2; + valuehalf = 0.5* (lo[dim] + hi[dim]); + + for (j = 0; j < nlist; j++) { + i = dotlist[j]; + if (dots[i].x[dim] <= valuehalf) dotmark[i] = 0; + else dotmark[i] = 1; + } + } + // found median // store cut info only if I am procmid -- GitLab From 24d9c537c0d589cfd1b46f9ccf65d765d93ff953 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 16:01:46 -0400 Subject: [PATCH 301/469] only search for LAPACK when building in static mode and when it is not needed for something else --- cmake/CMakeLists.txt | 3 +-- cmake/Modules/Packages/USER-PLUMED.cmake | 6 ++++++ 2 files changed, 7 insertions(+), 2 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 0f99cc6274..2fa3170415 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -219,8 +219,7 @@ if(BUILD_OMP) set (CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} ${OpenMP_CXX_FLAGS}") endif() - -if(PKG_MSCG OR PKG_USER-ATC OR PKG_USER-AWPMD OR PKG_USER-PLUMED OR PKG_USER-QUIP OR PKG_LATTE) +if(PKG_MSCG OR PKG_USER-ATC OR PKG_USER-AWPMD OR PKG_USER-QUIP OR PKG_LATTE) find_package(LAPACK) find_package(BLAS) if(NOT LAPACK_FOUND OR NOT BLAS_FOUND) diff --git a/cmake/Modules/Packages/USER-PLUMED.cmake b/cmake/Modules/Packages/USER-PLUMED.cmake index 500558fc72..f71d59901d 100644 --- a/cmake/Modules/Packages/USER-PLUMED.cmake +++ b/cmake/Modules/Packages/USER-PLUMED.cmake @@ -6,6 +6,12 @@ if(PKG_USER-PLUMED) validate_option(PLUMED_MODE PLUMED_MODE_VALUES) string(TOUPPER ${PLUMED_MODE} PLUMED_MODE) + if((PLUMED_MODE STREQUAL "STATIC") AND NOT LAPACK_LIBRARIES) + find_package(LAPACK REQUIRED) + find_package(BLAS REQUIRED) + list(APPEND LAPACK_LIBRARIES ${BLAS_LIBRARIES}) + endif() + find_package(PkgConfig QUIET) set(DOWNLOAD_PLUMED_DEFAULT ON) if(PKG_CONFIG_FOUND) -- GitLab From 6ee38d4887719368f6b89265b4656ce7a0ab4558 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 16:02:36 -0400 Subject: [PATCH 302/469] use ${CMAKE_SHARED_LIBRARY_SUFFIX) for better portability --- cmake/Modules/Packages/USER-PLUMED.cmake | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/cmake/Modules/Packages/USER-PLUMED.cmake b/cmake/Modules/Packages/USER-PLUMED.cmake index f71d59901d..35533f01ef 100644 --- a/cmake/Modules/Packages/USER-PLUMED.cmake +++ b/cmake/Modules/Packages/USER-PLUMED.cmake @@ -61,9 +61,9 @@ if(PKG_USER-PLUMED) add_definitions(-D__PLUMED_WRAPPER_CXX=1) list(APPEND LAMMPS_LINK_LIBS ${PLUMED_INSTALL_DIR}/lib/libplumed.a ${GSL_LIBRARIES} ${LAPACK_LIBRARIES} ${CMAKE_DL_LIBS}) elseif(PLUMED_MODE STREQUAL "SHARED") - list(APPEND LAMMPS_LINK_LIBS ${PLUMED_INSTALL_DIR}/lib/libplumed.so ${PLUMED_INSTALL_DIR}/lib/libplumedKernel.so ${CMAKE_DL_LIBS}) + list(APPEND LAMMPS_LINK_LIBS ${PLUMED_INSTALL_DIR}/lib/libplumed${CMAKE_SHARED_LIBRARY_SUFFIX} ${PLUMED_INSTALL_DIR}/lib/libplumedKernel${CMAKE_SHARED_LIBRARY_SUFFIX} ${CMAKE_DL_LIBS}) elseif(PLUMED_MODE STREQUAL "RUNTIME") - add_definitions(-D__PLUMED_HAS_DLOPEN=1 -D__PLUMED_DEFAULT_KERNEL=${PLUMED_INSTALL_DIR}/lib/libplumedKernel.so) + add_definitions(-D__PLUMED_HAS_DLOPEN=1 -D__PLUMED_DEFAULT_KERNEL=${PLUMED_INSTALL_DIR}/lib/libplumedKernel${CMAKE_SHARED_LIBRARY_SUFFIX}) list(APPEND LAMMPS_LINK_LIBS ${PLUMED_INSTALL_DIR}/lib/libplumedWrapper.a -rdynamic ${CMAKE_DL_LIBS}) endif() set(PLUMED_INCLUDE_DIRS "${PLUMED_INSTALL_DIR}/include") @@ -76,7 +76,7 @@ if(PKG_USER-PLUMED) elseif(PLUMED_MODE STREQUAL "SHARED") include(${PLUMED_LIBDIR}/plumed/src/lib/Plumed.cmake.shared) elseif(PLUMED_MODE STREQUAL "RUNTIME") - add_definitions(-D__PLUMED_HAS_DLOPEN=1 -D__PLUMED_DEFAULT_KERNEL=${PLUMED_LIBDIR}/libplumedKernel.so) + add_definitions(-D__PLUMED_HAS_DLOPEN=1 -D__PLUMED_DEFAULT_KERNEL=${PLUMED_LIBDIR}/libplumedKernel${CMAKE_SHARED_LIBRARY_SUFFIX}) include(${PLUMED_LIBDIR}/plumed/src/lib/Plumed.cmake.runtime) endif() list(APPEND LAMMPS_LINK_LIBS ${PLUMED_LOAD}) -- GitLab From d59737299cde717e88731c6324206a47b371679d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 16:02:49 -0400 Subject: [PATCH 303/469] whitespace cleanup --- lib/plumed/README | 16 ++++++++-------- 1 file changed, 8 insertions(+), 8 deletions(-) diff --git a/lib/plumed/README b/lib/plumed/README index fb8ef29ff3..0d5f52f6b2 100644 --- a/lib/plumed/README +++ b/lib/plumed/README @@ -1,7 +1,7 @@ This directory contains links to the PLUMED library which is required to use the PLUMED package and its fix plumed command in a -LAMMPS input script. PLUMED should only be downloaded into this directory if -you wish to statically link the library. If you wish to link PLUMED as +LAMMPS input script. PLUMED should only be downloaded into this directory if +you wish to statically link the library. If you wish to link PLUMED as a dynamic library (as we recommend) then you can compile and build PLUMED separately to LAMMPS. To use PLUMED in conjuction with LAMMPS you then simply need to ensure that the PLUMED library is in your path at runtime. @@ -18,15 +18,15 @@ below. Instructions: -1. Download PLUMED either as a tarball from +1. Download PLUMED either as a tarball from http://www.plumed.org/get-it - or clone it using git clone https://github.com/plumed/plumed2.git. + or clone it using git clone https://github.com/plumed/plumed2.git. If you download the tarball unpack it in unpack it in this /lib/plumed directory. Similarly if you clone it clone it to the /lib/plumed directory. -2. Compile PLUMED from within its home directory. In the +2. Compile PLUMED from within its home directory. In the simplest cases this be done by issuing the commands % ./configure % make @@ -34,14 +34,14 @@ Instructions: http://plumed.github.io/doc-master/user-doc/html/_installation.html 3. There is no need to install PLUMED if you only wish - to use it from LAMMPS. You should thus only run + to use it from LAMMPS. You should thus only run make install if you want to use PLUMED as a stand-alone - code or from some other code. To install it you can + code or from some other code. To install it you can run the following commands: a) install under the default /usr/local % sudo make install b) install under a user-writeable location by first - changing the PREFIX variable when running the + changing the PREFIX variable when running the configure command file, then % make install -- GitLab From 3c53efb1ca132c1cf9671ccb0877bf762d6a61f4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 16:03:11 -0400 Subject: [PATCH 304/469] don't set MPI communicator when compiling in serial with MPI stubs --- src/USER-PLUMED/fix_plumed.cpp | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/USER-PLUMED/fix_plumed.cpp b/src/USER-PLUMED/fix_plumed.cpp index 8bd0ecca05..c75a48f9b4 100644 --- a/src/USER-PLUMED/fix_plumed.cpp +++ b/src/USER-PLUMED/fix_plumed.cpp @@ -107,7 +107,11 @@ FixPlumed::FixPlumed(LAMMPS *lmp, int narg, char **arg) : // whereas if partitions are not defined then world is equal to // MPI_COMM_WORLD. +#if !defined(MPI_STUBS) + // plumed does not know about LAMMPS using the MPI STUBS library and will + // fail if this is called under these circumstances p->cmd("setMPIComm",&world); +#endif // Set up units // LAMMPS units wrt kj/mol - nm - ps -- GitLab From eaf2b59b1b4b586f279d4a958293a343e1cea906 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 16:53:03 -0400 Subject: [PATCH 305/469] adapt fix neigh/history/omp to changes for dynamic exchange buffer size --- src/USER-OMP/fix_neigh_history_omp.cpp | 11 ++++++++--- src/fix.h | 2 +- 2 files changed, 9 insertions(+), 4 deletions(-) diff --git a/src/USER-OMP/fix_neigh_history_omp.cpp b/src/USER-OMP/fix_neigh_history_omp.cpp index efa7f5a3f1..c44d122981 100644 --- a/src/USER-OMP/fix_neigh_history_omp.cpp +++ b/src/USER-OMP/fix_neigh_history_omp.cpp @@ -175,6 +175,8 @@ void FixNeighHistoryOMP::pre_exchange_onesided() } // set maxpartner = max # of partners of any owned atom + // maxexchange = max # of values for any Comm::exchange() atom + maxpartner = m = 0; for (i = lfrom; i < lto; i++) m = MAX(m,npartner[i]); @@ -184,7 +186,7 @@ void FixNeighHistoryOMP::pre_exchange_onesided() #endif { maxpartner = MAX(m,maxpartner); - comm->maxexchange_fix =MAX(comm->maxexchange_fix,(dnum+1)*maxpartner+1); + maxexchange = (dnum+1)*maxpartner+1; } } @@ -347,6 +349,7 @@ void FixNeighHistoryOMP::pre_exchange_newton() } // set maxpartner = max # of partners of any owned atom + // maxexchange = max # of values for any Comm::exchange() atom m = 0; for (i = lfrom; i < lto; i++) m = MAX(m,npartner[i]); @@ -356,7 +359,7 @@ void FixNeighHistoryOMP::pre_exchange_newton() #endif { maxpartner = MAX(m,maxpartner); - comm->maxexchange_fix = MAX(comm->maxexchange_fix,(dnum+1)*maxpartner+1); + maxexchange = (dnum+1)*maxpartner+1; } } @@ -485,6 +488,8 @@ void FixNeighHistoryOMP::pre_exchange_no_newton() } // set maxpartner = max # of partners of any owned atom + // maxexchange = max # of values for any Comm::exchange() atom + m = 0; for (i = lfrom; i < lto; i++) m = MAX(m,npartner[i]); @@ -494,7 +499,7 @@ void FixNeighHistoryOMP::pre_exchange_no_newton() #endif { maxpartner = MAX(m,maxpartner); - comm->maxexchange_fix = MAX(comm->maxexchange_fix,(dnum+1)*maxpartner+1); + maxexchange = (dnum+1)*maxpartner+1; } } } diff --git a/src/fix.h b/src/fix.h index f4bf7f9c01..be99fe7cff 100644 --- a/src/fix.h +++ b/src/fix.h @@ -57,7 +57,7 @@ class Fix : protected Pointers { int respa_level_support; // 1 if fix supports fix_modify respa int respa_level; // which respa level to apply fix (1-Nrespa) int maxexchange; // max # of per-atom values for Comm::exchange() - int maxexchange_dynamic; // 1 if fix sets maxexchange dynamically + int maxexchange_dynamic; // 1 if fix sets maxexchange dynamically int scalar_flag; // 0/1 if compute_scalar() function exists int vector_flag; // 0/1 if compute_vector() function exists -- GitLab From c098582df81520e55d63621845bcada8cdbfded1 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 17:27:35 -0400 Subject: [PATCH 306/469] refactor communication cutoff estimator. move it to Comm class. and adjust heuristics. --- src/comm.cpp | 41 ++++++++++++++++++++++++++++++++++++----- src/comm.h | 2 ++ src/comm_brick.cpp | 2 +- src/comm_tiled.cpp | 2 +- src/info.cpp | 2 +- src/neighbor.cpp | 28 +--------------------------- 6 files changed, 42 insertions(+), 35 deletions(-) diff --git a/src/comm.cpp b/src/comm.cpp index 052de93793..3b4029e7d3 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -20,6 +20,7 @@ #include "atom_vec.h" #include "force.h" #include "pair.h" +#include "bond.h" #include "modify.h" #include "fix.h" #include "compute.h" @@ -585,6 +586,41 @@ void Comm::set_proc_grid(int outflag) } } +/* ---------------------------------------------------------------------- + determine suitable communication cutoff. + it is the maximum of the user specified value and estimates based on + the maximum neighbor list cutoff and largest bond equilibrium length. + we use the 1.5x the bond equilibrium distance as cutoff, if only a + bond style exists or only bond and angle styles exists. If dihedrals + or impropers are present we multiply by 2.0. This plus the + "neighbor list skin" will become the default communication cutoff, if + no pair style is defined and thus avoids all kinds of unexpected behavior + for such systems. If a pair style exists, the result is the maximum of + the bond based cutoff and the largest pair cutoff and the user + specified communication cutoff. +------------------------------------------------------------------------- */ + +double Comm::get_comm_cutoff() +{ + double maxcommcutoff = 0.0; + if (force->bond) { + int n = atom->nbondtypes; + for (int i = 1; i <= n; ++i) + maxcommcutoff = MAX(maxcommcutoff,force->bond->equilibrium_distance(i)); + + if (force->dihedral || force->improper) { + maxcommcutoff *= 2.0; + } else { + maxcommcutoff *=1.5; + } + maxcommcutoff += neighbor->skin; + } + maxcommcutoff = MAX(maxcommcutoff,neighbor->cutneighmax); + maxcommcutoff = MAX(maxcommcutoff,cutghostuser); + + return maxcommcutoff; +} + /* ---------------------------------------------------------------------- determine which proc owns atom with coord x[3] based on current decomp x will be in box (orthogonal) or lamda coords (triclinic) @@ -963,11 +999,6 @@ rendezvous_all2all(int n, char *inbuf, int insize, int inorder, int *procs, return 0; // all nout_rvous are 0, no 2nd irregular } - - - - - // create procs and outbuf for All2all if necesary if (!outorder) { diff --git a/src/comm.h b/src/comm.h index 90a215b4a6..860912a7d2 100644 --- a/src/comm.h +++ b/src/comm.h @@ -70,6 +70,8 @@ class Comm : protected Pointers { void set_processors(int, char **); // set 3d processor grid attributes virtual void set_proc_grid(int outflag = 1); // setup 3d grid of procs + double get_comm_cutoff(); // determine communication cutoff + virtual void setup() = 0; // setup 3d comm pattern virtual void forward_comm(int dummy = 0) = 0; // forward comm of atom coords virtual void reverse_comm() = 0; // reverse comm of forces diff --git a/src/comm_brick.cpp b/src/comm_brick.cpp index eb53f89746..a9ce64399f 100644 --- a/src/comm_brick.cpp +++ b/src/comm_brick.cpp @@ -175,7 +175,7 @@ void CommBrick::setup() int ntypes = atom->ntypes; double *prd,*sublo,*subhi; - double cut = MAX(neighbor->cutneighmax,cutghostuser); + double cut = get_comm_cutoff(); if ((cut == 0.0) && (me == 0)) error->warning(FLERR,"Communication cutoff is 0.0. No ghost atoms " "will be generated. Atoms may get lost."); diff --git a/src/comm_tiled.cpp b/src/comm_tiled.cpp index 9d4c446057..2558559cf7 100644 --- a/src/comm_tiled.cpp +++ b/src/comm_tiled.cpp @@ -157,7 +157,7 @@ void CommTiled::setup() // set cutoff for comm forward and comm reverse // check that cutoff < any periodic box length - double cut = MAX(neighbor->cutneighmax,cutghostuser); + double cut = get_comm_cutoff(); if ((cut == 0.0) && (me == 0)) error->warning(FLERR,"Communication cutoff is 0.0. No ghost atoms " "will be generated. Atoms may get lost."); diff --git a/src/info.cpp b/src/info.cpp index 25b9879408..74cbe6556f 100644 --- a/src/info.cpp +++ b/src/info.cpp @@ -366,7 +366,7 @@ void Info::command(int narg, char **arg) if (comm->mode == 0) { fprintf(out,"Communication mode = single\n"); fprintf(out,"Communication cutoff = %g\n", - MAX(comm->cutghostuser,neighbor->cutneighmax)); + comm->get_comm_cutoff()); } if (comm->mode == 1) { diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 9964b23b60..0382624198 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -35,7 +35,6 @@ #include "comm.h" #include "force.h" #include "pair.h" -#include "bond.h" #include "domain.h" #include "group.h" #include "modify.h" @@ -277,31 +276,6 @@ void Neighbor::init() // cutneigh = force cutoff + skin if cutforce > 0, else cutneigh = 0 // cutneighghost = pair cutghost if it requests it, else same as cutneigh - // also consider bonded interactions for estimating the the neighborlist - // and communication cutoff. we use the 1.5x the bond equilibrium distance - // as cutoff, if only a bond style exists. if also an angle style exists we - // multiply by 2.5, for dihedral or improper we multiply by 3.5. (1,2, or 3 - // bonds plus half a bond length total stretch). - // this plus "skin" will become the default communication cutoff, if no - // pair style is defined. otherwise the maximum of the largest pairwise - // cutoff of this is used. - - double maxbondcutoff = 0.0; - if (force->bond) { - n = atom->nbondtypes; - for (i = 1; i <= n; ++i) { - double bondcutoff = force->bond->equilibrium_distance(i); - maxbondcutoff = MAX(bondcutoff,maxbondcutoff); - } - if (force->dihedral || force->improper) { - maxbondcutoff *= 3.5; - } else if (force->angle) { - maxbondcutoff *=2.5; - } else { - maxbondcutoff *=1.5; - } - } - triggersq = 0.25*skin*skin; boxcheck = 0; if (domain->box_change && (domain->xperiodic || domain->yperiodic || @@ -319,7 +293,7 @@ void Neighbor::init() double cutoff,delta,cut; cutneighmin = BIG; - cutneighmax = maxbondcutoff; + cutneighmax = 0.0; for (i = 1; i <= n; i++) { cuttype[i] = cuttypesq[i] = 0.0; -- GitLab From d08477cc5f152f9fe8e2d916a9548aac798b75c9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 24 Jul 2019 17:49:00 -0400 Subject: [PATCH 307/469] print warning, when explicitly specified communication cutoff is increased --- src/comm.cpp | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/src/comm.cpp b/src/comm.cpp index 3b4029e7d3..4e605808af 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -617,6 +617,11 @@ double Comm::get_comm_cutoff() } maxcommcutoff = MAX(maxcommcutoff,neighbor->cutneighmax); maxcommcutoff = MAX(maxcommcutoff,cutghostuser); + if ((me == 0) && (cutghostuser > 0.0) && (maxcommcutoff > cutghostuser)) { + char mesg[128]; + snprintf(mesg,128,"Communication cutoff is changed to %g",maxcommcutoff); + error->warning(FLERR,mesg); + } return maxcommcutoff; } -- GitLab From b5a066ecd023495b252f3dfab7a8aedce0ac77bc Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 24 Jul 2019 21:08:08 -0500 Subject: [PATCH 308/469] Better error checking for kim_init log.cite behavior --- src/KIM/kim_init.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 5fb6748427..83638f3428 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -486,7 +486,7 @@ void KimInit::write_log_cite(char * model_name) if (0 == strncmp("kimcite",fileName,7)) { - if (lmp->citeme) lmp->citeme->add(fileString); + if ((lmp->citeme) && (availableAsString)) lmp->citeme->add(fileString); } } -- GitLab From aec43304f4b71efba11471450b078d6ccff65573 Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Thu, 25 Jul 2019 11:02:51 +0200 Subject: [PATCH 309/469] Add files via upload tex file with the equations for the shape parameters --- doc/src/Eqs/compute_shape_parameters.tex | 12 ++++++++++++ 1 file changed, 12 insertions(+) create mode 100644 doc/src/Eqs/compute_shape_parameters.tex diff --git a/doc/src/Eqs/compute_shape_parameters.tex b/doc/src/Eqs/compute_shape_parameters.tex new file mode 100644 index 0000000000..af7a6777f6 --- /dev/null +++ b/doc/src/Eqs/compute_shape_parameters.tex @@ -0,0 +1,12 @@ +\documentstyle[12pt]{article} + +\begin{document} + +\begin{eqnarray*} + c = l_z - 0.5(l_y+l_x) \\ + b = l_y - l_x \\ + k = \frac{3}{2} \frac{l_x^2+l_y^2+l_z^2}{(l_x+l_y+l_z)^2} - \frac{1}{2} +\end{eqnarray*} + +\end{document} + -- GitLab From 0be034ea46cb1013fcb04d23c343d50eb887a649 Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Thu, 25 Jul 2019 11:03:41 +0200 Subject: [PATCH 310/469] Add files via upload txt file with the documentation of the new compute style --- doc/src/compute_gyration_shape.txt | 86 ++++++++++++++++++++++++++++++ 1 file changed, 86 insertions(+) create mode 100644 doc/src/compute_gyration_shape.txt diff --git a/doc/src/compute_gyration_shape.txt b/doc/src/compute_gyration_shape.txt new file mode 100644 index 0000000000..b9b62cfaa7 --- /dev/null +++ b/doc/src/compute_gyration_shape.txt @@ -0,0 +1,86 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Commands_all.html) + +:line + +compute gyration/shape command :h3 + +[Syntax:] + +compute ID group-ID gyration computeID :pre + +ID, group-ID are documented in "compute"_compute.html command +gyration/shape = style name of this compute command +computeID = ID of "compute gyration"_compute_gyration.html command :ul + +[Examples:] + +compute 1 molecule gyration/shape pe :pre + +[Description:] + +Define a computation that calculates the eigenvalues of the gyration tensor of a +group of atoms and three shape parameters. The computation includes all effects +due to atoms passing thru periodic boundaries. + +The three computed shape parameters are the asphericity, b, the acylindricity, c, +and the relative shape anisotropy, k: + +:c,image(Eqs/compute_shape_parameters.jpg) + +where lx ≤ ly ≤ lz are the three eigenvalues of the gyration tensor. +The asphericity is always non-negative and zero only when the three principal +moments are equal. This zero condition is met when the distribution of particles +is spherically symmetric (hence the name asphericity) but also whenever the particle + distribution is symmetric with respect to the three coordinate axes, e.g., +when the particles are distributed uniformly on a cube, tetrahedron or other Platonic +solid. The acylindricity is always non-negative and zero only when the two principal +moments are equal. This zero condition is met when the distribution of particles is +cylindrically symmetric (hence the name, acylindricity), but also whenever the particle +distribution is symmetric with respect to the two coordinate axes, e.g., when the +particles are distributed uniformly on a regular prism. the relative shape anisotropy +is bounded between zero (if all points are spherically symmetric) and one +(if all points lie on a line). + +NOTE: The coordinates of an atom contribute to the gyration tensor in +"unwrapped" form, by using the image flags associated with each atom. +See the "dump custom"_dump.html command for a discussion of "unwrapped" +coordinates. See the Atoms section of the "read_data"_read_data.html +command for a discussion of image flags and how they are set for each +atom. You can reset the image flags (e.g. to 0) before invoking this +compute by using the "set image"_set.html command. + +[Output info:] + +This compute calculates a global vector of +length 6, which can be accessed by indices 1-6. The first three values are the +eigenvalues of the gyration tensor followed by the asphericity, the acylindricity +and the relative shape anisotropy. The computed values can be used by any command +that uses global vector values from a compute as input. See the "Howto +output"_Howto_output.html doc page for an overview of LAMMPS output +options. + +The vector values calculated by this compute are +"intensive". The first five vector values will be in +distance^2 "units"_units.html while the sixth one is dimensionless. + +[Restrictions:] + +This compute is part of the USER-MISC package. It is only enabled if +LAMMPS was built with that package. See the "Build +package"_Build_package.html doc page for more info. + +[Related commands:] + +"compute gyration"_compute_gyration.html + +[Default:] none + +:line + +:link(Theodorou) +[(Theodorou)] Theodorou, Suter, Macromolecules, 18, 1206 (1985). + -- GitLab From 1cebc5516e1093f21f7f87e345a27c51cf2b4355 Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Thu, 25 Jul 2019 11:05:35 +0200 Subject: [PATCH 311/469] Update README Adding my e-mail to README --- src/USER-MISC/README | 1 + 1 file changed, 1 insertion(+) diff --git a/src/USER-MISC/README b/src/USER-MISC/README index 219e19673d..c5b9353415 100644 --- a/src/USER-MISC/README +++ b/src/USER-MISC/README @@ -30,6 +30,7 @@ compute ackland/atom, Gerolf Ziegenhain, gerolf at ziegenhain.com, 4 Oct 2007 compute basal/atom, Christopher Barrett, cdb333 at cavs.msstate.edu, 3 Mar 2013 compute cnp/atom, Paulo Branicio (USC), branicio at usc.edu, 31 May 2017 compute entropy/atom, Pablo Piaggi (EPFL), pablo.piaggi at epfl.ch, 15 June 2018 +compute gyration/shape, Evangelos Voyiatzis, evoyiatzis at gmail.com, 25 July 2019 compute pressure/cylinder, Cody K. Addington (NCSU), , 2 Oct 2018 compute stress/mop, Romain Vermorel (U Pau) & Laurent Joly (U Lyon), romain.vermorel at univ-pau.fr & ljoly.ulyon at gmail.com, 5 Sep 18 compute stress/mop/profile, Romain Vermorel (U Pau) & Laurent Joly (U Lyon), romain.vermorel at univ-pau.fr & ljoly.ulyon at gmail.com, 5 Sep 18 -- GitLab From 6e9252c8475f3c328e6df45a19f45dd7d0daae35 Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Thu, 25 Jul 2019 11:10:36 +0200 Subject: [PATCH 312/469] Add files via upload The actual source code for the new compute --- src/USER-MISC/compute_gyration.cpp | 115 +++++++++++++++++++++++++ src/USER-MISC/compute_gyration_shape.h | 53 ++++++++++++ 2 files changed, 168 insertions(+) create mode 100644 src/USER-MISC/compute_gyration.cpp create mode 100644 src/USER-MISC/compute_gyration_shape.h diff --git a/src/USER-MISC/compute_gyration.cpp b/src/USER-MISC/compute_gyration.cpp new file mode 100644 index 0000000000..f8d19853e0 --- /dev/null +++ b/src/USER-MISC/compute_gyration.cpp @@ -0,0 +1,115 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include +#include "compute_gyration.h" +#include "update.h" +#include "atom.h" +#include "group.h" +#include "domain.h" +#include "error.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +ComputeGyration::ComputeGyration(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg) +{ + if (narg != 3) error->all(FLERR,"Illegal compute gyration command"); + + scalar_flag = vector_flag = 1; + size_vector = 6; + extscalar = 0; + extvector = 0; + + vector = new double[6]; +} + +/* ---------------------------------------------------------------------- */ + +ComputeGyration::~ComputeGyration() +{ + delete [] vector; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeGyration::init() +{ + masstotal = group->mass(igroup); +} + +/* ---------------------------------------------------------------------- */ + +double ComputeGyration::compute_scalar() +{ + invoked_scalar = update->ntimestep; + + double xcm[3]; + if (group->dynamic[igroup]) masstotal = group->mass(igroup); + group->xcm(igroup,masstotal,xcm); + scalar = group->gyration(igroup,masstotal,xcm); + return scalar; +} + +/* ---------------------------------------------------------------------- + compute the radius-of-gyration tensor of group of atoms + around center-of-mass cm + must unwrap atoms to compute Rg tensor correctly +------------------------------------------------------------------------- */ + +void ComputeGyration::compute_vector() +{ + invoked_vector = update->ntimestep; + + double xcm[3]; + group->xcm(igroup,masstotal,xcm); + + double **x = atom->x; + int *mask = atom->mask; + int *type = atom->type; + imageint *image = atom->image; + double *mass = atom->mass; + double *rmass = atom->rmass; + int nlocal = atom->nlocal; + + double dx,dy,dz,massone; + double unwrap[3]; + + double rg[6]; + rg[0] = rg[1] = rg[2] = rg[3] = rg[4] = rg[5] = 0.0; + + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + if (rmass) massone = rmass[i]; + else massone = mass[type[i]]; + + domain->unmap(x[i],image[i],unwrap); + dx = unwrap[0] - xcm[0]; + dy = unwrap[1] - xcm[1]; + dz = unwrap[2] - xcm[2]; + + rg[0] += dx*dx * massone; + rg[1] += dy*dy * massone; + rg[2] += dz*dz * massone; + rg[3] += dx*dy * massone; + rg[4] += dx*dz * massone; + rg[5] += dy*dz * massone; + } + MPI_Allreduce(rg,vector,6,MPI_DOUBLE,MPI_SUM,world); + + if (masstotal > 0.0) + for (int i = 0; i < 6; i++) + vector[i] /= masstotal; +} diff --git a/src/USER-MISC/compute_gyration_shape.h b/src/USER-MISC/compute_gyration_shape.h new file mode 100644 index 0000000000..1b39dd2e38 --- /dev/null +++ b/src/USER-MISC/compute_gyration_shape.h @@ -0,0 +1,53 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS + +ComputeStyle(gyration/shape,ComputeGyrationShape) + +#else + +#ifndef LMP_COMPUTE_GYRATION_SHAPE_H +#define LMP_COMPUTE_GYRATION_SHAPE_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeGyrationShape : public Compute { + public: + char *id_gyration; // fields accessed by other classes + + ComputeGyrationShape(class LAMMPS *, int, char **); + ~ComputeGyrationShape(); + void init(); + void compute_vector(); + + private: + class Compute *c_gyration; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ -- GitLab From 6710cc40527519efae40c349ec468cb4cc133dd3 Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Thu, 25 Jul 2019 11:44:43 +0200 Subject: [PATCH 313/469] cpp file for the compute command The right file with the cpp code --- src/USER-MISC/compute_gyration_shape.cpp | 133 +++++++++++++++++++++++ 1 file changed, 133 insertions(+) create mode 100644 src/USER-MISC/compute_gyration_shape.cpp diff --git a/src/USER-MISC/compute_gyration_shape.cpp b/src/USER-MISC/compute_gyration_shape.cpp new file mode 100644 index 0000000000..0e566e671f --- /dev/null +++ b/src/USER-MISC/compute_gyration_shape.cpp @@ -0,0 +1,133 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + * Contributing author: Evangelos Voyiatzis (Royal DSM) + * ------------------------------------------------------------------------- */ + + +#include +#include +#include "compute_gyration_shape.h" +#include "math_extra.h" +#include "update.h" +#include "atom.h" +#include "group.h" +#include "domain.h" +#include "error.h" +#include "modify.h" +#include "compute.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +ComputeGyrationShape::ComputeGyrationShape(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), id_gyration(NULL) +{ + if (narg != 4) error->all(FLERR,"Illegal compute gyration/shape command"); + + vector_flag = 1; + size_vector = 6; + extscalar = 0; + extvector = 0; + + // ID of compute gyration + int n = strlen(arg[3]) + 1; + id_gyration = new char[n]; + strcpy(id_gyration,arg[3]); + + init(); + + vector = new double[6]; +} + +/* ---------------------------------------------------------------------- */ + +ComputeGyrationShape::~ComputeGyrationShape() +{ + delete [] id_gyration; + delete [] vector; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeGyrationShape::init() +{ + // check that the compute gyration command exist + int icompute = modify->find_compute(id_gyration); + if (icompute < 0) + error->all(FLERR,"Compute gyration does not exist for compute gyration/shape"); + + // check the id_gyration corresponds really to a compute gyration command + c_gyration = (Compute *) modify->compute[icompute]; + if (strcmp(c_gyration->style,"gyration") != 0) + error->all(FLERR,"Compute gyration/shape does not use gyration compute"); +} + +/* ---------------------------------------------------------------------- + compute shape parameters based on the eigenvalues of the gyration tensor of group of atoms +------------------------------------------------------------------------- */ + +void ComputeGyrationShape::compute_vector() +{ + invoked_vector = update->ntimestep; + + // get the gyration tensor from the compute gyration + int icompute = modify->find_compute(id_gyration); + Compute *compute = modify->compute[icompute]; + compute->compute_vector(); + double *gyration_tensor = compute->vector; + + // call the function for the calculation of the eigenvalues + double ione[3][3], evalues[3], evectors[3][3]; + + ione[0][0] = gyration_tensor[0]; + ione[1][1] = gyration_tensor[1]; + ione[2][2] = gyration_tensor[2]; + ione[0][1] = ione[1][0] = gyration_tensor[3]; + ione[1][2] = ione[2][1] = gyration_tensor[4]; + ione[0][2] = ione[2][0] = gyration_tensor[5]; + + int ierror = MathExtra::jacobi(ione,evalues,evectors); + if (ierror) error->all(FLERR, "Insufficient Jacobi rotations for gyration/shape"); + + // sort the eigenvalues according to their size with bubble sort + double t; + for (int i = 0; i < 3; i++) { + for (int j = 0; j < 2-i; j++) { + if (fabs(evalues[j]) < fabs(evalues[j+1])) { + t = evalues[j]; + evalues[j] = evalues[j+1]; + evalues[j+1] = t; + } + } + } + + // compute the shape parameters of the gyration tensor + double sq_eigen_x = pow(evalues[0], 2); + double sq_eigen_y = pow(evalues[1], 2); + double sq_eigen_z = pow(evalues[2], 2); + + double nominator = pow(sq_eigen_x, 2) + pow(sq_eigen_y, 2) + pow(sq_eigen_z, 2); + double denominator = pow(sq_eigen_x+sq_eigen_y+sq_eigen_z, 2); + + vector[0] = evalues[0]; + vector[1] = evalues[1]; + vector[2] = evalues[2]; + vector[3] = sq_eigen_z - 0.5*(sq_eigen_x + sq_eigen_y); + vector[4] = sq_eigen_y - sq_eigen_x; + vector[5] = 0.5*(3*nominator/denominator -1); + +} + -- GitLab From 114a754a72b19eec8e3aa28ce328018263530577 Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Thu, 25 Jul 2019 11:48:04 +0200 Subject: [PATCH 314/469] Delete compute_gyration.cpp It is not part of the new compute style --- src/USER-MISC/compute_gyration.cpp | 115 ----------------------------- 1 file changed, 115 deletions(-) delete mode 100644 src/USER-MISC/compute_gyration.cpp diff --git a/src/USER-MISC/compute_gyration.cpp b/src/USER-MISC/compute_gyration.cpp deleted file mode 100644 index f8d19853e0..0000000000 --- a/src/USER-MISC/compute_gyration.cpp +++ /dev/null @@ -1,115 +0,0 @@ -/* ---------------------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#include -#include "compute_gyration.h" -#include "update.h" -#include "atom.h" -#include "group.h" -#include "domain.h" -#include "error.h" - -using namespace LAMMPS_NS; - -/* ---------------------------------------------------------------------- */ - -ComputeGyration::ComputeGyration(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg) -{ - if (narg != 3) error->all(FLERR,"Illegal compute gyration command"); - - scalar_flag = vector_flag = 1; - size_vector = 6; - extscalar = 0; - extvector = 0; - - vector = new double[6]; -} - -/* ---------------------------------------------------------------------- */ - -ComputeGyration::~ComputeGyration() -{ - delete [] vector; -} - -/* ---------------------------------------------------------------------- */ - -void ComputeGyration::init() -{ - masstotal = group->mass(igroup); -} - -/* ---------------------------------------------------------------------- */ - -double ComputeGyration::compute_scalar() -{ - invoked_scalar = update->ntimestep; - - double xcm[3]; - if (group->dynamic[igroup]) masstotal = group->mass(igroup); - group->xcm(igroup,masstotal,xcm); - scalar = group->gyration(igroup,masstotal,xcm); - return scalar; -} - -/* ---------------------------------------------------------------------- - compute the radius-of-gyration tensor of group of atoms - around center-of-mass cm - must unwrap atoms to compute Rg tensor correctly -------------------------------------------------------------------------- */ - -void ComputeGyration::compute_vector() -{ - invoked_vector = update->ntimestep; - - double xcm[3]; - group->xcm(igroup,masstotal,xcm); - - double **x = atom->x; - int *mask = atom->mask; - int *type = atom->type; - imageint *image = atom->image; - double *mass = atom->mass; - double *rmass = atom->rmass; - int nlocal = atom->nlocal; - - double dx,dy,dz,massone; - double unwrap[3]; - - double rg[6]; - rg[0] = rg[1] = rg[2] = rg[3] = rg[4] = rg[5] = 0.0; - - for (int i = 0; i < nlocal; i++) - if (mask[i] & groupbit) { - if (rmass) massone = rmass[i]; - else massone = mass[type[i]]; - - domain->unmap(x[i],image[i],unwrap); - dx = unwrap[0] - xcm[0]; - dy = unwrap[1] - xcm[1]; - dz = unwrap[2] - xcm[2]; - - rg[0] += dx*dx * massone; - rg[1] += dy*dy * massone; - rg[2] += dz*dz * massone; - rg[3] += dx*dy * massone; - rg[4] += dx*dz * massone; - rg[5] += dy*dz * massone; - } - MPI_Allreduce(rg,vector,6,MPI_DOUBLE,MPI_SUM,world); - - if (masstotal > 0.0) - for (int i = 0; i < 6; i++) - vector[i] /= masstotal; -} -- GitLab From b1a5444815925197b05a51362c336a61fbd59aaf Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 07:32:15 -0400 Subject: [PATCH 315/469] add (empty) read/write_restart_settings() functions to bond/angle/dihedral/improper base classes --- src/angle.h | 2 ++ src/bond.h | 2 ++ src/dihedral.h | 2 ++ src/improper.h | 2 ++ 4 files changed, 8 insertions(+) diff --git a/src/angle.h b/src/angle.h index 3d8371242e..ddd12ab7b8 100644 --- a/src/angle.h +++ b/src/angle.h @@ -46,6 +46,8 @@ class Angle : protected Pointers { virtual double equilibrium_angle(int) = 0; virtual void write_restart(FILE *) = 0; virtual void read_restart(FILE *) = 0; + virtual void write_restart_settings(FILE *) {}; + virtual void read_restart_settings(FILE *) {}; virtual void write_data(FILE *) {} virtual double single(int, int, int, int) = 0; virtual double memory_usage(); diff --git a/src/bond.h b/src/bond.h index 8fb7040832..cce94e33a0 100644 --- a/src/bond.h +++ b/src/bond.h @@ -48,6 +48,8 @@ class Bond : protected Pointers { virtual double equilibrium_distance(int) = 0; virtual void write_restart(FILE *) = 0; virtual void read_restart(FILE *) = 0; + virtual void write_restart_settings(FILE *) {}; + virtual void read_restart_settings(FILE *) {}; virtual void write_data(FILE *) {} virtual double single(int, double, int, int, double &) = 0; virtual double memory_usage(); diff --git a/src/dihedral.h b/src/dihedral.h index f1b42008bf..ac3786c40e 100644 --- a/src/dihedral.h +++ b/src/dihedral.h @@ -45,6 +45,8 @@ class Dihedral : protected Pointers { virtual void coeff(int, char **) = 0; virtual void write_restart(FILE *) = 0; virtual void read_restart(FILE *) = 0; + virtual void write_restart_settings(FILE *) {}; + virtual void read_restart_settings(FILE *) {}; virtual void write_data(FILE *) {} virtual double memory_usage(); diff --git a/src/improper.h b/src/improper.h index d940b43a13..876c928d7e 100644 --- a/src/improper.h +++ b/src/improper.h @@ -45,6 +45,8 @@ class Improper : protected Pointers { virtual void coeff(int, char **) = 0; virtual void write_restart(FILE *) = 0; virtual void read_restart(FILE *) = 0; + virtual void write_restart_settings(FILE *) {}; + virtual void read_restart_settings(FILE *) {}; virtual void write_data(FILE *) {} virtual double memory_usage(); -- GitLab From 5ca93e3651661bc25514fcdf046a22d88d88549c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 07:54:21 -0400 Subject: [PATCH 316/469] move global settings in restart files for table styles to restart settings functions --- src/MOLECULE/angle_table.cpp | 23 ++++++++++++++++++++--- src/MOLECULE/angle_table.h | 2 ++ src/MOLECULE/bond_table.cpp | 23 ++++++++++++++++++++--- src/MOLECULE/bond_table.h | 2 ++ src/USER-MISC/dihedral_table.cpp | 24 +++++++++++++++++++++--- src/USER-MISC/dihedral_table.h | 2 ++ src/USER-MISC/dihedral_table_cut.cpp | 21 +++++++++++++++++++-- src/USER-MISC/dihedral_table_cut.h | 2 ++ 8 files changed, 88 insertions(+), 11 deletions(-) diff --git a/src/MOLECULE/angle_table.cpp b/src/MOLECULE/angle_table.cpp index c18b4c43b0..898ce49be7 100644 --- a/src/MOLECULE/angle_table.cpp +++ b/src/MOLECULE/angle_table.cpp @@ -277,6 +277,25 @@ double AngleTable::equilibrium_angle(int i) ------------------------------------------------------------------------- */ void AngleTable::write_restart(FILE *fp) +{ + write_restart_settings(fp); +} + +/* ---------------------------------------------------------------------- + proc 0 reads from restart file, bcasts + ------------------------------------------------------------------------- */ + +void AngleTable::read_restart(FILE *fp) +{ + read_restart_settings(fp); + allocate(); +} + +/* ---------------------------------------------------------------------- + proc 0 writes to restart file + ------------------------------------------------------------------------- */ + +void AngleTable::write_restart_settings(FILE *fp) { fwrite(&tabstyle,sizeof(int),1,fp); fwrite(&tablength,sizeof(int),1,fp); @@ -286,7 +305,7 @@ void AngleTable::write_restart(FILE *fp) proc 0 reads from restart file, bcasts ------------------------------------------------------------------------- */ -void AngleTable::read_restart(FILE *fp) +void AngleTable::read_restart_settings(FILE *fp) { if (comm->me == 0) { fread(&tabstyle,sizeof(int),1,fp); @@ -294,8 +313,6 @@ void AngleTable::read_restart(FILE *fp) } MPI_Bcast(&tabstyle,1,MPI_INT,0,world); MPI_Bcast(&tablength,1,MPI_INT,0,world); - - allocate(); } /* ---------------------------------------------------------------------- */ diff --git a/src/MOLECULE/angle_table.h b/src/MOLECULE/angle_table.h index 0088ace39b..81e6c2ed89 100644 --- a/src/MOLECULE/angle_table.h +++ b/src/MOLECULE/angle_table.h @@ -35,6 +35,8 @@ class AngleTable : public Angle { double equilibrium_angle(int); void write_restart(FILE *); void read_restart(FILE *); + void write_restart_settings(FILE *); + void read_restart_settings(FILE *); double single(int, int, int, int); protected: diff --git a/src/MOLECULE/bond_table.cpp b/src/MOLECULE/bond_table.cpp index 10851774d7..170afc27f0 100644 --- a/src/MOLECULE/bond_table.cpp +++ b/src/MOLECULE/bond_table.cpp @@ -221,6 +221,25 @@ double BondTable::equilibrium_distance(int i) ------------------------------------------------------------------------- */ void BondTable::write_restart(FILE *fp) +{ + write_restart_settings(fp); +} + +/* ---------------------------------------------------------------------- + proc 0 reads from restart file, bcasts + ------------------------------------------------------------------------- */ + +void BondTable::read_restart(FILE *fp) +{ + read_restart_settings(fp); + allocate(); +} + +/* ---------------------------------------------------------------------- + proc 0 writes to restart file + ------------------------------------------------------------------------- */ + +void BondTable::write_restart_settings(FILE *fp) { fwrite(&tabstyle,sizeof(int),1,fp); fwrite(&tablength,sizeof(int),1,fp); @@ -230,7 +249,7 @@ void BondTable::write_restart(FILE *fp) proc 0 reads from restart file, bcasts ------------------------------------------------------------------------- */ -void BondTable::read_restart(FILE *fp) +void BondTable::read_restart_settings(FILE *fp) { if (comm->me == 0) { fread(&tabstyle,sizeof(int),1,fp); @@ -238,8 +257,6 @@ void BondTable::read_restart(FILE *fp) } MPI_Bcast(&tabstyle,1,MPI_INT,0,world); MPI_Bcast(&tablength,1,MPI_INT,0,world); - - allocate(); } /* ---------------------------------------------------------------------- */ diff --git a/src/MOLECULE/bond_table.h b/src/MOLECULE/bond_table.h index 5766239167..5d4f2e8493 100644 --- a/src/MOLECULE/bond_table.h +++ b/src/MOLECULE/bond_table.h @@ -35,6 +35,8 @@ class BondTable : public Bond { double equilibrium_distance(int); void write_restart(FILE *); void read_restart(FILE *); + void write_restart_settings(FILE *); + void read_restart_settings(FILE *); double single(int, double, int, int, double &); protected: diff --git a/src/USER-MISC/dihedral_table.cpp b/src/USER-MISC/dihedral_table.cpp index a97ae3649f..ce5a32b603 100644 --- a/src/USER-MISC/dihedral_table.cpp +++ b/src/USER-MISC/dihedral_table.cpp @@ -1011,6 +1011,26 @@ void DihedralTable::coeff(int narg, char **arg) ------------------------------------------------------------------------- */ void DihedralTable::write_restart(FILE *fp) +{ + write_restart_settings(fp); +} + +/* ---------------------------------------------------------------------- + proc 0 reads from restart file, bcasts + ------------------------------------------------------------------------- */ + +void DihedralTable::read_restart(FILE *fp) +{ + read_restart_settings(fp); + allocate(); +} + + +/* ---------------------------------------------------------------------- + proc 0 writes to restart file + ------------------------------------------------------------------------- */ + +void DihedralTable::write_restart_settings(FILE *fp) { fwrite(&tabstyle,sizeof(int),1,fp); fwrite(&tablength,sizeof(int),1,fp); @@ -1020,7 +1040,7 @@ void DihedralTable::write_restart(FILE *fp) proc 0 reads from restart file, bcasts ------------------------------------------------------------------------- */ -void DihedralTable::read_restart(FILE *fp) +void DihedralTable::read_restart_settings(FILE *fp) { if (comm->me == 0) { fread(&tabstyle,sizeof(int),1,fp); @@ -1029,8 +1049,6 @@ void DihedralTable::read_restart(FILE *fp) MPI_Bcast(&tabstyle,1,MPI_INT,0,world); MPI_Bcast(&tablength,1,MPI_INT,0,world); - - allocate(); } diff --git a/src/USER-MISC/dihedral_table.h b/src/USER-MISC/dihedral_table.h index 08bd21ba83..a7b8417b48 100644 --- a/src/USER-MISC/dihedral_table.h +++ b/src/USER-MISC/dihedral_table.h @@ -36,6 +36,8 @@ class DihedralTable : public Dihedral { void coeff(int, char **); void write_restart(FILE *); void read_restart(FILE *); + void write_restart_settings(FILE *); + void read_restart_settings(FILE *); double single(int type, int i1, int i2, int i3, int i4); protected: diff --git a/src/USER-MISC/dihedral_table_cut.cpp b/src/USER-MISC/dihedral_table_cut.cpp index 18a645cd75..f5c85cc52b 100644 --- a/src/USER-MISC/dihedral_table_cut.cpp +++ b/src/USER-MISC/dihedral_table_cut.cpp @@ -1003,8 +1003,7 @@ void DihedralTableCut::coeff(int narg, char **arg) void DihedralTableCut::write_restart(FILE *fp) { - fwrite(&tabstyle,sizeof(int),1,fp); - fwrite(&tablength,sizeof(int),1,fp); + write_restart_settings(fp); } /* ---------------------------------------------------------------------- @@ -1013,8 +1012,26 @@ void DihedralTableCut::write_restart(FILE *fp) void DihedralTableCut::read_restart(FILE *fp) { + read_restart_settings(fp); allocate(); +} +/* ---------------------------------------------------------------------- + proc 0 writes out coeffs to restart file +------------------------------------------------------------------------- */ + +void DihedralTableCut::write_restart_settings(FILE *fp) +{ + fwrite(&tabstyle,sizeof(int),1,fp); + fwrite(&tablength,sizeof(int),1,fp); +} + +/* ---------------------------------------------------------------------- + proc 0 reads coeffs from restart file, bcasts them +------------------------------------------------------------------------- */ + +void DihedralTableCut::read_restart_settings(FILE *fp) +{ if (comm->me == 0) { fread(&tabstyle,sizeof(int),1,fp); fread(&tablength,sizeof(int),1,fp); diff --git a/src/USER-MISC/dihedral_table_cut.h b/src/USER-MISC/dihedral_table_cut.h index dd645bedda..b07e925f08 100644 --- a/src/USER-MISC/dihedral_table_cut.h +++ b/src/USER-MISC/dihedral_table_cut.h @@ -33,6 +33,8 @@ class DihedralTableCut : public Dihedral { void coeff(int, char **); void write_restart(FILE *); void read_restart(FILE *); + void write_restart_settings(FILE *); + void read_restart_settings(FILE *); protected: double *aat_k,*aat_theta0_1,*aat_theta0_2; -- GitLab From f86d2c99346b66f27a036e694251ac77b40d0796 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 07:55:39 -0400 Subject: [PATCH 317/469] read/write settings in restart files for bonded hybrid styles this allows to properly restart table styles, which require additional settings unlike all other bonded styles. --- src/angle_hybrid.cpp | 2 ++ src/bond_hybrid.cpp | 2 ++ src/dihedral_hybrid.cpp | 2 ++ src/improper_hybrid.cpp | 2 ++ src/pair.h | 2 +- 5 files changed, 9 insertions(+), 1 deletion(-) diff --git a/src/angle_hybrid.cpp b/src/angle_hybrid.cpp index 6afa7413b2..d6c616fae4 100644 --- a/src/angle_hybrid.cpp +++ b/src/angle_hybrid.cpp @@ -324,6 +324,7 @@ void AngleHybrid::write_restart(FILE *fp) n = strlen(keywords[m]) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(keywords[m],sizeof(char),n,fp); + styles[m]->write_restart_settings(fp); } } @@ -349,6 +350,7 @@ void AngleHybrid::read_restart(FILE *fp) if (me == 0) fread(keywords[m],sizeof(char),n,fp); MPI_Bcast(keywords[m],n,MPI_CHAR,0,world); styles[m] = force->new_angle(keywords[m],0,dummy); + styles[m]->read_restart_settings(fp); } } diff --git a/src/bond_hybrid.cpp b/src/bond_hybrid.cpp index 65609b4b6e..1527943dc7 100644 --- a/src/bond_hybrid.cpp +++ b/src/bond_hybrid.cpp @@ -325,6 +325,7 @@ void BondHybrid::write_restart(FILE *fp) n = strlen(keywords[m]) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(keywords[m],sizeof(char),n,fp); + styles[m]->write_restart_settings(fp); } } @@ -350,6 +351,7 @@ void BondHybrid::read_restart(FILE *fp) if (me == 0) fread(keywords[m],sizeof(char),n,fp); MPI_Bcast(keywords[m],n,MPI_CHAR,0,world); styles[m] = force->new_bond(keywords[m],0,dummy); + styles[m]->read_restart_settings(fp); } } diff --git a/src/dihedral_hybrid.cpp b/src/dihedral_hybrid.cpp index f3e4823d53..8908139bdc 100644 --- a/src/dihedral_hybrid.cpp +++ b/src/dihedral_hybrid.cpp @@ -309,6 +309,7 @@ void DihedralHybrid::write_restart(FILE *fp) n = strlen(keywords[m]) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(keywords[m],sizeof(char),n,fp); + styles[m]->write_restart_settings(fp); } } @@ -334,6 +335,7 @@ void DihedralHybrid::read_restart(FILE *fp) if (me == 0) fread(keywords[m],sizeof(char),n,fp); MPI_Bcast(keywords[m],n,MPI_CHAR,0,world); styles[m] = force->new_dihedral(keywords[m],0,dummy); + styles[m]->read_restart_settings(fp); } } diff --git a/src/improper_hybrid.cpp b/src/improper_hybrid.cpp index 5fdcb42a96..174f54907e 100644 --- a/src/improper_hybrid.cpp +++ b/src/improper_hybrid.cpp @@ -306,6 +306,7 @@ void ImproperHybrid::write_restart(FILE *fp) n = strlen(keywords[m]) + 1; fwrite(&n,sizeof(int),1,fp); fwrite(keywords[m],sizeof(char),n,fp); + styles[m]->write_restart_settings(fp); } } @@ -331,6 +332,7 @@ void ImproperHybrid::read_restart(FILE *fp) if (me == 0) fread(keywords[m],sizeof(char),n,fp); MPI_Bcast(keywords[m],n,MPI_CHAR,0,world); styles[m] = force->new_improper(keywords[m],0,dummy); + styles[m]->read_restart_settings(fp); } } diff --git a/src/pair.h b/src/pair.h index 7481514dae..bad2b83c74 100644 --- a/src/pair.h +++ b/src/pair.h @@ -61,7 +61,7 @@ class Pair : protected Pointers { int dispersionflag; // 1 if compatible with LJ/dispersion solver int tip4pflag; // 1 if compatible with TIP4P solver int dipoleflag; // 1 if compatible with dipole solver - int spinflag; // 1 if compatible with spin solver + int spinflag; // 1 if compatible with spin solver int reinitflag; // 1 if compatible with fix adapt and alike int tail_flag; // pair_modify flag for LJ tail correction -- GitLab From 18730e0f923813ebc5f0a6266e4996bd25408eb0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 08:15:18 -0400 Subject: [PATCH 318/469] add documentation for the need to respecify coeff commands for bonded table styles --- doc/src/angle_table.txt | 10 ++++++++++ doc/src/bond_table.txt | 10 ++++++++++ doc/src/dihedral_table.txt | 10 ++++++++++ doc/src/dihedral_table_cut.txt | 10 ++++++++++ 4 files changed, 40 insertions(+) diff --git a/doc/src/angle_table.txt b/doc/src/angle_table.txt index 6b9187e512..61c987f587 100644 --- a/doc/src/angle_table.txt +++ b/doc/src/angle_table.txt @@ -143,6 +143,16 @@ instructions on how to use the accelerated styles effectively. :line +[Restart info:] + +This angle style writes the settings for the "angle_style table" +command to "binary restart files"_restart.html, so a angle_style +command does not need to specified in an input script that reads a +restart file. However, the coefficient information is not stored in +the restart file, since it is tabulated in the potential files. Thus, +angle_coeff commands do need to be specified in the restart input +script. + [Restrictions:] This angle style can only be used if LAMMPS was built with the diff --git a/doc/src/bond_table.txt b/doc/src/bond_table.txt index fbf6eb5815..7235214af0 100644 --- a/doc/src/bond_table.txt +++ b/doc/src/bond_table.txt @@ -140,6 +140,16 @@ instructions on how to use the accelerated styles effectively. :line +[Restart info:] + +This bond style writes the settings for the "bond_style table" +command to "binary restart files"_restart.html, so a bond_style +command does not need to specified in an input script that reads a +restart file. However, the coefficient information is not stored in +the restart file, since it is tabulated in the potential files. Thus, +bond_coeff commands do need to be specified in the restart input +script. + [Restrictions:] This bond style can only be used if LAMMPS was built with the MOLECULE diff --git a/doc/src/dihedral_table.txt b/doc/src/dihedral_table.txt index 3f679f5709..b3cfd37570 100644 --- a/doc/src/dihedral_table.txt +++ b/doc/src/dihedral_table.txt @@ -191,6 +191,16 @@ switch"_Run_options.html when you invoke LAMMPS, or you can use the See the "Speed packages"_Speed_packages.html doc page for more instructions on how to use the accelerated styles effectively. +[Restart info:] + +This dihedral style writes the settings for the "dihedral_style table" +command to "binary restart files"_restart.html, so a dihedral_style +command does not need to specified in an input script that reads a +restart file. However, the coefficient information is not stored in +the restart file, since it is tabulated in the potential files. Thus, +dihedral_coeff commands do need to be specified in the restart input +script. + [Restrictions:] This dihedral style can only be used if LAMMPS was built with the diff --git a/doc/src/dihedral_table_cut.txt b/doc/src/dihedral_table_cut.txt index b72f34e36e..560f5375a7 100644 --- a/doc/src/dihedral_table_cut.txt +++ b/doc/src/dihedral_table_cut.txt @@ -189,6 +189,16 @@ Note that one file can contain many sections, each with a tabulated potential. LAMMPS reads the file section by section until it finds one that matches the specified keyword. +[Restart info:] + +This dihedral style writes the settings for the "dihedral_style table/cut" +command to "binary restart files"_restart.html, so a dihedral_style +command does not need to specified in an input script that reads a +restart file. However, the coefficient information is not stored in +the restart file, since it is tabulated in the potential files. Thus, +dihedral_coeff commands do need to be specified in the restart input +script. + [Restrictions:] This dihedral style can only be used if LAMMPS was built with the -- GitLab From 4586fd50af7143b7349399ceee2ac7629af7a0ec Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 08:33:21 -0400 Subject: [PATCH 319/469] adjust logic for choosing the communication cutoff to requests from @sjplimp limit cases where warning about adjusting the comm cutoff is printed. --- src/comm.cpp | 53 ++++++++++++++++++++++++++++++++-------------------- 1 file changed, 33 insertions(+), 20 deletions(-) diff --git a/src/comm.cpp b/src/comm.cpp index 4e605808af..ae2715f0fd 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -588,39 +588,52 @@ void Comm::set_proc_grid(int outflag) /* ---------------------------------------------------------------------- determine suitable communication cutoff. - it is the maximum of the user specified value and estimates based on - the maximum neighbor list cutoff and largest bond equilibrium length. - we use the 1.5x the bond equilibrium distance as cutoff, if only a - bond style exists or only bond and angle styles exists. If dihedrals - or impropers are present we multiply by 2.0. This plus the - "neighbor list skin" will become the default communication cutoff, if - no pair style is defined and thus avoids all kinds of unexpected behavior - for such systems. If a pair style exists, the result is the maximum of - the bond based cutoff and the largest pair cutoff and the user - specified communication cutoff. + use the larger of the user specified value and the cutoff required + by the neighborlist build for pair styles. + if bonded interactions exist, apply a heuristic based on the equilibrium + bond length (use 1.5x r_bond if no dihedral or improper style exists + otherwise 2x r_bond) plus neighbor list skin. + if no user specified communication cutoff is given include this + heuristic, otherwise ignore it. + print a warning, if a user specified communication cutoff is overridden. ------------------------------------------------------------------------- */ double Comm::get_comm_cutoff() { double maxcommcutoff = 0.0; + double maxbondcutoff = 0.0; + if (force->bond) { int n = atom->nbondtypes; for (int i = 1; i <= n; ++i) - maxcommcutoff = MAX(maxcommcutoff,force->bond->equilibrium_distance(i)); + maxbondcutoff = MAX(maxbondcutoff,force->bond->equilibrium_distance(i)); if (force->dihedral || force->improper) { - maxcommcutoff *= 2.0; + maxbondcutoff *= 2.0; } else { - maxcommcutoff *=1.5; + maxbondcutoff *=1.5; } - maxcommcutoff += neighbor->skin; + maxbondcutoff += neighbor->skin; } - maxcommcutoff = MAX(maxcommcutoff,neighbor->cutneighmax); - maxcommcutoff = MAX(maxcommcutoff,cutghostuser); - if ((me == 0) && (cutghostuser > 0.0) && (maxcommcutoff > cutghostuser)) { - char mesg[128]; - snprintf(mesg,128,"Communication cutoff is changed to %g",maxcommcutoff); - error->warning(FLERR,mesg); + + // always take the larger of max neighbor list and user specified cutoff + + maxcommcutoff = MAX(cutghostuser,neighbor->cutneighmax); + + // consider cutoff estimate from bond length only if no user specified cutoff + + if (cutghostuser == 0.0) maxcommcutoff = MAX(maxcommcutoff,maxbondcutoff); + + // print warning if neighborlist cutoff overrides user cutoff or + // applied bond based cutoff is larger than neighbor cutoff. + + if (me == 0) { + if ( ((cutghostuser > 0.0) && (maxcommcutoff > cutghostuser)) + || ((cutghostuser == 0.0) && (maxcommcutoff == maxbondcutoff)) ) { + char mesg[128]; + snprintf(mesg,128,"Communication cutoff adjusted to %g",maxcommcutoff); + error->warning(FLERR,mesg); + } } return maxcommcutoff; -- GitLab From 183d92cad777efd998981b0b1f3c36752fa9c256 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 08:42:48 -0400 Subject: [PATCH 320/469] update comm_modify documentation --- doc/src/comm_modify.txt | 9 +++++++++ 1 file changed, 9 insertions(+) diff --git a/doc/src/comm_modify.txt b/doc/src/comm_modify.txt index 482259142b..d5f5aecf54 100644 --- a/doc/src/comm_modify.txt +++ b/doc/src/comm_modify.txt @@ -72,6 +72,15 @@ greater than the neighbor cutoff, then extra ghost atoms will be acquired. If the provided cutoff is smaller, the provided value will be ignored and the ghost cutoff is set to the neighbor cutoff. Specifying a cutoff value of 0.0 will reset any previous value to the default. +If bonded interactions exist and equilibrium bond length information is +available, then also a heuristic based on that bond length (2.0x {r_eq} +for systems with dihedrals or improper, 1.5x {r_eq} without) plus +neighbor skin is applied if the communication cutoff is set to its +default value of 0.0. This avoids problems for systems without a pair +style or where the non-bonded cutoff is (much) shorter than the largest +bond lengths. A warning message is printed, if a specified +communication cutoff > 0.0 is overridden or the bond length heuristics +lead to a larger communication cutoff. The {cutoff/multi} option is equivalent to {cutoff}, but applies to communication mode {multi} instead. Since in this case the communication -- GitLab From ca291f1015a1606c3f529ad69f42b98697ae9fb7 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Thu, 25 Jul 2019 11:47:56 -0500 Subject: [PATCH 321/469] Update to kim-api-2.1.1 --- cmake/Modules/Packages/KIM.cmake | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/cmake/Modules/Packages/KIM.cmake b/cmake/Modules/Packages/KIM.cmake index 5c0b8e2ee8..1a9dcf83a4 100644 --- a/cmake/Modules/Packages/KIM.cmake +++ b/cmake/Modules/Packages/KIM.cmake @@ -21,8 +21,8 @@ if(PKG_KIM) enable_language(Fortran) include(ExternalProject) ExternalProject_Add(kim_build - URL https://s3.openkim.org/kim-api/kim-api-2.1.0.txz - URL_MD5 9ada58e677a545a1987b1ecb98e39d7e + URL https://s3.openkim.org/kim-api/kim-api-2.1.1.txz + URL_MD5 ae0ee413e026c6e93d35692db5966fb4 BINARY_DIR build CMAKE_ARGS -DCMAKE_C_COMPILER=${CMAKE_C_COMPILER} -DCMAKE_CXX_COMPILER=${CMAKE_CXX_COMPILER} -- GitLab From df139bf32bdcaeddb6a0675167781dd5fc802204 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 25 Jul 2019 11:17:45 -0600 Subject: [PATCH 322/469] Merge in suggestions from PR #1582 --- src/KOKKOS/kokkos.cpp | 84 +++++++++++++------- src/MAKE/MACHINES/Makefile.lassen | 125 ++++++++++++++++++++++++++++++ 2 files changed, 181 insertions(+), 28 deletions(-) create mode 100644 src/MAKE/MACHINES/Makefile.lassen diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 3d1cb419d6..c0a74ca3b0 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -30,32 +30,38 @@ // for detecting CUDA-aware MPI support: // the variable int have_cuda_aware -// - is -1 if CUDA-aware MPI support is unknown -// - is 0 if no CUDA-aware MPI support available // - is 1 if CUDA-aware MPI support is available +// - is 0 if CUDA-aware MPI support is unavailable +// - is -1 if CUDA-aware MPI support is unknown #define CUDA_AWARE_UNKNOWN static int have_cuda_aware = -1; // OpenMPI supports detecting CUDA-aware MPI as of version 2.0.0 -#if OPEN_MPI +// IBM Spectrum MPI looks like OpenMPI but defines MPIX_CUDA_AWARE_SUPPORT=0 +// even when CUDA-aware MPI is available, and also has a runtime option +// to turn CUDA-aware MPI on/off, so support is unknown + +#if (defined OPEN_MPI) && !(defined SPECTRUM_MPI) #if (OMPI_MAJOR_VERSION >= 2) + #include + #if defined(MPIX_CUDA_AWARE_SUPPORT) && MPIX_CUDA_AWARE_SUPPORT static int have_cuda_aware = 1; #elif defined(MPIX_CUDA_AWARE_SUPPORT) && !MPIX_CUDA_AWARE_SUPPORT static int have_cuda_aware = 0; #else CUDA_AWARE_UNKNOWN -#endif +#endif // defined(MPIX_CUDA_AWARE_SUPPORT) #else // old OpenMPI CUDA_AWARE_UNKNOWN -#endif +#endif // (OMPI_MAJOR_VERSION >=2) #else // unknown MPI library CUDA_AWARE_UNKNOWN -#endif +#endif // OPEN_MPI #endif // KOKKOS_ENABLE_CUDA @@ -147,29 +153,10 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) #ifdef KOKKOS_ENABLE_CUDA if (ngpus <= 0) error->all(FLERR,"Kokkos has been compiled for CUDA but no GPUs are requested"); - - // check and warn about CUDA-aware MPI availability when using multiple MPI tasks - - int nmpi = 0; - MPI_Comm_size(world,&nmpi); - if ((nmpi > 1) && (me == 0)) { - if ( 1 == have_cuda_aware ) { - ; // all good, nothing to warn about - } else if ( -1 == have_cuda_aware ) { - error->warning(FLERR,"Kokkos with CUDA assumes CUDA-aware MPI is available," - " but cannot determine if this is the case\n try" - " '-pk kokkos cuda/aware off' when getting segmentation faults"); - } else if ( 0 == have_cuda_aware ) { - error->warning(FLERR,"CUDA-aware MPI is NOT available, " - "using '-pk kokkos cuda/aware off' by default"); - } else { - ; // should never get here - } - } #endif #ifndef KOKKOS_ENABLE_SERIAL - if (nthreads == 1) + if (nthreads == 1 && me == 0) error->warning(FLERR,"When using a single thread, the Kokkos Serial backend " "(i.e. Makefile.kokkos_mpi_only) gives better performance " "than the OpenMP backend"); @@ -185,7 +172,11 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) // default settings for package kokkos command binsize = 0.0; - cuda_aware_flag = 1; +#if KOKKOS_USE_CUDA + cuda_aware_flag = 1; +#else + cuda_aware_flag = 0; +#endif neigh_thread = 0; neigh_thread_set = 0; neighflag_qeq_set = 0; @@ -209,9 +200,46 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) } #ifdef KOKKOS_ENABLE_CUDA + + // check and warn about CUDA-aware MPI availability when using multiple MPI tasks // change default only if we can safely detect that CUDA-aware MPI is not available - if (0 == have_cuda_aware) cuda_aware_flag = 0; + + int nmpi = 0; + MPI_Comm_size(world,&nmpi); + if (nmpi > 0) { + if (have_cuda_aware == 0) { + if (me == 0) + error->warning(FLERR,"CUDA-aware MPI is NOT available, " + "using '-pk kokkos cuda/aware off'"); + cuda_aware_flag = 0; + } else if (have_cuda_aware == -1) { // maybe we are dealing with MPICH, MVAPICH2 or some derivative? + // MVAPICH2 +#if (defined MPICH) && (defined MVAPICH2_VERSION) + char* str; + if (!(str = getenv("MV2_ENABLE_CUDA") && (!(strcmp(str,"1") == 0))) { + if (me == 0) + error->warning(FLERR,"MVAPICH2 'MV2_ENABLE_CUDA' environment variable is not set. Disabling CUDA-aware MPI"); + cuda_aware_flag = 0; + } + // pure MPICH or some unsupported MPICH derivative +#elif (defined MPICH) && !(defined MVAPICH2_VERSION) + if (me == 0) + error->warning(FLERR,"Detected MPICH. Disabling CUDA-aware MPI"); + cuda_aware_flag = 0; +#elif (defined SPECTRUM_MPI) + if (me == 0) + error->warning(FLERR,"Must use the '-gpu' flag with Spectrum MPI to enable " + "CUDA-aware MPI support"); +#else + if (me == 0) + error->warning(FLERR,"Kokkos with CUDA assumes CUDA-aware MPI is available," + " but cannot determine if this is the case\n try" + " '-pk kokkos cuda/aware off' if getting segmentation faults"); + #endif + } // if (-1 == have_cuda_aware) + } // nmpi > 0 +#endif // KOKKOS_USE_CUDA #ifdef KILL_KOKKOS_ON_SIGSEGV signal(SIGSEGV, my_signal_handler); diff --git a/src/MAKE/MACHINES/Makefile.lassen b/src/MAKE/MACHINES/Makefile.lassen new file mode 100644 index 0000000000..669e599e3c --- /dev/null +++ b/src/MAKE/MACHINES/Makefile.lassen @@ -0,0 +1,125 @@ +# lassen_kokkos = KOKKOS/CUDA, V100 GPU and Power9, IBM Spectrum MPI, nvcc compiler with gcc 7.3.1 + +SHELL = /bin/sh + +# --------------------------------------------------------------------- +# compiler/linker settings +# specify flags and libraries needed for your compiler + +KOKKOS_ABSOLUTE_PATH = $(shell cd $(KOKKOS_PATH); pwd) +export MPICH_CXX = $(KOKKOS_ABSOLUTE_PATH)/bin/nvcc_wrapper +export OMPI_CXX = $(KOKKOS_ABSOLUTE_PATH)/bin/nvcc_wrapper +CC = $(KOKKOS_ABSOLUTE_PATH)/bin/nvcc_wrapper +CCFLAGS = -g -O3 +SHFLAGS = -fPIC +DEPFLAGS = -M + +LINK = $(KOKKOS_ABSOLUTE_PATH)/bin/nvcc_wrapper +LINKFLAGS = -g -O3 +LIB = +SIZE = size + +ARCHIVE = ar +ARFLAGS = -rc +SHLIBFLAGS = -shared +KOKKOS_DEVICES = Cuda +KOKKOS_ARCH = Power9,Volta70 + +# --------------------------------------------------------------------- +# LAMMPS-specific settings, all OPTIONAL +# specify settings for LAMMPS features you will use +# if you change any -D setting, do full re-compile after "make clean" + +# LAMMPS ifdef settings +# see possible settings in Section 2.2 (step 4) of manual + +LMP_INC = -DLAMMPS_GZIP + +# MPI library +# see discussion in Section 2.2 (step 5) of manual +# MPI wrapper compiler/linker can provide this info +# can point to dummy MPI library in src/STUBS as in Makefile.serial +# use -D MPICH and OMPI settings in INC to avoid C++ lib conflicts +# INC = path for mpi.h, MPI compiler settings +# PATH = path for MPI library +# LIB = name of MPI library + +MPI_INC = -DSPECTRUM_MPI -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX=1 -I/usr/tce/packages/spectrum-mpi/spectrum-mpi-rolling-release-gcc-7.3.1/include +MPI_PATH = +MPI_LIB = -L/usr/tce/packages/spectrum-mpi/spectrum-mpi-rolling-release-gcc-7.3.1/lib -lmpi_ibm + +# FFT library +# see discussion in Section 2.2 (step 6) of manaul +# can be left blank to use provided KISS FFT library +# INC = -DFFT setting, e.g. -DFFT_FFTW, FFT compiler settings +# PATH = path for FFT library +# LIB = name of FFT library + +FFT_INC = +FFT_PATH = +FFT_LIB = + +# JPEG and/or PNG library +# see discussion in Section 2.2 (step 7) of manual +# only needed if -DLAMMPS_JPEG or -DLAMMPS_PNG listed with LMP_INC +# INC = path(s) for jpeglib.h and/or png.h +# PATH = path(s) for JPEG library and/or PNG library +# LIB = name(s) of JPEG library and/or PNG library + +JPG_INC = +JPG_PATH = +JPG_LIB = + +# --------------------------------------------------------------------- +# build rules and dependencies +# do not edit this section + +include Makefile.package.settings +include Makefile.package + +EXTRA_INC = $(LMP_INC) $(PKG_INC) $(MPI_INC) $(FFT_INC) $(JPG_INC) $(PKG_SYSINC) +EXTRA_PATH = $(PKG_PATH) $(MPI_PATH) $(FFT_PATH) $(JPG_PATH) $(PKG_SYSPATH) +EXTRA_LIB = $(PKG_LIB) $(MPI_LIB) $(FFT_LIB) $(JPG_LIB) $(PKG_SYSLIB) +EXTRA_CPP_DEPENDS = $(PKG_CPP_DEPENDS) +EXTRA_LINK_DEPENDS = $(PKG_LINK_DEPENDS) + +# Path to src files + +vpath %.cpp .. +vpath %.h .. + +# Link target + +$(EXE): $(OBJ) $(EXTRA_LINK_DEPENDS) + $(LINK) $(LINKFLAGS) $(EXTRA_PATH) $(OBJ) $(EXTRA_LIB) $(LIB) -o $(EXE) + $(SIZE) $(EXE) + +# Library targets + +lib: $(OBJ) $(EXTRA_LINK_DEPENDS) + $(ARCHIVE) $(ARFLAGS) $(EXE) $(OBJ) + +shlib: $(OBJ) $(EXTRA_LINK_DEPENDS) + $(CC) $(CCFLAGS) $(SHFLAGS) $(SHLIBFLAGS) $(EXTRA_PATH) -o $(EXE) \ + $(OBJ) $(EXTRA_LIB) $(LIB) + +# Compilation rules + +%.o:%.cpp $(EXTRA_CPP_DEPENDS) + $(CC) $(CCFLAGS) $(SHFLAGS) $(EXTRA_INC) -c $< + +%.d:%.cpp $(EXTRA_CPP_DEPENDS) + $(CC) $(CCFLAGS) $(EXTRA_INC) $(DEPFLAGS) $< > $@ + +%.o:%.cu $(EXTRA_CPP_DEPENDS) + $(CC) $(CCFLAGS) $(SHFLAGS) $(EXTRA_INC) -c $< + +# Individual dependencies + +depend : fastdep.exe $(SRC) + @./fastdep.exe $(EXTRA_INC) -- $^ > .depend || exit 1 + +fastdep.exe: ../DEPEND/fastdep.c + cc -O -o $@ $< + +sinclude .depend -- GitLab From d0b442aca1ca95ed7de518cd79981b153a1fbe23 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 25 Jul 2019 11:25:32 -0600 Subject: [PATCH 323/469] Rename file --- src/MAKE/MACHINES/{Makefile.lassen => Makefile.lassen_kokkos} | 0 1 file changed, 0 insertions(+), 0 deletions(-) rename src/MAKE/MACHINES/{Makefile.lassen => Makefile.lassen_kokkos} (100%) diff --git a/src/MAKE/MACHINES/Makefile.lassen b/src/MAKE/MACHINES/Makefile.lassen_kokkos similarity index 100% rename from src/MAKE/MACHINES/Makefile.lassen rename to src/MAKE/MACHINES/Makefile.lassen_kokkos -- GitLab From 081780706c45560e8f83798ded0c1abd37676e7a Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 25 Jul 2019 12:15:29 -0600 Subject: [PATCH 324/469] Store if comm flags are changed by turning off CUDA-aware MPI so they can be restored if using cuda/aware on --- src/KOKKOS/kokkos.cpp | 46 +++++++++++++++++++++++++++++++++++-------- src/KOKKOS/kokkos.h | 3 +++ 2 files changed, 41 insertions(+), 8 deletions(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index c0a74ca3b0..5e8b63936b 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -74,6 +74,10 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) kokkos_exists = 1; lmp->kokkos = this; + exchange_comm_changed = 0; + forward_comm_changed = 0; + reverse_comm_changed = 0; + delete memory; memory = new MemoryKokkos(lmp); memoryKK = (MemoryKokkos*) memory; @@ -209,8 +213,8 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) if (nmpi > 0) { if (have_cuda_aware == 0) { if (me == 0) - error->warning(FLERR,"CUDA-aware MPI is NOT available, " - "using '-pk kokkos cuda/aware off'"); + error->warning(FLERR,"Turning off CUDA-aware MPI since it is not detected, " + "use '-pk kokkos cuda/aware on' to override"); cuda_aware_flag = 0; } else if (have_cuda_aware == -1) { // maybe we are dealing with MPICH, MVAPICH2 or some derivative? // MVAPICH2 @@ -320,6 +324,7 @@ void KokkosLMP::accelerator(int narg, char **arg) exchange_comm_classic = 0; exchange_comm_on_host = 0; } else error->all(FLERR,"Illegal package kokkos command"); + exchange_comm_changed = 0; iarg += 2; } else if (strcmp(arg[iarg],"comm/forward") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal package kokkos command"); @@ -331,6 +336,7 @@ void KokkosLMP::accelerator(int narg, char **arg) forward_comm_classic = 0; forward_comm_on_host = 0; } else error->all(FLERR,"Illegal package kokkos command"); + forward_comm_changed = 0; iarg += 2; } else if (strcmp(arg[iarg],"comm/reverse") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal package kokkos command"); @@ -342,6 +348,7 @@ void KokkosLMP::accelerator(int narg, char **arg) reverse_comm_classic = 0; reverse_comm_on_host = 0; } else error->all(FLERR,"Illegal package kokkos command"); + reverse_comm_changed = 0; iarg += 2; } else if (strcmp(arg[iarg],"cuda/aware") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal package kokkos command"); @@ -362,12 +369,35 @@ void KokkosLMP::accelerator(int narg, char **arg) // if "cuda/aware off" and "comm device", change to "comm host" if (!cuda_aware_flag) { - if (exchange_comm_classic == 0 && exchange_comm_on_host == 0) - exchange_comm_on_host = 1; - if (forward_comm_classic == 0 && forward_comm_on_host == 0) - forward_comm_on_host = 1; - if (reverse_comm_classic == 0 && reverse_comm_on_host == 0) - reverse_comm_on_host = 1; + if (exchange_comm_classic == 0 && exchange_comm_on_host == 0) { + exchange_comm_on_host = 1; + exchange_comm_changed = 1; + } + if (forward_comm_classic == 0 && forward_comm_on_host == 0) { + forward_comm_on_host = 1; + forward_comm_changed = 1; + } + if (reverse_comm_classic == 0 && reverse_comm_on_host == 0) { + reverse_comm_on_host = 1; + reverse_comm_changed = 1; + } + } + + // if "cuda/aware on" and comm flags were changed previously, change them back + + if (cuda_aware_flag) { + if (exchange_comm_changed) { + exchange_comm_on_host = 0; + exchange_comm_changed = 0; + } + if (forward_comm_changed) { + forward_comm_on_host = 0; + forward_comm_changed = 0; + } + if (reverse_comm_changed) { + reverse_comm_on_host = 0; + reverse_comm_changed = 0; + } } // set newton flags diff --git a/src/KOKKOS/kokkos.h b/src/KOKKOS/kokkos.h index 19e6297ea4..b9f1e66c68 100644 --- a/src/KOKKOS/kokkos.h +++ b/src/KOKKOS/kokkos.h @@ -32,6 +32,9 @@ class KokkosLMP : protected Pointers { int exchange_comm_on_host; int forward_comm_on_host; int reverse_comm_on_host; + int exchange_comm_changed; + int forward_comm_changed; + int reverse_comm_changed; int nthreads,ngpus; int numa; int auto_sync; -- GitLab From 7c1fedff1887951068d82cb4930cab3afc0e2b48 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 25 Jul 2019 12:30:45 -0600 Subject: [PATCH 325/469] Fix var name --- src/KOKKOS/kokkos.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 5e8b63936b..c90e702d7d 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -176,7 +176,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) // default settings for package kokkos command binsize = 0.0; -#if KOKKOS_USE_CUDA +#ifdef KOKKOS_ENABLE_CUDA cuda_aware_flag = 1; #else cuda_aware_flag = 0; @@ -243,7 +243,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) #endif } // if (-1 == have_cuda_aware) } // nmpi > 0 -#endif // KOKKOS_USE_CUDA +#endif // KOKKOS_ENABLE_CUDA #ifdef KILL_KOKKOS_ON_SIGSEGV signal(SIGSEGV, my_signal_handler); -- GitLab From ab74bfef20844f81707362224ee990712119f17c Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 25 Jul 2019 12:52:16 -0600 Subject: [PATCH 326/469] Small logic tweak --- src/KOKKOS/kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index c90e702d7d..f6ab8f5916 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -42,7 +42,7 @@ // even when CUDA-aware MPI is available, and also has a runtime option // to turn CUDA-aware MPI on/off, so support is unknown -#if (defined OPEN_MPI) && !(defined SPECTRUM_MPI) +#if (OPEN_MPI) && !(defined SPECTRUM_MPI) #if (OMPI_MAJOR_VERSION >= 2) #include -- GitLab From fadb40051ba753d6534d7f6d128dc3eb1e00fe69 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Thu, 25 Jul 2019 14:03:35 -0500 Subject: [PATCH 327/469] Update kim_query & clear and update examples/kim --- ....kim.lj.simulator_model => in.kim-ex.melt} | 6 +- examples/kim/in.kim-pm-query.melt | 37 +++++ .../{in.kim.lj.newton-off => in.kim-pm.melt} | 19 +-- examples/kim/in.kim-sm.melt | 36 +++++ examples/kim/in.kim.lj.lmp.newton-off | 35 ----- examples/kim/in.kim.lj.newton-on | 41 ------ ...in.kim.lj.lmp.newton-on => in.lammps.melt} | 4 +- examples/kim/in.query | 12 -- .../log.06Feb2019.in.kim.lj.lmp.newton-off.1 | 55 -------- .../log.06Feb2019.in.kim.lj.lmp.newton-off.4 | 55 -------- .../log.06Feb2019.in.kim.lj.lmp.newton-on.1 | 55 -------- .../log.06Feb2019.in.kim.lj.lmp.newton-on.4 | 55 -------- .../kim/log.06Feb2019.in.kim.lj.newton-off.1 | 59 -------- .../kim/log.06Feb2019.in.kim.lj.newton-off.4 | 65 --------- .../kim/log.06Feb2019.in.kim.lj.newton-on.1 | 59 -------- .../kim/log.06Feb2019.in.kim.lj.newton-on.4 | 65 --------- examples/kim/log.22Mar2019.query.g++.1 | 34 ----- ...og.30Apr2019.kim.VOH.simulator_model.g++.1 | 92 ------------ ....30Apr2019.kim.ex_si.simulator_model.g++.1 | 132 ------------------ ....30Apr2019.kim.ex_si.simulator_model.g++.4 | 132 ------------------ ...log.30Apr2019.kim.lj.simulator_model.g++.1 | 104 -------------- ...log.30Apr2019.kim.lj.simulator_model.g++.4 | 104 -------------- src/KIM/kim_query.cpp | 3 +- 23 files changed, 86 insertions(+), 1173 deletions(-) rename examples/kim/{in.kim.lj.simulator_model => in.kim-ex.melt} (82%) create mode 100644 examples/kim/in.kim-pm-query.melt rename examples/kim/{in.kim.lj.newton-off => in.kim-pm.melt} (52%) create mode 100644 examples/kim/in.kim-sm.melt delete mode 100644 examples/kim/in.kim.lj.lmp.newton-off delete mode 100644 examples/kim/in.kim.lj.newton-on rename examples/kim/{in.kim.lj.lmp.newton-on => in.lammps.melt} (91%) delete mode 100644 examples/kim/in.query delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.1 delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.4 delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.1 delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.4 delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.newton-off.1 delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.newton-off.4 delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.newton-on.1 delete mode 100644 examples/kim/log.06Feb2019.in.kim.lj.newton-on.4 delete mode 100644 examples/kim/log.22Mar2019.query.g++.1 delete mode 100644 examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 delete mode 100644 examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 delete mode 100644 examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 delete mode 100644 examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 delete mode 100644 examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 diff --git a/examples/kim/in.kim.lj.simulator_model b/examples/kim/in.kim-ex.melt similarity index 82% rename from examples/kim/in.kim.lj.simulator_model rename to examples/kim/in.kim-ex.melt index cb7a2e14ed..5cc3dbc61b 100644 --- a/examples/kim/in.kim.lj.simulator_model +++ b/examples/kim/in.kim-ex.melt @@ -14,15 +14,14 @@ variable xx equal 20*$x variable yy equal 20*$y variable zz equal 20*$z -kim_init Sim_LAMMPS_LJcut_AkersonElliott_Alchemy_PbAu real unit_conversion_mode -newton on +kim_init LennardJones_Ar real lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} create_box 1 box create_atoms 1 box -kim_interactions Au +kim_interactions Ar mass 1 39.95 velocity all create 200.0 232345 loop geom @@ -31,5 +30,6 @@ neighbor 0.3 bin neigh_modify delay 0 every 1 check yes fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 run 100 diff --git a/examples/kim/in.kim-pm-query.melt b/examples/kim/in.kim-pm-query.melt new file mode 100644 index 0000000000..d39dd2d464 --- /dev/null +++ b/examples/kim/in.kim-pm-query.melt @@ -0,0 +1,37 @@ +# 3d Lennard-Jones melt +# +# This example requires that the KIM Portable Model (PM) +# SW_StillingerWeber_1985_Si__MO_405512056662_005 +# is installed. This can be done with the command +# kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# Or, see https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable yy equal 20*$y +variable zz equal 20*$z + +kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 real +kim_query a0 get_lattice_constant_cubic crystal=["fcc"] species=["Si"] units=["angstrom"] + +lattice fcc ${a0} +region box block 0 ${xx} 0 ${yy} 0 ${zz} +create_box 1 box +create_atoms 1 box + +kim_interactions Si + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 diff --git a/examples/kim/in.kim.lj.newton-off b/examples/kim/in.kim-pm.melt similarity index 52% rename from examples/kim/in.kim.lj.newton-off rename to examples/kim/in.kim-pm.melt index 82cf5ba602..999cf77180 100644 --- a/examples/kim/in.kim.lj.newton-off +++ b/examples/kim/in.kim-pm.melt @@ -1,9 +1,10 @@ # 3d Lennard-Jones melt # -# This example requires that the example models provided with -# the kim-api package are installed. see the ./lib/kim/README or -# ./lib/kim/Install.py files for details on how to install these -# example models. +# This example requires that the KIM Portable Model (PM) +# SW_StillingerWeber_1985_Si__MO_405512056662_005 +# is installed. This can be done with the command +# kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# Or, see https://openkim.org/doc/obtaining-models for alternative options. # variable x index 1 @@ -14,20 +15,14 @@ variable xx equal 20*$x variable yy equal 20*$y variable zz equal 20*$z -units metal -atom_style atomic -newton off +kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 real lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} create_box 1 box create_atoms 1 box -#pair_style lj/cut 8.1500 -#pair_coeff 1 1 0.0104 3.4000 - -pair_style kim LennardJones_Ar -pair_coeff * * Ar +kim_interactions Si mass 1 39.95 velocity all create 200.0 232345 loop geom diff --git a/examples/kim/in.kim-sm.melt b/examples/kim/in.kim-sm.melt new file mode 100644 index 0000000000..32f8c6170f --- /dev/null +++ b/examples/kim/in.kim-sm.melt @@ -0,0 +1,36 @@ +# 3d Lennard-Jones melt +# +# This example requires that the KIM Simulator Model (PM) +# Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# is installed. This can be done with the command +# kim-api-collections-management install user Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# Or, see https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable yy equal 20*$y +variable zz equal 20*$z + +kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real + +lattice fcc 4.4300 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +create_box 1 box +create_atoms 1 box + +kim_interactions O + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 diff --git a/examples/kim/in.kim.lj.lmp.newton-off b/examples/kim/in.kim.lj.lmp.newton-off deleted file mode 100644 index 197755294a..0000000000 --- a/examples/kim/in.kim.lj.lmp.newton-off +++ /dev/null @@ -1,35 +0,0 @@ -# 3d Lennard-Jones melt - -variable x index 1 -variable y index 1 -variable z index 1 - -variable xx equal 20*$x -variable yy equal 20*$y -variable zz equal 20*$z - -units metal -atom_style atomic -newton off - -lattice fcc 4.4300 -region box block 0 ${xx} 0 ${yy} 0 ${zz} -create_box 1 box -create_atoms 1 box - -pair_style lj/cut 8.1500 -pair_coeff 1 1 0.0104 3.4000 - -#pair_style kim LennardJones_Ar -#pair_coeff * * Ar - -mass 1 39.95 -velocity all create 200.0 232345 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve -#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 - -run 100 diff --git a/examples/kim/in.kim.lj.newton-on b/examples/kim/in.kim.lj.newton-on deleted file mode 100644 index 3a95f1dbb0..0000000000 --- a/examples/kim/in.kim.lj.newton-on +++ /dev/null @@ -1,41 +0,0 @@ -# 3d Lennard-Jones melt -# -# This example requires that the example models provided with -# the kim-api package are installed. see the ./lib/kim/README or -# ./lib/kim/Install.py files for details on how to install these -# example models. -# - -variable x index 1 -variable y index 1 -variable z index 1 - -variable xx equal 20*$x -variable yy equal 20*$y -variable zz equal 20*$z - -units metal -atom_style atomic -newton on - -lattice fcc 4.4300 -region box block 0 ${xx} 0 ${yy} 0 ${zz} -create_box 1 box -create_atoms 1 box - -#pair_style lj/cut 8.1500 -#pair_coeff 1 1 0.0104 3.4000 - -pair_style kim LennardJones_Ar -pair_coeff * * Ar - -mass 1 39.95 -velocity all create 200.0 232345 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve -#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 - -run 100 diff --git a/examples/kim/in.kim.lj.lmp.newton-on b/examples/kim/in.lammps.melt similarity index 91% rename from examples/kim/in.kim.lj.lmp.newton-on rename to examples/kim/in.lammps.melt index f9f79e2bb2..5792f3a5db 100644 --- a/examples/kim/in.kim.lj.lmp.newton-on +++ b/examples/kim/in.lammps.melt @@ -8,9 +8,7 @@ variable xx equal 20*$x variable yy equal 20*$y variable zz equal 20*$z -units metal -atom_style atomic -newton on +units real lattice fcc 4.4300 region box block 0 ${xx} 0 ${yy} 0 ${zz} diff --git a/examples/kim/in.query b/examples/kim/in.query deleted file mode 100644 index 72e739fb52..0000000000 --- a/examples/kim/in.query +++ /dev/null @@ -1,12 +0,0 @@ - -# example for performing a query to the OpenKIM test database to retrieve -# a parameter to be used in the input. here it requests the aluminium -# lattice constant for a specific test used for a specific model and then -# assigns it to the variable 'latconst' - -kim_init EAM_CubicNaturalSpline_ErcolessiAdams_1994_Al__MO_800509458712_002 metal -info variables out log -kim_query latconst split get_test_result test=TE_156715955670 species=["Al"] prop=structure-cubic-crystal-npt keys=["a","a"] units=["angstrom","angstrom"] -info variables out log -lattice fcc ${latconst_1} -lattice fcc ${latconst_2} diff --git a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.1 b/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.1 deleted file mode 100644 index 5925fd750d..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.1 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 1 by 1 MPI processor grid -Created 32000 atoms - Time spent = 0.004499 secs -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 20.37 | 20.37 | 20.37 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 2.92885 on 1 procs for 100 steps with 32000 atoms - -Performance: 2.950 ns/day, 8.136 hours/ns, 34.143 timesteps/s -99.1% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 2.5638 | 2.5638 | 2.5638 | 0.0 | 87.54 -Neigh | 0.31935 | 0.31935 | 0.31935 | 0.0 | 10.90 -Comm | 0.006833 | 0.006833 | 0.006833 | 0.0 | 0.23 -Output | 0.000107 | 0.000107 | 0.000107 | 0.0 | 0.00 -Modify | 0.027806 | 0.027806 | 0.027806 | 0.0 | 0.95 -Other | | 0.01091 | | | 0.37 - -Nlocal: 32000 ave 32000 max 32000 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 19911 ave 19911 max 19911 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 2.3705e+06 ave 2.3705e+06 max 2.3705e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 2370499 -Ave neighs/atom = 74.0781 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:03 diff --git a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.4 b/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.4 deleted file mode 100644 index c1ca108c7b..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-off.4 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 2 by 2 MPI processor grid -Created 32000 atoms - Time spent = 0.001039 secs -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton off - pair build: half/bin/newtoff - stencil: half/bin/3d/newtoff - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 8.013 | 8.013 | 8.013 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 0.778581 on 4 procs for 100 steps with 32000 atoms - -Performance: 11.097 ns/day, 2.163 hours/ns, 128.439 timesteps/s -99.8% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.65171 | 0.65891 | 0.67656 | 1.3 | 84.63 -Neigh | 0.07924 | 0.079548 | 0.07997 | 0.1 | 10.22 -Comm | 0.006755 | 0.0069015 | 0.007072 | 0.2 | 0.89 -Output | 4.6e-05 | 9.725e-05 | 0.000203 | 0.0 | 0.01 -Modify | 0.006841 | 0.006941 | 0.007015 | 0.1 | 0.89 -Other | | 0.02618 | | | 3.36 - -Nlocal: 8000 ave 8018 max 7967 min -Histogram: 1 0 0 0 0 0 1 0 0 2 -Nghost: 9131 ave 9164 max 9113 min -Histogram: 2 0 0 1 0 0 0 0 0 1 -Neighs: 630904 ave 632094 max 628209 min -Histogram: 1 0 0 0 0 0 0 1 0 2 - -Total # of neighbors = 2523614 -Ave neighs/atom = 78.8629 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.1 b/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.1 deleted file mode 100644 index 53555743d7..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.1 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 1 by 1 MPI processor grid -Created 32000 atoms - Time spent = 0.003479 secs -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d/newton - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 19.23 | 19.23 | 19.23 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 2.17978 on 1 procs for 100 steps with 32000 atoms - -Performance: 3.964 ns/day, 6.055 hours/ns, 45.876 timesteps/s -99.9% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 1.9892 | 1.9892 | 1.9892 | 0.0 | 91.26 -Neigh | 0.14506 | 0.14506 | 0.14506 | 0.0 | 6.65 -Comm | 0.011049 | 0.011049 | 0.011049 | 0.0 | 0.51 -Output | 9.1e-05 | 9.1e-05 | 9.1e-05 | 0.0 | 0.00 -Modify | 0.02347 | 0.02347 | 0.02347 | 0.0 | 1.08 -Other | | 0.01094 | | | 0.50 - -Nlocal: 32000 ave 32000 max 32000 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 19911 ave 19911 max 19911 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 2.12688e+06 ave 2.12688e+06 max 2.12688e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 2126875 -Ave neighs/atom = 66.4648 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:02 diff --git a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.4 b/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.4 deleted file mode 100644 index f0fdf66193..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.lmp.newton-on.4 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 2 by 2 MPI processor grid -Created 32000 atoms - Time spent = 0.000919 secs -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d/newton - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 7.632 | 7.632 | 7.632 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 0.63515 on 4 procs for 100 steps with 32000 atoms - -Performance: 13.603 ns/day, 1.764 hours/ns, 157.443 timesteps/s -99.8% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.55365 | 0.5566 | 0.55868 | 0.2 | 87.63 -Neigh | 0.041495 | 0.0418 | 0.04211 | 0.1 | 6.58 -Comm | 0.019086 | 0.021075 | 0.023898 | 1.2 | 3.32 -Output | 4.4e-05 | 5.025e-05 | 6e-05 | 0.0 | 0.01 -Modify | 0.009315 | 0.0093595 | 0.009422 | 0.0 | 1.47 -Other | | 0.006263 | | | 0.99 - -Nlocal: 8000 ave 8018 max 7967 min -Histogram: 1 0 0 0 0 0 1 0 0 2 -Nghost: 9131 ave 9164 max 9113 min -Histogram: 2 0 0 1 0 0 0 0 0 1 -Neighs: 531719 ave 533273 max 529395 min -Histogram: 1 0 0 0 1 0 0 0 0 2 - -Total # of neighbors = 2126875 -Ave neighs/atom = 66.4648 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/kim/log.06Feb2019.in.kim.lj.newton-off.1 b/examples/kim/log.06Feb2019.in.kim.lj.newton-off.1 deleted file mode 100644 index 0ab258fe0d..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.newton-off.1 +++ /dev/null @@ -1,59 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 1 by 1 MPI processor grid -Created 32000 atoms - Time spent = 0.003446 secs -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair kim, perpetual - attributes: full, newton off, cut 8.45 - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 28.51 | 28.51 | 28.51 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 3.01669 on 1 procs for 100 steps with 32000 atoms - -Performance: 2.864 ns/day, 8.380 hours/ns, 33.149 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 2.6562 | 2.6562 | 2.6562 | 0.0 | 88.05 -Neigh | 0.31903 | 0.31903 | 0.31903 | 0.0 | 10.58 -Comm | 0.00634 | 0.00634 | 0.00634 | 0.0 | 0.21 -Output | 9.1e-05 | 9.1e-05 | 9.1e-05 | 0.0 | 0.00 -Modify | 0.024723 | 0.024723 | 0.024723 | 0.0 | 0.82 -Other | | 0.01032 | | | 0.34 - -Nlocal: 32000 ave 32000 max 32000 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 19911 ave 19911 max 19911 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 4.25375e+06 ave 4.25375e+06 max 4.25375e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 4253750 -Ave neighs/atom = 132.93 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:03 diff --git a/examples/kim/log.06Feb2019.in.kim.lj.newton-off.4 b/examples/kim/log.06Feb2019.in.kim.lj.newton-off.4 deleted file mode 100644 index c17ea6afb7..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.newton-off.4 +++ /dev/null @@ -1,65 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 2 by 2 MPI processor grid -Created 32000 atoms - Time spent = 0.000921 secs -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair kim, perpetual - attributes: full, newton off, cut 8.45 - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 10.05 | 10.05 | 10.05 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 0.890192 on 4 procs for 100 steps with 32000 atoms - -Performance: 9.706 ns/day, 2.473 hours/ns, 112.335 timesteps/s -99.7% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.77867 | 0.77906 | 0.7794 | 0.0 | 87.52 -Neigh | 0.087831 | 0.088176 | 0.088805 | 0.1 | 9.91 -Comm | 0.006358 | 0.0065898 | 0.006815 | 0.3 | 0.74 -Output | 4.9e-05 | 5.975e-05 | 6.8e-05 | 0.0 | 0.01 -Modify | 0.010265 | 0.010429 | 0.010678 | 0.2 | 1.17 -Other | | 0.005874 | | | 0.66 - -Nlocal: 8000 ave 8018 max 7967 min -Histogram: 1 0 0 0 0 0 1 0 0 2 -Nghost: 9131 ave 9164 max 9113 min -Histogram: 2 0 0 1 0 0 0 0 0 1 -Neighs: 0 ave 0 max 0 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -FullNghs: 1.06344e+06 ave 1.06594e+06 max 1.05881e+06 min -Histogram: 1 0 0 0 0 0 1 0 0 2 - -Total # of neighbors = 4253750 -Ave neighs/atom = 132.93 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/kim/log.06Feb2019.in.kim.lj.newton-on.1 b/examples/kim/log.06Feb2019.in.kim.lj.newton-on.1 deleted file mode 100644 index 59d018e12a..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.newton-on.1 +++ /dev/null @@ -1,59 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 1 by 1 MPI processor grid -Created 32000 atoms - Time spent = 0.003089 secs -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair kim, perpetual - attributes: full, newton off, cut 8.45 - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 28.12 | 28.12 | 28.12 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 3.05849 on 1 procs for 100 steps with 32000 atoms - -Performance: 2.825 ns/day, 8.496 hours/ns, 32.696 timesteps/s -99.6% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 2.6786 | 2.6786 | 2.6786 | 0.0 | 87.58 -Neigh | 0.33105 | 0.33105 | 0.33105 | 0.0 | 10.82 -Comm | 0.012602 | 0.012602 | 0.012602 | 0.0 | 0.41 -Output | 9.5e-05 | 9.5e-05 | 9.5e-05 | 0.0 | 0.00 -Modify | 0.024858 | 0.024858 | 0.024858 | 0.0 | 0.81 -Other | | 0.01132 | | | 0.37 - -Nlocal: 32000 ave 32000 max 32000 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 19911 ave 19911 max 19911 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 4.25375e+06 ave 4.25375e+06 max 4.25375e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 4253750 -Ave neighs/atom = 132.93 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:03 diff --git a/examples/kim/log.06Feb2019.in.kim.lj.newton-on.4 b/examples/kim/log.06Feb2019.in.kim.lj.newton-on.4 deleted file mode 100644 index da8c9f0faa..0000000000 --- a/examples/kim/log.06Feb2019.in.kim.lj.newton-on.4 +++ /dev/null @@ -1,65 +0,0 @@ -LAMMPS (1 Feb 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:87) - using 1 OpenMP thread(s) per MPI task -Lattice spacing in x,y,z = 4.43 4.43 4.43 -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 2 by 2 MPI processor grid -Created 32000 atoms - Time spent = 0.000893 secs -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:1097) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:1102) -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair kim, perpetual - attributes: full, newton off, cut 8.45 - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.001 -Per MPI rank memory allocation (min/avg/max) = 9.789 | 9.789 | 9.789 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 0.903182 on 4 procs for 100 steps with 32000 atoms - -Performance: 9.566 ns/day, 2.509 hours/ns, 110.720 timesteps/s -99.6% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.76173 | 0.76349 | 0.76597 | 0.2 | 84.53 -Neigh | 0.088773 | 0.088938 | 0.089074 | 0.0 | 9.85 -Comm | 0.032018 | 0.03452 | 0.03638 | 0.9 | 3.82 -Output | 4e-05 | 4.425e-05 | 5.2e-05 | 0.0 | 0.00 -Modify | 0.009278 | 0.0093917 | 0.009528 | 0.1 | 1.04 -Other | | 0.006797 | | | 0.75 - -Nlocal: 8000 ave 8018 max 7967 min -Histogram: 1 0 0 0 0 0 1 0 0 2 -Nghost: 9131 ave 9164 max 9113 min -Histogram: 2 0 0 1 0 0 0 0 0 1 -Neighs: 0 ave 0 max 0 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -FullNghs: 1.06344e+06 ave 1.06594e+06 max 1.05881e+06 min -Histogram: 1 0 0 0 0 0 1 0 0 2 - -Total # of neighbors = 4253750 -Ave neighs/atom = 132.93 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/kim/log.22Mar2019.query.g++.1 b/examples/kim/log.22Mar2019.query.g++.1 deleted file mode 100644 index 034bb13bba..0000000000 --- a/examples/kim/log.22Mar2019.query.g++.1 +++ /dev/null @@ -1,34 +0,0 @@ -LAMMPS (28 Feb 2019) - -# example for performing a query to the OpenKIM test database to retrieve -# a parameter to be used in the input. here it requests the aluminium -# lattice constant for a specific test used for a specific model and then -# assigns it to the variable 'latconst' - -units metal -info variables out log - -Info-Info-Info-Info-Info-Info-Info-Info-Info-Info-Info -Printed on Fri Mar 22 20:00:56 2019 - - -Variable information: - -Info-Info-Info-Info-Info-Info-Info-Info-Info-Info-Info - -kim_query latconst get_test_result test=TE_156715955670 species=["Al"] model=MO_800509458712 prop=structure-cubic-crystal-npt keys=["a"] units=["angstrom"] -info variables out log - -Info-Info-Info-Info-Info-Info-Info-Info-Info-Info-Info -Printed on Fri Mar 22 20:00:57 2019 - - -Variable information: -Variable[ 0]: latconst , style = string , def = 4.03208274841 - -Info-Info-Info-Info-Info-Info-Info-Info-Info-Info-Info - -lattice fcc ${latconst} -lattice fcc 4.03208274841 -Lattice spacing in x,y,z = 4.03208 4.03208 4.03208 -Total wall time: 0:00:00 diff --git a/examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 b/examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 deleted file mode 100644 index e9d1f17d76..0000000000 --- a/examples/kim/log.30Apr2019.kim.VOH.simulator_model.g++.1 +++ /dev/null @@ -1,92 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task -# REAX potential for VOH system -# ..... - -units real -atom_style charge - -kim_style init Sim_LAMMPS_ReaxFF_ChenowethVanDuinPersson_2008_CHOV__SM_429148913211_000 -units real -atom_style charge -neigh_modify one 4000 - -read_data data.VOH - orthogonal box = (0 0 0) to (25 25 25) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 100 atoms - read_data CPU = 0.000217199 secs - -kim_style define H C O V -Using KIM Simulator Model : Sim_LAMMPS_ReaxFF_ChenowethVanDuinPersson_2008_CHOV__SM_429148913211_000 -For Simulator : LAMMPS 28-Feb-2019 -Running on : LAMMPS 30 Apr 2019 -pair_style reax/c /tmp/kim-simulator-model-parameter-file-XXXXXXFRmlac safezone 2.0 mincap 100 -pair_coeff * * /tmp/kim-simulator-model-parameter-file-XXXXXX363kge H C O V -Reading potential file /tmp/kim-simulator-model-parameter-file-XXXXXX363kge with DATE: 2011-02-18 -WARNING: Changed valency_val to valency_boc for X (src/USER-REAXC/reaxc_ffield.cpp:311) -fix reaxqeq all qeq/reax 1 0.0 10.0 1.0e-6 /tmp/kim-simulator-model-parameter-file-XXXXXXzgDl49 - -neighbor 2 bin -neigh_modify every 10 delay 0 check no - -fix 1 all nve -fix 3 all temp/berendsen 500.0 500.0 100.0 - -timestep 0.25 - -#dump 1 all atom 30 dump.reax.voh - -run 300 -Neighbor list info ... - update every 10 steps, delay 0 steps, check no - max neighbors/atom: 4000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 5 5 5 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair reax/c, perpetual - attributes: half, newton off, ghost - pair build: half/bin/newtoff/ghost - stencil: half/ghost/bin/3d/newtoff - bin: standard - (2) fix qeq/reax, perpetual, copy from (1) - attributes: half, newton off, ghost - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 25.97 | 25.97 | 25.97 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -10246.825 0 -10246.825 42.256089 - 300 199.45773 -10218.342 0 -10159.482 -66.730725 -Loop time of 1.06721 on 1 procs for 300 steps with 100 atoms - -Performance: 6.072 ns/day, 3.953 hours/ns, 281.107 timesteps/s -98.8% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.93954 | 0.93954 | 0.93954 | 0.0 | 88.04 -Neigh | 0.029087 | 0.029087 | 0.029087 | 0.0 | 2.73 -Comm | 0.0018935 | 0.0018935 | 0.0018935 | 0.0 | 0.18 -Output | 1.8358e-05 | 1.8358e-05 | 1.8358e-05 | 0.0 | 0.00 -Modify | 0.096112 | 0.096112 | 0.096112 | 0.0 | 9.01 -Other | | 0.0005522 | | | 0.05 - -Nlocal: 100 ave 100 max 100 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 608 ave 608 max 608 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 3441 ave 3441 max 3441 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 3441 -Ave neighs/atom = 34.41 -Neighbor list builds = 30 -Dangerous builds not checked - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:01 diff --git a/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 b/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 deleted file mode 100644 index a6d1c4a955..0000000000 --- a/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.1 +++ /dev/null @@ -1,132 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task - -units metal -kim_style init ex_sim_model_Si_mod_tersoff -units metal -newton on - -atom_style atomic -atom_modify map array -boundary p p p - -# temperatures -variable tlo equal 1800.0 -variable thi equal 2400.0 - -# coordination number cutoff - -variable r equal 2.835 - -# minimization parameters - -variable etol equal 1.0e-5 -variable ftol equal 1.0e-5 -variable maxiter equal 100 -variable maxeval equal 100 -variable dmax equal 1.0e-1 - -# diamond unit cell - -variable a equal 5.431 -lattice custom $a a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 -lattice custom 5.431 a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 -Lattice spacing in x,y,z = 5.431 5.431 5.431 - -region myreg block 0 4 0 4 0 4 -create_box 1 myreg -Created orthogonal box = (0 0 0) to (21.724 21.724 21.724) - 1 by 1 by 1 MPI processor grid -create_atoms 1 region myreg -Created 512 atoms - create_atoms CPU = 0.000393867 secs - -mass 1 28.06 - -group Si type 1 -512 atoms in group Si - -velocity all create ${thi} 5287286 mom yes rot yes dist gaussian -velocity all create 2400 5287286 mom yes rot yes dist gaussian - -# make a vacancy - -group del id 300 -1 atoms in group del -delete_atoms group del -Deleted 1 atoms, new total = 511 -kim_style define Si -Using KIM Simulator Model : ex_sim_model_Si_mod_tersoff -For Simulator : LAMMPS 12-Dec-2018 -Running on : LAMMPS 30 Apr 2019 -pair_style tersoff/mod -pair_coeff * * /tmp/kim-simulator-model-parameter-file-XXXXXXVWG8uV Si -Reading potential file /tmp/kim-simulator-model-parameter-file-XXXXXXVWG8uV with DATE: 2013-07-26 - -thermo 10 - -fix 1 all nve -fix 2 all langevin ${thi} ${thi} 0.1 48278 -fix 2 all langevin 2400 ${thi} 0.1 48278 -fix 2 all langevin 2400 2400 0.1 48278 - -timestep 1.0e-3 -neighbor 1.0 bin -neigh_modify every 1 delay 10 check yes - -run 100 -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 4.3 - ghost atom cutoff = 4.3 - binsize = 2.15, bins = 11 11 11 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair tersoff/mod, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.11 | 3.11 | 3.11 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 2397.3877 -2363.0694 0 -2205.0272 15086.224 - 10 1328.4035 -2289.1682 0 -2201.5963 29164.666 - 20 1086.1557 -2254.4447 0 -2182.8424 31906.878 - 30 1528.8439 -2270.2968 0 -2169.5113 21610.528 - 40 1345.227 -2250.3915 0 -2161.7105 22146.886 - 50 1300.3329 -2235.8593 0 -2150.1379 23557.875 - 60 1546.1664 -2241.3019 0 -2139.3744 21648.774 - 70 1662.2896 -2236.2369 0 -2126.6543 23958.738 - 80 1631.7284 -2223.45 0 -2115.8821 28842.194 - 90 1795.3629 -2225.2998 0 -2106.9447 29522.37 - 100 1830.156 -2224.3733 0 -2103.7245 28805.09 -Loop time of 0.201725 on 1 procs for 100 steps with 511 atoms - -Performance: 42.831 ns/day, 0.560 hours/ns, 495.724 timesteps/s -99.3% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.19292 | 0.19292 | 0.19292 | 0.0 | 95.63 -Neigh | 0.0037313 | 0.0037313 | 0.0037313 | 0.0 | 1.85 -Comm | 0.00074744 | 0.00074744 | 0.00074744 | 0.0 | 0.37 -Output | 0.00026727 | 0.00026727 | 0.00026727 | 0.0 | 0.13 -Modify | 0.0036564 | 0.0036564 | 0.0036564 | 0.0 | 1.81 -Other | | 0.0004075 | | | 0.20 - -Nlocal: 511 ave 511 max 511 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 970 ave 970 max 970 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 9174 ave 9174 max 9174 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 9174 -Ave neighs/atom = 17.953 -Neighbor list builds = 4 -Dangerous builds = 0 - -Total wall time: 0:00:00 diff --git a/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 b/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 deleted file mode 100644 index dcb170aeb6..0000000000 --- a/examples/kim/log.30Apr2019.kim.ex_si.simulator_model.g++.4 +++ /dev/null @@ -1,132 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task - -units metal -kim_style init ex_sim_model_Si_mod_tersoff -units metal -newton on - -atom_style atomic -atom_modify map array -boundary p p p - -# temperatures -variable tlo equal 1800.0 -variable thi equal 2400.0 - -# coordination number cutoff - -variable r equal 2.835 - -# minimization parameters - -variable etol equal 1.0e-5 -variable ftol equal 1.0e-5 -variable maxiter equal 100 -variable maxeval equal 100 -variable dmax equal 1.0e-1 - -# diamond unit cell - -variable a equal 5.431 -lattice custom $a a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 -lattice custom 5.431 a1 1.0 0.0 0.0 a2 0.0 1.0 0.0 a3 0.0 0.0 1.0 basis 0.0 0.0 0.0 basis 0.0 0.5 0.5 basis 0.5 0.0 0.5 basis 0.5 0.5 0.0 basis 0.25 0.25 0.25 basis 0.25 0.75 0.75 basis 0.75 0.25 0.75 basis 0.75 0.75 0.25 -Lattice spacing in x,y,z = 5.431 5.431 5.431 - -region myreg block 0 4 0 4 0 4 -create_box 1 myreg -Created orthogonal box = (0 0 0) to (21.724 21.724 21.724) - 1 by 2 by 2 MPI processor grid -create_atoms 1 region myreg -Created 512 atoms - create_atoms CPU = 0.102434 secs - -mass 1 28.06 - -group Si type 1 -512 atoms in group Si - -velocity all create ${thi} 5287286 mom yes rot yes dist gaussian -velocity all create 2400 5287286 mom yes rot yes dist gaussian - -# make a vacancy - -group del id 300 -1 atoms in group del -delete_atoms group del -Deleted 1 atoms, new total = 511 -kim_style define Si -Using KIM Simulator Model : ex_sim_model_Si_mod_tersoff -For Simulator : LAMMPS 12-Dec-2018 -Running on : LAMMPS 30 Apr 2019 -pair_style tersoff/mod -pair_coeff * * /tmp/kim-simulator-model-parameter-file-XXXXXXqDlERL Si -Reading potential file /tmp/kim-simulator-model-parameter-file-XXXXXXqDlERL with DATE: 2013-07-26 - -thermo 10 - -fix 1 all nve -fix 2 all langevin ${thi} ${thi} 0.1 48278 -fix 2 all langevin 2400 ${thi} 0.1 48278 -fix 2 all langevin 2400 2400 0.1 48278 - -timestep 1.0e-3 -neighbor 1.0 bin -neigh_modify every 1 delay 10 check yes - -run 100 -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 4.3 - ghost atom cutoff = 4.3 - binsize = 2.15, bins = 11 11 11 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair tersoff/mod, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.082 | 3.082 | 3.082 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 2397.5824 -2363.0694 0 -2205.0143 15087.562 - 10 1298.5003 -2292.5456 0 -2206.945 28361.893 - 20 1114.7065 -2260.7006 0 -2187.2161 30574.077 - 30 1504.9472 -2271.8639 0 -2172.6537 20395.651 - 40 1357.5949 -2248.6066 0 -2159.1103 21779.773 - 50 1351.7212 -2235.0803 0 -2145.9713 23404.844 - 60 1582.4191 -2238.3233 0 -2134.006 21711.26 - 70 1654.3988 -2230.0965 0 -2121.0341 24276.504 - 80 1654.9629 -2218.6654 0 -2109.5658 27571.472 - 90 1815.7206 -2219.2065 0 -2099.5093 28475.757 - 100 1901.1544 -2216.5428 0 -2091.2137 28962.04 -Loop time of 4.36959 on 4 procs for 100 steps with 511 atoms - -Performance: 1.977 ns/day, 12.138 hours/ns, 22.885 timesteps/s -47.8% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.051784 | 0.056551 | 0.064825 | 2.1 | 1.29 -Neigh | 0.00093389 | 0.001028 | 0.0011392 | 0.3 | 0.02 -Comm | 2.8964 | 2.9342 | 3.016 | 2.8 | 67.15 -Output | 0.673 | 0.68159 | 0.69707 | 1.1 | 15.60 -Modify | 0.0011303 | 0.0029655 | 0.0081694 | 5.5 | 0.07 -Other | | 0.6933 | | | 15.87 - -Nlocal: 127.75 ave 134 max 123 min -Histogram: 1 0 0 2 0 0 0 0 0 1 -Nghost: 495 ave 498 max 489 min -Histogram: 1 0 0 0 0 0 0 1 1 1 -Neighs: 0 ave 0 max 0 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -FullNghs: 2302 ave 2443 max 2194 min -Histogram: 1 0 0 2 0 0 0 0 0 1 - -Total # of neighbors = 9208 -Ave neighs/atom = 18.0196 -Neighbor list builds = 4 -Dangerous builds = 0 - -Total wall time: 0:00:05 diff --git a/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 b/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 deleted file mode 100644 index 94aaf1aaef..0000000000 --- a/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.1 +++ /dev/null @@ -1,104 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task -# 3d Lennard-Jones melt -# -# This example requires that the example models provided with -# the kim-api package are installed. see the ./lib/kim/README or -# ./lib/kim/Install.py files for details on how to install these -# example models. -# - -variable x index 1 -variable y index 1 -variable z index 1 - -variable xx equal 20*$x -variable xx equal 20*1 -variable yy equal 20*$y -variable yy equal 20*1 -variable zz equal 20*$z -variable zz equal 20*1 - -units metal -atom_style atomic -newton on - -kim_style init LennardJones_Ar - -lattice fcc 4.4300 -Lattice spacing in x,y,z = 4.43 4.43 4.43 -region box block 0 ${xx} 0 ${yy} 0 ${zz} -region box block 0 20 0 ${yy} 0 ${zz} -region box block 0 20 0 20 0 ${zz} -region box block 0 20 0 20 0 20 -create_box 1 box -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 32000 atoms - create_atoms CPU = 0.00314307 secs - -#pair_style lj/cut 8.1500 -#pair_coeff 1 1 0.0104 3.4000 - -kim_style define Ar -pair_style kim LennardJones_Ar -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:980) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:985) -pair_coeff * * Ar - -mass 1 39.95 -velocity all create 200.0 232345 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve -#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 - -run 100 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair kim, perpetual - attributes: full, newton off, cut 8.45 - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 28.12 | 28.12 | 28.12 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 4.91804 on 1 procs for 100 steps with 32000 atoms - -Performance: 1.757 ns/day, 13.661 hours/ns, 20.333 timesteps/s -99.7% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 4.3033 | 4.3033 | 4.3033 | 0.0 | 87.50 -Neigh | 0.53176 | 0.53176 | 0.53176 | 0.0 | 10.81 -Comm | 0.024606 | 0.024606 | 0.024606 | 0.0 | 0.50 -Output | 0.00016403 | 0.00016403 | 0.00016403 | 0.0 | 0.00 -Modify | 0.038671 | 0.038671 | 0.038671 | 0.0 | 0.79 -Other | | 0.01951 | | | 0.40 - -Nlocal: 32000 ave 32000 max 32000 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 19911 ave 19911 max 19911 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 4.25375e+06 ave 4.25375e+06 max 4.25375e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 4253750 -Ave neighs/atom = 132.93 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:05 diff --git a/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 b/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 deleted file mode 100644 index 3377f22d02..0000000000 --- a/examples/kim/log.30Apr2019.kim.lj.simulator_model.g++.4 +++ /dev/null @@ -1,104 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task -# 3d Lennard-Jones melt -# -# This example requires that the example models provided with -# the kim-api package are installed. see the ./lib/kim/README or -# ./lib/kim/Install.py files for details on how to install these -# example models. -# - -variable x index 1 -variable y index 1 -variable z index 1 - -variable xx equal 20*$x -variable xx equal 20*1 -variable yy equal 20*$y -variable yy equal 20*1 -variable zz equal 20*$z -variable zz equal 20*1 - -units metal -atom_style atomic -newton on - -kim_style init LennardJones_Ar - -lattice fcc 4.4300 -Lattice spacing in x,y,z = 4.43 4.43 4.43 -region box block 0 ${xx} 0 ${yy} 0 ${zz} -region box block 0 20 0 ${yy} 0 ${zz} -region box block 0 20 0 20 0 ${zz} -region box block 0 20 0 20 0 20 -create_box 1 box -Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) - 1 by 2 by 2 MPI processor grid -create_atoms 1 box -Created 32000 atoms - create_atoms CPU = 0.0979962 secs - -#pair_style lj/cut 8.1500 -#pair_coeff 1 1 0.0104 3.4000 - -kim_style define Ar -pair_style kim LennardJones_Ar -WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (src/KIM/pair_kim.cpp:980) -WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (src/KIM/pair_kim.cpp:985) -pair_coeff * * Ar - -mass 1 39.95 -velocity all create 200.0 232345 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve -#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 - -run 100 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 8.45 - ghost atom cutoff = 8.45 - binsize = 4.225, bins = 21 21 21 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair kim, perpetual - attributes: full, newton off, cut 8.45 - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 9.789 | 9.789 | 9.789 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 200 6290.8194 0 7118.0584 129712.25 - 100 95.179725 6718.814 0 7112.496 133346.59 -Loop time of 6.29539 on 4 procs for 100 steps with 32000 atoms - -Performance: 1.372 ns/day, 17.487 hours/ns, 15.885 timesteps/s -48.4% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 1.9399 | 2.079 | 2.2181 | 9.1 | 33.02 -Neigh | 0.25924 | 0.26632 | 0.2692 | 0.8 | 4.23 -Comm | 2.5011 | 2.6605 | 2.751 | 5.9 | 42.26 -Output | 0.069904 | 0.07097 | 0.071545 | 0.3 | 1.13 -Modify | 0.011383 | 0.012206 | 0.01419 | 1.0 | 0.19 -Other | | 1.206 | | | 19.16 - -Nlocal: 8000 ave 8018 max 7967 min -Histogram: 1 0 0 0 0 0 1 0 0 2 -Nghost: 9131 ave 9164 max 9113 min -Histogram: 2 0 0 1 0 0 0 0 0 1 -Neighs: 0 ave 0 max 0 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -FullNghs: 1.06344e+06 ave 1.06594e+06 max 1.05881e+06 min -Histogram: 1 0 0 0 0 0 1 0 0 2 - -Total # of neighbors = 4253750 -Ave neighs/atom = 132.93 -Neighbor list builds = 3 -Dangerous builds = 0 -Total wall time: 0:00:07 diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index dc8d0544f6..85b865d03f 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -220,8 +220,9 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, url += qfunction; std::string query(arg[0]); - query += "&model="; + query += "&model=[\""; query += model_name; + query += "\"]"; for (int i=1; i < narg; ++i) { query += '&'; query += arg[i]; -- GitLab From fe83e4de2ec4acc6e5a190bac6dd597e52a1aab5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 16:00:01 -0400 Subject: [PATCH 328/469] revise logic and documentation of communication cutoff selection one more time --- doc/src/comm_modify.txt | 21 +++++++-------- src/comm.cpp | 59 ++++++++++++++++++++++++++++------------- 2 files changed, 50 insertions(+), 30 deletions(-) diff --git a/doc/src/comm_modify.txt b/doc/src/comm_modify.txt index d5f5aecf54..5f03636c1d 100644 --- a/doc/src/comm_modify.txt +++ b/doc/src/comm_modify.txt @@ -69,18 +69,15 @@ processors. By default the ghost cutoff = neighbor cutoff = pairwise force cutoff + neighbor skin. See the "neighbor"_neighbor.html command for more information about the skin distance. If the specified Rcut is greater than the neighbor cutoff, then extra ghost atoms will be acquired. -If the provided cutoff is smaller, the provided value will be ignored -and the ghost cutoff is set to the neighbor cutoff. Specifying a -cutoff value of 0.0 will reset any previous value to the default. -If bonded interactions exist and equilibrium bond length information is -available, then also a heuristic based on that bond length (2.0x {r_eq} -for systems with dihedrals or improper, 1.5x {r_eq} without) plus -neighbor skin is applied if the communication cutoff is set to its -default value of 0.0. This avoids problems for systems without a pair -style or where the non-bonded cutoff is (much) shorter than the largest -bond lengths. A warning message is printed, if a specified -communication cutoff > 0.0 is overridden or the bond length heuristics -lead to a larger communication cutoff. +If the provided cutoff is smaller, the provided value will be ignored, +the ghost cutoff is set to the neighbor cutoff and a warning will be +printed. Specifying a cutoff value of 0.0 will reset any previous value +to the default. If bonded interactions exist and equilibrium bond length +information is available, then also a heuristic based on that bond length +is computed. It is used as communication cutoff, if there is no pair +style present and no {comm_modify cutoff} command used. Otherwise a +warning is printed, if this bond based estimate is larger than the +communication cutoff used. A The {cutoff/multi} option is equivalent to {cutoff}, but applies to communication mode {multi} instead. Since in this case the communication diff --git a/src/comm.cpp b/src/comm.cpp index ae2715f0fd..303bd6a8cb 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -588,30 +588,42 @@ void Comm::set_proc_grid(int outflag) /* ---------------------------------------------------------------------- determine suitable communication cutoff. - use the larger of the user specified value and the cutoff required - by the neighborlist build for pair styles. - if bonded interactions exist, apply a heuristic based on the equilibrium - bond length (use 1.5x r_bond if no dihedral or improper style exists - otherwise 2x r_bond) plus neighbor list skin. - if no user specified communication cutoff is given include this - heuristic, otherwise ignore it. + this uses three inputs: 1) maximum neighborlist cutoff, 2) an estimate + based on bond lengths and bonded interaction styles present, and 3) a + user supplied communication cutoff. + the neighbor list cutoff (1) is *always* used, since it is a requirement + for neighborlists working correctly. the bond length based cutoff is + *only* used, if no pair style is defined and no user cutoff is provided. + otherwise, a warning is printed. if the bond length based estimate is + larger than what is used. print a warning, if a user specified communication cutoff is overridden. ------------------------------------------------------------------------- */ double Comm::get_comm_cutoff() { - double maxcommcutoff = 0.0; - double maxbondcutoff = 0.0; + double maxcommcutoff, maxbondcutoff = 0.0; if (force->bond) { int n = atom->nbondtypes; for (int i = 1; i <= n; ++i) maxbondcutoff = MAX(maxbondcutoff,force->bond->equilibrium_distance(i)); - if (force->dihedral || force->improper) { - maxbondcutoff *= 2.0; + // apply bond length based heuristics. + + if (force->newton_bond) { + if (force->dihedral || force->improper) { + maxbondcutoff *= 2.25; + } else { + maxbondcutoff *=1.5; + } } else { - maxbondcutoff *=1.5; + if (force->dihedral || force->improper) { + maxbondcutoff *= 3.125; + } else if (force->angle) { + maxbondcutoff *= 2.25; + } else { + maxbondcutoff *=1.5; + } } maxbondcutoff += neighbor->skin; } @@ -620,16 +632,27 @@ double Comm::get_comm_cutoff() maxcommcutoff = MAX(cutghostuser,neighbor->cutneighmax); - // consider cutoff estimate from bond length only if no user specified cutoff + // use cutoff estimate from bond length only if no user specified + // cutoff was given and no pair style present. Otherwise print a + // warning, if the estimated bond based cutoff is larger than what + // is currently used. - if (cutghostuser == 0.0) maxcommcutoff = MAX(maxcommcutoff,maxbondcutoff); + if (!force->pair && (cutghostuser == 0.0)) { + maxcommcutoff = MAX(maxcommcutoff,maxbondcutoff); + } else { + if ((me == 0) && (maxbondcutoff > maxcommcutoff)) { + char mesg[256]; + snprintf(mesg,256,"Communication cutoff %g is shorter than a bond " + "length based estimate of %g. This may lead to errors.", + maxcommcutoff,maxbondcutoff); + error->warning(FLERR,mesg); + } + } - // print warning if neighborlist cutoff overrides user cutoff or - // applied bond based cutoff is larger than neighbor cutoff. + // print warning if neighborlist cutoff overrides user cutoff if (me == 0) { - if ( ((cutghostuser > 0.0) && (maxcommcutoff > cutghostuser)) - || ((cutghostuser == 0.0) && (maxcommcutoff == maxbondcutoff)) ) { + if ((cutghostuser > 0.0) && (maxcommcutoff > cutghostuser)) { char mesg[128]; snprintf(mesg,128,"Communication cutoff adjusted to %g",maxcommcutoff); error->warning(FLERR,mesg); -- GitLab From 60dfa7daf81e056a126dc52e131295aafe97a3d1 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Thu, 25 Jul 2019 18:31:40 -0500 Subject: [PATCH 329/469] doc spelling update --- doc/src/Install_mac.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/Install_mac.txt b/doc/src/Install_mac.txt index e277f7e0e4..773c9ec93a 100644 --- a/doc/src/Install_mac.txt +++ b/doc/src/Install_mac.txt @@ -28,7 +28,7 @@ Lennard-Jones benchmark file: % brew test lammps -v :pre The LAMMPS binary is built with the "KIM package"_Build_extras#kim which -results in homebrew also installing the `kim-api` binaries when LAMMPS is +results in Homebrew also installing the `kim-api` binaries when LAMMPS is installed. In order to use potentials from "openkim.org"_openkim, you can install the `openkim-models` package -- GitLab From 52e175546420c04705ac101f58806a94f5705aba Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 25 Jul 2019 21:20:42 -0400 Subject: [PATCH 330/469] fix spelling errors and false positives --- doc/src/kim_commands.txt | 4 ++-- doc/utils/sphinx-config/false_positives.txt | 1 + 2 files changed, 3 insertions(+), 2 deletions(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index dd61f6f5cc..0bb7de03d6 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -282,7 +282,7 @@ keyword {fixed_types} for models that have a preset fixed mapping (i.e. the mapping between LAMMPS atom types and chemical species is defined by the model and cannot be changed). In the latter case, the user must consult the model documentation to see how many atom types there are and how they -map to the chemcial species. +map to the chemical species. For example, consider an OpenKIM IM that supports Si and C species. If the LAMMPS simulation has four atom types, where the first three are Si, @@ -488,7 +488,7 @@ The citation format for an IM is displayed on its page on "OpenKIM"_https://openkim.org along with the corresponding BibTex file, and is automatically added to the LAMMPS {log.cite} file. -Citing the IM software (KIM infrastucture and specific PM or SM codes) +Citing the IM software (KIM infrastructure and specific PM or SM codes) used in the simulation gives credit to the researchers who developed them and enables open source efforts like OpenKIM to function. diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index e383fddfa9..cf9b823ba3 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -884,6 +884,7 @@ Fogarty Foiles fopenmp forestgreen +formatarg formulae Forschungszentrum Fortran -- GitLab From 179b507107ce774f89e3b116697d974264013f1c Mon Sep 17 00:00:00 2001 From: Denis Taniguchi Date: Fri, 26 Jul 2019 10:55:27 +0100 Subject: [PATCH 331/469] Fixing bug in nve/kk when using rmass. --- src/KOKKOS/fix_nve_kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/fix_nve_kokkos.cpp b/src/KOKKOS/fix_nve_kokkos.cpp index 6db8ff8c0f..740e6ff54b 100644 --- a/src/KOKKOS/fix_nve_kokkos.cpp +++ b/src/KOKKOS/fix_nve_kokkos.cpp @@ -98,7 +98,7 @@ KOKKOS_INLINE_FUNCTION void FixNVEKokkos::initial_integrate_rmass_item(int i) const { if (mask[i] & groupbit) { - const double dtfm = dtf / rmass[type[i]]; + const double dtfm = dtf / rmass[i]; v(i,0) += dtfm * f(i,0); v(i,1) += dtfm * f(i,1); v(i,2) += dtfm * f(i,2); -- GitLab From 47689b4ad36198e7501d5bbd37419d658dce3c3f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 06:03:21 -0400 Subject: [PATCH 332/469] make include files independent of previously included headers. include them first in implementation files. this is to be compliant with upcoming definition of include file policy --- src/KIM/fix_store_kim.cpp | 2 +- src/KIM/fix_store_kim.h | 1 - src/KIM/kim_init.cpp | 2 +- src/KIM/kim_init.h | 1 + src/KIM/kim_interactions.cpp | 2 +- src/KIM/kim_interactions.h | 1 + src/KIM/kim_query.cpp | 2 +- src/KIM/pair_kim.cpp | 2 +- 8 files changed, 7 insertions(+), 6 deletions(-) diff --git a/src/KIM/fix_store_kim.cpp b/src/KIM/fix_store_kim.cpp index 1bd924bcfb..16d606d2ed 100644 --- a/src/KIM/fix_store_kim.cpp +++ b/src/KIM/fix_store_kim.cpp @@ -54,8 +54,8 @@ Designed for use with the kim-api-2.0.2 (and newer) package ------------------------------------------------------------------------- */ -#include #include "fix_store_kim.h" +#include extern "C" { #include "KIM_SimulatorModel.h" } diff --git a/src/KIM/fix_store_kim.h b/src/KIM/fix_store_kim.h index 655be83ad0..6baf480993 100644 --- a/src/KIM/fix_store_kim.h +++ b/src/KIM/fix_store_kim.h @@ -63,7 +63,6 @@ FixStyle(STORE/KIM,FixStoreKIM) #ifndef LMP_FIX_STORE_KIM_H #define LMP_FIX_STORE_KIM_H -#include #include "fix.h" namespace LAMMPS_NS { diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 83638f3428..bae286aff6 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -55,11 +55,11 @@ Designed for use with the kim-api-2.1.0 (and newer) package ------------------------------------------------------------------------- */ +#include "kim_init.h" #include #include #include #include -#include "kim_init.h" #include "error.h" #include "atom.h" #include "comm.h" diff --git a/src/KIM/kim_init.h b/src/KIM/kim_init.h index 7c7a24615b..2b5dc520c7 100644 --- a/src/KIM/kim_init.h +++ b/src/KIM/kim_init.h @@ -65,6 +65,7 @@ CommandStyle(kim_init,KimInit) #define LMP_KIM_INIT_H #include "pointers.h" +#include namespace LAMMPS_NS { diff --git a/src/KIM/kim_interactions.cpp b/src/KIM/kim_interactions.cpp index d0fbb809d2..449b6bcb13 100644 --- a/src/KIM/kim_interactions.cpp +++ b/src/KIM/kim_interactions.cpp @@ -55,10 +55,10 @@ Designed for use with the kim-api-2.1.0 (and newer) package ------------------------------------------------------------------------- */ +#include "kim_interactions.h" #include #include #include -#include "kim_interactions.h" #include "error.h" #include "atom.h" #include "comm.h" diff --git a/src/KIM/kim_interactions.h b/src/KIM/kim_interactions.h index 6da1880f84..8172004d53 100644 --- a/src/KIM/kim_interactions.h +++ b/src/KIM/kim_interactions.h @@ -65,6 +65,7 @@ CommandStyle(kim_interactions,KimInteractions) #define LMP_KIM_INTERACTIONS_H #include "pointers.h" +#include namespace LAMMPS_NS { diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index 85b865d03f..6688ed6690 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -54,11 +54,11 @@ Designed for use with the kim-api-2.1.0 (and newer) package ------------------------------------------------------------------------- */ +#include "kim_query.h" #include #include #include #include -#include "kim_query.h" #include "comm.h" #include "error.h" #include "input.h" diff --git a/src/KIM/pair_kim.cpp b/src/KIM/pair_kim.cpp index 50eef1de2b..74b92a3e2b 100644 --- a/src/KIM/pair_kim.cpp +++ b/src/KIM/pair_kim.cpp @@ -53,13 +53,13 @@ /* ---------------------------------------------------------------------- Designed for use with the kim-api-2.0.2 (and newer) package ------------------------------------------------------------------------- */ +#include "pair_kim.h" #include #include #include // includes from LAMMPS -#include "pair_kim.h" #include "atom.h" #include "comm.h" #include "universe.h" -- GitLab From e8d891c0ddb78c5be220fb9ccdcdbba1fa24509f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 06:06:03 -0400 Subject: [PATCH 333/469] simplify installation of data folders and make it consistent fixes #1586 --- cmake/CMakeLists.txt | 8 +++----- 1 file changed, 3 insertions(+), 5 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 0f99cc6274..7cd7b62c91 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -551,11 +551,9 @@ include(Documentation) ############################################################################### # Install potential and force field files in data directory ############################################################################### -set(LAMMPS_INSTALL_POTENTIALS_DIR ${CMAKE_INSTALL_FULL_DATADIR}/lammps/potentials) -install(DIRECTORY ${LAMMPS_POTENTIALS_DIR} DESTINATION ${LAMMPS_INSTALL_POTENTIALS_DIR}) - -set(LAMMPS_INSTALL_FRC_FILES_DIR ${CMAKE_INSTALL_FULL_DATADIR}/lammps/frc_files) -install(DIRECTORY ${LAMMPS_TOOLS_DIR}/msi2lmp/frc_files/ DESTINATION ${LAMMPS_INSTALL_FRC_FILES_DIR}) +set(LAMMPS_INSTALL_DATADIR ${CMAKE_INSTALL_FULL_DATADIR}/lammps) +install(DIRECTORY ${LAMMPS_POTENTIALS_DIR} DESTINATION ${LAMMPS_INSTALL_DATADIR}) +install(DIRECTORY ${LAMMPS_TOOLS_DIR}/msi2lmp/frc_files DESTINATION ${LAMMPS_INSTALL_DATADIR}) configure_file(etc/profile.d/lammps.sh.in ${CMAKE_BINARY_DIR}/etc/profile.d/lammps.sh @ONLY) configure_file(etc/profile.d/lammps.csh.in ${CMAKE_BINARY_DIR}/etc/profile.d/lammps.csh @ONLY) -- GitLab From ca1fece850217324c5566f96dbd54d3d8ab66dca Mon Sep 17 00:00:00 2001 From: Denis Taniguchi Date: Fri, 26 Jul 2019 12:46:04 +0100 Subject: [PATCH 334/469] Fixing remaining wrong indexing of rmass in nve/kk. --- src/KOKKOS/fix_nve_kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/fix_nve_kokkos.cpp b/src/KOKKOS/fix_nve_kokkos.cpp index 740e6ff54b..ca7f728370 100644 --- a/src/KOKKOS/fix_nve_kokkos.cpp +++ b/src/KOKKOS/fix_nve_kokkos.cpp @@ -154,7 +154,7 @@ KOKKOS_INLINE_FUNCTION void FixNVEKokkos::final_integrate_rmass_item(int i) const { if (mask[i] & groupbit) { - const double dtfm = dtf / rmass[type[i]]; + const double dtfm = dtf / rmass[i]; v(i,0) += dtfm * f(i,0); v(i,1) += dtfm * f(i,1); v(i,2) += dtfm * f(i,2); -- GitLab From 8d4f1896994e50d7f66ab1f66a7bf8bd306f48e0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 09:38:32 -0400 Subject: [PATCH 335/469] Revert "new versions of jacobi() method" This reverts commit 39315268e885fba886a0ff30eccc619ffaa64c5f. --- src/math_extra.cpp | 229 ++++++++++++--------------------------------- src/math_extra.h | 9 +- 2 files changed, 63 insertions(+), 175 deletions(-) diff --git a/src/math_extra.cpp b/src/math_extra.cpp index 4184e84b59..797d210d0e 100644 --- a/src/math_extra.cpp +++ b/src/math_extra.cpp @@ -13,7 +13,6 @@ /* ---------------------------------------------------------------------- Contributing author: Mike Brown (SNL) - Arno Mayrhofer (DCS Computing), jacobi() functions ------------------------------------------------------------------------- */ #include "math_extra.h" @@ -96,189 +95,83 @@ int mldivide3(const double m[3][3], const double *v, double *ans) /* ---------------------------------------------------------------------- compute evalues and evectors of 3x3 real symmetric matrix based on Jacobi rotations - two variants for passing in matrix - - procedure jacobi(S ∈ Rn×n; out e ∈ Rn; out E ∈ Rn×n) - var - i, k, l, m, state ∈ N - s, c, t, p, y, d, r ∈ R - ind ∈ Nn - changed ∈ Ln - ! init e, E, and arrays ind, changed - E := I; state := n - for k := 1 to n do indk := maxind(k); ek := Skk; changedk := true endfor - while state≠0 do ! next rotation - m := 1 ! find index (k,l) of pivot p - for k := 2 to n−1 do - if │Sk indk│ > │Sm indm│ then m := k endif - endfor - k := m; l := indm; p := Skl - ! calculate c = cos φ, s = sin φ - y := (el−ek)/2; d := │y│+√(p2+y2) - r := √(p2+d2); c := d/r; s := p/r; t := p2/d - if y<0 then s := −s; t := −t endif - Skl := 0.0; update(k,−t); update(l,t) - ! rotate rows and columns k and l - for i := 1 to k−1 do rotate(i,k,i,l) endfor - for i := k+1 to l−1 do rotate(k,i,i,l) endfor - for i := l+1 to n do rotate(k,i,l,i) endfor - ! rotate eigenvectors - for i := 1 to n do - ┌ ┐ ┌ ┐┌ ┐ - │Eik│ │c −s││Eik│ - │ │ := │ ││ │ - │Eil│ │s c││Eil│ - └ ┘ └ ┘└ ┘ - endfor - ! rows k, l have changed, update rows indk, indl - indk := maxind(k); indl := maxind(l) - loop - endproc + adapted from Numerical Recipes jacobi() function ------------------------------------------------------------------------- */ int jacobi(double matrix[3][3], double *evalues, double evectors[3][3]) { - evectors[0][0] = 1.0; evectors[0][1] = 0.0; evectors[0][2] = 0.0; - evectors[1][0] = 0.0; evectors[1][1] = 1.0; evectors[1][2] = 0.0; - evectors[2][0] = 0.0; evectors[2][1] = 0.0; evectors[2][2] = 1.0; - evalues[0] = 0.0; evalues[1] = 0.0; evalues[2] = 0.0; - double threshold = 0.0; - - for (int i = 0; i < 3; i++) - for (int j = i; j < 3; j++) - threshold += fabs(matrix[i][j]); - - if (threshold < 1.0e-200) return 0; - threshold *= 1.0e-12; - int state = 2; - bool changed[3] = {true, true, true}; - - int iteration = 0; - while (state > 0 && iteration < MAXJACOBI) { - for (int k = 0; k < 2; k++) { - for (int l = k+1; l < 3; l++) { - const double p = matrix[k][l]; - const double y = (matrix[l][l]-matrix[k][k])*0.5; - const double d = fabs(y)+sqrt(p*p + y*y); - const double r = sqrt(p*p + d*d); - const double c = r > threshold ? d/r : 1.0; - double s = r > threshold ? p/r : 0.0; - double t = d > threshold ? p*p/d : 0.0; - if (y < 0.0) { - s *= -1.0; - t *= -1.0; - } - matrix[k][l] = 0.0; - update_eigenvalue(matrix[k][k], changed[k], state, -t, threshold); - update_eigenvalue(matrix[l][l], changed[l], state, t, threshold); - for (int i = 0; i < k; i++) - rotate(matrix[i][k], matrix[i][l],c,s); - for (int i = k+1; i < l; i++) - rotate(matrix[k][i], matrix[i][l],c,s); - for (int i = l+1; i < 3; i++) - rotate(matrix[k][i], matrix[l][i],c,s); - for (int i = 0; i < 3; i++) - rotate(evectors[i][k], evectors[i][l],c,s); - } - } - iteration++; - } - - for (int i = 0; i < 3; i++) - evalues[i] = matrix[i][i]; + int i,j,k; + double tresh,theta,tau,t,sm,s,h,g,c,b[3],z[3]; - if (iteration == MAXJACOBI) return 1; - return 0; -} + for (i = 0; i < 3; i++) { + for (j = 0; j < 3; j++) evectors[i][j] = 0.0; + evectors[i][i] = 1.0; + } + for (i = 0; i < 3; i++) { + b[i] = evalues[i] = matrix[i][i]; + z[i] = 0.0; + } -int jacobi(double **matrix, double *evalues, double **evectors) -{ - evectors[0][0] = 1.0; evectors[0][1] = 0.0; evectors[0][2] = 0.0; - evectors[1][0] = 0.0; evectors[1][1] = 1.0; evectors[1][2] = 0.0; - evectors[2][0] = 0.0; evectors[2][1] = 0.0; evectors[2][2] = 1.0; - evalues[0] = 0.0; evalues[1] = 0.0; evalues[2] = 0.0; - double threshold = 0.0; - - for (int i = 0; i < 3; i++) - for (int j = i; j < 3; j++) - threshold += fabs(matrix[i][j]); - - if (threshold < 1.0e-200) return 0; - threshold *= 1.0e-12; - int state = 2; - bool changed[3] = {true, true, true}; - - int iteration = 0; - while (state > 0 && iteration < MAXJACOBI) { - for (int k = 0; k < 2; k++) { - for (int l = k+1; l < 3; l++) { - const double p = matrix[k][l]; - const double y = (matrix[l][l]-matrix[k][k])*0.5; - const double d = fabs(y)+sqrt(p*p + y*y); - const double r = sqrt(p*p + d*d); - const double c = r > threshold ? d/r : 1.0; - double s = r > threshold ? p/r : 0.0; - double t = d > threshold ? p*p/d : 0.0; - if (y < 0.0) { - s *= -1.0; - t *= -1.0; + for (int iter = 1; iter <= MAXJACOBI; iter++) { + sm = 0.0; + for (i = 0; i < 2; i++) + for (j = i+1; j < 3; j++) + sm += fabs(matrix[i][j]); + if (sm == 0.0) return 0; + + if (iter < 4) tresh = 0.2*sm/(3*3); + else tresh = 0.0; + + for (i = 0; i < 2; i++) { + for (j = i+1; j < 3; j++) { + g = 100.0*fabs(matrix[i][j]); + if (iter > 4 && fabs(evalues[i])+g == fabs(evalues[i]) + && fabs(evalues[j])+g == fabs(evalues[j])) + matrix[i][j] = 0.0; + else if (fabs(matrix[i][j]) > tresh) { + h = evalues[j]-evalues[i]; + if (fabs(h)+g == fabs(h)) t = (matrix[i][j])/h; + else { + theta = 0.5*h/(matrix[i][j]); + t = 1.0/(fabs(theta)+sqrt(1.0+theta*theta)); + if (theta < 0.0) t = -t; + } + c = 1.0/sqrt(1.0+t*t); + s = t*c; + tau = s/(1.0+c); + h = t*matrix[i][j]; + z[i] -= h; + z[j] += h; + evalues[i] -= h; + evalues[j] += h; + matrix[i][j] = 0.0; + for (k = 0; k < i; k++) rotate(matrix,k,i,k,j,s,tau); + for (k = i+1; k < j; k++) rotate(matrix,i,k,k,j,s,tau); + for (k = j+1; k < 3; k++) rotate(matrix,i,k,j,k,s,tau); + for (k = 0; k < 3; k++) rotate(evectors,k,i,k,j,s,tau); } - matrix[k][l] = 0.0; - update_eigenvalue(matrix[k][k], changed[k], state, -t, threshold); - update_eigenvalue(matrix[l][l], changed[l], state, t, threshold); - for (int i = 0; i < k; i++) - rotate(matrix[i][k], matrix[i][l],c,s); - for (int i = k+1; i < l; i++) - rotate(matrix[k][i], matrix[i][l],c,s); - for (int i = l+1; i < 3; i++) - rotate(matrix[k][i], matrix[l][i],c,s); - for (int i = 0; i < 3; i++) - rotate(evectors[i][k], evectors[i][l],c,s); } } - iteration++; - } - for (int i = 0; i < 3; i++) - evalues[i] = matrix[i][i]; - - if (iteration == MAXJACOBI) return 1; - return 0; -} - -/* ---------------------------------------------------------------------- - perform a single Jacobi rotation of Sij, Skl - ┌ ┐ ┌ ┐┌ ┐ - │Skl│ │c −s││Skl│ - │ │ := │ ││ │ - │Sij│ │s c││Sij│ - └ ┘ └ ┘└ ┘ -------------------------------------------------------------------------- */ - -void rotate(double &matrix_kl, double &matrix_ij, - const double c, const double s) -{ - const double tmp_kl = matrix_kl; - matrix_kl = c*matrix_kl - s*matrix_ij; - matrix_ij = s*tmp_kl + c*matrix_ij; + for (i = 0; i < 3; i++) { + evalues[i] = b[i] += z[i]; + z[i] = 0.0; + } + } + return 1; } /* ---------------------------------------------------------------------- - update eigenvalue and its status + perform a single Jacobi rotation ------------------------------------------------------------------------- */ -void update_eigenvalue(double &eigenvalue, bool &changed, int &state, - const double t, const double threshold) +void rotate(double matrix[3][3], int i, int j, int k, int l, + double s, double tau) { - eigenvalue += t; - - if (changed && fabs(t) < threshold) { - changed = false; - state--; - } else if (!changed && fabs(t) > threshold) { - changed = true; - state++; - } + double g = matrix[i][j]; + double h = matrix[k][l]; + matrix[i][j] = g-s*(h+g*tau); + matrix[k][l] = h+s*(g-h*tau); } /* ---------------------------------------------------------------------- diff --git a/src/math_extra.h b/src/math_extra.h index ad8105d271..09b135c641 100644 --- a/src/math_extra.h +++ b/src/math_extra.h @@ -74,14 +74,9 @@ namespace MathExtra { void write3(const double mat[3][3]); int mldivide3(const double mat[3][3], const double *vec, double *ans); - int jacobi(double matrix[3][3], double *evalues, double evectors[3][3]); - int jacobi(double **matrix, double *evalues, double **evectors); - void rotate(double &matrix_kl, double &matrix_ij, - const double c, const double s); - void update_eigenvalue(double &eigenvalue, bool &changed, int &state, - const double t, const double threshold); - + void rotate(double matrix[3][3], int i, int j, int k, int l, + double s, double tau); void richardson(double *q, double *m, double *w, double *moments, double dtq); void no_squish_rotate(int k, double *p, double *q, double *inertia, double dt); -- GitLab From 0bb9df76c2d132e66e79f482432ac2f33ec9781e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 09:58:18 -0400 Subject: [PATCH 336/469] correct shell profile variables to point to the installation directory --- cmake/etc/profile.d/lammps.csh.in | 4 ++-- cmake/etc/profile.d/lammps.sh.in | 4 ++-- 2 files changed, 4 insertions(+), 4 deletions(-) diff --git a/cmake/etc/profile.d/lammps.csh.in b/cmake/etc/profile.d/lammps.csh.in index 42f222d67c..1c13583914 100644 --- a/cmake/etc/profile.d/lammps.csh.in +++ b/cmake/etc/profile.d/lammps.csh.in @@ -1,4 +1,4 @@ # set environment for LAMMPS and msi2lmp executables # to find potential and force field files -if ( "$?LAMMPS_POTENTIALS" == 0 ) setenv LAMMPS_POTENTIALS @LAMMPS_POTENTIALS_DIR@ -if ( "$?MSI2LMP_LIBRARY" == 0 ) setenv MSI2LMP_LIBRARY @LAMMPS_FRC_FILES_DIR@ +if ( "$?LAMMPS_POTENTIALS" == 0 ) setenv LAMMPS_POTENTIALS @LAMMPS_INSTALL_DATADIR@/potentials +if ( "$?MSI2LMP_LIBRARY" == 0 ) setenv MSI2LMP_LIBRARY @LAMMPS_INSTALL_DATADIR@/frc_files diff --git a/cmake/etc/profile.d/lammps.sh.in b/cmake/etc/profile.d/lammps.sh.in index c1967cb5b2..1542a8982f 100644 --- a/cmake/etc/profile.d/lammps.sh.in +++ b/cmake/etc/profile.d/lammps.sh.in @@ -1,5 +1,5 @@ # set environment for LAMMPS and msi2lmp executables # to find potential and force field files -LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS-@LAMMPS_POTENTIALS_DIR@} -MSI2LMP_LIBRARY=${MSI2LMP_LIBRARY-@LAMMPS_FRC_FILES_DIR@} +LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS-@LAMMPS_INSTALL_DATADIR@/potentials} +MSI2LMP_LIBRARY=${MSI2LMP_LIBRARY-@LAMMPS_INSTALL_DATADIR@/frc_files} export LAMMPS_POTENTIALS MSI2LMP_LIBRARY -- GitLab From 010cb0edf304035fafd16b7870dce1a4b05fc7b9 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Fri, 26 Jul 2019 11:10:54 -0500 Subject: [PATCH 337/469] Add warning to cmake if PKG_KIM=ON but DOWNLOAD_KIM not set & KIM is not found This can be a scenario where the user has KIM installed but does not have the environment setup correctly to be found. The config. step should provide some warning of this. Otherwise, it is easy to miss the fact that KIM is being downloaded and built. --- cmake/Modules/Packages/KIM.cmake | 1 + 1 file changed, 1 insertion(+) diff --git a/cmake/Modules/Packages/KIM.cmake b/cmake/Modules/Packages/KIM.cmake index 1a9dcf83a4..5987ebbf0a 100644 --- a/cmake/Modules/Packages/KIM.cmake +++ b/cmake/Modules/Packages/KIM.cmake @@ -9,6 +9,7 @@ if(PKG_KIM) if(KIM-API_FOUND) set(DOWNLOAD_KIM_DEFAULT OFF) else() + message(WARNING "KIM-API package not found. We will download and build our own") set(DOWNLOAD_KIM_DEFAULT ON) endif() option(DOWNLOAD_KIM "Download KIM-API from OpenKIM instead of using an already installed one" ${DOWNLOAD_KIM_DEFAULT}) -- GitLab From 6a5902ec489b49386cf21b9d6fdc5487baa00f33 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Fri, 26 Jul 2019 11:14:46 -0500 Subject: [PATCH 338/469] Update kim_init to use KIM::Collections::GetItemType() A bit of a cleaner solution. Should be no visible change for users. --- src/KIM/kim_init.cpp | 106 +++++++++++++++++++++++++------------------ 1 file changed, 63 insertions(+), 43 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index bae286aff6..954a4b0f2c 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -164,21 +164,39 @@ void KimInit::determine_model_type_and_units(char * model_name, KIM_TemperatureUnit temperatureUnit; KIM_TimeUnit timeUnit; int units_accepted; - KIM_Model * kim_MO; - - get_kim_unit_names(user_units, lengthUnit, energyUnit, - chargeUnit, temperatureUnit, timeUnit, error); - int kim_error = KIM_Model_Create(KIM_NUMBERING_zeroBased, - lengthUnit, - energyUnit, - chargeUnit, - temperatureUnit, - timeUnit, - model_name, - &units_accepted, - &kim_MO); - - if (!kim_error) { // model is an MO + KIM_Collections * kim_Coll; + KIM_CollectionItemType itemType; + + int kim_error = KIM_Collections_Create(&kim_Coll); + if (kim_error) { + error->all(FLERR,"Unable to access KIM Collections to find Model."); + } + + kim_error = KIM_Collections_GetItemType(kim_Coll, model_name, &itemType); + if (kim_error) { + error->all(FLERR,"KIM Model name not found."); + } + KIM_Collections_Destroy(&kim_Coll); + + if (KIM_CollectionItemType_Equal(itemType, + KIM_COLLECTION_ITEM_TYPE_portableModel)) + { + get_kim_unit_names(user_units, lengthUnit, energyUnit, + chargeUnit, temperatureUnit, timeUnit, error); + KIM_Model * kim_MO; + int kim_error = KIM_Model_Create(KIM_NUMBERING_zeroBased, + lengthUnit, + energyUnit, + chargeUnit, + temperatureUnit, + timeUnit, + model_name, + &units_accepted, + &kim_MO); + + if (kim_error) + error->all(FLERR,"Unable to load KIM Simulator Model."); + model_type = MO; KIM_Model_Destroy(&kim_MO); @@ -213,37 +231,39 @@ void KimInit::determine_model_type_and_units(char * model_name, error->all(FLERR,"KIM Model does not support the requested unit system"); } } + else if (KIM_CollectionItemType_Equal( + itemType, KIM_COLLECTION_ITEM_TYPE_simulatorModel)) { + KIM_SimulatorModel * kim_SM; + kim_error = KIM_SimulatorModel_Create(model_name, &kim_SM); + if (kim_error) + error->all(FLERR,"Unable to load KIM Simulator Model."); + model_type = SM; + + int sim_fields; + int sim_lines; + char const * sim_field; + char const * sim_value; + KIM_SimulatorModel_GetNumberOfSimulatorFields(kim_SM, &sim_fields); + KIM_SimulatorModel_CloseTemplateMap(kim_SM); + for (int i=0; i < sim_fields; ++i) { + KIM_SimulatorModel_GetSimulatorFieldMetadata( + kim_SM,i,&sim_lines,&sim_field); - KIM_SimulatorModel * kim_SM; - kim_error = KIM_SimulatorModel_Create(model_name, &kim_SM); - if (kim_error) - error->all(FLERR,"KIM model name not found"); - model_type = SM; - - int sim_fields; - int sim_lines; - char const * sim_field; - char const * sim_value; - KIM_SimulatorModel_GetNumberOfSimulatorFields(kim_SM, &sim_fields); - KIM_SimulatorModel_CloseTemplateMap(kim_SM); - for (int i=0; i < sim_fields; ++i) { - KIM_SimulatorModel_GetSimulatorFieldMetadata( - kim_SM,i,&sim_lines,&sim_field); - - if (0 == strcmp(sim_field,"units")) { - KIM_SimulatorModel_GetSimulatorFieldLine(kim_SM,i,0,&sim_value); - int len=strlen(sim_value)+1; - *model_units = new char[len]; strcpy(*model_units,sim_value); - break; + if (0 == strcmp(sim_field,"units")) { + KIM_SimulatorModel_GetSimulatorFieldLine(kim_SM,i,0,&sim_value); + int len=strlen(sim_value)+1; + *model_units = new char[len]; strcpy(*model_units,sim_value); + break; + } } - } - KIM_SimulatorModel_Destroy(&kim_SM); + KIM_SimulatorModel_Destroy(&kim_SM); - if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) { - std::string mesg("Incompatible units for KIM Simulator Model, " - "required units = "); - mesg += *model_units; - error->all(FLERR,mesg.c_str()); + if ((! unit_conversion_mode) && (strcmp(*model_units, user_units)!=0)) { + std::string mesg("Incompatible units for KIM Simulator Model, " + "required units = "); + mesg += *model_units; + error->all(FLERR,mesg.c_str()); + } } } -- GitLab From 17d6b317a77033dddd21cc3e259738b9359515bf Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 26 Jul 2019 10:37:22 -0600 Subject: [PATCH 339/469] Better workaround for Spectrum MPI --- src/KOKKOS/kokkos.cpp | 42 +++++++++++++++++++++++++++++++----------- 1 file changed, 31 insertions(+), 11 deletions(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index f6ab8f5916..6f6602b947 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -38,11 +38,7 @@ // OpenMPI supports detecting CUDA-aware MPI as of version 2.0.0 -// IBM Spectrum MPI looks like OpenMPI but defines MPIX_CUDA_AWARE_SUPPORT=0 -// even when CUDA-aware MPI is available, and also has a runtime option -// to turn CUDA-aware MPI on/off, so support is unknown - -#if (OPEN_MPI) && !(defined SPECTRUM_MPI) +#if (OPEN_MPI) #if (OMPI_MAJOR_VERSION >= 2) #include @@ -211,7 +207,30 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) int nmpi = 0; MPI_Comm_size(world,&nmpi); if (nmpi > 0) { - if (have_cuda_aware == 0) { + + // Check for IBM Spectrum MPI + + int len; + char mpi_version[MPI_MAX_LIBRARY_VERSION_STRING]; + MPI_Get_library_version(mpi_version, &len); + if (strstr(&mpi_version[0], "Spectrum") != NULL) { + int gpu_flag = 0; + char* str; + if (str = getenv("OMPI_MCA_pml_pami_enable_cuda")) { + if(!(strcmp(str,"1") == 0)) { + cuda_aware_flag = 1; + gpu_flag = 1; + } + } + + if (!gpu_flag) { + if (me == 0) + error->warning(FLERR,"The Spectrum MPI '-gpu' flag is not set. Disabling CUDA-aware MPI"); + cuda_aware_flag = 0; + } + } + + if (cuda_aware_flag == 1 && have_cuda_aware == 0) { if (me == 0) error->warning(FLERR,"Turning off CUDA-aware MPI since it is not detected, " "use '-pk kokkos cuda/aware on' to override"); @@ -220,7 +239,12 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) // MVAPICH2 #if (defined MPICH) && (defined MVAPICH2_VERSION) char* str; - if (!(str = getenv("MV2_ENABLE_CUDA") && (!(strcmp(str,"1") == 0))) { + int gpu_flag = 0; + if (str = getenv("MV2_ENABLE_CUDA") + if (!(strcmp(str,"1") == 0)) + gpu_flag = 1; + + if (!gpu_flag) { if (me == 0) error->warning(FLERR,"MVAPICH2 'MV2_ENABLE_CUDA' environment variable is not set. Disabling CUDA-aware MPI"); cuda_aware_flag = 0; @@ -230,10 +254,6 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) if (me == 0) error->warning(FLERR,"Detected MPICH. Disabling CUDA-aware MPI"); cuda_aware_flag = 0; -#elif (defined SPECTRUM_MPI) - if (me == 0) - error->warning(FLERR,"Must use the '-gpu' flag with Spectrum MPI to enable " - "CUDA-aware MPI support"); #else if (me == 0) error->warning(FLERR,"Kokkos with CUDA assumes CUDA-aware MPI is available," -- GitLab From 0ba854b4ab28866387977419134c6afaea57e36d Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 26 Jul 2019 11:23:46 -0600 Subject: [PATCH 340/469] Add MPI_Get_library_version to STUBS library --- src/STUBS/mpi.c | 17 +++++++++++++++++ src/STUBS/mpi.h | 2 ++ 2 files changed, 19 insertions(+) diff --git a/src/STUBS/mpi.c b/src/STUBS/mpi.c index af7a489bb1..c104a0ad7c 100644 --- a/src/STUBS/mpi.c +++ b/src/STUBS/mpi.c @@ -76,6 +76,23 @@ int MPI_Finalized(int *flag) /* ---------------------------------------------------------------------- */ +/* return "LAMMPS MPI STUBS" as name of the library */ + +int MPI_Get_library_version(char *verison, int *resultlen) +{ + const char string[] = "LAMMPS MPI STUBS"; + int len; + + if (!version || !resultlen) return MPI_ERR_ARG; + + len = strlen(string); + memcpy(version,string,len+1); + *resultlen = len; + return MPI_SUCCESS; +} + +/* ---------------------------------------------------------------------- */ + /* return "localhost" as name of the processor */ int MPI_Get_processor_name(char *name, int *resultlen) diff --git a/src/STUBS/mpi.h b/src/STUBS/mpi.h index 1eca1ec527..063dc542be 100644 --- a/src/STUBS/mpi.h +++ b/src/STUBS/mpi.h @@ -63,6 +63,7 @@ extern "C" { #define MPI_IN_PLACE NULL #define MPI_MAX_PROCESSOR_NAME 128 +#define MPI_MAX_LIBRARY_VERSION_STRING 128 typedef void MPI_User_function(void *invec, void *inoutvec, int *len, MPI_Datatype *datatype); @@ -79,6 +80,7 @@ typedef struct _MPI_Status MPI_Status; int MPI_Init(int *argc, char ***argv); int MPI_Initialized(int *flag); int MPI_Finalized(int *flag); +int MPI_Get_library_version(char *version, int *resultlen); int MPI_Get_processor_name(char *name, int *resultlen); int MPI_Get_version(int *major, int *minor); -- GitLab From e816f0e7a6e74e828a7d8cb9be1d16d2f01b211b Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 26 Jul 2019 11:24:15 -0600 Subject: [PATCH 341/469] Cleanup of CUDA-aware MPI code --- src/KOKKOS/kokkos.cpp | 23 +++++++++-------------- src/MAKE/MACHINES/Makefile.lassen_kokkos | 2 +- 2 files changed, 10 insertions(+), 15 deletions(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 6f6602b947..18a4a3168f 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -214,20 +214,17 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) char mpi_version[MPI_MAX_LIBRARY_VERSION_STRING]; MPI_Get_library_version(mpi_version, &len); if (strstr(&mpi_version[0], "Spectrum") != NULL) { - int gpu_flag = 0; + cuda_aware_flag = 0; char* str; - if (str = getenv("OMPI_MCA_pml_pami_enable_cuda")) { - if(!(strcmp(str,"1") == 0)) { + if (str = getenv("OMPI_MCA_pml_pami_enable_cuda")) + if((strcmp(str,"1") == 0)) { + have_cuda_aware = 1; cuda_aware_flag = 1; - gpu_flag = 1; } - } - if (!gpu_flag) { + if (!cuda_aware_flag) if (me == 0) error->warning(FLERR,"The Spectrum MPI '-gpu' flag is not set. Disabling CUDA-aware MPI"); - cuda_aware_flag = 0; - } } if (cuda_aware_flag == 1 && have_cuda_aware == 0) { @@ -239,16 +236,14 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) // MVAPICH2 #if (defined MPICH) && (defined MVAPICH2_VERSION) char* str; - int gpu_flag = 0; + cuda_aware_flag = 0; if (str = getenv("MV2_ENABLE_CUDA") - if (!(strcmp(str,"1") == 0)) - gpu_flag = 1; + if ((strcmp(str,"1") == 0)) + cuda_aware_flag = 1; - if (!gpu_flag) { + if (!cuda_aware_flag) if (me == 0) error->warning(FLERR,"MVAPICH2 'MV2_ENABLE_CUDA' environment variable is not set. Disabling CUDA-aware MPI"); - cuda_aware_flag = 0; - } // pure MPICH or some unsupported MPICH derivative #elif (defined MPICH) && !(defined MVAPICH2_VERSION) if (me == 0) diff --git a/src/MAKE/MACHINES/Makefile.lassen_kokkos b/src/MAKE/MACHINES/Makefile.lassen_kokkos index 669e599e3c..23697bfea2 100644 --- a/src/MAKE/MACHINES/Makefile.lassen_kokkos +++ b/src/MAKE/MACHINES/Makefile.lassen_kokkos @@ -44,7 +44,7 @@ LMP_INC = -DLAMMPS_GZIP # PATH = path for MPI library # LIB = name of MPI library -MPI_INC = -DSPECTRUM_MPI -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX=1 -I/usr/tce/packages/spectrum-mpi/spectrum-mpi-rolling-release-gcc-7.3.1/include +MPI_INC = -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX=1 -I/usr/tce/packages/spectrum-mpi/spectrum-mpi-rolling-release-gcc-7.3.1/include MPI_PATH = MPI_LIB = -L/usr/tce/packages/spectrum-mpi/spectrum-mpi-rolling-release-gcc-7.3.1/lib -lmpi_ibm -- GitLab From f2dbe186ca2ce3846a8e7a9abc3c533acf791e1a Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 26 Jul 2019 11:45:50 -0600 Subject: [PATCH 342/469] Fix typo --- src/STUBS/mpi.c | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/STUBS/mpi.c b/src/STUBS/mpi.c index c104a0ad7c..cd92750b9a 100644 --- a/src/STUBS/mpi.c +++ b/src/STUBS/mpi.c @@ -78,7 +78,7 @@ int MPI_Finalized(int *flag) /* return "LAMMPS MPI STUBS" as name of the library */ -int MPI_Get_library_version(char *verison, int *resultlen) +int MPI_Get_library_version(char *version, int *resultlen) { const char string[] = "LAMMPS MPI STUBS"; int len; -- GitLab From a5a1e27fb1d0692dcb7bf8b4a5bc25810a943719 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 15:42:34 -0400 Subject: [PATCH 343/469] refactor commands in the STUBS folder for 'make serial' and 'make clean-serial' make so that for the "serial" make target we not only automatically build the STUBS library, if it is missing, but also update its compilation when there are changes and remove it on the "clean-serial" target. --- src/Makefile | 7 +++++-- src/STUBS/Makefile | 4 ++-- 2 files changed, 7 insertions(+), 4 deletions(-) diff --git a/src/Makefile b/src/Makefile index d611adc404..5db09db65a 100644 --- a/src/Makefile +++ b/src/Makefile @@ -198,8 +198,8 @@ gitversion: # shlib = shared lib in Obj_shared_machine .DEFAULT: - @if [ $@ = "serial" -a ! -f STUBS/libmpi_stubs.a ]; \ - then $(MAKE) mpi-stubs; fi + @if [ $@ = "serial" ]; \ + then cd STUBS; $(MAKE); cd ..; fi @test -f MAKE/Makefile.$@ -o -f MAKE/OPTIONS/Makefile.$@ -o \ -f MAKE/MACHINES/Makefile.$@ -o -f MAKE/MINE/Makefile.$@ @if [ ! -d $(objdir) ]; then mkdir $(objdir); fi @@ -256,7 +256,10 @@ clean: clean-all: rm -rf Obj_* + clean-%: + @if [ $@ = "clean-serial" ]; \ + then cd STUBS; $(MAKE) clean; cd ..; fi rm -rf Obj_$(@:clean-%=%) Obj_shared_$(@:clean-%=%) # Create Makefile.list diff --git a/src/STUBS/Makefile b/src/STUBS/Makefile index 3649ddb383..3c3c3b46d9 100644 --- a/src/STUBS/Makefile +++ b/src/STUBS/Makefile @@ -28,7 +28,7 @@ ARCHFLAG = rs # Targets -lib: $(OBJ) +$(EXE): $(OBJ) $(ARCHIVE) $(ARCHFLAG) $(EXE) $(OBJ) clean: @@ -41,4 +41,4 @@ clean: # Individual dependencies -$(OBJ): $(INC) +$(OBJ): $(INC) ../version.h -- GitLab From a0e005f93c290ae12076546a2739bafee34d9e20 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 15:43:01 -0400 Subject: [PATCH 344/469] include LAMMPS version in STUBS library version string. --- src/STUBS/mpi.c | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/src/STUBS/mpi.c b/src/STUBS/mpi.c index cd92750b9a..f56d3616c8 100644 --- a/src/STUBS/mpi.c +++ b/src/STUBS/mpi.c @@ -20,6 +20,7 @@ #include #include #include +#include "../version.h" /* data structure for double/int */ @@ -80,7 +81,7 @@ int MPI_Finalized(int *flag) int MPI_Get_library_version(char *version, int *resultlen) { - const char string[] = "LAMMPS MPI STUBS"; + const char string[] = "LAMMPS MPI STUBS for LAMMPS version " LAMMPS_VERSION; int len; if (!version || !resultlen) return MPI_ERR_ARG; -- GitLab From 94126e5424a2516b1b6e448c8c9c4195fc38e629 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 15:44:10 -0400 Subject: [PATCH 345/469] use MPI_Get_library_version() API to provide a more detailed version info, not just the MPI standard level very chatty output (e.g. from MPICH) is truncated to the next line after 80 characters. --- src/info.cpp | 10 +++++++++- 1 file changed, 9 insertions(+), 1 deletion(-) diff --git a/src/info.cpp b/src/info.cpp index 25b9879408..6241877c82 100644 --- a/src/info.cpp +++ b/src/info.cpp @@ -353,11 +353,19 @@ void Info::command(int narg, char **arg) } if (flags & COMM) { - int major,minor; + int major,minor,len; + char version[MPI_MAX_LIBRARY_VERSION_STRING]; + MPI_Get_version(&major,&minor); + MPI_Get_library_version(version,&len); + if (len > 80) { + char *ptr = strchr(version+80,'\n'); + if (ptr) *ptr = '\0'; + } fprintf(out,"\nCommunication information:\n"); fprintf(out,"MPI library level: MPI v%d.%d\n",major,minor); + fprintf(out,"MPI version: %s\n",version); fprintf(out,"Comm style = %s, Comm layout = %s\n", commstyles[comm->style], commlayout[comm->layout]); fprintf(out,"Communicate velocities for ghost atoms = %s\n", -- GitLab From 0f10c55c1cbc693491c6d180807a7ca40f61b18a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 26 Jul 2019 17:26:59 -0400 Subject: [PATCH 346/469] avoid recursive header inclusion --- lib/poems/system.h | 2 -- 1 file changed, 2 deletions(-) diff --git a/lib/poems/system.h b/lib/poems/system.h index 1b59395de7..573044ce33 100644 --- a/lib/poems/system.h +++ b/lib/poems/system.h @@ -15,7 +15,6 @@ * CONTACT: anderk5@rpi.edu * *_________________________________________________________________________*/ - #ifndef SYSTEM_H #define SYSTEM_H @@ -31,7 +30,6 @@ #include "workspace.h" #include "matrixfun.h" #include "onsolver.h" -#include "system.h" #include "inertialframe.h" #include "rigidbody.h" #include "revolutejoint.h" -- GitLab From 2fba3d027a6a41866890acfe2b1975aac822d2bc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 28 Jul 2019 14:44:47 -0400 Subject: [PATCH 347/469] fix small formatting issue --- doc/src/compute_hexorder_atom.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_hexorder_atom.txt b/doc/src/compute_hexorder_atom.txt index 082a3cad7a..3c58c3f4dd 100644 --- a/doc/src/compute_hexorder_atom.txt +++ b/doc/src/compute_hexorder_atom.txt @@ -65,7 +65,7 @@ In an isotropic liquid, local neighborhoods may still exhibit weak hexagonal symmetry, but because the orientational correlation decays quickly with distance, the value of phi will be different for different atoms, and so when {q}6 is averaged over all the atoms -in the system, \|<{q}6>\| << 1. +in the system, |<{q}6>| << 1. The value of {qn} is set to zero for atoms not in the specified compute group, as well as for atoms that have less than -- GitLab From a0abd270b53f58dd99b702ee1fa2691960ee3738 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Mon, 29 Jul 2019 11:41:01 -0500 Subject: [PATCH 348/469] kim_query check for empty query result --- src/KIM/kim_query.cpp | 14 ++++++++++---- 1 file changed, 10 insertions(+), 4 deletions(-) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index 6688ed6690..e81e8c5d18 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -130,11 +130,13 @@ void KimQuery::command(int narg, char **arg) // as the first element, and then the error message // that was returned by the web server + char errmsg[1024]; if (0 == strlen(value)) { - char errmsg[1024]; - sprintf(errmsg,"OpenKIM query failed: %s",value+1); - error->all(FLERR,errmsg); + error->all(FLERR,errmsg); + } else if (0 == strcmp(value,"EMPTY")) { + sprintf(errmsg,"OpenKIM query returned no results"); + error->all(FLERR,errmsg); } char **varcmd = new char*[3]; @@ -269,7 +271,11 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, if (value[len] == ']') { retval = new char[len]; value[len] = '\0'; - strcpy(retval,value+1); + if (0 == strcmp(value+1, "")) { + strcpy(retval,"EMPTY"); + } + else + strcpy(retval,value+1); } else { retval = new char[len+2]; retval[0] = '\0'; -- GitLab From 5307558727d3b7ea07a3a664aa9e550713547239 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 13:34:04 -0400 Subject: [PATCH 349/469] need to install some base C++ headers for C++ library use --- cmake/CMakeLists.txt | 34 ++++++++++++++++++++++++++++++++++ 1 file changed, 34 insertions(+) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 7cd7b62c91..eee595df7e 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -497,10 +497,44 @@ if(BUILD_LIB) if(LAMMPS_DEPS) add_dependencies(lammps ${LAMMPS_DEPS}) endif() + set(LAMMPS_CXX_HEADERS + angle.h + atom.h + bond.h + citeme.h + comm.h + compute.h + dihedral.h + domain.h + error.h + fix.h + force.h + group.h + improper.h + input.h + kspace.h + lammps.h + lattice.h + lmppython.h + memory.h + modify.h + neighbor.h + neigh_list.h + output.h + pair.h + pointers.h + region.h + timer.h + universe.h + update.h + variable.h) + list(TRANSFORM LAMMPS_CXX_HEADERS PREPEND ${LAMMPS_SOURCE_DIR}/) + set_target_properties(lammps PROPERTIES OUTPUT_NAME lammps${LAMMPS_LIB_SUFFIX}) set_target_properties(lammps PROPERTIES SOVERSION ${SOVERSION}) install(TARGETS lammps LIBRARY DESTINATION ${CMAKE_INSTALL_LIBDIR} ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR}) install(FILES ${LAMMPS_SOURCE_DIR}/library.h DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/lammps) + install(FILES ${LAMMPS_CXX_HEADERS} DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/lammps) configure_file(pkgconfig/liblammps.pc.in ${CMAKE_CURRENT_BINARY_DIR}/liblammps${LAMMPS_LIB_SUFFIX}.pc @ONLY) install(FILES ${CMAKE_CURRENT_BINARY_DIR}/liblammps${LAMMPS_LIB_SUFFIX}.pc DESTINATION ${CMAKE_INSTALL_LIBDIR}/pkgconfig) configure_file(FindLAMMPS.cmake.in ${CMAKE_CURRENT_BINARY_DIR}/FindLAMMPS${LAMMPS_LIB_SUFFIX}.cmake @ONLY) -- GitLab From 96e0b03ede16ae551fde9fce4c2657e9d972181f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 13:38:38 -0400 Subject: [PATCH 350/469] .frc files only need to be installed if msi2lmp is built --- cmake/CMakeLists.txt | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index eee595df7e..eaa699106c 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -587,7 +587,9 @@ include(Documentation) ############################################################################### set(LAMMPS_INSTALL_DATADIR ${CMAKE_INSTALL_FULL_DATADIR}/lammps) install(DIRECTORY ${LAMMPS_POTENTIALS_DIR} DESTINATION ${LAMMPS_INSTALL_DATADIR}) -install(DIRECTORY ${LAMMPS_TOOLS_DIR}/msi2lmp/frc_files DESTINATION ${LAMMPS_INSTALL_DATADIR}) +if(BUILD_TOOLS) + install(DIRECTORY ${LAMMPS_TOOLS_DIR}/msi2lmp/frc_files DESTINATION ${LAMMPS_INSTALL_DATADIR}) +endif() configure_file(etc/profile.d/lammps.sh.in ${CMAKE_BINARY_DIR}/etc/profile.d/lammps.sh @ONLY) configure_file(etc/profile.d/lammps.csh.in ${CMAKE_BINARY_DIR}/etc/profile.d/lammps.csh @ONLY) -- GitLab From 6a1b61637bb7eaded180ef01167c7e3295af1ce6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 13:43:06 -0400 Subject: [PATCH 351/469] provide some more details about 'make install' with CMake --- doc/src/Build_cmake.txt | 9 +++++++-- 1 file changed, 7 insertions(+), 2 deletions(-) diff --git a/doc/src/Build_cmake.txt b/doc/src/Build_cmake.txt index a16ba995a8..8106b008bb 100644 --- a/doc/src/Build_cmake.txt +++ b/doc/src/Build_cmake.txt @@ -52,11 +52,16 @@ LAMMPS or need to re-compile LAMMPS repeatedly, installation of the ccache (= Compiler Cache) software may speed up repeated compilation even more. -After compilation, you can optionally copy the LAMMPS executable and -library into your system folders (by default under $HOME/.local) with: +After compilation, you may optionally install the LAMMPS executable into +your system with: make install # optional, copy LAMMPS executable & library elsewhere :pre +This will install the lammps executable and library (if requested), some +tools (if configured) and additional files like library API headers, manpages, +potential files. The location of the installation tree is set by the CMake +variable "CMAKE_INSTALL_PREFIX" which defaults to $\{HOME\}/.local + :line There are 3 variants of CMake: a command-line version (cmake), a text mode -- GitLab From e0b20c4fd404cff90e2a6335862b1dcca69e22b3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 15:23:23 -0400 Subject: [PATCH 352/469] add false positive --- doc/src/Build_cmake.txt | 7 ++++--- doc/utils/sphinx-config/false_positives.txt | 1 + 2 files changed, 5 insertions(+), 3 deletions(-) diff --git a/doc/src/Build_cmake.txt b/doc/src/Build_cmake.txt index 8106b008bb..6eb23b2bb5 100644 --- a/doc/src/Build_cmake.txt +++ b/doc/src/Build_cmake.txt @@ -58,9 +58,10 @@ your system with: make install # optional, copy LAMMPS executable & library elsewhere :pre This will install the lammps executable and library (if requested), some -tools (if configured) and additional files like library API headers, manpages, -potential files. The location of the installation tree is set by the CMake -variable "CMAKE_INSTALL_PREFIX" which defaults to $\{HOME\}/.local +tools (if configured) and additional files like library API headers, +manpages, potential and force field files. The location of the installation +tree is set by the CMake variable "CMAKE_INSTALL_PREFIX" which defaults +to $\{HOME\}/.local :line diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index da5c869075..e6fdaf826b 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -1539,6 +1539,7 @@ Mandelli Manh manifoldforce Manolopoulos +manpages manybody MANYBODY Maras -- GitLab From 2afc498a2b595157ef63c50894c03e5106b57dbc Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Mon, 29 Jul 2019 15:04:15 -0500 Subject: [PATCH 353/469] Add logging to kim_query (compile error at moment) --- src/KIM/kim_query.cpp | 15 ++++++++++++++- src/KIM/kim_query.h | 4 ++++ 2 files changed, 18 insertions(+), 1 deletion(-) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index e81e8c5d18..e2bee158ed 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -154,14 +154,16 @@ void KimQuery::command(int narg, char **arg) varcmd[0] = const_cast(splitname.str().c_str()); varcmd[2] = const_cast(token.c_str()); input->variable->set(3,varcmd); + echo_var_assign(splitname.str(), varcmd[2]); } } else { varcmd[0] = varname; varcmd[1] = (char *) "string"; varcmd[2] = value; - input->variable->set(3,varcmd); + + echo_var_assign(varname, value); } delete[] varcmd; @@ -297,3 +299,14 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, return retval; } #endif + +void KimQuery::echo_var_assign(std::string const & name, + std::string const & value) const +{ + if (comm->me == 0) { + std::string mesg; + mesg = name + " = " + value + "\n"; + if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); + if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); + } +} diff --git a/src/KIM/kim_query.h b/src/KIM/kim_query.h index b5433def79..9cffc9ad28 100644 --- a/src/KIM/kim_query.h +++ b/src/KIM/kim_query.h @@ -64,6 +64,7 @@ CommandStyle(kim_query,KimQuery) #define LMP_KIM_QUERY_H #include "pointers.h" +#include namespace LAMMPS_NS { @@ -71,6 +72,9 @@ class KimQuery : protected Pointers { public: KimQuery(class LAMMPS *lmp) : Pointers(lmp) {}; void command(int, char **); + private: + void echo_var_assign(std::string const & name, std::string const & value) + const; }; } -- GitLab From 0beb39c1af9cf93979452cdd84722c3118cbebfb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 15:59:42 -0400 Subject: [PATCH 354/469] fully integrate compute gyration/shape into doc build system --- doc/src/Commands_compute.txt | 1 + doc/src/Eqs/compute_shape_parameters.jpg | Bin 0 -> 7007 bytes doc/src/Eqs/compute_shape_parameters.tex | 3 +- doc/src/Errors_messages.txt | 8 ++++ doc/src/compute.txt | 1 + doc/src/compute_gyration.txt | 3 +- doc/src/compute_gyration_shape.txt | 48 ++++++++++---------- doc/src/computes.txt | 1 + doc/src/lammps.book | 1 + doc/utils/sphinx-config/false_positives.txt | 6 +++ 10 files changed, 46 insertions(+), 26 deletions(-) create mode 100644 doc/src/Eqs/compute_shape_parameters.jpg diff --git a/doc/src/Commands_compute.txt b/doc/src/Commands_compute.txt index f566702609..3413116e80 100644 --- a/doc/src/Commands_compute.txt +++ b/doc/src/Commands_compute.txt @@ -66,6 +66,7 @@ KOKKOS, o = USER-OMP, t = OPT. "group/group"_compute_group_group.html, "gyration"_compute_gyration.html, "gyration/chunk"_compute_gyration_chunk.html, +"gyration/shape"_compute_gyration_shape.html, "heat/flux"_compute_heat_flux.html, "heat/flux/tally"_compute_tally.html, "hexorder/atom"_compute_hexorder_atom.html, diff --git a/doc/src/Eqs/compute_shape_parameters.jpg b/doc/src/Eqs/compute_shape_parameters.jpg new file mode 100644 index 0000000000000000000000000000000000000000..9e2374561b40690173497a2e1c9a28c869b0c819 GIT binary patch literal 7007 zcmex=oIr{vTivYZ;lC8CV2ag%k}P*@OcV*_8@Kj2b5{E zCr+Nabot8FYu9hwy!G(W<0ns_J%91?)yGetzkL1n{m0K=Ab&A3FoS&sA|M_^^Oqn4 z6C)D~3o{El$X|?1Sas$bx1YB0@MQ!g0foS!c2zxGb1R?2~CEWOVlss_mn^2o0~o7-<1vj85VV} z`pLN% zW4Em{)epYk>UsQePXHT#qrNGxL-uy@s-ExLPOkFKO}nhc{PcLM`jb$0{r%e=wAZaG zJ`h!S$%cPP#EF|byh|rNp69au_wn=lo||4+y|^KCYBNt0Uy%mml@ResF-J3%Z#hgp z$9_`yp7*n_|C@W zrgt7(JKs)Is55zM^*(amgLMm+M&EK0nW$1eFH`-pwD|ow*UdkcM*K0~pL#Ol`L^=o z-(5aV{#p7*gX!DaRj=wKH*LJKReHrbg-MSj^d}~BZ1~wDV3WR1bViC{PT!+ls~+w% z(DwXrKCsO$by{{v58u+>BNgkOHCUX!y<(|rpf|DMV`gR{UEwIxt#uzq-&t9y z9I>odR658~D<3W_ zE?lOzvUW%8D=zhn&J(TtniBGFRzAPlE%$ZmgVkr9{xbx8)Y)#;^Svw}%QrJaEriu2 zi+SS45Wzhg{xdXOcU^hkc}d3gSuG1Va^BucleG&8s$ZH|W4pyFzv0W4ou%SN&fj)V z@>hJS=63$kkvb8^D;M3|*GDyd@}99a_RZT%j|zJ??%5ZSSNU^8;qk2uuJtR9FP|N6 zD7)`+!M4}iH=7msZx=1v(JvTZ(bzZnS;n-^UN@y3S2#}|PN-k~_;sx4)O*`?FR4D8 zn48ad?xoO|6YerK`y$TUePLYT<|ui5$2#waf8Q-!nR#pJ(`O59-|((HFFIwi7V{Ig z+l)U&-F4Pfh3)SuEnM&;IP_`}bJVSqTIsu4t=%6LXvwp^>|R)5?sZwB-|X5=vAQac z5aZ_`lj@}y?ylj`oA3QG{aZ-i+3Xcg-_2(C)$A1LH#2H5%$#WB{7^DMdbw1~snxHRT}rB-uz+t(vGGqN5+O z-<;=hXrfB>cGiRgUsNWz8BV_OXl+!)($$`d(;}BoW_&iK=?q(e1p|Xo1p}YwE8i$+ zot@O~FaL0KOPp`ZwoB1p@7%Xg*r>ibW%B%} zJBu1DcS{H#mE)f7agCYt7Td-vg3>&jSZ^JXuaopII8}Yw^sZX8J$qKuS(SbJBjPeb z8~#2yEqCMC1qO>-J0xDQ*JUq>NRFHr+UwHCkj^}f+2Z84lYd_ATe|Fa*0r>2Z_SVH zRgtijlrWlqaEe^TqXtWUzN0MvbhmBY^7+>3!?$e0CeB=(qUKq6v%!*+tNwoJ-B52{ zv+KT|VK+H4ml&N^HcX#*g1Ol6$s7jT28IO2uoukMVV9R&;ccJxYJb|EzK7e(x#zL( zH(l&1!Z>%`i);H7F6Nc2KJfNO<_HkPlh&YM&nIRWjn>*)&O6cJ|X_h7%an zmCLOrx&K}NxVlm#Z`;L%lZ%@V?wrCP{%Yg9^M6aDUc8*>EW^1;Kd}-^Jy+P-+ca*Shn|H1vSIk3k zhW>f32{TzeWn>pLH=lUaV76jK-h15~-IQH>cDCKRXE=RYI!BjPkw4SM{|pb!KTQA2 zE2aLAN9jMqqZQ0mT_-kwjBhXHUb1!5^)IVucUpKP?&-a|<2-}RJngs!je~15%cJJp zO5L|GSN99|uIP%VJRf@=>#!?N()wCBPy9ba=ls4sk!$A9vPfoqW71pyGdxOvyk0C@{aK%6 z;-v-Z8#>E9|1a>)JL1|!K>r%O6*LVRVle= z|MxZr%VQSj*XG@-*mmmOZLgV%^R4Dy*|uRBqxIs?=7!JTC8;U&Em$veZP{XrO_$ca z6XSgPX;G!k>Qpv&1>siN8{fXKGe5LT_fpocpv|2nYq@=Y>u%ZS*nM{9x28KA?>MRJ zSe%}dK8K-vYvX?gj=9_FpJ=YDe{d=PpVsyl3wXTid2Zj1Id1jJ>hO#k29c(ck$%4n2Dx1gu_;sXJeEYgDzip0?2@Fm_?0 z^w%KHFu5NJpYJu8feYg$R?FrWmR*~0|JKQ(1=Cv9f*!N8KV`R(dbV)a6}^2L_g}tT z8Dlpycj=PJ(GQu9oAfy`IJNy=aePwM6>+N|{}n&-{Wi`#y1f0J;IsX6k3CZ|mO3Ea zd*=4BHw6alL97gAUjlumIr8XhGdXD{_h&KGibnhI@pbpzy014fd1tFyXx;(?7UrK< zXEA6ksaiJQ^x@{Ne^=kN6*HY#dd%w2&hw(@YBvYWezfuO!z<}lB~tOX@^rhF9i4bT zB|%{KF753q-&RfE<>X!X@UGOMO1rZQ@44E1|IWv)#~9jTE1h5qyne+Gs=eJe+M6TUGQYU)3bf!Xt)F(mB&gg=eZ|AER zZYxbVjzkRUWX1esV*6!oVbEa8X)Rf8VGw{p_J&1ya0@%4B@bnum@9v&9DEE26A-%f4( z&(Ik9o1fuFx$nNVPq%KpKi7I@;?G^ZM^;HZpSxZ$s8W66^;xrhF67i`FZFy9`?KuZ zMbD?Um-SAU=)`WSc&t9j-&N-0tP@*zUeT{{UKMrp5vS0(gKsW)T|D+L2+O;cl4ai)p2NuaJbfI z6{GU)uH6nY@lBEWU(btX=NvYl)w#8K{$9~d9iMEsPyh4k>+%L0>*QL|CuY~@l?44f z{VdDeNbk?PJE2Ro{3@T6K3nrLPO{l)>m*&fN~1;jn>ia&TTVT5d%>8vqi?xIfUW2A zoUebwYR!Ej-bX&W^7VSt-MJz=wshXu=Vo~7(4WWs231@P?_W>7w*HSxiLHZOYubw3 zC9G|W{Mas^v)T1()wabs*Jq{PT_v#AL|;OEfvU&9EsW=1ivLrRGHr<&ky`(xcS*P@79)C3$CV@CU1Q5+hIz>jT1i|Vjh24ckP(< zl+Jr^56*Je3ys!lUJ!WT1;hE3C*M2pTuHgIsMT*~W@fQw{>;3*C|2exqP?GLH`r~R z{cXS4e})UfF8>)0?%DsRH!7-cdgiJ_8{^#0b=_`=l(hV{QgrTr29C1!{|t7U>mS72 z{}aj(b9vddrBjbBU;gsj#nzuuw|+iX`6X~sjeVd0r7hXkeiyd<)e4_>PTalp*3o6< zk6#?Q*2_@*pW(yYANK#+_VWK{U^Dp7@G*4Zvg}=U+n@bsNO`r*{GXrA`Asn@yN&0h zXIh-&k9Q7;ujspU!0#FN$w%AH&)40$+hb!w%5#}H<=m63ul|;P9qV_D`?chy>c|T= zMaPQP@E1Br7XP?>Xxnz7+jlBvyR}u!Su*itz0f8D3x%eeEOLf{{}~RIKlsn^OX`dL zABn^N8IFeatzD%zJzJXN&+E=70?`iAY>|8g#y1!^)i(rHhsF!OethVk?ELUuTW7tp zPT@7WEyBY0{CVQBY9@c>E{4_Sy*8r7EED`6JhFT$&~Y}rmCcXITbJ#z??djgwYjU}er!J+bT8WB zqOx-_OZDB4&wPF;>m4a!V4U`P&h-V6F@HB5y7&52#hw?_{B{3*N?~q(XB>Qi-5%4~ z?tj$l`2RC3T<`p!;b4#bpU@JKnUc!N$}1M|@c;1pBmbYlIj;RbL$gHvk5%>$tv}TN z<*kzc$CLP<;nC^^Yx;$=KmJH|*m?E&mU+*(6L+~bEJ%%ypV?MxU{v|iK~(kQ_GY!t zN7Ii=aUXjXdT}dUC z(|3bqj)tWL!~8?*?!7X&G2`MjPqpcGF@}oiHKi7B*xWo1NXmTD+BWr(G;h+gSJ&7k zS)X=dJ-X)Oj3@mzO^&bllZ^P+GGxKqg{~ru=Z=fcZ!*#Kd-v?ur)PK9rS86MoS$&X z%q6hFdgB4vqI+NcAI@v7et4fL;>IftEHr)~Kh7Oz?^ zuzF{Oy#~A87si>zio1SHP0TuOcr$a-UDp2$%O+VJll~A|_@9BvH29JDuhM<(4?ljc z&w4ds$;#I}>E|YY>ES=NHcoT%kLk-|E&g8pHrI4U{;!O_O&Wi~&)9zu4$R&ax6;11 zS(*c;-HUWtC%AxxcjnI`{*TG)f0{7FW!=h~^J@C7 z)}^a0PObT@C1krPd-m3ka&0z+t4@`!wQ#$YJ8AXoB?pzf*EAGgNvTWPbyA@%iD#qR zlaf0N9&OOg$^Fmp(CX^uY_aoiZtK*&Nw&+qR=@nEgLGI`Z{MPxZ|2j!d$sdi@LI?C z#lrM-jmLimpNl1bS&B;MdU3lmub(1)X2M@HH}}V}H3dgGlr%0fK4}fmp7v30=E^%2 zyIroV)jjgz#_hWt#~zr)c&u7+hErbe?w_9dX9CzGU5l?*ty`G?=&iO_|H%ryph(qI zbN_{87^^uRuuDF+AbHv2m)&yWSC?NealNw4lb0 ztd(ou@4ziv%cQ5K&kdOPiqZ63#E*XGc!_Kyv#rZHZr!?~ExqKR!s$6Ozx&VaI;s0` zMzfCLPFZdZ)5gT){QnG`eOqToZ2LRwx@1rCnw<-HSKB(B4(wgBanJT$y?)m+RQVXc zoG?9IfVRy-B~r_wAkRcjel@N2ccH<=29uwHoR?lK9v{ zQaj(z^S}4#eWOzT54U}{4zmaD-myRM-;qn3m;bW}+Z6>K=K^)FPS1CZ{NtIvwszYq z^KDHYcIWz7g4h(Ewpl96gzGOpsJ8iIa?nTB723<9G7ozRecL(1d+(`VEx&huJ;%?s zYW6{8s+(P6>fMbJjc0nHcm+%BOr+(96R8H{YBP^q8o}*}@}n r Date: Mon, 29 Jul 2019 16:16:24 -0400 Subject: [PATCH 355/469] cleanup of compute gyration/shape code. - use MathSpecial::square(x) instead of pow(x,2) for improved precision and handling of small and negative numbers - remove unused include statements - no need to refetch the compute in every step. during init() is sufficient --- src/USER-MISC/compute_gyration_shape.cpp | 47 +++++++++++------------- src/USER-MISC/compute_gyration_shape.h | 7 ++++ 2 files changed, 29 insertions(+), 25 deletions(-) diff --git a/src/USER-MISC/compute_gyration_shape.cpp b/src/USER-MISC/compute_gyration_shape.cpp index 0e566e671f..a0ee6089b7 100644 --- a/src/USER-MISC/compute_gyration_shape.cpp +++ b/src/USER-MISC/compute_gyration_shape.cpp @@ -16,17 +16,14 @@ * ------------------------------------------------------------------------- */ +#include "compute_gyration_shape.h" #include #include -#include "compute_gyration_shape.h" -#include "math_extra.h" -#include "update.h" -#include "atom.h" -#include "group.h" -#include "domain.h" #include "error.h" +#include "math_extra.h" +#include "math_special.h" #include "modify.h" -#include "compute.h" +#include "update.h" using namespace LAMMPS_NS; @@ -67,27 +64,26 @@ void ComputeGyrationShape::init() // check that the compute gyration command exist int icompute = modify->find_compute(id_gyration); if (icompute < 0) - error->all(FLERR,"Compute gyration does not exist for compute gyration/shape"); + error->all(FLERR,"Compute gyration ID does not exist for " + "compute gyration/shape"); // check the id_gyration corresponds really to a compute gyration command c_gyration = (Compute *) modify->compute[icompute]; if (strcmp(c_gyration->style,"gyration") != 0) - error->all(FLERR,"Compute gyration/shape does not use gyration compute"); + error->all(FLERR,"Compute gyration compute ID does not point to " + "gyration compute for compute gyration/shape"); } /* ---------------------------------------------------------------------- - compute shape parameters based on the eigenvalues of the gyration tensor of group of atoms + compute shape parameters based on the eigenvalues of the + gyration tensor of group of atoms ------------------------------------------------------------------------- */ void ComputeGyrationShape::compute_vector() { invoked_vector = update->ntimestep; - - // get the gyration tensor from the compute gyration - int icompute = modify->find_compute(id_gyration); - Compute *compute = modify->compute[icompute]; - compute->compute_vector(); - double *gyration_tensor = compute->vector; + c_gyration->compute_vector(); + double *gyration_tensor = c_gyration->vector; // call the function for the calculation of the eigenvalues double ione[3][3], evalues[3], evectors[3][3]; @@ -100,7 +96,8 @@ void ComputeGyrationShape::compute_vector() ione[0][2] = ione[2][0] = gyration_tensor[5]; int ierror = MathExtra::jacobi(ione,evalues,evectors); - if (ierror) error->all(FLERR, "Insufficient Jacobi rotations for gyration/shape"); + if (ierror) error->all(FLERR, "Insufficient Jacobi rotations " + "for gyration/shape"); // sort the eigenvalues according to their size with bubble sort double t; @@ -115,19 +112,19 @@ void ComputeGyrationShape::compute_vector() } // compute the shape parameters of the gyration tensor - double sq_eigen_x = pow(evalues[0], 2); - double sq_eigen_y = pow(evalues[1], 2); - double sq_eigen_z = pow(evalues[2], 2); + double sq_eigen_x = MathSpecial::square(evalues[0]); + double sq_eigen_y = MathSpecial::square(evalues[1]); + double sq_eigen_z = MathSpecial::square(evalues[2]); - double nominator = pow(sq_eigen_x, 2) + pow(sq_eigen_y, 2) + pow(sq_eigen_z, 2); - double denominator = pow(sq_eigen_x+sq_eigen_y+sq_eigen_z, 2); + double nominator = MathSpecial::square(sq_eigen_x) + + MathSpecial::square(sq_eigen_y) + + MathSpecial::square(sq_eigen_z); + double denominator = MathSpecial::square(sq_eigen_x+sq_eigen_y+sq_eigen_z); vector[0] = evalues[0]; vector[1] = evalues[1]; vector[2] = evalues[2]; vector[3] = sq_eigen_z - 0.5*(sq_eigen_x + sq_eigen_y); vector[4] = sq_eigen_y - sq_eigen_x; - vector[5] = 0.5*(3*nominator/denominator -1); - + vector[5] = 0.5*(3*nominator/denominator - 1.0); } - diff --git a/src/USER-MISC/compute_gyration_shape.h b/src/USER-MISC/compute_gyration_shape.h index 1b39dd2e38..1d58f000dd 100644 --- a/src/USER-MISC/compute_gyration_shape.h +++ b/src/USER-MISC/compute_gyration_shape.h @@ -50,4 +50,11 @@ Self-explanatory. Check the input script syntax and compare to the documentation for the command. You can use -echo screen as a command-line option when running LAMMPS to see the offending line. +E: Compute gyration ID does not exist for compute gyration/shape + +Self-explanatory. Provide a valid compute ID + +E: Compute gyration/shape compute ID does not point to a gyration compute + +Self-explanatory. Provide an ID of a compute gyration command. */ -- GitLab From 0f059c56f946b9de88a869401370e6e874fd808c Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Mon, 29 Jul 2019 15:30:46 -0500 Subject: [PATCH 356/469] Add details about installing models to KIM example input --- examples/kim/in.kim-pm-query.melt | 9 +++++++++ examples/kim/in.kim-pm.melt | 9 +++++++++ examples/kim/in.kim-sm.melt | 11 ++++++++++- 3 files changed, 28 insertions(+), 1 deletion(-) diff --git a/examples/kim/in.kim-pm-query.melt b/examples/kim/in.kim-pm-query.melt index d39dd2d464..fa04d90436 100644 --- a/examples/kim/in.kim-pm-query.melt +++ b/examples/kim/in.kim-pm-query.melt @@ -4,6 +4,15 @@ # SW_StillingerWeber_1985_Si__MO_405512056662_005 # is installed. This can be done with the command # kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# # Or, see https://openkim.org/doc/obtaining-models for alternative options. # diff --git a/examples/kim/in.kim-pm.melt b/examples/kim/in.kim-pm.melt index 999cf77180..9959a66793 100644 --- a/examples/kim/in.kim-pm.melt +++ b/examples/kim/in.kim-pm.melt @@ -4,6 +4,15 @@ # SW_StillingerWeber_1985_Si__MO_405512056662_005 # is installed. This can be done with the command # kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# # Or, see https://openkim.org/doc/obtaining-models for alternative options. # diff --git a/examples/kim/in.kim-sm.melt b/examples/kim/in.kim-sm.melt index 32f8c6170f..0ee8e9a857 100644 --- a/examples/kim/in.kim-sm.melt +++ b/examples/kim/in.kim-sm.melt @@ -4,7 +4,16 @@ # Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 # is installed. This can be done with the command # kim-api-collections-management install user Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 -# Or, see https://openkim.org/doc/obtaining-models for alternative options. +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# +# See https://openkim.org/doc/obtaining-models for alternative options. # variable x index 1 -- GitLab From ea4107c4b433082aad60b811588e8e53fc1c1651 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 16:36:57 -0400 Subject: [PATCH 357/469] add write_echo() method to Input class for logging implicit commands where the echo command would send explicit ones --- src/KIM/kim_init.cpp | 14 ++++---------- src/KIM/kim_interactions.cpp | 3 +-- src/KIM/kim_query.cpp | 3 +-- src/input.cpp | 11 +++++++++++ src/input.h | 5 ++--- 5 files changed, 19 insertions(+), 17 deletions(-) diff --git a/src/KIM/kim_init.cpp b/src/KIM/kim_init.cpp index 954a4b0f2c..a4272caa01 100644 --- a/src/KIM/kim_init.cpp +++ b/src/KIM/kim_init.cpp @@ -377,8 +377,7 @@ void KimInit::kim_init_log_delimiter(std::string const begin_end) const mesg = "#=== END kim-init ============================================\n\n"; - if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); - if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); + input->write_echo(mesg.c_str()); } } @@ -425,8 +424,7 @@ void KimInit::do_variables(char *user_units, char *model_units) mesg += " to "; mesg += to; mesg += ":\n"; - if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); - if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); + input->write_echo(mesg.c_str()); } for (int i = 0; i < nunits; i++) { @@ -455,14 +453,10 @@ void KimInit::do_variables(char *user_units, char *model_units) << " internal " << std::setprecision(12) << std::scientific << conversion_factor << std::endl; - if ((screen) && (input->echo_screen)) fputs(mesg.str().c_str(),screen); - if ((logfile) && (input->echo_log)) fputs(mesg.str().c_str(),logfile); + input->write_echo(mesg.str().c_str()); } } - if (comm->me == 0) { - if ((screen) && (input->echo_screen)) fputs("#\n",screen); - if ((logfile) && (input->echo_log)) fputs("#\n",logfile); - } + if (comm->me == 0) input->write_echo("#\n"); } /* ---------------------------------------------------------------------- */ diff --git a/src/KIM/kim_interactions.cpp b/src/KIM/kim_interactions.cpp index 449b6bcb13..7dbe523033 100644 --- a/src/KIM/kim_interactions.cpp +++ b/src/KIM/kim_interactions.cpp @@ -106,8 +106,7 @@ void KimInteractions::kim_interactions_log_delimiter( mesg = "#=== END kim_interactions ====================================\n\n"; - if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); - if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); + input->write_echo(mesg.c_str()); } } diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index e2bee158ed..1e699e74b0 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -306,7 +306,6 @@ void KimQuery::echo_var_assign(std::string const & name, if (comm->me == 0) { std::string mesg; mesg = name + " = " + value + "\n"; - if ((screen) && (input->echo_screen)) fputs(mesg.c_str(),screen); - if ((logfile) && (input->echo_log)) fputs(mesg.c_str(),logfile); + input->write_echo(mesg.c_str()); } } diff --git a/src/input.cpp b/src/input.cpp index 08e3655437..8bf4fc12e1 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -314,6 +314,17 @@ char *Input::one(const char *single) return command; } +/* ---------------------------------------------------------------------- + Send text to active echo file pointers +------------------------------------------------------------------------- */ +void Input::write_echo(const char *txt) +{ + if (me == 0) { + if (echo_screen && screen) fputs(txt,screen); + if (echo_log && logfile) fputs(txt,logfile); + } +} + /* ---------------------------------------------------------------------- parse copy of command line by inserting string terminators strip comment = all chars from # on diff --git a/src/input.h b/src/input.h index dc5a2670d4..b86982cb39 100644 --- a/src/input.h +++ b/src/input.h @@ -25,8 +25,6 @@ class Input : protected Pointers { friend class Info; friend class Error; friend class Deprecated; - friend class KimInit; - friend class KimInteractions; public: int narg; // # of command args @@ -41,7 +39,8 @@ class Input : protected Pointers { void substitute(char *&, char *&, int &, int &, int); // substitute for variables in a string int expand_args(int, char **, int, char **&); // expand args due to wildcard - + void write_echo(const char *); // send text to active echo file pointers + protected: char *command; // ptr to current command int echo_screen; // 0 = no, 1 = yes -- GitLab From 2ffc35297bfc7904051cbc18ec4c6ea7d6599d86 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 16:57:34 -0400 Subject: [PATCH 358/469] make kim_query log of variable setting look more like other KIM log messages this adds BEGIN/END marker comments and echoes the actual command line that the kim_query command implicitly executes --- src/KIM/kim_query.cpp | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index 1e699e74b0..cfb26c4d5e 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -305,7 +305,9 @@ void KimQuery::echo_var_assign(std::string const & name, { if (comm->me == 0) { std::string mesg; - mesg = name + " = " + value + "\n"; + mesg = "#=== BEGIN kim_query =========================================\n"; + mesg += "variable " + name + " string " + value + "\n"; + mesg += "#=== END kim_query ===========================================\n"; input->write_echo(mesg.c_str()); } } -- GitLab From c03e9c9711b5eed9ba3e2c589c18af4b5728e7e7 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Mon, 29 Jul 2019 16:11:08 -0500 Subject: [PATCH 359/469] Adjust write_echo() within kim_query --- src/KIM/kim_query.cpp | 23 +++++++++++++++++++++-- src/KIM/kim_query.h | 1 + 2 files changed, 22 insertions(+), 2 deletions(-) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index cfb26c4d5e..e35afa9a8b 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -139,6 +139,7 @@ void KimQuery::command(int narg, char **arg) error->all(FLERR,errmsg); } + kim_query_log_delimiter("begin"); char **varcmd = new char*[3]; if (split) { int counter = 1; @@ -165,6 +166,7 @@ void KimQuery::command(int narg, char **arg) echo_var_assign(varname, value); } + kim_query_log_delimiter("end"); delete[] varcmd; delete[] value; @@ -300,14 +302,31 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, } #endif +/* ---------------------------------------------------------------------- */ + +void KimQuery::kim_query_log_delimiter(std::string const begin_end) const +{ + if (comm->me == 0) { + std::string mesg; + if (begin_end == "begin") + mesg = + "#=== BEGIN kim-query =========================================\n"; + else if (begin_end == "end") + mesg = + "#=== END kim-query ===========================================\n\n"; + + input->write_echo(mesg.c_str()); + } +} + +/* ---------------------------------------------------------------------- */ + void KimQuery::echo_var_assign(std::string const & name, std::string const & value) const { if (comm->me == 0) { std::string mesg; - mesg = "#=== BEGIN kim_query =========================================\n"; mesg += "variable " + name + " string " + value + "\n"; - mesg += "#=== END kim_query ===========================================\n"; input->write_echo(mesg.c_str()); } } diff --git a/src/KIM/kim_query.h b/src/KIM/kim_query.h index 9cffc9ad28..33a37f5131 100644 --- a/src/KIM/kim_query.h +++ b/src/KIM/kim_query.h @@ -73,6 +73,7 @@ class KimQuery : protected Pointers { KimQuery(class LAMMPS *lmp) : Pointers(lmp) {}; void command(int, char **); private: + void kim_query_log_delimiter(std::string const begin_end) const; void echo_var_assign(std::string const & name, std::string const & value) const; }; -- GitLab From 180c90acfbf412e7e2156f533d08441055daa129 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 20:21:31 -0400 Subject: [PATCH 360/469] use utils::strmatch() to more safely detect gravity fix --- src/GRANULAR/fix_pour.cpp | 9 ++++----- 1 file changed, 4 insertions(+), 5 deletions(-) diff --git a/src/GRANULAR/fix_pour.cpp b/src/GRANULAR/fix_pour.cpp index 3ffca8db9d..4972d8f3f4 100644 --- a/src/GRANULAR/fix_pour.cpp +++ b/src/GRANULAR/fix_pour.cpp @@ -32,6 +32,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace FixConst; @@ -180,11 +181,9 @@ FixPour::FixPour(LAMMPS *lmp, int narg, char **arg) : // assume grav = -magnitude at this point, enforce in init() int ifix; - for (ifix = 0; ifix < modify->nfix; ifix++) { - if (strcmp(modify->fix[ifix]->style,"gravity") == 0) break; - if (strcmp(modify->fix[ifix]->style,"gravity/omp") == 0) break; - if (strstr(modify->fix[ifix]->style,"gravity/kk") != NULL) break; - } + for (ifix = 0; ifix < modify->nfix; ifix++) + if (utils:strmatch(modify->fix[ifix]->style,"^gravity")) break; + if (ifix == modify->nfix) error->all(FLERR,"No fix gravity defined for fix pour"); grav = - ((FixGravity *) modify->fix[ifix])->magnitude * force->ftm2v; -- GitLab From 5cb02781c24d48071d4c45d9b637c41e5abb5842 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 20:35:24 -0400 Subject: [PATCH 361/469] simplify checking for per chunk compute --- src/compute_chunk_spread_atom.cpp | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/src/compute_chunk_spread_atom.cpp b/src/compute_chunk_spread_atom.cpp index 3d0cea1add..4beeb2b010 100644 --- a/src/compute_chunk_spread_atom.cpp +++ b/src/compute_chunk_spread_atom.cpp @@ -23,6 +23,7 @@ #include "input.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -116,9 +117,7 @@ ComputeChunkSpreadAtom(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Compute ID for compute chunk/spread/atom " "does not exist"); - char *ptr = strstr(modify->compute[icompute]->style,"/chunk"); - if (!ptr || (ptr != modify->compute[icompute]->style + - strlen(modify->compute[icompute]->style) - strlen("/chunk"))) + if (!utils::strmatch(modify->compute[icompute]->style,"/chunk$") error->all(FLERR,"Compute for compute chunk/spread/atom " "does not calculate per-chunk values"); -- GitLab From 9f276be0e532cee13031b807303cb8ffb5b0d43f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 20:48:47 -0400 Subject: [PATCH 362/469] fix up legacy doc building for final kim doc files --- doc/src/lammps.book | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/lammps.book b/doc/src/lammps.book index 79b410c783..a3ec9c568b 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -168,7 +168,7 @@ include.html info.html jump.html kim_query.html -kim_style.html +kim_commands.html label.html lattice.html log.html -- GitLab From 90c678849ade82a139852971a5040039485ecfbf Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 21:10:49 -0400 Subject: [PATCH 363/469] replace non-ascii characters with ASCII equivalents --- doc/src/compute.txt | 2 +- doc/src/kim_commands.txt | 12 ++++++------ 2 files changed, 7 insertions(+), 7 deletions(-) diff --git a/doc/src/compute.txt b/doc/src/compute.txt index 53ed373aa5..0741699e61 100644 --- a/doc/src/compute.txt +++ b/doc/src/compute.txt @@ -177,7 +177,7 @@ compute"_Commands_compute.html doc page are followed by one or more of "angle"_compute_angle.html - energy of each angle sub-style "angle/local"_compute_angle_local.html - theta and energy of each angle "angmom/chunk"_compute_angmom_chunk.html - angular momentum for each chunk -"basal/atom"_compute_basal_atom.html - calculates the hexagonal close-packed “c” lattice vector of each atom +"basal/atom"_compute_basal_atom.html - calculates the hexagonal close-packed "c" lattice vector of each atom "body/local"_compute_body_local.html - attributes of body sub-particles "bond"_compute_bond.html - energy of each bond sub-style "bond/local"_compute_bond_local.html - distance and energy of each bond diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 0bb7de03d6..93c4e8c4a8 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -258,12 +258,12 @@ variable xyfinal equal xy*$\{_u_distance\} variable xzfinal equal xz*$\{_u_distance\} variable yzfinal equal yz*$\{_u_distance\} change_box all x scale $\{_u_distance\} & -               y scale $\{_u_distance\} & -               z scale $\{_u_distance\} & -               xy final $\{xyfinal\} & -               xz final $\{xzfinal\} & -               yz final $\{yzfinal\} & -               remap :pre + y scale $\{_u_distance\} & + z scale $\{_u_distance\} & + xy final $\{xyfinal\} & + xz final $\{xzfinal\} & + yz final $\{yzfinal\} & + remap :pre NOTE: Unit conversion will only work if the conversion factors are placed in all appropriate places in the input script. It is up to the user to do this -- GitLab From 9004ebc3fe8ebb38b1b64236eb7e95b144a6882e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 21:11:13 -0400 Subject: [PATCH 364/469] one more fixup for compatibility for old PDF build scheme --- doc/src/lammps.book | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/lammps.book b/doc/src/lammps.book index a3ec9c568b..b3808e18dc 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -42,6 +42,7 @@ Commands_compute.html Commands_pair.html Commands_bond.html Commands_kspace.html +Commands_removed.html Packages.html Packages_standard.html Packages_user.html @@ -167,7 +168,6 @@ if.html include.html info.html jump.html -kim_query.html kim_commands.html label.html lattice.html -- GitLab From 4289dbb78d3fe8267e2a91881e30a92c6dbbd461 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 22:28:29 -0400 Subject: [PATCH 365/469] clean up includes and whitespace --- src/USER-MISC/compute_momentum.cpp | 15 ++++++--------- 1 file changed, 6 insertions(+), 9 deletions(-) diff --git a/src/USER-MISC/compute_momentum.cpp b/src/USER-MISC/compute_momentum.cpp index f8fc0ec6ab..541b52d9c0 100644 --- a/src/USER-MISC/compute_momentum.cpp +++ b/src/USER-MISC/compute_momentum.cpp @@ -1,12 +1,9 @@ -#include #include "compute_momentum.h" +#include #include "atom.h" -#include "update.h" -#include "force.h" -#include "domain.h" -#include "group.h" #include "error.h" +#include "update.h" using namespace LAMMPS_NS; @@ -45,14 +42,14 @@ void ComputeMomentum::compute_vector() if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { - for(int j = 0; j < 3; ++j) - mom[j] += rmass[i] * v[i][j]; + for(int j = 0; j < 3; ++j) + mom[j] += rmass[i] * v[i][j]; } } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) - for(int j = 0; j < 3; ++j) - mom[j] += mass[type[i]] * v[i][j]; + for(int j = 0; j < 3; ++j) + mom[j] += mass[type[i]] * v[i][j]; } MPI_Allreduce(&mom, vector, 3, MPI_DOUBLE, MPI_SUM, world); -- GitLab From c9f3f99ee84f2136acf5cb16c590289de41c4a14 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Mon, 29 Jul 2019 21:48:12 -0500 Subject: [PATCH 366/469] Update to kim-api-2.1.2 --- cmake/Modules/Packages/KIM.cmake | 8 +++++--- 1 file changed, 5 insertions(+), 3 deletions(-) diff --git a/cmake/Modules/Packages/KIM.cmake b/cmake/Modules/Packages/KIM.cmake index 5987ebbf0a..d9d028f6dc 100644 --- a/cmake/Modules/Packages/KIM.cmake +++ b/cmake/Modules/Packages/KIM.cmake @@ -9,7 +9,9 @@ if(PKG_KIM) if(KIM-API_FOUND) set(DOWNLOAD_KIM_DEFAULT OFF) else() - message(WARNING "KIM-API package not found. We will download and build our own") + if (NOT DOWNLOAD_KIM) + message(WARNING "KIM-API package not found. We will download and build our own") + endif() set(DOWNLOAD_KIM_DEFAULT ON) endif() option(DOWNLOAD_KIM "Download KIM-API from OpenKIM instead of using an already installed one" ${DOWNLOAD_KIM_DEFAULT}) @@ -22,8 +24,8 @@ if(PKG_KIM) enable_language(Fortran) include(ExternalProject) ExternalProject_Add(kim_build - URL https://s3.openkim.org/kim-api/kim-api-2.1.1.txz - URL_MD5 ae0ee413e026c6e93d35692db5966fb4 + URL https://s3.openkim.org/kim-api/kim-api-2.1.2.txz + URL_MD5 6ac52e14ef52967fc7858220b208cba5 BINARY_DIR build CMAKE_ARGS -DCMAKE_C_COMPILER=${CMAKE_C_COMPILER} -DCMAKE_CXX_COMPILER=${CMAKE_CXX_COMPILER} -- GitLab From d201d6c2d11f8150d11e74ad58498fd1fc678d9e Mon Sep 17 00:00:00 2001 From: mkanski Date: Tue, 30 Jul 2019 10:18:53 +0200 Subject: [PATCH 367/469] fix grammar error --- doc/src/create_atoms.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/create_atoms.txt b/doc/src/create_atoms.txt index e673849793..2c97194cba 100644 --- a/doc/src/create_atoms.txt +++ b/doc/src/create_atoms.txt @@ -242,7 +242,7 @@ write_dump all atom sinusoid.lammpstrj :pre :c,image(JPG/sinusoid_small.jpg,JPG/sinusoid.jpg) -The {rotate} keyword allows to specify the orientation +The {rotate} keyword allows specification of the orientation at which molecules are inserted. The axis of rotation is determined by the rotation vector (Rx,Ry,Rz) that goes through the insertion point. The specified {theta} determines the angle of -- GitLab From 3ee86470bbb2cd93cca8c9d7b90d3937d7518c51 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 05:53:28 -0400 Subject: [PATCH 368/469] correct documentation URL for PLUMED --- doc/src/fix_plumed.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/fix_plumed.txt b/doc/src/fix_plumed.txt index 97b3150a0b..86807f531d 100644 --- a/doc/src/fix_plumed.txt +++ b/doc/src/fix_plumed.txt @@ -114,5 +114,5 @@ The default options are plumedfile = NULL and outfile = NULL :link(PLUMED) [(PLUMED)] G.A. Tribello, M. Bonomi, D. Branduardi, C. Camilloni and G. Bussi, Comp. Phys. Comm 185, 604 (2014) -:link(plumeddocs,http://www.plumed.org/documentation) +:link(plumeddocs,http://www.plumed.org/doc.html) :link(plumedhome,http://www.plumed.org/) -- GitLab From 7ab7691c5122f5fc33c0b60bfa02b696d7ccb65d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 05:57:57 -0400 Subject: [PATCH 369/469] update PLUMED support to version 2.5.2 --- cmake/Modules/Packages/USER-PLUMED.cmake | 4 ++-- lib/plumed/Install.py | 3 ++- 2 files changed, 4 insertions(+), 3 deletions(-) diff --git a/cmake/Modules/Packages/USER-PLUMED.cmake b/cmake/Modules/Packages/USER-PLUMED.cmake index 35533f01ef..a9c5a59338 100644 --- a/cmake/Modules/Packages/USER-PLUMED.cmake +++ b/cmake/Modules/Packages/USER-PLUMED.cmake @@ -43,8 +43,8 @@ if(PKG_USER-PLUMED) message(STATUS "PLUMED download requested - we will build our own") include(ExternalProject) ExternalProject_Add(plumed_build - URL https://github.com/plumed/plumed2/releases/download/v2.5.1/plumed-src-2.5.1.tgz - URL_MD5 c2a7b519e32197a120cdf47e0f194f81 + URL https://github.com/plumed/plumed2/releases/download/v2.5.2/plumed-src-2.5.2.tgz + URL_MD5 bd2f18346c788eb54e1e52f4f6acf41a BUILD_IN_SOURCE 1 CONFIGURE_COMMAND /configure --prefix= ${CONFIGURE_REQUEST_PIC} diff --git a/lib/plumed/Install.py b/lib/plumed/Install.py index 3623a8cff0..a59200d1f8 100644 --- a/lib/plumed/Install.py +++ b/lib/plumed/Install.py @@ -17,7 +17,7 @@ parser = ArgumentParser(prog='Install.py', # settings -version = "2.5.1" +version = "2.5.2" mode = "static" # help message @@ -44,6 +44,7 @@ checksums = { \ '2.4.4' : '71ed465bdc7c2059e282dbda8d564e71', \ '2.5.0' : '6224cd089493661e19ceacccd35cf911', \ '2.5.1' : 'c2a7b519e32197a120cdf47e0f194f81', \ + '2.5.2' : 'bd2f18346c788eb54e1e52f4f6acf41a', \ } # parse and process arguments -- GitLab From 3fdadb587554308e1db82e5d3ac4838850f61f58 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 06:02:47 -0400 Subject: [PATCH 370/469] add configuration for linking VTK 7.1 on Ubuntu 18.04 --- lib/vtk/Makefile.lammps.ubuntu18.04_vtk7 | 12 ++++++++++++ 1 file changed, 12 insertions(+) create mode 100644 lib/vtk/Makefile.lammps.ubuntu18.04_vtk7 diff --git a/lib/vtk/Makefile.lammps.ubuntu18.04_vtk7 b/lib/vtk/Makefile.lammps.ubuntu18.04_vtk7 new file mode 100644 index 0000000000..c833a5f67c --- /dev/null +++ b/lib/vtk/Makefile.lammps.ubuntu18.04_vtk7 @@ -0,0 +1,12 @@ +# Settings that the LAMMPS build will import when this package library is used +# +# Ubuntu 18.04 installation of VTK7 library: +# ------------------------------------------ +# +# Execute the following installation command: +# +# $ sudo apt-get install libvtk7-dev +# +vtk_SYSINC = -I/usr/include/vtk7.1 +vtk_SYSLIB = -lvtkCommonCore-7.1 -lvtkIOCore-7.1 -lvtkIOXML-7.1 -lvtkIOLegacy-7.1 -lvtkCommonDataModel-7.1 -lvtkIOParallelXML-7.1 +vtk_SYSPATH = -L/usr/lib/x86_64-linux-gnu -- GitLab From 3559c25bd9d91167e4dcec040dcda6348cdc349c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 06:35:35 -0400 Subject: [PATCH 371/469] add missing parenthesis --- src/compute_chunk_spread_atom.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/compute_chunk_spread_atom.cpp b/src/compute_chunk_spread_atom.cpp index 4beeb2b010..a58c52d8e8 100644 --- a/src/compute_chunk_spread_atom.cpp +++ b/src/compute_chunk_spread_atom.cpp @@ -117,7 +117,7 @@ ComputeChunkSpreadAtom(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Compute ID for compute chunk/spread/atom " "does not exist"); - if (!utils::strmatch(modify->compute[icompute]->style,"/chunk$") + if (!utils::strmatch(modify->compute[icompute]->style,"/chunk$")) error->all(FLERR,"Compute for compute chunk/spread/atom " "does not calculate per-chunk values"); -- GitLab From b0bccfd8a10b8418da9490c54c5e5ae83864b837 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 06:55:47 -0400 Subject: [PATCH 372/469] fix typo --- src/GRANULAR/fix_pour.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/GRANULAR/fix_pour.cpp b/src/GRANULAR/fix_pour.cpp index 4972d8f3f4..f7cf408e78 100644 --- a/src/GRANULAR/fix_pour.cpp +++ b/src/GRANULAR/fix_pour.cpp @@ -182,7 +182,7 @@ FixPour::FixPour(LAMMPS *lmp, int narg, char **arg) : int ifix; for (ifix = 0; ifix < modify->nfix; ifix++) - if (utils:strmatch(modify->fix[ifix]->style,"^gravity")) break; + if (utils::strmatch(modify->fix[ifix]->style,"^gravity")) break; if (ifix == modify->nfix) error->all(FLERR,"No fix gravity defined for fix pour"); -- GitLab From d1e8d7cbf88f102af94715f1cd65ec9936c2217f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 08:26:11 -0400 Subject: [PATCH 373/469] Step version string for next patch release --- doc/lammps.1 | 2 +- doc/src/Manual.txt | 4 ++-- src/version.h | 2 +- 3 files changed, 4 insertions(+), 4 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index 4685ad22a3..9a3d7e78c8 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,4 +1,4 @@ -.TH LAMMPS "19 July 2019" "2019-07-19" +.TH LAMMPS "31 July 2019" "2019-07-31" .SH NAME .B LAMMPS \- Molecular Dynamics Simulator. diff --git a/doc/src/Manual.txt b/doc/src/Manual.txt index 80d72aac57..927ee780e4 100644 --- a/doc/src/Manual.txt +++ b/doc/src/Manual.txt @@ -1,7 +1,7 @@ LAMMPS Users Manual - + @@ -21,7 +21,7 @@ :line LAMMPS Documentation :c,h1 -19 Jul 2019 version :c,h2 +31 Jul 2019 version :c,h2 "What is a LAMMPS version?"_Manual_version.html diff --git a/src/version.h b/src/version.h index 8a8cbec57e..9007966450 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "19 Jul 2019" +#define LAMMPS_VERSION "31 Jul 2019" -- GitLab From 354855147983862c1830af93970db678e3c2dc09 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Tue, 30 Jul 2019 08:49:58 -0600 Subject: [PATCH 374/469] Fix Kokkos package compile error --- src/KOKKOS/fix_neigh_history_kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/fix_neigh_history_kokkos.cpp b/src/KOKKOS/fix_neigh_history_kokkos.cpp index 5f53950fe6..8cfe7111dd 100644 --- a/src/KOKKOS/fix_neigh_history_kokkos.cpp +++ b/src/KOKKOS/fix_neigh_history_kokkos.cpp @@ -99,7 +99,7 @@ void FixNeighHistoryKokkos::pre_exchange() copymode = 0; - comm->maxexchange_fix = MAX(comm->maxexchange_fix,(dnum+1)*maxpartner+1); + maxexchange = (dnum+1)*maxpartner+1; } /* ---------------------------------------------------------------------- */ -- GitLab From 602b4a47c0dad33501990a0601b89ec29e8abfbb Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Tue, 30 Jul 2019 10:37:27 -0600 Subject: [PATCH 375/469] Fix failing regression test --- examples/USER/eff/Be-solid/data.Be-solid | 2016 +++++++++++----------- 1 file changed, 1008 insertions(+), 1008 deletions(-) diff --git a/examples/USER/eff/Be-solid/data.Be-solid b/examples/USER/eff/Be-solid/data.Be-solid index e13aebf738..aa2e0a00aa 100644 --- a/examples/USER/eff/Be-solid/data.Be-solid +++ b/examples/USER/eff/Be-solid/data.Be-solid @@ -12115,7 +12115,7 @@ Atoms 12099 2 0.000000 1 2.500000 5.740000 7.290779 1.756250 12100 2 0.000000 -1 2.500000 5.740000 7.290779 1.756250 12101 2 0.000000 1 2.500000 63.140000 5.965183 5.268750 -12102 2 0.000000 -1.000000 2.500000 63.140000 5.965183 5.268750 +12102 2 0.000000 -1 2.500000 63.140000 5.965183 5.268750 12103 2 0.000000 1 2.500000 1.148000 1.988394 5.268750 12104 2 0.000000 -1 2.500000 1.148000 1.988394 5.268750 12105 2 0.000000 1 2.500000 3.444000 3.313991 8.781250 @@ -12123,7 +12123,7 @@ Atoms 12107 2 0.000000 1 2.500000 5.740000 7.290779 8.781250 12108 2 0.000000 -1 2.500000 5.740000 7.290779 8.781250 12109 2 0.000000 1 2.500000 63.140000 5.965183 12.293750 -12110 2 0.000000 -1.000000 2.500000 63.140000 5.965183 12.293750 +12110 2 0.000000 -1 2.500000 63.140000 5.965183 12.293750 12111 2 0.000000 1 2.500000 1.148000 1.988394 12.293750 12112 2 0.000000 -1 2.500000 1.148000 1.988394 12.293750 12113 2 0.000000 1 2.500000 3.444000 3.313991 15.806250 @@ -12131,7 +12131,7 @@ Atoms 12115 2 0.000000 1 2.500000 5.740000 7.290779 15.806250 12116 2 0.000000 -1 2.500000 5.740000 7.290779 15.806250 12117 2 0.000000 1 2.500000 63.140000 5.965183 19.318750 -12118 2 0.000000 -1.000000 2.500000 63.140000 5.965183 19.318750 +12118 2 0.000000 -1 2.500000 63.140000 5.965183 19.318750 12119 2 0.000000 1 2.500000 1.148000 1.988394 19.318750 12120 2 0.000000 -1 2.500000 1.148000 1.988394 19.318750 12121 2 0.000000 1 2.500000 3.444000 3.313991 22.831250 @@ -12139,7 +12139,7 @@ Atoms 12123 2 0.000000 1 2.500000 5.740000 7.290779 22.831250 12124 2 0.000000 -1 2.500000 5.740000 7.290779 22.831250 12125 2 0.000000 1 2.500000 63.140000 5.965183 26.343750 -12126 2 0.000000 -1.000000 2.500000 63.140000 5.965183 26.343750 +12126 2 0.000000 -1 2.500000 63.140000 5.965183 26.343750 12127 2 0.000000 1 2.500000 1.148000 1.988394 26.343750 12128 2 0.000000 -1 2.500000 1.148000 1.988394 26.343750 12129 2 0.000000 1 2.500000 3.444000 3.313991 29.856250 @@ -12147,7 +12147,7 @@ Atoms 12131 2 0.000000 1 2.500000 5.740000 7.290779 29.856250 12132 2 0.000000 -1 2.500000 5.740000 7.290779 29.856250 12133 2 0.000000 1 2.500000 63.140000 5.965183 33.368750 -12134 2 0.000000 -1.000000 2.500000 63.140000 5.965183 33.368750 +12134 2 0.000000 -1 2.500000 63.140000 5.965183 33.368750 12135 2 0.000000 1 2.500000 1.148000 1.988394 33.368750 12136 2 0.000000 -1 2.500000 1.148000 1.988394 33.368750 12137 2 0.000000 1 2.500000 3.444000 3.313991 36.881250 @@ -12155,7 +12155,7 @@ Atoms 12139 2 0.000000 1 2.500000 5.740000 7.290779 36.881250 12140 2 0.000000 -1 2.500000 5.740000 7.290779 36.881250 12141 2 0.000000 1 2.500000 63.140000 5.965183 40.393750 -12142 2 0.000000 -1.000000 2.500000 63.140000 5.965183 40.393750 +12142 2 0.000000 -1 2.500000 63.140000 5.965183 40.393750 12143 2 0.000000 1 2.500000 1.148000 1.988394 40.393750 12144 2 0.000000 -1 2.500000 1.148000 1.988394 40.393750 12145 2 0.000000 1 2.500000 3.444000 3.313991 43.906250 @@ -12163,7 +12163,7 @@ Atoms 12147 2 0.000000 1 2.500000 5.740000 7.290779 43.906250 12148 2 0.000000 -1 2.500000 5.740000 7.290779 43.906250 12149 2 0.000000 1 2.500000 63.140000 5.965183 47.418750 -12150 2 0.000000 -1.000000 2.500000 63.140000 5.965183 47.418750 +12150 2 0.000000 -1 2.500000 63.140000 5.965183 47.418750 12151 2 0.000000 1 2.500000 1.148000 1.988394 47.418750 12152 2 0.000000 -1 2.500000 1.148000 1.988394 47.418750 12153 2 0.000000 1 2.500000 3.444000 3.313991 50.931250 @@ -12171,7 +12171,7 @@ Atoms 12155 2 0.000000 1 2.500000 5.740000 7.290779 50.931250 12156 2 0.000000 -1 2.500000 5.740000 7.290779 50.931250 12157 2 0.000000 1 2.500000 63.140000 5.965183 54.443750 -12158 2 0.000000 -1.000000 2.500000 63.140000 5.965183 54.443750 +12158 2 0.000000 -1 2.500000 63.140000 5.965183 54.443750 12159 2 0.000000 1 2.500000 1.148000 1.988394 54.443750 12160 2 0.000000 -1 2.500000 1.148000 1.988394 54.443750 12161 2 0.000000 1 2.500000 3.444000 3.313991 57.956250 @@ -12179,7 +12179,7 @@ Atoms 12163 2 0.000000 1 2.500000 5.740000 7.290779 57.956250 12164 2 0.000000 -1 2.500000 5.740000 7.290779 57.956250 12165 2 0.000000 1 2.500000 63.140000 5.965183 61.468750 -12166 2 0.000000 -1.000000 2.500000 63.140000 5.965183 61.468750 +12166 2 0.000000 -1 2.500000 63.140000 5.965183 61.468750 12167 2 0.000000 1 2.500000 1.148000 1.988394 61.468750 12168 2 0.000000 -1 2.500000 1.148000 1.988394 61.468750 12169 2 0.000000 1 2.500000 3.444000 11.267568 1.756250 @@ -12187,7 +12187,7 @@ Atoms 12171 2 0.000000 1 2.500000 5.740000 15.244357 1.756250 12172 2 0.000000 -1 2.500000 5.740000 15.244357 1.756250 12173 2 0.000000 1 2.500000 63.140000 13.918760 5.268750 -12174 2 0.000000 -1.000000 2.500000 63.140000 13.918760 5.268750 +12174 2 0.000000 -1 2.500000 63.140000 13.918760 5.268750 12175 2 0.000000 1 2.500000 1.148000 9.941972 5.268750 12176 2 0.000000 -1 2.500000 1.148000 9.941972 5.268750 12177 2 0.000000 1 2.500000 3.444000 11.267568 8.781250 @@ -12195,7 +12195,7 @@ Atoms 12179 2 0.000000 1 2.500000 5.740000 15.244357 8.781250 12180 2 0.000000 -1 2.500000 5.740000 15.244357 8.781250 12181 2 0.000000 1 2.500000 63.140000 13.918760 12.293750 -12182 2 0.000000 -1.000000 2.500000 63.140000 13.918760 12.293750 +12182 2 0.000000 -1 2.500000 63.140000 13.918760 12.293750 12183 2 0.000000 1 2.500000 1.148000 9.941972 12.293750 12184 2 0.000000 -1 2.500000 1.148000 9.941972 12.293750 12185 2 0.000000 1 2.500000 3.444000 11.267568 15.806250 @@ -12203,7 +12203,7 @@ Atoms 12187 2 0.000000 1 2.500000 5.740000 15.244357 15.806250 12188 2 0.000000 -1 2.500000 5.740000 15.244357 15.806250 12189 2 0.000000 1 2.500000 63.140000 13.918760 19.318750 -12190 2 0.000000 -1.000000 2.500000 63.140000 13.918760 19.318750 +12190 2 0.000000 -1 2.500000 63.140000 13.918760 19.318750 12191 2 0.000000 1 2.500000 1.148000 9.941972 19.318750 12192 2 0.000000 -1 2.500000 1.148000 9.941972 19.318750 12193 2 0.000000 1 2.500000 3.444000 11.267568 22.831250 @@ -12211,7 +12211,7 @@ Atoms 12195 2 0.000000 1 2.500000 5.740000 15.244357 22.831250 12196 2 0.000000 -1 2.500000 5.740000 15.244357 22.831250 12197 2 0.000000 1 2.500000 63.140000 13.918760 26.343750 -12198 2 0.000000 -1.000000 2.500000 63.140000 13.918760 26.343750 +12198 2 0.000000 -1 2.500000 63.140000 13.918760 26.343750 12199 2 0.000000 1 2.500000 1.148000 9.941972 26.343750 12200 2 0.000000 -1 2.500000 1.148000 9.941972 26.343750 12201 2 0.000000 1 2.500000 3.444000 11.267568 29.856250 @@ -12219,7 +12219,7 @@ Atoms 12203 2 0.000000 1 2.500000 5.740000 15.244357 29.856250 12204 2 0.000000 -1 2.500000 5.740000 15.244357 29.856250 12205 2 0.000000 1 2.500000 63.140000 13.918760 33.368750 -12206 2 0.000000 -1.000000 2.500000 63.140000 13.918760 33.368750 +12206 2 0.000000 -1 2.500000 63.140000 13.918760 33.368750 12207 2 0.000000 1 2.500000 1.148000 9.941972 33.368750 12208 2 0.000000 -1 2.500000 1.148000 9.941972 33.368750 12209 2 0.000000 1 2.500000 3.444000 11.267568 36.881250 @@ -12227,7 +12227,7 @@ Atoms 12211 2 0.000000 1 2.500000 5.740000 15.244357 36.881250 12212 2 0.000000 -1 2.500000 5.740000 15.244357 36.881250 12213 2 0.000000 1 2.500000 63.140000 13.918760 40.393750 -12214 2 0.000000 -1.000000 2.500000 63.140000 13.918760 40.393750 +12214 2 0.000000 -1 2.500000 63.140000 13.918760 40.393750 12215 2 0.000000 1 2.500000 1.148000 9.941972 40.393750 12216 2 0.000000 -1 2.500000 1.148000 9.941972 40.393750 12217 2 0.000000 1 2.500000 3.444000 11.267568 43.906250 @@ -12235,7 +12235,7 @@ Atoms 12219 2 0.000000 1 2.500000 5.740000 15.244357 43.906250 12220 2 0.000000 -1 2.500000 5.740000 15.244357 43.906250 12221 2 0.000000 1 2.500000 63.140000 13.918760 47.418750 -12222 2 0.000000 -1.000000 2.500000 63.140000 13.918760 47.418750 +12222 2 0.000000 -1 2.500000 63.140000 13.918760 47.418750 12223 2 0.000000 1 2.500000 1.148000 9.941972 47.418750 12224 2 0.000000 -1 2.500000 1.148000 9.941972 47.418750 12225 2 0.000000 1 2.500000 3.444000 11.267568 50.931250 @@ -12243,7 +12243,7 @@ Atoms 12227 2 0.000000 1 2.500000 5.740000 15.244357 50.931250 12228 2 0.000000 -1 2.500000 5.740000 15.244357 50.931250 12229 2 0.000000 1 2.500000 63.140000 13.918760 54.443750 -12230 2 0.000000 -1.000000 2.500000 63.140000 13.918760 54.443750 +12230 2 0.000000 -1 2.500000 63.140000 13.918760 54.443750 12231 2 0.000000 1 2.500000 1.148000 9.941972 54.443750 12232 2 0.000000 -1 2.500000 1.148000 9.941972 54.443750 12233 2 0.000000 1 2.500000 3.444000 11.267568 57.956250 @@ -12251,7 +12251,7 @@ Atoms 12235 2 0.000000 1 2.500000 5.740000 15.244357 57.956250 12236 2 0.000000 -1 2.500000 5.740000 15.244357 57.956250 12237 2 0.000000 1 2.500000 63.140000 13.918760 61.468750 -12238 2 0.000000 -1.000000 2.500000 63.140000 13.918760 61.468750 +12238 2 0.000000 -1 2.500000 63.140000 13.918760 61.468750 12239 2 0.000000 1 2.500000 1.148000 9.941972 61.468750 12240 2 0.000000 -1 2.500000 1.148000 9.941972 61.468750 12241 2 0.000000 1 2.500000 3.444000 19.221145 1.756250 @@ -12259,7 +12259,7 @@ Atoms 12243 2 0.000000 1 2.500000 5.740000 23.197934 1.756250 12244 2 0.000000 -1 2.500000 5.740000 23.197934 1.756250 12245 2 0.000000 1 2.500000 63.140000 21.872338 5.268750 -12246 2 0.000000 -1.000000 2.500000 63.140000 21.872338 5.268750 +12246 2 0.000000 -1 2.500000 63.140000 21.872338 5.268750 12247 2 0.000000 1 2.500000 1.148000 17.895549 5.268750 12248 2 0.000000 -1 2.500000 1.148000 17.895549 5.268750 12249 2 0.000000 1 2.500000 3.444000 19.221145 8.781250 @@ -12267,7 +12267,7 @@ Atoms 12251 2 0.000000 1 2.500000 5.740000 23.197934 8.781250 12252 2 0.000000 -1 2.500000 5.740000 23.197934 8.781250 12253 2 0.000000 1 2.500000 63.140000 21.872338 12.293750 -12254 2 0.000000 -1.000000 2.500000 63.140000 21.872338 12.293750 +12254 2 0.000000 -1 2.500000 63.140000 21.872338 12.293750 12255 2 0.000000 1 2.500000 1.148000 17.895549 12.293750 12256 2 0.000000 -1 2.500000 1.148000 17.895549 12.293750 12257 2 0.000000 1 2.500000 3.444000 19.221145 15.806250 @@ -12275,7 +12275,7 @@ Atoms 12259 2 0.000000 1 2.500000 5.740000 23.197934 15.806250 12260 2 0.000000 -1 2.500000 5.740000 23.197934 15.806250 12261 2 0.000000 1 2.500000 63.140000 21.872338 19.318750 -12262 2 0.000000 -1.000000 2.500000 63.140000 21.872338 19.318750 +12262 2 0.000000 -1 2.500000 63.140000 21.872338 19.318750 12263 2 0.000000 1 2.500000 1.148000 17.895549 19.318750 12264 2 0.000000 -1 2.500000 1.148000 17.895549 19.318750 12265 2 0.000000 1 2.500000 3.444000 19.221145 22.831250 @@ -12283,7 +12283,7 @@ Atoms 12267 2 0.000000 1 2.500000 5.740000 23.197934 22.831250 12268 2 0.000000 -1 2.500000 5.740000 23.197934 22.831250 12269 2 0.000000 1 2.500000 63.140000 21.872338 26.343750 -12270 2 0.000000 -1.000000 2.500000 63.140000 21.872338 26.343750 +12270 2 0.000000 -1 2.500000 63.140000 21.872338 26.343750 12271 2 0.000000 1 2.500000 1.148000 17.895549 26.343750 12272 2 0.000000 -1 2.500000 1.148000 17.895549 26.343750 12273 2 0.000000 1 2.500000 3.444000 19.221145 29.856250 @@ -12291,7 +12291,7 @@ Atoms 12275 2 0.000000 1 2.500000 5.740000 23.197934 29.856250 12276 2 0.000000 -1 2.500000 5.740000 23.197934 29.856250 12277 2 0.000000 1 2.500000 63.140000 21.872338 33.368750 -12278 2 0.000000 -1.000000 2.500000 63.140000 21.872338 33.368750 +12278 2 0.000000 -1 2.500000 63.140000 21.872338 33.368750 12279 2 0.000000 1 2.500000 1.148000 17.895549 33.368750 12280 2 0.000000 -1 2.500000 1.148000 17.895549 33.368750 12281 2 0.000000 1 2.500000 3.444000 19.221145 36.881250 @@ -12299,7 +12299,7 @@ Atoms 12283 2 0.000000 1 2.500000 5.740000 23.197934 36.881250 12284 2 0.000000 -1 2.500000 5.740000 23.197934 36.881250 12285 2 0.000000 1 2.500000 63.140000 21.872338 40.393750 -12286 2 0.000000 -1.000000 2.500000 63.140000 21.872338 40.393750 +12286 2 0.000000 -1 2.500000 63.140000 21.872338 40.393750 12287 2 0.000000 1 2.500000 1.148000 17.895549 40.393750 12288 2 0.000000 -1 2.500000 1.148000 17.895549 40.393750 12289 2 0.000000 1 2.500000 3.444000 19.221145 43.906250 @@ -12307,7 +12307,7 @@ Atoms 12291 2 0.000000 1 2.500000 5.740000 23.197934 43.906250 12292 2 0.000000 -1 2.500000 5.740000 23.197934 43.906250 12293 2 0.000000 1 2.500000 63.140000 21.872338 47.418750 -12294 2 0.000000 -1.000000 2.500000 63.140000 21.872338 47.418750 +12294 2 0.000000 -1 2.500000 63.140000 21.872338 47.418750 12295 2 0.000000 1 2.500000 1.148000 17.895549 47.418750 12296 2 0.000000 -1 2.500000 1.148000 17.895549 47.418750 12297 2 0.000000 1 2.500000 3.444000 19.221145 50.931250 @@ -12315,7 +12315,7 @@ Atoms 12299 2 0.000000 1 2.500000 5.740000 23.197934 50.931250 12300 2 0.000000 -1 2.500000 5.740000 23.197934 50.931250 12301 2 0.000000 1 2.500000 63.140000 21.872338 54.443750 -12302 2 0.000000 -1.000000 2.500000 63.140000 21.872338 54.443750 +12302 2 0.000000 -1 2.500000 63.140000 21.872338 54.443750 12303 2 0.000000 1 2.500000 1.148000 17.895549 54.443750 12304 2 0.000000 -1 2.500000 1.148000 17.895549 54.443750 12305 2 0.000000 1 2.500000 3.444000 19.221145 57.956250 @@ -12323,7 +12323,7 @@ Atoms 12307 2 0.000000 1 2.500000 5.740000 23.197934 57.956250 12308 2 0.000000 -1 2.500000 5.740000 23.197934 57.956250 12309 2 0.000000 1 2.500000 63.140000 21.872338 61.468750 -12310 2 0.000000 -1.000000 2.500000 63.140000 21.872338 61.468750 +12310 2 0.000000 -1 2.500000 63.140000 21.872338 61.468750 12311 2 0.000000 1 2.500000 1.148000 17.895549 61.468750 12312 2 0.000000 -1 2.500000 1.148000 17.895549 61.468750 12313 2 0.000000 1 2.500000 3.444000 27.174722 1.756250 @@ -12331,7 +12331,7 @@ Atoms 12315 2 0.000000 1 2.500000 5.740000 31.151511 1.756250 12316 2 0.000000 -1 2.500000 5.740000 31.151511 1.756250 12317 2 0.000000 1 2.500000 63.140000 29.825915 5.268750 -12318 2 0.000000 -1.000000 2.500000 63.140000 29.825915 5.268750 +12318 2 0.000000 -1 2.500000 63.140000 29.825915 5.268750 12319 2 0.000000 1 2.500000 1.148000 25.849126 5.268750 12320 2 0.000000 -1 2.500000 1.148000 25.849126 5.268750 12321 2 0.000000 1 2.500000 3.444000 27.174722 8.781250 @@ -12339,7 +12339,7 @@ Atoms 12323 2 0.000000 1 2.500000 5.740000 31.151511 8.781250 12324 2 0.000000 -1 2.500000 5.740000 31.151511 8.781250 12325 2 0.000000 1 2.500000 63.140000 29.825915 12.293750 -12326 2 0.000000 -1.000000 2.500000 63.140000 29.825915 12.293750 +12326 2 0.000000 -1 2.500000 63.140000 29.825915 12.293750 12327 2 0.000000 1 2.500000 1.148000 25.849126 12.293750 12328 2 0.000000 -1 2.500000 1.148000 25.849126 12.293750 12329 2 0.000000 1 2.500000 3.444000 27.174722 15.806250 @@ -12347,7 +12347,7 @@ Atoms 12331 2 0.000000 1 2.500000 5.740000 31.151511 15.806250 12332 2 0.000000 -1 2.500000 5.740000 31.151511 15.806250 12333 2 0.000000 1 2.500000 63.140000 29.825915 19.318750 -12334 2 0.000000 -1.000000 2.500000 63.140000 29.825915 19.318750 +12334 2 0.000000 -1 2.500000 63.140000 29.825915 19.318750 12335 2 0.000000 1 2.500000 1.148000 25.849126 19.318750 12336 2 0.000000 -1 2.500000 1.148000 25.849126 19.318750 12337 2 0.000000 1 2.500000 3.444000 27.174722 22.831250 @@ -12355,7 +12355,7 @@ Atoms 12339 2 0.000000 1 2.500000 5.740000 31.151511 22.831250 12340 2 0.000000 -1 2.500000 5.740000 31.151511 22.831250 12341 2 0.000000 1 2.500000 63.140000 29.825915 26.343750 -12342 2 0.000000 -1.000000 2.500000 63.140000 29.825915 26.343750 +12342 2 0.000000 -1 2.500000 63.140000 29.825915 26.343750 12343 2 0.000000 1 2.500000 1.148000 25.849126 26.343750 12344 2 0.000000 -1 2.500000 1.148000 25.849126 26.343750 12345 2 0.000000 1 2.500000 3.444000 27.174722 29.856250 @@ -12363,7 +12363,7 @@ Atoms 12347 2 0.000000 1 2.500000 5.740000 31.151511 29.856250 12348 2 0.000000 -1 2.500000 5.740000 31.151511 29.856250 12349 2 0.000000 1 2.500000 63.140000 29.825915 33.368750 -12350 2 0.000000 -1.000000 2.500000 63.140000 29.825915 33.368750 +12350 2 0.000000 -1 2.500000 63.140000 29.825915 33.368750 12351 2 0.000000 1 2.500000 1.148000 25.849126 33.368750 12352 2 0.000000 -1 2.500000 1.148000 25.849126 33.368750 12353 2 0.000000 1 2.500000 3.444000 27.174722 36.881250 @@ -12371,7 +12371,7 @@ Atoms 12355 2 0.000000 1 2.500000 5.740000 31.151511 36.881250 12356 2 0.000000 -1 2.500000 5.740000 31.151511 36.881250 12357 2 0.000000 1 2.500000 63.140000 29.825915 40.393750 -12358 2 0.000000 -1.000000 2.500000 63.140000 29.825915 40.393750 +12358 2 0.000000 -1 2.500000 63.140000 29.825915 40.393750 12359 2 0.000000 1 2.500000 1.148000 25.849126 40.393750 12360 2 0.000000 -1 2.500000 1.148000 25.849126 40.393750 12361 2 0.000000 1 2.500000 3.444000 27.174722 43.906250 @@ -12379,7 +12379,7 @@ Atoms 12363 2 0.000000 1 2.500000 5.740000 31.151511 43.906250 12364 2 0.000000 -1 2.500000 5.740000 31.151511 43.906250 12365 2 0.000000 1 2.500000 63.140000 29.825915 47.418750 -12366 2 0.000000 -1.000000 2.500000 63.140000 29.825915 47.418750 +12366 2 0.000000 -1 2.500000 63.140000 29.825915 47.418750 12367 2 0.000000 1 2.500000 1.148000 25.849126 47.418750 12368 2 0.000000 -1 2.500000 1.148000 25.849126 47.418750 12369 2 0.000000 1 2.500000 3.444000 27.174722 50.931250 @@ -12387,7 +12387,7 @@ Atoms 12371 2 0.000000 1 2.500000 5.740000 31.151511 50.931250 12372 2 0.000000 -1 2.500000 5.740000 31.151511 50.931250 12373 2 0.000000 1 2.500000 63.140000 29.825915 54.443750 -12374 2 0.000000 -1.000000 2.500000 63.140000 29.825915 54.443750 +12374 2 0.000000 -1 2.500000 63.140000 29.825915 54.443750 12375 2 0.000000 1 2.500000 1.148000 25.849126 54.443750 12376 2 0.000000 -1 2.500000 1.148000 25.849126 54.443750 12377 2 0.000000 1 2.500000 3.444000 27.174722 57.956250 @@ -12395,7 +12395,7 @@ Atoms 12379 2 0.000000 1 2.500000 5.740000 31.151511 57.956250 12380 2 0.000000 -1 2.500000 5.740000 31.151511 57.956250 12381 2 0.000000 1 2.500000 63.140000 29.825915 61.468750 -12382 2 0.000000 -1.000000 2.500000 63.140000 29.825915 61.468750 +12382 2 0.000000 -1 2.500000 63.140000 29.825915 61.468750 12383 2 0.000000 1 2.500000 1.148000 25.849126 61.468750 12384 2 0.000000 -1 2.500000 1.148000 25.849126 61.468750 12385 2 0.000000 1 2.500000 3.444000 35.128300 1.756250 @@ -12403,7 +12403,7 @@ Atoms 12387 2 0.000000 1 2.500000 5.740000 39.105088 1.756250 12388 2 0.000000 -1 2.500000 5.740000 39.105088 1.756250 12389 2 0.000000 1 2.500000 63.140000 37.779492 5.268750 -12390 2 0.000000 -1.000000 2.500000 63.140000 37.779492 5.268750 +12390 2 0.000000 -1 2.500000 63.140000 37.779492 5.268750 12391 2 0.000000 1 2.500000 1.148000 33.802704 5.268750 12392 2 0.000000 -1 2.500000 1.148000 33.802704 5.268750 12393 2 0.000000 1 2.500000 3.444000 35.128300 8.781250 @@ -12411,7 +12411,7 @@ Atoms 12395 2 0.000000 1 2.500000 5.740000 39.105088 8.781250 12396 2 0.000000 -1 2.500000 5.740000 39.105088 8.781250 12397 2 0.000000 1 2.500000 63.140000 37.779492 12.293750 -12398 2 0.000000 -1.000000 2.500000 63.140000 37.779492 12.293750 +12398 2 0.000000 -1 2.500000 63.140000 37.779492 12.293750 12399 2 0.000000 1 2.500000 1.148000 33.802704 12.293750 12400 2 0.000000 -1 2.500000 1.148000 33.802704 12.293750 12401 2 0.000000 1 2.500000 3.444000 35.128300 15.806250 @@ -12419,7 +12419,7 @@ Atoms 12403 2 0.000000 1 2.500000 5.740000 39.105088 15.806250 12404 2 0.000000 -1 2.500000 5.740000 39.105088 15.806250 12405 2 0.000000 1 2.500000 63.140000 37.779492 19.318750 -12406 2 0.000000 -1.000000 2.500000 63.140000 37.779492 19.318750 +12406 2 0.000000 -1 2.500000 63.140000 37.779492 19.318750 12407 2 0.000000 1 2.500000 1.148000 33.802704 19.318750 12408 2 0.000000 -1 2.500000 1.148000 33.802704 19.318750 12409 2 0.000000 1 2.500000 3.444000 35.128300 22.831250 @@ -12427,7 +12427,7 @@ Atoms 12411 2 0.000000 1 2.500000 5.740000 39.105088 22.831250 12412 2 0.000000 -1 2.500000 5.740000 39.105088 22.831250 12413 2 0.000000 1 2.500000 63.140000 37.779492 26.343750 -12414 2 0.000000 -1.000000 2.500000 63.140000 37.779492 26.343750 +12414 2 0.000000 -1 2.500000 63.140000 37.779492 26.343750 12415 2 0.000000 1 2.500000 1.148000 33.802704 26.343750 12416 2 0.000000 -1 2.500000 1.148000 33.802704 26.343750 12417 2 0.000000 1 2.500000 3.444000 35.128300 29.856250 @@ -12435,7 +12435,7 @@ Atoms 12419 2 0.000000 1 2.500000 5.740000 39.105088 29.856250 12420 2 0.000000 -1 2.500000 5.740000 39.105088 29.856250 12421 2 0.000000 1 2.500000 63.140000 37.779492 33.368750 -12422 2 0.000000 -1.000000 2.500000 63.140000 37.779492 33.368750 +12422 2 0.000000 -1 2.500000 63.140000 37.779492 33.368750 12423 2 0.000000 1 2.500000 1.148000 33.802704 33.368750 12424 2 0.000000 -1 2.500000 1.148000 33.802704 33.368750 12425 2 0.000000 1 2.500000 3.444000 35.128300 36.881250 @@ -12443,7 +12443,7 @@ Atoms 12427 2 0.000000 1 2.500000 5.740000 39.105088 36.881250 12428 2 0.000000 -1 2.500000 5.740000 39.105088 36.881250 12429 2 0.000000 1 2.500000 63.140000 37.779492 40.393750 -12430 2 0.000000 -1.000000 2.500000 63.140000 37.779492 40.393750 +12430 2 0.000000 -1 2.500000 63.140000 37.779492 40.393750 12431 2 0.000000 1 2.500000 1.148000 33.802704 40.393750 12432 2 0.000000 -1 2.500000 1.148000 33.802704 40.393750 12433 2 0.000000 1 2.500000 3.444000 35.128300 43.906250 @@ -12451,7 +12451,7 @@ Atoms 12435 2 0.000000 1 2.500000 5.740000 39.105088 43.906250 12436 2 0.000000 -1 2.500000 5.740000 39.105088 43.906250 12437 2 0.000000 1 2.500000 63.140000 37.779492 47.418750 -12438 2 0.000000 -1.000000 2.500000 63.140000 37.779492 47.418750 +12438 2 0.000000 -1 2.500000 63.140000 37.779492 47.418750 12439 2 0.000000 1 2.500000 1.148000 33.802704 47.418750 12440 2 0.000000 -1 2.500000 1.148000 33.802704 47.418750 12441 2 0.000000 1 2.500000 3.444000 35.128300 50.931250 @@ -12459,7 +12459,7 @@ Atoms 12443 2 0.000000 1 2.500000 5.740000 39.105088 50.931250 12444 2 0.000000 -1 2.500000 5.740000 39.105088 50.931250 12445 2 0.000000 1 2.500000 63.140000 37.779492 54.443750 -12446 2 0.000000 -1.000000 2.500000 63.140000 37.779492 54.443750 +12446 2 0.000000 -1 2.500000 63.140000 37.779492 54.443750 12447 2 0.000000 1 2.500000 1.148000 33.802704 54.443750 12448 2 0.000000 -1 2.500000 1.148000 33.802704 54.443750 12449 2 0.000000 1 2.500000 3.444000 35.128300 57.956250 @@ -12467,7 +12467,7 @@ Atoms 12451 2 0.000000 1 2.500000 5.740000 39.105088 57.956250 12452 2 0.000000 -1 2.500000 5.740000 39.105088 57.956250 12453 2 0.000000 1 2.500000 63.140000 37.779492 61.468750 -12454 2 0.000000 -1.000000 2.500000 63.140000 37.779492 61.468750 +12454 2 0.000000 -1 2.500000 63.140000 37.779492 61.468750 12455 2 0.000000 1 2.500000 1.148000 33.802704 61.468750 12456 2 0.000000 -1 2.500000 1.148000 33.802704 61.468750 12457 2 0.000000 1 2.500000 3.444000 43.081877 1.756250 @@ -12475,7 +12475,7 @@ Atoms 12459 2 0.000000 1 2.500000 5.740000 47.058666 1.756250 12460 2 0.000000 -1 2.500000 5.740000 47.058666 1.756250 12461 2 0.000000 1 2.500000 63.140000 45.733070 5.268750 -12462 2 0.000000 -1.000000 2.500000 63.140000 45.733070 5.268750 +12462 2 0.000000 -1 2.500000 63.140000 45.733070 5.268750 12463 2 0.000000 1 2.500000 1.148000 41.756281 5.268750 12464 2 0.000000 -1 2.500000 1.148000 41.756281 5.268750 12465 2 0.000000 1 2.500000 3.444000 43.081877 8.781250 @@ -12483,7 +12483,7 @@ Atoms 12467 2 0.000000 1 2.500000 5.740000 47.058666 8.781250 12468 2 0.000000 -1 2.500000 5.740000 47.058666 8.781250 12469 2 0.000000 1 2.500000 63.140000 45.733070 12.293750 -12470 2 0.000000 -1.000000 2.500000 63.140000 45.733070 12.293750 +12470 2 0.000000 -1 2.500000 63.140000 45.733070 12.293750 12471 2 0.000000 1 2.500000 1.148000 41.756281 12.293750 12472 2 0.000000 -1 2.500000 1.148000 41.756281 12.293750 12473 2 0.000000 1 2.500000 3.444000 43.081877 15.806250 @@ -12491,7 +12491,7 @@ Atoms 12475 2 0.000000 1 2.500000 5.740000 47.058666 15.806250 12476 2 0.000000 -1 2.500000 5.740000 47.058666 15.806250 12477 2 0.000000 1 2.500000 63.140000 45.733070 19.318750 -12478 2 0.000000 -1.000000 2.500000 63.140000 45.733070 19.318750 +12478 2 0.000000 -1 2.500000 63.140000 45.733070 19.318750 12479 2 0.000000 1 2.500000 1.148000 41.756281 19.318750 12480 2 0.000000 -1 2.500000 1.148000 41.756281 19.318750 12481 2 0.000000 1 2.500000 3.444000 43.081877 22.831250 @@ -12499,7 +12499,7 @@ Atoms 12483 2 0.000000 1 2.500000 5.740000 47.058666 22.831250 12484 2 0.000000 -1 2.500000 5.740000 47.058666 22.831250 12485 2 0.000000 1 2.500000 63.140000 45.733070 26.343750 -12486 2 0.000000 -1.000000 2.500000 63.140000 45.733070 26.343750 +12486 2 0.000000 -1 2.500000 63.140000 45.733070 26.343750 12487 2 0.000000 1 2.500000 1.148000 41.756281 26.343750 12488 2 0.000000 -1 2.500000 1.148000 41.756281 26.343750 12489 2 0.000000 1 2.500000 3.444000 43.081877 29.856250 @@ -12507,7 +12507,7 @@ Atoms 12491 2 0.000000 1 2.500000 5.740000 47.058666 29.856250 12492 2 0.000000 -1 2.500000 5.740000 47.058666 29.856250 12493 2 0.000000 1 2.500000 63.140000 45.733070 33.368750 -12494 2 0.000000 -1.000000 2.500000 63.140000 45.733070 33.368750 +12494 2 0.000000 -1 2.500000 63.140000 45.733070 33.368750 12495 2 0.000000 1 2.500000 1.148000 41.756281 33.368750 12496 2 0.000000 -1 2.500000 1.148000 41.756281 33.368750 12497 2 0.000000 1 2.500000 3.444000 43.081877 36.881250 @@ -12515,7 +12515,7 @@ Atoms 12499 2 0.000000 1 2.500000 5.740000 47.058666 36.881250 12500 2 0.000000 -1 2.500000 5.740000 47.058666 36.881250 12501 2 0.000000 1 2.500000 63.140000 45.733070 40.393750 -12502 2 0.000000 -1.000000 2.500000 63.140000 45.733070 40.393750 +12502 2 0.000000 -1 2.500000 63.140000 45.733070 40.393750 12503 2 0.000000 1 2.500000 1.148000 41.756281 40.393750 12504 2 0.000000 -1 2.500000 1.148000 41.756281 40.393750 12505 2 0.000000 1 2.500000 3.444000 43.081877 43.906250 @@ -12523,7 +12523,7 @@ Atoms 12507 2 0.000000 1 2.500000 5.740000 47.058666 43.906250 12508 2 0.000000 -1 2.500000 5.740000 47.058666 43.906250 12509 2 0.000000 1 2.500000 63.140000 45.733070 47.418750 -12510 2 0.000000 -1.000000 2.500000 63.140000 45.733070 47.418750 +12510 2 0.000000 -1 2.500000 63.140000 45.733070 47.418750 12511 2 0.000000 1 2.500000 1.148000 41.756281 47.418750 12512 2 0.000000 -1 2.500000 1.148000 41.756281 47.418750 12513 2 0.000000 1 2.500000 3.444000 43.081877 50.931250 @@ -12531,7 +12531,7 @@ Atoms 12515 2 0.000000 1 2.500000 5.740000 47.058666 50.931250 12516 2 0.000000 -1 2.500000 5.740000 47.058666 50.931250 12517 2 0.000000 1 2.500000 63.140000 45.733070 54.443750 -12518 2 0.000000 -1.000000 2.500000 63.140000 45.733070 54.443750 +12518 2 0.000000 -1 2.500000 63.140000 45.733070 54.443750 12519 2 0.000000 1 2.500000 1.148000 41.756281 54.443750 12520 2 0.000000 -1 2.500000 1.148000 41.756281 54.443750 12521 2 0.000000 1 2.500000 3.444000 43.081877 57.956250 @@ -12539,7 +12539,7 @@ Atoms 12523 2 0.000000 1 2.500000 5.740000 47.058666 57.956250 12524 2 0.000000 -1 2.500000 5.740000 47.058666 57.956250 12525 2 0.000000 1 2.500000 63.140000 45.733070 61.468750 -12526 2 0.000000 -1.000000 2.500000 63.140000 45.733070 61.468750 +12526 2 0.000000 -1 2.500000 63.140000 45.733070 61.468750 12527 2 0.000000 1 2.500000 1.148000 41.756281 61.468750 12528 2 0.000000 -1 2.500000 1.148000 41.756281 61.468750 12529 2 0.000000 1 2.500000 3.444000 51.035454 1.756250 @@ -12547,7 +12547,7 @@ Atoms 12531 2 0.000000 1 2.500000 5.740000 55.012243 1.756250 12532 2 0.000000 -1 2.500000 5.740000 55.012243 1.756250 12533 2 0.000000 1 2.500000 63.140000 53.686647 5.268750 -12534 2 0.000000 -1.000000 2.500000 63.140000 53.686647 5.268750 +12534 2 0.000000 -1 2.500000 63.140000 53.686647 5.268750 12535 2 0.000000 1 2.500000 1.148000 49.709858 5.268750 12536 2 0.000000 -1 2.500000 1.148000 49.709858 5.268750 12537 2 0.000000 1 2.500000 3.444000 51.035454 8.781250 @@ -12555,7 +12555,7 @@ Atoms 12539 2 0.000000 1 2.500000 5.740000 55.012243 8.781250 12540 2 0.000000 -1 2.500000 5.740000 55.012243 8.781250 12541 2 0.000000 1 2.500000 63.140000 53.686647 12.293750 -12542 2 0.000000 -1.000000 2.500000 63.140000 53.686647 12.293750 +12542 2 0.000000 -1 2.500000 63.140000 53.686647 12.293750 12543 2 0.000000 1 2.500000 1.148000 49.709858 12.293750 12544 2 0.000000 -1 2.500000 1.148000 49.709858 12.293750 12545 2 0.000000 1 2.500000 3.444000 51.035454 15.806250 @@ -12563,7 +12563,7 @@ Atoms 12547 2 0.000000 1 2.500000 5.740000 55.012243 15.806250 12548 2 0.000000 -1 2.500000 5.740000 55.012243 15.806250 12549 2 0.000000 1 2.500000 63.140000 53.686647 19.318750 -12550 2 0.000000 -1.000000 2.500000 63.140000 53.686647 19.318750 +12550 2 0.000000 -1 2.500000 63.140000 53.686647 19.318750 12551 2 0.000000 1 2.500000 1.148000 49.709858 19.318750 12552 2 0.000000 -1 2.500000 1.148000 49.709858 19.318750 12553 2 0.000000 1 2.500000 3.444000 51.035454 22.831250 @@ -12571,7 +12571,7 @@ Atoms 12555 2 0.000000 1 2.500000 5.740000 55.012243 22.831250 12556 2 0.000000 -1 2.500000 5.740000 55.012243 22.831250 12557 2 0.000000 1 2.500000 63.140000 53.686647 26.343750 -12558 2 0.000000 -1.000000 2.500000 63.140000 53.686647 26.343750 +12558 2 0.000000 -1 2.500000 63.140000 53.686647 26.343750 12559 2 0.000000 1 2.500000 1.148000 49.709858 26.343750 12560 2 0.000000 -1 2.500000 1.148000 49.709858 26.343750 12561 2 0.000000 1 2.500000 3.444000 51.035454 29.856250 @@ -12579,7 +12579,7 @@ Atoms 12563 2 0.000000 1 2.500000 5.740000 55.012243 29.856250 12564 2 0.000000 -1 2.500000 5.740000 55.012243 29.856250 12565 2 0.000000 1 2.500000 63.140000 53.686647 33.368750 -12566 2 0.000000 -1.000000 2.500000 63.140000 53.686647 33.368750 +12566 2 0.000000 -1 2.500000 63.140000 53.686647 33.368750 12567 2 0.000000 1 2.500000 1.148000 49.709858 33.368750 12568 2 0.000000 -1 2.500000 1.148000 49.709858 33.368750 12569 2 0.000000 1 2.500000 3.444000 51.035454 36.881250 @@ -12587,7 +12587,7 @@ Atoms 12571 2 0.000000 1 2.500000 5.740000 55.012243 36.881250 12572 2 0.000000 -1 2.500000 5.740000 55.012243 36.881250 12573 2 0.000000 1 2.500000 63.140000 53.686647 40.393750 -12574 2 0.000000 -1.000000 2.500000 63.140000 53.686647 40.393750 +12574 2 0.000000 -1 2.500000 63.140000 53.686647 40.393750 12575 2 0.000000 1 2.500000 1.148000 49.709858 40.393750 12576 2 0.000000 -1 2.500000 1.148000 49.709858 40.393750 12577 2 0.000000 1 2.500000 3.444000 51.035454 43.906250 @@ -12595,7 +12595,7 @@ Atoms 12579 2 0.000000 1 2.500000 5.740000 55.012243 43.906250 12580 2 0.000000 -1 2.500000 5.740000 55.012243 43.906250 12581 2 0.000000 1 2.500000 63.140000 53.686647 47.418750 -12582 2 0.000000 -1.000000 2.500000 63.140000 53.686647 47.418750 +12582 2 0.000000 -1 2.500000 63.140000 53.686647 47.418750 12583 2 0.000000 1 2.500000 1.148000 49.709858 47.418750 12584 2 0.000000 -1 2.500000 1.148000 49.709858 47.418750 12585 2 0.000000 1 2.500000 3.444000 51.035454 50.931250 @@ -12603,7 +12603,7 @@ Atoms 12587 2 0.000000 1 2.500000 5.740000 55.012243 50.931250 12588 2 0.000000 -1 2.500000 5.740000 55.012243 50.931250 12589 2 0.000000 1 2.500000 63.140000 53.686647 54.443750 -12590 2 0.000000 -1.000000 2.500000 63.140000 53.686647 54.443750 +12590 2 0.000000 -1 2.500000 63.140000 53.686647 54.443750 12591 2 0.000000 1 2.500000 1.148000 49.709858 54.443750 12592 2 0.000000 -1 2.500000 1.148000 49.709858 54.443750 12593 2 0.000000 1 2.500000 3.444000 51.035454 57.956250 @@ -12611,7 +12611,7 @@ Atoms 12595 2 0.000000 1 2.500000 5.740000 55.012243 57.956250 12596 2 0.000000 -1 2.500000 5.740000 55.012243 57.956250 12597 2 0.000000 1 2.500000 63.140000 53.686647 61.468750 -12598 2 0.000000 -1.000000 2.500000 63.140000 53.686647 61.468750 +12598 2 0.000000 -1 2.500000 63.140000 53.686647 61.468750 12599 2 0.000000 1 2.500000 1.148000 49.709858 61.468750 12600 2 0.000000 -1 2.500000 1.148000 49.709858 61.468750 12601 2 0.000000 1 2.500000 3.444000 58.989032 1.756250 @@ -12619,7 +12619,7 @@ Atoms 12603 2 0.000000 1 2.500000 5.740000 62.965820 1.756250 12604 2 0.000000 -1 2.500000 5.740000 62.965820 1.756250 12605 2 0.000000 1 2.500000 63.140000 61.640224 5.268750 -12606 2 0.000000 -1.000000 2.500000 63.140000 61.640224 5.268750 +12606 2 0.000000 -1 2.500000 63.140000 61.640224 5.268750 12607 2 0.000000 1 2.500000 1.148000 57.663435 5.268750 12608 2 0.000000 -1 2.500000 1.148000 57.663435 5.268750 12609 2 0.000000 1 2.500000 3.444000 58.989032 8.781250 @@ -12627,7 +12627,7 @@ Atoms 12611 2 0.000000 1 2.500000 5.740000 62.965820 8.781250 12612 2 0.000000 -1 2.500000 5.740000 62.965820 8.781250 12613 2 0.000000 1 2.500000 63.140000 61.640224 12.293750 -12614 2 0.000000 -1.000000 2.500000 63.140000 61.640224 12.293750 +12614 2 0.000000 -1 2.500000 63.140000 61.640224 12.293750 12615 2 0.000000 1 2.500000 1.148000 57.663435 12.293750 12616 2 0.000000 -1 2.500000 1.148000 57.663435 12.293750 12617 2 0.000000 1 2.500000 3.444000 58.989032 15.806250 @@ -12635,7 +12635,7 @@ Atoms 12619 2 0.000000 1 2.500000 5.740000 62.965820 15.806250 12620 2 0.000000 -1 2.500000 5.740000 62.965820 15.806250 12621 2 0.000000 1 2.500000 63.140000 61.640224 19.318750 -12622 2 0.000000 -1.000000 2.500000 63.140000 61.640224 19.318750 +12622 2 0.000000 -1 2.500000 63.140000 61.640224 19.318750 12623 2 0.000000 1 2.500000 1.148000 57.663435 19.318750 12624 2 0.000000 -1 2.500000 1.148000 57.663435 19.318750 12625 2 0.000000 1 2.500000 3.444000 58.989032 22.831250 @@ -12643,7 +12643,7 @@ Atoms 12627 2 0.000000 1 2.500000 5.740000 62.965820 22.831250 12628 2 0.000000 -1 2.500000 5.740000 62.965820 22.831250 12629 2 0.000000 1 2.500000 63.140000 61.640224 26.343750 -12630 2 0.000000 -1.000000 2.500000 63.140000 61.640224 26.343750 +12630 2 0.000000 -1 2.500000 63.140000 61.640224 26.343750 12631 2 0.000000 1 2.500000 1.148000 57.663435 26.343750 12632 2 0.000000 -1 2.500000 1.148000 57.663435 26.343750 12633 2 0.000000 1 2.500000 3.444000 58.989032 29.856250 @@ -12651,7 +12651,7 @@ Atoms 12635 2 0.000000 1 2.500000 5.740000 62.965820 29.856250 12636 2 0.000000 -1 2.500000 5.740000 62.965820 29.856250 12637 2 0.000000 1 2.500000 63.140000 61.640224 33.368750 -12638 2 0.000000 -1.000000 2.500000 63.140000 61.640224 33.368750 +12638 2 0.000000 -1 2.500000 63.140000 61.640224 33.368750 12639 2 0.000000 1 2.500000 1.148000 57.663435 33.368750 12640 2 0.000000 -1 2.500000 1.148000 57.663435 33.368750 12641 2 0.000000 1 2.500000 3.444000 58.989032 36.881250 @@ -12659,7 +12659,7 @@ Atoms 12643 2 0.000000 1 2.500000 5.740000 62.965820 36.881250 12644 2 0.000000 -1 2.500000 5.740000 62.965820 36.881250 12645 2 0.000000 1 2.500000 63.140000 61.640224 40.393750 -12646 2 0.000000 -1.000000 2.500000 63.140000 61.640224 40.393750 +12646 2 0.000000 -1 2.500000 63.140000 61.640224 40.393750 12647 2 0.000000 1 2.500000 1.148000 57.663435 40.393750 12648 2 0.000000 -1 2.500000 1.148000 57.663435 40.393750 12649 2 0.000000 1 2.500000 3.444000 58.989032 43.906250 @@ -12667,7 +12667,7 @@ Atoms 12651 2 0.000000 1 2.500000 5.740000 62.965820 43.906250 12652 2 0.000000 -1 2.500000 5.740000 62.965820 43.906250 12653 2 0.000000 1 2.500000 63.140000 61.640224 47.418750 -12654 2 0.000000 -1.000000 2.500000 63.140000 61.640224 47.418750 +12654 2 0.000000 -1 2.500000 63.140000 61.640224 47.418750 12655 2 0.000000 1 2.500000 1.148000 57.663435 47.418750 12656 2 0.000000 -1 2.500000 1.148000 57.663435 47.418750 12657 2 0.000000 1 2.500000 3.444000 58.989032 50.931250 @@ -12675,7 +12675,7 @@ Atoms 12659 2 0.000000 1 2.500000 5.740000 62.965820 50.931250 12660 2 0.000000 -1 2.500000 5.740000 62.965820 50.931250 12661 2 0.000000 1 2.500000 63.140000 61.640224 54.443750 -12662 2 0.000000 -1.000000 2.500000 63.140000 61.640224 54.443750 +12662 2 0.000000 -1 2.500000 63.140000 61.640224 54.443750 12663 2 0.000000 1 2.500000 1.148000 57.663435 54.443750 12664 2 0.000000 -1 2.500000 1.148000 57.663435 54.443750 12665 2 0.000000 1 2.500000 3.444000 58.989032 57.956250 @@ -12683,7 +12683,7 @@ Atoms 12667 2 0.000000 1 2.500000 5.740000 62.965820 57.956250 12668 2 0.000000 -1 2.500000 5.740000 62.965820 57.956250 12669 2 0.000000 1 2.500000 63.140000 61.640224 61.468750 -12670 2 0.000000 -1.000000 2.500000 63.140000 61.640224 61.468750 +12670 2 0.000000 -1 2.500000 63.140000 61.640224 61.468750 12671 2 0.000000 1 2.500000 1.148000 57.663435 61.468750 12672 2 0.000000 -1 2.500000 1.148000 57.663435 61.468750 12673 2 0.000000 1 2.500000 8.036000 3.313991 1.756250 @@ -12691,7 +12691,7 @@ Atoms 12675 2 0.000000 1 2.500000 10.332000 7.290779 1.756250 12676 2 0.000000 -1 2.500000 10.332000 7.290779 1.756250 12677 2 0.000000 1 2.500000 3.444000 5.965183 5.268750 -12678 2 0.000000 -1.000000 2.500000 3.444000 5.965183 5.268750 +12678 2 0.000000 -1 2.500000 3.444000 5.965183 5.268750 12679 2 0.000000 1 2.500000 5.740000 1.988394 5.268750 12680 2 0.000000 -1 2.500000 5.740000 1.988394 5.268750 12681 2 0.000000 1 2.500000 8.036000 3.313991 8.781250 @@ -12699,7 +12699,7 @@ Atoms 12683 2 0.000000 1 2.500000 10.332000 7.290779 8.781250 12684 2 0.000000 -1 2.500000 10.332000 7.290779 8.781250 12685 2 0.000000 1 2.500000 3.444000 5.965183 12.293750 -12686 2 0.000000 -1.000000 2.500000 3.444000 5.965183 12.293750 +12686 2 0.000000 -1 2.500000 3.444000 5.965183 12.293750 12687 2 0.000000 1 2.500000 5.740000 1.988394 12.293750 12688 2 0.000000 -1 2.500000 5.740000 1.988394 12.293750 12689 2 0.000000 1 2.500000 8.036000 3.313991 15.806250 @@ -12707,7 +12707,7 @@ Atoms 12691 2 0.000000 1 2.500000 10.332000 7.290779 15.806250 12692 2 0.000000 -1 2.500000 10.332000 7.290779 15.806250 12693 2 0.000000 1 2.500000 3.444000 5.965183 19.318750 -12694 2 0.000000 -1.000000 2.500000 3.444000 5.965183 19.318750 +12694 2 0.000000 -1 2.500000 3.444000 5.965183 19.318750 12695 2 0.000000 1 2.500000 5.740000 1.988394 19.318750 12696 2 0.000000 -1 2.500000 5.740000 1.988394 19.318750 12697 2 0.000000 1 2.500000 8.036000 3.313991 22.831250 @@ -12715,7 +12715,7 @@ Atoms 12699 2 0.000000 1 2.500000 10.332000 7.290779 22.831250 12700 2 0.000000 -1 2.500000 10.332000 7.290779 22.831250 12701 2 0.000000 1 2.500000 3.444000 5.965183 26.343750 -12702 2 0.000000 -1.000000 2.500000 3.444000 5.965183 26.343750 +12702 2 0.000000 -1 2.500000 3.444000 5.965183 26.343750 12703 2 0.000000 1 2.500000 5.740000 1.988394 26.343750 12704 2 0.000000 -1 2.500000 5.740000 1.988394 26.343750 12705 2 0.000000 1 2.500000 8.036000 3.313991 29.856250 @@ -12723,7 +12723,7 @@ Atoms 12707 2 0.000000 1 2.500000 10.332000 7.290779 29.856250 12708 2 0.000000 -1 2.500000 10.332000 7.290779 29.856250 12709 2 0.000000 1 2.500000 3.444000 5.965183 33.368750 -12710 2 0.000000 -1.000000 2.500000 3.444000 5.965183 33.368750 +12710 2 0.000000 -1 2.500000 3.444000 5.965183 33.368750 12711 2 0.000000 1 2.500000 5.740000 1.988394 33.368750 12712 2 0.000000 -1 2.500000 5.740000 1.988394 33.368750 12713 2 0.000000 1 2.500000 8.036000 3.313991 36.881250 @@ -12731,7 +12731,7 @@ Atoms 12715 2 0.000000 1 2.500000 10.332000 7.290779 36.881250 12716 2 0.000000 -1 2.500000 10.332000 7.290779 36.881250 12717 2 0.000000 1 2.500000 3.444000 5.965183 40.393750 -12718 2 0.000000 -1.000000 2.500000 3.444000 5.965183 40.393750 +12718 2 0.000000 -1 2.500000 3.444000 5.965183 40.393750 12719 2 0.000000 1 2.500000 5.740000 1.988394 40.393750 12720 2 0.000000 -1 2.500000 5.740000 1.988394 40.393750 12721 2 0.000000 1 2.500000 8.036000 3.313991 43.906250 @@ -12739,7 +12739,7 @@ Atoms 12723 2 0.000000 1 2.500000 10.332000 7.290779 43.906250 12724 2 0.000000 -1 2.500000 10.332000 7.290779 43.906250 12725 2 0.000000 1 2.500000 3.444000 5.965183 47.418750 -12726 2 0.000000 -1.000000 2.500000 3.444000 5.965183 47.418750 +12726 2 0.000000 -1 2.500000 3.444000 5.965183 47.418750 12727 2 0.000000 1 2.500000 5.740000 1.988394 47.418750 12728 2 0.000000 -1 2.500000 5.740000 1.988394 47.418750 12729 2 0.000000 1 2.500000 8.036000 3.313991 50.931250 @@ -12747,7 +12747,7 @@ Atoms 12731 2 0.000000 1 2.500000 10.332000 7.290779 50.931250 12732 2 0.000000 -1 2.500000 10.332000 7.290779 50.931250 12733 2 0.000000 1 2.500000 3.444000 5.965183 54.443750 -12734 2 0.000000 -1.000000 2.500000 3.444000 5.965183 54.443750 +12734 2 0.000000 -1 2.500000 3.444000 5.965183 54.443750 12735 2 0.000000 1 2.500000 5.740000 1.988394 54.443750 12736 2 0.000000 -1 2.500000 5.740000 1.988394 54.443750 12737 2 0.000000 1 2.500000 8.036000 3.313991 57.956250 @@ -12755,7 +12755,7 @@ Atoms 12739 2 0.000000 1 2.500000 10.332000 7.290779 57.956250 12740 2 0.000000 -1 2.500000 10.332000 7.290779 57.956250 12741 2 0.000000 1 2.500000 3.444000 5.965183 61.468750 -12742 2 0.000000 -1.000000 2.500000 3.444000 5.965183 61.468750 +12742 2 0.000000 -1 2.500000 3.444000 5.965183 61.468750 12743 2 0.000000 1 2.500000 5.740000 1.988394 61.468750 12744 2 0.000000 -1 2.500000 5.740000 1.988394 61.468750 12745 2 0.000000 1 2.500000 8.036000 11.267568 1.756250 @@ -12763,7 +12763,7 @@ Atoms 12747 2 0.000000 1 2.500000 10.332000 15.244357 1.756250 12748 2 0.000000 -1 2.500000 10.332000 15.244357 1.756250 12749 2 0.000000 1 2.500000 3.444000 13.918760 5.268750 -12750 2 0.000000 -1.000000 2.500000 3.444000 13.918760 5.268750 +12750 2 0.000000 -1 2.500000 3.444000 13.918760 5.268750 12751 2 0.000000 1 2.500000 5.740000 9.941972 5.268750 12752 2 0.000000 -1 2.500000 5.740000 9.941972 5.268750 12753 2 0.000000 1 2.500000 8.036000 11.267568 8.781250 @@ -12771,7 +12771,7 @@ Atoms 12755 2 0.000000 1 2.500000 10.332000 15.244357 8.781250 12756 2 0.000000 -1 2.500000 10.332000 15.244357 8.781250 12757 2 0.000000 1 2.500000 3.444000 13.918760 12.293750 -12758 2 0.000000 -1.000000 2.500000 3.444000 13.918760 12.293750 +12758 2 0.000000 -1 2.500000 3.444000 13.918760 12.293750 12759 2 0.000000 1 2.500000 5.740000 9.941972 12.293750 12760 2 0.000000 -1 2.500000 5.740000 9.941972 12.293750 12761 2 0.000000 1 2.500000 8.036000 11.267568 15.806250 @@ -12779,7 +12779,7 @@ Atoms 12763 2 0.000000 1 2.500000 10.332000 15.244357 15.806250 12764 2 0.000000 -1 2.500000 10.332000 15.244357 15.806250 12765 2 0.000000 1 2.500000 3.444000 13.918760 19.318750 -12766 2 0.000000 -1.000000 2.500000 3.444000 13.918760 19.318750 +12766 2 0.000000 -1 2.500000 3.444000 13.918760 19.318750 12767 2 0.000000 1 2.500000 5.740000 9.941972 19.318750 12768 2 0.000000 -1 2.500000 5.740000 9.941972 19.318750 12769 2 0.000000 1 2.500000 8.036000 11.267568 22.831250 @@ -12787,7 +12787,7 @@ Atoms 12771 2 0.000000 1 2.500000 10.332000 15.244357 22.831250 12772 2 0.000000 -1 2.500000 10.332000 15.244357 22.831250 12773 2 0.000000 1 2.500000 3.444000 13.918760 26.343750 -12774 2 0.000000 -1.000000 2.500000 3.444000 13.918760 26.343750 +12774 2 0.000000 -1 2.500000 3.444000 13.918760 26.343750 12775 2 0.000000 1 2.500000 5.740000 9.941972 26.343750 12776 2 0.000000 -1 2.500000 5.740000 9.941972 26.343750 12777 2 0.000000 1 2.500000 8.036000 11.267568 29.856250 @@ -12795,7 +12795,7 @@ Atoms 12779 2 0.000000 1 2.500000 10.332000 15.244357 29.856250 12780 2 0.000000 -1 2.500000 10.332000 15.244357 29.856250 12781 2 0.000000 1 2.500000 3.444000 13.918760 33.368750 -12782 2 0.000000 -1.000000 2.500000 3.444000 13.918760 33.368750 +12782 2 0.000000 -1 2.500000 3.444000 13.918760 33.368750 12783 2 0.000000 1 2.500000 5.740000 9.941972 33.368750 12784 2 0.000000 -1 2.500000 5.740000 9.941972 33.368750 12785 2 0.000000 1 2.500000 8.036000 11.267568 36.881250 @@ -12803,7 +12803,7 @@ Atoms 12787 2 0.000000 1 2.500000 10.332000 15.244357 36.881250 12788 2 0.000000 -1 2.500000 10.332000 15.244357 36.881250 12789 2 0.000000 1 2.500000 3.444000 13.918760 40.393750 -12790 2 0.000000 -1.000000 2.500000 3.444000 13.918760 40.393750 +12790 2 0.000000 -1 2.500000 3.444000 13.918760 40.393750 12791 2 0.000000 1 2.500000 5.740000 9.941972 40.393750 12792 2 0.000000 -1 2.500000 5.740000 9.941972 40.393750 12793 2 0.000000 1 2.500000 8.036000 11.267568 43.906250 @@ -12811,7 +12811,7 @@ Atoms 12795 2 0.000000 1 2.500000 10.332000 15.244357 43.906250 12796 2 0.000000 -1 2.500000 10.332000 15.244357 43.906250 12797 2 0.000000 1 2.500000 3.444000 13.918760 47.418750 -12798 2 0.000000 -1.000000 2.500000 3.444000 13.918760 47.418750 +12798 2 0.000000 -1 2.500000 3.444000 13.918760 47.418750 12799 2 0.000000 1 2.500000 5.740000 9.941972 47.418750 12800 2 0.000000 -1 2.500000 5.740000 9.941972 47.418750 12801 2 0.000000 1 2.500000 8.036000 11.267568 50.931250 @@ -12819,7 +12819,7 @@ Atoms 12803 2 0.000000 1 2.500000 10.332000 15.244357 50.931250 12804 2 0.000000 -1 2.500000 10.332000 15.244357 50.931250 12805 2 0.000000 1 2.500000 3.444000 13.918760 54.443750 -12806 2 0.000000 -1.000000 2.500000 3.444000 13.918760 54.443750 +12806 2 0.000000 -1 2.500000 3.444000 13.918760 54.443750 12807 2 0.000000 1 2.500000 5.740000 9.941972 54.443750 12808 2 0.000000 -1 2.500000 5.740000 9.941972 54.443750 12809 2 0.000000 1 2.500000 8.036000 11.267568 57.956250 @@ -12827,7 +12827,7 @@ Atoms 12811 2 0.000000 1 2.500000 10.332000 15.244357 57.956250 12812 2 0.000000 -1 2.500000 10.332000 15.244357 57.956250 12813 2 0.000000 1 2.500000 3.444000 13.918760 61.468750 -12814 2 0.000000 -1.000000 2.500000 3.444000 13.918760 61.468750 +12814 2 0.000000 -1 2.500000 3.444000 13.918760 61.468750 12815 2 0.000000 1 2.500000 5.740000 9.941972 61.468750 12816 2 0.000000 -1 2.500000 5.740000 9.941972 61.468750 12817 2 0.000000 1 2.500000 8.036000 19.221145 1.756250 @@ -12835,7 +12835,7 @@ Atoms 12819 2 0.000000 1 2.500000 10.332000 23.197934 1.756250 12820 2 0.000000 -1 2.500000 10.332000 23.197934 1.756250 12821 2 0.000000 1 2.500000 3.444000 21.872338 5.268750 -12822 2 0.000000 -1.000000 2.500000 3.444000 21.872338 5.268750 +12822 2 0.000000 -1 2.500000 3.444000 21.872338 5.268750 12823 2 0.000000 1 2.500000 5.740000 17.895549 5.268750 12824 2 0.000000 -1 2.500000 5.740000 17.895549 5.268750 12825 2 0.000000 1 2.500000 8.036000 19.221145 8.781250 @@ -12843,7 +12843,7 @@ Atoms 12827 2 0.000000 1 2.500000 10.332000 23.197934 8.781250 12828 2 0.000000 -1 2.500000 10.332000 23.197934 8.781250 12829 2 0.000000 1 2.500000 3.444000 21.872338 12.293750 -12830 2 0.000000 -1.000000 2.500000 3.444000 21.872338 12.293750 +12830 2 0.000000 -1 2.500000 3.444000 21.872338 12.293750 12831 2 0.000000 1 2.500000 5.740000 17.895549 12.293750 12832 2 0.000000 -1 2.500000 5.740000 17.895549 12.293750 12833 2 0.000000 1 2.500000 8.036000 19.221145 15.806250 @@ -12851,7 +12851,7 @@ Atoms 12835 2 0.000000 1 2.500000 10.332000 23.197934 15.806250 12836 2 0.000000 -1 2.500000 10.332000 23.197934 15.806250 12837 2 0.000000 1 2.500000 3.444000 21.872338 19.318750 -12838 2 0.000000 -1.000000 2.500000 3.444000 21.872338 19.318750 +12838 2 0.000000 -1 2.500000 3.444000 21.872338 19.318750 12839 2 0.000000 1 2.500000 5.740000 17.895549 19.318750 12840 2 0.000000 -1 2.500000 5.740000 17.895549 19.318750 12841 2 0.000000 1 2.500000 8.036000 19.221145 22.831250 @@ -12859,7 +12859,7 @@ Atoms 12843 2 0.000000 1 2.500000 10.332000 23.197934 22.831250 12844 2 0.000000 -1 2.500000 10.332000 23.197934 22.831250 12845 2 0.000000 1 2.500000 3.444000 21.872338 26.343750 -12846 2 0.000000 -1.000000 2.500000 3.444000 21.872338 26.343750 +12846 2 0.000000 -1 2.500000 3.444000 21.872338 26.343750 12847 2 0.000000 1 2.500000 5.740000 17.895549 26.343750 12848 2 0.000000 -1 2.500000 5.740000 17.895549 26.343750 12849 2 0.000000 1 2.500000 8.036000 19.221145 29.856250 @@ -12867,7 +12867,7 @@ Atoms 12851 2 0.000000 1 2.500000 10.332000 23.197934 29.856250 12852 2 0.000000 -1 2.500000 10.332000 23.197934 29.856250 12853 2 0.000000 1 2.500000 3.444000 21.872338 33.368750 -12854 2 0.000000 -1.000000 2.500000 3.444000 21.872338 33.368750 +12854 2 0.000000 -1 2.500000 3.444000 21.872338 33.368750 12855 2 0.000000 1 2.500000 5.740000 17.895549 33.368750 12856 2 0.000000 -1 2.500000 5.740000 17.895549 33.368750 12857 2 0.000000 1 2.500000 8.036000 19.221145 36.881250 @@ -12875,7 +12875,7 @@ Atoms 12859 2 0.000000 1 2.500000 10.332000 23.197934 36.881250 12860 2 0.000000 -1 2.500000 10.332000 23.197934 36.881250 12861 2 0.000000 1 2.500000 3.444000 21.872338 40.393750 -12862 2 0.000000 -1.000000 2.500000 3.444000 21.872338 40.393750 +12862 2 0.000000 -1 2.500000 3.444000 21.872338 40.393750 12863 2 0.000000 1 2.500000 5.740000 17.895549 40.393750 12864 2 0.000000 -1 2.500000 5.740000 17.895549 40.393750 12865 2 0.000000 1 2.500000 8.036000 19.221145 43.906250 @@ -12883,7 +12883,7 @@ Atoms 12867 2 0.000000 1 2.500000 10.332000 23.197934 43.906250 12868 2 0.000000 -1 2.500000 10.332000 23.197934 43.906250 12869 2 0.000000 1 2.500000 3.444000 21.872338 47.418750 -12870 2 0.000000 -1.000000 2.500000 3.444000 21.872338 47.418750 +12870 2 0.000000 -1 2.500000 3.444000 21.872338 47.418750 12871 2 0.000000 1 2.500000 5.740000 17.895549 47.418750 12872 2 0.000000 -1 2.500000 5.740000 17.895549 47.418750 12873 2 0.000000 1 2.500000 8.036000 19.221145 50.931250 @@ -12891,7 +12891,7 @@ Atoms 12875 2 0.000000 1 2.500000 10.332000 23.197934 50.931250 12876 2 0.000000 -1 2.500000 10.332000 23.197934 50.931250 12877 2 0.000000 1 2.500000 3.444000 21.872338 54.443750 -12878 2 0.000000 -1.000000 2.500000 3.444000 21.872338 54.443750 +12878 2 0.000000 -1 2.500000 3.444000 21.872338 54.443750 12879 2 0.000000 1 2.500000 5.740000 17.895549 54.443750 12880 2 0.000000 -1 2.500000 5.740000 17.895549 54.443750 12881 2 0.000000 1 2.500000 8.036000 19.221145 57.956250 @@ -12899,7 +12899,7 @@ Atoms 12883 2 0.000000 1 2.500000 10.332000 23.197934 57.956250 12884 2 0.000000 -1 2.500000 10.332000 23.197934 57.956250 12885 2 0.000000 1 2.500000 3.444000 21.872338 61.468750 -12886 2 0.000000 -1.000000 2.500000 3.444000 21.872338 61.468750 +12886 2 0.000000 -1 2.500000 3.444000 21.872338 61.468750 12887 2 0.000000 1 2.500000 5.740000 17.895549 61.468750 12888 2 0.000000 -1 2.500000 5.740000 17.895549 61.468750 12889 2 0.000000 1 2.500000 8.036000 27.174722 1.756250 @@ -12907,7 +12907,7 @@ Atoms 12891 2 0.000000 1 2.500000 10.332000 31.151511 1.756250 12892 2 0.000000 -1 2.500000 10.332000 31.151511 1.756250 12893 2 0.000000 1 2.500000 3.444000 29.825915 5.268750 -12894 2 0.000000 -1.000000 2.500000 3.444000 29.825915 5.268750 +12894 2 0.000000 -1 2.500000 3.444000 29.825915 5.268750 12895 2 0.000000 1 2.500000 5.740000 25.849126 5.268750 12896 2 0.000000 -1 2.500000 5.740000 25.849126 5.268750 12897 2 0.000000 1 2.500000 8.036000 27.174722 8.781250 @@ -12915,7 +12915,7 @@ Atoms 12899 2 0.000000 1 2.500000 10.332000 31.151511 8.781250 12900 2 0.000000 -1 2.500000 10.332000 31.151511 8.781250 12901 2 0.000000 1 2.500000 3.444000 29.825915 12.293750 -12902 2 0.000000 -1.000000 2.500000 3.444000 29.825915 12.293750 +12902 2 0.000000 -1 2.500000 3.444000 29.825915 12.293750 12903 2 0.000000 1 2.500000 5.740000 25.849126 12.293750 12904 2 0.000000 -1 2.500000 5.740000 25.849126 12.293750 12905 2 0.000000 1 2.500000 8.036000 27.174722 15.806250 @@ -12923,7 +12923,7 @@ Atoms 12907 2 0.000000 1 2.500000 10.332000 31.151511 15.806250 12908 2 0.000000 -1 2.500000 10.332000 31.151511 15.806250 12909 2 0.000000 1 2.500000 3.444000 29.825915 19.318750 -12910 2 0.000000 -1.000000 2.500000 3.444000 29.825915 19.318750 +12910 2 0.000000 -1 2.500000 3.444000 29.825915 19.318750 12911 2 0.000000 1 2.500000 5.740000 25.849126 19.318750 12912 2 0.000000 -1 2.500000 5.740000 25.849126 19.318750 12913 2 0.000000 1 2.500000 8.036000 27.174722 22.831250 @@ -12931,7 +12931,7 @@ Atoms 12915 2 0.000000 1 2.500000 10.332000 31.151511 22.831250 12916 2 0.000000 -1 2.500000 10.332000 31.151511 22.831250 12917 2 0.000000 1 2.500000 3.444000 29.825915 26.343750 -12918 2 0.000000 -1.000000 2.500000 3.444000 29.825915 26.343750 +12918 2 0.000000 -1 2.500000 3.444000 29.825915 26.343750 12919 2 0.000000 1 2.500000 5.740000 25.849126 26.343750 12920 2 0.000000 -1 2.500000 5.740000 25.849126 26.343750 12921 2 0.000000 1 2.500000 8.036000 27.174722 29.856250 @@ -12939,7 +12939,7 @@ Atoms 12923 2 0.000000 1 2.500000 10.332000 31.151511 29.856250 12924 2 0.000000 -1 2.500000 10.332000 31.151511 29.856250 12925 2 0.000000 1 2.500000 3.444000 29.825915 33.368750 -12926 2 0.000000 -1.000000 2.500000 3.444000 29.825915 33.368750 +12926 2 0.000000 -1 2.500000 3.444000 29.825915 33.368750 12927 2 0.000000 1 2.500000 5.740000 25.849126 33.368750 12928 2 0.000000 -1 2.500000 5.740000 25.849126 33.368750 12929 2 0.000000 1 2.500000 8.036000 27.174722 36.881250 @@ -12947,7 +12947,7 @@ Atoms 12931 2 0.000000 1 2.500000 10.332000 31.151511 36.881250 12932 2 0.000000 -1 2.500000 10.332000 31.151511 36.881250 12933 2 0.000000 1 2.500000 3.444000 29.825915 40.393750 -12934 2 0.000000 -1.000000 2.500000 3.444000 29.825915 40.393750 +12934 2 0.000000 -1 2.500000 3.444000 29.825915 40.393750 12935 2 0.000000 1 2.500000 5.740000 25.849126 40.393750 12936 2 0.000000 -1 2.500000 5.740000 25.849126 40.393750 12937 2 0.000000 1 2.500000 8.036000 27.174722 43.906250 @@ -12955,7 +12955,7 @@ Atoms 12939 2 0.000000 1 2.500000 10.332000 31.151511 43.906250 12940 2 0.000000 -1 2.500000 10.332000 31.151511 43.906250 12941 2 0.000000 1 2.500000 3.444000 29.825915 47.418750 -12942 2 0.000000 -1.000000 2.500000 3.444000 29.825915 47.418750 +12942 2 0.000000 -1 2.500000 3.444000 29.825915 47.418750 12943 2 0.000000 1 2.500000 5.740000 25.849126 47.418750 12944 2 0.000000 -1 2.500000 5.740000 25.849126 47.418750 12945 2 0.000000 1 2.500000 8.036000 27.174722 50.931250 @@ -12963,7 +12963,7 @@ Atoms 12947 2 0.000000 1 2.500000 10.332000 31.151511 50.931250 12948 2 0.000000 -1 2.500000 10.332000 31.151511 50.931250 12949 2 0.000000 1 2.500000 3.444000 29.825915 54.443750 -12950 2 0.000000 -1.000000 2.500000 3.444000 29.825915 54.443750 +12950 2 0.000000 -1 2.500000 3.444000 29.825915 54.443750 12951 2 0.000000 1 2.500000 5.740000 25.849126 54.443750 12952 2 0.000000 -1 2.500000 5.740000 25.849126 54.443750 12953 2 0.000000 1 2.500000 8.036000 27.174722 57.956250 @@ -12971,7 +12971,7 @@ Atoms 12955 2 0.000000 1 2.500000 10.332000 31.151511 57.956250 12956 2 0.000000 -1 2.500000 10.332000 31.151511 57.956250 12957 2 0.000000 1 2.500000 3.444000 29.825915 61.468750 -12958 2 0.000000 -1.000000 2.500000 3.444000 29.825915 61.468750 +12958 2 0.000000 -1 2.500000 3.444000 29.825915 61.468750 12959 2 0.000000 1 2.500000 5.740000 25.849126 61.468750 12960 2 0.000000 -1 2.500000 5.740000 25.849126 61.468750 12961 2 0.000000 1 2.500000 8.036000 35.128300 1.756250 @@ -12979,7 +12979,7 @@ Atoms 12963 2 0.000000 1 2.500000 10.332000 39.105088 1.756250 12964 2 0.000000 -1 2.500000 10.332000 39.105088 1.756250 12965 2 0.000000 1 2.500000 3.444000 37.779492 5.268750 -12966 2 0.000000 -1.000000 2.500000 3.444000 37.779492 5.268750 +12966 2 0.000000 -1 2.500000 3.444000 37.779492 5.268750 12967 2 0.000000 1 2.500000 5.740000 33.802704 5.268750 12968 2 0.000000 -1 2.500000 5.740000 33.802704 5.268750 12969 2 0.000000 1 2.500000 8.036000 35.128300 8.781250 @@ -12987,7 +12987,7 @@ Atoms 12971 2 0.000000 1 2.500000 10.332000 39.105088 8.781250 12972 2 0.000000 -1 2.500000 10.332000 39.105088 8.781250 12973 2 0.000000 1 2.500000 3.444000 37.779492 12.293750 -12974 2 0.000000 -1.000000 2.500000 3.444000 37.779492 12.293750 +12974 2 0.000000 -1 2.500000 3.444000 37.779492 12.293750 12975 2 0.000000 1 2.500000 5.740000 33.802704 12.293750 12976 2 0.000000 -1 2.500000 5.740000 33.802704 12.293750 12977 2 0.000000 1 2.500000 8.036000 35.128300 15.806250 @@ -12995,7 +12995,7 @@ Atoms 12979 2 0.000000 1 2.500000 10.332000 39.105088 15.806250 12980 2 0.000000 -1 2.500000 10.332000 39.105088 15.806250 12981 2 0.000000 1 2.500000 3.444000 37.779492 19.318750 -12982 2 0.000000 -1.000000 2.500000 3.444000 37.779492 19.318750 +12982 2 0.000000 -1 2.500000 3.444000 37.779492 19.318750 12983 2 0.000000 1 2.500000 5.740000 33.802704 19.318750 12984 2 0.000000 -1 2.500000 5.740000 33.802704 19.318750 12985 2 0.000000 1 2.500000 8.036000 35.128300 22.831250 @@ -13003,7 +13003,7 @@ Atoms 12987 2 0.000000 1 2.500000 10.332000 39.105088 22.831250 12988 2 0.000000 -1 2.500000 10.332000 39.105088 22.831250 12989 2 0.000000 1 2.500000 3.444000 37.779492 26.343750 -12990 2 0.000000 -1.000000 2.500000 3.444000 37.779492 26.343750 +12990 2 0.000000 -1 2.500000 3.444000 37.779492 26.343750 12991 2 0.000000 1 2.500000 5.740000 33.802704 26.343750 12992 2 0.000000 -1 2.500000 5.740000 33.802704 26.343750 12993 2 0.000000 1 2.500000 8.036000 35.128300 29.856250 @@ -13011,7 +13011,7 @@ Atoms 12995 2 0.000000 1 2.500000 10.332000 39.105088 29.856250 12996 2 0.000000 -1 2.500000 10.332000 39.105088 29.856250 12997 2 0.000000 1 2.500000 3.444000 37.779492 33.368750 -12998 2 0.000000 -1.000000 2.500000 3.444000 37.779492 33.368750 +12998 2 0.000000 -1 2.500000 3.444000 37.779492 33.368750 12999 2 0.000000 1 2.500000 5.740000 33.802704 33.368750 13000 2 0.000000 -1 2.500000 5.740000 33.802704 33.368750 13001 2 0.000000 1 2.500000 8.036000 35.128300 36.881250 @@ -13019,7 +13019,7 @@ Atoms 13003 2 0.000000 1 2.500000 10.332000 39.105088 36.881250 13004 2 0.000000 -1 2.500000 10.332000 39.105088 36.881250 13005 2 0.000000 1 2.500000 3.444000 37.779492 40.393750 -13006 2 0.000000 -1.000000 2.500000 3.444000 37.779492 40.393750 +13006 2 0.000000 -1 2.500000 3.444000 37.779492 40.393750 13007 2 0.000000 1 2.500000 5.740000 33.802704 40.393750 13008 2 0.000000 -1 2.500000 5.740000 33.802704 40.393750 13009 2 0.000000 1 2.500000 8.036000 35.128300 43.906250 @@ -13027,7 +13027,7 @@ Atoms 13011 2 0.000000 1 2.500000 10.332000 39.105088 43.906250 13012 2 0.000000 -1 2.500000 10.332000 39.105088 43.906250 13013 2 0.000000 1 2.500000 3.444000 37.779492 47.418750 -13014 2 0.000000 -1.000000 2.500000 3.444000 37.779492 47.418750 +13014 2 0.000000 -1 2.500000 3.444000 37.779492 47.418750 13015 2 0.000000 1 2.500000 5.740000 33.802704 47.418750 13016 2 0.000000 -1 2.500000 5.740000 33.802704 47.418750 13017 2 0.000000 1 2.500000 8.036000 35.128300 50.931250 @@ -13035,7 +13035,7 @@ Atoms 13019 2 0.000000 1 2.500000 10.332000 39.105088 50.931250 13020 2 0.000000 -1 2.500000 10.332000 39.105088 50.931250 13021 2 0.000000 1 2.500000 3.444000 37.779492 54.443750 -13022 2 0.000000 -1.000000 2.500000 3.444000 37.779492 54.443750 +13022 2 0.000000 -1 2.500000 3.444000 37.779492 54.443750 13023 2 0.000000 1 2.500000 5.740000 33.802704 54.443750 13024 2 0.000000 -1 2.500000 5.740000 33.802704 54.443750 13025 2 0.000000 1 2.500000 8.036000 35.128300 57.956250 @@ -13043,7 +13043,7 @@ Atoms 13027 2 0.000000 1 2.500000 10.332000 39.105088 57.956250 13028 2 0.000000 -1 2.500000 10.332000 39.105088 57.956250 13029 2 0.000000 1 2.500000 3.444000 37.779492 61.468750 -13030 2 0.000000 -1.000000 2.500000 3.444000 37.779492 61.468750 +13030 2 0.000000 -1 2.500000 3.444000 37.779492 61.468750 13031 2 0.000000 1 2.500000 5.740000 33.802704 61.468750 13032 2 0.000000 -1 2.500000 5.740000 33.802704 61.468750 13033 2 0.000000 1 2.500000 8.036000 43.081877 1.756250 @@ -13051,7 +13051,7 @@ Atoms 13035 2 0.000000 1 2.500000 10.332000 47.058666 1.756250 13036 2 0.000000 -1 2.500000 10.332000 47.058666 1.756250 13037 2 0.000000 1 2.500000 3.444000 45.733070 5.268750 -13038 2 0.000000 -1.000000 2.500000 3.444000 45.733070 5.268750 +13038 2 0.000000 -1 2.500000 3.444000 45.733070 5.268750 13039 2 0.000000 1 2.500000 5.740000 41.756281 5.268750 13040 2 0.000000 -1 2.500000 5.740000 41.756281 5.268750 13041 2 0.000000 1 2.500000 8.036000 43.081877 8.781250 @@ -13059,7 +13059,7 @@ Atoms 13043 2 0.000000 1 2.500000 10.332000 47.058666 8.781250 13044 2 0.000000 -1 2.500000 10.332000 47.058666 8.781250 13045 2 0.000000 1 2.500000 3.444000 45.733070 12.293750 -13046 2 0.000000 -1.000000 2.500000 3.444000 45.733070 12.293750 +13046 2 0.000000 -1 2.500000 3.444000 45.733070 12.293750 13047 2 0.000000 1 2.500000 5.740000 41.756281 12.293750 13048 2 0.000000 -1 2.500000 5.740000 41.756281 12.293750 13049 2 0.000000 1 2.500000 8.036000 43.081877 15.806250 @@ -13067,7 +13067,7 @@ Atoms 13051 2 0.000000 1 2.500000 10.332000 47.058666 15.806250 13052 2 0.000000 -1 2.500000 10.332000 47.058666 15.806250 13053 2 0.000000 1 2.500000 3.444000 45.733070 19.318750 -13054 2 0.000000 -1.000000 2.500000 3.444000 45.733070 19.318750 +13054 2 0.000000 -1 2.500000 3.444000 45.733070 19.318750 13055 2 0.000000 1 2.500000 5.740000 41.756281 19.318750 13056 2 0.000000 -1 2.500000 5.740000 41.756281 19.318750 13057 2 0.000000 1 2.500000 8.036000 43.081877 22.831250 @@ -13075,7 +13075,7 @@ Atoms 13059 2 0.000000 1 2.500000 10.332000 47.058666 22.831250 13060 2 0.000000 -1 2.500000 10.332000 47.058666 22.831250 13061 2 0.000000 1 2.500000 3.444000 45.733070 26.343750 -13062 2 0.000000 -1.000000 2.500000 3.444000 45.733070 26.343750 +13062 2 0.000000 -1 2.500000 3.444000 45.733070 26.343750 13063 2 0.000000 1 2.500000 5.740000 41.756281 26.343750 13064 2 0.000000 -1 2.500000 5.740000 41.756281 26.343750 13065 2 0.000000 1 2.500000 8.036000 43.081877 29.856250 @@ -13083,7 +13083,7 @@ Atoms 13067 2 0.000000 1 2.500000 10.332000 47.058666 29.856250 13068 2 0.000000 -1 2.500000 10.332000 47.058666 29.856250 13069 2 0.000000 1 2.500000 3.444000 45.733070 33.368750 -13070 2 0.000000 -1.000000 2.500000 3.444000 45.733070 33.368750 +13070 2 0.000000 -1 2.500000 3.444000 45.733070 33.368750 13071 2 0.000000 1 2.500000 5.740000 41.756281 33.368750 13072 2 0.000000 -1 2.500000 5.740000 41.756281 33.368750 13073 2 0.000000 1 2.500000 8.036000 43.081877 36.881250 @@ -13091,7 +13091,7 @@ Atoms 13075 2 0.000000 1 2.500000 10.332000 47.058666 36.881250 13076 2 0.000000 -1 2.500000 10.332000 47.058666 36.881250 13077 2 0.000000 1 2.500000 3.444000 45.733070 40.393750 -13078 2 0.000000 -1.000000 2.500000 3.444000 45.733070 40.393750 +13078 2 0.000000 -1 2.500000 3.444000 45.733070 40.393750 13079 2 0.000000 1 2.500000 5.740000 41.756281 40.393750 13080 2 0.000000 -1 2.500000 5.740000 41.756281 40.393750 13081 2 0.000000 1 2.500000 8.036000 43.081877 43.906250 @@ -13099,7 +13099,7 @@ Atoms 13083 2 0.000000 1 2.500000 10.332000 47.058666 43.906250 13084 2 0.000000 -1 2.500000 10.332000 47.058666 43.906250 13085 2 0.000000 1 2.500000 3.444000 45.733070 47.418750 -13086 2 0.000000 -1.000000 2.500000 3.444000 45.733070 47.418750 +13086 2 0.000000 -1 2.500000 3.444000 45.733070 47.418750 13087 2 0.000000 1 2.500000 5.740000 41.756281 47.418750 13088 2 0.000000 -1 2.500000 5.740000 41.756281 47.418750 13089 2 0.000000 1 2.500000 8.036000 43.081877 50.931250 @@ -13107,7 +13107,7 @@ Atoms 13091 2 0.000000 1 2.500000 10.332000 47.058666 50.931250 13092 2 0.000000 -1 2.500000 10.332000 47.058666 50.931250 13093 2 0.000000 1 2.500000 3.444000 45.733070 54.443750 -13094 2 0.000000 -1.000000 2.500000 3.444000 45.733070 54.443750 +13094 2 0.000000 -1 2.500000 3.444000 45.733070 54.443750 13095 2 0.000000 1 2.500000 5.740000 41.756281 54.443750 13096 2 0.000000 -1 2.500000 5.740000 41.756281 54.443750 13097 2 0.000000 1 2.500000 8.036000 43.081877 57.956250 @@ -13115,7 +13115,7 @@ Atoms 13099 2 0.000000 1 2.500000 10.332000 47.058666 57.956250 13100 2 0.000000 -1 2.500000 10.332000 47.058666 57.956250 13101 2 0.000000 1 2.500000 3.444000 45.733070 61.468750 -13102 2 0.000000 -1.000000 2.500000 3.444000 45.733070 61.468750 +13102 2 0.000000 -1 2.500000 3.444000 45.733070 61.468750 13103 2 0.000000 1 2.500000 5.740000 41.756281 61.468750 13104 2 0.000000 -1 2.500000 5.740000 41.756281 61.468750 13105 2 0.000000 1 2.500000 8.036000 51.035454 1.756250 @@ -13123,7 +13123,7 @@ Atoms 13107 2 0.000000 1 2.500000 10.332000 55.012243 1.756250 13108 2 0.000000 -1 2.500000 10.332000 55.012243 1.756250 13109 2 0.000000 1 2.500000 3.444000 53.686647 5.268750 -13110 2 0.000000 -1.000000 2.500000 3.444000 53.686647 5.268750 +13110 2 0.000000 -1 2.500000 3.444000 53.686647 5.268750 13111 2 0.000000 1 2.500000 5.740000 49.709858 5.268750 13112 2 0.000000 -1 2.500000 5.740000 49.709858 5.268750 13113 2 0.000000 1 2.500000 8.036000 51.035454 8.781250 @@ -13131,7 +13131,7 @@ Atoms 13115 2 0.000000 1 2.500000 10.332000 55.012243 8.781250 13116 2 0.000000 -1 2.500000 10.332000 55.012243 8.781250 13117 2 0.000000 1 2.500000 3.444000 53.686647 12.293750 -13118 2 0.000000 -1.000000 2.500000 3.444000 53.686647 12.293750 +13118 2 0.000000 -1 2.500000 3.444000 53.686647 12.293750 13119 2 0.000000 1 2.500000 5.740000 49.709858 12.293750 13120 2 0.000000 -1 2.500000 5.740000 49.709858 12.293750 13121 2 0.000000 1 2.500000 8.036000 51.035454 15.806250 @@ -13139,7 +13139,7 @@ Atoms 13123 2 0.000000 1 2.500000 10.332000 55.012243 15.806250 13124 2 0.000000 -1 2.500000 10.332000 55.012243 15.806250 13125 2 0.000000 1 2.500000 3.444000 53.686647 19.318750 -13126 2 0.000000 -1.000000 2.500000 3.444000 53.686647 19.318750 +13126 2 0.000000 -1 2.500000 3.444000 53.686647 19.318750 13127 2 0.000000 1 2.500000 5.740000 49.709858 19.318750 13128 2 0.000000 -1 2.500000 5.740000 49.709858 19.318750 13129 2 0.000000 1 2.500000 8.036000 51.035454 22.831250 @@ -13147,7 +13147,7 @@ Atoms 13131 2 0.000000 1 2.500000 10.332000 55.012243 22.831250 13132 2 0.000000 -1 2.500000 10.332000 55.012243 22.831250 13133 2 0.000000 1 2.500000 3.444000 53.686647 26.343750 -13134 2 0.000000 -1.000000 2.500000 3.444000 53.686647 26.343750 +13134 2 0.000000 -1 2.500000 3.444000 53.686647 26.343750 13135 2 0.000000 1 2.500000 5.740000 49.709858 26.343750 13136 2 0.000000 -1 2.500000 5.740000 49.709858 26.343750 13137 2 0.000000 1 2.500000 8.036000 51.035454 29.856250 @@ -13155,7 +13155,7 @@ Atoms 13139 2 0.000000 1 2.500000 10.332000 55.012243 29.856250 13140 2 0.000000 -1 2.500000 10.332000 55.012243 29.856250 13141 2 0.000000 1 2.500000 3.444000 53.686647 33.368750 -13142 2 0.000000 -1.000000 2.500000 3.444000 53.686647 33.368750 +13142 2 0.000000 -1 2.500000 3.444000 53.686647 33.368750 13143 2 0.000000 1 2.500000 5.740000 49.709858 33.368750 13144 2 0.000000 -1 2.500000 5.740000 49.709858 33.368750 13145 2 0.000000 1 2.500000 8.036000 51.035454 36.881250 @@ -13163,7 +13163,7 @@ Atoms 13147 2 0.000000 1 2.500000 10.332000 55.012243 36.881250 13148 2 0.000000 -1 2.500000 10.332000 55.012243 36.881250 13149 2 0.000000 1 2.500000 3.444000 53.686647 40.393750 -13150 2 0.000000 -1.000000 2.500000 3.444000 53.686647 40.393750 +13150 2 0.000000 -1 2.500000 3.444000 53.686647 40.393750 13151 2 0.000000 1 2.500000 5.740000 49.709858 40.393750 13152 2 0.000000 -1 2.500000 5.740000 49.709858 40.393750 13153 2 0.000000 1 2.500000 8.036000 51.035454 43.906250 @@ -13171,7 +13171,7 @@ Atoms 13155 2 0.000000 1 2.500000 10.332000 55.012243 43.906250 13156 2 0.000000 -1 2.500000 10.332000 55.012243 43.906250 13157 2 0.000000 1 2.500000 3.444000 53.686647 47.418750 -13158 2 0.000000 -1.000000 2.500000 3.444000 53.686647 47.418750 +13158 2 0.000000 -1 2.500000 3.444000 53.686647 47.418750 13159 2 0.000000 1 2.500000 5.740000 49.709858 47.418750 13160 2 0.000000 -1 2.500000 5.740000 49.709858 47.418750 13161 2 0.000000 1 2.500000 8.036000 51.035454 50.931250 @@ -13179,7 +13179,7 @@ Atoms 13163 2 0.000000 1 2.500000 10.332000 55.012243 50.931250 13164 2 0.000000 -1 2.500000 10.332000 55.012243 50.931250 13165 2 0.000000 1 2.500000 3.444000 53.686647 54.443750 -13166 2 0.000000 -1.000000 2.500000 3.444000 53.686647 54.443750 +13166 2 0.000000 -1 2.500000 3.444000 53.686647 54.443750 13167 2 0.000000 1 2.500000 5.740000 49.709858 54.443750 13168 2 0.000000 -1 2.500000 5.740000 49.709858 54.443750 13169 2 0.000000 1 2.500000 8.036000 51.035454 57.956250 @@ -13187,7 +13187,7 @@ Atoms 13171 2 0.000000 1 2.500000 10.332000 55.012243 57.956250 13172 2 0.000000 -1 2.500000 10.332000 55.012243 57.956250 13173 2 0.000000 1 2.500000 3.444000 53.686647 61.468750 -13174 2 0.000000 -1.000000 2.500000 3.444000 53.686647 61.468750 +13174 2 0.000000 -1 2.500000 3.444000 53.686647 61.468750 13175 2 0.000000 1 2.500000 5.740000 49.709858 61.468750 13176 2 0.000000 -1 2.500000 5.740000 49.709858 61.468750 13177 2 0.000000 1 2.500000 8.036000 58.989032 1.756250 @@ -13195,7 +13195,7 @@ Atoms 13179 2 0.000000 1 2.500000 10.332000 62.965820 1.756250 13180 2 0.000000 -1 2.500000 10.332000 62.965820 1.756250 13181 2 0.000000 1 2.500000 3.444000 61.640224 5.268750 -13182 2 0.000000 -1.000000 2.500000 3.444000 61.640224 5.268750 +13182 2 0.000000 -1 2.500000 3.444000 61.640224 5.268750 13183 2 0.000000 1 2.500000 5.740000 57.663435 5.268750 13184 2 0.000000 -1 2.500000 5.740000 57.663435 5.268750 13185 2 0.000000 1 2.500000 8.036000 58.989032 8.781250 @@ -13203,7 +13203,7 @@ Atoms 13187 2 0.000000 1 2.500000 10.332000 62.965820 8.781250 13188 2 0.000000 -1 2.500000 10.332000 62.965820 8.781250 13189 2 0.000000 1 2.500000 3.444000 61.640224 12.293750 -13190 2 0.000000 -1.000000 2.500000 3.444000 61.640224 12.293750 +13190 2 0.000000 -1 2.500000 3.444000 61.640224 12.293750 13191 2 0.000000 1 2.500000 5.740000 57.663435 12.293750 13192 2 0.000000 -1 2.500000 5.740000 57.663435 12.293750 13193 2 0.000000 1 2.500000 8.036000 58.989032 15.806250 @@ -13211,7 +13211,7 @@ Atoms 13195 2 0.000000 1 2.500000 10.332000 62.965820 15.806250 13196 2 0.000000 -1 2.500000 10.332000 62.965820 15.806250 13197 2 0.000000 1 2.500000 3.444000 61.640224 19.318750 -13198 2 0.000000 -1.000000 2.500000 3.444000 61.640224 19.318750 +13198 2 0.000000 -1 2.500000 3.444000 61.640224 19.318750 13199 2 0.000000 1 2.500000 5.740000 57.663435 19.318750 13200 2 0.000000 -1 2.500000 5.740000 57.663435 19.318750 13201 2 0.000000 1 2.500000 8.036000 58.989032 22.831250 @@ -13219,7 +13219,7 @@ Atoms 13203 2 0.000000 1 2.500000 10.332000 62.965820 22.831250 13204 2 0.000000 -1 2.500000 10.332000 62.965820 22.831250 13205 2 0.000000 1 2.500000 3.444000 61.640224 26.343750 -13206 2 0.000000 -1.000000 2.500000 3.444000 61.640224 26.343750 +13206 2 0.000000 -1 2.500000 3.444000 61.640224 26.343750 13207 2 0.000000 1 2.500000 5.740000 57.663435 26.343750 13208 2 0.000000 -1 2.500000 5.740000 57.663435 26.343750 13209 2 0.000000 1 2.500000 8.036000 58.989032 29.856250 @@ -13227,7 +13227,7 @@ Atoms 13211 2 0.000000 1 2.500000 10.332000 62.965820 29.856250 13212 2 0.000000 -1 2.500000 10.332000 62.965820 29.856250 13213 2 0.000000 1 2.500000 3.444000 61.640224 33.368750 -13214 2 0.000000 -1.000000 2.500000 3.444000 61.640224 33.368750 +13214 2 0.000000 -1 2.500000 3.444000 61.640224 33.368750 13215 2 0.000000 1 2.500000 5.740000 57.663435 33.368750 13216 2 0.000000 -1 2.500000 5.740000 57.663435 33.368750 13217 2 0.000000 1 2.500000 8.036000 58.989032 36.881250 @@ -13235,7 +13235,7 @@ Atoms 13219 2 0.000000 1 2.500000 10.332000 62.965820 36.881250 13220 2 0.000000 -1 2.500000 10.332000 62.965820 36.881250 13221 2 0.000000 1 2.500000 3.444000 61.640224 40.393750 -13222 2 0.000000 -1.000000 2.500000 3.444000 61.640224 40.393750 +13222 2 0.000000 -1 2.500000 3.444000 61.640224 40.393750 13223 2 0.000000 1 2.500000 5.740000 57.663435 40.393750 13224 2 0.000000 -1 2.500000 5.740000 57.663435 40.393750 13225 2 0.000000 1 2.500000 8.036000 58.989032 43.906250 @@ -13243,7 +13243,7 @@ Atoms 13227 2 0.000000 1 2.500000 10.332000 62.965820 43.906250 13228 2 0.000000 -1 2.500000 10.332000 62.965820 43.906250 13229 2 0.000000 1 2.500000 3.444000 61.640224 47.418750 -13230 2 0.000000 -1.000000 2.500000 3.444000 61.640224 47.418750 +13230 2 0.000000 -1 2.500000 3.444000 61.640224 47.418750 13231 2 0.000000 1 2.500000 5.740000 57.663435 47.418750 13232 2 0.000000 -1 2.500000 5.740000 57.663435 47.418750 13233 2 0.000000 1 2.500000 8.036000 58.989032 50.931250 @@ -13251,7 +13251,7 @@ Atoms 13235 2 0.000000 1 2.500000 10.332000 62.965820 50.931250 13236 2 0.000000 -1 2.500000 10.332000 62.965820 50.931250 13237 2 0.000000 1 2.500000 3.444000 61.640224 54.443750 -13238 2 0.000000 -1.000000 2.500000 3.444000 61.640224 54.443750 +13238 2 0.000000 -1 2.500000 3.444000 61.640224 54.443750 13239 2 0.000000 1 2.500000 5.740000 57.663435 54.443750 13240 2 0.000000 -1 2.500000 5.740000 57.663435 54.443750 13241 2 0.000000 1 2.500000 8.036000 58.989032 57.956250 @@ -13259,7 +13259,7 @@ Atoms 13243 2 0.000000 1 2.500000 10.332000 62.965820 57.956250 13244 2 0.000000 -1 2.500000 10.332000 62.965820 57.956250 13245 2 0.000000 1 2.500000 3.444000 61.640224 61.468750 -13246 2 0.000000 -1.000000 2.500000 3.444000 61.640224 61.468750 +13246 2 0.000000 -1 2.500000 3.444000 61.640224 61.468750 13247 2 0.000000 1 2.500000 5.740000 57.663435 61.468750 13248 2 0.000000 -1 2.500000 5.740000 57.663435 61.468750 13249 2 0.000000 1 2.500000 12.628000 3.313991 1.756250 @@ -13267,7 +13267,7 @@ Atoms 13251 2 0.000000 1 2.500000 14.924000 7.290779 1.756250 13252 2 0.000000 -1 2.500000 14.924000 7.290779 1.756250 13253 2 0.000000 1 2.500000 8.036000 5.965183 5.268750 -13254 2 0.000000 -1.000000 2.500000 8.036000 5.965183 5.268750 +13254 2 0.000000 -1 2.500000 8.036000 5.965183 5.268750 13255 2 0.000000 1 2.500000 10.332000 1.988394 5.268750 13256 2 0.000000 -1 2.500000 10.332000 1.988394 5.268750 13257 2 0.000000 1 2.500000 12.628000 3.313991 8.781250 @@ -13275,7 +13275,7 @@ Atoms 13259 2 0.000000 1 2.500000 14.924000 7.290779 8.781250 13260 2 0.000000 -1 2.500000 14.924000 7.290779 8.781250 13261 2 0.000000 1 2.500000 8.036000 5.965183 12.293750 -13262 2 0.000000 -1.000000 2.500000 8.036000 5.965183 12.293750 +13262 2 0.000000 -1 2.500000 8.036000 5.965183 12.293750 13263 2 0.000000 1 2.500000 10.332000 1.988394 12.293750 13264 2 0.000000 -1 2.500000 10.332000 1.988394 12.293750 13265 2 0.000000 1 2.500000 12.628000 3.313991 15.806250 @@ -13283,7 +13283,7 @@ Atoms 13267 2 0.000000 1 2.500000 14.924000 7.290779 15.806250 13268 2 0.000000 -1 2.500000 14.924000 7.290779 15.806250 13269 2 0.000000 1 2.500000 8.036000 5.965183 19.318750 -13270 2 0.000000 -1.000000 2.500000 8.036000 5.965183 19.318750 +13270 2 0.000000 -1 2.500000 8.036000 5.965183 19.318750 13271 2 0.000000 1 2.500000 10.332000 1.988394 19.318750 13272 2 0.000000 -1 2.500000 10.332000 1.988394 19.318750 13273 2 0.000000 1 2.500000 12.628000 3.313991 22.831250 @@ -13291,7 +13291,7 @@ Atoms 13275 2 0.000000 1 2.500000 14.924000 7.290779 22.831250 13276 2 0.000000 -1 2.500000 14.924000 7.290779 22.831250 13277 2 0.000000 1 2.500000 8.036000 5.965183 26.343750 -13278 2 0.000000 -1.000000 2.500000 8.036000 5.965183 26.343750 +13278 2 0.000000 -1 2.500000 8.036000 5.965183 26.343750 13279 2 0.000000 1 2.500000 10.332000 1.988394 26.343750 13280 2 0.000000 -1 2.500000 10.332000 1.988394 26.343750 13281 2 0.000000 1 2.500000 12.628000 3.313991 29.856250 @@ -13299,7 +13299,7 @@ Atoms 13283 2 0.000000 1 2.500000 14.924000 7.290779 29.856250 13284 2 0.000000 -1 2.500000 14.924000 7.290779 29.856250 13285 2 0.000000 1 2.500000 8.036000 5.965183 33.368750 -13286 2 0.000000 -1.000000 2.500000 8.036000 5.965183 33.368750 +13286 2 0.000000 -1 2.500000 8.036000 5.965183 33.368750 13287 2 0.000000 1 2.500000 10.332000 1.988394 33.368750 13288 2 0.000000 -1 2.500000 10.332000 1.988394 33.368750 13289 2 0.000000 1 2.500000 12.628000 3.313991 36.881250 @@ -13307,7 +13307,7 @@ Atoms 13291 2 0.000000 1 2.500000 14.924000 7.290779 36.881250 13292 2 0.000000 -1 2.500000 14.924000 7.290779 36.881250 13293 2 0.000000 1 2.500000 8.036000 5.965183 40.393750 -13294 2 0.000000 -1.000000 2.500000 8.036000 5.965183 40.393750 +13294 2 0.000000 -1 2.500000 8.036000 5.965183 40.393750 13295 2 0.000000 1 2.500000 10.332000 1.988394 40.393750 13296 2 0.000000 -1 2.500000 10.332000 1.988394 40.393750 13297 2 0.000000 1 2.500000 12.628000 3.313991 43.906250 @@ -13315,7 +13315,7 @@ Atoms 13299 2 0.000000 1 2.500000 14.924000 7.290779 43.906250 13300 2 0.000000 -1 2.500000 14.924000 7.290779 43.906250 13301 2 0.000000 1 2.500000 8.036000 5.965183 47.418750 -13302 2 0.000000 -1.000000 2.500000 8.036000 5.965183 47.418750 +13302 2 0.000000 -1 2.500000 8.036000 5.965183 47.418750 13303 2 0.000000 1 2.500000 10.332000 1.988394 47.418750 13304 2 0.000000 -1 2.500000 10.332000 1.988394 47.418750 13305 2 0.000000 1 2.500000 12.628000 3.313991 50.931250 @@ -13323,7 +13323,7 @@ Atoms 13307 2 0.000000 1 2.500000 14.924000 7.290779 50.931250 13308 2 0.000000 -1 2.500000 14.924000 7.290779 50.931250 13309 2 0.000000 1 2.500000 8.036000 5.965183 54.443750 -13310 2 0.000000 -1.000000 2.500000 8.036000 5.965183 54.443750 +13310 2 0.000000 -1 2.500000 8.036000 5.965183 54.443750 13311 2 0.000000 1 2.500000 10.332000 1.988394 54.443750 13312 2 0.000000 -1 2.500000 10.332000 1.988394 54.443750 13313 2 0.000000 1 2.500000 12.628000 3.313991 57.956250 @@ -13331,7 +13331,7 @@ Atoms 13315 2 0.000000 1 2.500000 14.924000 7.290779 57.956250 13316 2 0.000000 -1 2.500000 14.924000 7.290779 57.956250 13317 2 0.000000 1 2.500000 8.036000 5.965183 61.468750 -13318 2 0.000000 -1.000000 2.500000 8.036000 5.965183 61.468750 +13318 2 0.000000 -1 2.500000 8.036000 5.965183 61.468750 13319 2 0.000000 1 2.500000 10.332000 1.988394 61.468750 13320 2 0.000000 -1 2.500000 10.332000 1.988394 61.468750 13321 2 0.000000 1 2.500000 12.628000 11.267568 1.756250 @@ -13339,7 +13339,7 @@ Atoms 13323 2 0.000000 1 2.500000 14.924000 15.244357 1.756250 13324 2 0.000000 -1 2.500000 14.924000 15.244357 1.756250 13325 2 0.000000 1 2.500000 8.036000 13.918760 5.268750 -13326 2 0.000000 -1.000000 2.500000 8.036000 13.918760 5.268750 +13326 2 0.000000 -1 2.500000 8.036000 13.918760 5.268750 13327 2 0.000000 1 2.500000 10.332000 9.941972 5.268750 13328 2 0.000000 -1 2.500000 10.332000 9.941972 5.268750 13329 2 0.000000 1 2.500000 12.628000 11.267568 8.781250 @@ -13347,7 +13347,7 @@ Atoms 13331 2 0.000000 1 2.500000 14.924000 15.244357 8.781250 13332 2 0.000000 -1 2.500000 14.924000 15.244357 8.781250 13333 2 0.000000 1 2.500000 8.036000 13.918760 12.293750 -13334 2 0.000000 -1.000000 2.500000 8.036000 13.918760 12.293750 +13334 2 0.000000 -1 2.500000 8.036000 13.918760 12.293750 13335 2 0.000000 1 2.500000 10.332000 9.941972 12.293750 13336 2 0.000000 -1 2.500000 10.332000 9.941972 12.293750 13337 2 0.000000 1 2.500000 12.628000 11.267568 15.806250 @@ -13355,7 +13355,7 @@ Atoms 13339 2 0.000000 1 2.500000 14.924000 15.244357 15.806250 13340 2 0.000000 -1 2.500000 14.924000 15.244357 15.806250 13341 2 0.000000 1 2.500000 8.036000 13.918760 19.318750 -13342 2 0.000000 -1.000000 2.500000 8.036000 13.918760 19.318750 +13342 2 0.000000 -1 2.500000 8.036000 13.918760 19.318750 13343 2 0.000000 1 2.500000 10.332000 9.941972 19.318750 13344 2 0.000000 -1 2.500000 10.332000 9.941972 19.318750 13345 2 0.000000 1 2.500000 12.628000 11.267568 22.831250 @@ -13363,7 +13363,7 @@ Atoms 13347 2 0.000000 1 2.500000 14.924000 15.244357 22.831250 13348 2 0.000000 -1 2.500000 14.924000 15.244357 22.831250 13349 2 0.000000 1 2.500000 8.036000 13.918760 26.343750 -13350 2 0.000000 -1.000000 2.500000 8.036000 13.918760 26.343750 +13350 2 0.000000 -1 2.500000 8.036000 13.918760 26.343750 13351 2 0.000000 1 2.500000 10.332000 9.941972 26.343750 13352 2 0.000000 -1 2.500000 10.332000 9.941972 26.343750 13353 2 0.000000 1 2.500000 12.628000 11.267568 29.856250 @@ -13371,7 +13371,7 @@ Atoms 13355 2 0.000000 1 2.500000 14.924000 15.244357 29.856250 13356 2 0.000000 -1 2.500000 14.924000 15.244357 29.856250 13357 2 0.000000 1 2.500000 8.036000 13.918760 33.368750 -13358 2 0.000000 -1.000000 2.500000 8.036000 13.918760 33.368750 +13358 2 0.000000 -1 2.500000 8.036000 13.918760 33.368750 13359 2 0.000000 1 2.500000 10.332000 9.941972 33.368750 13360 2 0.000000 -1 2.500000 10.332000 9.941972 33.368750 13361 2 0.000000 1 2.500000 12.628000 11.267568 36.881250 @@ -13379,7 +13379,7 @@ Atoms 13363 2 0.000000 1 2.500000 14.924000 15.244357 36.881250 13364 2 0.000000 -1 2.500000 14.924000 15.244357 36.881250 13365 2 0.000000 1 2.500000 8.036000 13.918760 40.393750 -13366 2 0.000000 -1.000000 2.500000 8.036000 13.918760 40.393750 +13366 2 0.000000 -1 2.500000 8.036000 13.918760 40.393750 13367 2 0.000000 1 2.500000 10.332000 9.941972 40.393750 13368 2 0.000000 -1 2.500000 10.332000 9.941972 40.393750 13369 2 0.000000 1 2.500000 12.628000 11.267568 43.906250 @@ -13387,7 +13387,7 @@ Atoms 13371 2 0.000000 1 2.500000 14.924000 15.244357 43.906250 13372 2 0.000000 -1 2.500000 14.924000 15.244357 43.906250 13373 2 0.000000 1 2.500000 8.036000 13.918760 47.418750 -13374 2 0.000000 -1.000000 2.500000 8.036000 13.918760 47.418750 +13374 2 0.000000 -1 2.500000 8.036000 13.918760 47.418750 13375 2 0.000000 1 2.500000 10.332000 9.941972 47.418750 13376 2 0.000000 -1 2.500000 10.332000 9.941972 47.418750 13377 2 0.000000 1 2.500000 12.628000 11.267568 50.931250 @@ -13395,7 +13395,7 @@ Atoms 13379 2 0.000000 1 2.500000 14.924000 15.244357 50.931250 13380 2 0.000000 -1 2.500000 14.924000 15.244357 50.931250 13381 2 0.000000 1 2.500000 8.036000 13.918760 54.443750 -13382 2 0.000000 -1.000000 2.500000 8.036000 13.918760 54.443750 +13382 2 0.000000 -1 2.500000 8.036000 13.918760 54.443750 13383 2 0.000000 1 2.500000 10.332000 9.941972 54.443750 13384 2 0.000000 -1 2.500000 10.332000 9.941972 54.443750 13385 2 0.000000 1 2.500000 12.628000 11.267568 57.956250 @@ -13403,7 +13403,7 @@ Atoms 13387 2 0.000000 1 2.500000 14.924000 15.244357 57.956250 13388 2 0.000000 -1 2.500000 14.924000 15.244357 57.956250 13389 2 0.000000 1 2.500000 8.036000 13.918760 61.468750 -13390 2 0.000000 -1.000000 2.500000 8.036000 13.918760 61.468750 +13390 2 0.000000 -1 2.500000 8.036000 13.918760 61.468750 13391 2 0.000000 1 2.500000 10.332000 9.941972 61.468750 13392 2 0.000000 -1 2.500000 10.332000 9.941972 61.468750 13393 2 0.000000 1 2.500000 12.628000 19.221145 1.756250 @@ -13411,7 +13411,7 @@ Atoms 13395 2 0.000000 1 2.500000 14.924000 23.197934 1.756250 13396 2 0.000000 -1 2.500000 14.924000 23.197934 1.756250 13397 2 0.000000 1 2.500000 8.036000 21.872338 5.268750 -13398 2 0.000000 -1.000000 2.500000 8.036000 21.872338 5.268750 +13398 2 0.000000 -1 2.500000 8.036000 21.872338 5.268750 13399 2 0.000000 1 2.500000 10.332000 17.895549 5.268750 13400 2 0.000000 -1 2.500000 10.332000 17.895549 5.268750 13401 2 0.000000 1 2.500000 12.628000 19.221145 8.781250 @@ -13419,7 +13419,7 @@ Atoms 13403 2 0.000000 1 2.500000 14.924000 23.197934 8.781250 13404 2 0.000000 -1 2.500000 14.924000 23.197934 8.781250 13405 2 0.000000 1 2.500000 8.036000 21.872338 12.293750 -13406 2 0.000000 -1.000000 2.500000 8.036000 21.872338 12.293750 +13406 2 0.000000 -1 2.500000 8.036000 21.872338 12.293750 13407 2 0.000000 1 2.500000 10.332000 17.895549 12.293750 13408 2 0.000000 -1 2.500000 10.332000 17.895549 12.293750 13409 2 0.000000 1 2.500000 12.628000 19.221145 15.806250 @@ -13427,7 +13427,7 @@ Atoms 13411 2 0.000000 1 2.500000 14.924000 23.197934 15.806250 13412 2 0.000000 -1 2.500000 14.924000 23.197934 15.806250 13413 2 0.000000 1 2.500000 8.036000 21.872338 19.318750 -13414 2 0.000000 -1.000000 2.500000 8.036000 21.872338 19.318750 +13414 2 0.000000 -1 2.500000 8.036000 21.872338 19.318750 13415 2 0.000000 1 2.500000 10.332000 17.895549 19.318750 13416 2 0.000000 -1 2.500000 10.332000 17.895549 19.318750 13417 2 0.000000 1 2.500000 12.628000 19.221145 22.831250 @@ -13435,7 +13435,7 @@ Atoms 13419 2 0.000000 1 2.500000 14.924000 23.197934 22.831250 13420 2 0.000000 -1 2.500000 14.924000 23.197934 22.831250 13421 2 0.000000 1 2.500000 8.036000 21.872338 26.343750 -13422 2 0.000000 -1.000000 2.500000 8.036000 21.872338 26.343750 +13422 2 0.000000 -1 2.500000 8.036000 21.872338 26.343750 13423 2 0.000000 1 2.500000 10.332000 17.895549 26.343750 13424 2 0.000000 -1 2.500000 10.332000 17.895549 26.343750 13425 2 0.000000 1 2.500000 12.628000 19.221145 29.856250 @@ -13443,7 +13443,7 @@ Atoms 13427 2 0.000000 1 2.500000 14.924000 23.197934 29.856250 13428 2 0.000000 -1 2.500000 14.924000 23.197934 29.856250 13429 2 0.000000 1 2.500000 8.036000 21.872338 33.368750 -13430 2 0.000000 -1.000000 2.500000 8.036000 21.872338 33.368750 +13430 2 0.000000 -1 2.500000 8.036000 21.872338 33.368750 13431 2 0.000000 1 2.500000 10.332000 17.895549 33.368750 13432 2 0.000000 -1 2.500000 10.332000 17.895549 33.368750 13433 2 0.000000 1 2.500000 12.628000 19.221145 36.881250 @@ -13451,7 +13451,7 @@ Atoms 13435 2 0.000000 1 2.500000 14.924000 23.197934 36.881250 13436 2 0.000000 -1 2.500000 14.924000 23.197934 36.881250 13437 2 0.000000 1 2.500000 8.036000 21.872338 40.393750 -13438 2 0.000000 -1.000000 2.500000 8.036000 21.872338 40.393750 +13438 2 0.000000 -1 2.500000 8.036000 21.872338 40.393750 13439 2 0.000000 1 2.500000 10.332000 17.895549 40.393750 13440 2 0.000000 -1 2.500000 10.332000 17.895549 40.393750 13441 2 0.000000 1 2.500000 12.628000 19.221145 43.906250 @@ -13459,7 +13459,7 @@ Atoms 13443 2 0.000000 1 2.500000 14.924000 23.197934 43.906250 13444 2 0.000000 -1 2.500000 14.924000 23.197934 43.906250 13445 2 0.000000 1 2.500000 8.036000 21.872338 47.418750 -13446 2 0.000000 -1.000000 2.500000 8.036000 21.872338 47.418750 +13446 2 0.000000 -1 2.500000 8.036000 21.872338 47.418750 13447 2 0.000000 1 2.500000 10.332000 17.895549 47.418750 13448 2 0.000000 -1 2.500000 10.332000 17.895549 47.418750 13449 2 0.000000 1 2.500000 12.628000 19.221145 50.931250 @@ -13467,7 +13467,7 @@ Atoms 13451 2 0.000000 1 2.500000 14.924000 23.197934 50.931250 13452 2 0.000000 -1 2.500000 14.924000 23.197934 50.931250 13453 2 0.000000 1 2.500000 8.036000 21.872338 54.443750 -13454 2 0.000000 -1.000000 2.500000 8.036000 21.872338 54.443750 +13454 2 0.000000 -1 2.500000 8.036000 21.872338 54.443750 13455 2 0.000000 1 2.500000 10.332000 17.895549 54.443750 13456 2 0.000000 -1 2.500000 10.332000 17.895549 54.443750 13457 2 0.000000 1 2.500000 12.628000 19.221145 57.956250 @@ -13475,7 +13475,7 @@ Atoms 13459 2 0.000000 1 2.500000 14.924000 23.197934 57.956250 13460 2 0.000000 -1 2.500000 14.924000 23.197934 57.956250 13461 2 0.000000 1 2.500000 8.036000 21.872338 61.468750 -13462 2 0.000000 -1.000000 2.500000 8.036000 21.872338 61.468750 +13462 2 0.000000 -1 2.500000 8.036000 21.872338 61.468750 13463 2 0.000000 1 2.500000 10.332000 17.895549 61.468750 13464 2 0.000000 -1 2.500000 10.332000 17.895549 61.468750 13465 2 0.000000 1 2.500000 12.628000 27.174722 1.756250 @@ -13483,7 +13483,7 @@ Atoms 13467 2 0.000000 1 2.500000 14.924000 31.151511 1.756250 13468 2 0.000000 -1 2.500000 14.924000 31.151511 1.756250 13469 2 0.000000 1 2.500000 8.036000 29.825915 5.268750 -13470 2 0.000000 -1.000000 2.500000 8.036000 29.825915 5.268750 +13470 2 0.000000 -1 2.500000 8.036000 29.825915 5.268750 13471 2 0.000000 1 2.500000 10.332000 25.849126 5.268750 13472 2 0.000000 -1 2.500000 10.332000 25.849126 5.268750 13473 2 0.000000 1 2.500000 12.628000 27.174722 8.781250 @@ -13491,7 +13491,7 @@ Atoms 13475 2 0.000000 1 2.500000 14.924000 31.151511 8.781250 13476 2 0.000000 -1 2.500000 14.924000 31.151511 8.781250 13477 2 0.000000 1 2.500000 8.036000 29.825915 12.293750 -13478 2 0.000000 -1.000000 2.500000 8.036000 29.825915 12.293750 +13478 2 0.000000 -1 2.500000 8.036000 29.825915 12.293750 13479 2 0.000000 1 2.500000 10.332000 25.849126 12.293750 13480 2 0.000000 -1 2.500000 10.332000 25.849126 12.293750 13481 2 0.000000 1 2.500000 12.628000 27.174722 15.806250 @@ -13499,7 +13499,7 @@ Atoms 13483 2 0.000000 1 2.500000 14.924000 31.151511 15.806250 13484 2 0.000000 -1 2.500000 14.924000 31.151511 15.806250 13485 2 0.000000 1 2.500000 8.036000 29.825915 19.318750 -13486 2 0.000000 -1.000000 2.500000 8.036000 29.825915 19.318750 +13486 2 0.000000 -1 2.500000 8.036000 29.825915 19.318750 13487 2 0.000000 1 2.500000 10.332000 25.849126 19.318750 13488 2 0.000000 -1 2.500000 10.332000 25.849126 19.318750 13489 2 0.000000 1 2.500000 12.628000 27.174722 22.831250 @@ -13507,7 +13507,7 @@ Atoms 13491 2 0.000000 1 2.500000 14.924000 31.151511 22.831250 13492 2 0.000000 -1 2.500000 14.924000 31.151511 22.831250 13493 2 0.000000 1 2.500000 8.036000 29.825915 26.343750 -13494 2 0.000000 -1.000000 2.500000 8.036000 29.825915 26.343750 +13494 2 0.000000 -1 2.500000 8.036000 29.825915 26.343750 13495 2 0.000000 1 2.500000 10.332000 25.849126 26.343750 13496 2 0.000000 -1 2.500000 10.332000 25.849126 26.343750 13497 2 0.000000 1 2.500000 12.628000 27.174722 29.856250 @@ -13515,7 +13515,7 @@ Atoms 13499 2 0.000000 1 2.500000 14.924000 31.151511 29.856250 13500 2 0.000000 -1 2.500000 14.924000 31.151511 29.856250 13501 2 0.000000 1 2.500000 8.036000 29.825915 33.368750 -13502 2 0.000000 -1.000000 2.500000 8.036000 29.825915 33.368750 +13502 2 0.000000 -1 2.500000 8.036000 29.825915 33.368750 13503 2 0.000000 1 2.500000 10.332000 25.849126 33.368750 13504 2 0.000000 -1 2.500000 10.332000 25.849126 33.368750 13505 2 0.000000 1 2.500000 12.628000 27.174722 36.881250 @@ -13523,7 +13523,7 @@ Atoms 13507 2 0.000000 1 2.500000 14.924000 31.151511 36.881250 13508 2 0.000000 -1 2.500000 14.924000 31.151511 36.881250 13509 2 0.000000 1 2.500000 8.036000 29.825915 40.393750 -13510 2 0.000000 -1.000000 2.500000 8.036000 29.825915 40.393750 +13510 2 0.000000 -1 2.500000 8.036000 29.825915 40.393750 13511 2 0.000000 1 2.500000 10.332000 25.849126 40.393750 13512 2 0.000000 -1 2.500000 10.332000 25.849126 40.393750 13513 2 0.000000 1 2.500000 12.628000 27.174722 43.906250 @@ -13531,7 +13531,7 @@ Atoms 13515 2 0.000000 1 2.500000 14.924000 31.151511 43.906250 13516 2 0.000000 -1 2.500000 14.924000 31.151511 43.906250 13517 2 0.000000 1 2.500000 8.036000 29.825915 47.418750 -13518 2 0.000000 -1.000000 2.500000 8.036000 29.825915 47.418750 +13518 2 0.000000 -1 2.500000 8.036000 29.825915 47.418750 13519 2 0.000000 1 2.500000 10.332000 25.849126 47.418750 13520 2 0.000000 -1 2.500000 10.332000 25.849126 47.418750 13521 2 0.000000 1 2.500000 12.628000 27.174722 50.931250 @@ -13539,7 +13539,7 @@ Atoms 13523 2 0.000000 1 2.500000 14.924000 31.151511 50.931250 13524 2 0.000000 -1 2.500000 14.924000 31.151511 50.931250 13525 2 0.000000 1 2.500000 8.036000 29.825915 54.443750 -13526 2 0.000000 -1.000000 2.500000 8.036000 29.825915 54.443750 +13526 2 0.000000 -1 2.500000 8.036000 29.825915 54.443750 13527 2 0.000000 1 2.500000 10.332000 25.849126 54.443750 13528 2 0.000000 -1 2.500000 10.332000 25.849126 54.443750 13529 2 0.000000 1 2.500000 12.628000 27.174722 57.956250 @@ -13547,7 +13547,7 @@ Atoms 13531 2 0.000000 1 2.500000 14.924000 31.151511 57.956250 13532 2 0.000000 -1 2.500000 14.924000 31.151511 57.956250 13533 2 0.000000 1 2.500000 8.036000 29.825915 61.468750 -13534 2 0.000000 -1.000000 2.500000 8.036000 29.825915 61.468750 +13534 2 0.000000 -1 2.500000 8.036000 29.825915 61.468750 13535 2 0.000000 1 2.500000 10.332000 25.849126 61.468750 13536 2 0.000000 -1 2.500000 10.332000 25.849126 61.468750 13537 2 0.000000 1 2.500000 12.628000 35.128300 1.756250 @@ -13555,7 +13555,7 @@ Atoms 13539 2 0.000000 1 2.500000 14.924000 39.105088 1.756250 13540 2 0.000000 -1 2.500000 14.924000 39.105088 1.756250 13541 2 0.000000 1 2.500000 8.036000 37.779492 5.268750 -13542 2 0.000000 -1.000000 2.500000 8.036000 37.779492 5.268750 +13542 2 0.000000 -1 2.500000 8.036000 37.779492 5.268750 13543 2 0.000000 1 2.500000 10.332000 33.802704 5.268750 13544 2 0.000000 -1 2.500000 10.332000 33.802704 5.268750 13545 2 0.000000 1 2.500000 12.628000 35.128300 8.781250 @@ -13563,7 +13563,7 @@ Atoms 13547 2 0.000000 1 2.500000 14.924000 39.105088 8.781250 13548 2 0.000000 -1 2.500000 14.924000 39.105088 8.781250 13549 2 0.000000 1 2.500000 8.036000 37.779492 12.293750 -13550 2 0.000000 -1.000000 2.500000 8.036000 37.779492 12.293750 +13550 2 0.000000 -1 2.500000 8.036000 37.779492 12.293750 13551 2 0.000000 1 2.500000 10.332000 33.802704 12.293750 13552 2 0.000000 -1 2.500000 10.332000 33.802704 12.293750 13553 2 0.000000 1 2.500000 12.628000 35.128300 15.806250 @@ -13571,7 +13571,7 @@ Atoms 13555 2 0.000000 1 2.500000 14.924000 39.105088 15.806250 13556 2 0.000000 -1 2.500000 14.924000 39.105088 15.806250 13557 2 0.000000 1 2.500000 8.036000 37.779492 19.318750 -13558 2 0.000000 -1.000000 2.500000 8.036000 37.779492 19.318750 +13558 2 0.000000 -1 2.500000 8.036000 37.779492 19.318750 13559 2 0.000000 1 2.500000 10.332000 33.802704 19.318750 13560 2 0.000000 -1 2.500000 10.332000 33.802704 19.318750 13561 2 0.000000 1 2.500000 12.628000 35.128300 22.831250 @@ -13579,7 +13579,7 @@ Atoms 13563 2 0.000000 1 2.500000 14.924000 39.105088 22.831250 13564 2 0.000000 -1 2.500000 14.924000 39.105088 22.831250 13565 2 0.000000 1 2.500000 8.036000 37.779492 26.343750 -13566 2 0.000000 -1.000000 2.500000 8.036000 37.779492 26.343750 +13566 2 0.000000 -1 2.500000 8.036000 37.779492 26.343750 13567 2 0.000000 1 2.500000 10.332000 33.802704 26.343750 13568 2 0.000000 -1 2.500000 10.332000 33.802704 26.343750 13569 2 0.000000 1 2.500000 12.628000 35.128300 29.856250 @@ -13587,7 +13587,7 @@ Atoms 13571 2 0.000000 1 2.500000 14.924000 39.105088 29.856250 13572 2 0.000000 -1 2.500000 14.924000 39.105088 29.856250 13573 2 0.000000 1 2.500000 8.036000 37.779492 33.368750 -13574 2 0.000000 -1.000000 2.500000 8.036000 37.779492 33.368750 +13574 2 0.000000 -1 2.500000 8.036000 37.779492 33.368750 13575 2 0.000000 1 2.500000 10.332000 33.802704 33.368750 13576 2 0.000000 -1 2.500000 10.332000 33.802704 33.368750 13577 2 0.000000 1 2.500000 12.628000 35.128300 36.881250 @@ -13595,7 +13595,7 @@ Atoms 13579 2 0.000000 1 2.500000 14.924000 39.105088 36.881250 13580 2 0.000000 -1 2.500000 14.924000 39.105088 36.881250 13581 2 0.000000 1 2.500000 8.036000 37.779492 40.393750 -13582 2 0.000000 -1.000000 2.500000 8.036000 37.779492 40.393750 +13582 2 0.000000 -1 2.500000 8.036000 37.779492 40.393750 13583 2 0.000000 1 2.500000 10.332000 33.802704 40.393750 13584 2 0.000000 -1 2.500000 10.332000 33.802704 40.393750 13585 2 0.000000 1 2.500000 12.628000 35.128300 43.906250 @@ -13603,7 +13603,7 @@ Atoms 13587 2 0.000000 1 2.500000 14.924000 39.105088 43.906250 13588 2 0.000000 -1 2.500000 14.924000 39.105088 43.906250 13589 2 0.000000 1 2.500000 8.036000 37.779492 47.418750 -13590 2 0.000000 -1.000000 2.500000 8.036000 37.779492 47.418750 +13590 2 0.000000 -1 2.500000 8.036000 37.779492 47.418750 13591 2 0.000000 1 2.500000 10.332000 33.802704 47.418750 13592 2 0.000000 -1 2.500000 10.332000 33.802704 47.418750 13593 2 0.000000 1 2.500000 12.628000 35.128300 50.931250 @@ -13611,7 +13611,7 @@ Atoms 13595 2 0.000000 1 2.500000 14.924000 39.105088 50.931250 13596 2 0.000000 -1 2.500000 14.924000 39.105088 50.931250 13597 2 0.000000 1 2.500000 8.036000 37.779492 54.443750 -13598 2 0.000000 -1.000000 2.500000 8.036000 37.779492 54.443750 +13598 2 0.000000 -1 2.500000 8.036000 37.779492 54.443750 13599 2 0.000000 1 2.500000 10.332000 33.802704 54.443750 13600 2 0.000000 -1 2.500000 10.332000 33.802704 54.443750 13601 2 0.000000 1 2.500000 12.628000 35.128300 57.956250 @@ -13619,7 +13619,7 @@ Atoms 13603 2 0.000000 1 2.500000 14.924000 39.105088 57.956250 13604 2 0.000000 -1 2.500000 14.924000 39.105088 57.956250 13605 2 0.000000 1 2.500000 8.036000 37.779492 61.468750 -13606 2 0.000000 -1.000000 2.500000 8.036000 37.779492 61.468750 +13606 2 0.000000 -1 2.500000 8.036000 37.779492 61.468750 13607 2 0.000000 1 2.500000 10.332000 33.802704 61.468750 13608 2 0.000000 -1 2.500000 10.332000 33.802704 61.468750 13609 2 0.000000 1 2.500000 12.628000 43.081877 1.756250 @@ -13627,7 +13627,7 @@ Atoms 13611 2 0.000000 1 2.500000 14.924000 47.058666 1.756250 13612 2 0.000000 -1 2.500000 14.924000 47.058666 1.756250 13613 2 0.000000 1 2.500000 8.036000 45.733070 5.268750 -13614 2 0.000000 -1.000000 2.500000 8.036000 45.733070 5.268750 +13614 2 0.000000 -1 2.500000 8.036000 45.733070 5.268750 13615 2 0.000000 1 2.500000 10.332000 41.756281 5.268750 13616 2 0.000000 -1 2.500000 10.332000 41.756281 5.268750 13617 2 0.000000 1 2.500000 12.628000 43.081877 8.781250 @@ -13635,7 +13635,7 @@ Atoms 13619 2 0.000000 1 2.500000 14.924000 47.058666 8.781250 13620 2 0.000000 -1 2.500000 14.924000 47.058666 8.781250 13621 2 0.000000 1 2.500000 8.036000 45.733070 12.293750 -13622 2 0.000000 -1.000000 2.500000 8.036000 45.733070 12.293750 +13622 2 0.000000 -1 2.500000 8.036000 45.733070 12.293750 13623 2 0.000000 1 2.500000 10.332000 41.756281 12.293750 13624 2 0.000000 -1 2.500000 10.332000 41.756281 12.293750 13625 2 0.000000 1 2.500000 12.628000 43.081877 15.806250 @@ -13643,7 +13643,7 @@ Atoms 13627 2 0.000000 1 2.500000 14.924000 47.058666 15.806250 13628 2 0.000000 -1 2.500000 14.924000 47.058666 15.806250 13629 2 0.000000 1 2.500000 8.036000 45.733070 19.318750 -13630 2 0.000000 -1.000000 2.500000 8.036000 45.733070 19.318750 +13630 2 0.000000 -1 2.500000 8.036000 45.733070 19.318750 13631 2 0.000000 1 2.500000 10.332000 41.756281 19.318750 13632 2 0.000000 -1 2.500000 10.332000 41.756281 19.318750 13633 2 0.000000 1 2.500000 12.628000 43.081877 22.831250 @@ -13651,7 +13651,7 @@ Atoms 13635 2 0.000000 1 2.500000 14.924000 47.058666 22.831250 13636 2 0.000000 -1 2.500000 14.924000 47.058666 22.831250 13637 2 0.000000 1 2.500000 8.036000 45.733070 26.343750 -13638 2 0.000000 -1.000000 2.500000 8.036000 45.733070 26.343750 +13638 2 0.000000 -1 2.500000 8.036000 45.733070 26.343750 13639 2 0.000000 1 2.500000 10.332000 41.756281 26.343750 13640 2 0.000000 -1 2.500000 10.332000 41.756281 26.343750 13641 2 0.000000 1 2.500000 12.628000 43.081877 29.856250 @@ -13659,7 +13659,7 @@ Atoms 13643 2 0.000000 1 2.500000 14.924000 47.058666 29.856250 13644 2 0.000000 -1 2.500000 14.924000 47.058666 29.856250 13645 2 0.000000 1 2.500000 8.036000 45.733070 33.368750 -13646 2 0.000000 -1.000000 2.500000 8.036000 45.733070 33.368750 +13646 2 0.000000 -1 2.500000 8.036000 45.733070 33.368750 13647 2 0.000000 1 2.500000 10.332000 41.756281 33.368750 13648 2 0.000000 -1 2.500000 10.332000 41.756281 33.368750 13649 2 0.000000 1 2.500000 12.628000 43.081877 36.881250 @@ -13667,7 +13667,7 @@ Atoms 13651 2 0.000000 1 2.500000 14.924000 47.058666 36.881250 13652 2 0.000000 -1 2.500000 14.924000 47.058666 36.881250 13653 2 0.000000 1 2.500000 8.036000 45.733070 40.393750 -13654 2 0.000000 -1.000000 2.500000 8.036000 45.733070 40.393750 +13654 2 0.000000 -1 2.500000 8.036000 45.733070 40.393750 13655 2 0.000000 1 2.500000 10.332000 41.756281 40.393750 13656 2 0.000000 -1 2.500000 10.332000 41.756281 40.393750 13657 2 0.000000 1 2.500000 12.628000 43.081877 43.906250 @@ -13675,7 +13675,7 @@ Atoms 13659 2 0.000000 1 2.500000 14.924000 47.058666 43.906250 13660 2 0.000000 -1 2.500000 14.924000 47.058666 43.906250 13661 2 0.000000 1 2.500000 8.036000 45.733070 47.418750 -13662 2 0.000000 -1.000000 2.500000 8.036000 45.733070 47.418750 +13662 2 0.000000 -1 2.500000 8.036000 45.733070 47.418750 13663 2 0.000000 1 2.500000 10.332000 41.756281 47.418750 13664 2 0.000000 -1 2.500000 10.332000 41.756281 47.418750 13665 2 0.000000 1 2.500000 12.628000 43.081877 50.931250 @@ -13683,7 +13683,7 @@ Atoms 13667 2 0.000000 1 2.500000 14.924000 47.058666 50.931250 13668 2 0.000000 -1 2.500000 14.924000 47.058666 50.931250 13669 2 0.000000 1 2.500000 8.036000 45.733070 54.443750 -13670 2 0.000000 -1.000000 2.500000 8.036000 45.733070 54.443750 +13670 2 0.000000 -1 2.500000 8.036000 45.733070 54.443750 13671 2 0.000000 1 2.500000 10.332000 41.756281 54.443750 13672 2 0.000000 -1 2.500000 10.332000 41.756281 54.443750 13673 2 0.000000 1 2.500000 12.628000 43.081877 57.956250 @@ -13691,7 +13691,7 @@ Atoms 13675 2 0.000000 1 2.500000 14.924000 47.058666 57.956250 13676 2 0.000000 -1 2.500000 14.924000 47.058666 57.956250 13677 2 0.000000 1 2.500000 8.036000 45.733070 61.468750 -13678 2 0.000000 -1.000000 2.500000 8.036000 45.733070 61.468750 +13678 2 0.000000 -1 2.500000 8.036000 45.733070 61.468750 13679 2 0.000000 1 2.500000 10.332000 41.756281 61.468750 13680 2 0.000000 -1 2.500000 10.332000 41.756281 61.468750 13681 2 0.000000 1 2.500000 12.628000 51.035454 1.756250 @@ -13699,7 +13699,7 @@ Atoms 13683 2 0.000000 1 2.500000 14.924000 55.012243 1.756250 13684 2 0.000000 -1 2.500000 14.924000 55.012243 1.756250 13685 2 0.000000 1 2.500000 8.036000 53.686647 5.268750 -13686 2 0.000000 -1.000000 2.500000 8.036000 53.686647 5.268750 +13686 2 0.000000 -1 2.500000 8.036000 53.686647 5.268750 13687 2 0.000000 1 2.500000 10.332000 49.709858 5.268750 13688 2 0.000000 -1 2.500000 10.332000 49.709858 5.268750 13689 2 0.000000 1 2.500000 12.628000 51.035454 8.781250 @@ -13707,7 +13707,7 @@ Atoms 13691 2 0.000000 1 2.500000 14.924000 55.012243 8.781250 13692 2 0.000000 -1 2.500000 14.924000 55.012243 8.781250 13693 2 0.000000 1 2.500000 8.036000 53.686647 12.293750 -13694 2 0.000000 -1.000000 2.500000 8.036000 53.686647 12.293750 +13694 2 0.000000 -1 2.500000 8.036000 53.686647 12.293750 13695 2 0.000000 1 2.500000 10.332000 49.709858 12.293750 13696 2 0.000000 -1 2.500000 10.332000 49.709858 12.293750 13697 2 0.000000 1 2.500000 12.628000 51.035454 15.806250 @@ -13715,7 +13715,7 @@ Atoms 13699 2 0.000000 1 2.500000 14.924000 55.012243 15.806250 13700 2 0.000000 -1 2.500000 14.924000 55.012243 15.806250 13701 2 0.000000 1 2.500000 8.036000 53.686647 19.318750 -13702 2 0.000000 -1.000000 2.500000 8.036000 53.686647 19.318750 +13702 2 0.000000 -1 2.500000 8.036000 53.686647 19.318750 13703 2 0.000000 1 2.500000 10.332000 49.709858 19.318750 13704 2 0.000000 -1 2.500000 10.332000 49.709858 19.318750 13705 2 0.000000 1 2.500000 12.628000 51.035454 22.831250 @@ -13723,7 +13723,7 @@ Atoms 13707 2 0.000000 1 2.500000 14.924000 55.012243 22.831250 13708 2 0.000000 -1 2.500000 14.924000 55.012243 22.831250 13709 2 0.000000 1 2.500000 8.036000 53.686647 26.343750 -13710 2 0.000000 -1.000000 2.500000 8.036000 53.686647 26.343750 +13710 2 0.000000 -1 2.500000 8.036000 53.686647 26.343750 13711 2 0.000000 1 2.500000 10.332000 49.709858 26.343750 13712 2 0.000000 -1 2.500000 10.332000 49.709858 26.343750 13713 2 0.000000 1 2.500000 12.628000 51.035454 29.856250 @@ -13731,7 +13731,7 @@ Atoms 13715 2 0.000000 1 2.500000 14.924000 55.012243 29.856250 13716 2 0.000000 -1 2.500000 14.924000 55.012243 29.856250 13717 2 0.000000 1 2.500000 8.036000 53.686647 33.368750 -13718 2 0.000000 -1.000000 2.500000 8.036000 53.686647 33.368750 +13718 2 0.000000 -1 2.500000 8.036000 53.686647 33.368750 13719 2 0.000000 1 2.500000 10.332000 49.709858 33.368750 13720 2 0.000000 -1 2.500000 10.332000 49.709858 33.368750 13721 2 0.000000 1 2.500000 12.628000 51.035454 36.881250 @@ -13739,7 +13739,7 @@ Atoms 13723 2 0.000000 1 2.500000 14.924000 55.012243 36.881250 13724 2 0.000000 -1 2.500000 14.924000 55.012243 36.881250 13725 2 0.000000 1 2.500000 8.036000 53.686647 40.393750 -13726 2 0.000000 -1.000000 2.500000 8.036000 53.686647 40.393750 +13726 2 0.000000 -1 2.500000 8.036000 53.686647 40.393750 13727 2 0.000000 1 2.500000 10.332000 49.709858 40.393750 13728 2 0.000000 -1 2.500000 10.332000 49.709858 40.393750 13729 2 0.000000 1 2.500000 12.628000 51.035454 43.906250 @@ -13747,7 +13747,7 @@ Atoms 13731 2 0.000000 1 2.500000 14.924000 55.012243 43.906250 13732 2 0.000000 -1 2.500000 14.924000 55.012243 43.906250 13733 2 0.000000 1 2.500000 8.036000 53.686647 47.418750 -13734 2 0.000000 -1.000000 2.500000 8.036000 53.686647 47.418750 +13734 2 0.000000 -1 2.500000 8.036000 53.686647 47.418750 13735 2 0.000000 1 2.500000 10.332000 49.709858 47.418750 13736 2 0.000000 -1 2.500000 10.332000 49.709858 47.418750 13737 2 0.000000 1 2.500000 12.628000 51.035454 50.931250 @@ -13755,7 +13755,7 @@ Atoms 13739 2 0.000000 1 2.500000 14.924000 55.012243 50.931250 13740 2 0.000000 -1 2.500000 14.924000 55.012243 50.931250 13741 2 0.000000 1 2.500000 8.036000 53.686647 54.443750 -13742 2 0.000000 -1.000000 2.500000 8.036000 53.686647 54.443750 +13742 2 0.000000 -1 2.500000 8.036000 53.686647 54.443750 13743 2 0.000000 1 2.500000 10.332000 49.709858 54.443750 13744 2 0.000000 -1 2.500000 10.332000 49.709858 54.443750 13745 2 0.000000 1 2.500000 12.628000 51.035454 57.956250 @@ -13763,7 +13763,7 @@ Atoms 13747 2 0.000000 1 2.500000 14.924000 55.012243 57.956250 13748 2 0.000000 -1 2.500000 14.924000 55.012243 57.956250 13749 2 0.000000 1 2.500000 8.036000 53.686647 61.468750 -13750 2 0.000000 -1.000000 2.500000 8.036000 53.686647 61.468750 +13750 2 0.000000 -1 2.500000 8.036000 53.686647 61.468750 13751 2 0.000000 1 2.500000 10.332000 49.709858 61.468750 13752 2 0.000000 -1 2.500000 10.332000 49.709858 61.468750 13753 2 0.000000 1 2.500000 12.628000 58.989032 1.756250 @@ -13771,7 +13771,7 @@ Atoms 13755 2 0.000000 1 2.500000 14.924000 62.965820 1.756250 13756 2 0.000000 -1 2.500000 14.924000 62.965820 1.756250 13757 2 0.000000 1 2.500000 8.036000 61.640224 5.268750 -13758 2 0.000000 -1.000000 2.500000 8.036000 61.640224 5.268750 +13758 2 0.000000 -1 2.500000 8.036000 61.640224 5.268750 13759 2 0.000000 1 2.500000 10.332000 57.663435 5.268750 13760 2 0.000000 -1 2.500000 10.332000 57.663435 5.268750 13761 2 0.000000 1 2.500000 12.628000 58.989032 8.781250 @@ -13779,7 +13779,7 @@ Atoms 13763 2 0.000000 1 2.500000 14.924000 62.965820 8.781250 13764 2 0.000000 -1 2.500000 14.924000 62.965820 8.781250 13765 2 0.000000 1 2.500000 8.036000 61.640224 12.293750 -13766 2 0.000000 -1.000000 2.500000 8.036000 61.640224 12.293750 +13766 2 0.000000 -1 2.500000 8.036000 61.640224 12.293750 13767 2 0.000000 1 2.500000 10.332000 57.663435 12.293750 13768 2 0.000000 -1 2.500000 10.332000 57.663435 12.293750 13769 2 0.000000 1 2.500000 12.628000 58.989032 15.806250 @@ -13787,7 +13787,7 @@ Atoms 13771 2 0.000000 1 2.500000 14.924000 62.965820 15.806250 13772 2 0.000000 -1 2.500000 14.924000 62.965820 15.806250 13773 2 0.000000 1 2.500000 8.036000 61.640224 19.318750 -13774 2 0.000000 -1.000000 2.500000 8.036000 61.640224 19.318750 +13774 2 0.000000 -1 2.500000 8.036000 61.640224 19.318750 13775 2 0.000000 1 2.500000 10.332000 57.663435 19.318750 13776 2 0.000000 -1 2.500000 10.332000 57.663435 19.318750 13777 2 0.000000 1 2.500000 12.628000 58.989032 22.831250 @@ -13795,7 +13795,7 @@ Atoms 13779 2 0.000000 1 2.500000 14.924000 62.965820 22.831250 13780 2 0.000000 -1 2.500000 14.924000 62.965820 22.831250 13781 2 0.000000 1 2.500000 8.036000 61.640224 26.343750 -13782 2 0.000000 -1.000000 2.500000 8.036000 61.640224 26.343750 +13782 2 0.000000 -1 2.500000 8.036000 61.640224 26.343750 13783 2 0.000000 1 2.500000 10.332000 57.663435 26.343750 13784 2 0.000000 -1 2.500000 10.332000 57.663435 26.343750 13785 2 0.000000 1 2.500000 12.628000 58.989032 29.856250 @@ -13803,7 +13803,7 @@ Atoms 13787 2 0.000000 1 2.500000 14.924000 62.965820 29.856250 13788 2 0.000000 -1 2.500000 14.924000 62.965820 29.856250 13789 2 0.000000 1 2.500000 8.036000 61.640224 33.368750 -13790 2 0.000000 -1.000000 2.500000 8.036000 61.640224 33.368750 +13790 2 0.000000 -1 2.500000 8.036000 61.640224 33.368750 13791 2 0.000000 1 2.500000 10.332000 57.663435 33.368750 13792 2 0.000000 -1 2.500000 10.332000 57.663435 33.368750 13793 2 0.000000 1 2.500000 12.628000 58.989032 36.881250 @@ -13811,7 +13811,7 @@ Atoms 13795 2 0.000000 1 2.500000 14.924000 62.965820 36.881250 13796 2 0.000000 -1 2.500000 14.924000 62.965820 36.881250 13797 2 0.000000 1 2.500000 8.036000 61.640224 40.393750 -13798 2 0.000000 -1.000000 2.500000 8.036000 61.640224 40.393750 +13798 2 0.000000 -1 2.500000 8.036000 61.640224 40.393750 13799 2 0.000000 1 2.500000 10.332000 57.663435 40.393750 13800 2 0.000000 -1 2.500000 10.332000 57.663435 40.393750 13801 2 0.000000 1 2.500000 12.628000 58.989032 43.906250 @@ -13819,7 +13819,7 @@ Atoms 13803 2 0.000000 1 2.500000 14.924000 62.965820 43.906250 13804 2 0.000000 -1 2.500000 14.924000 62.965820 43.906250 13805 2 0.000000 1 2.500000 8.036000 61.640224 47.418750 -13806 2 0.000000 -1.000000 2.500000 8.036000 61.640224 47.418750 +13806 2 0.000000 -1 2.500000 8.036000 61.640224 47.418750 13807 2 0.000000 1 2.500000 10.332000 57.663435 47.418750 13808 2 0.000000 -1 2.500000 10.332000 57.663435 47.418750 13809 2 0.000000 1 2.500000 12.628000 58.989032 50.931250 @@ -13827,7 +13827,7 @@ Atoms 13811 2 0.000000 1 2.500000 14.924000 62.965820 50.931250 13812 2 0.000000 -1 2.500000 14.924000 62.965820 50.931250 13813 2 0.000000 1 2.500000 8.036000 61.640224 54.443750 -13814 2 0.000000 -1.000000 2.500000 8.036000 61.640224 54.443750 +13814 2 0.000000 -1 2.500000 8.036000 61.640224 54.443750 13815 2 0.000000 1 2.500000 10.332000 57.663435 54.443750 13816 2 0.000000 -1 2.500000 10.332000 57.663435 54.443750 13817 2 0.000000 1 2.500000 12.628000 58.989032 57.956250 @@ -13835,7 +13835,7 @@ Atoms 13819 2 0.000000 1 2.500000 14.924000 62.965820 57.956250 13820 2 0.000000 -1 2.500000 14.924000 62.965820 57.956250 13821 2 0.000000 1 2.500000 8.036000 61.640224 61.468750 -13822 2 0.000000 -1.000000 2.500000 8.036000 61.640224 61.468750 +13822 2 0.000000 -1 2.500000 8.036000 61.640224 61.468750 13823 2 0.000000 1 2.500000 10.332000 57.663435 61.468750 13824 2 0.000000 -1 2.500000 10.332000 57.663435 61.468750 13825 2 0.000000 1 2.500000 17.220000 3.313991 1.756250 @@ -13843,7 +13843,7 @@ Atoms 13827 2 0.000000 1 2.500000 19.516000 7.290779 1.756250 13828 2 0.000000 -1 2.500000 19.516000 7.290779 1.756250 13829 2 0.000000 1 2.500000 12.628000 5.965183 5.268750 -13830 2 0.000000 -1.000000 2.500000 12.628000 5.965183 5.268750 +13830 2 0.000000 -1 2.500000 12.628000 5.965183 5.268750 13831 2 0.000000 1 2.500000 14.924000 1.988394 5.268750 13832 2 0.000000 -1 2.500000 14.924000 1.988394 5.268750 13833 2 0.000000 1 2.500000 17.220000 3.313991 8.781250 @@ -13851,7 +13851,7 @@ Atoms 13835 2 0.000000 1 2.500000 19.516000 7.290779 8.781250 13836 2 0.000000 -1 2.500000 19.516000 7.290779 8.781250 13837 2 0.000000 1 2.500000 12.628000 5.965183 12.293750 -13838 2 0.000000 -1.000000 2.500000 12.628000 5.965183 12.293750 +13838 2 0.000000 -1 2.500000 12.628000 5.965183 12.293750 13839 2 0.000000 1 2.500000 14.924000 1.988394 12.293750 13840 2 0.000000 -1 2.500000 14.924000 1.988394 12.293750 13841 2 0.000000 1 2.500000 17.220000 3.313991 15.806250 @@ -13859,7 +13859,7 @@ Atoms 13843 2 0.000000 1 2.500000 19.516000 7.290779 15.806250 13844 2 0.000000 -1 2.500000 19.516000 7.290779 15.806250 13845 2 0.000000 1 2.500000 12.628000 5.965183 19.318750 -13846 2 0.000000 -1.000000 2.500000 12.628000 5.965183 19.318750 +13846 2 0.000000 -1 2.500000 12.628000 5.965183 19.318750 13847 2 0.000000 1 2.500000 14.924000 1.988394 19.318750 13848 2 0.000000 -1 2.500000 14.924000 1.988394 19.318750 13849 2 0.000000 1 2.500000 17.220000 3.313991 22.831250 @@ -13867,7 +13867,7 @@ Atoms 13851 2 0.000000 1 2.500000 19.516000 7.290779 22.831250 13852 2 0.000000 -1 2.500000 19.516000 7.290779 22.831250 13853 2 0.000000 1 2.500000 12.628000 5.965183 26.343750 -13854 2 0.000000 -1.000000 2.500000 12.628000 5.965183 26.343750 +13854 2 0.000000 -1 2.500000 12.628000 5.965183 26.343750 13855 2 0.000000 1 2.500000 14.924000 1.988394 26.343750 13856 2 0.000000 -1 2.500000 14.924000 1.988394 26.343750 13857 2 0.000000 1 2.500000 17.220000 3.313991 29.856250 @@ -13875,7 +13875,7 @@ Atoms 13859 2 0.000000 1 2.500000 19.516000 7.290779 29.856250 13860 2 0.000000 -1 2.500000 19.516000 7.290779 29.856250 13861 2 0.000000 1 2.500000 12.628000 5.965183 33.368750 -13862 2 0.000000 -1.000000 2.500000 12.628000 5.965183 33.368750 +13862 2 0.000000 -1 2.500000 12.628000 5.965183 33.368750 13863 2 0.000000 1 2.500000 14.924000 1.988394 33.368750 13864 2 0.000000 -1 2.500000 14.924000 1.988394 33.368750 13865 2 0.000000 1 2.500000 17.220000 3.313991 36.881250 @@ -13883,7 +13883,7 @@ Atoms 13867 2 0.000000 1 2.500000 19.516000 7.290779 36.881250 13868 2 0.000000 -1 2.500000 19.516000 7.290779 36.881250 13869 2 0.000000 1 2.500000 12.628000 5.965183 40.393750 -13870 2 0.000000 -1.000000 2.500000 12.628000 5.965183 40.393750 +13870 2 0.000000 -1 2.500000 12.628000 5.965183 40.393750 13871 2 0.000000 1 2.500000 14.924000 1.988394 40.393750 13872 2 0.000000 -1 2.500000 14.924000 1.988394 40.393750 13873 2 0.000000 1 2.500000 17.220000 3.313991 43.906250 @@ -13891,7 +13891,7 @@ Atoms 13875 2 0.000000 1 2.500000 19.516000 7.290779 43.906250 13876 2 0.000000 -1 2.500000 19.516000 7.290779 43.906250 13877 2 0.000000 1 2.500000 12.628000 5.965183 47.418750 -13878 2 0.000000 -1.000000 2.500000 12.628000 5.965183 47.418750 +13878 2 0.000000 -1 2.500000 12.628000 5.965183 47.418750 13879 2 0.000000 1 2.500000 14.924000 1.988394 47.418750 13880 2 0.000000 -1 2.500000 14.924000 1.988394 47.418750 13881 2 0.000000 1 2.500000 17.220000 3.313991 50.931250 @@ -13899,7 +13899,7 @@ Atoms 13883 2 0.000000 1 2.500000 19.516000 7.290779 50.931250 13884 2 0.000000 -1 2.500000 19.516000 7.290779 50.931250 13885 2 0.000000 1 2.500000 12.628000 5.965183 54.443750 -13886 2 0.000000 -1.000000 2.500000 12.628000 5.965183 54.443750 +13886 2 0.000000 -1 2.500000 12.628000 5.965183 54.443750 13887 2 0.000000 1 2.500000 14.924000 1.988394 54.443750 13888 2 0.000000 -1 2.500000 14.924000 1.988394 54.443750 13889 2 0.000000 1 2.500000 17.220000 3.313991 57.956250 @@ -13907,7 +13907,7 @@ Atoms 13891 2 0.000000 1 2.500000 19.516000 7.290779 57.956250 13892 2 0.000000 -1 2.500000 19.516000 7.290779 57.956250 13893 2 0.000000 1 2.500000 12.628000 5.965183 61.468750 -13894 2 0.000000 -1.000000 2.500000 12.628000 5.965183 61.468750 +13894 2 0.000000 -1 2.500000 12.628000 5.965183 61.468750 13895 2 0.000000 1 2.500000 14.924000 1.988394 61.468750 13896 2 0.000000 -1 2.500000 14.924000 1.988394 61.468750 13897 2 0.000000 1 2.500000 17.220000 11.267568 1.756250 @@ -13915,7 +13915,7 @@ Atoms 13899 2 0.000000 1 2.500000 19.516000 15.244357 1.756250 13900 2 0.000000 -1 2.500000 19.516000 15.244357 1.756250 13901 2 0.000000 1 2.500000 12.628000 13.918760 5.268750 -13902 2 0.000000 -1.000000 2.500000 12.628000 13.918760 5.268750 +13902 2 0.000000 -1 2.500000 12.628000 13.918760 5.268750 13903 2 0.000000 1 2.500000 14.924000 9.941972 5.268750 13904 2 0.000000 -1 2.500000 14.924000 9.941972 5.268750 13905 2 0.000000 1 2.500000 17.220000 11.267568 8.781250 @@ -13923,7 +13923,7 @@ Atoms 13907 2 0.000000 1 2.500000 19.516000 15.244357 8.781250 13908 2 0.000000 -1 2.500000 19.516000 15.244357 8.781250 13909 2 0.000000 1 2.500000 12.628000 13.918760 12.293750 -13910 2 0.000000 -1.000000 2.500000 12.628000 13.918760 12.293750 +13910 2 0.000000 -1 2.500000 12.628000 13.918760 12.293750 13911 2 0.000000 1 2.500000 14.924000 9.941972 12.293750 13912 2 0.000000 -1 2.500000 14.924000 9.941972 12.293750 13913 2 0.000000 1 2.500000 17.220000 11.267568 15.806250 @@ -13931,7 +13931,7 @@ Atoms 13915 2 0.000000 1 2.500000 19.516000 15.244357 15.806250 13916 2 0.000000 -1 2.500000 19.516000 15.244357 15.806250 13917 2 0.000000 1 2.500000 12.628000 13.918760 19.318750 -13918 2 0.000000 -1.000000 2.500000 12.628000 13.918760 19.318750 +13918 2 0.000000 -1 2.500000 12.628000 13.918760 19.318750 13919 2 0.000000 1 2.500000 14.924000 9.941972 19.318750 13920 2 0.000000 -1 2.500000 14.924000 9.941972 19.318750 13921 2 0.000000 1 2.500000 17.220000 11.267568 22.831250 @@ -13939,7 +13939,7 @@ Atoms 13923 2 0.000000 1 2.500000 19.516000 15.244357 22.831250 13924 2 0.000000 -1 2.500000 19.516000 15.244357 22.831250 13925 2 0.000000 1 2.500000 12.628000 13.918760 26.343750 -13926 2 0.000000 -1.000000 2.500000 12.628000 13.918760 26.343750 +13926 2 0.000000 -1 2.500000 12.628000 13.918760 26.343750 13927 2 0.000000 1 2.500000 14.924000 9.941972 26.343750 13928 2 0.000000 -1 2.500000 14.924000 9.941972 26.343750 13929 2 0.000000 1 2.500000 17.220000 11.267568 29.856250 @@ -13947,7 +13947,7 @@ Atoms 13931 2 0.000000 1 2.500000 19.516000 15.244357 29.856250 13932 2 0.000000 -1 2.500000 19.516000 15.244357 29.856250 13933 2 0.000000 1 2.500000 12.628000 13.918760 33.368750 -13934 2 0.000000 -1.000000 2.500000 12.628000 13.918760 33.368750 +13934 2 0.000000 -1 2.500000 12.628000 13.918760 33.368750 13935 2 0.000000 1 2.500000 14.924000 9.941972 33.368750 13936 2 0.000000 -1 2.500000 14.924000 9.941972 33.368750 13937 2 0.000000 1 2.500000 17.220000 11.267568 36.881250 @@ -13955,7 +13955,7 @@ Atoms 13939 2 0.000000 1 2.500000 19.516000 15.244357 36.881250 13940 2 0.000000 -1 2.500000 19.516000 15.244357 36.881250 13941 2 0.000000 1 2.500000 12.628000 13.918760 40.393750 -13942 2 0.000000 -1.000000 2.500000 12.628000 13.918760 40.393750 +13942 2 0.000000 -1 2.500000 12.628000 13.918760 40.393750 13943 2 0.000000 1 2.500000 14.924000 9.941972 40.393750 13944 2 0.000000 -1 2.500000 14.924000 9.941972 40.393750 13945 2 0.000000 1 2.500000 17.220000 11.267568 43.906250 @@ -13963,7 +13963,7 @@ Atoms 13947 2 0.000000 1 2.500000 19.516000 15.244357 43.906250 13948 2 0.000000 -1 2.500000 19.516000 15.244357 43.906250 13949 2 0.000000 1 2.500000 12.628000 13.918760 47.418750 -13950 2 0.000000 -1.000000 2.500000 12.628000 13.918760 47.418750 +13950 2 0.000000 -1 2.500000 12.628000 13.918760 47.418750 13951 2 0.000000 1 2.500000 14.924000 9.941972 47.418750 13952 2 0.000000 -1 2.500000 14.924000 9.941972 47.418750 13953 2 0.000000 1 2.500000 17.220000 11.267568 50.931250 @@ -13971,7 +13971,7 @@ Atoms 13955 2 0.000000 1 2.500000 19.516000 15.244357 50.931250 13956 2 0.000000 -1 2.500000 19.516000 15.244357 50.931250 13957 2 0.000000 1 2.500000 12.628000 13.918760 54.443750 -13958 2 0.000000 -1.000000 2.500000 12.628000 13.918760 54.443750 +13958 2 0.000000 -1 2.500000 12.628000 13.918760 54.443750 13959 2 0.000000 1 2.500000 14.924000 9.941972 54.443750 13960 2 0.000000 -1 2.500000 14.924000 9.941972 54.443750 13961 2 0.000000 1 2.500000 17.220000 11.267568 57.956250 @@ -13979,7 +13979,7 @@ Atoms 13963 2 0.000000 1 2.500000 19.516000 15.244357 57.956250 13964 2 0.000000 -1 2.500000 19.516000 15.244357 57.956250 13965 2 0.000000 1 2.500000 12.628000 13.918760 61.468750 -13966 2 0.000000 -1.000000 2.500000 12.628000 13.918760 61.468750 +13966 2 0.000000 -1 2.500000 12.628000 13.918760 61.468750 13967 2 0.000000 1 2.500000 14.924000 9.941972 61.468750 13968 2 0.000000 -1 2.500000 14.924000 9.941972 61.468750 13969 2 0.000000 1 2.500000 17.220000 19.221145 1.756250 @@ -13987,7 +13987,7 @@ Atoms 13971 2 0.000000 1 2.500000 19.516000 23.197934 1.756250 13972 2 0.000000 -1 2.500000 19.516000 23.197934 1.756250 13973 2 0.000000 1 2.500000 12.628000 21.872338 5.268750 -13974 2 0.000000 -1.000000 2.500000 12.628000 21.872338 5.268750 +13974 2 0.000000 -1 2.500000 12.628000 21.872338 5.268750 13975 2 0.000000 1 2.500000 14.924000 17.895549 5.268750 13976 2 0.000000 -1 2.500000 14.924000 17.895549 5.268750 13977 2 0.000000 1 2.500000 17.220000 19.221145 8.781250 @@ -13995,7 +13995,7 @@ Atoms 13979 2 0.000000 1 2.500000 19.516000 23.197934 8.781250 13980 2 0.000000 -1 2.500000 19.516000 23.197934 8.781250 13981 2 0.000000 1 2.500000 12.628000 21.872338 12.293750 -13982 2 0.000000 -1.000000 2.500000 12.628000 21.872338 12.293750 +13982 2 0.000000 -1 2.500000 12.628000 21.872338 12.293750 13983 2 0.000000 1 2.500000 14.924000 17.895549 12.293750 13984 2 0.000000 -1 2.500000 14.924000 17.895549 12.293750 13985 2 0.000000 1 2.500000 17.220000 19.221145 15.806250 @@ -14003,7 +14003,7 @@ Atoms 13987 2 0.000000 1 2.500000 19.516000 23.197934 15.806250 13988 2 0.000000 -1 2.500000 19.516000 23.197934 15.806250 13989 2 0.000000 1 2.500000 12.628000 21.872338 19.318750 -13990 2 0.000000 -1.000000 2.500000 12.628000 21.872338 19.318750 +13990 2 0.000000 -1 2.500000 12.628000 21.872338 19.318750 13991 2 0.000000 1 2.500000 14.924000 17.895549 19.318750 13992 2 0.000000 -1 2.500000 14.924000 17.895549 19.318750 13993 2 0.000000 1 2.500000 17.220000 19.221145 22.831250 @@ -14011,7 +14011,7 @@ Atoms 13995 2 0.000000 1 2.500000 19.516000 23.197934 22.831250 13996 2 0.000000 -1 2.500000 19.516000 23.197934 22.831250 13997 2 0.000000 1 2.500000 12.628000 21.872338 26.343750 -13998 2 0.000000 -1.000000 2.500000 12.628000 21.872338 26.343750 +13998 2 0.000000 -1 2.500000 12.628000 21.872338 26.343750 13999 2 0.000000 1 2.500000 14.924000 17.895549 26.343750 14000 2 0.000000 -1 2.500000 14.924000 17.895549 26.343750 14001 2 0.000000 1 2.500000 17.220000 19.221145 29.856250 @@ -14019,7 +14019,7 @@ Atoms 14003 2 0.000000 1 2.500000 19.516000 23.197934 29.856250 14004 2 0.000000 -1 2.500000 19.516000 23.197934 29.856250 14005 2 0.000000 1 2.500000 12.628000 21.872338 33.368750 -14006 2 0.000000 -1.000000 2.500000 12.628000 21.872338 33.368750 +14006 2 0.000000 -1 2.500000 12.628000 21.872338 33.368750 14007 2 0.000000 1 2.500000 14.924000 17.895549 33.368750 14008 2 0.000000 -1 2.500000 14.924000 17.895549 33.368750 14009 2 0.000000 1 2.500000 17.220000 19.221145 36.881250 @@ -14027,7 +14027,7 @@ Atoms 14011 2 0.000000 1 2.500000 19.516000 23.197934 36.881250 14012 2 0.000000 -1 2.500000 19.516000 23.197934 36.881250 14013 2 0.000000 1 2.500000 12.628000 21.872338 40.393750 -14014 2 0.000000 -1.000000 2.500000 12.628000 21.872338 40.393750 +14014 2 0.000000 -1 2.500000 12.628000 21.872338 40.393750 14015 2 0.000000 1 2.500000 14.924000 17.895549 40.393750 14016 2 0.000000 -1 2.500000 14.924000 17.895549 40.393750 14017 2 0.000000 1 2.500000 17.220000 19.221145 43.906250 @@ -14035,7 +14035,7 @@ Atoms 14019 2 0.000000 1 2.500000 19.516000 23.197934 43.906250 14020 2 0.000000 -1 2.500000 19.516000 23.197934 43.906250 14021 2 0.000000 1 2.500000 12.628000 21.872338 47.418750 -14022 2 0.000000 -1.000000 2.500000 12.628000 21.872338 47.418750 +14022 2 0.000000 -1 2.500000 12.628000 21.872338 47.418750 14023 2 0.000000 1 2.500000 14.924000 17.895549 47.418750 14024 2 0.000000 -1 2.500000 14.924000 17.895549 47.418750 14025 2 0.000000 1 2.500000 17.220000 19.221145 50.931250 @@ -14043,7 +14043,7 @@ Atoms 14027 2 0.000000 1 2.500000 19.516000 23.197934 50.931250 14028 2 0.000000 -1 2.500000 19.516000 23.197934 50.931250 14029 2 0.000000 1 2.500000 12.628000 21.872338 54.443750 -14030 2 0.000000 -1.000000 2.500000 12.628000 21.872338 54.443750 +14030 2 0.000000 -1 2.500000 12.628000 21.872338 54.443750 14031 2 0.000000 1 2.500000 14.924000 17.895549 54.443750 14032 2 0.000000 -1 2.500000 14.924000 17.895549 54.443750 14033 2 0.000000 1 2.500000 17.220000 19.221145 57.956250 @@ -14051,7 +14051,7 @@ Atoms 14035 2 0.000000 1 2.500000 19.516000 23.197934 57.956250 14036 2 0.000000 -1 2.500000 19.516000 23.197934 57.956250 14037 2 0.000000 1 2.500000 12.628000 21.872338 61.468750 -14038 2 0.000000 -1.000000 2.500000 12.628000 21.872338 61.468750 +14038 2 0.000000 -1 2.500000 12.628000 21.872338 61.468750 14039 2 0.000000 1 2.500000 14.924000 17.895549 61.468750 14040 2 0.000000 -1 2.500000 14.924000 17.895549 61.468750 14041 2 0.000000 1 2.500000 17.220000 27.174722 1.756250 @@ -14059,7 +14059,7 @@ Atoms 14043 2 0.000000 1 2.500000 19.516000 31.151511 1.756250 14044 2 0.000000 -1 2.500000 19.516000 31.151511 1.756250 14045 2 0.000000 1 2.500000 12.628000 29.825915 5.268750 -14046 2 0.000000 -1.000000 2.500000 12.628000 29.825915 5.268750 +14046 2 0.000000 -1 2.500000 12.628000 29.825915 5.268750 14047 2 0.000000 1 2.500000 14.924000 25.849126 5.268750 14048 2 0.000000 -1 2.500000 14.924000 25.849126 5.268750 14049 2 0.000000 1 2.500000 17.220000 27.174722 8.781250 @@ -14067,7 +14067,7 @@ Atoms 14051 2 0.000000 1 2.500000 19.516000 31.151511 8.781250 14052 2 0.000000 -1 2.500000 19.516000 31.151511 8.781250 14053 2 0.000000 1 2.500000 12.628000 29.825915 12.293750 -14054 2 0.000000 -1.000000 2.500000 12.628000 29.825915 12.293750 +14054 2 0.000000 -1 2.500000 12.628000 29.825915 12.293750 14055 2 0.000000 1 2.500000 14.924000 25.849126 12.293750 14056 2 0.000000 -1 2.500000 14.924000 25.849126 12.293750 14057 2 0.000000 1 2.500000 17.220000 27.174722 15.806250 @@ -14075,7 +14075,7 @@ Atoms 14059 2 0.000000 1 2.500000 19.516000 31.151511 15.806250 14060 2 0.000000 -1 2.500000 19.516000 31.151511 15.806250 14061 2 0.000000 1 2.500000 12.628000 29.825915 19.318750 -14062 2 0.000000 -1.000000 2.500000 12.628000 29.825915 19.318750 +14062 2 0.000000 -1 2.500000 12.628000 29.825915 19.318750 14063 2 0.000000 1 2.500000 14.924000 25.849126 19.318750 14064 2 0.000000 -1 2.500000 14.924000 25.849126 19.318750 14065 2 0.000000 1 2.500000 17.220000 27.174722 22.831250 @@ -14083,7 +14083,7 @@ Atoms 14067 2 0.000000 1 2.500000 19.516000 31.151511 22.831250 14068 2 0.000000 -1 2.500000 19.516000 31.151511 22.831250 14069 2 0.000000 1 2.500000 12.628000 29.825915 26.343750 -14070 2 0.000000 -1.000000 2.500000 12.628000 29.825915 26.343750 +14070 2 0.000000 -1 2.500000 12.628000 29.825915 26.343750 14071 2 0.000000 1 2.500000 14.924000 25.849126 26.343750 14072 2 0.000000 -1 2.500000 14.924000 25.849126 26.343750 14073 2 0.000000 1 2.500000 17.220000 27.174722 29.856250 @@ -14091,7 +14091,7 @@ Atoms 14075 2 0.000000 1 2.500000 19.516000 31.151511 29.856250 14076 2 0.000000 -1 2.500000 19.516000 31.151511 29.856250 14077 2 0.000000 1 2.500000 12.628000 29.825915 33.368750 -14078 2 0.000000 -1.000000 2.500000 12.628000 29.825915 33.368750 +14078 2 0.000000 -1 2.500000 12.628000 29.825915 33.368750 14079 2 0.000000 1 2.500000 14.924000 25.849126 33.368750 14080 2 0.000000 -1 2.500000 14.924000 25.849126 33.368750 14081 2 0.000000 1 2.500000 17.220000 27.174722 36.881250 @@ -14099,7 +14099,7 @@ Atoms 14083 2 0.000000 1 2.500000 19.516000 31.151511 36.881250 14084 2 0.000000 -1 2.500000 19.516000 31.151511 36.881250 14085 2 0.000000 1 2.500000 12.628000 29.825915 40.393750 -14086 2 0.000000 -1.000000 2.500000 12.628000 29.825915 40.393750 +14086 2 0.000000 -1 2.500000 12.628000 29.825915 40.393750 14087 2 0.000000 1 2.500000 14.924000 25.849126 40.393750 14088 2 0.000000 -1 2.500000 14.924000 25.849126 40.393750 14089 2 0.000000 1 2.500000 17.220000 27.174722 43.906250 @@ -14107,7 +14107,7 @@ Atoms 14091 2 0.000000 1 2.500000 19.516000 31.151511 43.906250 14092 2 0.000000 -1 2.500000 19.516000 31.151511 43.906250 14093 2 0.000000 1 2.500000 12.628000 29.825915 47.418750 -14094 2 0.000000 -1.000000 2.500000 12.628000 29.825915 47.418750 +14094 2 0.000000 -1 2.500000 12.628000 29.825915 47.418750 14095 2 0.000000 1 2.500000 14.924000 25.849126 47.418750 14096 2 0.000000 -1 2.500000 14.924000 25.849126 47.418750 14097 2 0.000000 1 2.500000 17.220000 27.174722 50.931250 @@ -14115,7 +14115,7 @@ Atoms 14099 2 0.000000 1 2.500000 19.516000 31.151511 50.931250 14100 2 0.000000 -1 2.500000 19.516000 31.151511 50.931250 14101 2 0.000000 1 2.500000 12.628000 29.825915 54.443750 -14102 2 0.000000 -1.000000 2.500000 12.628000 29.825915 54.443750 +14102 2 0.000000 -1 2.500000 12.628000 29.825915 54.443750 14103 2 0.000000 1 2.500000 14.924000 25.849126 54.443750 14104 2 0.000000 -1 2.500000 14.924000 25.849126 54.443750 14105 2 0.000000 1 2.500000 17.220000 27.174722 57.956250 @@ -14123,7 +14123,7 @@ Atoms 14107 2 0.000000 1 2.500000 19.516000 31.151511 57.956250 14108 2 0.000000 -1 2.500000 19.516000 31.151511 57.956250 14109 2 0.000000 1 2.500000 12.628000 29.825915 61.468750 -14110 2 0.000000 -1.000000 2.500000 12.628000 29.825915 61.468750 +14110 2 0.000000 -1 2.500000 12.628000 29.825915 61.468750 14111 2 0.000000 1 2.500000 14.924000 25.849126 61.468750 14112 2 0.000000 -1 2.500000 14.924000 25.849126 61.468750 14113 2 0.000000 1 2.500000 17.220000 35.128300 1.756250 @@ -14131,7 +14131,7 @@ Atoms 14115 2 0.000000 1 2.500000 19.516000 39.105088 1.756250 14116 2 0.000000 -1 2.500000 19.516000 39.105088 1.756250 14117 2 0.000000 1 2.500000 12.628000 37.779492 5.268750 -14118 2 0.000000 -1.000000 2.500000 12.628000 37.779492 5.268750 +14118 2 0.000000 -1 2.500000 12.628000 37.779492 5.268750 14119 2 0.000000 1 2.500000 14.924000 33.802704 5.268750 14120 2 0.000000 -1 2.500000 14.924000 33.802704 5.268750 14121 2 0.000000 1 2.500000 17.220000 35.128300 8.781250 @@ -14139,7 +14139,7 @@ Atoms 14123 2 0.000000 1 2.500000 19.516000 39.105088 8.781250 14124 2 0.000000 -1 2.500000 19.516000 39.105088 8.781250 14125 2 0.000000 1 2.500000 12.628000 37.779492 12.293750 -14126 2 0.000000 -1.000000 2.500000 12.628000 37.779492 12.293750 +14126 2 0.000000 -1 2.500000 12.628000 37.779492 12.293750 14127 2 0.000000 1 2.500000 14.924000 33.802704 12.293750 14128 2 0.000000 -1 2.500000 14.924000 33.802704 12.293750 14129 2 0.000000 1 2.500000 17.220000 35.128300 15.806250 @@ -14147,7 +14147,7 @@ Atoms 14131 2 0.000000 1 2.500000 19.516000 39.105088 15.806250 14132 2 0.000000 -1 2.500000 19.516000 39.105088 15.806250 14133 2 0.000000 1 2.500000 12.628000 37.779492 19.318750 -14134 2 0.000000 -1.000000 2.500000 12.628000 37.779492 19.318750 +14134 2 0.000000 -1 2.500000 12.628000 37.779492 19.318750 14135 2 0.000000 1 2.500000 14.924000 33.802704 19.318750 14136 2 0.000000 -1 2.500000 14.924000 33.802704 19.318750 14137 2 0.000000 1 2.500000 17.220000 35.128300 22.831250 @@ -14155,7 +14155,7 @@ Atoms 14139 2 0.000000 1 2.500000 19.516000 39.105088 22.831250 14140 2 0.000000 -1 2.500000 19.516000 39.105088 22.831250 14141 2 0.000000 1 2.500000 12.628000 37.779492 26.343750 -14142 2 0.000000 -1.000000 2.500000 12.628000 37.779492 26.343750 +14142 2 0.000000 -1 2.500000 12.628000 37.779492 26.343750 14143 2 0.000000 1 2.500000 14.924000 33.802704 26.343750 14144 2 0.000000 -1 2.500000 14.924000 33.802704 26.343750 14145 2 0.000000 1 2.500000 17.220000 35.128300 29.856250 @@ -14163,7 +14163,7 @@ Atoms 14147 2 0.000000 1 2.500000 19.516000 39.105088 29.856250 14148 2 0.000000 -1 2.500000 19.516000 39.105088 29.856250 14149 2 0.000000 1 2.500000 12.628000 37.779492 33.368750 -14150 2 0.000000 -1.000000 2.500000 12.628000 37.779492 33.368750 +14150 2 0.000000 -1 2.500000 12.628000 37.779492 33.368750 14151 2 0.000000 1 2.500000 14.924000 33.802704 33.368750 14152 2 0.000000 -1 2.500000 14.924000 33.802704 33.368750 14153 2 0.000000 1 2.500000 17.220000 35.128300 36.881250 @@ -14171,7 +14171,7 @@ Atoms 14155 2 0.000000 1 2.500000 19.516000 39.105088 36.881250 14156 2 0.000000 -1 2.500000 19.516000 39.105088 36.881250 14157 2 0.000000 1 2.500000 12.628000 37.779492 40.393750 -14158 2 0.000000 -1.000000 2.500000 12.628000 37.779492 40.393750 +14158 2 0.000000 -1 2.500000 12.628000 37.779492 40.393750 14159 2 0.000000 1 2.500000 14.924000 33.802704 40.393750 14160 2 0.000000 -1 2.500000 14.924000 33.802704 40.393750 14161 2 0.000000 1 2.500000 17.220000 35.128300 43.906250 @@ -14179,7 +14179,7 @@ Atoms 14163 2 0.000000 1 2.500000 19.516000 39.105088 43.906250 14164 2 0.000000 -1 2.500000 19.516000 39.105088 43.906250 14165 2 0.000000 1 2.500000 12.628000 37.779492 47.418750 -14166 2 0.000000 -1.000000 2.500000 12.628000 37.779492 47.418750 +14166 2 0.000000 -1 2.500000 12.628000 37.779492 47.418750 14167 2 0.000000 1 2.500000 14.924000 33.802704 47.418750 14168 2 0.000000 -1 2.500000 14.924000 33.802704 47.418750 14169 2 0.000000 1 2.500000 17.220000 35.128300 50.931250 @@ -14187,7 +14187,7 @@ Atoms 14171 2 0.000000 1 2.500000 19.516000 39.105088 50.931250 14172 2 0.000000 -1 2.500000 19.516000 39.105088 50.931250 14173 2 0.000000 1 2.500000 12.628000 37.779492 54.443750 -14174 2 0.000000 -1.000000 2.500000 12.628000 37.779492 54.443750 +14174 2 0.000000 -1 2.500000 12.628000 37.779492 54.443750 14175 2 0.000000 1 2.500000 14.924000 33.802704 54.443750 14176 2 0.000000 -1 2.500000 14.924000 33.802704 54.443750 14177 2 0.000000 1 2.500000 17.220000 35.128300 57.956250 @@ -14195,7 +14195,7 @@ Atoms 14179 2 0.000000 1 2.500000 19.516000 39.105088 57.956250 14180 2 0.000000 -1 2.500000 19.516000 39.105088 57.956250 14181 2 0.000000 1 2.500000 12.628000 37.779492 61.468750 -14182 2 0.000000 -1.000000 2.500000 12.628000 37.779492 61.468750 +14182 2 0.000000 -1 2.500000 12.628000 37.779492 61.468750 14183 2 0.000000 1 2.500000 14.924000 33.802704 61.468750 14184 2 0.000000 -1 2.500000 14.924000 33.802704 61.468750 14185 2 0.000000 1 2.500000 17.220000 43.081877 1.756250 @@ -14203,7 +14203,7 @@ Atoms 14187 2 0.000000 1 2.500000 19.516000 47.058666 1.756250 14188 2 0.000000 -1 2.500000 19.516000 47.058666 1.756250 14189 2 0.000000 1 2.500000 12.628000 45.733070 5.268750 -14190 2 0.000000 -1.000000 2.500000 12.628000 45.733070 5.268750 +14190 2 0.000000 -1 2.500000 12.628000 45.733070 5.268750 14191 2 0.000000 1 2.500000 14.924000 41.756281 5.268750 14192 2 0.000000 -1 2.500000 14.924000 41.756281 5.268750 14193 2 0.000000 1 2.500000 17.220000 43.081877 8.781250 @@ -14211,7 +14211,7 @@ Atoms 14195 2 0.000000 1 2.500000 19.516000 47.058666 8.781250 14196 2 0.000000 -1 2.500000 19.516000 47.058666 8.781250 14197 2 0.000000 1 2.500000 12.628000 45.733070 12.293750 -14198 2 0.000000 -1.000000 2.500000 12.628000 45.733070 12.293750 +14198 2 0.000000 -1 2.500000 12.628000 45.733070 12.293750 14199 2 0.000000 1 2.500000 14.924000 41.756281 12.293750 14200 2 0.000000 -1 2.500000 14.924000 41.756281 12.293750 14201 2 0.000000 1 2.500000 17.220000 43.081877 15.806250 @@ -14219,7 +14219,7 @@ Atoms 14203 2 0.000000 1 2.500000 19.516000 47.058666 15.806250 14204 2 0.000000 -1 2.500000 19.516000 47.058666 15.806250 14205 2 0.000000 1 2.500000 12.628000 45.733070 19.318750 -14206 2 0.000000 -1.000000 2.500000 12.628000 45.733070 19.318750 +14206 2 0.000000 -1 2.500000 12.628000 45.733070 19.318750 14207 2 0.000000 1 2.500000 14.924000 41.756281 19.318750 14208 2 0.000000 -1 2.500000 14.924000 41.756281 19.318750 14209 2 0.000000 1 2.500000 17.220000 43.081877 22.831250 @@ -14227,7 +14227,7 @@ Atoms 14211 2 0.000000 1 2.500000 19.516000 47.058666 22.831250 14212 2 0.000000 -1 2.500000 19.516000 47.058666 22.831250 14213 2 0.000000 1 2.500000 12.628000 45.733070 26.343750 -14214 2 0.000000 -1.000000 2.500000 12.628000 45.733070 26.343750 +14214 2 0.000000 -1 2.500000 12.628000 45.733070 26.343750 14215 2 0.000000 1 2.500000 14.924000 41.756281 26.343750 14216 2 0.000000 -1 2.500000 14.924000 41.756281 26.343750 14217 2 0.000000 1 2.500000 17.220000 43.081877 29.856250 @@ -14235,7 +14235,7 @@ Atoms 14219 2 0.000000 1 2.500000 19.516000 47.058666 29.856250 14220 2 0.000000 -1 2.500000 19.516000 47.058666 29.856250 14221 2 0.000000 1 2.500000 12.628000 45.733070 33.368750 -14222 2 0.000000 -1.000000 2.500000 12.628000 45.733070 33.368750 +14222 2 0.000000 -1 2.500000 12.628000 45.733070 33.368750 14223 2 0.000000 1 2.500000 14.924000 41.756281 33.368750 14224 2 0.000000 -1 2.500000 14.924000 41.756281 33.368750 14225 2 0.000000 1 2.500000 17.220000 43.081877 36.881250 @@ -14243,7 +14243,7 @@ Atoms 14227 2 0.000000 1 2.500000 19.516000 47.058666 36.881250 14228 2 0.000000 -1 2.500000 19.516000 47.058666 36.881250 14229 2 0.000000 1 2.500000 12.628000 45.733070 40.393750 -14230 2 0.000000 -1.000000 2.500000 12.628000 45.733070 40.393750 +14230 2 0.000000 -1 2.500000 12.628000 45.733070 40.393750 14231 2 0.000000 1 2.500000 14.924000 41.756281 40.393750 14232 2 0.000000 -1 2.500000 14.924000 41.756281 40.393750 14233 2 0.000000 1 2.500000 17.220000 43.081877 43.906250 @@ -14251,7 +14251,7 @@ Atoms 14235 2 0.000000 1 2.500000 19.516000 47.058666 43.906250 14236 2 0.000000 -1 2.500000 19.516000 47.058666 43.906250 14237 2 0.000000 1 2.500000 12.628000 45.733070 47.418750 -14238 2 0.000000 -1.000000 2.500000 12.628000 45.733070 47.418750 +14238 2 0.000000 -1 2.500000 12.628000 45.733070 47.418750 14239 2 0.000000 1 2.500000 14.924000 41.756281 47.418750 14240 2 0.000000 -1 2.500000 14.924000 41.756281 47.418750 14241 2 0.000000 1 2.500000 17.220000 43.081877 50.931250 @@ -14259,7 +14259,7 @@ Atoms 14243 2 0.000000 1 2.500000 19.516000 47.058666 50.931250 14244 2 0.000000 -1 2.500000 19.516000 47.058666 50.931250 14245 2 0.000000 1 2.500000 12.628000 45.733070 54.443750 -14246 2 0.000000 -1.000000 2.500000 12.628000 45.733070 54.443750 +14246 2 0.000000 -1 2.500000 12.628000 45.733070 54.443750 14247 2 0.000000 1 2.500000 14.924000 41.756281 54.443750 14248 2 0.000000 -1 2.500000 14.924000 41.756281 54.443750 14249 2 0.000000 1 2.500000 17.220000 43.081877 57.956250 @@ -14267,7 +14267,7 @@ Atoms 14251 2 0.000000 1 2.500000 19.516000 47.058666 57.956250 14252 2 0.000000 -1 2.500000 19.516000 47.058666 57.956250 14253 2 0.000000 1 2.500000 12.628000 45.733070 61.468750 -14254 2 0.000000 -1.000000 2.500000 12.628000 45.733070 61.468750 +14254 2 0.000000 -1 2.500000 12.628000 45.733070 61.468750 14255 2 0.000000 1 2.500000 14.924000 41.756281 61.468750 14256 2 0.000000 -1 2.500000 14.924000 41.756281 61.468750 14257 2 0.000000 1 2.500000 17.220000 51.035454 1.756250 @@ -14275,7 +14275,7 @@ Atoms 14259 2 0.000000 1 2.500000 19.516000 55.012243 1.756250 14260 2 0.000000 -1 2.500000 19.516000 55.012243 1.756250 14261 2 0.000000 1 2.500000 12.628000 53.686647 5.268750 -14262 2 0.000000 -1.000000 2.500000 12.628000 53.686647 5.268750 +14262 2 0.000000 -1 2.500000 12.628000 53.686647 5.268750 14263 2 0.000000 1 2.500000 14.924000 49.709858 5.268750 14264 2 0.000000 -1 2.500000 14.924000 49.709858 5.268750 14265 2 0.000000 1 2.500000 17.220000 51.035454 8.781250 @@ -14283,7 +14283,7 @@ Atoms 14267 2 0.000000 1 2.500000 19.516000 55.012243 8.781250 14268 2 0.000000 -1 2.500000 19.516000 55.012243 8.781250 14269 2 0.000000 1 2.500000 12.628000 53.686647 12.293750 -14270 2 0.000000 -1.000000 2.500000 12.628000 53.686647 12.293750 +14270 2 0.000000 -1 2.500000 12.628000 53.686647 12.293750 14271 2 0.000000 1 2.500000 14.924000 49.709858 12.293750 14272 2 0.000000 -1 2.500000 14.924000 49.709858 12.293750 14273 2 0.000000 1 2.500000 17.220000 51.035454 15.806250 @@ -14291,7 +14291,7 @@ Atoms 14275 2 0.000000 1 2.500000 19.516000 55.012243 15.806250 14276 2 0.000000 -1 2.500000 19.516000 55.012243 15.806250 14277 2 0.000000 1 2.500000 12.628000 53.686647 19.318750 -14278 2 0.000000 -1.000000 2.500000 12.628000 53.686647 19.318750 +14278 2 0.000000 -1 2.500000 12.628000 53.686647 19.318750 14279 2 0.000000 1 2.500000 14.924000 49.709858 19.318750 14280 2 0.000000 -1 2.500000 14.924000 49.709858 19.318750 14281 2 0.000000 1 2.500000 17.220000 51.035454 22.831250 @@ -14299,7 +14299,7 @@ Atoms 14283 2 0.000000 1 2.500000 19.516000 55.012243 22.831250 14284 2 0.000000 -1 2.500000 19.516000 55.012243 22.831250 14285 2 0.000000 1 2.500000 12.628000 53.686647 26.343750 -14286 2 0.000000 -1.000000 2.500000 12.628000 53.686647 26.343750 +14286 2 0.000000 -1 2.500000 12.628000 53.686647 26.343750 14287 2 0.000000 1 2.500000 14.924000 49.709858 26.343750 14288 2 0.000000 -1 2.500000 14.924000 49.709858 26.343750 14289 2 0.000000 1 2.500000 17.220000 51.035454 29.856250 @@ -14307,7 +14307,7 @@ Atoms 14291 2 0.000000 1 2.500000 19.516000 55.012243 29.856250 14292 2 0.000000 -1 2.500000 19.516000 55.012243 29.856250 14293 2 0.000000 1 2.500000 12.628000 53.686647 33.368750 -14294 2 0.000000 -1.000000 2.500000 12.628000 53.686647 33.368750 +14294 2 0.000000 -1 2.500000 12.628000 53.686647 33.368750 14295 2 0.000000 1 2.500000 14.924000 49.709858 33.368750 14296 2 0.000000 -1 2.500000 14.924000 49.709858 33.368750 14297 2 0.000000 1 2.500000 17.220000 51.035454 36.881250 @@ -14315,7 +14315,7 @@ Atoms 14299 2 0.000000 1 2.500000 19.516000 55.012243 36.881250 14300 2 0.000000 -1 2.500000 19.516000 55.012243 36.881250 14301 2 0.000000 1 2.500000 12.628000 53.686647 40.393750 -14302 2 0.000000 -1.000000 2.500000 12.628000 53.686647 40.393750 +14302 2 0.000000 -1 2.500000 12.628000 53.686647 40.393750 14303 2 0.000000 1 2.500000 14.924000 49.709858 40.393750 14304 2 0.000000 -1 2.500000 14.924000 49.709858 40.393750 14305 2 0.000000 1 2.500000 17.220000 51.035454 43.906250 @@ -14323,7 +14323,7 @@ Atoms 14307 2 0.000000 1 2.500000 19.516000 55.012243 43.906250 14308 2 0.000000 -1 2.500000 19.516000 55.012243 43.906250 14309 2 0.000000 1 2.500000 12.628000 53.686647 47.418750 -14310 2 0.000000 -1.000000 2.500000 12.628000 53.686647 47.418750 +14310 2 0.000000 -1 2.500000 12.628000 53.686647 47.418750 14311 2 0.000000 1 2.500000 14.924000 49.709858 47.418750 14312 2 0.000000 -1 2.500000 14.924000 49.709858 47.418750 14313 2 0.000000 1 2.500000 17.220000 51.035454 50.931250 @@ -14331,7 +14331,7 @@ Atoms 14315 2 0.000000 1 2.500000 19.516000 55.012243 50.931250 14316 2 0.000000 -1 2.500000 19.516000 55.012243 50.931250 14317 2 0.000000 1 2.500000 12.628000 53.686647 54.443750 -14318 2 0.000000 -1.000000 2.500000 12.628000 53.686647 54.443750 +14318 2 0.000000 -1 2.500000 12.628000 53.686647 54.443750 14319 2 0.000000 1 2.500000 14.924000 49.709858 54.443750 14320 2 0.000000 -1 2.500000 14.924000 49.709858 54.443750 14321 2 0.000000 1 2.500000 17.220000 51.035454 57.956250 @@ -14339,7 +14339,7 @@ Atoms 14323 2 0.000000 1 2.500000 19.516000 55.012243 57.956250 14324 2 0.000000 -1 2.500000 19.516000 55.012243 57.956250 14325 2 0.000000 1 2.500000 12.628000 53.686647 61.468750 -14326 2 0.000000 -1.000000 2.500000 12.628000 53.686647 61.468750 +14326 2 0.000000 -1 2.500000 12.628000 53.686647 61.468750 14327 2 0.000000 1 2.500000 14.924000 49.709858 61.468750 14328 2 0.000000 -1 2.500000 14.924000 49.709858 61.468750 14329 2 0.000000 1 2.500000 17.220000 58.989032 1.756250 @@ -14347,7 +14347,7 @@ Atoms 14331 2 0.000000 1 2.500000 19.516000 62.965820 1.756250 14332 2 0.000000 -1 2.500000 19.516000 62.965820 1.756250 14333 2 0.000000 1 2.500000 12.628000 61.640224 5.268750 -14334 2 0.000000 -1.000000 2.500000 12.628000 61.640224 5.268750 +14334 2 0.000000 -1 2.500000 12.628000 61.640224 5.268750 14335 2 0.000000 1 2.500000 14.924000 57.663435 5.268750 14336 2 0.000000 -1 2.500000 14.924000 57.663435 5.268750 14337 2 0.000000 1 2.500000 17.220000 58.989032 8.781250 @@ -14355,7 +14355,7 @@ Atoms 14339 2 0.000000 1 2.500000 19.516000 62.965820 8.781250 14340 2 0.000000 -1 2.500000 19.516000 62.965820 8.781250 14341 2 0.000000 1 2.500000 12.628000 61.640224 12.293750 -14342 2 0.000000 -1.000000 2.500000 12.628000 61.640224 12.293750 +14342 2 0.000000 -1 2.500000 12.628000 61.640224 12.293750 14343 2 0.000000 1 2.500000 14.924000 57.663435 12.293750 14344 2 0.000000 -1 2.500000 14.924000 57.663435 12.293750 14345 2 0.000000 1 2.500000 17.220000 58.989032 15.806250 @@ -14363,7 +14363,7 @@ Atoms 14347 2 0.000000 1 2.500000 19.516000 62.965820 15.806250 14348 2 0.000000 -1 2.500000 19.516000 62.965820 15.806250 14349 2 0.000000 1 2.500000 12.628000 61.640224 19.318750 -14350 2 0.000000 -1.000000 2.500000 12.628000 61.640224 19.318750 +14350 2 0.000000 -1 2.500000 12.628000 61.640224 19.318750 14351 2 0.000000 1 2.500000 14.924000 57.663435 19.318750 14352 2 0.000000 -1 2.500000 14.924000 57.663435 19.318750 14353 2 0.000000 1 2.500000 17.220000 58.989032 22.831250 @@ -14371,7 +14371,7 @@ Atoms 14355 2 0.000000 1 2.500000 19.516000 62.965820 22.831250 14356 2 0.000000 -1 2.500000 19.516000 62.965820 22.831250 14357 2 0.000000 1 2.500000 12.628000 61.640224 26.343750 -14358 2 0.000000 -1.000000 2.500000 12.628000 61.640224 26.343750 +14358 2 0.000000 -1 2.500000 12.628000 61.640224 26.343750 14359 2 0.000000 1 2.500000 14.924000 57.663435 26.343750 14360 2 0.000000 -1 2.500000 14.924000 57.663435 26.343750 14361 2 0.000000 1 2.500000 17.220000 58.989032 29.856250 @@ -14379,7 +14379,7 @@ Atoms 14363 2 0.000000 1 2.500000 19.516000 62.965820 29.856250 14364 2 0.000000 -1 2.500000 19.516000 62.965820 29.856250 14365 2 0.000000 1 2.500000 12.628000 61.640224 33.368750 -14366 2 0.000000 -1.000000 2.500000 12.628000 61.640224 33.368750 +14366 2 0.000000 -1 2.500000 12.628000 61.640224 33.368750 14367 2 0.000000 1 2.500000 14.924000 57.663435 33.368750 14368 2 0.000000 -1 2.500000 14.924000 57.663435 33.368750 14369 2 0.000000 1 2.500000 17.220000 58.989032 36.881250 @@ -14387,7 +14387,7 @@ Atoms 14371 2 0.000000 1 2.500000 19.516000 62.965820 36.881250 14372 2 0.000000 -1 2.500000 19.516000 62.965820 36.881250 14373 2 0.000000 1 2.500000 12.628000 61.640224 40.393750 -14374 2 0.000000 -1.000000 2.500000 12.628000 61.640224 40.393750 +14374 2 0.000000 -1 2.500000 12.628000 61.640224 40.393750 14375 2 0.000000 1 2.500000 14.924000 57.663435 40.393750 14376 2 0.000000 -1 2.500000 14.924000 57.663435 40.393750 14377 2 0.000000 1 2.500000 17.220000 58.989032 43.906250 @@ -14395,7 +14395,7 @@ Atoms 14379 2 0.000000 1 2.500000 19.516000 62.965820 43.906250 14380 2 0.000000 -1 2.500000 19.516000 62.965820 43.906250 14381 2 0.000000 1 2.500000 12.628000 61.640224 47.418750 -14382 2 0.000000 -1.000000 2.500000 12.628000 61.640224 47.418750 +14382 2 0.000000 -1 2.500000 12.628000 61.640224 47.418750 14383 2 0.000000 1 2.500000 14.924000 57.663435 47.418750 14384 2 0.000000 -1 2.500000 14.924000 57.663435 47.418750 14385 2 0.000000 1 2.500000 17.220000 58.989032 50.931250 @@ -14403,7 +14403,7 @@ Atoms 14387 2 0.000000 1 2.500000 19.516000 62.965820 50.931250 14388 2 0.000000 -1 2.500000 19.516000 62.965820 50.931250 14389 2 0.000000 1 2.500000 12.628000 61.640224 54.443750 -14390 2 0.000000 -1.000000 2.500000 12.628000 61.640224 54.443750 +14390 2 0.000000 -1 2.500000 12.628000 61.640224 54.443750 14391 2 0.000000 1 2.500000 14.924000 57.663435 54.443750 14392 2 0.000000 -1 2.500000 14.924000 57.663435 54.443750 14393 2 0.000000 1 2.500000 17.220000 58.989032 57.956250 @@ -14411,7 +14411,7 @@ Atoms 14395 2 0.000000 1 2.500000 19.516000 62.965820 57.956250 14396 2 0.000000 -1 2.500000 19.516000 62.965820 57.956250 14397 2 0.000000 1 2.500000 12.628000 61.640224 61.468750 -14398 2 0.000000 -1.000000 2.500000 12.628000 61.640224 61.468750 +14398 2 0.000000 -1 2.500000 12.628000 61.640224 61.468750 14399 2 0.000000 1 2.500000 14.924000 57.663435 61.468750 14400 2 0.000000 -1 2.500000 14.924000 57.663435 61.468750 14401 2 0.000000 1 2.500000 21.812000 3.313991 1.756250 @@ -14419,7 +14419,7 @@ Atoms 14403 2 0.000000 1 2.500000 24.108000 7.290779 1.756250 14404 2 0.000000 -1 2.500000 24.108000 7.290779 1.756250 14405 2 0.000000 1 2.500000 17.220000 5.965183 5.268750 -14406 2 0.000000 -1.000000 2.500000 17.220000 5.965183 5.268750 +14406 2 0.000000 -1 2.500000 17.220000 5.965183 5.268750 14407 2 0.000000 1 2.500000 19.516000 1.988394 5.268750 14408 2 0.000000 -1 2.500000 19.516000 1.988394 5.268750 14409 2 0.000000 1 2.500000 21.812000 3.313991 8.781250 @@ -14427,7 +14427,7 @@ Atoms 14411 2 0.000000 1 2.500000 24.108000 7.290779 8.781250 14412 2 0.000000 -1 2.500000 24.108000 7.290779 8.781250 14413 2 0.000000 1 2.500000 17.220000 5.965183 12.293750 -14414 2 0.000000 -1.000000 2.500000 17.220000 5.965183 12.293750 +14414 2 0.000000 -1 2.500000 17.220000 5.965183 12.293750 14415 2 0.000000 1 2.500000 19.516000 1.988394 12.293750 14416 2 0.000000 -1 2.500000 19.516000 1.988394 12.293750 14417 2 0.000000 1 2.500000 21.812000 3.313991 15.806250 @@ -14435,7 +14435,7 @@ Atoms 14419 2 0.000000 1 2.500000 24.108000 7.290779 15.806250 14420 2 0.000000 -1 2.500000 24.108000 7.290779 15.806250 14421 2 0.000000 1 2.500000 17.220000 5.965183 19.318750 -14422 2 0.000000 -1.000000 2.500000 17.220000 5.965183 19.318750 +14422 2 0.000000 -1 2.500000 17.220000 5.965183 19.318750 14423 2 0.000000 1 2.500000 19.516000 1.988394 19.318750 14424 2 0.000000 -1 2.500000 19.516000 1.988394 19.318750 14425 2 0.000000 1 2.500000 21.812000 3.313991 22.831250 @@ -14443,7 +14443,7 @@ Atoms 14427 2 0.000000 1 2.500000 24.108000 7.290779 22.831250 14428 2 0.000000 -1 2.500000 24.108000 7.290779 22.831250 14429 2 0.000000 1 2.500000 17.220000 5.965183 26.343750 -14430 2 0.000000 -1.000000 2.500000 17.220000 5.965183 26.343750 +14430 2 0.000000 -1 2.500000 17.220000 5.965183 26.343750 14431 2 0.000000 1 2.500000 19.516000 1.988394 26.343750 14432 2 0.000000 -1 2.500000 19.516000 1.988394 26.343750 14433 2 0.000000 1 2.500000 21.812000 3.313991 29.856250 @@ -14451,7 +14451,7 @@ Atoms 14435 2 0.000000 1 2.500000 24.108000 7.290779 29.856250 14436 2 0.000000 -1 2.500000 24.108000 7.290779 29.856250 14437 2 0.000000 1 2.500000 17.220000 5.965183 33.368750 -14438 2 0.000000 -1.000000 2.500000 17.220000 5.965183 33.368750 +14438 2 0.000000 -1 2.500000 17.220000 5.965183 33.368750 14439 2 0.000000 1 2.500000 19.516000 1.988394 33.368750 14440 2 0.000000 -1 2.500000 19.516000 1.988394 33.368750 14441 2 0.000000 1 2.500000 21.812000 3.313991 36.881250 @@ -14459,7 +14459,7 @@ Atoms 14443 2 0.000000 1 2.500000 24.108000 7.290779 36.881250 14444 2 0.000000 -1 2.500000 24.108000 7.290779 36.881250 14445 2 0.000000 1 2.500000 17.220000 5.965183 40.393750 -14446 2 0.000000 -1.000000 2.500000 17.220000 5.965183 40.393750 +14446 2 0.000000 -1 2.500000 17.220000 5.965183 40.393750 14447 2 0.000000 1 2.500000 19.516000 1.988394 40.393750 14448 2 0.000000 -1 2.500000 19.516000 1.988394 40.393750 14449 2 0.000000 1 2.500000 21.812000 3.313991 43.906250 @@ -14467,7 +14467,7 @@ Atoms 14451 2 0.000000 1 2.500000 24.108000 7.290779 43.906250 14452 2 0.000000 -1 2.500000 24.108000 7.290779 43.906250 14453 2 0.000000 1 2.500000 17.220000 5.965183 47.418750 -14454 2 0.000000 -1.000000 2.500000 17.220000 5.965183 47.418750 +14454 2 0.000000 -1 2.500000 17.220000 5.965183 47.418750 14455 2 0.000000 1 2.500000 19.516000 1.988394 47.418750 14456 2 0.000000 -1 2.500000 19.516000 1.988394 47.418750 14457 2 0.000000 1 2.500000 21.812000 3.313991 50.931250 @@ -14475,7 +14475,7 @@ Atoms 14459 2 0.000000 1 2.500000 24.108000 7.290779 50.931250 14460 2 0.000000 -1 2.500000 24.108000 7.290779 50.931250 14461 2 0.000000 1 2.500000 17.220000 5.965183 54.443750 -14462 2 0.000000 -1.000000 2.500000 17.220000 5.965183 54.443750 +14462 2 0.000000 -1 2.500000 17.220000 5.965183 54.443750 14463 2 0.000000 1 2.500000 19.516000 1.988394 54.443750 14464 2 0.000000 -1 2.500000 19.516000 1.988394 54.443750 14465 2 0.000000 1 2.500000 21.812000 3.313991 57.956250 @@ -14483,7 +14483,7 @@ Atoms 14467 2 0.000000 1 2.500000 24.108000 7.290779 57.956250 14468 2 0.000000 -1 2.500000 24.108000 7.290779 57.956250 14469 2 0.000000 1 2.500000 17.220000 5.965183 61.468750 -14470 2 0.000000 -1.000000 2.500000 17.220000 5.965183 61.468750 +14470 2 0.000000 -1 2.500000 17.220000 5.965183 61.468750 14471 2 0.000000 1 2.500000 19.516000 1.988394 61.468750 14472 2 0.000000 -1 2.500000 19.516000 1.988394 61.468750 14473 2 0.000000 1 2.500000 21.812000 11.267568 1.756250 @@ -14491,7 +14491,7 @@ Atoms 14475 2 0.000000 1 2.500000 24.108000 15.244357 1.756250 14476 2 0.000000 -1 2.500000 24.108000 15.244357 1.756250 14477 2 0.000000 1 2.500000 17.220000 13.918760 5.268750 -14478 2 0.000000 -1.000000 2.500000 17.220000 13.918760 5.268750 +14478 2 0.000000 -1 2.500000 17.220000 13.918760 5.268750 14479 2 0.000000 1 2.500000 19.516000 9.941972 5.268750 14480 2 0.000000 -1 2.500000 19.516000 9.941972 5.268750 14481 2 0.000000 1 2.500000 21.812000 11.267568 8.781250 @@ -14499,7 +14499,7 @@ Atoms 14483 2 0.000000 1 2.500000 24.108000 15.244357 8.781250 14484 2 0.000000 -1 2.500000 24.108000 15.244357 8.781250 14485 2 0.000000 1 2.500000 17.220000 13.918760 12.293750 -14486 2 0.000000 -1.000000 2.500000 17.220000 13.918760 12.293750 +14486 2 0.000000 -1 2.500000 17.220000 13.918760 12.293750 14487 2 0.000000 1 2.500000 19.516000 9.941972 12.293750 14488 2 0.000000 -1 2.500000 19.516000 9.941972 12.293750 14489 2 0.000000 1 2.500000 21.812000 11.267568 15.806250 @@ -14507,7 +14507,7 @@ Atoms 14491 2 0.000000 1 2.500000 24.108000 15.244357 15.806250 14492 2 0.000000 -1 2.500000 24.108000 15.244357 15.806250 14493 2 0.000000 1 2.500000 17.220000 13.918760 19.318750 -14494 2 0.000000 -1.000000 2.500000 17.220000 13.918760 19.318750 +14494 2 0.000000 -1 2.500000 17.220000 13.918760 19.318750 14495 2 0.000000 1 2.500000 19.516000 9.941972 19.318750 14496 2 0.000000 -1 2.500000 19.516000 9.941972 19.318750 14497 2 0.000000 1 2.500000 21.812000 11.267568 22.831250 @@ -14515,7 +14515,7 @@ Atoms 14499 2 0.000000 1 2.500000 24.108000 15.244357 22.831250 14500 2 0.000000 -1 2.500000 24.108000 15.244357 22.831250 14501 2 0.000000 1 2.500000 17.220000 13.918760 26.343750 -14502 2 0.000000 -1.000000 2.500000 17.220000 13.918760 26.343750 +14502 2 0.000000 -1 2.500000 17.220000 13.918760 26.343750 14503 2 0.000000 1 2.500000 19.516000 9.941972 26.343750 14504 2 0.000000 -1 2.500000 19.516000 9.941972 26.343750 14505 2 0.000000 1 2.500000 21.812000 11.267568 29.856250 @@ -14523,7 +14523,7 @@ Atoms 14507 2 0.000000 1 2.500000 24.108000 15.244357 29.856250 14508 2 0.000000 -1 2.500000 24.108000 15.244357 29.856250 14509 2 0.000000 1 2.500000 17.220000 13.918760 33.368750 -14510 2 0.000000 -1.000000 2.500000 17.220000 13.918760 33.368750 +14510 2 0.000000 -1 2.500000 17.220000 13.918760 33.368750 14511 2 0.000000 1 2.500000 19.516000 9.941972 33.368750 14512 2 0.000000 -1 2.500000 19.516000 9.941972 33.368750 14513 2 0.000000 1 2.500000 21.812000 11.267568 36.881250 @@ -14531,7 +14531,7 @@ Atoms 14515 2 0.000000 1 2.500000 24.108000 15.244357 36.881250 14516 2 0.000000 -1 2.500000 24.108000 15.244357 36.881250 14517 2 0.000000 1 2.500000 17.220000 13.918760 40.393750 -14518 2 0.000000 -1.000000 2.500000 17.220000 13.918760 40.393750 +14518 2 0.000000 -1 2.500000 17.220000 13.918760 40.393750 14519 2 0.000000 1 2.500000 19.516000 9.941972 40.393750 14520 2 0.000000 -1 2.500000 19.516000 9.941972 40.393750 14521 2 0.000000 1 2.500000 21.812000 11.267568 43.906250 @@ -14539,7 +14539,7 @@ Atoms 14523 2 0.000000 1 2.500000 24.108000 15.244357 43.906250 14524 2 0.000000 -1 2.500000 24.108000 15.244357 43.906250 14525 2 0.000000 1 2.500000 17.220000 13.918760 47.418750 -14526 2 0.000000 -1.000000 2.500000 17.220000 13.918760 47.418750 +14526 2 0.000000 -1 2.500000 17.220000 13.918760 47.418750 14527 2 0.000000 1 2.500000 19.516000 9.941972 47.418750 14528 2 0.000000 -1 2.500000 19.516000 9.941972 47.418750 14529 2 0.000000 1 2.500000 21.812000 11.267568 50.931250 @@ -14547,7 +14547,7 @@ Atoms 14531 2 0.000000 1 2.500000 24.108000 15.244357 50.931250 14532 2 0.000000 -1 2.500000 24.108000 15.244357 50.931250 14533 2 0.000000 1 2.500000 17.220000 13.918760 54.443750 -14534 2 0.000000 -1.000000 2.500000 17.220000 13.918760 54.443750 +14534 2 0.000000 -1 2.500000 17.220000 13.918760 54.443750 14535 2 0.000000 1 2.500000 19.516000 9.941972 54.443750 14536 2 0.000000 -1 2.500000 19.516000 9.941972 54.443750 14537 2 0.000000 1 2.500000 21.812000 11.267568 57.956250 @@ -14555,7 +14555,7 @@ Atoms 14539 2 0.000000 1 2.500000 24.108000 15.244357 57.956250 14540 2 0.000000 -1 2.500000 24.108000 15.244357 57.956250 14541 2 0.000000 1 2.500000 17.220000 13.918760 61.468750 -14542 2 0.000000 -1.000000 2.500000 17.220000 13.918760 61.468750 +14542 2 0.000000 -1 2.500000 17.220000 13.918760 61.468750 14543 2 0.000000 1 2.500000 19.516000 9.941972 61.468750 14544 2 0.000000 -1 2.500000 19.516000 9.941972 61.468750 14545 2 0.000000 1 2.500000 21.812000 19.221145 1.756250 @@ -14563,7 +14563,7 @@ Atoms 14547 2 0.000000 1 2.500000 24.108000 23.197934 1.756250 14548 2 0.000000 -1 2.500000 24.108000 23.197934 1.756250 14549 2 0.000000 1 2.500000 17.220000 21.872338 5.268750 -14550 2 0.000000 -1.000000 2.500000 17.220000 21.872338 5.268750 +14550 2 0.000000 -1 2.500000 17.220000 21.872338 5.268750 14551 2 0.000000 1 2.500000 19.516000 17.895549 5.268750 14552 2 0.000000 -1 2.500000 19.516000 17.895549 5.268750 14553 2 0.000000 1 2.500000 21.812000 19.221145 8.781250 @@ -14571,7 +14571,7 @@ Atoms 14555 2 0.000000 1 2.500000 24.108000 23.197934 8.781250 14556 2 0.000000 -1 2.500000 24.108000 23.197934 8.781250 14557 2 0.000000 1 2.500000 17.220000 21.872338 12.293750 -14558 2 0.000000 -1.000000 2.500000 17.220000 21.872338 12.293750 +14558 2 0.000000 -1 2.500000 17.220000 21.872338 12.293750 14559 2 0.000000 1 2.500000 19.516000 17.895549 12.293750 14560 2 0.000000 -1 2.500000 19.516000 17.895549 12.293750 14561 2 0.000000 1 2.500000 21.812000 19.221145 15.806250 @@ -14579,7 +14579,7 @@ Atoms 14563 2 0.000000 1 2.500000 24.108000 23.197934 15.806250 14564 2 0.000000 -1 2.500000 24.108000 23.197934 15.806250 14565 2 0.000000 1 2.500000 17.220000 21.872338 19.318750 -14566 2 0.000000 -1.000000 2.500000 17.220000 21.872338 19.318750 +14566 2 0.000000 -1 2.500000 17.220000 21.872338 19.318750 14567 2 0.000000 1 2.500000 19.516000 17.895549 19.318750 14568 2 0.000000 -1 2.500000 19.516000 17.895549 19.318750 14569 2 0.000000 1 2.500000 21.812000 19.221145 22.831250 @@ -14587,7 +14587,7 @@ Atoms 14571 2 0.000000 1 2.500000 24.108000 23.197934 22.831250 14572 2 0.000000 -1 2.500000 24.108000 23.197934 22.831250 14573 2 0.000000 1 2.500000 17.220000 21.872338 26.343750 -14574 2 0.000000 -1.000000 2.500000 17.220000 21.872338 26.343750 +14574 2 0.000000 -1 2.500000 17.220000 21.872338 26.343750 14575 2 0.000000 1 2.500000 19.516000 17.895549 26.343750 14576 2 0.000000 -1 2.500000 19.516000 17.895549 26.343750 14577 2 0.000000 1 2.500000 21.812000 19.221145 29.856250 @@ -14595,7 +14595,7 @@ Atoms 14579 2 0.000000 1 2.500000 24.108000 23.197934 29.856250 14580 2 0.000000 -1 2.500000 24.108000 23.197934 29.856250 14581 2 0.000000 1 2.500000 17.220000 21.872338 33.368750 -14582 2 0.000000 -1.000000 2.500000 17.220000 21.872338 33.368750 +14582 2 0.000000 -1 2.500000 17.220000 21.872338 33.368750 14583 2 0.000000 1 2.500000 19.516000 17.895549 33.368750 14584 2 0.000000 -1 2.500000 19.516000 17.895549 33.368750 14585 2 0.000000 1 2.500000 21.812000 19.221145 36.881250 @@ -14603,7 +14603,7 @@ Atoms 14587 2 0.000000 1 2.500000 24.108000 23.197934 36.881250 14588 2 0.000000 -1 2.500000 24.108000 23.197934 36.881250 14589 2 0.000000 1 2.500000 17.220000 21.872338 40.393750 -14590 2 0.000000 -1.000000 2.500000 17.220000 21.872338 40.393750 +14590 2 0.000000 -1 2.500000 17.220000 21.872338 40.393750 14591 2 0.000000 1 2.500000 19.516000 17.895549 40.393750 14592 2 0.000000 -1 2.500000 19.516000 17.895549 40.393750 14593 2 0.000000 1 2.500000 21.812000 19.221145 43.906250 @@ -14611,7 +14611,7 @@ Atoms 14595 2 0.000000 1 2.500000 24.108000 23.197934 43.906250 14596 2 0.000000 -1 2.500000 24.108000 23.197934 43.906250 14597 2 0.000000 1 2.500000 17.220000 21.872338 47.418750 -14598 2 0.000000 -1.000000 2.500000 17.220000 21.872338 47.418750 +14598 2 0.000000 -1 2.500000 17.220000 21.872338 47.418750 14599 2 0.000000 1 2.500000 19.516000 17.895549 47.418750 14600 2 0.000000 -1 2.500000 19.516000 17.895549 47.418750 14601 2 0.000000 1 2.500000 21.812000 19.221145 50.931250 @@ -14619,7 +14619,7 @@ Atoms 14603 2 0.000000 1 2.500000 24.108000 23.197934 50.931250 14604 2 0.000000 -1 2.500000 24.108000 23.197934 50.931250 14605 2 0.000000 1 2.500000 17.220000 21.872338 54.443750 -14606 2 0.000000 -1.000000 2.500000 17.220000 21.872338 54.443750 +14606 2 0.000000 -1 2.500000 17.220000 21.872338 54.443750 14607 2 0.000000 1 2.500000 19.516000 17.895549 54.443750 14608 2 0.000000 -1 2.500000 19.516000 17.895549 54.443750 14609 2 0.000000 1 2.500000 21.812000 19.221145 57.956250 @@ -14627,7 +14627,7 @@ Atoms 14611 2 0.000000 1 2.500000 24.108000 23.197934 57.956250 14612 2 0.000000 -1 2.500000 24.108000 23.197934 57.956250 14613 2 0.000000 1 2.500000 17.220000 21.872338 61.468750 -14614 2 0.000000 -1.000000 2.500000 17.220000 21.872338 61.468750 +14614 2 0.000000 -1 2.500000 17.220000 21.872338 61.468750 14615 2 0.000000 1 2.500000 19.516000 17.895549 61.468750 14616 2 0.000000 -1 2.500000 19.516000 17.895549 61.468750 14617 2 0.000000 1 2.500000 21.812000 27.174722 1.756250 @@ -14635,7 +14635,7 @@ Atoms 14619 2 0.000000 1 2.500000 24.108000 31.151511 1.756250 14620 2 0.000000 -1 2.500000 24.108000 31.151511 1.756250 14621 2 0.000000 1 2.500000 17.220000 29.825915 5.268750 -14622 2 0.000000 -1.000000 2.500000 17.220000 29.825915 5.268750 +14622 2 0.000000 -1 2.500000 17.220000 29.825915 5.268750 14623 2 0.000000 1 2.500000 19.516000 25.849126 5.268750 14624 2 0.000000 -1 2.500000 19.516000 25.849126 5.268750 14625 2 0.000000 1 2.500000 21.812000 27.174722 8.781250 @@ -14643,7 +14643,7 @@ Atoms 14627 2 0.000000 1 2.500000 24.108000 31.151511 8.781250 14628 2 0.000000 -1 2.500000 24.108000 31.151511 8.781250 14629 2 0.000000 1 2.500000 17.220000 29.825915 12.293750 -14630 2 0.000000 -1.000000 2.500000 17.220000 29.825915 12.293750 +14630 2 0.000000 -1 2.500000 17.220000 29.825915 12.293750 14631 2 0.000000 1 2.500000 19.516000 25.849126 12.293750 14632 2 0.000000 -1 2.500000 19.516000 25.849126 12.293750 14633 2 0.000000 1 2.500000 21.812000 27.174722 15.806250 @@ -14651,7 +14651,7 @@ Atoms 14635 2 0.000000 1 2.500000 24.108000 31.151511 15.806250 14636 2 0.000000 -1 2.500000 24.108000 31.151511 15.806250 14637 2 0.000000 1 2.500000 17.220000 29.825915 19.318750 -14638 2 0.000000 -1.000000 2.500000 17.220000 29.825915 19.318750 +14638 2 0.000000 -1 2.500000 17.220000 29.825915 19.318750 14639 2 0.000000 1 2.500000 19.516000 25.849126 19.318750 14640 2 0.000000 -1 2.500000 19.516000 25.849126 19.318750 14641 2 0.000000 1 2.500000 21.812000 27.174722 22.831250 @@ -14659,7 +14659,7 @@ Atoms 14643 2 0.000000 1 2.500000 24.108000 31.151511 22.831250 14644 2 0.000000 -1 2.500000 24.108000 31.151511 22.831250 14645 2 0.000000 1 2.500000 17.220000 29.825915 26.343750 -14646 2 0.000000 -1.000000 2.500000 17.220000 29.825915 26.343750 +14646 2 0.000000 -1 2.500000 17.220000 29.825915 26.343750 14647 2 0.000000 1 2.500000 19.516000 25.849126 26.343750 14648 2 0.000000 -1 2.500000 19.516000 25.849126 26.343750 14649 2 0.000000 1 2.500000 21.812000 27.174722 29.856250 @@ -14667,7 +14667,7 @@ Atoms 14651 2 0.000000 1 2.500000 24.108000 31.151511 29.856250 14652 2 0.000000 -1 2.500000 24.108000 31.151511 29.856250 14653 2 0.000000 1 2.500000 17.220000 29.825915 33.368750 -14654 2 0.000000 -1.000000 2.500000 17.220000 29.825915 33.368750 +14654 2 0.000000 -1 2.500000 17.220000 29.825915 33.368750 14655 2 0.000000 1 2.500000 19.516000 25.849126 33.368750 14656 2 0.000000 -1 2.500000 19.516000 25.849126 33.368750 14657 2 0.000000 1 2.500000 21.812000 27.174722 36.881250 @@ -14675,7 +14675,7 @@ Atoms 14659 2 0.000000 1 2.500000 24.108000 31.151511 36.881250 14660 2 0.000000 -1 2.500000 24.108000 31.151511 36.881250 14661 2 0.000000 1 2.500000 17.220000 29.825915 40.393750 -14662 2 0.000000 -1.000000 2.500000 17.220000 29.825915 40.393750 +14662 2 0.000000 -1 2.500000 17.220000 29.825915 40.393750 14663 2 0.000000 1 2.500000 19.516000 25.849126 40.393750 14664 2 0.000000 -1 2.500000 19.516000 25.849126 40.393750 14665 2 0.000000 1 2.500000 21.812000 27.174722 43.906250 @@ -14683,7 +14683,7 @@ Atoms 14667 2 0.000000 1 2.500000 24.108000 31.151511 43.906250 14668 2 0.000000 -1 2.500000 24.108000 31.151511 43.906250 14669 2 0.000000 1 2.500000 17.220000 29.825915 47.418750 -14670 2 0.000000 -1.000000 2.500000 17.220000 29.825915 47.418750 +14670 2 0.000000 -1 2.500000 17.220000 29.825915 47.418750 14671 2 0.000000 1 2.500000 19.516000 25.849126 47.418750 14672 2 0.000000 -1 2.500000 19.516000 25.849126 47.418750 14673 2 0.000000 1 2.500000 21.812000 27.174722 50.931250 @@ -14691,7 +14691,7 @@ Atoms 14675 2 0.000000 1 2.500000 24.108000 31.151511 50.931250 14676 2 0.000000 -1 2.500000 24.108000 31.151511 50.931250 14677 2 0.000000 1 2.500000 17.220000 29.825915 54.443750 -14678 2 0.000000 -1.000000 2.500000 17.220000 29.825915 54.443750 +14678 2 0.000000 -1 2.500000 17.220000 29.825915 54.443750 14679 2 0.000000 1 2.500000 19.516000 25.849126 54.443750 14680 2 0.000000 -1 2.500000 19.516000 25.849126 54.443750 14681 2 0.000000 1 2.500000 21.812000 27.174722 57.956250 @@ -14699,7 +14699,7 @@ Atoms 14683 2 0.000000 1 2.500000 24.108000 31.151511 57.956250 14684 2 0.000000 -1 2.500000 24.108000 31.151511 57.956250 14685 2 0.000000 1 2.500000 17.220000 29.825915 61.468750 -14686 2 0.000000 -1.000000 2.500000 17.220000 29.825915 61.468750 +14686 2 0.000000 -1 2.500000 17.220000 29.825915 61.468750 14687 2 0.000000 1 2.500000 19.516000 25.849126 61.468750 14688 2 0.000000 -1 2.500000 19.516000 25.849126 61.468750 14689 2 0.000000 1 2.500000 21.812000 35.128300 1.756250 @@ -14707,7 +14707,7 @@ Atoms 14691 2 0.000000 1 2.500000 24.108000 39.105088 1.756250 14692 2 0.000000 -1 2.500000 24.108000 39.105088 1.756250 14693 2 0.000000 1 2.500000 17.220000 37.779492 5.268750 -14694 2 0.000000 -1.000000 2.500000 17.220000 37.779492 5.268750 +14694 2 0.000000 -1 2.500000 17.220000 37.779492 5.268750 14695 2 0.000000 1 2.500000 19.516000 33.802704 5.268750 14696 2 0.000000 -1 2.500000 19.516000 33.802704 5.268750 14697 2 0.000000 1 2.500000 21.812000 35.128300 8.781250 @@ -14715,7 +14715,7 @@ Atoms 14699 2 0.000000 1 2.500000 24.108000 39.105088 8.781250 14700 2 0.000000 -1 2.500000 24.108000 39.105088 8.781250 14701 2 0.000000 1 2.500000 17.220000 37.779492 12.293750 -14702 2 0.000000 -1.000000 2.500000 17.220000 37.779492 12.293750 +14702 2 0.000000 -1 2.500000 17.220000 37.779492 12.293750 14703 2 0.000000 1 2.500000 19.516000 33.802704 12.293750 14704 2 0.000000 -1 2.500000 19.516000 33.802704 12.293750 14705 2 0.000000 1 2.500000 21.812000 35.128300 15.806250 @@ -14723,7 +14723,7 @@ Atoms 14707 2 0.000000 1 2.500000 24.108000 39.105088 15.806250 14708 2 0.000000 -1 2.500000 24.108000 39.105088 15.806250 14709 2 0.000000 1 2.500000 17.220000 37.779492 19.318750 -14710 2 0.000000 -1.000000 2.500000 17.220000 37.779492 19.318750 +14710 2 0.000000 -1 2.500000 17.220000 37.779492 19.318750 14711 2 0.000000 1 2.500000 19.516000 33.802704 19.318750 14712 2 0.000000 -1 2.500000 19.516000 33.802704 19.318750 14713 2 0.000000 1 2.500000 21.812000 35.128300 22.831250 @@ -14731,7 +14731,7 @@ Atoms 14715 2 0.000000 1 2.500000 24.108000 39.105088 22.831250 14716 2 0.000000 -1 2.500000 24.108000 39.105088 22.831250 14717 2 0.000000 1 2.500000 17.220000 37.779492 26.343750 -14718 2 0.000000 -1.000000 2.500000 17.220000 37.779492 26.343750 +14718 2 0.000000 -1 2.500000 17.220000 37.779492 26.343750 14719 2 0.000000 1 2.500000 19.516000 33.802704 26.343750 14720 2 0.000000 -1 2.500000 19.516000 33.802704 26.343750 14721 2 0.000000 1 2.500000 21.812000 35.128300 29.856250 @@ -14739,7 +14739,7 @@ Atoms 14723 2 0.000000 1 2.500000 24.108000 39.105088 29.856250 14724 2 0.000000 -1 2.500000 24.108000 39.105088 29.856250 14725 2 0.000000 1 2.500000 17.220000 37.779492 33.368750 -14726 2 0.000000 -1.000000 2.500000 17.220000 37.779492 33.368750 +14726 2 0.000000 -1 2.500000 17.220000 37.779492 33.368750 14727 2 0.000000 1 2.500000 19.516000 33.802704 33.368750 14728 2 0.000000 -1 2.500000 19.516000 33.802704 33.368750 14729 2 0.000000 1 2.500000 21.812000 35.128300 36.881250 @@ -14747,7 +14747,7 @@ Atoms 14731 2 0.000000 1 2.500000 24.108000 39.105088 36.881250 14732 2 0.000000 -1 2.500000 24.108000 39.105088 36.881250 14733 2 0.000000 1 2.500000 17.220000 37.779492 40.393750 -14734 2 0.000000 -1.000000 2.500000 17.220000 37.779492 40.393750 +14734 2 0.000000 -1 2.500000 17.220000 37.779492 40.393750 14735 2 0.000000 1 2.500000 19.516000 33.802704 40.393750 14736 2 0.000000 -1 2.500000 19.516000 33.802704 40.393750 14737 2 0.000000 1 2.500000 21.812000 35.128300 43.906250 @@ -14755,7 +14755,7 @@ Atoms 14739 2 0.000000 1 2.500000 24.108000 39.105088 43.906250 14740 2 0.000000 -1 2.500000 24.108000 39.105088 43.906250 14741 2 0.000000 1 2.500000 17.220000 37.779492 47.418750 -14742 2 0.000000 -1.000000 2.500000 17.220000 37.779492 47.418750 +14742 2 0.000000 -1 2.500000 17.220000 37.779492 47.418750 14743 2 0.000000 1 2.500000 19.516000 33.802704 47.418750 14744 2 0.000000 -1 2.500000 19.516000 33.802704 47.418750 14745 2 0.000000 1 2.500000 21.812000 35.128300 50.931250 @@ -14763,7 +14763,7 @@ Atoms 14747 2 0.000000 1 2.500000 24.108000 39.105088 50.931250 14748 2 0.000000 -1 2.500000 24.108000 39.105088 50.931250 14749 2 0.000000 1 2.500000 17.220000 37.779492 54.443750 -14750 2 0.000000 -1.000000 2.500000 17.220000 37.779492 54.443750 +14750 2 0.000000 -1 2.500000 17.220000 37.779492 54.443750 14751 2 0.000000 1 2.500000 19.516000 33.802704 54.443750 14752 2 0.000000 -1 2.500000 19.516000 33.802704 54.443750 14753 2 0.000000 1 2.500000 21.812000 35.128300 57.956250 @@ -14771,7 +14771,7 @@ Atoms 14755 2 0.000000 1 2.500000 24.108000 39.105088 57.956250 14756 2 0.000000 -1 2.500000 24.108000 39.105088 57.956250 14757 2 0.000000 1 2.500000 17.220000 37.779492 61.468750 -14758 2 0.000000 -1.000000 2.500000 17.220000 37.779492 61.468750 +14758 2 0.000000 -1 2.500000 17.220000 37.779492 61.468750 14759 2 0.000000 1 2.500000 19.516000 33.802704 61.468750 14760 2 0.000000 -1 2.500000 19.516000 33.802704 61.468750 14761 2 0.000000 1 2.500000 21.812000 43.081877 1.756250 @@ -14779,7 +14779,7 @@ Atoms 14763 2 0.000000 1 2.500000 24.108000 47.058666 1.756250 14764 2 0.000000 -1 2.500000 24.108000 47.058666 1.756250 14765 2 0.000000 1 2.500000 17.220000 45.733070 5.268750 -14766 2 0.000000 -1.000000 2.500000 17.220000 45.733070 5.268750 +14766 2 0.000000 -1 2.500000 17.220000 45.733070 5.268750 14767 2 0.000000 1 2.500000 19.516000 41.756281 5.268750 14768 2 0.000000 -1 2.500000 19.516000 41.756281 5.268750 14769 2 0.000000 1 2.500000 21.812000 43.081877 8.781250 @@ -14787,7 +14787,7 @@ Atoms 14771 2 0.000000 1 2.500000 24.108000 47.058666 8.781250 14772 2 0.000000 -1 2.500000 24.108000 47.058666 8.781250 14773 2 0.000000 1 2.500000 17.220000 45.733070 12.293750 -14774 2 0.000000 -1.000000 2.500000 17.220000 45.733070 12.293750 +14774 2 0.000000 -1 2.500000 17.220000 45.733070 12.293750 14775 2 0.000000 1 2.500000 19.516000 41.756281 12.293750 14776 2 0.000000 -1 2.500000 19.516000 41.756281 12.293750 14777 2 0.000000 1 2.500000 21.812000 43.081877 15.806250 @@ -14795,7 +14795,7 @@ Atoms 14779 2 0.000000 1 2.500000 24.108000 47.058666 15.806250 14780 2 0.000000 -1 2.500000 24.108000 47.058666 15.806250 14781 2 0.000000 1 2.500000 17.220000 45.733070 19.318750 -14782 2 0.000000 -1.000000 2.500000 17.220000 45.733070 19.318750 +14782 2 0.000000 -1 2.500000 17.220000 45.733070 19.318750 14783 2 0.000000 1 2.500000 19.516000 41.756281 19.318750 14784 2 0.000000 -1 2.500000 19.516000 41.756281 19.318750 14785 2 0.000000 1 2.500000 21.812000 43.081877 22.831250 @@ -14803,7 +14803,7 @@ Atoms 14787 2 0.000000 1 2.500000 24.108000 47.058666 22.831250 14788 2 0.000000 -1 2.500000 24.108000 47.058666 22.831250 14789 2 0.000000 1 2.500000 17.220000 45.733070 26.343750 -14790 2 0.000000 -1.000000 2.500000 17.220000 45.733070 26.343750 +14790 2 0.000000 -1 2.500000 17.220000 45.733070 26.343750 14791 2 0.000000 1 2.500000 19.516000 41.756281 26.343750 14792 2 0.000000 -1 2.500000 19.516000 41.756281 26.343750 14793 2 0.000000 1 2.500000 21.812000 43.081877 29.856250 @@ -14811,7 +14811,7 @@ Atoms 14795 2 0.000000 1 2.500000 24.108000 47.058666 29.856250 14796 2 0.000000 -1 2.500000 24.108000 47.058666 29.856250 14797 2 0.000000 1 2.500000 17.220000 45.733070 33.368750 -14798 2 0.000000 -1.000000 2.500000 17.220000 45.733070 33.368750 +14798 2 0.000000 -1 2.500000 17.220000 45.733070 33.368750 14799 2 0.000000 1 2.500000 19.516000 41.756281 33.368750 14800 2 0.000000 -1 2.500000 19.516000 41.756281 33.368750 14801 2 0.000000 1 2.500000 21.812000 43.081877 36.881250 @@ -14819,7 +14819,7 @@ Atoms 14803 2 0.000000 1 2.500000 24.108000 47.058666 36.881250 14804 2 0.000000 -1 2.500000 24.108000 47.058666 36.881250 14805 2 0.000000 1 2.500000 17.220000 45.733070 40.393750 -14806 2 0.000000 -1.000000 2.500000 17.220000 45.733070 40.393750 +14806 2 0.000000 -1 2.500000 17.220000 45.733070 40.393750 14807 2 0.000000 1 2.500000 19.516000 41.756281 40.393750 14808 2 0.000000 -1 2.500000 19.516000 41.756281 40.393750 14809 2 0.000000 1 2.500000 21.812000 43.081877 43.906250 @@ -14827,7 +14827,7 @@ Atoms 14811 2 0.000000 1 2.500000 24.108000 47.058666 43.906250 14812 2 0.000000 -1 2.500000 24.108000 47.058666 43.906250 14813 2 0.000000 1 2.500000 17.220000 45.733070 47.418750 -14814 2 0.000000 -1.000000 2.500000 17.220000 45.733070 47.418750 +14814 2 0.000000 -1 2.500000 17.220000 45.733070 47.418750 14815 2 0.000000 1 2.500000 19.516000 41.756281 47.418750 14816 2 0.000000 -1 2.500000 19.516000 41.756281 47.418750 14817 2 0.000000 1 2.500000 21.812000 43.081877 50.931250 @@ -14835,7 +14835,7 @@ Atoms 14819 2 0.000000 1 2.500000 24.108000 47.058666 50.931250 14820 2 0.000000 -1 2.500000 24.108000 47.058666 50.931250 14821 2 0.000000 1 2.500000 17.220000 45.733070 54.443750 -14822 2 0.000000 -1.000000 2.500000 17.220000 45.733070 54.443750 +14822 2 0.000000 -1 2.500000 17.220000 45.733070 54.443750 14823 2 0.000000 1 2.500000 19.516000 41.756281 54.443750 14824 2 0.000000 -1 2.500000 19.516000 41.756281 54.443750 14825 2 0.000000 1 2.500000 21.812000 43.081877 57.956250 @@ -14843,7 +14843,7 @@ Atoms 14827 2 0.000000 1 2.500000 24.108000 47.058666 57.956250 14828 2 0.000000 -1 2.500000 24.108000 47.058666 57.956250 14829 2 0.000000 1 2.500000 17.220000 45.733070 61.468750 -14830 2 0.000000 -1.000000 2.500000 17.220000 45.733070 61.468750 +14830 2 0.000000 -1 2.500000 17.220000 45.733070 61.468750 14831 2 0.000000 1 2.500000 19.516000 41.756281 61.468750 14832 2 0.000000 -1 2.500000 19.516000 41.756281 61.468750 14833 2 0.000000 1 2.500000 21.812000 51.035454 1.756250 @@ -14851,7 +14851,7 @@ Atoms 14835 2 0.000000 1 2.500000 24.108000 55.012243 1.756250 14836 2 0.000000 -1 2.500000 24.108000 55.012243 1.756250 14837 2 0.000000 1 2.500000 17.220000 53.686647 5.268750 -14838 2 0.000000 -1.000000 2.500000 17.220000 53.686647 5.268750 +14838 2 0.000000 -1 2.500000 17.220000 53.686647 5.268750 14839 2 0.000000 1 2.500000 19.516000 49.709858 5.268750 14840 2 0.000000 -1 2.500000 19.516000 49.709858 5.268750 14841 2 0.000000 1 2.500000 21.812000 51.035454 8.781250 @@ -14859,7 +14859,7 @@ Atoms 14843 2 0.000000 1 2.500000 24.108000 55.012243 8.781250 14844 2 0.000000 -1 2.500000 24.108000 55.012243 8.781250 14845 2 0.000000 1 2.500000 17.220000 53.686647 12.293750 -14846 2 0.000000 -1.000000 2.500000 17.220000 53.686647 12.293750 +14846 2 0.000000 -1 2.500000 17.220000 53.686647 12.293750 14847 2 0.000000 1 2.500000 19.516000 49.709858 12.293750 14848 2 0.000000 -1 2.500000 19.516000 49.709858 12.293750 14849 2 0.000000 1 2.500000 21.812000 51.035454 15.806250 @@ -14867,7 +14867,7 @@ Atoms 14851 2 0.000000 1 2.500000 24.108000 55.012243 15.806250 14852 2 0.000000 -1 2.500000 24.108000 55.012243 15.806250 14853 2 0.000000 1 2.500000 17.220000 53.686647 19.318750 -14854 2 0.000000 -1.000000 2.500000 17.220000 53.686647 19.318750 +14854 2 0.000000 -1 2.500000 17.220000 53.686647 19.318750 14855 2 0.000000 1 2.500000 19.516000 49.709858 19.318750 14856 2 0.000000 -1 2.500000 19.516000 49.709858 19.318750 14857 2 0.000000 1 2.500000 21.812000 51.035454 22.831250 @@ -14875,7 +14875,7 @@ Atoms 14859 2 0.000000 1 2.500000 24.108000 55.012243 22.831250 14860 2 0.000000 -1 2.500000 24.108000 55.012243 22.831250 14861 2 0.000000 1 2.500000 17.220000 53.686647 26.343750 -14862 2 0.000000 -1.000000 2.500000 17.220000 53.686647 26.343750 +14862 2 0.000000 -1 2.500000 17.220000 53.686647 26.343750 14863 2 0.000000 1 2.500000 19.516000 49.709858 26.343750 14864 2 0.000000 -1 2.500000 19.516000 49.709858 26.343750 14865 2 0.000000 1 2.500000 21.812000 51.035454 29.856250 @@ -14883,7 +14883,7 @@ Atoms 14867 2 0.000000 1 2.500000 24.108000 55.012243 29.856250 14868 2 0.000000 -1 2.500000 24.108000 55.012243 29.856250 14869 2 0.000000 1 2.500000 17.220000 53.686647 33.368750 -14870 2 0.000000 -1.000000 2.500000 17.220000 53.686647 33.368750 +14870 2 0.000000 -1 2.500000 17.220000 53.686647 33.368750 14871 2 0.000000 1 2.500000 19.516000 49.709858 33.368750 14872 2 0.000000 -1 2.500000 19.516000 49.709858 33.368750 14873 2 0.000000 1 2.500000 21.812000 51.035454 36.881250 @@ -14891,7 +14891,7 @@ Atoms 14875 2 0.000000 1 2.500000 24.108000 55.012243 36.881250 14876 2 0.000000 -1 2.500000 24.108000 55.012243 36.881250 14877 2 0.000000 1 2.500000 17.220000 53.686647 40.393750 -14878 2 0.000000 -1.000000 2.500000 17.220000 53.686647 40.393750 +14878 2 0.000000 -1 2.500000 17.220000 53.686647 40.393750 14879 2 0.000000 1 2.500000 19.516000 49.709858 40.393750 14880 2 0.000000 -1 2.500000 19.516000 49.709858 40.393750 14881 2 0.000000 1 2.500000 21.812000 51.035454 43.906250 @@ -14899,7 +14899,7 @@ Atoms 14883 2 0.000000 1 2.500000 24.108000 55.012243 43.906250 14884 2 0.000000 -1 2.500000 24.108000 55.012243 43.906250 14885 2 0.000000 1 2.500000 17.220000 53.686647 47.418750 -14886 2 0.000000 -1.000000 2.500000 17.220000 53.686647 47.418750 +14886 2 0.000000 -1 2.500000 17.220000 53.686647 47.418750 14887 2 0.000000 1 2.500000 19.516000 49.709858 47.418750 14888 2 0.000000 -1 2.500000 19.516000 49.709858 47.418750 14889 2 0.000000 1 2.500000 21.812000 51.035454 50.931250 @@ -14907,7 +14907,7 @@ Atoms 14891 2 0.000000 1 2.500000 24.108000 55.012243 50.931250 14892 2 0.000000 -1 2.500000 24.108000 55.012243 50.931250 14893 2 0.000000 1 2.500000 17.220000 53.686647 54.443750 -14894 2 0.000000 -1.000000 2.500000 17.220000 53.686647 54.443750 +14894 2 0.000000 -1 2.500000 17.220000 53.686647 54.443750 14895 2 0.000000 1 2.500000 19.516000 49.709858 54.443750 14896 2 0.000000 -1 2.500000 19.516000 49.709858 54.443750 14897 2 0.000000 1 2.500000 21.812000 51.035454 57.956250 @@ -14915,7 +14915,7 @@ Atoms 14899 2 0.000000 1 2.500000 24.108000 55.012243 57.956250 14900 2 0.000000 -1 2.500000 24.108000 55.012243 57.956250 14901 2 0.000000 1 2.500000 17.220000 53.686647 61.468750 -14902 2 0.000000 -1.000000 2.500000 17.220000 53.686647 61.468750 +14902 2 0.000000 -1 2.500000 17.220000 53.686647 61.468750 14903 2 0.000000 1 2.500000 19.516000 49.709858 61.468750 14904 2 0.000000 -1 2.500000 19.516000 49.709858 61.468750 14905 2 0.000000 1 2.500000 21.812000 58.989032 1.756250 @@ -14923,7 +14923,7 @@ Atoms 14907 2 0.000000 1 2.500000 24.108000 62.965820 1.756250 14908 2 0.000000 -1 2.500000 24.108000 62.965820 1.756250 14909 2 0.000000 1 2.500000 17.220000 61.640224 5.268750 -14910 2 0.000000 -1.000000 2.500000 17.220000 61.640224 5.268750 +14910 2 0.000000 -1 2.500000 17.220000 61.640224 5.268750 14911 2 0.000000 1 2.500000 19.516000 57.663435 5.268750 14912 2 0.000000 -1 2.500000 19.516000 57.663435 5.268750 14913 2 0.000000 1 2.500000 21.812000 58.989032 8.781250 @@ -14931,7 +14931,7 @@ Atoms 14915 2 0.000000 1 2.500000 24.108000 62.965820 8.781250 14916 2 0.000000 -1 2.500000 24.108000 62.965820 8.781250 14917 2 0.000000 1 2.500000 17.220000 61.640224 12.293750 -14918 2 0.000000 -1.000000 2.500000 17.220000 61.640224 12.293750 +14918 2 0.000000 -1 2.500000 17.220000 61.640224 12.293750 14919 2 0.000000 1 2.500000 19.516000 57.663435 12.293750 14920 2 0.000000 -1 2.500000 19.516000 57.663435 12.293750 14921 2 0.000000 1 2.500000 21.812000 58.989032 15.806250 @@ -14939,7 +14939,7 @@ Atoms 14923 2 0.000000 1 2.500000 24.108000 62.965820 15.806250 14924 2 0.000000 -1 2.500000 24.108000 62.965820 15.806250 14925 2 0.000000 1 2.500000 17.220000 61.640224 19.318750 -14926 2 0.000000 -1.000000 2.500000 17.220000 61.640224 19.318750 +14926 2 0.000000 -1 2.500000 17.220000 61.640224 19.318750 14927 2 0.000000 1 2.500000 19.516000 57.663435 19.318750 14928 2 0.000000 -1 2.500000 19.516000 57.663435 19.318750 14929 2 0.000000 1 2.500000 21.812000 58.989032 22.831250 @@ -14947,7 +14947,7 @@ Atoms 14931 2 0.000000 1 2.500000 24.108000 62.965820 22.831250 14932 2 0.000000 -1 2.500000 24.108000 62.965820 22.831250 14933 2 0.000000 1 2.500000 17.220000 61.640224 26.343750 -14934 2 0.000000 -1.000000 2.500000 17.220000 61.640224 26.343750 +14934 2 0.000000 -1 2.500000 17.220000 61.640224 26.343750 14935 2 0.000000 1 2.500000 19.516000 57.663435 26.343750 14936 2 0.000000 -1 2.500000 19.516000 57.663435 26.343750 14937 2 0.000000 1 2.500000 21.812000 58.989032 29.856250 @@ -14955,7 +14955,7 @@ Atoms 14939 2 0.000000 1 2.500000 24.108000 62.965820 29.856250 14940 2 0.000000 -1 2.500000 24.108000 62.965820 29.856250 14941 2 0.000000 1 2.500000 17.220000 61.640224 33.368750 -14942 2 0.000000 -1.000000 2.500000 17.220000 61.640224 33.368750 +14942 2 0.000000 -1 2.500000 17.220000 61.640224 33.368750 14943 2 0.000000 1 2.500000 19.516000 57.663435 33.368750 14944 2 0.000000 -1 2.500000 19.516000 57.663435 33.368750 14945 2 0.000000 1 2.500000 21.812000 58.989032 36.881250 @@ -14963,7 +14963,7 @@ Atoms 14947 2 0.000000 1 2.500000 24.108000 62.965820 36.881250 14948 2 0.000000 -1 2.500000 24.108000 62.965820 36.881250 14949 2 0.000000 1 2.500000 17.220000 61.640224 40.393750 -14950 2 0.000000 -1.000000 2.500000 17.220000 61.640224 40.393750 +14950 2 0.000000 -1 2.500000 17.220000 61.640224 40.393750 14951 2 0.000000 1 2.500000 19.516000 57.663435 40.393750 14952 2 0.000000 -1 2.500000 19.516000 57.663435 40.393750 14953 2 0.000000 1 2.500000 21.812000 58.989032 43.906250 @@ -14971,7 +14971,7 @@ Atoms 14955 2 0.000000 1 2.500000 24.108000 62.965820 43.906250 14956 2 0.000000 -1 2.500000 24.108000 62.965820 43.906250 14957 2 0.000000 1 2.500000 17.220000 61.640224 47.418750 -14958 2 0.000000 -1.000000 2.500000 17.220000 61.640224 47.418750 +14958 2 0.000000 -1 2.500000 17.220000 61.640224 47.418750 14959 2 0.000000 1 2.500000 19.516000 57.663435 47.418750 14960 2 0.000000 -1 2.500000 19.516000 57.663435 47.418750 14961 2 0.000000 1 2.500000 21.812000 58.989032 50.931250 @@ -14979,7 +14979,7 @@ Atoms 14963 2 0.000000 1 2.500000 24.108000 62.965820 50.931250 14964 2 0.000000 -1 2.500000 24.108000 62.965820 50.931250 14965 2 0.000000 1 2.500000 17.220000 61.640224 54.443750 -14966 2 0.000000 -1.000000 2.500000 17.220000 61.640224 54.443750 +14966 2 0.000000 -1 2.500000 17.220000 61.640224 54.443750 14967 2 0.000000 1 2.500000 19.516000 57.663435 54.443750 14968 2 0.000000 -1 2.500000 19.516000 57.663435 54.443750 14969 2 0.000000 1 2.500000 21.812000 58.989032 57.956250 @@ -14987,7 +14987,7 @@ Atoms 14971 2 0.000000 1 2.500000 24.108000 62.965820 57.956250 14972 2 0.000000 -1 2.500000 24.108000 62.965820 57.956250 14973 2 0.000000 1 2.500000 17.220000 61.640224 61.468750 -14974 2 0.000000 -1.000000 2.500000 17.220000 61.640224 61.468750 +14974 2 0.000000 -1 2.500000 17.220000 61.640224 61.468750 14975 2 0.000000 1 2.500000 19.516000 57.663435 61.468750 14976 2 0.000000 -1 2.500000 19.516000 57.663435 61.468750 14977 2 0.000000 1 2.500000 26.404000 3.313991 1.756250 @@ -14995,7 +14995,7 @@ Atoms 14979 2 0.000000 1 2.500000 28.700000 7.290779 1.756250 14980 2 0.000000 -1 2.500000 28.700000 7.290779 1.756250 14981 2 0.000000 1 2.500000 21.812000 5.965183 5.268750 -14982 2 0.000000 -1.000000 2.500000 21.812000 5.965183 5.268750 +14982 2 0.000000 -1 2.500000 21.812000 5.965183 5.268750 14983 2 0.000000 1 2.500000 24.108000 1.988394 5.268750 14984 2 0.000000 -1 2.500000 24.108000 1.988394 5.268750 14985 2 0.000000 1 2.500000 26.404000 3.313991 8.781250 @@ -15003,7 +15003,7 @@ Atoms 14987 2 0.000000 1 2.500000 28.700000 7.290779 8.781250 14988 2 0.000000 -1 2.500000 28.700000 7.290779 8.781250 14989 2 0.000000 1 2.500000 21.812000 5.965183 12.293750 -14990 2 0.000000 -1.000000 2.500000 21.812000 5.965183 12.293750 +14990 2 0.000000 -1 2.500000 21.812000 5.965183 12.293750 14991 2 0.000000 1 2.500000 24.108000 1.988394 12.293750 14992 2 0.000000 -1 2.500000 24.108000 1.988394 12.293750 14993 2 0.000000 1 2.500000 26.404000 3.313991 15.806250 @@ -15011,7 +15011,7 @@ Atoms 14995 2 0.000000 1 2.500000 28.700000 7.290779 15.806250 14996 2 0.000000 -1 2.500000 28.700000 7.290779 15.806250 14997 2 0.000000 1 2.500000 21.812000 5.965183 19.318750 -14998 2 0.000000 -1.000000 2.500000 21.812000 5.965183 19.318750 +14998 2 0.000000 -1 2.500000 21.812000 5.965183 19.318750 14999 2 0.000000 1 2.500000 24.108000 1.988394 19.318750 15000 2 0.000000 -1 2.500000 24.108000 1.988394 19.318750 15001 2 0.000000 1 2.500000 26.404000 3.313991 22.831250 @@ -15019,7 +15019,7 @@ Atoms 15003 2 0.000000 1 2.500000 28.700000 7.290779 22.831250 15004 2 0.000000 -1 2.500000 28.700000 7.290779 22.831250 15005 2 0.000000 1 2.500000 21.812000 5.965183 26.343750 -15006 2 0.000000 -1.000000 2.500000 21.812000 5.965183 26.343750 +15006 2 0.000000 -1 2.500000 21.812000 5.965183 26.343750 15007 2 0.000000 1 2.500000 24.108000 1.988394 26.343750 15008 2 0.000000 -1 2.500000 24.108000 1.988394 26.343750 15009 2 0.000000 1 2.500000 26.404000 3.313991 29.856250 @@ -15027,7 +15027,7 @@ Atoms 15011 2 0.000000 1 2.500000 28.700000 7.290779 29.856250 15012 2 0.000000 -1 2.500000 28.700000 7.290779 29.856250 15013 2 0.000000 1 2.500000 21.812000 5.965183 33.368750 -15014 2 0.000000 -1.000000 2.500000 21.812000 5.965183 33.368750 +15014 2 0.000000 -1 2.500000 21.812000 5.965183 33.368750 15015 2 0.000000 1 2.500000 24.108000 1.988394 33.368750 15016 2 0.000000 -1 2.500000 24.108000 1.988394 33.368750 15017 2 0.000000 1 2.500000 26.404000 3.313991 36.881250 @@ -15035,7 +15035,7 @@ Atoms 15019 2 0.000000 1 2.500000 28.700000 7.290779 36.881250 15020 2 0.000000 -1 2.500000 28.700000 7.290779 36.881250 15021 2 0.000000 1 2.500000 21.812000 5.965183 40.393750 -15022 2 0.000000 -1.000000 2.500000 21.812000 5.965183 40.393750 +15022 2 0.000000 -1 2.500000 21.812000 5.965183 40.393750 15023 2 0.000000 1 2.500000 24.108000 1.988394 40.393750 15024 2 0.000000 -1 2.500000 24.108000 1.988394 40.393750 15025 2 0.000000 1 2.500000 26.404000 3.313991 43.906250 @@ -15043,7 +15043,7 @@ Atoms 15027 2 0.000000 1 2.500000 28.700000 7.290779 43.906250 15028 2 0.000000 -1 2.500000 28.700000 7.290779 43.906250 15029 2 0.000000 1 2.500000 21.812000 5.965183 47.418750 -15030 2 0.000000 -1.000000 2.500000 21.812000 5.965183 47.418750 +15030 2 0.000000 -1 2.500000 21.812000 5.965183 47.418750 15031 2 0.000000 1 2.500000 24.108000 1.988394 47.418750 15032 2 0.000000 -1 2.500000 24.108000 1.988394 47.418750 15033 2 0.000000 1 2.500000 26.404000 3.313991 50.931250 @@ -15051,7 +15051,7 @@ Atoms 15035 2 0.000000 1 2.500000 28.700000 7.290779 50.931250 15036 2 0.000000 -1 2.500000 28.700000 7.290779 50.931250 15037 2 0.000000 1 2.500000 21.812000 5.965183 54.443750 -15038 2 0.000000 -1.000000 2.500000 21.812000 5.965183 54.443750 +15038 2 0.000000 -1 2.500000 21.812000 5.965183 54.443750 15039 2 0.000000 1 2.500000 24.108000 1.988394 54.443750 15040 2 0.000000 -1 2.500000 24.108000 1.988394 54.443750 15041 2 0.000000 1 2.500000 26.404000 3.313991 57.956250 @@ -15059,7 +15059,7 @@ Atoms 15043 2 0.000000 1 2.500000 28.700000 7.290779 57.956250 15044 2 0.000000 -1 2.500000 28.700000 7.290779 57.956250 15045 2 0.000000 1 2.500000 21.812000 5.965183 61.468750 -15046 2 0.000000 -1.000000 2.500000 21.812000 5.965183 61.468750 +15046 2 0.000000 -1 2.500000 21.812000 5.965183 61.468750 15047 2 0.000000 1 2.500000 24.108000 1.988394 61.468750 15048 2 0.000000 -1 2.500000 24.108000 1.988394 61.468750 15049 2 0.000000 1 2.500000 26.404000 11.267568 1.756250 @@ -15067,7 +15067,7 @@ Atoms 15051 2 0.000000 1 2.500000 28.700000 15.244357 1.756250 15052 2 0.000000 -1 2.500000 28.700000 15.244357 1.756250 15053 2 0.000000 1 2.500000 21.812000 13.918760 5.268750 -15054 2 0.000000 -1.000000 2.500000 21.812000 13.918760 5.268750 +15054 2 0.000000 -1 2.500000 21.812000 13.918760 5.268750 15055 2 0.000000 1 2.500000 24.108000 9.941972 5.268750 15056 2 0.000000 -1 2.500000 24.108000 9.941972 5.268750 15057 2 0.000000 1 2.500000 26.404000 11.267568 8.781250 @@ -15075,7 +15075,7 @@ Atoms 15059 2 0.000000 1 2.500000 28.700000 15.244357 8.781250 15060 2 0.000000 -1 2.500000 28.700000 15.244357 8.781250 15061 2 0.000000 1 2.500000 21.812000 13.918760 12.293750 -15062 2 0.000000 -1.000000 2.500000 21.812000 13.918760 12.293750 +15062 2 0.000000 -1 2.500000 21.812000 13.918760 12.293750 15063 2 0.000000 1 2.500000 24.108000 9.941972 12.293750 15064 2 0.000000 -1 2.500000 24.108000 9.941972 12.293750 15065 2 0.000000 1 2.500000 26.404000 11.267568 15.806250 @@ -15083,7 +15083,7 @@ Atoms 15067 2 0.000000 1 2.500000 28.700000 15.244357 15.806250 15068 2 0.000000 -1 2.500000 28.700000 15.244357 15.806250 15069 2 0.000000 1 2.500000 21.812000 13.918760 19.318750 -15070 2 0.000000 -1.000000 2.500000 21.812000 13.918760 19.318750 +15070 2 0.000000 -1 2.500000 21.812000 13.918760 19.318750 15071 2 0.000000 1 2.500000 24.108000 9.941972 19.318750 15072 2 0.000000 -1 2.500000 24.108000 9.941972 19.318750 15073 2 0.000000 1 2.500000 26.404000 11.267568 22.831250 @@ -15091,7 +15091,7 @@ Atoms 15075 2 0.000000 1 2.500000 28.700000 15.244357 22.831250 15076 2 0.000000 -1 2.500000 28.700000 15.244357 22.831250 15077 2 0.000000 1 2.500000 21.812000 13.918760 26.343750 -15078 2 0.000000 -1.000000 2.500000 21.812000 13.918760 26.343750 +15078 2 0.000000 -1 2.500000 21.812000 13.918760 26.343750 15079 2 0.000000 1 2.500000 24.108000 9.941972 26.343750 15080 2 0.000000 -1 2.500000 24.108000 9.941972 26.343750 15081 2 0.000000 1 2.500000 26.404000 11.267568 29.856250 @@ -15099,7 +15099,7 @@ Atoms 15083 2 0.000000 1 2.500000 28.700000 15.244357 29.856250 15084 2 0.000000 -1 2.500000 28.700000 15.244357 29.856250 15085 2 0.000000 1 2.500000 21.812000 13.918760 33.368750 -15086 2 0.000000 -1.000000 2.500000 21.812000 13.918760 33.368750 +15086 2 0.000000 -1 2.500000 21.812000 13.918760 33.368750 15087 2 0.000000 1 2.500000 24.108000 9.941972 33.368750 15088 2 0.000000 -1 2.500000 24.108000 9.941972 33.368750 15089 2 0.000000 1 2.500000 26.404000 11.267568 36.881250 @@ -15107,7 +15107,7 @@ Atoms 15091 2 0.000000 1 2.500000 28.700000 15.244357 36.881250 15092 2 0.000000 -1 2.500000 28.700000 15.244357 36.881250 15093 2 0.000000 1 2.500000 21.812000 13.918760 40.393750 -15094 2 0.000000 -1.000000 2.500000 21.812000 13.918760 40.393750 +15094 2 0.000000 -1 2.500000 21.812000 13.918760 40.393750 15095 2 0.000000 1 2.500000 24.108000 9.941972 40.393750 15096 2 0.000000 -1 2.500000 24.108000 9.941972 40.393750 15097 2 0.000000 1 2.500000 26.404000 11.267568 43.906250 @@ -15115,7 +15115,7 @@ Atoms 15099 2 0.000000 1 2.500000 28.700000 15.244357 43.906250 15100 2 0.000000 -1 2.500000 28.700000 15.244357 43.906250 15101 2 0.000000 1 2.500000 21.812000 13.918760 47.418750 -15102 2 0.000000 -1.000000 2.500000 21.812000 13.918760 47.418750 +15102 2 0.000000 -1 2.500000 21.812000 13.918760 47.418750 15103 2 0.000000 1 2.500000 24.108000 9.941972 47.418750 15104 2 0.000000 -1 2.500000 24.108000 9.941972 47.418750 15105 2 0.000000 1 2.500000 26.404000 11.267568 50.931250 @@ -15123,7 +15123,7 @@ Atoms 15107 2 0.000000 1 2.500000 28.700000 15.244357 50.931250 15108 2 0.000000 -1 2.500000 28.700000 15.244357 50.931250 15109 2 0.000000 1 2.500000 21.812000 13.918760 54.443750 -15110 2 0.000000 -1.000000 2.500000 21.812000 13.918760 54.443750 +15110 2 0.000000 -1 2.500000 21.812000 13.918760 54.443750 15111 2 0.000000 1 2.500000 24.108000 9.941972 54.443750 15112 2 0.000000 -1 2.500000 24.108000 9.941972 54.443750 15113 2 0.000000 1 2.500000 26.404000 11.267568 57.956250 @@ -15131,7 +15131,7 @@ Atoms 15115 2 0.000000 1 2.500000 28.700000 15.244357 57.956250 15116 2 0.000000 -1 2.500000 28.700000 15.244357 57.956250 15117 2 0.000000 1 2.500000 21.812000 13.918760 61.468750 -15118 2 0.000000 -1.000000 2.500000 21.812000 13.918760 61.468750 +15118 2 0.000000 -1 2.500000 21.812000 13.918760 61.468750 15119 2 0.000000 1 2.500000 24.108000 9.941972 61.468750 15120 2 0.000000 -1 2.500000 24.108000 9.941972 61.468750 15121 2 0.000000 1 2.500000 26.404000 19.221145 1.756250 @@ -15139,7 +15139,7 @@ Atoms 15123 2 0.000000 1 2.500000 28.700000 23.197934 1.756250 15124 2 0.000000 -1 2.500000 28.700000 23.197934 1.756250 15125 2 0.000000 1 2.500000 21.812000 21.872338 5.268750 -15126 2 0.000000 -1.000000 2.500000 21.812000 21.872338 5.268750 +15126 2 0.000000 -1 2.500000 21.812000 21.872338 5.268750 15127 2 0.000000 1 2.500000 24.108000 17.895549 5.268750 15128 2 0.000000 -1 2.500000 24.108000 17.895549 5.268750 15129 2 0.000000 1 2.500000 26.404000 19.221145 8.781250 @@ -15147,7 +15147,7 @@ Atoms 15131 2 0.000000 1 2.500000 28.700000 23.197934 8.781250 15132 2 0.000000 -1 2.500000 28.700000 23.197934 8.781250 15133 2 0.000000 1 2.500000 21.812000 21.872338 12.293750 -15134 2 0.000000 -1.000000 2.500000 21.812000 21.872338 12.293750 +15134 2 0.000000 -1 2.500000 21.812000 21.872338 12.293750 15135 2 0.000000 1 2.500000 24.108000 17.895549 12.293750 15136 2 0.000000 -1 2.500000 24.108000 17.895549 12.293750 15137 2 0.000000 1 2.500000 26.404000 19.221145 15.806250 @@ -15155,7 +15155,7 @@ Atoms 15139 2 0.000000 1 2.500000 28.700000 23.197934 15.806250 15140 2 0.000000 -1 2.500000 28.700000 23.197934 15.806250 15141 2 0.000000 1 2.500000 21.812000 21.872338 19.318750 -15142 2 0.000000 -1.000000 2.500000 21.812000 21.872338 19.318750 +15142 2 0.000000 -1 2.500000 21.812000 21.872338 19.318750 15143 2 0.000000 1 2.500000 24.108000 17.895549 19.318750 15144 2 0.000000 -1 2.500000 24.108000 17.895549 19.318750 15145 2 0.000000 1 2.500000 26.404000 19.221145 22.831250 @@ -15163,7 +15163,7 @@ Atoms 15147 2 0.000000 1 2.500000 28.700000 23.197934 22.831250 15148 2 0.000000 -1 2.500000 28.700000 23.197934 22.831250 15149 2 0.000000 1 2.500000 21.812000 21.872338 26.343750 -15150 2 0.000000 -1.000000 2.500000 21.812000 21.872338 26.343750 +15150 2 0.000000 -1 2.500000 21.812000 21.872338 26.343750 15151 2 0.000000 1 2.500000 24.108000 17.895549 26.343750 15152 2 0.000000 -1 2.500000 24.108000 17.895549 26.343750 15153 2 0.000000 1 2.500000 26.404000 19.221145 29.856250 @@ -15171,7 +15171,7 @@ Atoms 15155 2 0.000000 1 2.500000 28.700000 23.197934 29.856250 15156 2 0.000000 -1 2.500000 28.700000 23.197934 29.856250 15157 2 0.000000 1 2.500000 21.812000 21.872338 33.368750 -15158 2 0.000000 -1.000000 2.500000 21.812000 21.872338 33.368750 +15158 2 0.000000 -1 2.500000 21.812000 21.872338 33.368750 15159 2 0.000000 1 2.500000 24.108000 17.895549 33.368750 15160 2 0.000000 -1 2.500000 24.108000 17.895549 33.368750 15161 2 0.000000 1 2.500000 26.404000 19.221145 36.881250 @@ -15179,7 +15179,7 @@ Atoms 15163 2 0.000000 1 2.500000 28.700000 23.197934 36.881250 15164 2 0.000000 -1 2.500000 28.700000 23.197934 36.881250 15165 2 0.000000 1 2.500000 21.812000 21.872338 40.393750 -15166 2 0.000000 -1.000000 2.500000 21.812000 21.872338 40.393750 +15166 2 0.000000 -1 2.500000 21.812000 21.872338 40.393750 15167 2 0.000000 1 2.500000 24.108000 17.895549 40.393750 15168 2 0.000000 -1 2.500000 24.108000 17.895549 40.393750 15169 2 0.000000 1 2.500000 26.404000 19.221145 43.906250 @@ -15187,7 +15187,7 @@ Atoms 15171 2 0.000000 1 2.500000 28.700000 23.197934 43.906250 15172 2 0.000000 -1 2.500000 28.700000 23.197934 43.906250 15173 2 0.000000 1 2.500000 21.812000 21.872338 47.418750 -15174 2 0.000000 -1.000000 2.500000 21.812000 21.872338 47.418750 +15174 2 0.000000 -1 2.500000 21.812000 21.872338 47.418750 15175 2 0.000000 1 2.500000 24.108000 17.895549 47.418750 15176 2 0.000000 -1 2.500000 24.108000 17.895549 47.418750 15177 2 0.000000 1 2.500000 26.404000 19.221145 50.931250 @@ -15195,7 +15195,7 @@ Atoms 15179 2 0.000000 1 2.500000 28.700000 23.197934 50.931250 15180 2 0.000000 -1 2.500000 28.700000 23.197934 50.931250 15181 2 0.000000 1 2.500000 21.812000 21.872338 54.443750 -15182 2 0.000000 -1.000000 2.500000 21.812000 21.872338 54.443750 +15182 2 0.000000 -1 2.500000 21.812000 21.872338 54.443750 15183 2 0.000000 1 2.500000 24.108000 17.895549 54.443750 15184 2 0.000000 -1 2.500000 24.108000 17.895549 54.443750 15185 2 0.000000 1 2.500000 26.404000 19.221145 57.956250 @@ -15203,7 +15203,7 @@ Atoms 15187 2 0.000000 1 2.500000 28.700000 23.197934 57.956250 15188 2 0.000000 -1 2.500000 28.700000 23.197934 57.956250 15189 2 0.000000 1 2.500000 21.812000 21.872338 61.468750 -15190 2 0.000000 -1.000000 2.500000 21.812000 21.872338 61.468750 +15190 2 0.000000 -1 2.500000 21.812000 21.872338 61.468750 15191 2 0.000000 1 2.500000 24.108000 17.895549 61.468750 15192 2 0.000000 -1 2.500000 24.108000 17.895549 61.468750 15193 2 0.000000 1 2.500000 26.404000 27.174722 1.756250 @@ -15211,7 +15211,7 @@ Atoms 15195 2 0.000000 1 2.500000 28.700000 31.151511 1.756250 15196 2 0.000000 -1 2.500000 28.700000 31.151511 1.756250 15197 2 0.000000 1 2.500000 21.812000 29.825915 5.268750 -15198 2 0.000000 -1.000000 2.500000 21.812000 29.825915 5.268750 +15198 2 0.000000 -1 2.500000 21.812000 29.825915 5.268750 15199 2 0.000000 1 2.500000 24.108000 25.849126 5.268750 15200 2 0.000000 -1 2.500000 24.108000 25.849126 5.268750 15201 2 0.000000 1 2.500000 26.404000 27.174722 8.781250 @@ -15219,7 +15219,7 @@ Atoms 15203 2 0.000000 1 2.500000 28.700000 31.151511 8.781250 15204 2 0.000000 -1 2.500000 28.700000 31.151511 8.781250 15205 2 0.000000 1 2.500000 21.812000 29.825915 12.293750 -15206 2 0.000000 -1.000000 2.500000 21.812000 29.825915 12.293750 +15206 2 0.000000 -1 2.500000 21.812000 29.825915 12.293750 15207 2 0.000000 1 2.500000 24.108000 25.849126 12.293750 15208 2 0.000000 -1 2.500000 24.108000 25.849126 12.293750 15209 2 0.000000 1 2.500000 26.404000 27.174722 15.806250 @@ -15227,7 +15227,7 @@ Atoms 15211 2 0.000000 1 2.500000 28.700000 31.151511 15.806250 15212 2 0.000000 -1 2.500000 28.700000 31.151511 15.806250 15213 2 0.000000 1 2.500000 21.812000 29.825915 19.318750 -15214 2 0.000000 -1.000000 2.500000 21.812000 29.825915 19.318750 +15214 2 0.000000 -1 2.500000 21.812000 29.825915 19.318750 15215 2 0.000000 1 2.500000 24.108000 25.849126 19.318750 15216 2 0.000000 -1 2.500000 24.108000 25.849126 19.318750 15217 2 0.000000 1 2.500000 26.404000 27.174722 22.831250 @@ -15235,7 +15235,7 @@ Atoms 15219 2 0.000000 1 2.500000 28.700000 31.151511 22.831250 15220 2 0.000000 -1 2.500000 28.700000 31.151511 22.831250 15221 2 0.000000 1 2.500000 21.812000 29.825915 26.343750 -15222 2 0.000000 -1.000000 2.500000 21.812000 29.825915 26.343750 +15222 2 0.000000 -1 2.500000 21.812000 29.825915 26.343750 15223 2 0.000000 1 2.500000 24.108000 25.849126 26.343750 15224 2 0.000000 -1 2.500000 24.108000 25.849126 26.343750 15225 2 0.000000 1 2.500000 26.404000 27.174722 29.856250 @@ -15243,7 +15243,7 @@ Atoms 15227 2 0.000000 1 2.500000 28.700000 31.151511 29.856250 15228 2 0.000000 -1 2.500000 28.700000 31.151511 29.856250 15229 2 0.000000 1 2.500000 21.812000 29.825915 33.368750 -15230 2 0.000000 -1.000000 2.500000 21.812000 29.825915 33.368750 +15230 2 0.000000 -1 2.500000 21.812000 29.825915 33.368750 15231 2 0.000000 1 2.500000 24.108000 25.849126 33.368750 15232 2 0.000000 -1 2.500000 24.108000 25.849126 33.368750 15233 2 0.000000 1 2.500000 26.404000 27.174722 36.881250 @@ -15251,7 +15251,7 @@ Atoms 15235 2 0.000000 1 2.500000 28.700000 31.151511 36.881250 15236 2 0.000000 -1 2.500000 28.700000 31.151511 36.881250 15237 2 0.000000 1 2.500000 21.812000 29.825915 40.393750 -15238 2 0.000000 -1.000000 2.500000 21.812000 29.825915 40.393750 +15238 2 0.000000 -1 2.500000 21.812000 29.825915 40.393750 15239 2 0.000000 1 2.500000 24.108000 25.849126 40.393750 15240 2 0.000000 -1 2.500000 24.108000 25.849126 40.393750 15241 2 0.000000 1 2.500000 26.404000 27.174722 43.906250 @@ -15259,7 +15259,7 @@ Atoms 15243 2 0.000000 1 2.500000 28.700000 31.151511 43.906250 15244 2 0.000000 -1 2.500000 28.700000 31.151511 43.906250 15245 2 0.000000 1 2.500000 21.812000 29.825915 47.418750 -15246 2 0.000000 -1.000000 2.500000 21.812000 29.825915 47.418750 +15246 2 0.000000 -1 2.500000 21.812000 29.825915 47.418750 15247 2 0.000000 1 2.500000 24.108000 25.849126 47.418750 15248 2 0.000000 -1 2.500000 24.108000 25.849126 47.418750 15249 2 0.000000 1 2.500000 26.404000 27.174722 50.931250 @@ -15267,7 +15267,7 @@ Atoms 15251 2 0.000000 1 2.500000 28.700000 31.151511 50.931250 15252 2 0.000000 -1 2.500000 28.700000 31.151511 50.931250 15253 2 0.000000 1 2.500000 21.812000 29.825915 54.443750 -15254 2 0.000000 -1.000000 2.500000 21.812000 29.825915 54.443750 +15254 2 0.000000 -1 2.500000 21.812000 29.825915 54.443750 15255 2 0.000000 1 2.500000 24.108000 25.849126 54.443750 15256 2 0.000000 -1 2.500000 24.108000 25.849126 54.443750 15257 2 0.000000 1 2.500000 26.404000 27.174722 57.956250 @@ -15275,7 +15275,7 @@ Atoms 15259 2 0.000000 1 2.500000 28.700000 31.151511 57.956250 15260 2 0.000000 -1 2.500000 28.700000 31.151511 57.956250 15261 2 0.000000 1 2.500000 21.812000 29.825915 61.468750 -15262 2 0.000000 -1.000000 2.500000 21.812000 29.825915 61.468750 +15262 2 0.000000 -1 2.500000 21.812000 29.825915 61.468750 15263 2 0.000000 1 2.500000 24.108000 25.849126 61.468750 15264 2 0.000000 -1 2.500000 24.108000 25.849126 61.468750 15265 2 0.000000 1 2.500000 26.404000 35.128300 1.756250 @@ -15283,7 +15283,7 @@ Atoms 15267 2 0.000000 1 2.500000 28.700000 39.105088 1.756250 15268 2 0.000000 -1 2.500000 28.700000 39.105088 1.756250 15269 2 0.000000 1 2.500000 21.812000 37.779492 5.268750 -15270 2 0.000000 -1.000000 2.500000 21.812000 37.779492 5.268750 +15270 2 0.000000 -1 2.500000 21.812000 37.779492 5.268750 15271 2 0.000000 1 2.500000 24.108000 33.802704 5.268750 15272 2 0.000000 -1 2.500000 24.108000 33.802704 5.268750 15273 2 0.000000 1 2.500000 26.404000 35.128300 8.781250 @@ -15291,7 +15291,7 @@ Atoms 15275 2 0.000000 1 2.500000 28.700000 39.105088 8.781250 15276 2 0.000000 -1 2.500000 28.700000 39.105088 8.781250 15277 2 0.000000 1 2.500000 21.812000 37.779492 12.293750 -15278 2 0.000000 -1.000000 2.500000 21.812000 37.779492 12.293750 +15278 2 0.000000 -1 2.500000 21.812000 37.779492 12.293750 15279 2 0.000000 1 2.500000 24.108000 33.802704 12.293750 15280 2 0.000000 -1 2.500000 24.108000 33.802704 12.293750 15281 2 0.000000 1 2.500000 26.404000 35.128300 15.806250 @@ -15299,7 +15299,7 @@ Atoms 15283 2 0.000000 1 2.500000 28.700000 39.105088 15.806250 15284 2 0.000000 -1 2.500000 28.700000 39.105088 15.806250 15285 2 0.000000 1 2.500000 21.812000 37.779492 19.318750 -15286 2 0.000000 -1.000000 2.500000 21.812000 37.779492 19.318750 +15286 2 0.000000 -1 2.500000 21.812000 37.779492 19.318750 15287 2 0.000000 1 2.500000 24.108000 33.802704 19.318750 15288 2 0.000000 -1 2.500000 24.108000 33.802704 19.318750 15289 2 0.000000 1 2.500000 26.404000 35.128300 22.831250 @@ -15307,7 +15307,7 @@ Atoms 15291 2 0.000000 1 2.500000 28.700000 39.105088 22.831250 15292 2 0.000000 -1 2.500000 28.700000 39.105088 22.831250 15293 2 0.000000 1 2.500000 21.812000 37.779492 26.343750 -15294 2 0.000000 -1.000000 2.500000 21.812000 37.779492 26.343750 +15294 2 0.000000 -1 2.500000 21.812000 37.779492 26.343750 15295 2 0.000000 1 2.500000 24.108000 33.802704 26.343750 15296 2 0.000000 -1 2.500000 24.108000 33.802704 26.343750 15297 2 0.000000 1 2.500000 26.404000 35.128300 29.856250 @@ -15315,7 +15315,7 @@ Atoms 15299 2 0.000000 1 2.500000 28.700000 39.105088 29.856250 15300 2 0.000000 -1 2.500000 28.700000 39.105088 29.856250 15301 2 0.000000 1 2.500000 21.812000 37.779492 33.368750 -15302 2 0.000000 -1.000000 2.500000 21.812000 37.779492 33.368750 +15302 2 0.000000 -1 2.500000 21.812000 37.779492 33.368750 15303 2 0.000000 1 2.500000 24.108000 33.802704 33.368750 15304 2 0.000000 -1 2.500000 24.108000 33.802704 33.368750 15305 2 0.000000 1 2.500000 26.404000 35.128300 36.881250 @@ -15323,7 +15323,7 @@ Atoms 15307 2 0.000000 1 2.500000 28.700000 39.105088 36.881250 15308 2 0.000000 -1 2.500000 28.700000 39.105088 36.881250 15309 2 0.000000 1 2.500000 21.812000 37.779492 40.393750 -15310 2 0.000000 -1.000000 2.500000 21.812000 37.779492 40.393750 +15310 2 0.000000 -1 2.500000 21.812000 37.779492 40.393750 15311 2 0.000000 1 2.500000 24.108000 33.802704 40.393750 15312 2 0.000000 -1 2.500000 24.108000 33.802704 40.393750 15313 2 0.000000 1 2.500000 26.404000 35.128300 43.906250 @@ -15331,7 +15331,7 @@ Atoms 15315 2 0.000000 1 2.500000 28.700000 39.105088 43.906250 15316 2 0.000000 -1 2.500000 28.700000 39.105088 43.906250 15317 2 0.000000 1 2.500000 21.812000 37.779492 47.418750 -15318 2 0.000000 -1.000000 2.500000 21.812000 37.779492 47.418750 +15318 2 0.000000 -1 2.500000 21.812000 37.779492 47.418750 15319 2 0.000000 1 2.500000 24.108000 33.802704 47.418750 15320 2 0.000000 -1 2.500000 24.108000 33.802704 47.418750 15321 2 0.000000 1 2.500000 26.404000 35.128300 50.931250 @@ -15339,7 +15339,7 @@ Atoms 15323 2 0.000000 1 2.500000 28.700000 39.105088 50.931250 15324 2 0.000000 -1 2.500000 28.700000 39.105088 50.931250 15325 2 0.000000 1 2.500000 21.812000 37.779492 54.443750 -15326 2 0.000000 -1.000000 2.500000 21.812000 37.779492 54.443750 +15326 2 0.000000 -1 2.500000 21.812000 37.779492 54.443750 15327 2 0.000000 1 2.500000 24.108000 33.802704 54.443750 15328 2 0.000000 -1 2.500000 24.108000 33.802704 54.443750 15329 2 0.000000 1 2.500000 26.404000 35.128300 57.956250 @@ -15347,7 +15347,7 @@ Atoms 15331 2 0.000000 1 2.500000 28.700000 39.105088 57.956250 15332 2 0.000000 -1 2.500000 28.700000 39.105088 57.956250 15333 2 0.000000 1 2.500000 21.812000 37.779492 61.468750 -15334 2 0.000000 -1.000000 2.500000 21.812000 37.779492 61.468750 +15334 2 0.000000 -1 2.500000 21.812000 37.779492 61.468750 15335 2 0.000000 1 2.500000 24.108000 33.802704 61.468750 15336 2 0.000000 -1 2.500000 24.108000 33.802704 61.468750 15337 2 0.000000 1 2.500000 26.404000 43.081877 1.756250 @@ -15355,7 +15355,7 @@ Atoms 15339 2 0.000000 1 2.500000 28.700000 47.058666 1.756250 15340 2 0.000000 -1 2.500000 28.700000 47.058666 1.756250 15341 2 0.000000 1 2.500000 21.812000 45.733070 5.268750 -15342 2 0.000000 -1.000000 2.500000 21.812000 45.733070 5.268750 +15342 2 0.000000 -1 2.500000 21.812000 45.733070 5.268750 15343 2 0.000000 1 2.500000 24.108000 41.756281 5.268750 15344 2 0.000000 -1 2.500000 24.108000 41.756281 5.268750 15345 2 0.000000 1 2.500000 26.404000 43.081877 8.781250 @@ -15363,7 +15363,7 @@ Atoms 15347 2 0.000000 1 2.500000 28.700000 47.058666 8.781250 15348 2 0.000000 -1 2.500000 28.700000 47.058666 8.781250 15349 2 0.000000 1 2.500000 21.812000 45.733070 12.293750 -15350 2 0.000000 -1.000000 2.500000 21.812000 45.733070 12.293750 +15350 2 0.000000 -1 2.500000 21.812000 45.733070 12.293750 15351 2 0.000000 1 2.500000 24.108000 41.756281 12.293750 15352 2 0.000000 -1 2.500000 24.108000 41.756281 12.293750 15353 2 0.000000 1 2.500000 26.404000 43.081877 15.806250 @@ -15371,7 +15371,7 @@ Atoms 15355 2 0.000000 1 2.500000 28.700000 47.058666 15.806250 15356 2 0.000000 -1 2.500000 28.700000 47.058666 15.806250 15357 2 0.000000 1 2.500000 21.812000 45.733070 19.318750 -15358 2 0.000000 -1.000000 2.500000 21.812000 45.733070 19.318750 +15358 2 0.000000 -1 2.500000 21.812000 45.733070 19.318750 15359 2 0.000000 1 2.500000 24.108000 41.756281 19.318750 15360 2 0.000000 -1 2.500000 24.108000 41.756281 19.318750 15361 2 0.000000 1 2.500000 26.404000 43.081877 22.831250 @@ -15379,7 +15379,7 @@ Atoms 15363 2 0.000000 1 2.500000 28.700000 47.058666 22.831250 15364 2 0.000000 -1 2.500000 28.700000 47.058666 22.831250 15365 2 0.000000 1 2.500000 21.812000 45.733070 26.343750 -15366 2 0.000000 -1.000000 2.500000 21.812000 45.733070 26.343750 +15366 2 0.000000 -1 2.500000 21.812000 45.733070 26.343750 15367 2 0.000000 1 2.500000 24.108000 41.756281 26.343750 15368 2 0.000000 -1 2.500000 24.108000 41.756281 26.343750 15369 2 0.000000 1 2.500000 26.404000 43.081877 29.856250 @@ -15387,7 +15387,7 @@ Atoms 15371 2 0.000000 1 2.500000 28.700000 47.058666 29.856250 15372 2 0.000000 -1 2.500000 28.700000 47.058666 29.856250 15373 2 0.000000 1 2.500000 21.812000 45.733070 33.368750 -15374 2 0.000000 -1.000000 2.500000 21.812000 45.733070 33.368750 +15374 2 0.000000 -1 2.500000 21.812000 45.733070 33.368750 15375 2 0.000000 1 2.500000 24.108000 41.756281 33.368750 15376 2 0.000000 -1 2.500000 24.108000 41.756281 33.368750 15377 2 0.000000 1 2.500000 26.404000 43.081877 36.881250 @@ -15395,7 +15395,7 @@ Atoms 15379 2 0.000000 1 2.500000 28.700000 47.058666 36.881250 15380 2 0.000000 -1 2.500000 28.700000 47.058666 36.881250 15381 2 0.000000 1 2.500000 21.812000 45.733070 40.393750 -15382 2 0.000000 -1.000000 2.500000 21.812000 45.733070 40.393750 +15382 2 0.000000 -1 2.500000 21.812000 45.733070 40.393750 15383 2 0.000000 1 2.500000 24.108000 41.756281 40.393750 15384 2 0.000000 -1 2.500000 24.108000 41.756281 40.393750 15385 2 0.000000 1 2.500000 26.404000 43.081877 43.906250 @@ -15403,7 +15403,7 @@ Atoms 15387 2 0.000000 1 2.500000 28.700000 47.058666 43.906250 15388 2 0.000000 -1 2.500000 28.700000 47.058666 43.906250 15389 2 0.000000 1 2.500000 21.812000 45.733070 47.418750 -15390 2 0.000000 -1.000000 2.500000 21.812000 45.733070 47.418750 +15390 2 0.000000 -1 2.500000 21.812000 45.733070 47.418750 15391 2 0.000000 1 2.500000 24.108000 41.756281 47.418750 15392 2 0.000000 -1 2.500000 24.108000 41.756281 47.418750 15393 2 0.000000 1 2.500000 26.404000 43.081877 50.931250 @@ -15411,7 +15411,7 @@ Atoms 15395 2 0.000000 1 2.500000 28.700000 47.058666 50.931250 15396 2 0.000000 -1 2.500000 28.700000 47.058666 50.931250 15397 2 0.000000 1 2.500000 21.812000 45.733070 54.443750 -15398 2 0.000000 -1.000000 2.500000 21.812000 45.733070 54.443750 +15398 2 0.000000 -1 2.500000 21.812000 45.733070 54.443750 15399 2 0.000000 1 2.500000 24.108000 41.756281 54.443750 15400 2 0.000000 -1 2.500000 24.108000 41.756281 54.443750 15401 2 0.000000 1 2.500000 26.404000 43.081877 57.956250 @@ -15419,7 +15419,7 @@ Atoms 15403 2 0.000000 1 2.500000 28.700000 47.058666 57.956250 15404 2 0.000000 -1 2.500000 28.700000 47.058666 57.956250 15405 2 0.000000 1 2.500000 21.812000 45.733070 61.468750 -15406 2 0.000000 -1.000000 2.500000 21.812000 45.733070 61.468750 +15406 2 0.000000 -1 2.500000 21.812000 45.733070 61.468750 15407 2 0.000000 1 2.500000 24.108000 41.756281 61.468750 15408 2 0.000000 -1 2.500000 24.108000 41.756281 61.468750 15409 2 0.000000 1 2.500000 26.404000 51.035454 1.756250 @@ -15427,7 +15427,7 @@ Atoms 15411 2 0.000000 1 2.500000 28.700000 55.012243 1.756250 15412 2 0.000000 -1 2.500000 28.700000 55.012243 1.756250 15413 2 0.000000 1 2.500000 21.812000 53.686647 5.268750 -15414 2 0.000000 -1.000000 2.500000 21.812000 53.686647 5.268750 +15414 2 0.000000 -1 2.500000 21.812000 53.686647 5.268750 15415 2 0.000000 1 2.500000 24.108000 49.709858 5.268750 15416 2 0.000000 -1 2.500000 24.108000 49.709858 5.268750 15417 2 0.000000 1 2.500000 26.404000 51.035454 8.781250 @@ -15435,7 +15435,7 @@ Atoms 15419 2 0.000000 1 2.500000 28.700000 55.012243 8.781250 15420 2 0.000000 -1 2.500000 28.700000 55.012243 8.781250 15421 2 0.000000 1 2.500000 21.812000 53.686647 12.293750 -15422 2 0.000000 -1.000000 2.500000 21.812000 53.686647 12.293750 +15422 2 0.000000 -1 2.500000 21.812000 53.686647 12.293750 15423 2 0.000000 1 2.500000 24.108000 49.709858 12.293750 15424 2 0.000000 -1 2.500000 24.108000 49.709858 12.293750 15425 2 0.000000 1 2.500000 26.404000 51.035454 15.806250 @@ -15443,7 +15443,7 @@ Atoms 15427 2 0.000000 1 2.500000 28.700000 55.012243 15.806250 15428 2 0.000000 -1 2.500000 28.700000 55.012243 15.806250 15429 2 0.000000 1 2.500000 21.812000 53.686647 19.318750 -15430 2 0.000000 -1.000000 2.500000 21.812000 53.686647 19.318750 +15430 2 0.000000 -1 2.500000 21.812000 53.686647 19.318750 15431 2 0.000000 1 2.500000 24.108000 49.709858 19.318750 15432 2 0.000000 -1 2.500000 24.108000 49.709858 19.318750 15433 2 0.000000 1 2.500000 26.404000 51.035454 22.831250 @@ -15451,7 +15451,7 @@ Atoms 15435 2 0.000000 1 2.500000 28.700000 55.012243 22.831250 15436 2 0.000000 -1 2.500000 28.700000 55.012243 22.831250 15437 2 0.000000 1 2.500000 21.812000 53.686647 26.343750 -15438 2 0.000000 -1.000000 2.500000 21.812000 53.686647 26.343750 +15438 2 0.000000 -1 2.500000 21.812000 53.686647 26.343750 15439 2 0.000000 1 2.500000 24.108000 49.709858 26.343750 15440 2 0.000000 -1 2.500000 24.108000 49.709858 26.343750 15441 2 0.000000 1 2.500000 26.404000 51.035454 29.856250 @@ -15459,7 +15459,7 @@ Atoms 15443 2 0.000000 1 2.500000 28.700000 55.012243 29.856250 15444 2 0.000000 -1 2.500000 28.700000 55.012243 29.856250 15445 2 0.000000 1 2.500000 21.812000 53.686647 33.368750 -15446 2 0.000000 -1.000000 2.500000 21.812000 53.686647 33.368750 +15446 2 0.000000 -1 2.500000 21.812000 53.686647 33.368750 15447 2 0.000000 1 2.500000 24.108000 49.709858 33.368750 15448 2 0.000000 -1 2.500000 24.108000 49.709858 33.368750 15449 2 0.000000 1 2.500000 26.404000 51.035454 36.881250 @@ -15467,7 +15467,7 @@ Atoms 15451 2 0.000000 1 2.500000 28.700000 55.012243 36.881250 15452 2 0.000000 -1 2.500000 28.700000 55.012243 36.881250 15453 2 0.000000 1 2.500000 21.812000 53.686647 40.393750 -15454 2 0.000000 -1.000000 2.500000 21.812000 53.686647 40.393750 +15454 2 0.000000 -1 2.500000 21.812000 53.686647 40.393750 15455 2 0.000000 1 2.500000 24.108000 49.709858 40.393750 15456 2 0.000000 -1 2.500000 24.108000 49.709858 40.393750 15457 2 0.000000 1 2.500000 26.404000 51.035454 43.906250 @@ -15475,7 +15475,7 @@ Atoms 15459 2 0.000000 1 2.500000 28.700000 55.012243 43.906250 15460 2 0.000000 -1 2.500000 28.700000 55.012243 43.906250 15461 2 0.000000 1 2.500000 21.812000 53.686647 47.418750 -15462 2 0.000000 -1.000000 2.500000 21.812000 53.686647 47.418750 +15462 2 0.000000 -1 2.500000 21.812000 53.686647 47.418750 15463 2 0.000000 1 2.500000 24.108000 49.709858 47.418750 15464 2 0.000000 -1 2.500000 24.108000 49.709858 47.418750 15465 2 0.000000 1 2.500000 26.404000 51.035454 50.931250 @@ -15483,7 +15483,7 @@ Atoms 15467 2 0.000000 1 2.500000 28.700000 55.012243 50.931250 15468 2 0.000000 -1 2.500000 28.700000 55.012243 50.931250 15469 2 0.000000 1 2.500000 21.812000 53.686647 54.443750 -15470 2 0.000000 -1.000000 2.500000 21.812000 53.686647 54.443750 +15470 2 0.000000 -1 2.500000 21.812000 53.686647 54.443750 15471 2 0.000000 1 2.500000 24.108000 49.709858 54.443750 15472 2 0.000000 -1 2.500000 24.108000 49.709858 54.443750 15473 2 0.000000 1 2.500000 26.404000 51.035454 57.956250 @@ -15491,7 +15491,7 @@ Atoms 15475 2 0.000000 1 2.500000 28.700000 55.012243 57.956250 15476 2 0.000000 -1 2.500000 28.700000 55.012243 57.956250 15477 2 0.000000 1 2.500000 21.812000 53.686647 61.468750 -15478 2 0.000000 -1.000000 2.500000 21.812000 53.686647 61.468750 +15478 2 0.000000 -1 2.500000 21.812000 53.686647 61.468750 15479 2 0.000000 1 2.500000 24.108000 49.709858 61.468750 15480 2 0.000000 -1 2.500000 24.108000 49.709858 61.468750 15481 2 0.000000 1 2.500000 26.404000 58.989032 1.756250 @@ -15499,7 +15499,7 @@ Atoms 15483 2 0.000000 1 2.500000 28.700000 62.965820 1.756250 15484 2 0.000000 -1 2.500000 28.700000 62.965820 1.756250 15485 2 0.000000 1 2.500000 21.812000 61.640224 5.268750 -15486 2 0.000000 -1.000000 2.500000 21.812000 61.640224 5.268750 +15486 2 0.000000 -1 2.500000 21.812000 61.640224 5.268750 15487 2 0.000000 1 2.500000 24.108000 57.663435 5.268750 15488 2 0.000000 -1 2.500000 24.108000 57.663435 5.268750 15489 2 0.000000 1 2.500000 26.404000 58.989032 8.781250 @@ -15507,7 +15507,7 @@ Atoms 15491 2 0.000000 1 2.500000 28.700000 62.965820 8.781250 15492 2 0.000000 -1 2.500000 28.700000 62.965820 8.781250 15493 2 0.000000 1 2.500000 21.812000 61.640224 12.293750 -15494 2 0.000000 -1.000000 2.500000 21.812000 61.640224 12.293750 +15494 2 0.000000 -1 2.500000 21.812000 61.640224 12.293750 15495 2 0.000000 1 2.500000 24.108000 57.663435 12.293750 15496 2 0.000000 -1 2.500000 24.108000 57.663435 12.293750 15497 2 0.000000 1 2.500000 26.404000 58.989032 15.806250 @@ -15515,7 +15515,7 @@ Atoms 15499 2 0.000000 1 2.500000 28.700000 62.965820 15.806250 15500 2 0.000000 -1 2.500000 28.700000 62.965820 15.806250 15501 2 0.000000 1 2.500000 21.812000 61.640224 19.318750 -15502 2 0.000000 -1.000000 2.500000 21.812000 61.640224 19.318750 +15502 2 0.000000 -1 2.500000 21.812000 61.640224 19.318750 15503 2 0.000000 1 2.500000 24.108000 57.663435 19.318750 15504 2 0.000000 -1 2.500000 24.108000 57.663435 19.318750 15505 2 0.000000 1 2.500000 26.404000 58.989032 22.831250 @@ -15523,7 +15523,7 @@ Atoms 15507 2 0.000000 1 2.500000 28.700000 62.965820 22.831250 15508 2 0.000000 -1 2.500000 28.700000 62.965820 22.831250 15509 2 0.000000 1 2.500000 21.812000 61.640224 26.343750 -15510 2 0.000000 -1.000000 2.500000 21.812000 61.640224 26.343750 +15510 2 0.000000 -1 2.500000 21.812000 61.640224 26.343750 15511 2 0.000000 1 2.500000 24.108000 57.663435 26.343750 15512 2 0.000000 -1 2.500000 24.108000 57.663435 26.343750 15513 2 0.000000 1 2.500000 26.404000 58.989032 29.856250 @@ -15531,7 +15531,7 @@ Atoms 15515 2 0.000000 1 2.500000 28.700000 62.965820 29.856250 15516 2 0.000000 -1 2.500000 28.700000 62.965820 29.856250 15517 2 0.000000 1 2.500000 21.812000 61.640224 33.368750 -15518 2 0.000000 -1.000000 2.500000 21.812000 61.640224 33.368750 +15518 2 0.000000 -1 2.500000 21.812000 61.640224 33.368750 15519 2 0.000000 1 2.500000 24.108000 57.663435 33.368750 15520 2 0.000000 -1 2.500000 24.108000 57.663435 33.368750 15521 2 0.000000 1 2.500000 26.404000 58.989032 36.881250 @@ -15539,7 +15539,7 @@ Atoms 15523 2 0.000000 1 2.500000 28.700000 62.965820 36.881250 15524 2 0.000000 -1 2.500000 28.700000 62.965820 36.881250 15525 2 0.000000 1 2.500000 21.812000 61.640224 40.393750 -15526 2 0.000000 -1.000000 2.500000 21.812000 61.640224 40.393750 +15526 2 0.000000 -1 2.500000 21.812000 61.640224 40.393750 15527 2 0.000000 1 2.500000 24.108000 57.663435 40.393750 15528 2 0.000000 -1 2.500000 24.108000 57.663435 40.393750 15529 2 0.000000 1 2.500000 26.404000 58.989032 43.906250 @@ -15547,7 +15547,7 @@ Atoms 15531 2 0.000000 1 2.500000 28.700000 62.965820 43.906250 15532 2 0.000000 -1 2.500000 28.700000 62.965820 43.906250 15533 2 0.000000 1 2.500000 21.812000 61.640224 47.418750 -15534 2 0.000000 -1.000000 2.500000 21.812000 61.640224 47.418750 +15534 2 0.000000 -1 2.500000 21.812000 61.640224 47.418750 15535 2 0.000000 1 2.500000 24.108000 57.663435 47.418750 15536 2 0.000000 -1 2.500000 24.108000 57.663435 47.418750 15537 2 0.000000 1 2.500000 26.404000 58.989032 50.931250 @@ -15555,7 +15555,7 @@ Atoms 15539 2 0.000000 1 2.500000 28.700000 62.965820 50.931250 15540 2 0.000000 -1 2.500000 28.700000 62.965820 50.931250 15541 2 0.000000 1 2.500000 21.812000 61.640224 54.443750 -15542 2 0.000000 -1.000000 2.500000 21.812000 61.640224 54.443750 +15542 2 0.000000 -1 2.500000 21.812000 61.640224 54.443750 15543 2 0.000000 1 2.500000 24.108000 57.663435 54.443750 15544 2 0.000000 -1 2.500000 24.108000 57.663435 54.443750 15545 2 0.000000 1 2.500000 26.404000 58.989032 57.956250 @@ -15563,7 +15563,7 @@ Atoms 15547 2 0.000000 1 2.500000 28.700000 62.965820 57.956250 15548 2 0.000000 -1 2.500000 28.700000 62.965820 57.956250 15549 2 0.000000 1 2.500000 21.812000 61.640224 61.468750 -15550 2 0.000000 -1.000000 2.500000 21.812000 61.640224 61.468750 +15550 2 0.000000 -1 2.500000 21.812000 61.640224 61.468750 15551 2 0.000000 1 2.500000 24.108000 57.663435 61.468750 15552 2 0.000000 -1 2.500000 24.108000 57.663435 61.468750 15553 2 0.000000 1 2.500000 30.996000 3.313991 1.756250 @@ -15571,7 +15571,7 @@ Atoms 15555 2 0.000000 1 2.500000 33.292000 7.290779 1.756250 15556 2 0.000000 -1 2.500000 33.292000 7.290779 1.756250 15557 2 0.000000 1 2.500000 26.404000 5.965183 5.268750 -15558 2 0.000000 -1.000000 2.500000 26.404000 5.965183 5.268750 +15558 2 0.000000 -1 2.500000 26.404000 5.965183 5.268750 15559 2 0.000000 1 2.500000 28.700000 1.988394 5.268750 15560 2 0.000000 -1 2.500000 28.700000 1.988394 5.268750 15561 2 0.000000 1 2.500000 30.996000 3.313991 8.781250 @@ -15579,7 +15579,7 @@ Atoms 15563 2 0.000000 1 2.500000 33.292000 7.290779 8.781250 15564 2 0.000000 -1 2.500000 33.292000 7.290779 8.781250 15565 2 0.000000 1 2.500000 26.404000 5.965183 12.293750 -15566 2 0.000000 -1.000000 2.500000 26.404000 5.965183 12.293750 +15566 2 0.000000 -1 2.500000 26.404000 5.965183 12.293750 15567 2 0.000000 1 2.500000 28.700000 1.988394 12.293750 15568 2 0.000000 -1 2.500000 28.700000 1.988394 12.293750 15569 2 0.000000 1 2.500000 30.996000 3.313991 15.806250 @@ -15587,7 +15587,7 @@ Atoms 15571 2 0.000000 1 2.500000 33.292000 7.290779 15.806250 15572 2 0.000000 -1 2.500000 33.292000 7.290779 15.806250 15573 2 0.000000 1 2.500000 26.404000 5.965183 19.318750 -15574 2 0.000000 -1.000000 2.500000 26.404000 5.965183 19.318750 +15574 2 0.000000 -1 2.500000 26.404000 5.965183 19.318750 15575 2 0.000000 1 2.500000 28.700000 1.988394 19.318750 15576 2 0.000000 -1 2.500000 28.700000 1.988394 19.318750 15577 2 0.000000 1 2.500000 30.996000 3.313991 22.831250 @@ -15595,7 +15595,7 @@ Atoms 15579 2 0.000000 1 2.500000 33.292000 7.290779 22.831250 15580 2 0.000000 -1 2.500000 33.292000 7.290779 22.831250 15581 2 0.000000 1 2.500000 26.404000 5.965183 26.343750 -15582 2 0.000000 -1.000000 2.500000 26.404000 5.965183 26.343750 +15582 2 0.000000 -1 2.500000 26.404000 5.965183 26.343750 15583 2 0.000000 1 2.500000 28.700000 1.988394 26.343750 15584 2 0.000000 -1 2.500000 28.700000 1.988394 26.343750 15585 2 0.000000 1 2.500000 30.996000 3.313991 29.856250 @@ -15603,7 +15603,7 @@ Atoms 15587 2 0.000000 1 2.500000 33.292000 7.290779 29.856250 15588 2 0.000000 -1 2.500000 33.292000 7.290779 29.856250 15589 2 0.000000 1 2.500000 26.404000 5.965183 33.368750 -15590 2 0.000000 -1.000000 2.500000 26.404000 5.965183 33.368750 +15590 2 0.000000 -1 2.500000 26.404000 5.965183 33.368750 15591 2 0.000000 1 2.500000 28.700000 1.988394 33.368750 15592 2 0.000000 -1 2.500000 28.700000 1.988394 33.368750 15593 2 0.000000 1 2.500000 30.996000 3.313991 36.881250 @@ -15611,7 +15611,7 @@ Atoms 15595 2 0.000000 1 2.500000 33.292000 7.290779 36.881250 15596 2 0.000000 -1 2.500000 33.292000 7.290779 36.881250 15597 2 0.000000 1 2.500000 26.404000 5.965183 40.393750 -15598 2 0.000000 -1.000000 2.500000 26.404000 5.965183 40.393750 +15598 2 0.000000 -1 2.500000 26.404000 5.965183 40.393750 15599 2 0.000000 1 2.500000 28.700000 1.988394 40.393750 15600 2 0.000000 -1 2.500000 28.700000 1.988394 40.393750 15601 2 0.000000 1 2.500000 30.996000 3.313991 43.906250 @@ -15619,7 +15619,7 @@ Atoms 15603 2 0.000000 1 2.500000 33.292000 7.290779 43.906250 15604 2 0.000000 -1 2.500000 33.292000 7.290779 43.906250 15605 2 0.000000 1 2.500000 26.404000 5.965183 47.418750 -15606 2 0.000000 -1.000000 2.500000 26.404000 5.965183 47.418750 +15606 2 0.000000 -1 2.500000 26.404000 5.965183 47.418750 15607 2 0.000000 1 2.500000 28.700000 1.988394 47.418750 15608 2 0.000000 -1 2.500000 28.700000 1.988394 47.418750 15609 2 0.000000 1 2.500000 30.996000 3.313991 50.931250 @@ -15627,7 +15627,7 @@ Atoms 15611 2 0.000000 1 2.500000 33.292000 7.290779 50.931250 15612 2 0.000000 -1 2.500000 33.292000 7.290779 50.931250 15613 2 0.000000 1 2.500000 26.404000 5.965183 54.443750 -15614 2 0.000000 -1.000000 2.500000 26.404000 5.965183 54.443750 +15614 2 0.000000 -1 2.500000 26.404000 5.965183 54.443750 15615 2 0.000000 1 2.500000 28.700000 1.988394 54.443750 15616 2 0.000000 -1 2.500000 28.700000 1.988394 54.443750 15617 2 0.000000 1 2.500000 30.996000 3.313991 57.956250 @@ -15635,7 +15635,7 @@ Atoms 15619 2 0.000000 1 2.500000 33.292000 7.290779 57.956250 15620 2 0.000000 -1 2.500000 33.292000 7.290779 57.956250 15621 2 0.000000 1 2.500000 26.404000 5.965183 61.468750 -15622 2 0.000000 -1.000000 2.500000 26.404000 5.965183 61.468750 +15622 2 0.000000 -1 2.500000 26.404000 5.965183 61.468750 15623 2 0.000000 1 2.500000 28.700000 1.988394 61.468750 15624 2 0.000000 -1 2.500000 28.700000 1.988394 61.468750 15625 2 0.000000 1 2.500000 30.996000 11.267568 1.756250 @@ -15643,7 +15643,7 @@ Atoms 15627 2 0.000000 1 2.500000 33.292000 15.244357 1.756250 15628 2 0.000000 -1 2.500000 33.292000 15.244357 1.756250 15629 2 0.000000 1 2.500000 26.404000 13.918760 5.268750 -15630 2 0.000000 -1.000000 2.500000 26.404000 13.918760 5.268750 +15630 2 0.000000 -1 2.500000 26.404000 13.918760 5.268750 15631 2 0.000000 1 2.500000 28.700000 9.941972 5.268750 15632 2 0.000000 -1 2.500000 28.700000 9.941972 5.268750 15633 2 0.000000 1 2.500000 30.996000 11.267568 8.781250 @@ -15651,7 +15651,7 @@ Atoms 15635 2 0.000000 1 2.500000 33.292000 15.244357 8.781250 15636 2 0.000000 -1 2.500000 33.292000 15.244357 8.781250 15637 2 0.000000 1 2.500000 26.404000 13.918760 12.293750 -15638 2 0.000000 -1.000000 2.500000 26.404000 13.918760 12.293750 +15638 2 0.000000 -1 2.500000 26.404000 13.918760 12.293750 15639 2 0.000000 1 2.500000 28.700000 9.941972 12.293750 15640 2 0.000000 -1 2.500000 28.700000 9.941972 12.293750 15641 2 0.000000 1 2.500000 30.996000 11.267568 15.806250 @@ -15659,7 +15659,7 @@ Atoms 15643 2 0.000000 1 2.500000 33.292000 15.244357 15.806250 15644 2 0.000000 -1 2.500000 33.292000 15.244357 15.806250 15645 2 0.000000 1 2.500000 26.404000 13.918760 19.318750 -15646 2 0.000000 -1.000000 2.500000 26.404000 13.918760 19.318750 +15646 2 0.000000 -1 2.500000 26.404000 13.918760 19.318750 15647 2 0.000000 1 2.500000 28.700000 9.941972 19.318750 15648 2 0.000000 -1 2.500000 28.700000 9.941972 19.318750 15649 2 0.000000 1 2.500000 30.996000 11.267568 22.831250 @@ -15667,7 +15667,7 @@ Atoms 15651 2 0.000000 1 2.500000 33.292000 15.244357 22.831250 15652 2 0.000000 -1 2.500000 33.292000 15.244357 22.831250 15653 2 0.000000 1 2.500000 26.404000 13.918760 26.343750 -15654 2 0.000000 -1.000000 2.500000 26.404000 13.918760 26.343750 +15654 2 0.000000 -1 2.500000 26.404000 13.918760 26.343750 15655 2 0.000000 1 2.500000 28.700000 9.941972 26.343750 15656 2 0.000000 -1 2.500000 28.700000 9.941972 26.343750 15657 2 0.000000 1 2.500000 30.996000 11.267568 29.856250 @@ -15675,7 +15675,7 @@ Atoms 15659 2 0.000000 1 2.500000 33.292000 15.244357 29.856250 15660 2 0.000000 -1 2.500000 33.292000 15.244357 29.856250 15661 2 0.000000 1 2.500000 26.404000 13.918760 33.368750 -15662 2 0.000000 -1.000000 2.500000 26.404000 13.918760 33.368750 +15662 2 0.000000 -1 2.500000 26.404000 13.918760 33.368750 15663 2 0.000000 1 2.500000 28.700000 9.941972 33.368750 15664 2 0.000000 -1 2.500000 28.700000 9.941972 33.368750 15665 2 0.000000 1 2.500000 30.996000 11.267568 36.881250 @@ -15683,7 +15683,7 @@ Atoms 15667 2 0.000000 1 2.500000 33.292000 15.244357 36.881250 15668 2 0.000000 -1 2.500000 33.292000 15.244357 36.881250 15669 2 0.000000 1 2.500000 26.404000 13.918760 40.393750 -15670 2 0.000000 -1.000000 2.500000 26.404000 13.918760 40.393750 +15670 2 0.000000 -1 2.500000 26.404000 13.918760 40.393750 15671 2 0.000000 1 2.500000 28.700000 9.941972 40.393750 15672 2 0.000000 -1 2.500000 28.700000 9.941972 40.393750 15673 2 0.000000 1 2.500000 30.996000 11.267568 43.906250 @@ -15691,7 +15691,7 @@ Atoms 15675 2 0.000000 1 2.500000 33.292000 15.244357 43.906250 15676 2 0.000000 -1 2.500000 33.292000 15.244357 43.906250 15677 2 0.000000 1 2.500000 26.404000 13.918760 47.418750 -15678 2 0.000000 -1.000000 2.500000 26.404000 13.918760 47.418750 +15678 2 0.000000 -1 2.500000 26.404000 13.918760 47.418750 15679 2 0.000000 1 2.500000 28.700000 9.941972 47.418750 15680 2 0.000000 -1 2.500000 28.700000 9.941972 47.418750 15681 2 0.000000 1 2.500000 30.996000 11.267568 50.931250 @@ -15699,7 +15699,7 @@ Atoms 15683 2 0.000000 1 2.500000 33.292000 15.244357 50.931250 15684 2 0.000000 -1 2.500000 33.292000 15.244357 50.931250 15685 2 0.000000 1 2.500000 26.404000 13.918760 54.443750 -15686 2 0.000000 -1.000000 2.500000 26.404000 13.918760 54.443750 +15686 2 0.000000 -1 2.500000 26.404000 13.918760 54.443750 15687 2 0.000000 1 2.500000 28.700000 9.941972 54.443750 15688 2 0.000000 -1 2.500000 28.700000 9.941972 54.443750 15689 2 0.000000 1 2.500000 30.996000 11.267568 57.956250 @@ -15707,7 +15707,7 @@ Atoms 15691 2 0.000000 1 2.500000 33.292000 15.244357 57.956250 15692 2 0.000000 -1 2.500000 33.292000 15.244357 57.956250 15693 2 0.000000 1 2.500000 26.404000 13.918760 61.468750 -15694 2 0.000000 -1.000000 2.500000 26.404000 13.918760 61.468750 +15694 2 0.000000 -1 2.500000 26.404000 13.918760 61.468750 15695 2 0.000000 1 2.500000 28.700000 9.941972 61.468750 15696 2 0.000000 -1 2.500000 28.700000 9.941972 61.468750 15697 2 0.000000 1 2.500000 30.996000 19.221145 1.756250 @@ -15715,7 +15715,7 @@ Atoms 15699 2 0.000000 1 2.500000 33.292000 23.197934 1.756250 15700 2 0.000000 -1 2.500000 33.292000 23.197934 1.756250 15701 2 0.000000 1 2.500000 26.404000 21.872338 5.268750 -15702 2 0.000000 -1.000000 2.500000 26.404000 21.872338 5.268750 +15702 2 0.000000 -1 2.500000 26.404000 21.872338 5.268750 15703 2 0.000000 1 2.500000 28.700000 17.895549 5.268750 15704 2 0.000000 -1 2.500000 28.700000 17.895549 5.268750 15705 2 0.000000 1 2.500000 30.996000 19.221145 8.781250 @@ -15723,7 +15723,7 @@ Atoms 15707 2 0.000000 1 2.500000 33.292000 23.197934 8.781250 15708 2 0.000000 -1 2.500000 33.292000 23.197934 8.781250 15709 2 0.000000 1 2.500000 26.404000 21.872338 12.293750 -15710 2 0.000000 -1.000000 2.500000 26.404000 21.872338 12.293750 +15710 2 0.000000 -1 2.500000 26.404000 21.872338 12.293750 15711 2 0.000000 1 2.500000 28.700000 17.895549 12.293750 15712 2 0.000000 -1 2.500000 28.700000 17.895549 12.293750 15713 2 0.000000 1 2.500000 30.996000 19.221145 15.806250 @@ -15731,7 +15731,7 @@ Atoms 15715 2 0.000000 1 2.500000 33.292000 23.197934 15.806250 15716 2 0.000000 -1 2.500000 33.292000 23.197934 15.806250 15717 2 0.000000 1 2.500000 26.404000 21.872338 19.318750 -15718 2 0.000000 -1.000000 2.500000 26.404000 21.872338 19.318750 +15718 2 0.000000 -1 2.500000 26.404000 21.872338 19.318750 15719 2 0.000000 1 2.500000 28.700000 17.895549 19.318750 15720 2 0.000000 -1 2.500000 28.700000 17.895549 19.318750 15721 2 0.000000 1 2.500000 30.996000 19.221145 22.831250 @@ -15739,7 +15739,7 @@ Atoms 15723 2 0.000000 1 2.500000 33.292000 23.197934 22.831250 15724 2 0.000000 -1 2.500000 33.292000 23.197934 22.831250 15725 2 0.000000 1 2.500000 26.404000 21.872338 26.343750 -15726 2 0.000000 -1.000000 2.500000 26.404000 21.872338 26.343750 +15726 2 0.000000 -1 2.500000 26.404000 21.872338 26.343750 15727 2 0.000000 1 2.500000 28.700000 17.895549 26.343750 15728 2 0.000000 -1 2.500000 28.700000 17.895549 26.343750 15729 2 0.000000 1 2.500000 30.996000 19.221145 29.856250 @@ -15747,7 +15747,7 @@ Atoms 15731 2 0.000000 1 2.500000 33.292000 23.197934 29.856250 15732 2 0.000000 -1 2.500000 33.292000 23.197934 29.856250 15733 2 0.000000 1 2.500000 26.404000 21.872338 33.368750 -15734 2 0.000000 -1.000000 2.500000 26.404000 21.872338 33.368750 +15734 2 0.000000 -1 2.500000 26.404000 21.872338 33.368750 15735 2 0.000000 1 2.500000 28.700000 17.895549 33.368750 15736 2 0.000000 -1 2.500000 28.700000 17.895549 33.368750 15737 2 0.000000 1 2.500000 30.996000 19.221145 36.881250 @@ -15755,7 +15755,7 @@ Atoms 15739 2 0.000000 1 2.500000 33.292000 23.197934 36.881250 15740 2 0.000000 -1 2.500000 33.292000 23.197934 36.881250 15741 2 0.000000 1 2.500000 26.404000 21.872338 40.393750 -15742 2 0.000000 -1.000000 2.500000 26.404000 21.872338 40.393750 +15742 2 0.000000 -1 2.500000 26.404000 21.872338 40.393750 15743 2 0.000000 1 2.500000 28.700000 17.895549 40.393750 15744 2 0.000000 -1 2.500000 28.700000 17.895549 40.393750 15745 2 0.000000 1 2.500000 30.996000 19.221145 43.906250 @@ -15763,7 +15763,7 @@ Atoms 15747 2 0.000000 1 2.500000 33.292000 23.197934 43.906250 15748 2 0.000000 -1 2.500000 33.292000 23.197934 43.906250 15749 2 0.000000 1 2.500000 26.404000 21.872338 47.418750 -15750 2 0.000000 -1.000000 2.500000 26.404000 21.872338 47.418750 +15750 2 0.000000 -1 2.500000 26.404000 21.872338 47.418750 15751 2 0.000000 1 2.500000 28.700000 17.895549 47.418750 15752 2 0.000000 -1 2.500000 28.700000 17.895549 47.418750 15753 2 0.000000 1 2.500000 30.996000 19.221145 50.931250 @@ -15771,7 +15771,7 @@ Atoms 15755 2 0.000000 1 2.500000 33.292000 23.197934 50.931250 15756 2 0.000000 -1 2.500000 33.292000 23.197934 50.931250 15757 2 0.000000 1 2.500000 26.404000 21.872338 54.443750 -15758 2 0.000000 -1.000000 2.500000 26.404000 21.872338 54.443750 +15758 2 0.000000 -1 2.500000 26.404000 21.872338 54.443750 15759 2 0.000000 1 2.500000 28.700000 17.895549 54.443750 15760 2 0.000000 -1 2.500000 28.700000 17.895549 54.443750 15761 2 0.000000 1 2.500000 30.996000 19.221145 57.956250 @@ -15779,7 +15779,7 @@ Atoms 15763 2 0.000000 1 2.500000 33.292000 23.197934 57.956250 15764 2 0.000000 -1 2.500000 33.292000 23.197934 57.956250 15765 2 0.000000 1 2.500000 26.404000 21.872338 61.468750 -15766 2 0.000000 -1.000000 2.500000 26.404000 21.872338 61.468750 +15766 2 0.000000 -1 2.500000 26.404000 21.872338 61.468750 15767 2 0.000000 1 2.500000 28.700000 17.895549 61.468750 15768 2 0.000000 -1 2.500000 28.700000 17.895549 61.468750 15769 2 0.000000 1 2.500000 30.996000 27.174722 1.756250 @@ -15787,7 +15787,7 @@ Atoms 15771 2 0.000000 1 2.500000 33.292000 31.151511 1.756250 15772 2 0.000000 -1 2.500000 33.292000 31.151511 1.756250 15773 2 0.000000 1 2.500000 26.404000 29.825915 5.268750 -15774 2 0.000000 -1.000000 2.500000 26.404000 29.825915 5.268750 +15774 2 0.000000 -1 2.500000 26.404000 29.825915 5.268750 15775 2 0.000000 1 2.500000 28.700000 25.849126 5.268750 15776 2 0.000000 -1 2.500000 28.700000 25.849126 5.268750 15777 2 0.000000 1 2.500000 30.996000 27.174722 8.781250 @@ -15795,7 +15795,7 @@ Atoms 15779 2 0.000000 1 2.500000 33.292000 31.151511 8.781250 15780 2 0.000000 -1 2.500000 33.292000 31.151511 8.781250 15781 2 0.000000 1 2.500000 26.404000 29.825915 12.293750 -15782 2 0.000000 -1.000000 2.500000 26.404000 29.825915 12.293750 +15782 2 0.000000 -1 2.500000 26.404000 29.825915 12.293750 15783 2 0.000000 1 2.500000 28.700000 25.849126 12.293750 15784 2 0.000000 -1 2.500000 28.700000 25.849126 12.293750 15785 2 0.000000 1 2.500000 30.996000 27.174722 15.806250 @@ -15803,7 +15803,7 @@ Atoms 15787 2 0.000000 1 2.500000 33.292000 31.151511 15.806250 15788 2 0.000000 -1 2.500000 33.292000 31.151511 15.806250 15789 2 0.000000 1 2.500000 26.404000 29.825915 19.318750 -15790 2 0.000000 -1.000000 2.500000 26.404000 29.825915 19.318750 +15790 2 0.000000 -1 2.500000 26.404000 29.825915 19.318750 15791 2 0.000000 1 2.500000 28.700000 25.849126 19.318750 15792 2 0.000000 -1 2.500000 28.700000 25.849126 19.318750 15793 2 0.000000 1 2.500000 30.996000 27.174722 22.831250 @@ -15811,7 +15811,7 @@ Atoms 15795 2 0.000000 1 2.500000 33.292000 31.151511 22.831250 15796 2 0.000000 -1 2.500000 33.292000 31.151511 22.831250 15797 2 0.000000 1 2.500000 26.404000 29.825915 26.343750 -15798 2 0.000000 -1.000000 2.500000 26.404000 29.825915 26.343750 +15798 2 0.000000 -1 2.500000 26.404000 29.825915 26.343750 15799 2 0.000000 1 2.500000 28.700000 25.849126 26.343750 15800 2 0.000000 -1 2.500000 28.700000 25.849126 26.343750 15801 2 0.000000 1 2.500000 30.996000 27.174722 29.856250 @@ -15819,7 +15819,7 @@ Atoms 15803 2 0.000000 1 2.500000 33.292000 31.151511 29.856250 15804 2 0.000000 -1 2.500000 33.292000 31.151511 29.856250 15805 2 0.000000 1 2.500000 26.404000 29.825915 33.368750 -15806 2 0.000000 -1.000000 2.500000 26.404000 29.825915 33.368750 +15806 2 0.000000 -1 2.500000 26.404000 29.825915 33.368750 15807 2 0.000000 1 2.500000 28.700000 25.849126 33.368750 15808 2 0.000000 -1 2.500000 28.700000 25.849126 33.368750 15809 2 0.000000 1 2.500000 30.996000 27.174722 36.881250 @@ -15827,7 +15827,7 @@ Atoms 15811 2 0.000000 1 2.500000 33.292000 31.151511 36.881250 15812 2 0.000000 -1 2.500000 33.292000 31.151511 36.881250 15813 2 0.000000 1 2.500000 26.404000 29.825915 40.393750 -15814 2 0.000000 -1.000000 2.500000 26.404000 29.825915 40.393750 +15814 2 0.000000 -1 2.500000 26.404000 29.825915 40.393750 15815 2 0.000000 1 2.500000 28.700000 25.849126 40.393750 15816 2 0.000000 -1 2.500000 28.700000 25.849126 40.393750 15817 2 0.000000 1 2.500000 30.996000 27.174722 43.906250 @@ -15835,7 +15835,7 @@ Atoms 15819 2 0.000000 1 2.500000 33.292000 31.151511 43.906250 15820 2 0.000000 -1 2.500000 33.292000 31.151511 43.906250 15821 2 0.000000 1 2.500000 26.404000 29.825915 47.418750 -15822 2 0.000000 -1.000000 2.500000 26.404000 29.825915 47.418750 +15822 2 0.000000 -1 2.500000 26.404000 29.825915 47.418750 15823 2 0.000000 1 2.500000 28.700000 25.849126 47.418750 15824 2 0.000000 -1 2.500000 28.700000 25.849126 47.418750 15825 2 0.000000 1 2.500000 30.996000 27.174722 50.931250 @@ -15843,7 +15843,7 @@ Atoms 15827 2 0.000000 1 2.500000 33.292000 31.151511 50.931250 15828 2 0.000000 -1 2.500000 33.292000 31.151511 50.931250 15829 2 0.000000 1 2.500000 26.404000 29.825915 54.443750 -15830 2 0.000000 -1.000000 2.500000 26.404000 29.825915 54.443750 +15830 2 0.000000 -1 2.500000 26.404000 29.825915 54.443750 15831 2 0.000000 1 2.500000 28.700000 25.849126 54.443750 15832 2 0.000000 -1 2.500000 28.700000 25.849126 54.443750 15833 2 0.000000 1 2.500000 30.996000 27.174722 57.956250 @@ -15851,7 +15851,7 @@ Atoms 15835 2 0.000000 1 2.500000 33.292000 31.151511 57.956250 15836 2 0.000000 -1 2.500000 33.292000 31.151511 57.956250 15837 2 0.000000 1 2.500000 26.404000 29.825915 61.468750 -15838 2 0.000000 -1.000000 2.500000 26.404000 29.825915 61.468750 +15838 2 0.000000 -1 2.500000 26.404000 29.825915 61.468750 15839 2 0.000000 1 2.500000 28.700000 25.849126 61.468750 15840 2 0.000000 -1 2.500000 28.700000 25.849126 61.468750 15841 2 0.000000 1 2.500000 30.996000 35.128300 1.756250 @@ -15859,7 +15859,7 @@ Atoms 15843 2 0.000000 1 2.500000 33.292000 39.105088 1.756250 15844 2 0.000000 -1 2.500000 33.292000 39.105088 1.756250 15845 2 0.000000 1 2.500000 26.404000 37.779492 5.268750 -15846 2 0.000000 -1.000000 2.500000 26.404000 37.779492 5.268750 +15846 2 0.000000 -1 2.500000 26.404000 37.779492 5.268750 15847 2 0.000000 1 2.500000 28.700000 33.802704 5.268750 15848 2 0.000000 -1 2.500000 28.700000 33.802704 5.268750 15849 2 0.000000 1 2.500000 30.996000 35.128300 8.781250 @@ -15867,7 +15867,7 @@ Atoms 15851 2 0.000000 1 2.500000 33.292000 39.105088 8.781250 15852 2 0.000000 -1 2.500000 33.292000 39.105088 8.781250 15853 2 0.000000 1 2.500000 26.404000 37.779492 12.293750 -15854 2 0.000000 -1.000000 2.500000 26.404000 37.779492 12.293750 +15854 2 0.000000 -1 2.500000 26.404000 37.779492 12.293750 15855 2 0.000000 1 2.500000 28.700000 33.802704 12.293750 15856 2 0.000000 -1 2.500000 28.700000 33.802704 12.293750 15857 2 0.000000 1 2.500000 30.996000 35.128300 15.806250 @@ -15875,7 +15875,7 @@ Atoms 15859 2 0.000000 1 2.500000 33.292000 39.105088 15.806250 15860 2 0.000000 -1 2.500000 33.292000 39.105088 15.806250 15861 2 0.000000 1 2.500000 26.404000 37.779492 19.318750 -15862 2 0.000000 -1.000000 2.500000 26.404000 37.779492 19.318750 +15862 2 0.000000 -1 2.500000 26.404000 37.779492 19.318750 15863 2 0.000000 1 2.500000 28.700000 33.802704 19.318750 15864 2 0.000000 -1 2.500000 28.700000 33.802704 19.318750 15865 2 0.000000 1 2.500000 30.996000 35.128300 22.831250 @@ -15883,7 +15883,7 @@ Atoms 15867 2 0.000000 1 2.500000 33.292000 39.105088 22.831250 15868 2 0.000000 -1 2.500000 33.292000 39.105088 22.831250 15869 2 0.000000 1 2.500000 26.404000 37.779492 26.343750 -15870 2 0.000000 -1.000000 2.500000 26.404000 37.779492 26.343750 +15870 2 0.000000 -1 2.500000 26.404000 37.779492 26.343750 15871 2 0.000000 1 2.500000 28.700000 33.802704 26.343750 15872 2 0.000000 -1 2.500000 28.700000 33.802704 26.343750 15873 2 0.000000 1 2.500000 30.996000 35.128300 29.856250 @@ -15891,7 +15891,7 @@ Atoms 15875 2 0.000000 1 2.500000 33.292000 39.105088 29.856250 15876 2 0.000000 -1 2.500000 33.292000 39.105088 29.856250 15877 2 0.000000 1 2.500000 26.404000 37.779492 33.368750 -15878 2 0.000000 -1.000000 2.500000 26.404000 37.779492 33.368750 +15878 2 0.000000 -1 2.500000 26.404000 37.779492 33.368750 15879 2 0.000000 1 2.500000 28.700000 33.802704 33.368750 15880 2 0.000000 -1 2.500000 28.700000 33.802704 33.368750 15881 2 0.000000 1 2.500000 30.996000 35.128300 36.881250 @@ -15899,7 +15899,7 @@ Atoms 15883 2 0.000000 1 2.500000 33.292000 39.105088 36.881250 15884 2 0.000000 -1 2.500000 33.292000 39.105088 36.881250 15885 2 0.000000 1 2.500000 26.404000 37.779492 40.393750 -15886 2 0.000000 -1.000000 2.500000 26.404000 37.779492 40.393750 +15886 2 0.000000 -1 2.500000 26.404000 37.779492 40.393750 15887 2 0.000000 1 2.500000 28.700000 33.802704 40.393750 15888 2 0.000000 -1 2.500000 28.700000 33.802704 40.393750 15889 2 0.000000 1 2.500000 30.996000 35.128300 43.906250 @@ -15907,7 +15907,7 @@ Atoms 15891 2 0.000000 1 2.500000 33.292000 39.105088 43.906250 15892 2 0.000000 -1 2.500000 33.292000 39.105088 43.906250 15893 2 0.000000 1 2.500000 26.404000 37.779492 47.418750 -15894 2 0.000000 -1.000000 2.500000 26.404000 37.779492 47.418750 +15894 2 0.000000 -1 2.500000 26.404000 37.779492 47.418750 15895 2 0.000000 1 2.500000 28.700000 33.802704 47.418750 15896 2 0.000000 -1 2.500000 28.700000 33.802704 47.418750 15897 2 0.000000 1 2.500000 30.996000 35.128300 50.931250 @@ -15915,7 +15915,7 @@ Atoms 15899 2 0.000000 1 2.500000 33.292000 39.105088 50.931250 15900 2 0.000000 -1 2.500000 33.292000 39.105088 50.931250 15901 2 0.000000 1 2.500000 26.404000 37.779492 54.443750 -15902 2 0.000000 -1.000000 2.500000 26.404000 37.779492 54.443750 +15902 2 0.000000 -1 2.500000 26.404000 37.779492 54.443750 15903 2 0.000000 1 2.500000 28.700000 33.802704 54.443750 15904 2 0.000000 -1 2.500000 28.700000 33.802704 54.443750 15905 2 0.000000 1 2.500000 30.996000 35.128300 57.956250 @@ -15923,7 +15923,7 @@ Atoms 15907 2 0.000000 1 2.500000 33.292000 39.105088 57.956250 15908 2 0.000000 -1 2.500000 33.292000 39.105088 57.956250 15909 2 0.000000 1 2.500000 26.404000 37.779492 61.468750 -15910 2 0.000000 -1.000000 2.500000 26.404000 37.779492 61.468750 +15910 2 0.000000 -1 2.500000 26.404000 37.779492 61.468750 15911 2 0.000000 1 2.500000 28.700000 33.802704 61.468750 15912 2 0.000000 -1 2.500000 28.700000 33.802704 61.468750 15913 2 0.000000 1 2.500000 30.996000 43.081877 1.756250 @@ -15931,7 +15931,7 @@ Atoms 15915 2 0.000000 1 2.500000 33.292000 47.058666 1.756250 15916 2 0.000000 -1 2.500000 33.292000 47.058666 1.756250 15917 2 0.000000 1 2.500000 26.404000 45.733070 5.268750 -15918 2 0.000000 -1.000000 2.500000 26.404000 45.733070 5.268750 +15918 2 0.000000 -1 2.500000 26.404000 45.733070 5.268750 15919 2 0.000000 1 2.500000 28.700000 41.756281 5.268750 15920 2 0.000000 -1 2.500000 28.700000 41.756281 5.268750 15921 2 0.000000 1 2.500000 30.996000 43.081877 8.781250 @@ -15939,7 +15939,7 @@ Atoms 15923 2 0.000000 1 2.500000 33.292000 47.058666 8.781250 15924 2 0.000000 -1 2.500000 33.292000 47.058666 8.781250 15925 2 0.000000 1 2.500000 26.404000 45.733070 12.293750 -15926 2 0.000000 -1.000000 2.500000 26.404000 45.733070 12.293750 +15926 2 0.000000 -1 2.500000 26.404000 45.733070 12.293750 15927 2 0.000000 1 2.500000 28.700000 41.756281 12.293750 15928 2 0.000000 -1 2.500000 28.700000 41.756281 12.293750 15929 2 0.000000 1 2.500000 30.996000 43.081877 15.806250 @@ -15947,7 +15947,7 @@ Atoms 15931 2 0.000000 1 2.500000 33.292000 47.058666 15.806250 15932 2 0.000000 -1 2.500000 33.292000 47.058666 15.806250 15933 2 0.000000 1 2.500000 26.404000 45.733070 19.318750 -15934 2 0.000000 -1.000000 2.500000 26.404000 45.733070 19.318750 +15934 2 0.000000 -1 2.500000 26.404000 45.733070 19.318750 15935 2 0.000000 1 2.500000 28.700000 41.756281 19.318750 15936 2 0.000000 -1 2.500000 28.700000 41.756281 19.318750 15937 2 0.000000 1 2.500000 30.996000 43.081877 22.831250 @@ -15955,7 +15955,7 @@ Atoms 15939 2 0.000000 1 2.500000 33.292000 47.058666 22.831250 15940 2 0.000000 -1 2.500000 33.292000 47.058666 22.831250 15941 2 0.000000 1 2.500000 26.404000 45.733070 26.343750 -15942 2 0.000000 -1.000000 2.500000 26.404000 45.733070 26.343750 +15942 2 0.000000 -1 2.500000 26.404000 45.733070 26.343750 15943 2 0.000000 1 2.500000 28.700000 41.756281 26.343750 15944 2 0.000000 -1 2.500000 28.700000 41.756281 26.343750 15945 2 0.000000 1 2.500000 30.996000 43.081877 29.856250 @@ -15963,7 +15963,7 @@ Atoms 15947 2 0.000000 1 2.500000 33.292000 47.058666 29.856250 15948 2 0.000000 -1 2.500000 33.292000 47.058666 29.856250 15949 2 0.000000 1 2.500000 26.404000 45.733070 33.368750 -15950 2 0.000000 -1.000000 2.500000 26.404000 45.733070 33.368750 +15950 2 0.000000 -1 2.500000 26.404000 45.733070 33.368750 15951 2 0.000000 1 2.500000 28.700000 41.756281 33.368750 15952 2 0.000000 -1 2.500000 28.700000 41.756281 33.368750 15953 2 0.000000 1 2.500000 30.996000 43.081877 36.881250 @@ -15971,7 +15971,7 @@ Atoms 15955 2 0.000000 1 2.500000 33.292000 47.058666 36.881250 15956 2 0.000000 -1 2.500000 33.292000 47.058666 36.881250 15957 2 0.000000 1 2.500000 26.404000 45.733070 40.393750 -15958 2 0.000000 -1.000000 2.500000 26.404000 45.733070 40.393750 +15958 2 0.000000 -1 2.500000 26.404000 45.733070 40.393750 15959 2 0.000000 1 2.500000 28.700000 41.756281 40.393750 15960 2 0.000000 -1 2.500000 28.700000 41.756281 40.393750 15961 2 0.000000 1 2.500000 30.996000 43.081877 43.906250 @@ -15979,7 +15979,7 @@ Atoms 15963 2 0.000000 1 2.500000 33.292000 47.058666 43.906250 15964 2 0.000000 -1 2.500000 33.292000 47.058666 43.906250 15965 2 0.000000 1 2.500000 26.404000 45.733070 47.418750 -15966 2 0.000000 -1.000000 2.500000 26.404000 45.733070 47.418750 +15966 2 0.000000 -1 2.500000 26.404000 45.733070 47.418750 15967 2 0.000000 1 2.500000 28.700000 41.756281 47.418750 15968 2 0.000000 -1 2.500000 28.700000 41.756281 47.418750 15969 2 0.000000 1 2.500000 30.996000 43.081877 50.931250 @@ -15987,7 +15987,7 @@ Atoms 15971 2 0.000000 1 2.500000 33.292000 47.058666 50.931250 15972 2 0.000000 -1 2.500000 33.292000 47.058666 50.931250 15973 2 0.000000 1 2.500000 26.404000 45.733070 54.443750 -15974 2 0.000000 -1.000000 2.500000 26.404000 45.733070 54.443750 +15974 2 0.000000 -1 2.500000 26.404000 45.733070 54.443750 15975 2 0.000000 1 2.500000 28.700000 41.756281 54.443750 15976 2 0.000000 -1 2.500000 28.700000 41.756281 54.443750 15977 2 0.000000 1 2.500000 30.996000 43.081877 57.956250 @@ -15995,7 +15995,7 @@ Atoms 15979 2 0.000000 1 2.500000 33.292000 47.058666 57.956250 15980 2 0.000000 -1 2.500000 33.292000 47.058666 57.956250 15981 2 0.000000 1 2.500000 26.404000 45.733070 61.468750 -15982 2 0.000000 -1.000000 2.500000 26.404000 45.733070 61.468750 +15982 2 0.000000 -1 2.500000 26.404000 45.733070 61.468750 15983 2 0.000000 1 2.500000 28.700000 41.756281 61.468750 15984 2 0.000000 -1 2.500000 28.700000 41.756281 61.468750 15985 2 0.000000 1 2.500000 30.996000 51.035454 1.756250 @@ -16003,7 +16003,7 @@ Atoms 15987 2 0.000000 1 2.500000 33.292000 55.012243 1.756250 15988 2 0.000000 -1 2.500000 33.292000 55.012243 1.756250 15989 2 0.000000 1 2.500000 26.404000 53.686647 5.268750 -15990 2 0.000000 -1.000000 2.500000 26.404000 53.686647 5.268750 +15990 2 0.000000 -1 2.500000 26.404000 53.686647 5.268750 15991 2 0.000000 1 2.500000 28.700000 49.709858 5.268750 15992 2 0.000000 -1 2.500000 28.700000 49.709858 5.268750 15993 2 0.000000 1 2.500000 30.996000 51.035454 8.781250 @@ -16011,7 +16011,7 @@ Atoms 15995 2 0.000000 1 2.500000 33.292000 55.012243 8.781250 15996 2 0.000000 -1 2.500000 33.292000 55.012243 8.781250 15997 2 0.000000 1 2.500000 26.404000 53.686647 12.293750 -15998 2 0.000000 -1.000000 2.500000 26.404000 53.686647 12.293750 +15998 2 0.000000 -1 2.500000 26.404000 53.686647 12.293750 15999 2 0.000000 1 2.500000 28.700000 49.709858 12.293750 16000 2 0.000000 -1 2.500000 28.700000 49.709858 12.293750 16001 2 0.000000 1 2.500000 30.996000 51.035454 15.806250 @@ -16019,7 +16019,7 @@ Atoms 16003 2 0.000000 1 2.500000 33.292000 55.012243 15.806250 16004 2 0.000000 -1 2.500000 33.292000 55.012243 15.806250 16005 2 0.000000 1 2.500000 26.404000 53.686647 19.318750 -16006 2 0.000000 -1.000000 2.500000 26.404000 53.686647 19.318750 +16006 2 0.000000 -1 2.500000 26.404000 53.686647 19.318750 16007 2 0.000000 1 2.500000 28.700000 49.709858 19.318750 16008 2 0.000000 -1 2.500000 28.700000 49.709858 19.318750 16009 2 0.000000 1 2.500000 30.996000 51.035454 22.831250 @@ -16027,7 +16027,7 @@ Atoms 16011 2 0.000000 1 2.500000 33.292000 55.012243 22.831250 16012 2 0.000000 -1 2.500000 33.292000 55.012243 22.831250 16013 2 0.000000 1 2.500000 26.404000 53.686647 26.343750 -16014 2 0.000000 -1.000000 2.500000 26.404000 53.686647 26.343750 +16014 2 0.000000 -1 2.500000 26.404000 53.686647 26.343750 16015 2 0.000000 1 2.500000 28.700000 49.709858 26.343750 16016 2 0.000000 -1 2.500000 28.700000 49.709858 26.343750 16017 2 0.000000 1 2.500000 30.996000 51.035454 29.856250 @@ -16035,7 +16035,7 @@ Atoms 16019 2 0.000000 1 2.500000 33.292000 55.012243 29.856250 16020 2 0.000000 -1 2.500000 33.292000 55.012243 29.856250 16021 2 0.000000 1 2.500000 26.404000 53.686647 33.368750 -16022 2 0.000000 -1.000000 2.500000 26.404000 53.686647 33.368750 +16022 2 0.000000 -1 2.500000 26.404000 53.686647 33.368750 16023 2 0.000000 1 2.500000 28.700000 49.709858 33.368750 16024 2 0.000000 -1 2.500000 28.700000 49.709858 33.368750 16025 2 0.000000 1 2.500000 30.996000 51.035454 36.881250 @@ -16043,7 +16043,7 @@ Atoms 16027 2 0.000000 1 2.500000 33.292000 55.012243 36.881250 16028 2 0.000000 -1 2.500000 33.292000 55.012243 36.881250 16029 2 0.000000 1 2.500000 26.404000 53.686647 40.393750 -16030 2 0.000000 -1.000000 2.500000 26.404000 53.686647 40.393750 +16030 2 0.000000 -1 2.500000 26.404000 53.686647 40.393750 16031 2 0.000000 1 2.500000 28.700000 49.709858 40.393750 16032 2 0.000000 -1 2.500000 28.700000 49.709858 40.393750 16033 2 0.000000 1 2.500000 30.996000 51.035454 43.906250 @@ -16051,7 +16051,7 @@ Atoms 16035 2 0.000000 1 2.500000 33.292000 55.012243 43.906250 16036 2 0.000000 -1 2.500000 33.292000 55.012243 43.906250 16037 2 0.000000 1 2.500000 26.404000 53.686647 47.418750 -16038 2 0.000000 -1.000000 2.500000 26.404000 53.686647 47.418750 +16038 2 0.000000 -1 2.500000 26.404000 53.686647 47.418750 16039 2 0.000000 1 2.500000 28.700000 49.709858 47.418750 16040 2 0.000000 -1 2.500000 28.700000 49.709858 47.418750 16041 2 0.000000 1 2.500000 30.996000 51.035454 50.931250 @@ -16059,7 +16059,7 @@ Atoms 16043 2 0.000000 1 2.500000 33.292000 55.012243 50.931250 16044 2 0.000000 -1 2.500000 33.292000 55.012243 50.931250 16045 2 0.000000 1 2.500000 26.404000 53.686647 54.443750 -16046 2 0.000000 -1.000000 2.500000 26.404000 53.686647 54.443750 +16046 2 0.000000 -1 2.500000 26.404000 53.686647 54.443750 16047 2 0.000000 1 2.500000 28.700000 49.709858 54.443750 16048 2 0.000000 -1 2.500000 28.700000 49.709858 54.443750 16049 2 0.000000 1 2.500000 30.996000 51.035454 57.956250 @@ -16067,7 +16067,7 @@ Atoms 16051 2 0.000000 1 2.500000 33.292000 55.012243 57.956250 16052 2 0.000000 -1 2.500000 33.292000 55.012243 57.956250 16053 2 0.000000 1 2.500000 26.404000 53.686647 61.468750 -16054 2 0.000000 -1.000000 2.500000 26.404000 53.686647 61.468750 +16054 2 0.000000 -1 2.500000 26.404000 53.686647 61.468750 16055 2 0.000000 1 2.500000 28.700000 49.709858 61.468750 16056 2 0.000000 -1 2.500000 28.700000 49.709858 61.468750 16057 2 0.000000 1 2.500000 30.996000 58.989032 1.756250 @@ -16075,7 +16075,7 @@ Atoms 16059 2 0.000000 1 2.500000 33.292000 62.965820 1.756250 16060 2 0.000000 -1 2.500000 33.292000 62.965820 1.756250 16061 2 0.000000 1 2.500000 26.404000 61.640224 5.268750 -16062 2 0.000000 -1.000000 2.500000 26.404000 61.640224 5.268750 +16062 2 0.000000 -1 2.500000 26.404000 61.640224 5.268750 16063 2 0.000000 1 2.500000 28.700000 57.663435 5.268750 16064 2 0.000000 -1 2.500000 28.700000 57.663435 5.268750 16065 2 0.000000 1 2.500000 30.996000 58.989032 8.781250 @@ -16083,7 +16083,7 @@ Atoms 16067 2 0.000000 1 2.500000 33.292000 62.965820 8.781250 16068 2 0.000000 -1 2.500000 33.292000 62.965820 8.781250 16069 2 0.000000 1 2.500000 26.404000 61.640224 12.293750 -16070 2 0.000000 -1.000000 2.500000 26.404000 61.640224 12.293750 +16070 2 0.000000 -1 2.500000 26.404000 61.640224 12.293750 16071 2 0.000000 1 2.500000 28.700000 57.663435 12.293750 16072 2 0.000000 -1 2.500000 28.700000 57.663435 12.293750 16073 2 0.000000 1 2.500000 30.996000 58.989032 15.806250 @@ -16091,7 +16091,7 @@ Atoms 16075 2 0.000000 1 2.500000 33.292000 62.965820 15.806250 16076 2 0.000000 -1 2.500000 33.292000 62.965820 15.806250 16077 2 0.000000 1 2.500000 26.404000 61.640224 19.318750 -16078 2 0.000000 -1.000000 2.500000 26.404000 61.640224 19.318750 +16078 2 0.000000 -1 2.500000 26.404000 61.640224 19.318750 16079 2 0.000000 1 2.500000 28.700000 57.663435 19.318750 16080 2 0.000000 -1 2.500000 28.700000 57.663435 19.318750 16081 2 0.000000 1 2.500000 30.996000 58.989032 22.831250 @@ -16099,7 +16099,7 @@ Atoms 16083 2 0.000000 1 2.500000 33.292000 62.965820 22.831250 16084 2 0.000000 -1 2.500000 33.292000 62.965820 22.831250 16085 2 0.000000 1 2.500000 26.404000 61.640224 26.343750 -16086 2 0.000000 -1.000000 2.500000 26.404000 61.640224 26.343750 +16086 2 0.000000 -1 2.500000 26.404000 61.640224 26.343750 16087 2 0.000000 1 2.500000 28.700000 57.663435 26.343750 16088 2 0.000000 -1 2.500000 28.700000 57.663435 26.343750 16089 2 0.000000 1 2.500000 30.996000 58.989032 29.856250 @@ -16107,7 +16107,7 @@ Atoms 16091 2 0.000000 1 2.500000 33.292000 62.965820 29.856250 16092 2 0.000000 -1 2.500000 33.292000 62.965820 29.856250 16093 2 0.000000 1 2.500000 26.404000 61.640224 33.368750 -16094 2 0.000000 -1.000000 2.500000 26.404000 61.640224 33.368750 +16094 2 0.000000 -1 2.500000 26.404000 61.640224 33.368750 16095 2 0.000000 1 2.500000 28.700000 57.663435 33.368750 16096 2 0.000000 -1 2.500000 28.700000 57.663435 33.368750 16097 2 0.000000 1 2.500000 30.996000 58.989032 36.881250 @@ -16115,7 +16115,7 @@ Atoms 16099 2 0.000000 1 2.500000 33.292000 62.965820 36.881250 16100 2 0.000000 -1 2.500000 33.292000 62.965820 36.881250 16101 2 0.000000 1 2.500000 26.404000 61.640224 40.393750 -16102 2 0.000000 -1.000000 2.500000 26.404000 61.640224 40.393750 +16102 2 0.000000 -1 2.500000 26.404000 61.640224 40.393750 16103 2 0.000000 1 2.500000 28.700000 57.663435 40.393750 16104 2 0.000000 -1 2.500000 28.700000 57.663435 40.393750 16105 2 0.000000 1 2.500000 30.996000 58.989032 43.906250 @@ -16123,7 +16123,7 @@ Atoms 16107 2 0.000000 1 2.500000 33.292000 62.965820 43.906250 16108 2 0.000000 -1 2.500000 33.292000 62.965820 43.906250 16109 2 0.000000 1 2.500000 26.404000 61.640224 47.418750 -16110 2 0.000000 -1.000000 2.500000 26.404000 61.640224 47.418750 +16110 2 0.000000 -1 2.500000 26.404000 61.640224 47.418750 16111 2 0.000000 1 2.500000 28.700000 57.663435 47.418750 16112 2 0.000000 -1 2.500000 28.700000 57.663435 47.418750 16113 2 0.000000 1 2.500000 30.996000 58.989032 50.931250 @@ -16131,7 +16131,7 @@ Atoms 16115 2 0.000000 1 2.500000 33.292000 62.965820 50.931250 16116 2 0.000000 -1 2.500000 33.292000 62.965820 50.931250 16117 2 0.000000 1 2.500000 26.404000 61.640224 54.443750 -16118 2 0.000000 -1.000000 2.500000 26.404000 61.640224 54.443750 +16118 2 0.000000 -1 2.500000 26.404000 61.640224 54.443750 16119 2 0.000000 1 2.500000 28.700000 57.663435 54.443750 16120 2 0.000000 -1 2.500000 28.700000 57.663435 54.443750 16121 2 0.000000 1 2.500000 30.996000 58.989032 57.956250 @@ -16139,7 +16139,7 @@ Atoms 16123 2 0.000000 1 2.500000 33.292000 62.965820 57.956250 16124 2 0.000000 -1 2.500000 33.292000 62.965820 57.956250 16125 2 0.000000 1 2.500000 26.404000 61.640224 61.468750 -16126 2 0.000000 -1.000000 2.500000 26.404000 61.640224 61.468750 +16126 2 0.000000 -1 2.500000 26.404000 61.640224 61.468750 16127 2 0.000000 1 2.500000 28.700000 57.663435 61.468750 16128 2 0.000000 -1 2.500000 28.700000 57.663435 61.468750 16129 2 0.000000 1 2.500000 35.588000 3.313991 1.756250 @@ -16147,7 +16147,7 @@ Atoms 16131 2 0.000000 1 2.500000 37.884000 7.290779 1.756250 16132 2 0.000000 -1 2.500000 37.884000 7.290779 1.756250 16133 2 0.000000 1 2.500000 30.996000 5.965183 5.268750 -16134 2 0.000000 -1.000000 2.500000 30.996000 5.965183 5.268750 +16134 2 0.000000 -1 2.500000 30.996000 5.965183 5.268750 16135 2 0.000000 1 2.500000 33.292000 1.988394 5.268750 16136 2 0.000000 -1 2.500000 33.292000 1.988394 5.268750 16137 2 0.000000 1 2.500000 35.588000 3.313991 8.781250 @@ -16155,7 +16155,7 @@ Atoms 16139 2 0.000000 1 2.500000 37.884000 7.290779 8.781250 16140 2 0.000000 -1 2.500000 37.884000 7.290779 8.781250 16141 2 0.000000 1 2.500000 30.996000 5.965183 12.293750 -16142 2 0.000000 -1.000000 2.500000 30.996000 5.965183 12.293750 +16142 2 0.000000 -1 2.500000 30.996000 5.965183 12.293750 16143 2 0.000000 1 2.500000 33.292000 1.988394 12.293750 16144 2 0.000000 -1 2.500000 33.292000 1.988394 12.293750 16145 2 0.000000 1 2.500000 35.588000 3.313991 15.806250 @@ -16163,7 +16163,7 @@ Atoms 16147 2 0.000000 1 2.500000 37.884000 7.290779 15.806250 16148 2 0.000000 -1 2.500000 37.884000 7.290779 15.806250 16149 2 0.000000 1 2.500000 30.996000 5.965183 19.318750 -16150 2 0.000000 -1.000000 2.500000 30.996000 5.965183 19.318750 +16150 2 0.000000 -1 2.500000 30.996000 5.965183 19.318750 16151 2 0.000000 1 2.500000 33.292000 1.988394 19.318750 16152 2 0.000000 -1 2.500000 33.292000 1.988394 19.318750 16153 2 0.000000 1 2.500000 35.588000 3.313991 22.831250 @@ -16171,7 +16171,7 @@ Atoms 16155 2 0.000000 1 2.500000 37.884000 7.290779 22.831250 16156 2 0.000000 -1 2.500000 37.884000 7.290779 22.831250 16157 2 0.000000 1 2.500000 30.996000 5.965183 26.343750 -16158 2 0.000000 -1.000000 2.500000 30.996000 5.965183 26.343750 +16158 2 0.000000 -1 2.500000 30.996000 5.965183 26.343750 16159 2 0.000000 1 2.500000 33.292000 1.988394 26.343750 16160 2 0.000000 -1 2.500000 33.292000 1.988394 26.343750 16161 2 0.000000 1 2.500000 35.588000 3.313991 29.856250 @@ -16179,7 +16179,7 @@ Atoms 16163 2 0.000000 1 2.500000 37.884000 7.290779 29.856250 16164 2 0.000000 -1 2.500000 37.884000 7.290779 29.856250 16165 2 0.000000 1 2.500000 30.996000 5.965183 33.368750 -16166 2 0.000000 -1.000000 2.500000 30.996000 5.965183 33.368750 +16166 2 0.000000 -1 2.500000 30.996000 5.965183 33.368750 16167 2 0.000000 1 2.500000 33.292000 1.988394 33.368750 16168 2 0.000000 -1 2.500000 33.292000 1.988394 33.368750 16169 2 0.000000 1 2.500000 35.588000 3.313991 36.881250 @@ -16187,7 +16187,7 @@ Atoms 16171 2 0.000000 1 2.500000 37.884000 7.290779 36.881250 16172 2 0.000000 -1 2.500000 37.884000 7.290779 36.881250 16173 2 0.000000 1 2.500000 30.996000 5.965183 40.393750 -16174 2 0.000000 -1.000000 2.500000 30.996000 5.965183 40.393750 +16174 2 0.000000 -1 2.500000 30.996000 5.965183 40.393750 16175 2 0.000000 1 2.500000 33.292000 1.988394 40.393750 16176 2 0.000000 -1 2.500000 33.292000 1.988394 40.393750 16177 2 0.000000 1 2.500000 35.588000 3.313991 43.906250 @@ -16195,7 +16195,7 @@ Atoms 16179 2 0.000000 1 2.500000 37.884000 7.290779 43.906250 16180 2 0.000000 -1 2.500000 37.884000 7.290779 43.906250 16181 2 0.000000 1 2.500000 30.996000 5.965183 47.418750 -16182 2 0.000000 -1.000000 2.500000 30.996000 5.965183 47.418750 +16182 2 0.000000 -1 2.500000 30.996000 5.965183 47.418750 16183 2 0.000000 1 2.500000 33.292000 1.988394 47.418750 16184 2 0.000000 -1 2.500000 33.292000 1.988394 47.418750 16185 2 0.000000 1 2.500000 35.588000 3.313991 50.931250 @@ -16203,7 +16203,7 @@ Atoms 16187 2 0.000000 1 2.500000 37.884000 7.290779 50.931250 16188 2 0.000000 -1 2.500000 37.884000 7.290779 50.931250 16189 2 0.000000 1 2.500000 30.996000 5.965183 54.443750 -16190 2 0.000000 -1.000000 2.500000 30.996000 5.965183 54.443750 +16190 2 0.000000 -1 2.500000 30.996000 5.965183 54.443750 16191 2 0.000000 1 2.500000 33.292000 1.988394 54.443750 16192 2 0.000000 -1 2.500000 33.292000 1.988394 54.443750 16193 2 0.000000 1 2.500000 35.588000 3.313991 57.956250 @@ -16211,7 +16211,7 @@ Atoms 16195 2 0.000000 1 2.500000 37.884000 7.290779 57.956250 16196 2 0.000000 -1 2.500000 37.884000 7.290779 57.956250 16197 2 0.000000 1 2.500000 30.996000 5.965183 61.468750 -16198 2 0.000000 -1.000000 2.500000 30.996000 5.965183 61.468750 +16198 2 0.000000 -1 2.500000 30.996000 5.965183 61.468750 16199 2 0.000000 1 2.500000 33.292000 1.988394 61.468750 16200 2 0.000000 -1 2.500000 33.292000 1.988394 61.468750 16201 2 0.000000 1 2.500000 35.588000 11.267568 1.756250 @@ -16219,7 +16219,7 @@ Atoms 16203 2 0.000000 1 2.500000 37.884000 15.244357 1.756250 16204 2 0.000000 -1 2.500000 37.884000 15.244357 1.756250 16205 2 0.000000 1 2.500000 30.996000 13.918760 5.268750 -16206 2 0.000000 -1.000000 2.500000 30.996000 13.918760 5.268750 +16206 2 0.000000 -1 2.500000 30.996000 13.918760 5.268750 16207 2 0.000000 1 2.500000 33.292000 9.941972 5.268750 16208 2 0.000000 -1 2.500000 33.292000 9.941972 5.268750 16209 2 0.000000 1 2.500000 35.588000 11.267568 8.781250 @@ -16227,7 +16227,7 @@ Atoms 16211 2 0.000000 1 2.500000 37.884000 15.244357 8.781250 16212 2 0.000000 -1 2.500000 37.884000 15.244357 8.781250 16213 2 0.000000 1 2.500000 30.996000 13.918760 12.293750 -16214 2 0.000000 -1.000000 2.500000 30.996000 13.918760 12.293750 +16214 2 0.000000 -1 2.500000 30.996000 13.918760 12.293750 16215 2 0.000000 1 2.500000 33.292000 9.941972 12.293750 16216 2 0.000000 -1 2.500000 33.292000 9.941972 12.293750 16217 2 0.000000 1 2.500000 35.588000 11.267568 15.806250 @@ -16235,7 +16235,7 @@ Atoms 16219 2 0.000000 1 2.500000 37.884000 15.244357 15.806250 16220 2 0.000000 -1 2.500000 37.884000 15.244357 15.806250 16221 2 0.000000 1 2.500000 30.996000 13.918760 19.318750 -16222 2 0.000000 -1.000000 2.500000 30.996000 13.918760 19.318750 +16222 2 0.000000 -1 2.500000 30.996000 13.918760 19.318750 16223 2 0.000000 1 2.500000 33.292000 9.941972 19.318750 16224 2 0.000000 -1 2.500000 33.292000 9.941972 19.318750 16225 2 0.000000 1 2.500000 35.588000 11.267568 22.831250 @@ -16243,7 +16243,7 @@ Atoms 16227 2 0.000000 1 2.500000 37.884000 15.244357 22.831250 16228 2 0.000000 -1 2.500000 37.884000 15.244357 22.831250 16229 2 0.000000 1 2.500000 30.996000 13.918760 26.343750 -16230 2 0.000000 -1.000000 2.500000 30.996000 13.918760 26.343750 +16230 2 0.000000 -1 2.500000 30.996000 13.918760 26.343750 16231 2 0.000000 1 2.500000 33.292000 9.941972 26.343750 16232 2 0.000000 -1 2.500000 33.292000 9.941972 26.343750 16233 2 0.000000 1 2.500000 35.588000 11.267568 29.856250 @@ -16251,7 +16251,7 @@ Atoms 16235 2 0.000000 1 2.500000 37.884000 15.244357 29.856250 16236 2 0.000000 -1 2.500000 37.884000 15.244357 29.856250 16237 2 0.000000 1 2.500000 30.996000 13.918760 33.368750 -16238 2 0.000000 -1.000000 2.500000 30.996000 13.918760 33.368750 +16238 2 0.000000 -1 2.500000 30.996000 13.918760 33.368750 16239 2 0.000000 1 2.500000 33.292000 9.941972 33.368750 16240 2 0.000000 -1 2.500000 33.292000 9.941972 33.368750 16241 2 0.000000 1 2.500000 35.588000 11.267568 36.881250 @@ -16259,7 +16259,7 @@ Atoms 16243 2 0.000000 1 2.500000 37.884000 15.244357 36.881250 16244 2 0.000000 -1 2.500000 37.884000 15.244357 36.881250 16245 2 0.000000 1 2.500000 30.996000 13.918760 40.393750 -16246 2 0.000000 -1.000000 2.500000 30.996000 13.918760 40.393750 +16246 2 0.000000 -1 2.500000 30.996000 13.918760 40.393750 16247 2 0.000000 1 2.500000 33.292000 9.941972 40.393750 16248 2 0.000000 -1 2.500000 33.292000 9.941972 40.393750 16249 2 0.000000 1 2.500000 35.588000 11.267568 43.906250 @@ -16267,7 +16267,7 @@ Atoms 16251 2 0.000000 1 2.500000 37.884000 15.244357 43.906250 16252 2 0.000000 -1 2.500000 37.884000 15.244357 43.906250 16253 2 0.000000 1 2.500000 30.996000 13.918760 47.418750 -16254 2 0.000000 -1.000000 2.500000 30.996000 13.918760 47.418750 +16254 2 0.000000 -1 2.500000 30.996000 13.918760 47.418750 16255 2 0.000000 1 2.500000 33.292000 9.941972 47.418750 16256 2 0.000000 -1 2.500000 33.292000 9.941972 47.418750 16257 2 0.000000 1 2.500000 35.588000 11.267568 50.931250 @@ -16275,7 +16275,7 @@ Atoms 16259 2 0.000000 1 2.500000 37.884000 15.244357 50.931250 16260 2 0.000000 -1 2.500000 37.884000 15.244357 50.931250 16261 2 0.000000 1 2.500000 30.996000 13.918760 54.443750 -16262 2 0.000000 -1.000000 2.500000 30.996000 13.918760 54.443750 +16262 2 0.000000 -1 2.500000 30.996000 13.918760 54.443750 16263 2 0.000000 1 2.500000 33.292000 9.941972 54.443750 16264 2 0.000000 -1 2.500000 33.292000 9.941972 54.443750 16265 2 0.000000 1 2.500000 35.588000 11.267568 57.956250 @@ -16283,7 +16283,7 @@ Atoms 16267 2 0.000000 1 2.500000 37.884000 15.244357 57.956250 16268 2 0.000000 -1 2.500000 37.884000 15.244357 57.956250 16269 2 0.000000 1 2.500000 30.996000 13.918760 61.468750 -16270 2 0.000000 -1.000000 2.500000 30.996000 13.918760 61.468750 +16270 2 0.000000 -1 2.500000 30.996000 13.918760 61.468750 16271 2 0.000000 1 2.500000 33.292000 9.941972 61.468750 16272 2 0.000000 -1 2.500000 33.292000 9.941972 61.468750 16273 2 0.000000 1 2.500000 35.588000 19.221145 1.756250 @@ -16291,7 +16291,7 @@ Atoms 16275 2 0.000000 1 2.500000 37.884000 23.197934 1.756250 16276 2 0.000000 -1 2.500000 37.884000 23.197934 1.756250 16277 2 0.000000 1 2.500000 30.996000 21.872338 5.268750 -16278 2 0.000000 -1.000000 2.500000 30.996000 21.872338 5.268750 +16278 2 0.000000 -1 2.500000 30.996000 21.872338 5.268750 16279 2 0.000000 1 2.500000 33.292000 17.895549 5.268750 16280 2 0.000000 -1 2.500000 33.292000 17.895549 5.268750 16281 2 0.000000 1 2.500000 35.588000 19.221145 8.781250 @@ -16299,7 +16299,7 @@ Atoms 16283 2 0.000000 1 2.500000 37.884000 23.197934 8.781250 16284 2 0.000000 -1 2.500000 37.884000 23.197934 8.781250 16285 2 0.000000 1 2.500000 30.996000 21.872338 12.293750 -16286 2 0.000000 -1.000000 2.500000 30.996000 21.872338 12.293750 +16286 2 0.000000 -1 2.500000 30.996000 21.872338 12.293750 16287 2 0.000000 1 2.500000 33.292000 17.895549 12.293750 16288 2 0.000000 -1 2.500000 33.292000 17.895549 12.293750 16289 2 0.000000 1 2.500000 35.588000 19.221145 15.806250 @@ -16307,7 +16307,7 @@ Atoms 16291 2 0.000000 1 2.500000 37.884000 23.197934 15.806250 16292 2 0.000000 -1 2.500000 37.884000 23.197934 15.806250 16293 2 0.000000 1 2.500000 30.996000 21.872338 19.318750 -16294 2 0.000000 -1.000000 2.500000 30.996000 21.872338 19.318750 +16294 2 0.000000 -1 2.500000 30.996000 21.872338 19.318750 16295 2 0.000000 1 2.500000 33.292000 17.895549 19.318750 16296 2 0.000000 -1 2.500000 33.292000 17.895549 19.318750 16297 2 0.000000 1 2.500000 35.588000 19.221145 22.831250 @@ -16315,7 +16315,7 @@ Atoms 16299 2 0.000000 1 2.500000 37.884000 23.197934 22.831250 16300 2 0.000000 -1 2.500000 37.884000 23.197934 22.831250 16301 2 0.000000 1 2.500000 30.996000 21.872338 26.343750 -16302 2 0.000000 -1.000000 2.500000 30.996000 21.872338 26.343750 +16302 2 0.000000 -1 2.500000 30.996000 21.872338 26.343750 16303 2 0.000000 1 2.500000 33.292000 17.895549 26.343750 16304 2 0.000000 -1 2.500000 33.292000 17.895549 26.343750 16305 2 0.000000 1 2.500000 35.588000 19.221145 29.856250 @@ -16323,7 +16323,7 @@ Atoms 16307 2 0.000000 1 2.500000 37.884000 23.197934 29.856250 16308 2 0.000000 -1 2.500000 37.884000 23.197934 29.856250 16309 2 0.000000 1 2.500000 30.996000 21.872338 33.368750 -16310 2 0.000000 -1.000000 2.500000 30.996000 21.872338 33.368750 +16310 2 0.000000 -1 2.500000 30.996000 21.872338 33.368750 16311 2 0.000000 1 2.500000 33.292000 17.895549 33.368750 16312 2 0.000000 -1 2.500000 33.292000 17.895549 33.368750 16313 2 0.000000 1 2.500000 35.588000 19.221145 36.881250 @@ -16331,7 +16331,7 @@ Atoms 16315 2 0.000000 1 2.500000 37.884000 23.197934 36.881250 16316 2 0.000000 -1 2.500000 37.884000 23.197934 36.881250 16317 2 0.000000 1 2.500000 30.996000 21.872338 40.393750 -16318 2 0.000000 -1.000000 2.500000 30.996000 21.872338 40.393750 +16318 2 0.000000 -1 2.500000 30.996000 21.872338 40.393750 16319 2 0.000000 1 2.500000 33.292000 17.895549 40.393750 16320 2 0.000000 -1 2.500000 33.292000 17.895549 40.393750 16321 2 0.000000 1 2.500000 35.588000 19.221145 43.906250 @@ -16339,7 +16339,7 @@ Atoms 16323 2 0.000000 1 2.500000 37.884000 23.197934 43.906250 16324 2 0.000000 -1 2.500000 37.884000 23.197934 43.906250 16325 2 0.000000 1 2.500000 30.996000 21.872338 47.418750 -16326 2 0.000000 -1.000000 2.500000 30.996000 21.872338 47.418750 +16326 2 0.000000 -1 2.500000 30.996000 21.872338 47.418750 16327 2 0.000000 1 2.500000 33.292000 17.895549 47.418750 16328 2 0.000000 -1 2.500000 33.292000 17.895549 47.418750 16329 2 0.000000 1 2.500000 35.588000 19.221145 50.931250 @@ -16347,7 +16347,7 @@ Atoms 16331 2 0.000000 1 2.500000 37.884000 23.197934 50.931250 16332 2 0.000000 -1 2.500000 37.884000 23.197934 50.931250 16333 2 0.000000 1 2.500000 30.996000 21.872338 54.443750 -16334 2 0.000000 -1.000000 2.500000 30.996000 21.872338 54.443750 +16334 2 0.000000 -1 2.500000 30.996000 21.872338 54.443750 16335 2 0.000000 1 2.500000 33.292000 17.895549 54.443750 16336 2 0.000000 -1 2.500000 33.292000 17.895549 54.443750 16337 2 0.000000 1 2.500000 35.588000 19.221145 57.956250 @@ -16355,7 +16355,7 @@ Atoms 16339 2 0.000000 1 2.500000 37.884000 23.197934 57.956250 16340 2 0.000000 -1 2.500000 37.884000 23.197934 57.956250 16341 2 0.000000 1 2.500000 30.996000 21.872338 61.468750 -16342 2 0.000000 -1.000000 2.500000 30.996000 21.872338 61.468750 +16342 2 0.000000 -1 2.500000 30.996000 21.872338 61.468750 16343 2 0.000000 1 2.500000 33.292000 17.895549 61.468750 16344 2 0.000000 -1 2.500000 33.292000 17.895549 61.468750 16345 2 0.000000 1 2.500000 35.588000 27.174722 1.756250 @@ -16363,7 +16363,7 @@ Atoms 16347 2 0.000000 1 2.500000 37.884000 31.151511 1.756250 16348 2 0.000000 -1 2.500000 37.884000 31.151511 1.756250 16349 2 0.000000 1 2.500000 30.996000 29.825915 5.268750 -16350 2 0.000000 -1.000000 2.500000 30.996000 29.825915 5.268750 +16350 2 0.000000 -1 2.500000 30.996000 29.825915 5.268750 16351 2 0.000000 1 2.500000 33.292000 25.849126 5.268750 16352 2 0.000000 -1 2.500000 33.292000 25.849126 5.268750 16353 2 0.000000 1 2.500000 35.588000 27.174722 8.781250 @@ -16371,7 +16371,7 @@ Atoms 16355 2 0.000000 1 2.500000 37.884000 31.151511 8.781250 16356 2 0.000000 -1 2.500000 37.884000 31.151511 8.781250 16357 2 0.000000 1 2.500000 30.996000 29.825915 12.293750 -16358 2 0.000000 -1.000000 2.500000 30.996000 29.825915 12.293750 +16358 2 0.000000 -1 2.500000 30.996000 29.825915 12.293750 16359 2 0.000000 1 2.500000 33.292000 25.849126 12.293750 16360 2 0.000000 -1 2.500000 33.292000 25.849126 12.293750 16361 2 0.000000 1 2.500000 35.588000 27.174722 15.806250 @@ -16379,7 +16379,7 @@ Atoms 16363 2 0.000000 1 2.500000 37.884000 31.151511 15.806250 16364 2 0.000000 -1 2.500000 37.884000 31.151511 15.806250 16365 2 0.000000 1 2.500000 30.996000 29.825915 19.318750 -16366 2 0.000000 -1.000000 2.500000 30.996000 29.825915 19.318750 +16366 2 0.000000 -1 2.500000 30.996000 29.825915 19.318750 16367 2 0.000000 1 2.500000 33.292000 25.849126 19.318750 16368 2 0.000000 -1 2.500000 33.292000 25.849126 19.318750 16369 2 0.000000 1 2.500000 35.588000 27.174722 22.831250 @@ -16387,7 +16387,7 @@ Atoms 16371 2 0.000000 1 2.500000 37.884000 31.151511 22.831250 16372 2 0.000000 -1 2.500000 37.884000 31.151511 22.831250 16373 2 0.000000 1 2.500000 30.996000 29.825915 26.343750 -16374 2 0.000000 -1.000000 2.500000 30.996000 29.825915 26.343750 +16374 2 0.000000 -1 2.500000 30.996000 29.825915 26.343750 16375 2 0.000000 1 2.500000 33.292000 25.849126 26.343750 16376 2 0.000000 -1 2.500000 33.292000 25.849126 26.343750 16377 2 0.000000 1 2.500000 35.588000 27.174722 29.856250 @@ -16395,7 +16395,7 @@ Atoms 16379 2 0.000000 1 2.500000 37.884000 31.151511 29.856250 16380 2 0.000000 -1 2.500000 37.884000 31.151511 29.856250 16381 2 0.000000 1 2.500000 30.996000 29.825915 33.368750 -16382 2 0.000000 -1.000000 2.500000 30.996000 29.825915 33.368750 +16382 2 0.000000 -1 2.500000 30.996000 29.825915 33.368750 16383 2 0.000000 1 2.500000 33.292000 25.849126 33.368750 16384 2 0.000000 -1 2.500000 33.292000 25.849126 33.368750 16385 2 0.000000 1 2.500000 35.588000 27.174722 36.881250 @@ -16403,7 +16403,7 @@ Atoms 16387 2 0.000000 1 2.500000 37.884000 31.151511 36.881250 16388 2 0.000000 -1 2.500000 37.884000 31.151511 36.881250 16389 2 0.000000 1 2.500000 30.996000 29.825915 40.393750 -16390 2 0.000000 -1.000000 2.500000 30.996000 29.825915 40.393750 +16390 2 0.000000 -1 2.500000 30.996000 29.825915 40.393750 16391 2 0.000000 1 2.500000 33.292000 25.849126 40.393750 16392 2 0.000000 -1 2.500000 33.292000 25.849126 40.393750 16393 2 0.000000 1 2.500000 35.588000 27.174722 43.906250 @@ -16411,7 +16411,7 @@ Atoms 16395 2 0.000000 1 2.500000 37.884000 31.151511 43.906250 16396 2 0.000000 -1 2.500000 37.884000 31.151511 43.906250 16397 2 0.000000 1 2.500000 30.996000 29.825915 47.418750 -16398 2 0.000000 -1.000000 2.500000 30.996000 29.825915 47.418750 +16398 2 0.000000 -1 2.500000 30.996000 29.825915 47.418750 16399 2 0.000000 1 2.500000 33.292000 25.849126 47.418750 16400 2 0.000000 -1 2.500000 33.292000 25.849126 47.418750 16401 2 0.000000 1 2.500000 35.588000 27.174722 50.931250 @@ -16419,7 +16419,7 @@ Atoms 16403 2 0.000000 1 2.500000 37.884000 31.151511 50.931250 16404 2 0.000000 -1 2.500000 37.884000 31.151511 50.931250 16405 2 0.000000 1 2.500000 30.996000 29.825915 54.443750 -16406 2 0.000000 -1.000000 2.500000 30.996000 29.825915 54.443750 +16406 2 0.000000 -1 2.500000 30.996000 29.825915 54.443750 16407 2 0.000000 1 2.500000 33.292000 25.849126 54.443750 16408 2 0.000000 -1 2.500000 33.292000 25.849126 54.443750 16409 2 0.000000 1 2.500000 35.588000 27.174722 57.956250 @@ -16427,7 +16427,7 @@ Atoms 16411 2 0.000000 1 2.500000 37.884000 31.151511 57.956250 16412 2 0.000000 -1 2.500000 37.884000 31.151511 57.956250 16413 2 0.000000 1 2.500000 30.996000 29.825915 61.468750 -16414 2 0.000000 -1.000000 2.500000 30.996000 29.825915 61.468750 +16414 2 0.000000 -1 2.500000 30.996000 29.825915 61.468750 16415 2 0.000000 1 2.500000 33.292000 25.849126 61.468750 16416 2 0.000000 -1 2.500000 33.292000 25.849126 61.468750 16417 2 0.000000 1 2.500000 35.588000 35.128300 1.756250 @@ -16435,7 +16435,7 @@ Atoms 16419 2 0.000000 1 2.500000 37.884000 39.105088 1.756250 16420 2 0.000000 -1 2.500000 37.884000 39.105088 1.756250 16421 2 0.000000 1 2.500000 30.996000 37.779492 5.268750 -16422 2 0.000000 -1.000000 2.500000 30.996000 37.779492 5.268750 +16422 2 0.000000 -1 2.500000 30.996000 37.779492 5.268750 16423 2 0.000000 1 2.500000 33.292000 33.802704 5.268750 16424 2 0.000000 -1 2.500000 33.292000 33.802704 5.268750 16425 2 0.000000 1 2.500000 35.588000 35.128300 8.781250 @@ -16443,7 +16443,7 @@ Atoms 16427 2 0.000000 1 2.500000 37.884000 39.105088 8.781250 16428 2 0.000000 -1 2.500000 37.884000 39.105088 8.781250 16429 2 0.000000 1 2.500000 30.996000 37.779492 12.293750 -16430 2 0.000000 -1.000000 2.500000 30.996000 37.779492 12.293750 +16430 2 0.000000 -1 2.500000 30.996000 37.779492 12.293750 16431 2 0.000000 1 2.500000 33.292000 33.802704 12.293750 16432 2 0.000000 -1 2.500000 33.292000 33.802704 12.293750 16433 2 0.000000 1 2.500000 35.588000 35.128300 15.806250 @@ -16451,7 +16451,7 @@ Atoms 16435 2 0.000000 1 2.500000 37.884000 39.105088 15.806250 16436 2 0.000000 -1 2.500000 37.884000 39.105088 15.806250 16437 2 0.000000 1 2.500000 30.996000 37.779492 19.318750 -16438 2 0.000000 -1.000000 2.500000 30.996000 37.779492 19.318750 +16438 2 0.000000 -1 2.500000 30.996000 37.779492 19.318750 16439 2 0.000000 1 2.500000 33.292000 33.802704 19.318750 16440 2 0.000000 -1 2.500000 33.292000 33.802704 19.318750 16441 2 0.000000 1 2.500000 35.588000 35.128300 22.831250 @@ -16459,7 +16459,7 @@ Atoms 16443 2 0.000000 1 2.500000 37.884000 39.105088 22.831250 16444 2 0.000000 -1 2.500000 37.884000 39.105088 22.831250 16445 2 0.000000 1 2.500000 30.996000 37.779492 26.343750 -16446 2 0.000000 -1.000000 2.500000 30.996000 37.779492 26.343750 +16446 2 0.000000 -1 2.500000 30.996000 37.779492 26.343750 16447 2 0.000000 1 2.500000 33.292000 33.802704 26.343750 16448 2 0.000000 -1 2.500000 33.292000 33.802704 26.343750 16449 2 0.000000 1 2.500000 35.588000 35.128300 29.856250 @@ -16467,7 +16467,7 @@ Atoms 16451 2 0.000000 1 2.500000 37.884000 39.105088 29.856250 16452 2 0.000000 -1 2.500000 37.884000 39.105088 29.856250 16453 2 0.000000 1 2.500000 30.996000 37.779492 33.368750 -16454 2 0.000000 -1.000000 2.500000 30.996000 37.779492 33.368750 +16454 2 0.000000 -1 2.500000 30.996000 37.779492 33.368750 16455 2 0.000000 1 2.500000 33.292000 33.802704 33.368750 16456 2 0.000000 -1 2.500000 33.292000 33.802704 33.368750 16457 2 0.000000 1 2.500000 35.588000 35.128300 36.881250 @@ -16475,7 +16475,7 @@ Atoms 16459 2 0.000000 1 2.500000 37.884000 39.105088 36.881250 16460 2 0.000000 -1 2.500000 37.884000 39.105088 36.881250 16461 2 0.000000 1 2.500000 30.996000 37.779492 40.393750 -16462 2 0.000000 -1.000000 2.500000 30.996000 37.779492 40.393750 +16462 2 0.000000 -1 2.500000 30.996000 37.779492 40.393750 16463 2 0.000000 1 2.500000 33.292000 33.802704 40.393750 16464 2 0.000000 -1 2.500000 33.292000 33.802704 40.393750 16465 2 0.000000 1 2.500000 35.588000 35.128300 43.906250 @@ -16483,7 +16483,7 @@ Atoms 16467 2 0.000000 1 2.500000 37.884000 39.105088 43.906250 16468 2 0.000000 -1 2.500000 37.884000 39.105088 43.906250 16469 2 0.000000 1 2.500000 30.996000 37.779492 47.418750 -16470 2 0.000000 -1.000000 2.500000 30.996000 37.779492 47.418750 +16470 2 0.000000 -1 2.500000 30.996000 37.779492 47.418750 16471 2 0.000000 1 2.500000 33.292000 33.802704 47.418750 16472 2 0.000000 -1 2.500000 33.292000 33.802704 47.418750 16473 2 0.000000 1 2.500000 35.588000 35.128300 50.931250 @@ -16491,7 +16491,7 @@ Atoms 16475 2 0.000000 1 2.500000 37.884000 39.105088 50.931250 16476 2 0.000000 -1 2.500000 37.884000 39.105088 50.931250 16477 2 0.000000 1 2.500000 30.996000 37.779492 54.443750 -16478 2 0.000000 -1.000000 2.500000 30.996000 37.779492 54.443750 +16478 2 0.000000 -1 2.500000 30.996000 37.779492 54.443750 16479 2 0.000000 1 2.500000 33.292000 33.802704 54.443750 16480 2 0.000000 -1 2.500000 33.292000 33.802704 54.443750 16481 2 0.000000 1 2.500000 35.588000 35.128300 57.956250 @@ -16499,7 +16499,7 @@ Atoms 16483 2 0.000000 1 2.500000 37.884000 39.105088 57.956250 16484 2 0.000000 -1 2.500000 37.884000 39.105088 57.956250 16485 2 0.000000 1 2.500000 30.996000 37.779492 61.468750 -16486 2 0.000000 -1.000000 2.500000 30.996000 37.779492 61.468750 +16486 2 0.000000 -1 2.500000 30.996000 37.779492 61.468750 16487 2 0.000000 1 2.500000 33.292000 33.802704 61.468750 16488 2 0.000000 -1 2.500000 33.292000 33.802704 61.468750 16489 2 0.000000 1 2.500000 35.588000 43.081877 1.756250 @@ -16507,7 +16507,7 @@ Atoms 16491 2 0.000000 1 2.500000 37.884000 47.058666 1.756250 16492 2 0.000000 -1 2.500000 37.884000 47.058666 1.756250 16493 2 0.000000 1 2.500000 30.996000 45.733070 5.268750 -16494 2 0.000000 -1.000000 2.500000 30.996000 45.733070 5.268750 +16494 2 0.000000 -1 2.500000 30.996000 45.733070 5.268750 16495 2 0.000000 1 2.500000 33.292000 41.756281 5.268750 16496 2 0.000000 -1 2.500000 33.292000 41.756281 5.268750 16497 2 0.000000 1 2.500000 35.588000 43.081877 8.781250 @@ -16515,7 +16515,7 @@ Atoms 16499 2 0.000000 1 2.500000 37.884000 47.058666 8.781250 16500 2 0.000000 -1 2.500000 37.884000 47.058666 8.781250 16501 2 0.000000 1 2.500000 30.996000 45.733070 12.293750 -16502 2 0.000000 -1.000000 2.500000 30.996000 45.733070 12.293750 +16502 2 0.000000 -1 2.500000 30.996000 45.733070 12.293750 16503 2 0.000000 1 2.500000 33.292000 41.756281 12.293750 16504 2 0.000000 -1 2.500000 33.292000 41.756281 12.293750 16505 2 0.000000 1 2.500000 35.588000 43.081877 15.806250 @@ -16523,7 +16523,7 @@ Atoms 16507 2 0.000000 1 2.500000 37.884000 47.058666 15.806250 16508 2 0.000000 -1 2.500000 37.884000 47.058666 15.806250 16509 2 0.000000 1 2.500000 30.996000 45.733070 19.318750 -16510 2 0.000000 -1.000000 2.500000 30.996000 45.733070 19.318750 +16510 2 0.000000 -1 2.500000 30.996000 45.733070 19.318750 16511 2 0.000000 1 2.500000 33.292000 41.756281 19.318750 16512 2 0.000000 -1 2.500000 33.292000 41.756281 19.318750 16513 2 0.000000 1 2.500000 35.588000 43.081877 22.831250 @@ -16531,7 +16531,7 @@ Atoms 16515 2 0.000000 1 2.500000 37.884000 47.058666 22.831250 16516 2 0.000000 -1 2.500000 37.884000 47.058666 22.831250 16517 2 0.000000 1 2.500000 30.996000 45.733070 26.343750 -16518 2 0.000000 -1.000000 2.500000 30.996000 45.733070 26.343750 +16518 2 0.000000 -1 2.500000 30.996000 45.733070 26.343750 16519 2 0.000000 1 2.500000 33.292000 41.756281 26.343750 16520 2 0.000000 -1 2.500000 33.292000 41.756281 26.343750 16521 2 0.000000 1 2.500000 35.588000 43.081877 29.856250 @@ -16539,7 +16539,7 @@ Atoms 16523 2 0.000000 1 2.500000 37.884000 47.058666 29.856250 16524 2 0.000000 -1 2.500000 37.884000 47.058666 29.856250 16525 2 0.000000 1 2.500000 30.996000 45.733070 33.368750 -16526 2 0.000000 -1.000000 2.500000 30.996000 45.733070 33.368750 +16526 2 0.000000 -1 2.500000 30.996000 45.733070 33.368750 16527 2 0.000000 1 2.500000 33.292000 41.756281 33.368750 16528 2 0.000000 -1 2.500000 33.292000 41.756281 33.368750 16529 2 0.000000 1 2.500000 35.588000 43.081877 36.881250 @@ -16547,7 +16547,7 @@ Atoms 16531 2 0.000000 1 2.500000 37.884000 47.058666 36.881250 16532 2 0.000000 -1 2.500000 37.884000 47.058666 36.881250 16533 2 0.000000 1 2.500000 30.996000 45.733070 40.393750 -16534 2 0.000000 -1.000000 2.500000 30.996000 45.733070 40.393750 +16534 2 0.000000 -1 2.500000 30.996000 45.733070 40.393750 16535 2 0.000000 1 2.500000 33.292000 41.756281 40.393750 16536 2 0.000000 -1 2.500000 33.292000 41.756281 40.393750 16537 2 0.000000 1 2.500000 35.588000 43.081877 43.906250 @@ -16555,7 +16555,7 @@ Atoms 16539 2 0.000000 1 2.500000 37.884000 47.058666 43.906250 16540 2 0.000000 -1 2.500000 37.884000 47.058666 43.906250 16541 2 0.000000 1 2.500000 30.996000 45.733070 47.418750 -16542 2 0.000000 -1.000000 2.500000 30.996000 45.733070 47.418750 +16542 2 0.000000 -1 2.500000 30.996000 45.733070 47.418750 16543 2 0.000000 1 2.500000 33.292000 41.756281 47.418750 16544 2 0.000000 -1 2.500000 33.292000 41.756281 47.418750 16545 2 0.000000 1 2.500000 35.588000 43.081877 50.931250 @@ -16563,7 +16563,7 @@ Atoms 16547 2 0.000000 1 2.500000 37.884000 47.058666 50.931250 16548 2 0.000000 -1 2.500000 37.884000 47.058666 50.931250 16549 2 0.000000 1 2.500000 30.996000 45.733070 54.443750 -16550 2 0.000000 -1.000000 2.500000 30.996000 45.733070 54.443750 +16550 2 0.000000 -1 2.500000 30.996000 45.733070 54.443750 16551 2 0.000000 1 2.500000 33.292000 41.756281 54.443750 16552 2 0.000000 -1 2.500000 33.292000 41.756281 54.443750 16553 2 0.000000 1 2.500000 35.588000 43.081877 57.956250 @@ -16571,7 +16571,7 @@ Atoms 16555 2 0.000000 1 2.500000 37.884000 47.058666 57.956250 16556 2 0.000000 -1 2.500000 37.884000 47.058666 57.956250 16557 2 0.000000 1 2.500000 30.996000 45.733070 61.468750 -16558 2 0.000000 -1.000000 2.500000 30.996000 45.733070 61.468750 +16558 2 0.000000 -1 2.500000 30.996000 45.733070 61.468750 16559 2 0.000000 1 2.500000 33.292000 41.756281 61.468750 16560 2 0.000000 -1 2.500000 33.292000 41.756281 61.468750 16561 2 0.000000 1 2.500000 35.588000 51.035454 1.756250 @@ -16579,7 +16579,7 @@ Atoms 16563 2 0.000000 1 2.500000 37.884000 55.012243 1.756250 16564 2 0.000000 -1 2.500000 37.884000 55.012243 1.756250 16565 2 0.000000 1 2.500000 30.996000 53.686647 5.268750 -16566 2 0.000000 -1.000000 2.500000 30.996000 53.686647 5.268750 +16566 2 0.000000 -1 2.500000 30.996000 53.686647 5.268750 16567 2 0.000000 1 2.500000 33.292000 49.709858 5.268750 16568 2 0.000000 -1 2.500000 33.292000 49.709858 5.268750 16569 2 0.000000 1 2.500000 35.588000 51.035454 8.781250 @@ -16587,7 +16587,7 @@ Atoms 16571 2 0.000000 1 2.500000 37.884000 55.012243 8.781250 16572 2 0.000000 -1 2.500000 37.884000 55.012243 8.781250 16573 2 0.000000 1 2.500000 30.996000 53.686647 12.293750 -16574 2 0.000000 -1.000000 2.500000 30.996000 53.686647 12.293750 +16574 2 0.000000 -1 2.500000 30.996000 53.686647 12.293750 16575 2 0.000000 1 2.500000 33.292000 49.709858 12.293750 16576 2 0.000000 -1 2.500000 33.292000 49.709858 12.293750 16577 2 0.000000 1 2.500000 35.588000 51.035454 15.806250 @@ -16595,7 +16595,7 @@ Atoms 16579 2 0.000000 1 2.500000 37.884000 55.012243 15.806250 16580 2 0.000000 -1 2.500000 37.884000 55.012243 15.806250 16581 2 0.000000 1 2.500000 30.996000 53.686647 19.318750 -16582 2 0.000000 -1.000000 2.500000 30.996000 53.686647 19.318750 +16582 2 0.000000 -1 2.500000 30.996000 53.686647 19.318750 16583 2 0.000000 1 2.500000 33.292000 49.709858 19.318750 16584 2 0.000000 -1 2.500000 33.292000 49.709858 19.318750 16585 2 0.000000 1 2.500000 35.588000 51.035454 22.831250 @@ -16603,7 +16603,7 @@ Atoms 16587 2 0.000000 1 2.500000 37.884000 55.012243 22.831250 16588 2 0.000000 -1 2.500000 37.884000 55.012243 22.831250 16589 2 0.000000 1 2.500000 30.996000 53.686647 26.343750 -16590 2 0.000000 -1.000000 2.500000 30.996000 53.686647 26.343750 +16590 2 0.000000 -1 2.500000 30.996000 53.686647 26.343750 16591 2 0.000000 1 2.500000 33.292000 49.709858 26.343750 16592 2 0.000000 -1 2.500000 33.292000 49.709858 26.343750 16593 2 0.000000 1 2.500000 35.588000 51.035454 29.856250 @@ -16611,7 +16611,7 @@ Atoms 16595 2 0.000000 1 2.500000 37.884000 55.012243 29.856250 16596 2 0.000000 -1 2.500000 37.884000 55.012243 29.856250 16597 2 0.000000 1 2.500000 30.996000 53.686647 33.368750 -16598 2 0.000000 -1.000000 2.500000 30.996000 53.686647 33.368750 +16598 2 0.000000 -1 2.500000 30.996000 53.686647 33.368750 16599 2 0.000000 1 2.500000 33.292000 49.709858 33.368750 16600 2 0.000000 -1 2.500000 33.292000 49.709858 33.368750 16601 2 0.000000 1 2.500000 35.588000 51.035454 36.881250 @@ -16619,7 +16619,7 @@ Atoms 16603 2 0.000000 1 2.500000 37.884000 55.012243 36.881250 16604 2 0.000000 -1 2.500000 37.884000 55.012243 36.881250 16605 2 0.000000 1 2.500000 30.996000 53.686647 40.393750 -16606 2 0.000000 -1.000000 2.500000 30.996000 53.686647 40.393750 +16606 2 0.000000 -1 2.500000 30.996000 53.686647 40.393750 16607 2 0.000000 1 2.500000 33.292000 49.709858 40.393750 16608 2 0.000000 -1 2.500000 33.292000 49.709858 40.393750 16609 2 0.000000 1 2.500000 35.588000 51.035454 43.906250 @@ -16627,7 +16627,7 @@ Atoms 16611 2 0.000000 1 2.500000 37.884000 55.012243 43.906250 16612 2 0.000000 -1 2.500000 37.884000 55.012243 43.906250 16613 2 0.000000 1 2.500000 30.996000 53.686647 47.418750 -16614 2 0.000000 -1.000000 2.500000 30.996000 53.686647 47.418750 +16614 2 0.000000 -1 2.500000 30.996000 53.686647 47.418750 16615 2 0.000000 1 2.500000 33.292000 49.709858 47.418750 16616 2 0.000000 -1 2.500000 33.292000 49.709858 47.418750 16617 2 0.000000 1 2.500000 35.588000 51.035454 50.931250 @@ -16635,7 +16635,7 @@ Atoms 16619 2 0.000000 1 2.500000 37.884000 55.012243 50.931250 16620 2 0.000000 -1 2.500000 37.884000 55.012243 50.931250 16621 2 0.000000 1 2.500000 30.996000 53.686647 54.443750 -16622 2 0.000000 -1.000000 2.500000 30.996000 53.686647 54.443750 +16622 2 0.000000 -1 2.500000 30.996000 53.686647 54.443750 16623 2 0.000000 1 2.500000 33.292000 49.709858 54.443750 16624 2 0.000000 -1 2.500000 33.292000 49.709858 54.443750 16625 2 0.000000 1 2.500000 35.588000 51.035454 57.956250 @@ -16643,7 +16643,7 @@ Atoms 16627 2 0.000000 1 2.500000 37.884000 55.012243 57.956250 16628 2 0.000000 -1 2.500000 37.884000 55.012243 57.956250 16629 2 0.000000 1 2.500000 30.996000 53.686647 61.468750 -16630 2 0.000000 -1.000000 2.500000 30.996000 53.686647 61.468750 +16630 2 0.000000 -1 2.500000 30.996000 53.686647 61.468750 16631 2 0.000000 1 2.500000 33.292000 49.709858 61.468750 16632 2 0.000000 -1 2.500000 33.292000 49.709858 61.468750 16633 2 0.000000 1 2.500000 35.588000 58.989032 1.756250 @@ -16651,7 +16651,7 @@ Atoms 16635 2 0.000000 1 2.500000 37.884000 62.965820 1.756250 16636 2 0.000000 -1 2.500000 37.884000 62.965820 1.756250 16637 2 0.000000 1 2.500000 30.996000 61.640224 5.268750 -16638 2 0.000000 -1.000000 2.500000 30.996000 61.640224 5.268750 +16638 2 0.000000 -1 2.500000 30.996000 61.640224 5.268750 16639 2 0.000000 1 2.500000 33.292000 57.663435 5.268750 16640 2 0.000000 -1 2.500000 33.292000 57.663435 5.268750 16641 2 0.000000 1 2.500000 35.588000 58.989032 8.781250 @@ -16659,7 +16659,7 @@ Atoms 16643 2 0.000000 1 2.500000 37.884000 62.965820 8.781250 16644 2 0.000000 -1 2.500000 37.884000 62.965820 8.781250 16645 2 0.000000 1 2.500000 30.996000 61.640224 12.293750 -16646 2 0.000000 -1.000000 2.500000 30.996000 61.640224 12.293750 +16646 2 0.000000 -1 2.500000 30.996000 61.640224 12.293750 16647 2 0.000000 1 2.500000 33.292000 57.663435 12.293750 16648 2 0.000000 -1 2.500000 33.292000 57.663435 12.293750 16649 2 0.000000 1 2.500000 35.588000 58.989032 15.806250 @@ -16667,7 +16667,7 @@ Atoms 16651 2 0.000000 1 2.500000 37.884000 62.965820 15.806250 16652 2 0.000000 -1 2.500000 37.884000 62.965820 15.806250 16653 2 0.000000 1 2.500000 30.996000 61.640224 19.318750 -16654 2 0.000000 -1.000000 2.500000 30.996000 61.640224 19.318750 +16654 2 0.000000 -1 2.500000 30.996000 61.640224 19.318750 16655 2 0.000000 1 2.500000 33.292000 57.663435 19.318750 16656 2 0.000000 -1 2.500000 33.292000 57.663435 19.318750 16657 2 0.000000 1 2.500000 35.588000 58.989032 22.831250 @@ -16675,7 +16675,7 @@ Atoms 16659 2 0.000000 1 2.500000 37.884000 62.965820 22.831250 16660 2 0.000000 -1 2.500000 37.884000 62.965820 22.831250 16661 2 0.000000 1 2.500000 30.996000 61.640224 26.343750 -16662 2 0.000000 -1.000000 2.500000 30.996000 61.640224 26.343750 +16662 2 0.000000 -1 2.500000 30.996000 61.640224 26.343750 16663 2 0.000000 1 2.500000 33.292000 57.663435 26.343750 16664 2 0.000000 -1 2.500000 33.292000 57.663435 26.343750 16665 2 0.000000 1 2.500000 35.588000 58.989032 29.856250 @@ -16683,7 +16683,7 @@ Atoms 16667 2 0.000000 1 2.500000 37.884000 62.965820 29.856250 16668 2 0.000000 -1 2.500000 37.884000 62.965820 29.856250 16669 2 0.000000 1 2.500000 30.996000 61.640224 33.368750 -16670 2 0.000000 -1.000000 2.500000 30.996000 61.640224 33.368750 +16670 2 0.000000 -1 2.500000 30.996000 61.640224 33.368750 16671 2 0.000000 1 2.500000 33.292000 57.663435 33.368750 16672 2 0.000000 -1 2.500000 33.292000 57.663435 33.368750 16673 2 0.000000 1 2.500000 35.588000 58.989032 36.881250 @@ -16691,7 +16691,7 @@ Atoms 16675 2 0.000000 1 2.500000 37.884000 62.965820 36.881250 16676 2 0.000000 -1 2.500000 37.884000 62.965820 36.881250 16677 2 0.000000 1 2.500000 30.996000 61.640224 40.393750 -16678 2 0.000000 -1.000000 2.500000 30.996000 61.640224 40.393750 +16678 2 0.000000 -1 2.500000 30.996000 61.640224 40.393750 16679 2 0.000000 1 2.500000 33.292000 57.663435 40.393750 16680 2 0.000000 -1 2.500000 33.292000 57.663435 40.393750 16681 2 0.000000 1 2.500000 35.588000 58.989032 43.906250 @@ -16699,7 +16699,7 @@ Atoms 16683 2 0.000000 1 2.500000 37.884000 62.965820 43.906250 16684 2 0.000000 -1 2.500000 37.884000 62.965820 43.906250 16685 2 0.000000 1 2.500000 30.996000 61.640224 47.418750 -16686 2 0.000000 -1.000000 2.500000 30.996000 61.640224 47.418750 +16686 2 0.000000 -1 2.500000 30.996000 61.640224 47.418750 16687 2 0.000000 1 2.500000 33.292000 57.663435 47.418750 16688 2 0.000000 -1 2.500000 33.292000 57.663435 47.418750 16689 2 0.000000 1 2.500000 35.588000 58.989032 50.931250 @@ -16707,7 +16707,7 @@ Atoms 16691 2 0.000000 1 2.500000 37.884000 62.965820 50.931250 16692 2 0.000000 -1 2.500000 37.884000 62.965820 50.931250 16693 2 0.000000 1 2.500000 30.996000 61.640224 54.443750 -16694 2 0.000000 -1.000000 2.500000 30.996000 61.640224 54.443750 +16694 2 0.000000 -1 2.500000 30.996000 61.640224 54.443750 16695 2 0.000000 1 2.500000 33.292000 57.663435 54.443750 16696 2 0.000000 -1 2.500000 33.292000 57.663435 54.443750 16697 2 0.000000 1 2.500000 35.588000 58.989032 57.956250 @@ -16715,7 +16715,7 @@ Atoms 16699 2 0.000000 1 2.500000 37.884000 62.965820 57.956250 16700 2 0.000000 -1 2.500000 37.884000 62.965820 57.956250 16701 2 0.000000 1 2.500000 30.996000 61.640224 61.468750 -16702 2 0.000000 -1.000000 2.500000 30.996000 61.640224 61.468750 +16702 2 0.000000 -1 2.500000 30.996000 61.640224 61.468750 16703 2 0.000000 1 2.500000 33.292000 57.663435 61.468750 16704 2 0.000000 -1 2.500000 33.292000 57.663435 61.468750 16705 2 0.000000 1 2.500000 40.180000 3.313991 1.756250 @@ -16723,7 +16723,7 @@ Atoms 16707 2 0.000000 1 2.500000 42.476000 7.290779 1.756250 16708 2 0.000000 -1 2.500000 42.476000 7.290779 1.756250 16709 2 0.000000 1 2.500000 35.588000 5.965183 5.268750 -16710 2 0.000000 -1.000000 2.500000 35.588000 5.965183 5.268750 +16710 2 0.000000 -1 2.500000 35.588000 5.965183 5.268750 16711 2 0.000000 1 2.500000 37.884000 1.988394 5.268750 16712 2 0.000000 -1 2.500000 37.884000 1.988394 5.268750 16713 2 0.000000 1 2.500000 40.180000 3.313991 8.781250 @@ -16731,7 +16731,7 @@ Atoms 16715 2 0.000000 1 2.500000 42.476000 7.290779 8.781250 16716 2 0.000000 -1 2.500000 42.476000 7.290779 8.781250 16717 2 0.000000 1 2.500000 35.588000 5.965183 12.293750 -16718 2 0.000000 -1.000000 2.500000 35.588000 5.965183 12.293750 +16718 2 0.000000 -1 2.500000 35.588000 5.965183 12.293750 16719 2 0.000000 1 2.500000 37.884000 1.988394 12.293750 16720 2 0.000000 -1 2.500000 37.884000 1.988394 12.293750 16721 2 0.000000 1 2.500000 40.180000 3.313991 15.806250 @@ -16739,7 +16739,7 @@ Atoms 16723 2 0.000000 1 2.500000 42.476000 7.290779 15.806250 16724 2 0.000000 -1 2.500000 42.476000 7.290779 15.806250 16725 2 0.000000 1 2.500000 35.588000 5.965183 19.318750 -16726 2 0.000000 -1.000000 2.500000 35.588000 5.965183 19.318750 +16726 2 0.000000 -1 2.500000 35.588000 5.965183 19.318750 16727 2 0.000000 1 2.500000 37.884000 1.988394 19.318750 16728 2 0.000000 -1 2.500000 37.884000 1.988394 19.318750 16729 2 0.000000 1 2.500000 40.180000 3.313991 22.831250 @@ -16747,7 +16747,7 @@ Atoms 16731 2 0.000000 1 2.500000 42.476000 7.290779 22.831250 16732 2 0.000000 -1 2.500000 42.476000 7.290779 22.831250 16733 2 0.000000 1 2.500000 35.588000 5.965183 26.343750 -16734 2 0.000000 -1.000000 2.500000 35.588000 5.965183 26.343750 +16734 2 0.000000 -1 2.500000 35.588000 5.965183 26.343750 16735 2 0.000000 1 2.500000 37.884000 1.988394 26.343750 16736 2 0.000000 -1 2.500000 37.884000 1.988394 26.343750 16737 2 0.000000 1 2.500000 40.180000 3.313991 29.856250 @@ -16755,7 +16755,7 @@ Atoms 16739 2 0.000000 1 2.500000 42.476000 7.290779 29.856250 16740 2 0.000000 -1 2.500000 42.476000 7.290779 29.856250 16741 2 0.000000 1 2.500000 35.588000 5.965183 33.368750 -16742 2 0.000000 -1.000000 2.500000 35.588000 5.965183 33.368750 +16742 2 0.000000 -1 2.500000 35.588000 5.965183 33.368750 16743 2 0.000000 1 2.500000 37.884000 1.988394 33.368750 16744 2 0.000000 -1 2.500000 37.884000 1.988394 33.368750 16745 2 0.000000 1 2.500000 40.180000 3.313991 36.881250 @@ -16763,7 +16763,7 @@ Atoms 16747 2 0.000000 1 2.500000 42.476000 7.290779 36.881250 16748 2 0.000000 -1 2.500000 42.476000 7.290779 36.881250 16749 2 0.000000 1 2.500000 35.588000 5.965183 40.393750 -16750 2 0.000000 -1.000000 2.500000 35.588000 5.965183 40.393750 +16750 2 0.000000 -1 2.500000 35.588000 5.965183 40.393750 16751 2 0.000000 1 2.500000 37.884000 1.988394 40.393750 16752 2 0.000000 -1 2.500000 37.884000 1.988394 40.393750 16753 2 0.000000 1 2.500000 40.180000 3.313991 43.906250 @@ -16771,7 +16771,7 @@ Atoms 16755 2 0.000000 1 2.500000 42.476000 7.290779 43.906250 16756 2 0.000000 -1 2.500000 42.476000 7.290779 43.906250 16757 2 0.000000 1 2.500000 35.588000 5.965183 47.418750 -16758 2 0.000000 -1.000000 2.500000 35.588000 5.965183 47.418750 +16758 2 0.000000 -1 2.500000 35.588000 5.965183 47.418750 16759 2 0.000000 1 2.500000 37.884000 1.988394 47.418750 16760 2 0.000000 -1 2.500000 37.884000 1.988394 47.418750 16761 2 0.000000 1 2.500000 40.180000 3.313991 50.931250 @@ -16779,7 +16779,7 @@ Atoms 16763 2 0.000000 1 2.500000 42.476000 7.290779 50.931250 16764 2 0.000000 -1 2.500000 42.476000 7.290779 50.931250 16765 2 0.000000 1 2.500000 35.588000 5.965183 54.443750 -16766 2 0.000000 -1.000000 2.500000 35.588000 5.965183 54.443750 +16766 2 0.000000 -1 2.500000 35.588000 5.965183 54.443750 16767 2 0.000000 1 2.500000 37.884000 1.988394 54.443750 16768 2 0.000000 -1 2.500000 37.884000 1.988394 54.443750 16769 2 0.000000 1 2.500000 40.180000 3.313991 57.956250 @@ -16787,7 +16787,7 @@ Atoms 16771 2 0.000000 1 2.500000 42.476000 7.290779 57.956250 16772 2 0.000000 -1 2.500000 42.476000 7.290779 57.956250 16773 2 0.000000 1 2.500000 35.588000 5.965183 61.468750 -16774 2 0.000000 -1.000000 2.500000 35.588000 5.965183 61.468750 +16774 2 0.000000 -1 2.500000 35.588000 5.965183 61.468750 16775 2 0.000000 1 2.500000 37.884000 1.988394 61.468750 16776 2 0.000000 -1 2.500000 37.884000 1.988394 61.468750 16777 2 0.000000 1 2.500000 40.180000 11.267568 1.756250 @@ -16795,7 +16795,7 @@ Atoms 16779 2 0.000000 1 2.500000 42.476000 15.244357 1.756250 16780 2 0.000000 -1 2.500000 42.476000 15.244357 1.756250 16781 2 0.000000 1 2.500000 35.588000 13.918760 5.268750 -16782 2 0.000000 -1.000000 2.500000 35.588000 13.918760 5.268750 +16782 2 0.000000 -1 2.500000 35.588000 13.918760 5.268750 16783 2 0.000000 1 2.500000 37.884000 9.941972 5.268750 16784 2 0.000000 -1 2.500000 37.884000 9.941972 5.268750 16785 2 0.000000 1 2.500000 40.180000 11.267568 8.781250 @@ -16803,7 +16803,7 @@ Atoms 16787 2 0.000000 1 2.500000 42.476000 15.244357 8.781250 16788 2 0.000000 -1 2.500000 42.476000 15.244357 8.781250 16789 2 0.000000 1 2.500000 35.588000 13.918760 12.293750 -16790 2 0.000000 -1.000000 2.500000 35.588000 13.918760 12.293750 +16790 2 0.000000 -1 2.500000 35.588000 13.918760 12.293750 16791 2 0.000000 1 2.500000 37.884000 9.941972 12.293750 16792 2 0.000000 -1 2.500000 37.884000 9.941972 12.293750 16793 2 0.000000 1 2.500000 40.180000 11.267568 15.806250 @@ -16811,7 +16811,7 @@ Atoms 16795 2 0.000000 1 2.500000 42.476000 15.244357 15.806250 16796 2 0.000000 -1 2.500000 42.476000 15.244357 15.806250 16797 2 0.000000 1 2.500000 35.588000 13.918760 19.318750 -16798 2 0.000000 -1.000000 2.500000 35.588000 13.918760 19.318750 +16798 2 0.000000 -1 2.500000 35.588000 13.918760 19.318750 16799 2 0.000000 1 2.500000 37.884000 9.941972 19.318750 16800 2 0.000000 -1 2.500000 37.884000 9.941972 19.318750 16801 2 0.000000 1 2.500000 40.180000 11.267568 22.831250 @@ -16819,7 +16819,7 @@ Atoms 16803 2 0.000000 1 2.500000 42.476000 15.244357 22.831250 16804 2 0.000000 -1 2.500000 42.476000 15.244357 22.831250 16805 2 0.000000 1 2.500000 35.588000 13.918760 26.343750 -16806 2 0.000000 -1.000000 2.500000 35.588000 13.918760 26.343750 +16806 2 0.000000 -1 2.500000 35.588000 13.918760 26.343750 16807 2 0.000000 1 2.500000 37.884000 9.941972 26.343750 16808 2 0.000000 -1 2.500000 37.884000 9.941972 26.343750 16809 2 0.000000 1 2.500000 40.180000 11.267568 29.856250 @@ -16827,7 +16827,7 @@ Atoms 16811 2 0.000000 1 2.500000 42.476000 15.244357 29.856250 16812 2 0.000000 -1 2.500000 42.476000 15.244357 29.856250 16813 2 0.000000 1 2.500000 35.588000 13.918760 33.368750 -16814 2 0.000000 -1.000000 2.500000 35.588000 13.918760 33.368750 +16814 2 0.000000 -1 2.500000 35.588000 13.918760 33.368750 16815 2 0.000000 1 2.500000 37.884000 9.941972 33.368750 16816 2 0.000000 -1 2.500000 37.884000 9.941972 33.368750 16817 2 0.000000 1 2.500000 40.180000 11.267568 36.881250 @@ -16835,7 +16835,7 @@ Atoms 16819 2 0.000000 1 2.500000 42.476000 15.244357 36.881250 16820 2 0.000000 -1 2.500000 42.476000 15.244357 36.881250 16821 2 0.000000 1 2.500000 35.588000 13.918760 40.393750 -16822 2 0.000000 -1.000000 2.500000 35.588000 13.918760 40.393750 +16822 2 0.000000 -1 2.500000 35.588000 13.918760 40.393750 16823 2 0.000000 1 2.500000 37.884000 9.941972 40.393750 16824 2 0.000000 -1 2.500000 37.884000 9.941972 40.393750 16825 2 0.000000 1 2.500000 40.180000 11.267568 43.906250 @@ -16843,7 +16843,7 @@ Atoms 16827 2 0.000000 1 2.500000 42.476000 15.244357 43.906250 16828 2 0.000000 -1 2.500000 42.476000 15.244357 43.906250 16829 2 0.000000 1 2.500000 35.588000 13.918760 47.418750 -16830 2 0.000000 -1.000000 2.500000 35.588000 13.918760 47.418750 +16830 2 0.000000 -1 2.500000 35.588000 13.918760 47.418750 16831 2 0.000000 1 2.500000 37.884000 9.941972 47.418750 16832 2 0.000000 -1 2.500000 37.884000 9.941972 47.418750 16833 2 0.000000 1 2.500000 40.180000 11.267568 50.931250 @@ -16851,7 +16851,7 @@ Atoms 16835 2 0.000000 1 2.500000 42.476000 15.244357 50.931250 16836 2 0.000000 -1 2.500000 42.476000 15.244357 50.931250 16837 2 0.000000 1 2.500000 35.588000 13.918760 54.443750 -16838 2 0.000000 -1.000000 2.500000 35.588000 13.918760 54.443750 +16838 2 0.000000 -1 2.500000 35.588000 13.918760 54.443750 16839 2 0.000000 1 2.500000 37.884000 9.941972 54.443750 16840 2 0.000000 -1 2.500000 37.884000 9.941972 54.443750 16841 2 0.000000 1 2.500000 40.180000 11.267568 57.956250 @@ -16859,7 +16859,7 @@ Atoms 16843 2 0.000000 1 2.500000 42.476000 15.244357 57.956250 16844 2 0.000000 -1 2.500000 42.476000 15.244357 57.956250 16845 2 0.000000 1 2.500000 35.588000 13.918760 61.468750 -16846 2 0.000000 -1.000000 2.500000 35.588000 13.918760 61.468750 +16846 2 0.000000 -1 2.500000 35.588000 13.918760 61.468750 16847 2 0.000000 1 2.500000 37.884000 9.941972 61.468750 16848 2 0.000000 -1 2.500000 37.884000 9.941972 61.468750 16849 2 0.000000 1 2.500000 40.180000 19.221145 1.756250 @@ -16867,7 +16867,7 @@ Atoms 16851 2 0.000000 1 2.500000 42.476000 23.197934 1.756250 16852 2 0.000000 -1 2.500000 42.476000 23.197934 1.756250 16853 2 0.000000 1 2.500000 35.588000 21.872338 5.268750 -16854 2 0.000000 -1.000000 2.500000 35.588000 21.872338 5.268750 +16854 2 0.000000 -1 2.500000 35.588000 21.872338 5.268750 16855 2 0.000000 1 2.500000 37.884000 17.895549 5.268750 16856 2 0.000000 -1 2.500000 37.884000 17.895549 5.268750 16857 2 0.000000 1 2.500000 40.180000 19.221145 8.781250 @@ -16875,7 +16875,7 @@ Atoms 16859 2 0.000000 1 2.500000 42.476000 23.197934 8.781250 16860 2 0.000000 -1 2.500000 42.476000 23.197934 8.781250 16861 2 0.000000 1 2.500000 35.588000 21.872338 12.293750 -16862 2 0.000000 -1.000000 2.500000 35.588000 21.872338 12.293750 +16862 2 0.000000 -1 2.500000 35.588000 21.872338 12.293750 16863 2 0.000000 1 2.500000 37.884000 17.895549 12.293750 16864 2 0.000000 -1 2.500000 37.884000 17.895549 12.293750 16865 2 0.000000 1 2.500000 40.180000 19.221145 15.806250 @@ -16883,7 +16883,7 @@ Atoms 16867 2 0.000000 1 2.500000 42.476000 23.197934 15.806250 16868 2 0.000000 -1 2.500000 42.476000 23.197934 15.806250 16869 2 0.000000 1 2.500000 35.588000 21.872338 19.318750 -16870 2 0.000000 -1.000000 2.500000 35.588000 21.872338 19.318750 +16870 2 0.000000 -1 2.500000 35.588000 21.872338 19.318750 16871 2 0.000000 1 2.500000 37.884000 17.895549 19.318750 16872 2 0.000000 -1 2.500000 37.884000 17.895549 19.318750 16873 2 0.000000 1 2.500000 40.180000 19.221145 22.831250 @@ -16891,7 +16891,7 @@ Atoms 16875 2 0.000000 1 2.500000 42.476000 23.197934 22.831250 16876 2 0.000000 -1 2.500000 42.476000 23.197934 22.831250 16877 2 0.000000 1 2.500000 35.588000 21.872338 26.343750 -16878 2 0.000000 -1.000000 2.500000 35.588000 21.872338 26.343750 +16878 2 0.000000 -1 2.500000 35.588000 21.872338 26.343750 16879 2 0.000000 1 2.500000 37.884000 17.895549 26.343750 16880 2 0.000000 -1 2.500000 37.884000 17.895549 26.343750 16881 2 0.000000 1 2.500000 40.180000 19.221145 29.856250 @@ -16899,7 +16899,7 @@ Atoms 16883 2 0.000000 1 2.500000 42.476000 23.197934 29.856250 16884 2 0.000000 -1 2.500000 42.476000 23.197934 29.856250 16885 2 0.000000 1 2.500000 35.588000 21.872338 33.368750 -16886 2 0.000000 -1.000000 2.500000 35.588000 21.872338 33.368750 +16886 2 0.000000 -1 2.500000 35.588000 21.872338 33.368750 16887 2 0.000000 1 2.500000 37.884000 17.895549 33.368750 16888 2 0.000000 -1 2.500000 37.884000 17.895549 33.368750 16889 2 0.000000 1 2.500000 40.180000 19.221145 36.881250 @@ -16907,7 +16907,7 @@ Atoms 16891 2 0.000000 1 2.500000 42.476000 23.197934 36.881250 16892 2 0.000000 -1 2.500000 42.476000 23.197934 36.881250 16893 2 0.000000 1 2.500000 35.588000 21.872338 40.393750 -16894 2 0.000000 -1.000000 2.500000 35.588000 21.872338 40.393750 +16894 2 0.000000 -1 2.500000 35.588000 21.872338 40.393750 16895 2 0.000000 1 2.500000 37.884000 17.895549 40.393750 16896 2 0.000000 -1 2.500000 37.884000 17.895549 40.393750 16897 2 0.000000 1 2.500000 40.180000 19.221145 43.906250 @@ -16915,7 +16915,7 @@ Atoms 16899 2 0.000000 1 2.500000 42.476000 23.197934 43.906250 16900 2 0.000000 -1 2.500000 42.476000 23.197934 43.906250 16901 2 0.000000 1 2.500000 35.588000 21.872338 47.418750 -16902 2 0.000000 -1.000000 2.500000 35.588000 21.872338 47.418750 +16902 2 0.000000 -1 2.500000 35.588000 21.872338 47.418750 16903 2 0.000000 1 2.500000 37.884000 17.895549 47.418750 16904 2 0.000000 -1 2.500000 37.884000 17.895549 47.418750 16905 2 0.000000 1 2.500000 40.180000 19.221145 50.931250 @@ -16923,7 +16923,7 @@ Atoms 16907 2 0.000000 1 2.500000 42.476000 23.197934 50.931250 16908 2 0.000000 -1 2.500000 42.476000 23.197934 50.931250 16909 2 0.000000 1 2.500000 35.588000 21.872338 54.443750 -16910 2 0.000000 -1.000000 2.500000 35.588000 21.872338 54.443750 +16910 2 0.000000 -1 2.500000 35.588000 21.872338 54.443750 16911 2 0.000000 1 2.500000 37.884000 17.895549 54.443750 16912 2 0.000000 -1 2.500000 37.884000 17.895549 54.443750 16913 2 0.000000 1 2.500000 40.180000 19.221145 57.956250 @@ -16931,7 +16931,7 @@ Atoms 16915 2 0.000000 1 2.500000 42.476000 23.197934 57.956250 16916 2 0.000000 -1 2.500000 42.476000 23.197934 57.956250 16917 2 0.000000 1 2.500000 35.588000 21.872338 61.468750 -16918 2 0.000000 -1.000000 2.500000 35.588000 21.872338 61.468750 +16918 2 0.000000 -1 2.500000 35.588000 21.872338 61.468750 16919 2 0.000000 1 2.500000 37.884000 17.895549 61.468750 16920 2 0.000000 -1 2.500000 37.884000 17.895549 61.468750 16921 2 0.000000 1 2.500000 40.180000 27.174722 1.756250 @@ -16939,7 +16939,7 @@ Atoms 16923 2 0.000000 1 2.500000 42.476000 31.151511 1.756250 16924 2 0.000000 -1 2.500000 42.476000 31.151511 1.756250 16925 2 0.000000 1 2.500000 35.588000 29.825915 5.268750 -16926 2 0.000000 -1.000000 2.500000 35.588000 29.825915 5.268750 +16926 2 0.000000 -1 2.500000 35.588000 29.825915 5.268750 16927 2 0.000000 1 2.500000 37.884000 25.849126 5.268750 16928 2 0.000000 -1 2.500000 37.884000 25.849126 5.268750 16929 2 0.000000 1 2.500000 40.180000 27.174722 8.781250 @@ -16947,7 +16947,7 @@ Atoms 16931 2 0.000000 1 2.500000 42.476000 31.151511 8.781250 16932 2 0.000000 -1 2.500000 42.476000 31.151511 8.781250 16933 2 0.000000 1 2.500000 35.588000 29.825915 12.293750 -16934 2 0.000000 -1.000000 2.500000 35.588000 29.825915 12.293750 +16934 2 0.000000 -1 2.500000 35.588000 29.825915 12.293750 16935 2 0.000000 1 2.500000 37.884000 25.849126 12.293750 16936 2 0.000000 -1 2.500000 37.884000 25.849126 12.293750 16937 2 0.000000 1 2.500000 40.180000 27.174722 15.806250 @@ -16955,7 +16955,7 @@ Atoms 16939 2 0.000000 1 2.500000 42.476000 31.151511 15.806250 16940 2 0.000000 -1 2.500000 42.476000 31.151511 15.806250 16941 2 0.000000 1 2.500000 35.588000 29.825915 19.318750 -16942 2 0.000000 -1.000000 2.500000 35.588000 29.825915 19.318750 +16942 2 0.000000 -1 2.500000 35.588000 29.825915 19.318750 16943 2 0.000000 1 2.500000 37.884000 25.849126 19.318750 16944 2 0.000000 -1 2.500000 37.884000 25.849126 19.318750 16945 2 0.000000 1 2.500000 40.180000 27.174722 22.831250 @@ -16963,7 +16963,7 @@ Atoms 16947 2 0.000000 1 2.500000 42.476000 31.151511 22.831250 16948 2 0.000000 -1 2.500000 42.476000 31.151511 22.831250 16949 2 0.000000 1 2.500000 35.588000 29.825915 26.343750 -16950 2 0.000000 -1.000000 2.500000 35.588000 29.825915 26.343750 +16950 2 0.000000 -1 2.500000 35.588000 29.825915 26.343750 16951 2 0.000000 1 2.500000 37.884000 25.849126 26.343750 16952 2 0.000000 -1 2.500000 37.884000 25.849126 26.343750 16953 2 0.000000 1 2.500000 40.180000 27.174722 29.856250 @@ -16971,7 +16971,7 @@ Atoms 16955 2 0.000000 1 2.500000 42.476000 31.151511 29.856250 16956 2 0.000000 -1 2.500000 42.476000 31.151511 29.856250 16957 2 0.000000 1 2.500000 35.588000 29.825915 33.368750 -16958 2 0.000000 -1.000000 2.500000 35.588000 29.825915 33.368750 +16958 2 0.000000 -1 2.500000 35.588000 29.825915 33.368750 16959 2 0.000000 1 2.500000 37.884000 25.849126 33.368750 16960 2 0.000000 -1 2.500000 37.884000 25.849126 33.368750 16961 2 0.000000 1 2.500000 40.180000 27.174722 36.881250 @@ -16979,7 +16979,7 @@ Atoms 16963 2 0.000000 1 2.500000 42.476000 31.151511 36.881250 16964 2 0.000000 -1 2.500000 42.476000 31.151511 36.881250 16965 2 0.000000 1 2.500000 35.588000 29.825915 40.393750 -16966 2 0.000000 -1.000000 2.500000 35.588000 29.825915 40.393750 +16966 2 0.000000 -1 2.500000 35.588000 29.825915 40.393750 16967 2 0.000000 1 2.500000 37.884000 25.849126 40.393750 16968 2 0.000000 -1 2.500000 37.884000 25.849126 40.393750 16969 2 0.000000 1 2.500000 40.180000 27.174722 43.906250 @@ -16987,7 +16987,7 @@ Atoms 16971 2 0.000000 1 2.500000 42.476000 31.151511 43.906250 16972 2 0.000000 -1 2.500000 42.476000 31.151511 43.906250 16973 2 0.000000 1 2.500000 35.588000 29.825915 47.418750 -16974 2 0.000000 -1.000000 2.500000 35.588000 29.825915 47.418750 +16974 2 0.000000 -1 2.500000 35.588000 29.825915 47.418750 16975 2 0.000000 1 2.500000 37.884000 25.849126 47.418750 16976 2 0.000000 -1 2.500000 37.884000 25.849126 47.418750 16977 2 0.000000 1 2.500000 40.180000 27.174722 50.931250 @@ -16995,7 +16995,7 @@ Atoms 16979 2 0.000000 1 2.500000 42.476000 31.151511 50.931250 16980 2 0.000000 -1 2.500000 42.476000 31.151511 50.931250 16981 2 0.000000 1 2.500000 35.588000 29.825915 54.443750 -16982 2 0.000000 -1.000000 2.500000 35.588000 29.825915 54.443750 +16982 2 0.000000 -1 2.500000 35.588000 29.825915 54.443750 16983 2 0.000000 1 2.500000 37.884000 25.849126 54.443750 16984 2 0.000000 -1 2.500000 37.884000 25.849126 54.443750 16985 2 0.000000 1 2.500000 40.180000 27.174722 57.956250 @@ -17003,7 +17003,7 @@ Atoms 16987 2 0.000000 1 2.500000 42.476000 31.151511 57.956250 16988 2 0.000000 -1 2.500000 42.476000 31.151511 57.956250 16989 2 0.000000 1 2.500000 35.588000 29.825915 61.468750 -16990 2 0.000000 -1.000000 2.500000 35.588000 29.825915 61.468750 +16990 2 0.000000 -1 2.500000 35.588000 29.825915 61.468750 16991 2 0.000000 1 2.500000 37.884000 25.849126 61.468750 16992 2 0.000000 -1 2.500000 37.884000 25.849126 61.468750 16993 2 0.000000 1 2.500000 40.180000 35.128300 1.756250 @@ -17011,7 +17011,7 @@ Atoms 16995 2 0.000000 1 2.500000 42.476000 39.105088 1.756250 16996 2 0.000000 -1 2.500000 42.476000 39.105088 1.756250 16997 2 0.000000 1 2.500000 35.588000 37.779492 5.268750 -16998 2 0.000000 -1.000000 2.500000 35.588000 37.779492 5.268750 +16998 2 0.000000 -1 2.500000 35.588000 37.779492 5.268750 16999 2 0.000000 1 2.500000 37.884000 33.802704 5.268750 17000 2 0.000000 -1 2.500000 37.884000 33.802704 5.268750 17001 2 0.000000 1 2.500000 40.180000 35.128300 8.781250 @@ -17019,7 +17019,7 @@ Atoms 17003 2 0.000000 1 2.500000 42.476000 39.105088 8.781250 17004 2 0.000000 -1 2.500000 42.476000 39.105088 8.781250 17005 2 0.000000 1 2.500000 35.588000 37.779492 12.293750 -17006 2 0.000000 -1.000000 2.500000 35.588000 37.779492 12.293750 +17006 2 0.000000 -1 2.500000 35.588000 37.779492 12.293750 17007 2 0.000000 1 2.500000 37.884000 33.802704 12.293750 17008 2 0.000000 -1 2.500000 37.884000 33.802704 12.293750 17009 2 0.000000 1 2.500000 40.180000 35.128300 15.806250 @@ -17027,7 +17027,7 @@ Atoms 17011 2 0.000000 1 2.500000 42.476000 39.105088 15.806250 17012 2 0.000000 -1 2.500000 42.476000 39.105088 15.806250 17013 2 0.000000 1 2.500000 35.588000 37.779492 19.318750 -17014 2 0.000000 -1.000000 2.500000 35.588000 37.779492 19.318750 +17014 2 0.000000 -1 2.500000 35.588000 37.779492 19.318750 17015 2 0.000000 1 2.500000 37.884000 33.802704 19.318750 17016 2 0.000000 -1 2.500000 37.884000 33.802704 19.318750 17017 2 0.000000 1 2.500000 40.180000 35.128300 22.831250 @@ -17035,7 +17035,7 @@ Atoms 17019 2 0.000000 1 2.500000 42.476000 39.105088 22.831250 17020 2 0.000000 -1 2.500000 42.476000 39.105088 22.831250 17021 2 0.000000 1 2.500000 35.588000 37.779492 26.343750 -17022 2 0.000000 -1.000000 2.500000 35.588000 37.779492 26.343750 +17022 2 0.000000 -1 2.500000 35.588000 37.779492 26.343750 17023 2 0.000000 1 2.500000 37.884000 33.802704 26.343750 17024 2 0.000000 -1 2.500000 37.884000 33.802704 26.343750 17025 2 0.000000 1 2.500000 40.180000 35.128300 29.856250 @@ -17043,7 +17043,7 @@ Atoms 17027 2 0.000000 1 2.500000 42.476000 39.105088 29.856250 17028 2 0.000000 -1 2.500000 42.476000 39.105088 29.856250 17029 2 0.000000 1 2.500000 35.588000 37.779492 33.368750 -17030 2 0.000000 -1.000000 2.500000 35.588000 37.779492 33.368750 +17030 2 0.000000 -1 2.500000 35.588000 37.779492 33.368750 17031 2 0.000000 1 2.500000 37.884000 33.802704 33.368750 17032 2 0.000000 -1 2.500000 37.884000 33.802704 33.368750 17033 2 0.000000 1 2.500000 40.180000 35.128300 36.881250 @@ -17051,7 +17051,7 @@ Atoms 17035 2 0.000000 1 2.500000 42.476000 39.105088 36.881250 17036 2 0.000000 -1 2.500000 42.476000 39.105088 36.881250 17037 2 0.000000 1 2.500000 35.588000 37.779492 40.393750 -17038 2 0.000000 -1.000000 2.500000 35.588000 37.779492 40.393750 +17038 2 0.000000 -1 2.500000 35.588000 37.779492 40.393750 17039 2 0.000000 1 2.500000 37.884000 33.802704 40.393750 17040 2 0.000000 -1 2.500000 37.884000 33.802704 40.393750 17041 2 0.000000 1 2.500000 40.180000 35.128300 43.906250 @@ -17059,7 +17059,7 @@ Atoms 17043 2 0.000000 1 2.500000 42.476000 39.105088 43.906250 17044 2 0.000000 -1 2.500000 42.476000 39.105088 43.906250 17045 2 0.000000 1 2.500000 35.588000 37.779492 47.418750 -17046 2 0.000000 -1.000000 2.500000 35.588000 37.779492 47.418750 +17046 2 0.000000 -1 2.500000 35.588000 37.779492 47.418750 17047 2 0.000000 1 2.500000 37.884000 33.802704 47.418750 17048 2 0.000000 -1 2.500000 37.884000 33.802704 47.418750 17049 2 0.000000 1 2.500000 40.180000 35.128300 50.931250 @@ -17067,7 +17067,7 @@ Atoms 17051 2 0.000000 1 2.500000 42.476000 39.105088 50.931250 17052 2 0.000000 -1 2.500000 42.476000 39.105088 50.931250 17053 2 0.000000 1 2.500000 35.588000 37.779492 54.443750 -17054 2 0.000000 -1.000000 2.500000 35.588000 37.779492 54.443750 +17054 2 0.000000 -1 2.500000 35.588000 37.779492 54.443750 17055 2 0.000000 1 2.500000 37.884000 33.802704 54.443750 17056 2 0.000000 -1 2.500000 37.884000 33.802704 54.443750 17057 2 0.000000 1 2.500000 40.180000 35.128300 57.956250 @@ -17075,7 +17075,7 @@ Atoms 17059 2 0.000000 1 2.500000 42.476000 39.105088 57.956250 17060 2 0.000000 -1 2.500000 42.476000 39.105088 57.956250 17061 2 0.000000 1 2.500000 35.588000 37.779492 61.468750 -17062 2 0.000000 -1.000000 2.500000 35.588000 37.779492 61.468750 +17062 2 0.000000 -1 2.500000 35.588000 37.779492 61.468750 17063 2 0.000000 1 2.500000 37.884000 33.802704 61.468750 17064 2 0.000000 -1 2.500000 37.884000 33.802704 61.468750 17065 2 0.000000 1 2.500000 40.180000 43.081877 1.756250 @@ -17083,7 +17083,7 @@ Atoms 17067 2 0.000000 1 2.500000 42.476000 47.058666 1.756250 17068 2 0.000000 -1 2.500000 42.476000 47.058666 1.756250 17069 2 0.000000 1 2.500000 35.588000 45.733070 5.268750 -17070 2 0.000000 -1.000000 2.500000 35.588000 45.733070 5.268750 +17070 2 0.000000 -1 2.500000 35.588000 45.733070 5.268750 17071 2 0.000000 1 2.500000 37.884000 41.756281 5.268750 17072 2 0.000000 -1 2.500000 37.884000 41.756281 5.268750 17073 2 0.000000 1 2.500000 40.180000 43.081877 8.781250 @@ -17091,7 +17091,7 @@ Atoms 17075 2 0.000000 1 2.500000 42.476000 47.058666 8.781250 17076 2 0.000000 -1 2.500000 42.476000 47.058666 8.781250 17077 2 0.000000 1 2.500000 35.588000 45.733070 12.293750 -17078 2 0.000000 -1.000000 2.500000 35.588000 45.733070 12.293750 +17078 2 0.000000 -1 2.500000 35.588000 45.733070 12.293750 17079 2 0.000000 1 2.500000 37.884000 41.756281 12.293750 17080 2 0.000000 -1 2.500000 37.884000 41.756281 12.293750 17081 2 0.000000 1 2.500000 40.180000 43.081877 15.806250 @@ -17099,7 +17099,7 @@ Atoms 17083 2 0.000000 1 2.500000 42.476000 47.058666 15.806250 17084 2 0.000000 -1 2.500000 42.476000 47.058666 15.806250 17085 2 0.000000 1 2.500000 35.588000 45.733070 19.318750 -17086 2 0.000000 -1.000000 2.500000 35.588000 45.733070 19.318750 +17086 2 0.000000 -1 2.500000 35.588000 45.733070 19.318750 17087 2 0.000000 1 2.500000 37.884000 41.756281 19.318750 17088 2 0.000000 -1 2.500000 37.884000 41.756281 19.318750 17089 2 0.000000 1 2.500000 40.180000 43.081877 22.831250 @@ -17107,7 +17107,7 @@ Atoms 17091 2 0.000000 1 2.500000 42.476000 47.058666 22.831250 17092 2 0.000000 -1 2.500000 42.476000 47.058666 22.831250 17093 2 0.000000 1 2.500000 35.588000 45.733070 26.343750 -17094 2 0.000000 -1.000000 2.500000 35.588000 45.733070 26.343750 +17094 2 0.000000 -1 2.500000 35.588000 45.733070 26.343750 17095 2 0.000000 1 2.500000 37.884000 41.756281 26.343750 17096 2 0.000000 -1 2.500000 37.884000 41.756281 26.343750 17097 2 0.000000 1 2.500000 40.180000 43.081877 29.856250 @@ -17115,7 +17115,7 @@ Atoms 17099 2 0.000000 1 2.500000 42.476000 47.058666 29.856250 17100 2 0.000000 -1 2.500000 42.476000 47.058666 29.856250 17101 2 0.000000 1 2.500000 35.588000 45.733070 33.368750 -17102 2 0.000000 -1.000000 2.500000 35.588000 45.733070 33.368750 +17102 2 0.000000 -1 2.500000 35.588000 45.733070 33.368750 17103 2 0.000000 1 2.500000 37.884000 41.756281 33.368750 17104 2 0.000000 -1 2.500000 37.884000 41.756281 33.368750 17105 2 0.000000 1 2.500000 40.180000 43.081877 36.881250 @@ -17123,7 +17123,7 @@ Atoms 17107 2 0.000000 1 2.500000 42.476000 47.058666 36.881250 17108 2 0.000000 -1 2.500000 42.476000 47.058666 36.881250 17109 2 0.000000 1 2.500000 35.588000 45.733070 40.393750 -17110 2 0.000000 -1.000000 2.500000 35.588000 45.733070 40.393750 +17110 2 0.000000 -1 2.500000 35.588000 45.733070 40.393750 17111 2 0.000000 1 2.500000 37.884000 41.756281 40.393750 17112 2 0.000000 -1 2.500000 37.884000 41.756281 40.393750 17113 2 0.000000 1 2.500000 40.180000 43.081877 43.906250 @@ -17131,7 +17131,7 @@ Atoms 17115 2 0.000000 1 2.500000 42.476000 47.058666 43.906250 17116 2 0.000000 -1 2.500000 42.476000 47.058666 43.906250 17117 2 0.000000 1 2.500000 35.588000 45.733070 47.418750 -17118 2 0.000000 -1.000000 2.500000 35.588000 45.733070 47.418750 +17118 2 0.000000 -1 2.500000 35.588000 45.733070 47.418750 17119 2 0.000000 1 2.500000 37.884000 41.756281 47.418750 17120 2 0.000000 -1 2.500000 37.884000 41.756281 47.418750 17121 2 0.000000 1 2.500000 40.180000 43.081877 50.931250 @@ -17139,7 +17139,7 @@ Atoms 17123 2 0.000000 1 2.500000 42.476000 47.058666 50.931250 17124 2 0.000000 -1 2.500000 42.476000 47.058666 50.931250 17125 2 0.000000 1 2.500000 35.588000 45.733070 54.443750 -17126 2 0.000000 -1.000000 2.500000 35.588000 45.733070 54.443750 +17126 2 0.000000 -1 2.500000 35.588000 45.733070 54.443750 17127 2 0.000000 1 2.500000 37.884000 41.756281 54.443750 17128 2 0.000000 -1 2.500000 37.884000 41.756281 54.443750 17129 2 0.000000 1 2.500000 40.180000 43.081877 57.956250 @@ -17147,7 +17147,7 @@ Atoms 17131 2 0.000000 1 2.500000 42.476000 47.058666 57.956250 17132 2 0.000000 -1 2.500000 42.476000 47.058666 57.956250 17133 2 0.000000 1 2.500000 35.588000 45.733070 61.468750 -17134 2 0.000000 -1.000000 2.500000 35.588000 45.733070 61.468750 +17134 2 0.000000 -1 2.500000 35.588000 45.733070 61.468750 17135 2 0.000000 1 2.500000 37.884000 41.756281 61.468750 17136 2 0.000000 -1 2.500000 37.884000 41.756281 61.468750 17137 2 0.000000 1 2.500000 40.180000 51.035454 1.756250 @@ -17155,7 +17155,7 @@ Atoms 17139 2 0.000000 1 2.500000 42.476000 55.012243 1.756250 17140 2 0.000000 -1 2.500000 42.476000 55.012243 1.756250 17141 2 0.000000 1 2.500000 35.588000 53.686647 5.268750 -17142 2 0.000000 -1.000000 2.500000 35.588000 53.686647 5.268750 +17142 2 0.000000 -1 2.500000 35.588000 53.686647 5.268750 17143 2 0.000000 1 2.500000 37.884000 49.709858 5.268750 17144 2 0.000000 -1 2.500000 37.884000 49.709858 5.268750 17145 2 0.000000 1 2.500000 40.180000 51.035454 8.781250 @@ -17163,7 +17163,7 @@ Atoms 17147 2 0.000000 1 2.500000 42.476000 55.012243 8.781250 17148 2 0.000000 -1 2.500000 42.476000 55.012243 8.781250 17149 2 0.000000 1 2.500000 35.588000 53.686647 12.293750 -17150 2 0.000000 -1.000000 2.500000 35.588000 53.686647 12.293750 +17150 2 0.000000 -1 2.500000 35.588000 53.686647 12.293750 17151 2 0.000000 1 2.500000 37.884000 49.709858 12.293750 17152 2 0.000000 -1 2.500000 37.884000 49.709858 12.293750 17153 2 0.000000 1 2.500000 40.180000 51.035454 15.806250 @@ -17171,7 +17171,7 @@ Atoms 17155 2 0.000000 1 2.500000 42.476000 55.012243 15.806250 17156 2 0.000000 -1 2.500000 42.476000 55.012243 15.806250 17157 2 0.000000 1 2.500000 35.588000 53.686647 19.318750 -17158 2 0.000000 -1.000000 2.500000 35.588000 53.686647 19.318750 +17158 2 0.000000 -1 2.500000 35.588000 53.686647 19.318750 17159 2 0.000000 1 2.500000 37.884000 49.709858 19.318750 17160 2 0.000000 -1 2.500000 37.884000 49.709858 19.318750 17161 2 0.000000 1 2.500000 40.180000 51.035454 22.831250 @@ -17179,7 +17179,7 @@ Atoms 17163 2 0.000000 1 2.500000 42.476000 55.012243 22.831250 17164 2 0.000000 -1 2.500000 42.476000 55.012243 22.831250 17165 2 0.000000 1 2.500000 35.588000 53.686647 26.343750 -17166 2 0.000000 -1.000000 2.500000 35.588000 53.686647 26.343750 +17166 2 0.000000 -1 2.500000 35.588000 53.686647 26.343750 17167 2 0.000000 1 2.500000 37.884000 49.709858 26.343750 17168 2 0.000000 -1 2.500000 37.884000 49.709858 26.343750 17169 2 0.000000 1 2.500000 40.180000 51.035454 29.856250 @@ -17187,7 +17187,7 @@ Atoms 17171 2 0.000000 1 2.500000 42.476000 55.012243 29.856250 17172 2 0.000000 -1 2.500000 42.476000 55.012243 29.856250 17173 2 0.000000 1 2.500000 35.588000 53.686647 33.368750 -17174 2 0.000000 -1.000000 2.500000 35.588000 53.686647 33.368750 +17174 2 0.000000 -1 2.500000 35.588000 53.686647 33.368750 17175 2 0.000000 1 2.500000 37.884000 49.709858 33.368750 17176 2 0.000000 -1 2.500000 37.884000 49.709858 33.368750 17177 2 0.000000 1 2.500000 40.180000 51.035454 36.881250 @@ -17195,7 +17195,7 @@ Atoms 17179 2 0.000000 1 2.500000 42.476000 55.012243 36.881250 17180 2 0.000000 -1 2.500000 42.476000 55.012243 36.881250 17181 2 0.000000 1 2.500000 35.588000 53.686647 40.393750 -17182 2 0.000000 -1.000000 2.500000 35.588000 53.686647 40.393750 +17182 2 0.000000 -1 2.500000 35.588000 53.686647 40.393750 17183 2 0.000000 1 2.500000 37.884000 49.709858 40.393750 17184 2 0.000000 -1 2.500000 37.884000 49.709858 40.393750 17185 2 0.000000 1 2.500000 40.180000 51.035454 43.906250 @@ -17203,7 +17203,7 @@ Atoms 17187 2 0.000000 1 2.500000 42.476000 55.012243 43.906250 17188 2 0.000000 -1 2.500000 42.476000 55.012243 43.906250 17189 2 0.000000 1 2.500000 35.588000 53.686647 47.418750 -17190 2 0.000000 -1.000000 2.500000 35.588000 53.686647 47.418750 +17190 2 0.000000 -1 2.500000 35.588000 53.686647 47.418750 17191 2 0.000000 1 2.500000 37.884000 49.709858 47.418750 17192 2 0.000000 -1 2.500000 37.884000 49.709858 47.418750 17193 2 0.000000 1 2.500000 40.180000 51.035454 50.931250 @@ -17211,7 +17211,7 @@ Atoms 17195 2 0.000000 1 2.500000 42.476000 55.012243 50.931250 17196 2 0.000000 -1 2.500000 42.476000 55.012243 50.931250 17197 2 0.000000 1 2.500000 35.588000 53.686647 54.443750 -17198 2 0.000000 -1.000000 2.500000 35.588000 53.686647 54.443750 +17198 2 0.000000 -1 2.500000 35.588000 53.686647 54.443750 17199 2 0.000000 1 2.500000 37.884000 49.709858 54.443750 17200 2 0.000000 -1 2.500000 37.884000 49.709858 54.443750 17201 2 0.000000 1 2.500000 40.180000 51.035454 57.956250 @@ -17219,7 +17219,7 @@ Atoms 17203 2 0.000000 1 2.500000 42.476000 55.012243 57.956250 17204 2 0.000000 -1 2.500000 42.476000 55.012243 57.956250 17205 2 0.000000 1 2.500000 35.588000 53.686647 61.468750 -17206 2 0.000000 -1.000000 2.500000 35.588000 53.686647 61.468750 +17206 2 0.000000 -1 2.500000 35.588000 53.686647 61.468750 17207 2 0.000000 1 2.500000 37.884000 49.709858 61.468750 17208 2 0.000000 -1 2.500000 37.884000 49.709858 61.468750 17209 2 0.000000 1 2.500000 40.180000 58.989032 1.756250 @@ -17227,7 +17227,7 @@ Atoms 17211 2 0.000000 1 2.500000 42.476000 62.965820 1.756250 17212 2 0.000000 -1 2.500000 42.476000 62.965820 1.756250 17213 2 0.000000 1 2.500000 35.588000 61.640224 5.268750 -17214 2 0.000000 -1.000000 2.500000 35.588000 61.640224 5.268750 +17214 2 0.000000 -1 2.500000 35.588000 61.640224 5.268750 17215 2 0.000000 1 2.500000 37.884000 57.663435 5.268750 17216 2 0.000000 -1 2.500000 37.884000 57.663435 5.268750 17217 2 0.000000 1 2.500000 40.180000 58.989032 8.781250 @@ -17235,7 +17235,7 @@ Atoms 17219 2 0.000000 1 2.500000 42.476000 62.965820 8.781250 17220 2 0.000000 -1 2.500000 42.476000 62.965820 8.781250 17221 2 0.000000 1 2.500000 35.588000 61.640224 12.293750 -17222 2 0.000000 -1.000000 2.500000 35.588000 61.640224 12.293750 +17222 2 0.000000 -1 2.500000 35.588000 61.640224 12.293750 17223 2 0.000000 1 2.500000 37.884000 57.663435 12.293750 17224 2 0.000000 -1 2.500000 37.884000 57.663435 12.293750 17225 2 0.000000 1 2.500000 40.180000 58.989032 15.806250 @@ -17243,7 +17243,7 @@ Atoms 17227 2 0.000000 1 2.500000 42.476000 62.965820 15.806250 17228 2 0.000000 -1 2.500000 42.476000 62.965820 15.806250 17229 2 0.000000 1 2.500000 35.588000 61.640224 19.318750 -17230 2 0.000000 -1.000000 2.500000 35.588000 61.640224 19.318750 +17230 2 0.000000 -1 2.500000 35.588000 61.640224 19.318750 17231 2 0.000000 1 2.500000 37.884000 57.663435 19.318750 17232 2 0.000000 -1 2.500000 37.884000 57.663435 19.318750 17233 2 0.000000 1 2.500000 40.180000 58.989032 22.831250 @@ -17251,7 +17251,7 @@ Atoms 17235 2 0.000000 1 2.500000 42.476000 62.965820 22.831250 17236 2 0.000000 -1 2.500000 42.476000 62.965820 22.831250 17237 2 0.000000 1 2.500000 35.588000 61.640224 26.343750 -17238 2 0.000000 -1.000000 2.500000 35.588000 61.640224 26.343750 +17238 2 0.000000 -1 2.500000 35.588000 61.640224 26.343750 17239 2 0.000000 1 2.500000 37.884000 57.663435 26.343750 17240 2 0.000000 -1 2.500000 37.884000 57.663435 26.343750 17241 2 0.000000 1 2.500000 40.180000 58.989032 29.856250 @@ -17259,7 +17259,7 @@ Atoms 17243 2 0.000000 1 2.500000 42.476000 62.965820 29.856250 17244 2 0.000000 -1 2.500000 42.476000 62.965820 29.856250 17245 2 0.000000 1 2.500000 35.588000 61.640224 33.368750 -17246 2 0.000000 -1.000000 2.500000 35.588000 61.640224 33.368750 +17246 2 0.000000 -1 2.500000 35.588000 61.640224 33.368750 17247 2 0.000000 1 2.500000 37.884000 57.663435 33.368750 17248 2 0.000000 -1 2.500000 37.884000 57.663435 33.368750 17249 2 0.000000 1 2.500000 40.180000 58.989032 36.881250 @@ -17267,7 +17267,7 @@ Atoms 17251 2 0.000000 1 2.500000 42.476000 62.965820 36.881250 17252 2 0.000000 -1 2.500000 42.476000 62.965820 36.881250 17253 2 0.000000 1 2.500000 35.588000 61.640224 40.393750 -17254 2 0.000000 -1.000000 2.500000 35.588000 61.640224 40.393750 +17254 2 0.000000 -1 2.500000 35.588000 61.640224 40.393750 17255 2 0.000000 1 2.500000 37.884000 57.663435 40.393750 17256 2 0.000000 -1 2.500000 37.884000 57.663435 40.393750 17257 2 0.000000 1 2.500000 40.180000 58.989032 43.906250 @@ -17275,7 +17275,7 @@ Atoms 17259 2 0.000000 1 2.500000 42.476000 62.965820 43.906250 17260 2 0.000000 -1 2.500000 42.476000 62.965820 43.906250 17261 2 0.000000 1 2.500000 35.588000 61.640224 47.418750 -17262 2 0.000000 -1.000000 2.500000 35.588000 61.640224 47.418750 +17262 2 0.000000 -1 2.500000 35.588000 61.640224 47.418750 17263 2 0.000000 1 2.500000 37.884000 57.663435 47.418750 17264 2 0.000000 -1 2.500000 37.884000 57.663435 47.418750 17265 2 0.000000 1 2.500000 40.180000 58.989032 50.931250 @@ -17283,7 +17283,7 @@ Atoms 17267 2 0.000000 1 2.500000 42.476000 62.965820 50.931250 17268 2 0.000000 -1 2.500000 42.476000 62.965820 50.931250 17269 2 0.000000 1 2.500000 35.588000 61.640224 54.443750 -17270 2 0.000000 -1.000000 2.500000 35.588000 61.640224 54.443750 +17270 2 0.000000 -1 2.500000 35.588000 61.640224 54.443750 17271 2 0.000000 1 2.500000 37.884000 57.663435 54.443750 17272 2 0.000000 -1 2.500000 37.884000 57.663435 54.443750 17273 2 0.000000 1 2.500000 40.180000 58.989032 57.956250 @@ -17291,7 +17291,7 @@ Atoms 17275 2 0.000000 1 2.500000 42.476000 62.965820 57.956250 17276 2 0.000000 -1 2.500000 42.476000 62.965820 57.956250 17277 2 0.000000 1 2.500000 35.588000 61.640224 61.468750 -17278 2 0.000000 -1.000000 2.500000 35.588000 61.640224 61.468750 +17278 2 0.000000 -1 2.500000 35.588000 61.640224 61.468750 17279 2 0.000000 1 2.500000 37.884000 57.663435 61.468750 17280 2 0.000000 -1 2.500000 37.884000 57.663435 61.468750 17281 2 0.000000 1 2.500000 44.772000 3.313991 1.756250 @@ -17299,7 +17299,7 @@ Atoms 17283 2 0.000000 1 2.500000 47.068000 7.290779 1.756250 17284 2 0.000000 -1 2.500000 47.068000 7.290779 1.756250 17285 2 0.000000 1 2.500000 40.180000 5.965183 5.268750 -17286 2 0.000000 -1.000000 2.500000 40.180000 5.965183 5.268750 +17286 2 0.000000 -1 2.500000 40.180000 5.965183 5.268750 17287 2 0.000000 1 2.500000 42.476000 1.988394 5.268750 17288 2 0.000000 -1 2.500000 42.476000 1.988394 5.268750 17289 2 0.000000 1 2.500000 44.772000 3.313991 8.781250 @@ -17307,7 +17307,7 @@ Atoms 17291 2 0.000000 1 2.500000 47.068000 7.290779 8.781250 17292 2 0.000000 -1 2.500000 47.068000 7.290779 8.781250 17293 2 0.000000 1 2.500000 40.180000 5.965183 12.293750 -17294 2 0.000000 -1.000000 2.500000 40.180000 5.965183 12.293750 +17294 2 0.000000 -1 2.500000 40.180000 5.965183 12.293750 17295 2 0.000000 1 2.500000 42.476000 1.988394 12.293750 17296 2 0.000000 -1 2.500000 42.476000 1.988394 12.293750 17297 2 0.000000 1 2.500000 44.772000 3.313991 15.806250 @@ -17315,7 +17315,7 @@ Atoms 17299 2 0.000000 1 2.500000 47.068000 7.290779 15.806250 17300 2 0.000000 -1 2.500000 47.068000 7.290779 15.806250 17301 2 0.000000 1 2.500000 40.180000 5.965183 19.318750 -17302 2 0.000000 -1.000000 2.500000 40.180000 5.965183 19.318750 +17302 2 0.000000 -1 2.500000 40.180000 5.965183 19.318750 17303 2 0.000000 1 2.500000 42.476000 1.988394 19.318750 17304 2 0.000000 -1 2.500000 42.476000 1.988394 19.318750 17305 2 0.000000 1 2.500000 44.772000 3.313991 22.831250 @@ -17323,7 +17323,7 @@ Atoms 17307 2 0.000000 1 2.500000 47.068000 7.290779 22.831250 17308 2 0.000000 -1 2.500000 47.068000 7.290779 22.831250 17309 2 0.000000 1 2.500000 40.180000 5.965183 26.343750 -17310 2 0.000000 -1.000000 2.500000 40.180000 5.965183 26.343750 +17310 2 0.000000 -1 2.500000 40.180000 5.965183 26.343750 17311 2 0.000000 1 2.500000 42.476000 1.988394 26.343750 17312 2 0.000000 -1 2.500000 42.476000 1.988394 26.343750 17313 2 0.000000 1 2.500000 44.772000 3.313991 29.856250 @@ -17331,7 +17331,7 @@ Atoms 17315 2 0.000000 1 2.500000 47.068000 7.290779 29.856250 17316 2 0.000000 -1 2.500000 47.068000 7.290779 29.856250 17317 2 0.000000 1 2.500000 40.180000 5.965183 33.368750 -17318 2 0.000000 -1.000000 2.500000 40.180000 5.965183 33.368750 +17318 2 0.000000 -1 2.500000 40.180000 5.965183 33.368750 17319 2 0.000000 1 2.500000 42.476000 1.988394 33.368750 17320 2 0.000000 -1 2.500000 42.476000 1.988394 33.368750 17321 2 0.000000 1 2.500000 44.772000 3.313991 36.881250 @@ -17339,7 +17339,7 @@ Atoms 17323 2 0.000000 1 2.500000 47.068000 7.290779 36.881250 17324 2 0.000000 -1 2.500000 47.068000 7.290779 36.881250 17325 2 0.000000 1 2.500000 40.180000 5.965183 40.393750 -17326 2 0.000000 -1.000000 2.500000 40.180000 5.965183 40.393750 +17326 2 0.000000 -1 2.500000 40.180000 5.965183 40.393750 17327 2 0.000000 1 2.500000 42.476000 1.988394 40.393750 17328 2 0.000000 -1 2.500000 42.476000 1.988394 40.393750 17329 2 0.000000 1 2.500000 44.772000 3.313991 43.906250 @@ -17347,7 +17347,7 @@ Atoms 17331 2 0.000000 1 2.500000 47.068000 7.290779 43.906250 17332 2 0.000000 -1 2.500000 47.068000 7.290779 43.906250 17333 2 0.000000 1 2.500000 40.180000 5.965183 47.418750 -17334 2 0.000000 -1.000000 2.500000 40.180000 5.965183 47.418750 +17334 2 0.000000 -1 2.500000 40.180000 5.965183 47.418750 17335 2 0.000000 1 2.500000 42.476000 1.988394 47.418750 17336 2 0.000000 -1 2.500000 42.476000 1.988394 47.418750 17337 2 0.000000 1 2.500000 44.772000 3.313991 50.931250 @@ -17355,7 +17355,7 @@ Atoms 17339 2 0.000000 1 2.500000 47.068000 7.290779 50.931250 17340 2 0.000000 -1 2.500000 47.068000 7.290779 50.931250 17341 2 0.000000 1 2.500000 40.180000 5.965183 54.443750 -17342 2 0.000000 -1.000000 2.500000 40.180000 5.965183 54.443750 +17342 2 0.000000 -1 2.500000 40.180000 5.965183 54.443750 17343 2 0.000000 1 2.500000 42.476000 1.988394 54.443750 17344 2 0.000000 -1 2.500000 42.476000 1.988394 54.443750 17345 2 0.000000 1 2.500000 44.772000 3.313991 57.956250 @@ -17363,7 +17363,7 @@ Atoms 17347 2 0.000000 1 2.500000 47.068000 7.290779 57.956250 17348 2 0.000000 -1 2.500000 47.068000 7.290779 57.956250 17349 2 0.000000 1 2.500000 40.180000 5.965183 61.468750 -17350 2 0.000000 -1.000000 2.500000 40.180000 5.965183 61.468750 +17350 2 0.000000 -1 2.500000 40.180000 5.965183 61.468750 17351 2 0.000000 1 2.500000 42.476000 1.988394 61.468750 17352 2 0.000000 -1 2.500000 42.476000 1.988394 61.468750 17353 2 0.000000 1 2.500000 44.772000 11.267568 1.756250 @@ -17371,7 +17371,7 @@ Atoms 17355 2 0.000000 1 2.500000 47.068000 15.244357 1.756250 17356 2 0.000000 -1 2.500000 47.068000 15.244357 1.756250 17357 2 0.000000 1 2.500000 40.180000 13.918760 5.268750 -17358 2 0.000000 -1.000000 2.500000 40.180000 13.918760 5.268750 +17358 2 0.000000 -1 2.500000 40.180000 13.918760 5.268750 17359 2 0.000000 1 2.500000 42.476000 9.941972 5.268750 17360 2 0.000000 -1 2.500000 42.476000 9.941972 5.268750 17361 2 0.000000 1 2.500000 44.772000 11.267568 8.781250 @@ -17379,7 +17379,7 @@ Atoms 17363 2 0.000000 1 2.500000 47.068000 15.244357 8.781250 17364 2 0.000000 -1 2.500000 47.068000 15.244357 8.781250 17365 2 0.000000 1 2.500000 40.180000 13.918760 12.293750 -17366 2 0.000000 -1.000000 2.500000 40.180000 13.918760 12.293750 +17366 2 0.000000 -1 2.500000 40.180000 13.918760 12.293750 17367 2 0.000000 1 2.500000 42.476000 9.941972 12.293750 17368 2 0.000000 -1 2.500000 42.476000 9.941972 12.293750 17369 2 0.000000 1 2.500000 44.772000 11.267568 15.806250 @@ -17387,7 +17387,7 @@ Atoms 17371 2 0.000000 1 2.500000 47.068000 15.244357 15.806250 17372 2 0.000000 -1 2.500000 47.068000 15.244357 15.806250 17373 2 0.000000 1 2.500000 40.180000 13.918760 19.318750 -17374 2 0.000000 -1.000000 2.500000 40.180000 13.918760 19.318750 +17374 2 0.000000 -1 2.500000 40.180000 13.918760 19.318750 17375 2 0.000000 1 2.500000 42.476000 9.941972 19.318750 17376 2 0.000000 -1 2.500000 42.476000 9.941972 19.318750 17377 2 0.000000 1 2.500000 44.772000 11.267568 22.831250 @@ -17395,7 +17395,7 @@ Atoms 17379 2 0.000000 1 2.500000 47.068000 15.244357 22.831250 17380 2 0.000000 -1 2.500000 47.068000 15.244357 22.831250 17381 2 0.000000 1 2.500000 40.180000 13.918760 26.343750 -17382 2 0.000000 -1.000000 2.500000 40.180000 13.918760 26.343750 +17382 2 0.000000 -1 2.500000 40.180000 13.918760 26.343750 17383 2 0.000000 1 2.500000 42.476000 9.941972 26.343750 17384 2 0.000000 -1 2.500000 42.476000 9.941972 26.343750 17385 2 0.000000 1 2.500000 44.772000 11.267568 29.856250 @@ -17403,7 +17403,7 @@ Atoms 17387 2 0.000000 1 2.500000 47.068000 15.244357 29.856250 17388 2 0.000000 -1 2.500000 47.068000 15.244357 29.856250 17389 2 0.000000 1 2.500000 40.180000 13.918760 33.368750 -17390 2 0.000000 -1.000000 2.500000 40.180000 13.918760 33.368750 +17390 2 0.000000 -1 2.500000 40.180000 13.918760 33.368750 17391 2 0.000000 1 2.500000 42.476000 9.941972 33.368750 17392 2 0.000000 -1 2.500000 42.476000 9.941972 33.368750 17393 2 0.000000 1 2.500000 44.772000 11.267568 36.881250 @@ -17411,7 +17411,7 @@ Atoms 17395 2 0.000000 1 2.500000 47.068000 15.244357 36.881250 17396 2 0.000000 -1 2.500000 47.068000 15.244357 36.881250 17397 2 0.000000 1 2.500000 40.180000 13.918760 40.393750 -17398 2 0.000000 -1.000000 2.500000 40.180000 13.918760 40.393750 +17398 2 0.000000 -1 2.500000 40.180000 13.918760 40.393750 17399 2 0.000000 1 2.500000 42.476000 9.941972 40.393750 17400 2 0.000000 -1 2.500000 42.476000 9.941972 40.393750 17401 2 0.000000 1 2.500000 44.772000 11.267568 43.906250 @@ -17419,7 +17419,7 @@ Atoms 17403 2 0.000000 1 2.500000 47.068000 15.244357 43.906250 17404 2 0.000000 -1 2.500000 47.068000 15.244357 43.906250 17405 2 0.000000 1 2.500000 40.180000 13.918760 47.418750 -17406 2 0.000000 -1.000000 2.500000 40.180000 13.918760 47.418750 +17406 2 0.000000 -1 2.500000 40.180000 13.918760 47.418750 17407 2 0.000000 1 2.500000 42.476000 9.941972 47.418750 17408 2 0.000000 -1 2.500000 42.476000 9.941972 47.418750 17409 2 0.000000 1 2.500000 44.772000 11.267568 50.931250 @@ -17427,7 +17427,7 @@ Atoms 17411 2 0.000000 1 2.500000 47.068000 15.244357 50.931250 17412 2 0.000000 -1 2.500000 47.068000 15.244357 50.931250 17413 2 0.000000 1 2.500000 40.180000 13.918760 54.443750 -17414 2 0.000000 -1.000000 2.500000 40.180000 13.918760 54.443750 +17414 2 0.000000 -1 2.500000 40.180000 13.918760 54.443750 17415 2 0.000000 1 2.500000 42.476000 9.941972 54.443750 17416 2 0.000000 -1 2.500000 42.476000 9.941972 54.443750 17417 2 0.000000 1 2.500000 44.772000 11.267568 57.956250 @@ -17435,7 +17435,7 @@ Atoms 17419 2 0.000000 1 2.500000 47.068000 15.244357 57.956250 17420 2 0.000000 -1 2.500000 47.068000 15.244357 57.956250 17421 2 0.000000 1 2.500000 40.180000 13.918760 61.468750 -17422 2 0.000000 -1.000000 2.500000 40.180000 13.918760 61.468750 +17422 2 0.000000 -1 2.500000 40.180000 13.918760 61.468750 17423 2 0.000000 1 2.500000 42.476000 9.941972 61.468750 17424 2 0.000000 -1 2.500000 42.476000 9.941972 61.468750 17425 2 0.000000 1 2.500000 44.772000 19.221145 1.756250 @@ -17443,7 +17443,7 @@ Atoms 17427 2 0.000000 1 2.500000 47.068000 23.197934 1.756250 17428 2 0.000000 -1 2.500000 47.068000 23.197934 1.756250 17429 2 0.000000 1 2.500000 40.180000 21.872338 5.268750 -17430 2 0.000000 -1.000000 2.500000 40.180000 21.872338 5.268750 +17430 2 0.000000 -1 2.500000 40.180000 21.872338 5.268750 17431 2 0.000000 1 2.500000 42.476000 17.895549 5.268750 17432 2 0.000000 -1 2.500000 42.476000 17.895549 5.268750 17433 2 0.000000 1 2.500000 44.772000 19.221145 8.781250 @@ -17451,7 +17451,7 @@ Atoms 17435 2 0.000000 1 2.500000 47.068000 23.197934 8.781250 17436 2 0.000000 -1 2.500000 47.068000 23.197934 8.781250 17437 2 0.000000 1 2.500000 40.180000 21.872338 12.293750 -17438 2 0.000000 -1.000000 2.500000 40.180000 21.872338 12.293750 +17438 2 0.000000 -1 2.500000 40.180000 21.872338 12.293750 17439 2 0.000000 1 2.500000 42.476000 17.895549 12.293750 17440 2 0.000000 -1 2.500000 42.476000 17.895549 12.293750 17441 2 0.000000 1 2.500000 44.772000 19.221145 15.806250 @@ -17459,7 +17459,7 @@ Atoms 17443 2 0.000000 1 2.500000 47.068000 23.197934 15.806250 17444 2 0.000000 -1 2.500000 47.068000 23.197934 15.806250 17445 2 0.000000 1 2.500000 40.180000 21.872338 19.318750 -17446 2 0.000000 -1.000000 2.500000 40.180000 21.872338 19.318750 +17446 2 0.000000 -1 2.500000 40.180000 21.872338 19.318750 17447 2 0.000000 1 2.500000 42.476000 17.895549 19.318750 17448 2 0.000000 -1 2.500000 42.476000 17.895549 19.318750 17449 2 0.000000 1 2.500000 44.772000 19.221145 22.831250 @@ -17467,7 +17467,7 @@ Atoms 17451 2 0.000000 1 2.500000 47.068000 23.197934 22.831250 17452 2 0.000000 -1 2.500000 47.068000 23.197934 22.831250 17453 2 0.000000 1 2.500000 40.180000 21.872338 26.343750 -17454 2 0.000000 -1.000000 2.500000 40.180000 21.872338 26.343750 +17454 2 0.000000 -1 2.500000 40.180000 21.872338 26.343750 17455 2 0.000000 1 2.500000 42.476000 17.895549 26.343750 17456 2 0.000000 -1 2.500000 42.476000 17.895549 26.343750 17457 2 0.000000 1 2.500000 44.772000 19.221145 29.856250 @@ -17475,7 +17475,7 @@ Atoms 17459 2 0.000000 1 2.500000 47.068000 23.197934 29.856250 17460 2 0.000000 -1 2.500000 47.068000 23.197934 29.856250 17461 2 0.000000 1 2.500000 40.180000 21.872338 33.368750 -17462 2 0.000000 -1.000000 2.500000 40.180000 21.872338 33.368750 +17462 2 0.000000 -1 2.500000 40.180000 21.872338 33.368750 17463 2 0.000000 1 2.500000 42.476000 17.895549 33.368750 17464 2 0.000000 -1 2.500000 42.476000 17.895549 33.368750 17465 2 0.000000 1 2.500000 44.772000 19.221145 36.881250 @@ -17483,7 +17483,7 @@ Atoms 17467 2 0.000000 1 2.500000 47.068000 23.197934 36.881250 17468 2 0.000000 -1 2.500000 47.068000 23.197934 36.881250 17469 2 0.000000 1 2.500000 40.180000 21.872338 40.393750 -17470 2 0.000000 -1.000000 2.500000 40.180000 21.872338 40.393750 +17470 2 0.000000 -1 2.500000 40.180000 21.872338 40.393750 17471 2 0.000000 1 2.500000 42.476000 17.895549 40.393750 17472 2 0.000000 -1 2.500000 42.476000 17.895549 40.393750 17473 2 0.000000 1 2.500000 44.772000 19.221145 43.906250 @@ -17491,7 +17491,7 @@ Atoms 17475 2 0.000000 1 2.500000 47.068000 23.197934 43.906250 17476 2 0.000000 -1 2.500000 47.068000 23.197934 43.906250 17477 2 0.000000 1 2.500000 40.180000 21.872338 47.418750 -17478 2 0.000000 -1.000000 2.500000 40.180000 21.872338 47.418750 +17478 2 0.000000 -1 2.500000 40.180000 21.872338 47.418750 17479 2 0.000000 1 2.500000 42.476000 17.895549 47.418750 17480 2 0.000000 -1 2.500000 42.476000 17.895549 47.418750 17481 2 0.000000 1 2.500000 44.772000 19.221145 50.931250 @@ -17499,7 +17499,7 @@ Atoms 17483 2 0.000000 1 2.500000 47.068000 23.197934 50.931250 17484 2 0.000000 -1 2.500000 47.068000 23.197934 50.931250 17485 2 0.000000 1 2.500000 40.180000 21.872338 54.443750 -17486 2 0.000000 -1.000000 2.500000 40.180000 21.872338 54.443750 +17486 2 0.000000 -1 2.500000 40.180000 21.872338 54.443750 17487 2 0.000000 1 2.500000 42.476000 17.895549 54.443750 17488 2 0.000000 -1 2.500000 42.476000 17.895549 54.443750 17489 2 0.000000 1 2.500000 44.772000 19.221145 57.956250 @@ -17507,7 +17507,7 @@ Atoms 17491 2 0.000000 1 2.500000 47.068000 23.197934 57.956250 17492 2 0.000000 -1 2.500000 47.068000 23.197934 57.956250 17493 2 0.000000 1 2.500000 40.180000 21.872338 61.468750 -17494 2 0.000000 -1.000000 2.500000 40.180000 21.872338 61.468750 +17494 2 0.000000 -1 2.500000 40.180000 21.872338 61.468750 17495 2 0.000000 1 2.500000 42.476000 17.895549 61.468750 17496 2 0.000000 -1 2.500000 42.476000 17.895549 61.468750 17497 2 0.000000 1 2.500000 44.772000 27.174722 1.756250 @@ -17515,7 +17515,7 @@ Atoms 17499 2 0.000000 1 2.500000 47.068000 31.151511 1.756250 17500 2 0.000000 -1 2.500000 47.068000 31.151511 1.756250 17501 2 0.000000 1 2.500000 40.180000 29.825915 5.268750 -17502 2 0.000000 -1.000000 2.500000 40.180000 29.825915 5.268750 +17502 2 0.000000 -1 2.500000 40.180000 29.825915 5.268750 17503 2 0.000000 1 2.500000 42.476000 25.849126 5.268750 17504 2 0.000000 -1 2.500000 42.476000 25.849126 5.268750 17505 2 0.000000 1 2.500000 44.772000 27.174722 8.781250 @@ -17523,7 +17523,7 @@ Atoms 17507 2 0.000000 1 2.500000 47.068000 31.151511 8.781250 17508 2 0.000000 -1 2.500000 47.068000 31.151511 8.781250 17509 2 0.000000 1 2.500000 40.180000 29.825915 12.293750 -17510 2 0.000000 -1.000000 2.500000 40.180000 29.825915 12.293750 +17510 2 0.000000 -1 2.500000 40.180000 29.825915 12.293750 17511 2 0.000000 1 2.500000 42.476000 25.849126 12.293750 17512 2 0.000000 -1 2.500000 42.476000 25.849126 12.293750 17513 2 0.000000 1 2.500000 44.772000 27.174722 15.806250 @@ -17531,7 +17531,7 @@ Atoms 17515 2 0.000000 1 2.500000 47.068000 31.151511 15.806250 17516 2 0.000000 -1 2.500000 47.068000 31.151511 15.806250 17517 2 0.000000 1 2.500000 40.180000 29.825915 19.318750 -17518 2 0.000000 -1.000000 2.500000 40.180000 29.825915 19.318750 +17518 2 0.000000 -1 2.500000 40.180000 29.825915 19.318750 17519 2 0.000000 1 2.500000 42.476000 25.849126 19.318750 17520 2 0.000000 -1 2.500000 42.476000 25.849126 19.318750 17521 2 0.000000 1 2.500000 44.772000 27.174722 22.831250 @@ -17539,7 +17539,7 @@ Atoms 17523 2 0.000000 1 2.500000 47.068000 31.151511 22.831250 17524 2 0.000000 -1 2.500000 47.068000 31.151511 22.831250 17525 2 0.000000 1 2.500000 40.180000 29.825915 26.343750 -17526 2 0.000000 -1.000000 2.500000 40.180000 29.825915 26.343750 +17526 2 0.000000 -1 2.500000 40.180000 29.825915 26.343750 17527 2 0.000000 1 2.500000 42.476000 25.849126 26.343750 17528 2 0.000000 -1 2.500000 42.476000 25.849126 26.343750 17529 2 0.000000 1 2.500000 44.772000 27.174722 29.856250 @@ -17547,7 +17547,7 @@ Atoms 17531 2 0.000000 1 2.500000 47.068000 31.151511 29.856250 17532 2 0.000000 -1 2.500000 47.068000 31.151511 29.856250 17533 2 0.000000 1 2.500000 40.180000 29.825915 33.368750 -17534 2 0.000000 -1.000000 2.500000 40.180000 29.825915 33.368750 +17534 2 0.000000 -1 2.500000 40.180000 29.825915 33.368750 17535 2 0.000000 1 2.500000 42.476000 25.849126 33.368750 17536 2 0.000000 -1 2.500000 42.476000 25.849126 33.368750 17537 2 0.000000 1 2.500000 44.772000 27.174722 36.881250 @@ -17555,7 +17555,7 @@ Atoms 17539 2 0.000000 1 2.500000 47.068000 31.151511 36.881250 17540 2 0.000000 -1 2.500000 47.068000 31.151511 36.881250 17541 2 0.000000 1 2.500000 40.180000 29.825915 40.393750 -17542 2 0.000000 -1.000000 2.500000 40.180000 29.825915 40.393750 +17542 2 0.000000 -1 2.500000 40.180000 29.825915 40.393750 17543 2 0.000000 1 2.500000 42.476000 25.849126 40.393750 17544 2 0.000000 -1 2.500000 42.476000 25.849126 40.393750 17545 2 0.000000 1 2.500000 44.772000 27.174722 43.906250 @@ -17563,7 +17563,7 @@ Atoms 17547 2 0.000000 1 2.500000 47.068000 31.151511 43.906250 17548 2 0.000000 -1 2.500000 47.068000 31.151511 43.906250 17549 2 0.000000 1 2.500000 40.180000 29.825915 47.418750 -17550 2 0.000000 -1.000000 2.500000 40.180000 29.825915 47.418750 +17550 2 0.000000 -1 2.500000 40.180000 29.825915 47.418750 17551 2 0.000000 1 2.500000 42.476000 25.849126 47.418750 17552 2 0.000000 -1 2.500000 42.476000 25.849126 47.418750 17553 2 0.000000 1 2.500000 44.772000 27.174722 50.931250 @@ -17571,7 +17571,7 @@ Atoms 17555 2 0.000000 1 2.500000 47.068000 31.151511 50.931250 17556 2 0.000000 -1 2.500000 47.068000 31.151511 50.931250 17557 2 0.000000 1 2.500000 40.180000 29.825915 54.443750 -17558 2 0.000000 -1.000000 2.500000 40.180000 29.825915 54.443750 +17558 2 0.000000 -1 2.500000 40.180000 29.825915 54.443750 17559 2 0.000000 1 2.500000 42.476000 25.849126 54.443750 17560 2 0.000000 -1 2.500000 42.476000 25.849126 54.443750 17561 2 0.000000 1 2.500000 44.772000 27.174722 57.956250 @@ -17579,7 +17579,7 @@ Atoms 17563 2 0.000000 1 2.500000 47.068000 31.151511 57.956250 17564 2 0.000000 -1 2.500000 47.068000 31.151511 57.956250 17565 2 0.000000 1 2.500000 40.180000 29.825915 61.468750 -17566 2 0.000000 -1.000000 2.500000 40.180000 29.825915 61.468750 +17566 2 0.000000 -1 2.500000 40.180000 29.825915 61.468750 17567 2 0.000000 1 2.500000 42.476000 25.849126 61.468750 17568 2 0.000000 -1 2.500000 42.476000 25.849126 61.468750 17569 2 0.000000 1 2.500000 44.772000 35.128300 1.756250 @@ -17587,7 +17587,7 @@ Atoms 17571 2 0.000000 1 2.500000 47.068000 39.105088 1.756250 17572 2 0.000000 -1 2.500000 47.068000 39.105088 1.756250 17573 2 0.000000 1 2.500000 40.180000 37.779492 5.268750 -17574 2 0.000000 -1.000000 2.500000 40.180000 37.779492 5.268750 +17574 2 0.000000 -1 2.500000 40.180000 37.779492 5.268750 17575 2 0.000000 1 2.500000 42.476000 33.802704 5.268750 17576 2 0.000000 -1 2.500000 42.476000 33.802704 5.268750 17577 2 0.000000 1 2.500000 44.772000 35.128300 8.781250 @@ -17595,7 +17595,7 @@ Atoms 17579 2 0.000000 1 2.500000 47.068000 39.105088 8.781250 17580 2 0.000000 -1 2.500000 47.068000 39.105088 8.781250 17581 2 0.000000 1 2.500000 40.180000 37.779492 12.293750 -17582 2 0.000000 -1.000000 2.500000 40.180000 37.779492 12.293750 +17582 2 0.000000 -1 2.500000 40.180000 37.779492 12.293750 17583 2 0.000000 1 2.500000 42.476000 33.802704 12.293750 17584 2 0.000000 -1 2.500000 42.476000 33.802704 12.293750 17585 2 0.000000 1 2.500000 44.772000 35.128300 15.806250 @@ -17603,7 +17603,7 @@ Atoms 17587 2 0.000000 1 2.500000 47.068000 39.105088 15.806250 17588 2 0.000000 -1 2.500000 47.068000 39.105088 15.806250 17589 2 0.000000 1 2.500000 40.180000 37.779492 19.318750 -17590 2 0.000000 -1.000000 2.500000 40.180000 37.779492 19.318750 +17590 2 0.000000 -1 2.500000 40.180000 37.779492 19.318750 17591 2 0.000000 1 2.500000 42.476000 33.802704 19.318750 17592 2 0.000000 -1 2.500000 42.476000 33.802704 19.318750 17593 2 0.000000 1 2.500000 44.772000 35.128300 22.831250 @@ -17611,7 +17611,7 @@ Atoms 17595 2 0.000000 1 2.500000 47.068000 39.105088 22.831250 17596 2 0.000000 -1 2.500000 47.068000 39.105088 22.831250 17597 2 0.000000 1 2.500000 40.180000 37.779492 26.343750 -17598 2 0.000000 -1.000000 2.500000 40.180000 37.779492 26.343750 +17598 2 0.000000 -1 2.500000 40.180000 37.779492 26.343750 17599 2 0.000000 1 2.500000 42.476000 33.802704 26.343750 17600 2 0.000000 -1 2.500000 42.476000 33.802704 26.343750 17601 2 0.000000 1 2.500000 44.772000 35.128300 29.856250 @@ -17619,7 +17619,7 @@ Atoms 17603 2 0.000000 1 2.500000 47.068000 39.105088 29.856250 17604 2 0.000000 -1 2.500000 47.068000 39.105088 29.856250 17605 2 0.000000 1 2.500000 40.180000 37.779492 33.368750 -17606 2 0.000000 -1.000000 2.500000 40.180000 37.779492 33.368750 +17606 2 0.000000 -1 2.500000 40.180000 37.779492 33.368750 17607 2 0.000000 1 2.500000 42.476000 33.802704 33.368750 17608 2 0.000000 -1 2.500000 42.476000 33.802704 33.368750 17609 2 0.000000 1 2.500000 44.772000 35.128300 36.881250 @@ -17627,7 +17627,7 @@ Atoms 17611 2 0.000000 1 2.500000 47.068000 39.105088 36.881250 17612 2 0.000000 -1 2.500000 47.068000 39.105088 36.881250 17613 2 0.000000 1 2.500000 40.180000 37.779492 40.393750 -17614 2 0.000000 -1.000000 2.500000 40.180000 37.779492 40.393750 +17614 2 0.000000 -1 2.500000 40.180000 37.779492 40.393750 17615 2 0.000000 1 2.500000 42.476000 33.802704 40.393750 17616 2 0.000000 -1 2.500000 42.476000 33.802704 40.393750 17617 2 0.000000 1 2.500000 44.772000 35.128300 43.906250 @@ -17635,7 +17635,7 @@ Atoms 17619 2 0.000000 1 2.500000 47.068000 39.105088 43.906250 17620 2 0.000000 -1 2.500000 47.068000 39.105088 43.906250 17621 2 0.000000 1 2.500000 40.180000 37.779492 47.418750 -17622 2 0.000000 -1.000000 2.500000 40.180000 37.779492 47.418750 +17622 2 0.000000 -1 2.500000 40.180000 37.779492 47.418750 17623 2 0.000000 1 2.500000 42.476000 33.802704 47.418750 17624 2 0.000000 -1 2.500000 42.476000 33.802704 47.418750 17625 2 0.000000 1 2.500000 44.772000 35.128300 50.931250 @@ -17643,7 +17643,7 @@ Atoms 17627 2 0.000000 1 2.500000 47.068000 39.105088 50.931250 17628 2 0.000000 -1 2.500000 47.068000 39.105088 50.931250 17629 2 0.000000 1 2.500000 40.180000 37.779492 54.443750 -17630 2 0.000000 -1.000000 2.500000 40.180000 37.779492 54.443750 +17630 2 0.000000 -1 2.500000 40.180000 37.779492 54.443750 17631 2 0.000000 1 2.500000 42.476000 33.802704 54.443750 17632 2 0.000000 -1 2.500000 42.476000 33.802704 54.443750 17633 2 0.000000 1 2.500000 44.772000 35.128300 57.956250 @@ -17651,7 +17651,7 @@ Atoms 17635 2 0.000000 1 2.500000 47.068000 39.105088 57.956250 17636 2 0.000000 -1 2.500000 47.068000 39.105088 57.956250 17637 2 0.000000 1 2.500000 40.180000 37.779492 61.468750 -17638 2 0.000000 -1.000000 2.500000 40.180000 37.779492 61.468750 +17638 2 0.000000 -1 2.500000 40.180000 37.779492 61.468750 17639 2 0.000000 1 2.500000 42.476000 33.802704 61.468750 17640 2 0.000000 -1 2.500000 42.476000 33.802704 61.468750 17641 2 0.000000 1 2.500000 44.772000 43.081877 1.756250 @@ -17659,7 +17659,7 @@ Atoms 17643 2 0.000000 1 2.500000 47.068000 47.058666 1.756250 17644 2 0.000000 -1 2.500000 47.068000 47.058666 1.756250 17645 2 0.000000 1 2.500000 40.180000 45.733070 5.268750 -17646 2 0.000000 -1.000000 2.500000 40.180000 45.733070 5.268750 +17646 2 0.000000 -1 2.500000 40.180000 45.733070 5.268750 17647 2 0.000000 1 2.500000 42.476000 41.756281 5.268750 17648 2 0.000000 -1 2.500000 42.476000 41.756281 5.268750 17649 2 0.000000 1 2.500000 44.772000 43.081877 8.781250 @@ -17667,7 +17667,7 @@ Atoms 17651 2 0.000000 1 2.500000 47.068000 47.058666 8.781250 17652 2 0.000000 -1 2.500000 47.068000 47.058666 8.781250 17653 2 0.000000 1 2.500000 40.180000 45.733070 12.293750 -17654 2 0.000000 -1.000000 2.500000 40.180000 45.733070 12.293750 +17654 2 0.000000 -1 2.500000 40.180000 45.733070 12.293750 17655 2 0.000000 1 2.500000 42.476000 41.756281 12.293750 17656 2 0.000000 -1 2.500000 42.476000 41.756281 12.293750 17657 2 0.000000 1 2.500000 44.772000 43.081877 15.806250 @@ -17675,7 +17675,7 @@ Atoms 17659 2 0.000000 1 2.500000 47.068000 47.058666 15.806250 17660 2 0.000000 -1 2.500000 47.068000 47.058666 15.806250 17661 2 0.000000 1 2.500000 40.180000 45.733070 19.318750 -17662 2 0.000000 -1.000000 2.500000 40.180000 45.733070 19.318750 +17662 2 0.000000 -1 2.500000 40.180000 45.733070 19.318750 17663 2 0.000000 1 2.500000 42.476000 41.756281 19.318750 17664 2 0.000000 -1 2.500000 42.476000 41.756281 19.318750 17665 2 0.000000 1 2.500000 44.772000 43.081877 22.831250 @@ -17683,7 +17683,7 @@ Atoms 17667 2 0.000000 1 2.500000 47.068000 47.058666 22.831250 17668 2 0.000000 -1 2.500000 47.068000 47.058666 22.831250 17669 2 0.000000 1 2.500000 40.180000 45.733070 26.343750 -17670 2 0.000000 -1.000000 2.500000 40.180000 45.733070 26.343750 +17670 2 0.000000 -1 2.500000 40.180000 45.733070 26.343750 17671 2 0.000000 1 2.500000 42.476000 41.756281 26.343750 17672 2 0.000000 -1 2.500000 42.476000 41.756281 26.343750 17673 2 0.000000 1 2.500000 44.772000 43.081877 29.856250 @@ -17691,7 +17691,7 @@ Atoms 17675 2 0.000000 1 2.500000 47.068000 47.058666 29.856250 17676 2 0.000000 -1 2.500000 47.068000 47.058666 29.856250 17677 2 0.000000 1 2.500000 40.180000 45.733070 33.368750 -17678 2 0.000000 -1.000000 2.500000 40.180000 45.733070 33.368750 +17678 2 0.000000 -1 2.500000 40.180000 45.733070 33.368750 17679 2 0.000000 1 2.500000 42.476000 41.756281 33.368750 17680 2 0.000000 -1 2.500000 42.476000 41.756281 33.368750 17681 2 0.000000 1 2.500000 44.772000 43.081877 36.881250 @@ -17699,7 +17699,7 @@ Atoms 17683 2 0.000000 1 2.500000 47.068000 47.058666 36.881250 17684 2 0.000000 -1 2.500000 47.068000 47.058666 36.881250 17685 2 0.000000 1 2.500000 40.180000 45.733070 40.393750 -17686 2 0.000000 -1.000000 2.500000 40.180000 45.733070 40.393750 +17686 2 0.000000 -1 2.500000 40.180000 45.733070 40.393750 17687 2 0.000000 1 2.500000 42.476000 41.756281 40.393750 17688 2 0.000000 -1 2.500000 42.476000 41.756281 40.393750 17689 2 0.000000 1 2.500000 44.772000 43.081877 43.906250 @@ -17707,7 +17707,7 @@ Atoms 17691 2 0.000000 1 2.500000 47.068000 47.058666 43.906250 17692 2 0.000000 -1 2.500000 47.068000 47.058666 43.906250 17693 2 0.000000 1 2.500000 40.180000 45.733070 47.418750 -17694 2 0.000000 -1.000000 2.500000 40.180000 45.733070 47.418750 +17694 2 0.000000 -1 2.500000 40.180000 45.733070 47.418750 17695 2 0.000000 1 2.500000 42.476000 41.756281 47.418750 17696 2 0.000000 -1 2.500000 42.476000 41.756281 47.418750 17697 2 0.000000 1 2.500000 44.772000 43.081877 50.931250 @@ -17715,7 +17715,7 @@ Atoms 17699 2 0.000000 1 2.500000 47.068000 47.058666 50.931250 17700 2 0.000000 -1 2.500000 47.068000 47.058666 50.931250 17701 2 0.000000 1 2.500000 40.180000 45.733070 54.443750 -17702 2 0.000000 -1.000000 2.500000 40.180000 45.733070 54.443750 +17702 2 0.000000 -1 2.500000 40.180000 45.733070 54.443750 17703 2 0.000000 1 2.500000 42.476000 41.756281 54.443750 17704 2 0.000000 -1 2.500000 42.476000 41.756281 54.443750 17705 2 0.000000 1 2.500000 44.772000 43.081877 57.956250 @@ -17723,7 +17723,7 @@ Atoms 17707 2 0.000000 1 2.500000 47.068000 47.058666 57.956250 17708 2 0.000000 -1 2.500000 47.068000 47.058666 57.956250 17709 2 0.000000 1 2.500000 40.180000 45.733070 61.468750 -17710 2 0.000000 -1.000000 2.500000 40.180000 45.733070 61.468750 +17710 2 0.000000 -1 2.500000 40.180000 45.733070 61.468750 17711 2 0.000000 1 2.500000 42.476000 41.756281 61.468750 17712 2 0.000000 -1 2.500000 42.476000 41.756281 61.468750 17713 2 0.000000 1 2.500000 44.772000 51.035454 1.756250 @@ -17731,7 +17731,7 @@ Atoms 17715 2 0.000000 1 2.500000 47.068000 55.012243 1.756250 17716 2 0.000000 -1 2.500000 47.068000 55.012243 1.756250 17717 2 0.000000 1 2.500000 40.180000 53.686647 5.268750 -17718 2 0.000000 -1.000000 2.500000 40.180000 53.686647 5.268750 +17718 2 0.000000 -1 2.500000 40.180000 53.686647 5.268750 17719 2 0.000000 1 2.500000 42.476000 49.709858 5.268750 17720 2 0.000000 -1 2.500000 42.476000 49.709858 5.268750 17721 2 0.000000 1 2.500000 44.772000 51.035454 8.781250 @@ -17739,7 +17739,7 @@ Atoms 17723 2 0.000000 1 2.500000 47.068000 55.012243 8.781250 17724 2 0.000000 -1 2.500000 47.068000 55.012243 8.781250 17725 2 0.000000 1 2.500000 40.180000 53.686647 12.293750 -17726 2 0.000000 -1.000000 2.500000 40.180000 53.686647 12.293750 +17726 2 0.000000 -1 2.500000 40.180000 53.686647 12.293750 17727 2 0.000000 1 2.500000 42.476000 49.709858 12.293750 17728 2 0.000000 -1 2.500000 42.476000 49.709858 12.293750 17729 2 0.000000 1 2.500000 44.772000 51.035454 15.806250 @@ -17747,7 +17747,7 @@ Atoms 17731 2 0.000000 1 2.500000 47.068000 55.012243 15.806250 17732 2 0.000000 -1 2.500000 47.068000 55.012243 15.806250 17733 2 0.000000 1 2.500000 40.180000 53.686647 19.318750 -17734 2 0.000000 -1.000000 2.500000 40.180000 53.686647 19.318750 +17734 2 0.000000 -1 2.500000 40.180000 53.686647 19.318750 17735 2 0.000000 1 2.500000 42.476000 49.709858 19.318750 17736 2 0.000000 -1 2.500000 42.476000 49.709858 19.318750 17737 2 0.000000 1 2.500000 44.772000 51.035454 22.831250 @@ -17755,7 +17755,7 @@ Atoms 17739 2 0.000000 1 2.500000 47.068000 55.012243 22.831250 17740 2 0.000000 -1 2.500000 47.068000 55.012243 22.831250 17741 2 0.000000 1 2.500000 40.180000 53.686647 26.343750 -17742 2 0.000000 -1.000000 2.500000 40.180000 53.686647 26.343750 +17742 2 0.000000 -1 2.500000 40.180000 53.686647 26.343750 17743 2 0.000000 1 2.500000 42.476000 49.709858 26.343750 17744 2 0.000000 -1 2.500000 42.476000 49.709858 26.343750 17745 2 0.000000 1 2.500000 44.772000 51.035454 29.856250 @@ -17763,7 +17763,7 @@ Atoms 17747 2 0.000000 1 2.500000 47.068000 55.012243 29.856250 17748 2 0.000000 -1 2.500000 47.068000 55.012243 29.856250 17749 2 0.000000 1 2.500000 40.180000 53.686647 33.368750 -17750 2 0.000000 -1.000000 2.500000 40.180000 53.686647 33.368750 +17750 2 0.000000 -1 2.500000 40.180000 53.686647 33.368750 17751 2 0.000000 1 2.500000 42.476000 49.709858 33.368750 17752 2 0.000000 -1 2.500000 42.476000 49.709858 33.368750 17753 2 0.000000 1 2.500000 44.772000 51.035454 36.881250 @@ -17771,7 +17771,7 @@ Atoms 17755 2 0.000000 1 2.500000 47.068000 55.012243 36.881250 17756 2 0.000000 -1 2.500000 47.068000 55.012243 36.881250 17757 2 0.000000 1 2.500000 40.180000 53.686647 40.393750 -17758 2 0.000000 -1.000000 2.500000 40.180000 53.686647 40.393750 +17758 2 0.000000 -1 2.500000 40.180000 53.686647 40.393750 17759 2 0.000000 1 2.500000 42.476000 49.709858 40.393750 17760 2 0.000000 -1 2.500000 42.476000 49.709858 40.393750 17761 2 0.000000 1 2.500000 44.772000 51.035454 43.906250 @@ -17779,7 +17779,7 @@ Atoms 17763 2 0.000000 1 2.500000 47.068000 55.012243 43.906250 17764 2 0.000000 -1 2.500000 47.068000 55.012243 43.906250 17765 2 0.000000 1 2.500000 40.180000 53.686647 47.418750 -17766 2 0.000000 -1.000000 2.500000 40.180000 53.686647 47.418750 +17766 2 0.000000 -1 2.500000 40.180000 53.686647 47.418750 17767 2 0.000000 1 2.500000 42.476000 49.709858 47.418750 17768 2 0.000000 -1 2.500000 42.476000 49.709858 47.418750 17769 2 0.000000 1 2.500000 44.772000 51.035454 50.931250 @@ -17787,7 +17787,7 @@ Atoms 17771 2 0.000000 1 2.500000 47.068000 55.012243 50.931250 17772 2 0.000000 -1 2.500000 47.068000 55.012243 50.931250 17773 2 0.000000 1 2.500000 40.180000 53.686647 54.443750 -17774 2 0.000000 -1.000000 2.500000 40.180000 53.686647 54.443750 +17774 2 0.000000 -1 2.500000 40.180000 53.686647 54.443750 17775 2 0.000000 1 2.500000 42.476000 49.709858 54.443750 17776 2 0.000000 -1 2.500000 42.476000 49.709858 54.443750 17777 2 0.000000 1 2.500000 44.772000 51.035454 57.956250 @@ -17795,7 +17795,7 @@ Atoms 17779 2 0.000000 1 2.500000 47.068000 55.012243 57.956250 17780 2 0.000000 -1 2.500000 47.068000 55.012243 57.956250 17781 2 0.000000 1 2.500000 40.180000 53.686647 61.468750 -17782 2 0.000000 -1.000000 2.500000 40.180000 53.686647 61.468750 +17782 2 0.000000 -1 2.500000 40.180000 53.686647 61.468750 17783 2 0.000000 1 2.500000 42.476000 49.709858 61.468750 17784 2 0.000000 -1 2.500000 42.476000 49.709858 61.468750 17785 2 0.000000 1 2.500000 44.772000 58.989032 1.756250 @@ -17803,7 +17803,7 @@ Atoms 17787 2 0.000000 1 2.500000 47.068000 62.965820 1.756250 17788 2 0.000000 -1 2.500000 47.068000 62.965820 1.756250 17789 2 0.000000 1 2.500000 40.180000 61.640224 5.268750 -17790 2 0.000000 -1.000000 2.500000 40.180000 61.640224 5.268750 +17790 2 0.000000 -1 2.500000 40.180000 61.640224 5.268750 17791 2 0.000000 1 2.500000 42.476000 57.663435 5.268750 17792 2 0.000000 -1 2.500000 42.476000 57.663435 5.268750 17793 2 0.000000 1 2.500000 44.772000 58.989032 8.781250 @@ -17811,7 +17811,7 @@ Atoms 17795 2 0.000000 1 2.500000 47.068000 62.965820 8.781250 17796 2 0.000000 -1 2.500000 47.068000 62.965820 8.781250 17797 2 0.000000 1 2.500000 40.180000 61.640224 12.293750 -17798 2 0.000000 -1.000000 2.500000 40.180000 61.640224 12.293750 +17798 2 0.000000 -1 2.500000 40.180000 61.640224 12.293750 17799 2 0.000000 1 2.500000 42.476000 57.663435 12.293750 17800 2 0.000000 -1 2.500000 42.476000 57.663435 12.293750 17801 2 0.000000 1 2.500000 44.772000 58.989032 15.806250 @@ -17819,7 +17819,7 @@ Atoms 17803 2 0.000000 1 2.500000 47.068000 62.965820 15.806250 17804 2 0.000000 -1 2.500000 47.068000 62.965820 15.806250 17805 2 0.000000 1 2.500000 40.180000 61.640224 19.318750 -17806 2 0.000000 -1.000000 2.500000 40.180000 61.640224 19.318750 +17806 2 0.000000 -1 2.500000 40.180000 61.640224 19.318750 17807 2 0.000000 1 2.500000 42.476000 57.663435 19.318750 17808 2 0.000000 -1 2.500000 42.476000 57.663435 19.318750 17809 2 0.000000 1 2.500000 44.772000 58.989032 22.831250 @@ -17827,7 +17827,7 @@ Atoms 17811 2 0.000000 1 2.500000 47.068000 62.965820 22.831250 17812 2 0.000000 -1 2.500000 47.068000 62.965820 22.831250 17813 2 0.000000 1 2.500000 40.180000 61.640224 26.343750 -17814 2 0.000000 -1.000000 2.500000 40.180000 61.640224 26.343750 +17814 2 0.000000 -1 2.500000 40.180000 61.640224 26.343750 17815 2 0.000000 1 2.500000 42.476000 57.663435 26.343750 17816 2 0.000000 -1 2.500000 42.476000 57.663435 26.343750 17817 2 0.000000 1 2.500000 44.772000 58.989032 29.856250 @@ -17835,7 +17835,7 @@ Atoms 17819 2 0.000000 1 2.500000 47.068000 62.965820 29.856250 17820 2 0.000000 -1 2.500000 47.068000 62.965820 29.856250 17821 2 0.000000 1 2.500000 40.180000 61.640224 33.368750 -17822 2 0.000000 -1.000000 2.500000 40.180000 61.640224 33.368750 +17822 2 0.000000 -1 2.500000 40.180000 61.640224 33.368750 17823 2 0.000000 1 2.500000 42.476000 57.663435 33.368750 17824 2 0.000000 -1 2.500000 42.476000 57.663435 33.368750 17825 2 0.000000 1 2.500000 44.772000 58.989032 36.881250 @@ -17843,7 +17843,7 @@ Atoms 17827 2 0.000000 1 2.500000 47.068000 62.965820 36.881250 17828 2 0.000000 -1 2.500000 47.068000 62.965820 36.881250 17829 2 0.000000 1 2.500000 40.180000 61.640224 40.393750 -17830 2 0.000000 -1.000000 2.500000 40.180000 61.640224 40.393750 +17830 2 0.000000 -1 2.500000 40.180000 61.640224 40.393750 17831 2 0.000000 1 2.500000 42.476000 57.663435 40.393750 17832 2 0.000000 -1 2.500000 42.476000 57.663435 40.393750 17833 2 0.000000 1 2.500000 44.772000 58.989032 43.906250 @@ -17851,7 +17851,7 @@ Atoms 17835 2 0.000000 1 2.500000 47.068000 62.965820 43.906250 17836 2 0.000000 -1 2.500000 47.068000 62.965820 43.906250 17837 2 0.000000 1 2.500000 40.180000 61.640224 47.418750 -17838 2 0.000000 -1.000000 2.500000 40.180000 61.640224 47.418750 +17838 2 0.000000 -1 2.500000 40.180000 61.640224 47.418750 17839 2 0.000000 1 2.500000 42.476000 57.663435 47.418750 17840 2 0.000000 -1 2.500000 42.476000 57.663435 47.418750 17841 2 0.000000 1 2.500000 44.772000 58.989032 50.931250 @@ -17859,7 +17859,7 @@ Atoms 17843 2 0.000000 1 2.500000 47.068000 62.965820 50.931250 17844 2 0.000000 -1 2.500000 47.068000 62.965820 50.931250 17845 2 0.000000 1 2.500000 40.180000 61.640224 54.443750 -17846 2 0.000000 -1.000000 2.500000 40.180000 61.640224 54.443750 +17846 2 0.000000 -1 2.500000 40.180000 61.640224 54.443750 17847 2 0.000000 1 2.500000 42.476000 57.663435 54.443750 17848 2 0.000000 -1 2.500000 42.476000 57.663435 54.443750 17849 2 0.000000 1 2.500000 44.772000 58.989032 57.956250 @@ -17867,7 +17867,7 @@ Atoms 17851 2 0.000000 1 2.500000 47.068000 62.965820 57.956250 17852 2 0.000000 -1 2.500000 47.068000 62.965820 57.956250 17853 2 0.000000 1 2.500000 40.180000 61.640224 61.468750 -17854 2 0.000000 -1.000000 2.500000 40.180000 61.640224 61.468750 +17854 2 0.000000 -1 2.500000 40.180000 61.640224 61.468750 17855 2 0.000000 1 2.500000 42.476000 57.663435 61.468750 17856 2 0.000000 -1 2.500000 42.476000 57.663435 61.468750 17857 2 0.000000 1 2.500000 49.364000 3.313991 1.756250 @@ -17875,7 +17875,7 @@ Atoms 17859 2 0.000000 1 2.500000 51.660000 7.290779 1.756250 17860 2 0.000000 -1 2.500000 51.660000 7.290779 1.756250 17861 2 0.000000 1 2.500000 44.772000 5.965183 5.268750 -17862 2 0.000000 -1.000000 2.500000 44.772000 5.965183 5.268750 +17862 2 0.000000 -1 2.500000 44.772000 5.965183 5.268750 17863 2 0.000000 1 2.500000 47.068000 1.988394 5.268750 17864 2 0.000000 -1 2.500000 47.068000 1.988394 5.268750 17865 2 0.000000 1 2.500000 49.364000 3.313991 8.781250 @@ -17883,7 +17883,7 @@ Atoms 17867 2 0.000000 1 2.500000 51.660000 7.290779 8.781250 17868 2 0.000000 -1 2.500000 51.660000 7.290779 8.781250 17869 2 0.000000 1 2.500000 44.772000 5.965183 12.293750 -17870 2 0.000000 -1.000000 2.500000 44.772000 5.965183 12.293750 +17870 2 0.000000 -1 2.500000 44.772000 5.965183 12.293750 17871 2 0.000000 1 2.500000 47.068000 1.988394 12.293750 17872 2 0.000000 -1 2.500000 47.068000 1.988394 12.293750 17873 2 0.000000 1 2.500000 49.364000 3.313991 15.806250 @@ -17891,7 +17891,7 @@ Atoms 17875 2 0.000000 1 2.500000 51.660000 7.290779 15.806250 17876 2 0.000000 -1 2.500000 51.660000 7.290779 15.806250 17877 2 0.000000 1 2.500000 44.772000 5.965183 19.318750 -17878 2 0.000000 -1.000000 2.500000 44.772000 5.965183 19.318750 +17878 2 0.000000 -1 2.500000 44.772000 5.965183 19.318750 17879 2 0.000000 1 2.500000 47.068000 1.988394 19.318750 17880 2 0.000000 -1 2.500000 47.068000 1.988394 19.318750 17881 2 0.000000 1 2.500000 49.364000 3.313991 22.831250 @@ -17899,7 +17899,7 @@ Atoms 17883 2 0.000000 1 2.500000 51.660000 7.290779 22.831250 17884 2 0.000000 -1 2.500000 51.660000 7.290779 22.831250 17885 2 0.000000 1 2.500000 44.772000 5.965183 26.343750 -17886 2 0.000000 -1.000000 2.500000 44.772000 5.965183 26.343750 +17886 2 0.000000 -1 2.500000 44.772000 5.965183 26.343750 17887 2 0.000000 1 2.500000 47.068000 1.988394 26.343750 17888 2 0.000000 -1 2.500000 47.068000 1.988394 26.343750 17889 2 0.000000 1 2.500000 49.364000 3.313991 29.856250 @@ -17907,7 +17907,7 @@ Atoms 17891 2 0.000000 1 2.500000 51.660000 7.290779 29.856250 17892 2 0.000000 -1 2.500000 51.660000 7.290779 29.856250 17893 2 0.000000 1 2.500000 44.772000 5.965183 33.368750 -17894 2 0.000000 -1.000000 2.500000 44.772000 5.965183 33.368750 +17894 2 0.000000 -1 2.500000 44.772000 5.965183 33.368750 17895 2 0.000000 1 2.500000 47.068000 1.988394 33.368750 17896 2 0.000000 -1 2.500000 47.068000 1.988394 33.368750 17897 2 0.000000 1 2.500000 49.364000 3.313991 36.881250 @@ -17915,7 +17915,7 @@ Atoms 17899 2 0.000000 1 2.500000 51.660000 7.290779 36.881250 17900 2 0.000000 -1 2.500000 51.660000 7.290779 36.881250 17901 2 0.000000 1 2.500000 44.772000 5.965183 40.393750 -17902 2 0.000000 -1.000000 2.500000 44.772000 5.965183 40.393750 +17902 2 0.000000 -1 2.500000 44.772000 5.965183 40.393750 17903 2 0.000000 1 2.500000 47.068000 1.988394 40.393750 17904 2 0.000000 -1 2.500000 47.068000 1.988394 40.393750 17905 2 0.000000 1 2.500000 49.364000 3.313991 43.906250 @@ -17923,7 +17923,7 @@ Atoms 17907 2 0.000000 1 2.500000 51.660000 7.290779 43.906250 17908 2 0.000000 -1 2.500000 51.660000 7.290779 43.906250 17909 2 0.000000 1 2.500000 44.772000 5.965183 47.418750 -17910 2 0.000000 -1.000000 2.500000 44.772000 5.965183 47.418750 +17910 2 0.000000 -1 2.500000 44.772000 5.965183 47.418750 17911 2 0.000000 1 2.500000 47.068000 1.988394 47.418750 17912 2 0.000000 -1 2.500000 47.068000 1.988394 47.418750 17913 2 0.000000 1 2.500000 49.364000 3.313991 50.931250 @@ -17931,7 +17931,7 @@ Atoms 17915 2 0.000000 1 2.500000 51.660000 7.290779 50.931250 17916 2 0.000000 -1 2.500000 51.660000 7.290779 50.931250 17917 2 0.000000 1 2.500000 44.772000 5.965183 54.443750 -17918 2 0.000000 -1.000000 2.500000 44.772000 5.965183 54.443750 +17918 2 0.000000 -1 2.500000 44.772000 5.965183 54.443750 17919 2 0.000000 1 2.500000 47.068000 1.988394 54.443750 17920 2 0.000000 -1 2.500000 47.068000 1.988394 54.443750 17921 2 0.000000 1 2.500000 49.364000 3.313991 57.956250 @@ -17939,7 +17939,7 @@ Atoms 17923 2 0.000000 1 2.500000 51.660000 7.290779 57.956250 17924 2 0.000000 -1 2.500000 51.660000 7.290779 57.956250 17925 2 0.000000 1 2.500000 44.772000 5.965183 61.468750 -17926 2 0.000000 -1.000000 2.500000 44.772000 5.965183 61.468750 +17926 2 0.000000 -1 2.500000 44.772000 5.965183 61.468750 17927 2 0.000000 1 2.500000 47.068000 1.988394 61.468750 17928 2 0.000000 -1 2.500000 47.068000 1.988394 61.468750 17929 2 0.000000 1 2.500000 49.364000 11.267568 1.756250 @@ -17947,7 +17947,7 @@ Atoms 17931 2 0.000000 1 2.500000 51.660000 15.244357 1.756250 17932 2 0.000000 -1 2.500000 51.660000 15.244357 1.756250 17933 2 0.000000 1 2.500000 44.772000 13.918760 5.268750 -17934 2 0.000000 -1.000000 2.500000 44.772000 13.918760 5.268750 +17934 2 0.000000 -1 2.500000 44.772000 13.918760 5.268750 17935 2 0.000000 1 2.500000 47.068000 9.941972 5.268750 17936 2 0.000000 -1 2.500000 47.068000 9.941972 5.268750 17937 2 0.000000 1 2.500000 49.364000 11.267568 8.781250 @@ -17955,7 +17955,7 @@ Atoms 17939 2 0.000000 1 2.500000 51.660000 15.244357 8.781250 17940 2 0.000000 -1 2.500000 51.660000 15.244357 8.781250 17941 2 0.000000 1 2.500000 44.772000 13.918760 12.293750 -17942 2 0.000000 -1.000000 2.500000 44.772000 13.918760 12.293750 +17942 2 0.000000 -1 2.500000 44.772000 13.918760 12.293750 17943 2 0.000000 1 2.500000 47.068000 9.941972 12.293750 17944 2 0.000000 -1 2.500000 47.068000 9.941972 12.293750 17945 2 0.000000 1 2.500000 49.364000 11.267568 15.806250 @@ -17963,7 +17963,7 @@ Atoms 17947 2 0.000000 1 2.500000 51.660000 15.244357 15.806250 17948 2 0.000000 -1 2.500000 51.660000 15.244357 15.806250 17949 2 0.000000 1 2.500000 44.772000 13.918760 19.318750 -17950 2 0.000000 -1.000000 2.500000 44.772000 13.918760 19.318750 +17950 2 0.000000 -1 2.500000 44.772000 13.918760 19.318750 17951 2 0.000000 1 2.500000 47.068000 9.941972 19.318750 17952 2 0.000000 -1 2.500000 47.068000 9.941972 19.318750 17953 2 0.000000 1 2.500000 49.364000 11.267568 22.831250 @@ -17971,7 +17971,7 @@ Atoms 17955 2 0.000000 1 2.500000 51.660000 15.244357 22.831250 17956 2 0.000000 -1 2.500000 51.660000 15.244357 22.831250 17957 2 0.000000 1 2.500000 44.772000 13.918760 26.343750 -17958 2 0.000000 -1.000000 2.500000 44.772000 13.918760 26.343750 +17958 2 0.000000 -1 2.500000 44.772000 13.918760 26.343750 17959 2 0.000000 1 2.500000 47.068000 9.941972 26.343750 17960 2 0.000000 -1 2.500000 47.068000 9.941972 26.343750 17961 2 0.000000 1 2.500000 49.364000 11.267568 29.856250 @@ -17979,7 +17979,7 @@ Atoms 17963 2 0.000000 1 2.500000 51.660000 15.244357 29.856250 17964 2 0.000000 -1 2.500000 51.660000 15.244357 29.856250 17965 2 0.000000 1 2.500000 44.772000 13.918760 33.368750 -17966 2 0.000000 -1.000000 2.500000 44.772000 13.918760 33.368750 +17966 2 0.000000 -1 2.500000 44.772000 13.918760 33.368750 17967 2 0.000000 1 2.500000 47.068000 9.941972 33.368750 17968 2 0.000000 -1 2.500000 47.068000 9.941972 33.368750 17969 2 0.000000 1 2.500000 49.364000 11.267568 36.881250 @@ -17987,7 +17987,7 @@ Atoms 17971 2 0.000000 1 2.500000 51.660000 15.244357 36.881250 17972 2 0.000000 -1 2.500000 51.660000 15.244357 36.881250 17973 2 0.000000 1 2.500000 44.772000 13.918760 40.393750 -17974 2 0.000000 -1.000000 2.500000 44.772000 13.918760 40.393750 +17974 2 0.000000 -1 2.500000 44.772000 13.918760 40.393750 17975 2 0.000000 1 2.500000 47.068000 9.941972 40.393750 17976 2 0.000000 -1 2.500000 47.068000 9.941972 40.393750 17977 2 0.000000 1 2.500000 49.364000 11.267568 43.906250 @@ -17995,7 +17995,7 @@ Atoms 17979 2 0.000000 1 2.500000 51.660000 15.244357 43.906250 17980 2 0.000000 -1 2.500000 51.660000 15.244357 43.906250 17981 2 0.000000 1 2.500000 44.772000 13.918760 47.418750 -17982 2 0.000000 -1.000000 2.500000 44.772000 13.918760 47.418750 +17982 2 0.000000 -1 2.500000 44.772000 13.918760 47.418750 17983 2 0.000000 1 2.500000 47.068000 9.941972 47.418750 17984 2 0.000000 -1 2.500000 47.068000 9.941972 47.418750 17985 2 0.000000 1 2.500000 49.364000 11.267568 50.931250 @@ -18003,7 +18003,7 @@ Atoms 17987 2 0.000000 1 2.500000 51.660000 15.244357 50.931250 17988 2 0.000000 -1 2.500000 51.660000 15.244357 50.931250 17989 2 0.000000 1 2.500000 44.772000 13.918760 54.443750 -17990 2 0.000000 -1.000000 2.500000 44.772000 13.918760 54.443750 +17990 2 0.000000 -1 2.500000 44.772000 13.918760 54.443750 17991 2 0.000000 1 2.500000 47.068000 9.941972 54.443750 17992 2 0.000000 -1 2.500000 47.068000 9.941972 54.443750 17993 2 0.000000 1 2.500000 49.364000 11.267568 57.956250 @@ -18011,7 +18011,7 @@ Atoms 17995 2 0.000000 1 2.500000 51.660000 15.244357 57.956250 17996 2 0.000000 -1 2.500000 51.660000 15.244357 57.956250 17997 2 0.000000 1 2.500000 44.772000 13.918760 61.468750 -17998 2 0.000000 -1.000000 2.500000 44.772000 13.918760 61.468750 +17998 2 0.000000 -1 2.500000 44.772000 13.918760 61.468750 17999 2 0.000000 1 2.500000 47.068000 9.941972 61.468750 18000 2 0.000000 -1 2.500000 47.068000 9.941972 61.468750 18001 2 0.000000 1 2.500000 49.364000 19.221145 1.756250 @@ -18019,7 +18019,7 @@ Atoms 18003 2 0.000000 1 2.500000 51.660000 23.197934 1.756250 18004 2 0.000000 -1 2.500000 51.660000 23.197934 1.756250 18005 2 0.000000 1 2.500000 44.772000 21.872338 5.268750 -18006 2 0.000000 -1.000000 2.500000 44.772000 21.872338 5.268750 +18006 2 0.000000 -1 2.500000 44.772000 21.872338 5.268750 18007 2 0.000000 1 2.500000 47.068000 17.895549 5.268750 18008 2 0.000000 -1 2.500000 47.068000 17.895549 5.268750 18009 2 0.000000 1 2.500000 49.364000 19.221145 8.781250 @@ -18027,7 +18027,7 @@ Atoms 18011 2 0.000000 1 2.500000 51.660000 23.197934 8.781250 18012 2 0.000000 -1 2.500000 51.660000 23.197934 8.781250 18013 2 0.000000 1 2.500000 44.772000 21.872338 12.293750 -18014 2 0.000000 -1.000000 2.500000 44.772000 21.872338 12.293750 +18014 2 0.000000 -1 2.500000 44.772000 21.872338 12.293750 18015 2 0.000000 1 2.500000 47.068000 17.895549 12.293750 18016 2 0.000000 -1 2.500000 47.068000 17.895549 12.293750 18017 2 0.000000 1 2.500000 49.364000 19.221145 15.806250 @@ -18035,7 +18035,7 @@ Atoms 18019 2 0.000000 1 2.500000 51.660000 23.197934 15.806250 18020 2 0.000000 -1 2.500000 51.660000 23.197934 15.806250 18021 2 0.000000 1 2.500000 44.772000 21.872338 19.318750 -18022 2 0.000000 -1.000000 2.500000 44.772000 21.872338 19.318750 +18022 2 0.000000 -1 2.500000 44.772000 21.872338 19.318750 18023 2 0.000000 1 2.500000 47.068000 17.895549 19.318750 18024 2 0.000000 -1 2.500000 47.068000 17.895549 19.318750 18025 2 0.000000 1 2.500000 49.364000 19.221145 22.831250 @@ -18043,7 +18043,7 @@ Atoms 18027 2 0.000000 1 2.500000 51.660000 23.197934 22.831250 18028 2 0.000000 -1 2.500000 51.660000 23.197934 22.831250 18029 2 0.000000 1 2.500000 44.772000 21.872338 26.343750 -18030 2 0.000000 -1.000000 2.500000 44.772000 21.872338 26.343750 +18030 2 0.000000 -1 2.500000 44.772000 21.872338 26.343750 18031 2 0.000000 1 2.500000 47.068000 17.895549 26.343750 18032 2 0.000000 -1 2.500000 47.068000 17.895549 26.343750 18033 2 0.000000 1 2.500000 49.364000 19.221145 29.856250 @@ -18051,7 +18051,7 @@ Atoms 18035 2 0.000000 1 2.500000 51.660000 23.197934 29.856250 18036 2 0.000000 -1 2.500000 51.660000 23.197934 29.856250 18037 2 0.000000 1 2.500000 44.772000 21.872338 33.368750 -18038 2 0.000000 -1.000000 2.500000 44.772000 21.872338 33.368750 +18038 2 0.000000 -1 2.500000 44.772000 21.872338 33.368750 18039 2 0.000000 1 2.500000 47.068000 17.895549 33.368750 18040 2 0.000000 -1 2.500000 47.068000 17.895549 33.368750 18041 2 0.000000 1 2.500000 49.364000 19.221145 36.881250 @@ -18059,7 +18059,7 @@ Atoms 18043 2 0.000000 1 2.500000 51.660000 23.197934 36.881250 18044 2 0.000000 -1 2.500000 51.660000 23.197934 36.881250 18045 2 0.000000 1 2.500000 44.772000 21.872338 40.393750 -18046 2 0.000000 -1.000000 2.500000 44.772000 21.872338 40.393750 +18046 2 0.000000 -1 2.500000 44.772000 21.872338 40.393750 18047 2 0.000000 1 2.500000 47.068000 17.895549 40.393750 18048 2 0.000000 -1 2.500000 47.068000 17.895549 40.393750 18049 2 0.000000 1 2.500000 49.364000 19.221145 43.906250 @@ -18067,7 +18067,7 @@ Atoms 18051 2 0.000000 1 2.500000 51.660000 23.197934 43.906250 18052 2 0.000000 -1 2.500000 51.660000 23.197934 43.906250 18053 2 0.000000 1 2.500000 44.772000 21.872338 47.418750 -18054 2 0.000000 -1.000000 2.500000 44.772000 21.872338 47.418750 +18054 2 0.000000 -1 2.500000 44.772000 21.872338 47.418750 18055 2 0.000000 1 2.500000 47.068000 17.895549 47.418750 18056 2 0.000000 -1 2.500000 47.068000 17.895549 47.418750 18057 2 0.000000 1 2.500000 49.364000 19.221145 50.931250 @@ -18075,7 +18075,7 @@ Atoms 18059 2 0.000000 1 2.500000 51.660000 23.197934 50.931250 18060 2 0.000000 -1 2.500000 51.660000 23.197934 50.931250 18061 2 0.000000 1 2.500000 44.772000 21.872338 54.443750 -18062 2 0.000000 -1.000000 2.500000 44.772000 21.872338 54.443750 +18062 2 0.000000 -1 2.500000 44.772000 21.872338 54.443750 18063 2 0.000000 1 2.500000 47.068000 17.895549 54.443750 18064 2 0.000000 -1 2.500000 47.068000 17.895549 54.443750 18065 2 0.000000 1 2.500000 49.364000 19.221145 57.956250 @@ -18083,7 +18083,7 @@ Atoms 18067 2 0.000000 1 2.500000 51.660000 23.197934 57.956250 18068 2 0.000000 -1 2.500000 51.660000 23.197934 57.956250 18069 2 0.000000 1 2.500000 44.772000 21.872338 61.468750 -18070 2 0.000000 -1.000000 2.500000 44.772000 21.872338 61.468750 +18070 2 0.000000 -1 2.500000 44.772000 21.872338 61.468750 18071 2 0.000000 1 2.500000 47.068000 17.895549 61.468750 18072 2 0.000000 -1 2.500000 47.068000 17.895549 61.468750 18073 2 0.000000 1 2.500000 49.364000 27.174722 1.756250 @@ -18091,7 +18091,7 @@ Atoms 18075 2 0.000000 1 2.500000 51.660000 31.151511 1.756250 18076 2 0.000000 -1 2.500000 51.660000 31.151511 1.756250 18077 2 0.000000 1 2.500000 44.772000 29.825915 5.268750 -18078 2 0.000000 -1.000000 2.500000 44.772000 29.825915 5.268750 +18078 2 0.000000 -1 2.500000 44.772000 29.825915 5.268750 18079 2 0.000000 1 2.500000 47.068000 25.849126 5.268750 18080 2 0.000000 -1 2.500000 47.068000 25.849126 5.268750 18081 2 0.000000 1 2.500000 49.364000 27.174722 8.781250 @@ -18099,7 +18099,7 @@ Atoms 18083 2 0.000000 1 2.500000 51.660000 31.151511 8.781250 18084 2 0.000000 -1 2.500000 51.660000 31.151511 8.781250 18085 2 0.000000 1 2.500000 44.772000 29.825915 12.293750 -18086 2 0.000000 -1.000000 2.500000 44.772000 29.825915 12.293750 +18086 2 0.000000 -1 2.500000 44.772000 29.825915 12.293750 18087 2 0.000000 1 2.500000 47.068000 25.849126 12.293750 18088 2 0.000000 -1 2.500000 47.068000 25.849126 12.293750 18089 2 0.000000 1 2.500000 49.364000 27.174722 15.806250 @@ -18107,7 +18107,7 @@ Atoms 18091 2 0.000000 1 2.500000 51.660000 31.151511 15.806250 18092 2 0.000000 -1 2.500000 51.660000 31.151511 15.806250 18093 2 0.000000 1 2.500000 44.772000 29.825915 19.318750 -18094 2 0.000000 -1.000000 2.500000 44.772000 29.825915 19.318750 +18094 2 0.000000 -1 2.500000 44.772000 29.825915 19.318750 18095 2 0.000000 1 2.500000 47.068000 25.849126 19.318750 18096 2 0.000000 -1 2.500000 47.068000 25.849126 19.318750 18097 2 0.000000 1 2.500000 49.364000 27.174722 22.831250 @@ -18115,7 +18115,7 @@ Atoms 18099 2 0.000000 1 2.500000 51.660000 31.151511 22.831250 18100 2 0.000000 -1 2.500000 51.660000 31.151511 22.831250 18101 2 0.000000 1 2.500000 44.772000 29.825915 26.343750 -18102 2 0.000000 -1.000000 2.500000 44.772000 29.825915 26.343750 +18102 2 0.000000 -1 2.500000 44.772000 29.825915 26.343750 18103 2 0.000000 1 2.500000 47.068000 25.849126 26.343750 18104 2 0.000000 -1 2.500000 47.068000 25.849126 26.343750 18105 2 0.000000 1 2.500000 49.364000 27.174722 29.856250 @@ -18123,7 +18123,7 @@ Atoms 18107 2 0.000000 1 2.500000 51.660000 31.151511 29.856250 18108 2 0.000000 -1 2.500000 51.660000 31.151511 29.856250 18109 2 0.000000 1 2.500000 44.772000 29.825915 33.368750 -18110 2 0.000000 -1.000000 2.500000 44.772000 29.825915 33.368750 +18110 2 0.000000 -1 2.500000 44.772000 29.825915 33.368750 18111 2 0.000000 1 2.500000 47.068000 25.849126 33.368750 18112 2 0.000000 -1 2.500000 47.068000 25.849126 33.368750 18113 2 0.000000 1 2.500000 49.364000 27.174722 36.881250 @@ -18131,7 +18131,7 @@ Atoms 18115 2 0.000000 1 2.500000 51.660000 31.151511 36.881250 18116 2 0.000000 -1 2.500000 51.660000 31.151511 36.881250 18117 2 0.000000 1 2.500000 44.772000 29.825915 40.393750 -18118 2 0.000000 -1.000000 2.500000 44.772000 29.825915 40.393750 +18118 2 0.000000 -1 2.500000 44.772000 29.825915 40.393750 18119 2 0.000000 1 2.500000 47.068000 25.849126 40.393750 18120 2 0.000000 -1 2.500000 47.068000 25.849126 40.393750 18121 2 0.000000 1 2.500000 49.364000 27.174722 43.906250 @@ -18139,7 +18139,7 @@ Atoms 18123 2 0.000000 1 2.500000 51.660000 31.151511 43.906250 18124 2 0.000000 -1 2.500000 51.660000 31.151511 43.906250 18125 2 0.000000 1 2.500000 44.772000 29.825915 47.418750 -18126 2 0.000000 -1.000000 2.500000 44.772000 29.825915 47.418750 +18126 2 0.000000 -1 2.500000 44.772000 29.825915 47.418750 18127 2 0.000000 1 2.500000 47.068000 25.849126 47.418750 18128 2 0.000000 -1 2.500000 47.068000 25.849126 47.418750 18129 2 0.000000 1 2.500000 49.364000 27.174722 50.931250 @@ -18147,7 +18147,7 @@ Atoms 18131 2 0.000000 1 2.500000 51.660000 31.151511 50.931250 18132 2 0.000000 -1 2.500000 51.660000 31.151511 50.931250 18133 2 0.000000 1 2.500000 44.772000 29.825915 54.443750 -18134 2 0.000000 -1.000000 2.500000 44.772000 29.825915 54.443750 +18134 2 0.000000 -1 2.500000 44.772000 29.825915 54.443750 18135 2 0.000000 1 2.500000 47.068000 25.849126 54.443750 18136 2 0.000000 -1 2.500000 47.068000 25.849126 54.443750 18137 2 0.000000 1 2.500000 49.364000 27.174722 57.956250 @@ -18155,7 +18155,7 @@ Atoms 18139 2 0.000000 1 2.500000 51.660000 31.151511 57.956250 18140 2 0.000000 -1 2.500000 51.660000 31.151511 57.956250 18141 2 0.000000 1 2.500000 44.772000 29.825915 61.468750 -18142 2 0.000000 -1.000000 2.500000 44.772000 29.825915 61.468750 +18142 2 0.000000 -1 2.500000 44.772000 29.825915 61.468750 18143 2 0.000000 1 2.500000 47.068000 25.849126 61.468750 18144 2 0.000000 -1 2.500000 47.068000 25.849126 61.468750 18145 2 0.000000 1 2.500000 49.364000 35.128300 1.756250 @@ -18163,7 +18163,7 @@ Atoms 18147 2 0.000000 1 2.500000 51.660000 39.105088 1.756250 18148 2 0.000000 -1 2.500000 51.660000 39.105088 1.756250 18149 2 0.000000 1 2.500000 44.772000 37.779492 5.268750 -18150 2 0.000000 -1.000000 2.500000 44.772000 37.779492 5.268750 +18150 2 0.000000 -1 2.500000 44.772000 37.779492 5.268750 18151 2 0.000000 1 2.500000 47.068000 33.802704 5.268750 18152 2 0.000000 -1 2.500000 47.068000 33.802704 5.268750 18153 2 0.000000 1 2.500000 49.364000 35.128300 8.781250 @@ -18171,7 +18171,7 @@ Atoms 18155 2 0.000000 1 2.500000 51.660000 39.105088 8.781250 18156 2 0.000000 -1 2.500000 51.660000 39.105088 8.781250 18157 2 0.000000 1 2.500000 44.772000 37.779492 12.293750 -18158 2 0.000000 -1.000000 2.500000 44.772000 37.779492 12.293750 +18158 2 0.000000 -1 2.500000 44.772000 37.779492 12.293750 18159 2 0.000000 1 2.500000 47.068000 33.802704 12.293750 18160 2 0.000000 -1 2.500000 47.068000 33.802704 12.293750 18161 2 0.000000 1 2.500000 49.364000 35.128300 15.806250 @@ -18179,7 +18179,7 @@ Atoms 18163 2 0.000000 1 2.500000 51.660000 39.105088 15.806250 18164 2 0.000000 -1 2.500000 51.660000 39.105088 15.806250 18165 2 0.000000 1 2.500000 44.772000 37.779492 19.318750 -18166 2 0.000000 -1.000000 2.500000 44.772000 37.779492 19.318750 +18166 2 0.000000 -1 2.500000 44.772000 37.779492 19.318750 18167 2 0.000000 1 2.500000 47.068000 33.802704 19.318750 18168 2 0.000000 -1 2.500000 47.068000 33.802704 19.318750 18169 2 0.000000 1 2.500000 49.364000 35.128300 22.831250 @@ -18187,7 +18187,7 @@ Atoms 18171 2 0.000000 1 2.500000 51.660000 39.105088 22.831250 18172 2 0.000000 -1 2.500000 51.660000 39.105088 22.831250 18173 2 0.000000 1 2.500000 44.772000 37.779492 26.343750 -18174 2 0.000000 -1.000000 2.500000 44.772000 37.779492 26.343750 +18174 2 0.000000 -1 2.500000 44.772000 37.779492 26.343750 18175 2 0.000000 1 2.500000 47.068000 33.802704 26.343750 18176 2 0.000000 -1 2.500000 47.068000 33.802704 26.343750 18177 2 0.000000 1 2.500000 49.364000 35.128300 29.856250 @@ -18195,7 +18195,7 @@ Atoms 18179 2 0.000000 1 2.500000 51.660000 39.105088 29.856250 18180 2 0.000000 -1 2.500000 51.660000 39.105088 29.856250 18181 2 0.000000 1 2.500000 44.772000 37.779492 33.368750 -18182 2 0.000000 -1.000000 2.500000 44.772000 37.779492 33.368750 +18182 2 0.000000 -1 2.500000 44.772000 37.779492 33.368750 18183 2 0.000000 1 2.500000 47.068000 33.802704 33.368750 18184 2 0.000000 -1 2.500000 47.068000 33.802704 33.368750 18185 2 0.000000 1 2.500000 49.364000 35.128300 36.881250 @@ -18203,7 +18203,7 @@ Atoms 18187 2 0.000000 1 2.500000 51.660000 39.105088 36.881250 18188 2 0.000000 -1 2.500000 51.660000 39.105088 36.881250 18189 2 0.000000 1 2.500000 44.772000 37.779492 40.393750 -18190 2 0.000000 -1.000000 2.500000 44.772000 37.779492 40.393750 +18190 2 0.000000 -1 2.500000 44.772000 37.779492 40.393750 18191 2 0.000000 1 2.500000 47.068000 33.802704 40.393750 18192 2 0.000000 -1 2.500000 47.068000 33.802704 40.393750 18193 2 0.000000 1 2.500000 49.364000 35.128300 43.906250 @@ -18211,7 +18211,7 @@ Atoms 18195 2 0.000000 1 2.500000 51.660000 39.105088 43.906250 18196 2 0.000000 -1 2.500000 51.660000 39.105088 43.906250 18197 2 0.000000 1 2.500000 44.772000 37.779492 47.418750 -18198 2 0.000000 -1.000000 2.500000 44.772000 37.779492 47.418750 +18198 2 0.000000 -1 2.500000 44.772000 37.779492 47.418750 18199 2 0.000000 1 2.500000 47.068000 33.802704 47.418750 18200 2 0.000000 -1 2.500000 47.068000 33.802704 47.418750 18201 2 0.000000 1 2.500000 49.364000 35.128300 50.931250 @@ -18219,7 +18219,7 @@ Atoms 18203 2 0.000000 1 2.500000 51.660000 39.105088 50.931250 18204 2 0.000000 -1 2.500000 51.660000 39.105088 50.931250 18205 2 0.000000 1 2.500000 44.772000 37.779492 54.443750 -18206 2 0.000000 -1.000000 2.500000 44.772000 37.779492 54.443750 +18206 2 0.000000 -1 2.500000 44.772000 37.779492 54.443750 18207 2 0.000000 1 2.500000 47.068000 33.802704 54.443750 18208 2 0.000000 -1 2.500000 47.068000 33.802704 54.443750 18209 2 0.000000 1 2.500000 49.364000 35.128300 57.956250 @@ -18227,7 +18227,7 @@ Atoms 18211 2 0.000000 1 2.500000 51.660000 39.105088 57.956250 18212 2 0.000000 -1 2.500000 51.660000 39.105088 57.956250 18213 2 0.000000 1 2.500000 44.772000 37.779492 61.468750 -18214 2 0.000000 -1.000000 2.500000 44.772000 37.779492 61.468750 +18214 2 0.000000 -1 2.500000 44.772000 37.779492 61.468750 18215 2 0.000000 1 2.500000 47.068000 33.802704 61.468750 18216 2 0.000000 -1 2.500000 47.068000 33.802704 61.468750 18217 2 0.000000 1 2.500000 49.364000 43.081877 1.756250 @@ -18235,7 +18235,7 @@ Atoms 18219 2 0.000000 1 2.500000 51.660000 47.058666 1.756250 18220 2 0.000000 -1 2.500000 51.660000 47.058666 1.756250 18221 2 0.000000 1 2.500000 44.772000 45.733070 5.268750 -18222 2 0.000000 -1.000000 2.500000 44.772000 45.733070 5.268750 +18222 2 0.000000 -1 2.500000 44.772000 45.733070 5.268750 18223 2 0.000000 1 2.500000 47.068000 41.756281 5.268750 18224 2 0.000000 -1 2.500000 47.068000 41.756281 5.268750 18225 2 0.000000 1 2.500000 49.364000 43.081877 8.781250 @@ -18243,7 +18243,7 @@ Atoms 18227 2 0.000000 1 2.500000 51.660000 47.058666 8.781250 18228 2 0.000000 -1 2.500000 51.660000 47.058666 8.781250 18229 2 0.000000 1 2.500000 44.772000 45.733070 12.293750 -18230 2 0.000000 -1.000000 2.500000 44.772000 45.733070 12.293750 +18230 2 0.000000 -1 2.500000 44.772000 45.733070 12.293750 18231 2 0.000000 1 2.500000 47.068000 41.756281 12.293750 18232 2 0.000000 -1 2.500000 47.068000 41.756281 12.293750 18233 2 0.000000 1 2.500000 49.364000 43.081877 15.806250 @@ -18251,7 +18251,7 @@ Atoms 18235 2 0.000000 1 2.500000 51.660000 47.058666 15.806250 18236 2 0.000000 -1 2.500000 51.660000 47.058666 15.806250 18237 2 0.000000 1 2.500000 44.772000 45.733070 19.318750 -18238 2 0.000000 -1.000000 2.500000 44.772000 45.733070 19.318750 +18238 2 0.000000 -1 2.500000 44.772000 45.733070 19.318750 18239 2 0.000000 1 2.500000 47.068000 41.756281 19.318750 18240 2 0.000000 -1 2.500000 47.068000 41.756281 19.318750 18241 2 0.000000 1 2.500000 49.364000 43.081877 22.831250 @@ -18259,7 +18259,7 @@ Atoms 18243 2 0.000000 1 2.500000 51.660000 47.058666 22.831250 18244 2 0.000000 -1 2.500000 51.660000 47.058666 22.831250 18245 2 0.000000 1 2.500000 44.772000 45.733070 26.343750 -18246 2 0.000000 -1.000000 2.500000 44.772000 45.733070 26.343750 +18246 2 0.000000 -1 2.500000 44.772000 45.733070 26.343750 18247 2 0.000000 1 2.500000 47.068000 41.756281 26.343750 18248 2 0.000000 -1 2.500000 47.068000 41.756281 26.343750 18249 2 0.000000 1 2.500000 49.364000 43.081877 29.856250 @@ -18267,7 +18267,7 @@ Atoms 18251 2 0.000000 1 2.500000 51.660000 47.058666 29.856250 18252 2 0.000000 -1 2.500000 51.660000 47.058666 29.856250 18253 2 0.000000 1 2.500000 44.772000 45.733070 33.368750 -18254 2 0.000000 -1.000000 2.500000 44.772000 45.733070 33.368750 +18254 2 0.000000 -1 2.500000 44.772000 45.733070 33.368750 18255 2 0.000000 1 2.500000 47.068000 41.756281 33.368750 18256 2 0.000000 -1 2.500000 47.068000 41.756281 33.368750 18257 2 0.000000 1 2.500000 49.364000 43.081877 36.881250 @@ -18275,7 +18275,7 @@ Atoms 18259 2 0.000000 1 2.500000 51.660000 47.058666 36.881250 18260 2 0.000000 -1 2.500000 51.660000 47.058666 36.881250 18261 2 0.000000 1 2.500000 44.772000 45.733070 40.393750 -18262 2 0.000000 -1.000000 2.500000 44.772000 45.733070 40.393750 +18262 2 0.000000 -1 2.500000 44.772000 45.733070 40.393750 18263 2 0.000000 1 2.500000 47.068000 41.756281 40.393750 18264 2 0.000000 -1 2.500000 47.068000 41.756281 40.393750 18265 2 0.000000 1 2.500000 49.364000 43.081877 43.906250 @@ -18283,7 +18283,7 @@ Atoms 18267 2 0.000000 1 2.500000 51.660000 47.058666 43.906250 18268 2 0.000000 -1 2.500000 51.660000 47.058666 43.906250 18269 2 0.000000 1 2.500000 44.772000 45.733070 47.418750 -18270 2 0.000000 -1.000000 2.500000 44.772000 45.733070 47.418750 +18270 2 0.000000 -1 2.500000 44.772000 45.733070 47.418750 18271 2 0.000000 1 2.500000 47.068000 41.756281 47.418750 18272 2 0.000000 -1 2.500000 47.068000 41.756281 47.418750 18273 2 0.000000 1 2.500000 49.364000 43.081877 50.931250 @@ -18291,7 +18291,7 @@ Atoms 18275 2 0.000000 1 2.500000 51.660000 47.058666 50.931250 18276 2 0.000000 -1 2.500000 51.660000 47.058666 50.931250 18277 2 0.000000 1 2.500000 44.772000 45.733070 54.443750 -18278 2 0.000000 -1.000000 2.500000 44.772000 45.733070 54.443750 +18278 2 0.000000 -1 2.500000 44.772000 45.733070 54.443750 18279 2 0.000000 1 2.500000 47.068000 41.756281 54.443750 18280 2 0.000000 -1 2.500000 47.068000 41.756281 54.443750 18281 2 0.000000 1 2.500000 49.364000 43.081877 57.956250 @@ -18299,7 +18299,7 @@ Atoms 18283 2 0.000000 1 2.500000 51.660000 47.058666 57.956250 18284 2 0.000000 -1 2.500000 51.660000 47.058666 57.956250 18285 2 0.000000 1 2.500000 44.772000 45.733070 61.468750 -18286 2 0.000000 -1.000000 2.500000 44.772000 45.733070 61.468750 +18286 2 0.000000 -1 2.500000 44.772000 45.733070 61.468750 18287 2 0.000000 1 2.500000 47.068000 41.756281 61.468750 18288 2 0.000000 -1 2.500000 47.068000 41.756281 61.468750 18289 2 0.000000 1 2.500000 49.364000 51.035454 1.756250 @@ -18307,7 +18307,7 @@ Atoms 18291 2 0.000000 1 2.500000 51.660000 55.012243 1.756250 18292 2 0.000000 -1 2.500000 51.660000 55.012243 1.756250 18293 2 0.000000 1 2.500000 44.772000 53.686647 5.268750 -18294 2 0.000000 -1.000000 2.500000 44.772000 53.686647 5.268750 +18294 2 0.000000 -1 2.500000 44.772000 53.686647 5.268750 18295 2 0.000000 1 2.500000 47.068000 49.709858 5.268750 18296 2 0.000000 -1 2.500000 47.068000 49.709858 5.268750 18297 2 0.000000 1 2.500000 49.364000 51.035454 8.781250 @@ -18315,7 +18315,7 @@ Atoms 18299 2 0.000000 1 2.500000 51.660000 55.012243 8.781250 18300 2 0.000000 -1 2.500000 51.660000 55.012243 8.781250 18301 2 0.000000 1 2.500000 44.772000 53.686647 12.293750 -18302 2 0.000000 -1.000000 2.500000 44.772000 53.686647 12.293750 +18302 2 0.000000 -1 2.500000 44.772000 53.686647 12.293750 18303 2 0.000000 1 2.500000 47.068000 49.709858 12.293750 18304 2 0.000000 -1 2.500000 47.068000 49.709858 12.293750 18305 2 0.000000 1 2.500000 49.364000 51.035454 15.806250 @@ -18323,7 +18323,7 @@ Atoms 18307 2 0.000000 1 2.500000 51.660000 55.012243 15.806250 18308 2 0.000000 -1 2.500000 51.660000 55.012243 15.806250 18309 2 0.000000 1 2.500000 44.772000 53.686647 19.318750 -18310 2 0.000000 -1.000000 2.500000 44.772000 53.686647 19.318750 +18310 2 0.000000 -1 2.500000 44.772000 53.686647 19.318750 18311 2 0.000000 1 2.500000 47.068000 49.709858 19.318750 18312 2 0.000000 -1 2.500000 47.068000 49.709858 19.318750 18313 2 0.000000 1 2.500000 49.364000 51.035454 22.831250 @@ -18331,7 +18331,7 @@ Atoms 18315 2 0.000000 1 2.500000 51.660000 55.012243 22.831250 18316 2 0.000000 -1 2.500000 51.660000 55.012243 22.831250 18317 2 0.000000 1 2.500000 44.772000 53.686647 26.343750 -18318 2 0.000000 -1.000000 2.500000 44.772000 53.686647 26.343750 +18318 2 0.000000 -1 2.500000 44.772000 53.686647 26.343750 18319 2 0.000000 1 2.500000 47.068000 49.709858 26.343750 18320 2 0.000000 -1 2.500000 47.068000 49.709858 26.343750 18321 2 0.000000 1 2.500000 49.364000 51.035454 29.856250 @@ -18339,7 +18339,7 @@ Atoms 18323 2 0.000000 1 2.500000 51.660000 55.012243 29.856250 18324 2 0.000000 -1 2.500000 51.660000 55.012243 29.856250 18325 2 0.000000 1 2.500000 44.772000 53.686647 33.368750 -18326 2 0.000000 -1.000000 2.500000 44.772000 53.686647 33.368750 +18326 2 0.000000 -1 2.500000 44.772000 53.686647 33.368750 18327 2 0.000000 1 2.500000 47.068000 49.709858 33.368750 18328 2 0.000000 -1 2.500000 47.068000 49.709858 33.368750 18329 2 0.000000 1 2.500000 49.364000 51.035454 36.881250 @@ -18347,7 +18347,7 @@ Atoms 18331 2 0.000000 1 2.500000 51.660000 55.012243 36.881250 18332 2 0.000000 -1 2.500000 51.660000 55.012243 36.881250 18333 2 0.000000 1 2.500000 44.772000 53.686647 40.393750 -18334 2 0.000000 -1.000000 2.500000 44.772000 53.686647 40.393750 +18334 2 0.000000 -1 2.500000 44.772000 53.686647 40.393750 18335 2 0.000000 1 2.500000 47.068000 49.709858 40.393750 18336 2 0.000000 -1 2.500000 47.068000 49.709858 40.393750 18337 2 0.000000 1 2.500000 49.364000 51.035454 43.906250 @@ -18355,7 +18355,7 @@ Atoms 18339 2 0.000000 1 2.500000 51.660000 55.012243 43.906250 18340 2 0.000000 -1 2.500000 51.660000 55.012243 43.906250 18341 2 0.000000 1 2.500000 44.772000 53.686647 47.418750 -18342 2 0.000000 -1.000000 2.500000 44.772000 53.686647 47.418750 +18342 2 0.000000 -1 2.500000 44.772000 53.686647 47.418750 18343 2 0.000000 1 2.500000 47.068000 49.709858 47.418750 18344 2 0.000000 -1 2.500000 47.068000 49.709858 47.418750 18345 2 0.000000 1 2.500000 49.364000 51.035454 50.931250 @@ -18363,7 +18363,7 @@ Atoms 18347 2 0.000000 1 2.500000 51.660000 55.012243 50.931250 18348 2 0.000000 -1 2.500000 51.660000 55.012243 50.931250 18349 2 0.000000 1 2.500000 44.772000 53.686647 54.443750 -18350 2 0.000000 -1.000000 2.500000 44.772000 53.686647 54.443750 +18350 2 0.000000 -1 2.500000 44.772000 53.686647 54.443750 18351 2 0.000000 1 2.500000 47.068000 49.709858 54.443750 18352 2 0.000000 -1 2.500000 47.068000 49.709858 54.443750 18353 2 0.000000 1 2.500000 49.364000 51.035454 57.956250 @@ -18371,7 +18371,7 @@ Atoms 18355 2 0.000000 1 2.500000 51.660000 55.012243 57.956250 18356 2 0.000000 -1 2.500000 51.660000 55.012243 57.956250 18357 2 0.000000 1 2.500000 44.772000 53.686647 61.468750 -18358 2 0.000000 -1.000000 2.500000 44.772000 53.686647 61.468750 +18358 2 0.000000 -1 2.500000 44.772000 53.686647 61.468750 18359 2 0.000000 1 2.500000 47.068000 49.709858 61.468750 18360 2 0.000000 -1 2.500000 47.068000 49.709858 61.468750 18361 2 0.000000 1 2.500000 49.364000 58.989032 1.756250 @@ -18379,7 +18379,7 @@ Atoms 18363 2 0.000000 1 2.500000 51.660000 62.965820 1.756250 18364 2 0.000000 -1 2.500000 51.660000 62.965820 1.756250 18365 2 0.000000 1 2.500000 44.772000 61.640224 5.268750 -18366 2 0.000000 -1.000000 2.500000 44.772000 61.640224 5.268750 +18366 2 0.000000 -1 2.500000 44.772000 61.640224 5.268750 18367 2 0.000000 1 2.500000 47.068000 57.663435 5.268750 18368 2 0.000000 -1 2.500000 47.068000 57.663435 5.268750 18369 2 0.000000 1 2.500000 49.364000 58.989032 8.781250 @@ -18387,7 +18387,7 @@ Atoms 18371 2 0.000000 1 2.500000 51.660000 62.965820 8.781250 18372 2 0.000000 -1 2.500000 51.660000 62.965820 8.781250 18373 2 0.000000 1 2.500000 44.772000 61.640224 12.293750 -18374 2 0.000000 -1.000000 2.500000 44.772000 61.640224 12.293750 +18374 2 0.000000 -1 2.500000 44.772000 61.640224 12.293750 18375 2 0.000000 1 2.500000 47.068000 57.663435 12.293750 18376 2 0.000000 -1 2.500000 47.068000 57.663435 12.293750 18377 2 0.000000 1 2.500000 49.364000 58.989032 15.806250 @@ -18395,7 +18395,7 @@ Atoms 18379 2 0.000000 1 2.500000 51.660000 62.965820 15.806250 18380 2 0.000000 -1 2.500000 51.660000 62.965820 15.806250 18381 2 0.000000 1 2.500000 44.772000 61.640224 19.318750 -18382 2 0.000000 -1.000000 2.500000 44.772000 61.640224 19.318750 +18382 2 0.000000 -1 2.500000 44.772000 61.640224 19.318750 18383 2 0.000000 1 2.500000 47.068000 57.663435 19.318750 18384 2 0.000000 -1 2.500000 47.068000 57.663435 19.318750 18385 2 0.000000 1 2.500000 49.364000 58.989032 22.831250 @@ -18403,7 +18403,7 @@ Atoms 18387 2 0.000000 1 2.500000 51.660000 62.965820 22.831250 18388 2 0.000000 -1 2.500000 51.660000 62.965820 22.831250 18389 2 0.000000 1 2.500000 44.772000 61.640224 26.343750 -18390 2 0.000000 -1.000000 2.500000 44.772000 61.640224 26.343750 +18390 2 0.000000 -1 2.500000 44.772000 61.640224 26.343750 18391 2 0.000000 1 2.500000 47.068000 57.663435 26.343750 18392 2 0.000000 -1 2.500000 47.068000 57.663435 26.343750 18393 2 0.000000 1 2.500000 49.364000 58.989032 29.856250 @@ -18411,7 +18411,7 @@ Atoms 18395 2 0.000000 1 2.500000 51.660000 62.965820 29.856250 18396 2 0.000000 -1 2.500000 51.660000 62.965820 29.856250 18397 2 0.000000 1 2.500000 44.772000 61.640224 33.368750 -18398 2 0.000000 -1.000000 2.500000 44.772000 61.640224 33.368750 +18398 2 0.000000 -1 2.500000 44.772000 61.640224 33.368750 18399 2 0.000000 1 2.500000 47.068000 57.663435 33.368750 18400 2 0.000000 -1 2.500000 47.068000 57.663435 33.368750 18401 2 0.000000 1 2.500000 49.364000 58.989032 36.881250 @@ -18419,7 +18419,7 @@ Atoms 18403 2 0.000000 1 2.500000 51.660000 62.965820 36.881250 18404 2 0.000000 -1 2.500000 51.660000 62.965820 36.881250 18405 2 0.000000 1 2.500000 44.772000 61.640224 40.393750 -18406 2 0.000000 -1.000000 2.500000 44.772000 61.640224 40.393750 +18406 2 0.000000 -1 2.500000 44.772000 61.640224 40.393750 18407 2 0.000000 1 2.500000 47.068000 57.663435 40.393750 18408 2 0.000000 -1 2.500000 47.068000 57.663435 40.393750 18409 2 0.000000 1 2.500000 49.364000 58.989032 43.906250 @@ -18427,7 +18427,7 @@ Atoms 18411 2 0.000000 1 2.500000 51.660000 62.965820 43.906250 18412 2 0.000000 -1 2.500000 51.660000 62.965820 43.906250 18413 2 0.000000 1 2.500000 44.772000 61.640224 47.418750 -18414 2 0.000000 -1.000000 2.500000 44.772000 61.640224 47.418750 +18414 2 0.000000 -1 2.500000 44.772000 61.640224 47.418750 18415 2 0.000000 1 2.500000 47.068000 57.663435 47.418750 18416 2 0.000000 -1 2.500000 47.068000 57.663435 47.418750 18417 2 0.000000 1 2.500000 49.364000 58.989032 50.931250 @@ -18435,7 +18435,7 @@ Atoms 18419 2 0.000000 1 2.500000 51.660000 62.965820 50.931250 18420 2 0.000000 -1 2.500000 51.660000 62.965820 50.931250 18421 2 0.000000 1 2.500000 44.772000 61.640224 54.443750 -18422 2 0.000000 -1.000000 2.500000 44.772000 61.640224 54.443750 +18422 2 0.000000 -1 2.500000 44.772000 61.640224 54.443750 18423 2 0.000000 1 2.500000 47.068000 57.663435 54.443750 18424 2 0.000000 -1 2.500000 47.068000 57.663435 54.443750 18425 2 0.000000 1 2.500000 49.364000 58.989032 57.956250 @@ -18443,7 +18443,7 @@ Atoms 18427 2 0.000000 1 2.500000 51.660000 62.965820 57.956250 18428 2 0.000000 -1 2.500000 51.660000 62.965820 57.956250 18429 2 0.000000 1 2.500000 44.772000 61.640224 61.468750 -18430 2 0.000000 -1.000000 2.500000 44.772000 61.640224 61.468750 +18430 2 0.000000 -1 2.500000 44.772000 61.640224 61.468750 18431 2 0.000000 1 2.500000 47.068000 57.663435 61.468750 18432 2 0.000000 -1 2.500000 47.068000 57.663435 61.468750 18433 2 0.000000 1 2.500000 53.956000 3.313991 1.756250 @@ -18451,7 +18451,7 @@ Atoms 18435 2 0.000000 1 2.500000 56.252000 7.290779 1.756250 18436 2 0.000000 -1 2.500000 56.252000 7.290779 1.756250 18437 2 0.000000 1 2.500000 49.364000 5.965183 5.268750 -18438 2 0.000000 -1.000000 2.500000 49.364000 5.965183 5.268750 +18438 2 0.000000 -1 2.500000 49.364000 5.965183 5.268750 18439 2 0.000000 1 2.500000 51.660000 1.988394 5.268750 18440 2 0.000000 -1 2.500000 51.660000 1.988394 5.268750 18441 2 0.000000 1 2.500000 53.956000 3.313991 8.781250 @@ -18459,7 +18459,7 @@ Atoms 18443 2 0.000000 1 2.500000 56.252000 7.290779 8.781250 18444 2 0.000000 -1 2.500000 56.252000 7.290779 8.781250 18445 2 0.000000 1 2.500000 49.364000 5.965183 12.293750 -18446 2 0.000000 -1.000000 2.500000 49.364000 5.965183 12.293750 +18446 2 0.000000 -1 2.500000 49.364000 5.965183 12.293750 18447 2 0.000000 1 2.500000 51.660000 1.988394 12.293750 18448 2 0.000000 -1 2.500000 51.660000 1.988394 12.293750 18449 2 0.000000 1 2.500000 53.956000 3.313991 15.806250 @@ -18467,7 +18467,7 @@ Atoms 18451 2 0.000000 1 2.500000 56.252000 7.290779 15.806250 18452 2 0.000000 -1 2.500000 56.252000 7.290779 15.806250 18453 2 0.000000 1 2.500000 49.364000 5.965183 19.318750 -18454 2 0.000000 -1.000000 2.500000 49.364000 5.965183 19.318750 +18454 2 0.000000 -1 2.500000 49.364000 5.965183 19.318750 18455 2 0.000000 1 2.500000 51.660000 1.988394 19.318750 18456 2 0.000000 -1 2.500000 51.660000 1.988394 19.318750 18457 2 0.000000 1 2.500000 53.956000 3.313991 22.831250 @@ -18475,7 +18475,7 @@ Atoms 18459 2 0.000000 1 2.500000 56.252000 7.290779 22.831250 18460 2 0.000000 -1 2.500000 56.252000 7.290779 22.831250 18461 2 0.000000 1 2.500000 49.364000 5.965183 26.343750 -18462 2 0.000000 -1.000000 2.500000 49.364000 5.965183 26.343750 +18462 2 0.000000 -1 2.500000 49.364000 5.965183 26.343750 18463 2 0.000000 1 2.500000 51.660000 1.988394 26.343750 18464 2 0.000000 -1 2.500000 51.660000 1.988394 26.343750 18465 2 0.000000 1 2.500000 53.956000 3.313991 29.856250 @@ -18483,7 +18483,7 @@ Atoms 18467 2 0.000000 1 2.500000 56.252000 7.290779 29.856250 18468 2 0.000000 -1 2.500000 56.252000 7.290779 29.856250 18469 2 0.000000 1 2.500000 49.364000 5.965183 33.368750 -18470 2 0.000000 -1.000000 2.500000 49.364000 5.965183 33.368750 +18470 2 0.000000 -1 2.500000 49.364000 5.965183 33.368750 18471 2 0.000000 1 2.500000 51.660000 1.988394 33.368750 18472 2 0.000000 -1 2.500000 51.660000 1.988394 33.368750 18473 2 0.000000 1 2.500000 53.956000 3.313991 36.881250 @@ -18491,7 +18491,7 @@ Atoms 18475 2 0.000000 1 2.500000 56.252000 7.290779 36.881250 18476 2 0.000000 -1 2.500000 56.252000 7.290779 36.881250 18477 2 0.000000 1 2.500000 49.364000 5.965183 40.393750 -18478 2 0.000000 -1.000000 2.500000 49.364000 5.965183 40.393750 +18478 2 0.000000 -1 2.500000 49.364000 5.965183 40.393750 18479 2 0.000000 1 2.500000 51.660000 1.988394 40.393750 18480 2 0.000000 -1 2.500000 51.660000 1.988394 40.393750 18481 2 0.000000 1 2.500000 53.956000 3.313991 43.906250 @@ -18499,7 +18499,7 @@ Atoms 18483 2 0.000000 1 2.500000 56.252000 7.290779 43.906250 18484 2 0.000000 -1 2.500000 56.252000 7.290779 43.906250 18485 2 0.000000 1 2.500000 49.364000 5.965183 47.418750 -18486 2 0.000000 -1.000000 2.500000 49.364000 5.965183 47.418750 +18486 2 0.000000 -1 2.500000 49.364000 5.965183 47.418750 18487 2 0.000000 1 2.500000 51.660000 1.988394 47.418750 18488 2 0.000000 -1 2.500000 51.660000 1.988394 47.418750 18489 2 0.000000 1 2.500000 53.956000 3.313991 50.931250 @@ -18507,7 +18507,7 @@ Atoms 18491 2 0.000000 1 2.500000 56.252000 7.290779 50.931250 18492 2 0.000000 -1 2.500000 56.252000 7.290779 50.931250 18493 2 0.000000 1 2.500000 49.364000 5.965183 54.443750 -18494 2 0.000000 -1.000000 2.500000 49.364000 5.965183 54.443750 +18494 2 0.000000 -1 2.500000 49.364000 5.965183 54.443750 18495 2 0.000000 1 2.500000 51.660000 1.988394 54.443750 18496 2 0.000000 -1 2.500000 51.660000 1.988394 54.443750 18497 2 0.000000 1 2.500000 53.956000 3.313991 57.956250 @@ -18515,7 +18515,7 @@ Atoms 18499 2 0.000000 1 2.500000 56.252000 7.290779 57.956250 18500 2 0.000000 -1 2.500000 56.252000 7.290779 57.956250 18501 2 0.000000 1 2.500000 49.364000 5.965183 61.468750 -18502 2 0.000000 -1.000000 2.500000 49.364000 5.965183 61.468750 +18502 2 0.000000 -1 2.500000 49.364000 5.965183 61.468750 18503 2 0.000000 1 2.500000 51.660000 1.988394 61.468750 18504 2 0.000000 -1 2.500000 51.660000 1.988394 61.468750 18505 2 0.000000 1 2.500000 53.956000 11.267568 1.756250 @@ -18523,7 +18523,7 @@ Atoms 18507 2 0.000000 1 2.500000 56.252000 15.244357 1.756250 18508 2 0.000000 -1 2.500000 56.252000 15.244357 1.756250 18509 2 0.000000 1 2.500000 49.364000 13.918760 5.268750 -18510 2 0.000000 -1.000000 2.500000 49.364000 13.918760 5.268750 +18510 2 0.000000 -1 2.500000 49.364000 13.918760 5.268750 18511 2 0.000000 1 2.500000 51.660000 9.941972 5.268750 18512 2 0.000000 -1 2.500000 51.660000 9.941972 5.268750 18513 2 0.000000 1 2.500000 53.956000 11.267568 8.781250 @@ -18531,7 +18531,7 @@ Atoms 18515 2 0.000000 1 2.500000 56.252000 15.244357 8.781250 18516 2 0.000000 -1 2.500000 56.252000 15.244357 8.781250 18517 2 0.000000 1 2.500000 49.364000 13.918760 12.293750 -18518 2 0.000000 -1.000000 2.500000 49.364000 13.918760 12.293750 +18518 2 0.000000 -1 2.500000 49.364000 13.918760 12.293750 18519 2 0.000000 1 2.500000 51.660000 9.941972 12.293750 18520 2 0.000000 -1 2.500000 51.660000 9.941972 12.293750 18521 2 0.000000 1 2.500000 53.956000 11.267568 15.806250 @@ -18539,7 +18539,7 @@ Atoms 18523 2 0.000000 1 2.500000 56.252000 15.244357 15.806250 18524 2 0.000000 -1 2.500000 56.252000 15.244357 15.806250 18525 2 0.000000 1 2.500000 49.364000 13.918760 19.318750 -18526 2 0.000000 -1.000000 2.500000 49.364000 13.918760 19.318750 +18526 2 0.000000 -1 2.500000 49.364000 13.918760 19.318750 18527 2 0.000000 1 2.500000 51.660000 9.941972 19.318750 18528 2 0.000000 -1 2.500000 51.660000 9.941972 19.318750 18529 2 0.000000 1 2.500000 53.956000 11.267568 22.831250 @@ -18547,7 +18547,7 @@ Atoms 18531 2 0.000000 1 2.500000 56.252000 15.244357 22.831250 18532 2 0.000000 -1 2.500000 56.252000 15.244357 22.831250 18533 2 0.000000 1 2.500000 49.364000 13.918760 26.343750 -18534 2 0.000000 -1.000000 2.500000 49.364000 13.918760 26.343750 +18534 2 0.000000 -1 2.500000 49.364000 13.918760 26.343750 18535 2 0.000000 1 2.500000 51.660000 9.941972 26.343750 18536 2 0.000000 -1 2.500000 51.660000 9.941972 26.343750 18537 2 0.000000 1 2.500000 53.956000 11.267568 29.856250 @@ -18555,7 +18555,7 @@ Atoms 18539 2 0.000000 1 2.500000 56.252000 15.244357 29.856250 18540 2 0.000000 -1 2.500000 56.252000 15.244357 29.856250 18541 2 0.000000 1 2.500000 49.364000 13.918760 33.368750 -18542 2 0.000000 -1.000000 2.500000 49.364000 13.918760 33.368750 +18542 2 0.000000 -1 2.500000 49.364000 13.918760 33.368750 18543 2 0.000000 1 2.500000 51.660000 9.941972 33.368750 18544 2 0.000000 -1 2.500000 51.660000 9.941972 33.368750 18545 2 0.000000 1 2.500000 53.956000 11.267568 36.881250 @@ -18563,7 +18563,7 @@ Atoms 18547 2 0.000000 1 2.500000 56.252000 15.244357 36.881250 18548 2 0.000000 -1 2.500000 56.252000 15.244357 36.881250 18549 2 0.000000 1 2.500000 49.364000 13.918760 40.393750 -18550 2 0.000000 -1.000000 2.500000 49.364000 13.918760 40.393750 +18550 2 0.000000 -1 2.500000 49.364000 13.918760 40.393750 18551 2 0.000000 1 2.500000 51.660000 9.941972 40.393750 18552 2 0.000000 -1 2.500000 51.660000 9.941972 40.393750 18553 2 0.000000 1 2.500000 53.956000 11.267568 43.906250 @@ -18571,7 +18571,7 @@ Atoms 18555 2 0.000000 1 2.500000 56.252000 15.244357 43.906250 18556 2 0.000000 -1 2.500000 56.252000 15.244357 43.906250 18557 2 0.000000 1 2.500000 49.364000 13.918760 47.418750 -18558 2 0.000000 -1.000000 2.500000 49.364000 13.918760 47.418750 +18558 2 0.000000 -1 2.500000 49.364000 13.918760 47.418750 18559 2 0.000000 1 2.500000 51.660000 9.941972 47.418750 18560 2 0.000000 -1 2.500000 51.660000 9.941972 47.418750 18561 2 0.000000 1 2.500000 53.956000 11.267568 50.931250 @@ -18579,7 +18579,7 @@ Atoms 18563 2 0.000000 1 2.500000 56.252000 15.244357 50.931250 18564 2 0.000000 -1 2.500000 56.252000 15.244357 50.931250 18565 2 0.000000 1 2.500000 49.364000 13.918760 54.443750 -18566 2 0.000000 -1.000000 2.500000 49.364000 13.918760 54.443750 +18566 2 0.000000 -1 2.500000 49.364000 13.918760 54.443750 18567 2 0.000000 1 2.500000 51.660000 9.941972 54.443750 18568 2 0.000000 -1 2.500000 51.660000 9.941972 54.443750 18569 2 0.000000 1 2.500000 53.956000 11.267568 57.956250 @@ -18587,7 +18587,7 @@ Atoms 18571 2 0.000000 1 2.500000 56.252000 15.244357 57.956250 18572 2 0.000000 -1 2.500000 56.252000 15.244357 57.956250 18573 2 0.000000 1 2.500000 49.364000 13.918760 61.468750 -18574 2 0.000000 -1.000000 2.500000 49.364000 13.918760 61.468750 +18574 2 0.000000 -1 2.500000 49.364000 13.918760 61.468750 18575 2 0.000000 1 2.500000 51.660000 9.941972 61.468750 18576 2 0.000000 -1 2.500000 51.660000 9.941972 61.468750 18577 2 0.000000 1 2.500000 53.956000 19.221145 1.756250 @@ -18595,7 +18595,7 @@ Atoms 18579 2 0.000000 1 2.500000 56.252000 23.197934 1.756250 18580 2 0.000000 -1 2.500000 56.252000 23.197934 1.756250 18581 2 0.000000 1 2.500000 49.364000 21.872338 5.268750 -18582 2 0.000000 -1.000000 2.500000 49.364000 21.872338 5.268750 +18582 2 0.000000 -1 2.500000 49.364000 21.872338 5.268750 18583 2 0.000000 1 2.500000 51.660000 17.895549 5.268750 18584 2 0.000000 -1 2.500000 51.660000 17.895549 5.268750 18585 2 0.000000 1 2.500000 53.956000 19.221145 8.781250 @@ -18603,7 +18603,7 @@ Atoms 18587 2 0.000000 1 2.500000 56.252000 23.197934 8.781250 18588 2 0.000000 -1 2.500000 56.252000 23.197934 8.781250 18589 2 0.000000 1 2.500000 49.364000 21.872338 12.293750 -18590 2 0.000000 -1.000000 2.500000 49.364000 21.872338 12.293750 +18590 2 0.000000 -1 2.500000 49.364000 21.872338 12.293750 18591 2 0.000000 1 2.500000 51.660000 17.895549 12.293750 18592 2 0.000000 -1 2.500000 51.660000 17.895549 12.293750 18593 2 0.000000 1 2.500000 53.956000 19.221145 15.806250 @@ -18611,7 +18611,7 @@ Atoms 18595 2 0.000000 1 2.500000 56.252000 23.197934 15.806250 18596 2 0.000000 -1 2.500000 56.252000 23.197934 15.806250 18597 2 0.000000 1 2.500000 49.364000 21.872338 19.318750 -18598 2 0.000000 -1.000000 2.500000 49.364000 21.872338 19.318750 +18598 2 0.000000 -1 2.500000 49.364000 21.872338 19.318750 18599 2 0.000000 1 2.500000 51.660000 17.895549 19.318750 18600 2 0.000000 -1 2.500000 51.660000 17.895549 19.318750 18601 2 0.000000 1 2.500000 53.956000 19.221145 22.831250 @@ -18619,7 +18619,7 @@ Atoms 18603 2 0.000000 1 2.500000 56.252000 23.197934 22.831250 18604 2 0.000000 -1 2.500000 56.252000 23.197934 22.831250 18605 2 0.000000 1 2.500000 49.364000 21.872338 26.343750 -18606 2 0.000000 -1.000000 2.500000 49.364000 21.872338 26.343750 +18606 2 0.000000 -1 2.500000 49.364000 21.872338 26.343750 18607 2 0.000000 1 2.500000 51.660000 17.895549 26.343750 18608 2 0.000000 -1 2.500000 51.660000 17.895549 26.343750 18609 2 0.000000 1 2.500000 53.956000 19.221145 29.856250 @@ -18627,7 +18627,7 @@ Atoms 18611 2 0.000000 1 2.500000 56.252000 23.197934 29.856250 18612 2 0.000000 -1 2.500000 56.252000 23.197934 29.856250 18613 2 0.000000 1 2.500000 49.364000 21.872338 33.368750 -18614 2 0.000000 -1.000000 2.500000 49.364000 21.872338 33.368750 +18614 2 0.000000 -1 2.500000 49.364000 21.872338 33.368750 18615 2 0.000000 1 2.500000 51.660000 17.895549 33.368750 18616 2 0.000000 -1 2.500000 51.660000 17.895549 33.368750 18617 2 0.000000 1 2.500000 53.956000 19.221145 36.881250 @@ -18635,7 +18635,7 @@ Atoms 18619 2 0.000000 1 2.500000 56.252000 23.197934 36.881250 18620 2 0.000000 -1 2.500000 56.252000 23.197934 36.881250 18621 2 0.000000 1 2.500000 49.364000 21.872338 40.393750 -18622 2 0.000000 -1.000000 2.500000 49.364000 21.872338 40.393750 +18622 2 0.000000 -1 2.500000 49.364000 21.872338 40.393750 18623 2 0.000000 1 2.500000 51.660000 17.895549 40.393750 18624 2 0.000000 -1 2.500000 51.660000 17.895549 40.393750 18625 2 0.000000 1 2.500000 53.956000 19.221145 43.906250 @@ -18643,7 +18643,7 @@ Atoms 18627 2 0.000000 1 2.500000 56.252000 23.197934 43.906250 18628 2 0.000000 -1 2.500000 56.252000 23.197934 43.906250 18629 2 0.000000 1 2.500000 49.364000 21.872338 47.418750 -18630 2 0.000000 -1.000000 2.500000 49.364000 21.872338 47.418750 +18630 2 0.000000 -1 2.500000 49.364000 21.872338 47.418750 18631 2 0.000000 1 2.500000 51.660000 17.895549 47.418750 18632 2 0.000000 -1 2.500000 51.660000 17.895549 47.418750 18633 2 0.000000 1 2.500000 53.956000 19.221145 50.931250 @@ -18651,7 +18651,7 @@ Atoms 18635 2 0.000000 1 2.500000 56.252000 23.197934 50.931250 18636 2 0.000000 -1 2.500000 56.252000 23.197934 50.931250 18637 2 0.000000 1 2.500000 49.364000 21.872338 54.443750 -18638 2 0.000000 -1.000000 2.500000 49.364000 21.872338 54.443750 +18638 2 0.000000 -1 2.500000 49.364000 21.872338 54.443750 18639 2 0.000000 1 2.500000 51.660000 17.895549 54.443750 18640 2 0.000000 -1 2.500000 51.660000 17.895549 54.443750 18641 2 0.000000 1 2.500000 53.956000 19.221145 57.956250 @@ -18659,7 +18659,7 @@ Atoms 18643 2 0.000000 1 2.500000 56.252000 23.197934 57.956250 18644 2 0.000000 -1 2.500000 56.252000 23.197934 57.956250 18645 2 0.000000 1 2.500000 49.364000 21.872338 61.468750 -18646 2 0.000000 -1.000000 2.500000 49.364000 21.872338 61.468750 +18646 2 0.000000 -1 2.500000 49.364000 21.872338 61.468750 18647 2 0.000000 1 2.500000 51.660000 17.895549 61.468750 18648 2 0.000000 -1 2.500000 51.660000 17.895549 61.468750 18649 2 0.000000 1 2.500000 53.956000 27.174722 1.756250 @@ -18667,7 +18667,7 @@ Atoms 18651 2 0.000000 1 2.500000 56.252000 31.151511 1.756250 18652 2 0.000000 -1 2.500000 56.252000 31.151511 1.756250 18653 2 0.000000 1 2.500000 49.364000 29.825915 5.268750 -18654 2 0.000000 -1.000000 2.500000 49.364000 29.825915 5.268750 +18654 2 0.000000 -1 2.500000 49.364000 29.825915 5.268750 18655 2 0.000000 1 2.500000 51.660000 25.849126 5.268750 18656 2 0.000000 -1 2.500000 51.660000 25.849126 5.268750 18657 2 0.000000 1 2.500000 53.956000 27.174722 8.781250 @@ -18675,7 +18675,7 @@ Atoms 18659 2 0.000000 1 2.500000 56.252000 31.151511 8.781250 18660 2 0.000000 -1 2.500000 56.252000 31.151511 8.781250 18661 2 0.000000 1 2.500000 49.364000 29.825915 12.293750 -18662 2 0.000000 -1.000000 2.500000 49.364000 29.825915 12.293750 +18662 2 0.000000 -1 2.500000 49.364000 29.825915 12.293750 18663 2 0.000000 1 2.500000 51.660000 25.849126 12.293750 18664 2 0.000000 -1 2.500000 51.660000 25.849126 12.293750 18665 2 0.000000 1 2.500000 53.956000 27.174722 15.806250 @@ -18683,7 +18683,7 @@ Atoms 18667 2 0.000000 1 2.500000 56.252000 31.151511 15.806250 18668 2 0.000000 -1 2.500000 56.252000 31.151511 15.806250 18669 2 0.000000 1 2.500000 49.364000 29.825915 19.318750 -18670 2 0.000000 -1.000000 2.500000 49.364000 29.825915 19.318750 +18670 2 0.000000 -1 2.500000 49.364000 29.825915 19.318750 18671 2 0.000000 1 2.500000 51.660000 25.849126 19.318750 18672 2 0.000000 -1 2.500000 51.660000 25.849126 19.318750 18673 2 0.000000 1 2.500000 53.956000 27.174722 22.831250 @@ -18691,7 +18691,7 @@ Atoms 18675 2 0.000000 1 2.500000 56.252000 31.151511 22.831250 18676 2 0.000000 -1 2.500000 56.252000 31.151511 22.831250 18677 2 0.000000 1 2.500000 49.364000 29.825915 26.343750 -18678 2 0.000000 -1.000000 2.500000 49.364000 29.825915 26.343750 +18678 2 0.000000 -1 2.500000 49.364000 29.825915 26.343750 18679 2 0.000000 1 2.500000 51.660000 25.849126 26.343750 18680 2 0.000000 -1 2.500000 51.660000 25.849126 26.343750 18681 2 0.000000 1 2.500000 53.956000 27.174722 29.856250 @@ -18699,7 +18699,7 @@ Atoms 18683 2 0.000000 1 2.500000 56.252000 31.151511 29.856250 18684 2 0.000000 -1 2.500000 56.252000 31.151511 29.856250 18685 2 0.000000 1 2.500000 49.364000 29.825915 33.368750 -18686 2 0.000000 -1.000000 2.500000 49.364000 29.825915 33.368750 +18686 2 0.000000 -1 2.500000 49.364000 29.825915 33.368750 18687 2 0.000000 1 2.500000 51.660000 25.849126 33.368750 18688 2 0.000000 -1 2.500000 51.660000 25.849126 33.368750 18689 2 0.000000 1 2.500000 53.956000 27.174722 36.881250 @@ -18707,7 +18707,7 @@ Atoms 18691 2 0.000000 1 2.500000 56.252000 31.151511 36.881250 18692 2 0.000000 -1 2.500000 56.252000 31.151511 36.881250 18693 2 0.000000 1 2.500000 49.364000 29.825915 40.393750 -18694 2 0.000000 -1.000000 2.500000 49.364000 29.825915 40.393750 +18694 2 0.000000 -1 2.500000 49.364000 29.825915 40.393750 18695 2 0.000000 1 2.500000 51.660000 25.849126 40.393750 18696 2 0.000000 -1 2.500000 51.660000 25.849126 40.393750 18697 2 0.000000 1 2.500000 53.956000 27.174722 43.906250 @@ -18715,7 +18715,7 @@ Atoms 18699 2 0.000000 1 2.500000 56.252000 31.151511 43.906250 18700 2 0.000000 -1 2.500000 56.252000 31.151511 43.906250 18701 2 0.000000 1 2.500000 49.364000 29.825915 47.418750 -18702 2 0.000000 -1.000000 2.500000 49.364000 29.825915 47.418750 +18702 2 0.000000 -1 2.500000 49.364000 29.825915 47.418750 18703 2 0.000000 1 2.500000 51.660000 25.849126 47.418750 18704 2 0.000000 -1 2.500000 51.660000 25.849126 47.418750 18705 2 0.000000 1 2.500000 53.956000 27.174722 50.931250 @@ -18723,7 +18723,7 @@ Atoms 18707 2 0.000000 1 2.500000 56.252000 31.151511 50.931250 18708 2 0.000000 -1 2.500000 56.252000 31.151511 50.931250 18709 2 0.000000 1 2.500000 49.364000 29.825915 54.443750 -18710 2 0.000000 -1.000000 2.500000 49.364000 29.825915 54.443750 +18710 2 0.000000 -1 2.500000 49.364000 29.825915 54.443750 18711 2 0.000000 1 2.500000 51.660000 25.849126 54.443750 18712 2 0.000000 -1 2.500000 51.660000 25.849126 54.443750 18713 2 0.000000 1 2.500000 53.956000 27.174722 57.956250 @@ -18731,7 +18731,7 @@ Atoms 18715 2 0.000000 1 2.500000 56.252000 31.151511 57.956250 18716 2 0.000000 -1 2.500000 56.252000 31.151511 57.956250 18717 2 0.000000 1 2.500000 49.364000 29.825915 61.468750 -18718 2 0.000000 -1.000000 2.500000 49.364000 29.825915 61.468750 +18718 2 0.000000 -1 2.500000 49.364000 29.825915 61.468750 18719 2 0.000000 1 2.500000 51.660000 25.849126 61.468750 18720 2 0.000000 -1 2.500000 51.660000 25.849126 61.468750 18721 2 0.000000 1 2.500000 53.956000 35.128300 1.756250 @@ -18739,7 +18739,7 @@ Atoms 18723 2 0.000000 1 2.500000 56.252000 39.105088 1.756250 18724 2 0.000000 -1 2.500000 56.252000 39.105088 1.756250 18725 2 0.000000 1 2.500000 49.364000 37.779492 5.268750 -18726 2 0.000000 -1.000000 2.500000 49.364000 37.779492 5.268750 +18726 2 0.000000 -1 2.500000 49.364000 37.779492 5.268750 18727 2 0.000000 1 2.500000 51.660000 33.802704 5.268750 18728 2 0.000000 -1 2.500000 51.660000 33.802704 5.268750 18729 2 0.000000 1 2.500000 53.956000 35.128300 8.781250 @@ -18747,7 +18747,7 @@ Atoms 18731 2 0.000000 1 2.500000 56.252000 39.105088 8.781250 18732 2 0.000000 -1 2.500000 56.252000 39.105088 8.781250 18733 2 0.000000 1 2.500000 49.364000 37.779492 12.293750 -18734 2 0.000000 -1.000000 2.500000 49.364000 37.779492 12.293750 +18734 2 0.000000 -1 2.500000 49.364000 37.779492 12.293750 18735 2 0.000000 1 2.500000 51.660000 33.802704 12.293750 18736 2 0.000000 -1 2.500000 51.660000 33.802704 12.293750 18737 2 0.000000 1 2.500000 53.956000 35.128300 15.806250 @@ -18755,7 +18755,7 @@ Atoms 18739 2 0.000000 1 2.500000 56.252000 39.105088 15.806250 18740 2 0.000000 -1 2.500000 56.252000 39.105088 15.806250 18741 2 0.000000 1 2.500000 49.364000 37.779492 19.318750 -18742 2 0.000000 -1.000000 2.500000 49.364000 37.779492 19.318750 +18742 2 0.000000 -1 2.500000 49.364000 37.779492 19.318750 18743 2 0.000000 1 2.500000 51.660000 33.802704 19.318750 18744 2 0.000000 -1 2.500000 51.660000 33.802704 19.318750 18745 2 0.000000 1 2.500000 53.956000 35.128300 22.831250 @@ -18763,7 +18763,7 @@ Atoms 18747 2 0.000000 1 2.500000 56.252000 39.105088 22.831250 18748 2 0.000000 -1 2.500000 56.252000 39.105088 22.831250 18749 2 0.000000 1 2.500000 49.364000 37.779492 26.343750 -18750 2 0.000000 -1.000000 2.500000 49.364000 37.779492 26.343750 +18750 2 0.000000 -1 2.500000 49.364000 37.779492 26.343750 18751 2 0.000000 1 2.500000 51.660000 33.802704 26.343750 18752 2 0.000000 -1 2.500000 51.660000 33.802704 26.343750 18753 2 0.000000 1 2.500000 53.956000 35.128300 29.856250 @@ -18771,7 +18771,7 @@ Atoms 18755 2 0.000000 1 2.500000 56.252000 39.105088 29.856250 18756 2 0.000000 -1 2.500000 56.252000 39.105088 29.856250 18757 2 0.000000 1 2.500000 49.364000 37.779492 33.368750 -18758 2 0.000000 -1.000000 2.500000 49.364000 37.779492 33.368750 +18758 2 0.000000 -1 2.500000 49.364000 37.779492 33.368750 18759 2 0.000000 1 2.500000 51.660000 33.802704 33.368750 18760 2 0.000000 -1 2.500000 51.660000 33.802704 33.368750 18761 2 0.000000 1 2.500000 53.956000 35.128300 36.881250 @@ -18779,7 +18779,7 @@ Atoms 18763 2 0.000000 1 2.500000 56.252000 39.105088 36.881250 18764 2 0.000000 -1 2.500000 56.252000 39.105088 36.881250 18765 2 0.000000 1 2.500000 49.364000 37.779492 40.393750 -18766 2 0.000000 -1.000000 2.500000 49.364000 37.779492 40.393750 +18766 2 0.000000 -1 2.500000 49.364000 37.779492 40.393750 18767 2 0.000000 1 2.500000 51.660000 33.802704 40.393750 18768 2 0.000000 -1 2.500000 51.660000 33.802704 40.393750 18769 2 0.000000 1 2.500000 53.956000 35.128300 43.906250 @@ -18787,7 +18787,7 @@ Atoms 18771 2 0.000000 1 2.500000 56.252000 39.105088 43.906250 18772 2 0.000000 -1 2.500000 56.252000 39.105088 43.906250 18773 2 0.000000 1 2.500000 49.364000 37.779492 47.418750 -18774 2 0.000000 -1.000000 2.500000 49.364000 37.779492 47.418750 +18774 2 0.000000 -1 2.500000 49.364000 37.779492 47.418750 18775 2 0.000000 1 2.500000 51.660000 33.802704 47.418750 18776 2 0.000000 -1 2.500000 51.660000 33.802704 47.418750 18777 2 0.000000 1 2.500000 53.956000 35.128300 50.931250 @@ -18795,7 +18795,7 @@ Atoms 18779 2 0.000000 1 2.500000 56.252000 39.105088 50.931250 18780 2 0.000000 -1 2.500000 56.252000 39.105088 50.931250 18781 2 0.000000 1 2.500000 49.364000 37.779492 54.443750 -18782 2 0.000000 -1.000000 2.500000 49.364000 37.779492 54.443750 +18782 2 0.000000 -1 2.500000 49.364000 37.779492 54.443750 18783 2 0.000000 1 2.500000 51.660000 33.802704 54.443750 18784 2 0.000000 -1 2.500000 51.660000 33.802704 54.443750 18785 2 0.000000 1 2.500000 53.956000 35.128300 57.956250 @@ -18803,7 +18803,7 @@ Atoms 18787 2 0.000000 1 2.500000 56.252000 39.105088 57.956250 18788 2 0.000000 -1 2.500000 56.252000 39.105088 57.956250 18789 2 0.000000 1 2.500000 49.364000 37.779492 61.468750 -18790 2 0.000000 -1.000000 2.500000 49.364000 37.779492 61.468750 +18790 2 0.000000 -1 2.500000 49.364000 37.779492 61.468750 18791 2 0.000000 1 2.500000 51.660000 33.802704 61.468750 18792 2 0.000000 -1 2.500000 51.660000 33.802704 61.468750 18793 2 0.000000 1 2.500000 53.956000 43.081877 1.756250 @@ -18811,7 +18811,7 @@ Atoms 18795 2 0.000000 1 2.500000 56.252000 47.058666 1.756250 18796 2 0.000000 -1 2.500000 56.252000 47.058666 1.756250 18797 2 0.000000 1 2.500000 49.364000 45.733070 5.268750 -18798 2 0.000000 -1.000000 2.500000 49.364000 45.733070 5.268750 +18798 2 0.000000 -1 2.500000 49.364000 45.733070 5.268750 18799 2 0.000000 1 2.500000 51.660000 41.756281 5.268750 18800 2 0.000000 -1 2.500000 51.660000 41.756281 5.268750 18801 2 0.000000 1 2.500000 53.956000 43.081877 8.781250 @@ -18819,7 +18819,7 @@ Atoms 18803 2 0.000000 1 2.500000 56.252000 47.058666 8.781250 18804 2 0.000000 -1 2.500000 56.252000 47.058666 8.781250 18805 2 0.000000 1 2.500000 49.364000 45.733070 12.293750 -18806 2 0.000000 -1.000000 2.500000 49.364000 45.733070 12.293750 +18806 2 0.000000 -1 2.500000 49.364000 45.733070 12.293750 18807 2 0.000000 1 2.500000 51.660000 41.756281 12.293750 18808 2 0.000000 -1 2.500000 51.660000 41.756281 12.293750 18809 2 0.000000 1 2.500000 53.956000 43.081877 15.806250 @@ -18827,7 +18827,7 @@ Atoms 18811 2 0.000000 1 2.500000 56.252000 47.058666 15.806250 18812 2 0.000000 -1 2.500000 56.252000 47.058666 15.806250 18813 2 0.000000 1 2.500000 49.364000 45.733070 19.318750 -18814 2 0.000000 -1.000000 2.500000 49.364000 45.733070 19.318750 +18814 2 0.000000 -1 2.500000 49.364000 45.733070 19.318750 18815 2 0.000000 1 2.500000 51.660000 41.756281 19.318750 18816 2 0.000000 -1 2.500000 51.660000 41.756281 19.318750 18817 2 0.000000 1 2.500000 53.956000 43.081877 22.831250 @@ -18835,7 +18835,7 @@ Atoms 18819 2 0.000000 1 2.500000 56.252000 47.058666 22.831250 18820 2 0.000000 -1 2.500000 56.252000 47.058666 22.831250 18821 2 0.000000 1 2.500000 49.364000 45.733070 26.343750 -18822 2 0.000000 -1.000000 2.500000 49.364000 45.733070 26.343750 +18822 2 0.000000 -1 2.500000 49.364000 45.733070 26.343750 18823 2 0.000000 1 2.500000 51.660000 41.756281 26.343750 18824 2 0.000000 -1 2.500000 51.660000 41.756281 26.343750 18825 2 0.000000 1 2.500000 53.956000 43.081877 29.856250 @@ -18843,7 +18843,7 @@ Atoms 18827 2 0.000000 1 2.500000 56.252000 47.058666 29.856250 18828 2 0.000000 -1 2.500000 56.252000 47.058666 29.856250 18829 2 0.000000 1 2.500000 49.364000 45.733070 33.368750 -18830 2 0.000000 -1.000000 2.500000 49.364000 45.733070 33.368750 +18830 2 0.000000 -1 2.500000 49.364000 45.733070 33.368750 18831 2 0.000000 1 2.500000 51.660000 41.756281 33.368750 18832 2 0.000000 -1 2.500000 51.660000 41.756281 33.368750 18833 2 0.000000 1 2.500000 53.956000 43.081877 36.881250 @@ -18851,7 +18851,7 @@ Atoms 18835 2 0.000000 1 2.500000 56.252000 47.058666 36.881250 18836 2 0.000000 -1 2.500000 56.252000 47.058666 36.881250 18837 2 0.000000 1 2.500000 49.364000 45.733070 40.393750 -18838 2 0.000000 -1.000000 2.500000 49.364000 45.733070 40.393750 +18838 2 0.000000 -1 2.500000 49.364000 45.733070 40.393750 18839 2 0.000000 1 2.500000 51.660000 41.756281 40.393750 18840 2 0.000000 -1 2.500000 51.660000 41.756281 40.393750 18841 2 0.000000 1 2.500000 53.956000 43.081877 43.906250 @@ -18859,7 +18859,7 @@ Atoms 18843 2 0.000000 1 2.500000 56.252000 47.058666 43.906250 18844 2 0.000000 -1 2.500000 56.252000 47.058666 43.906250 18845 2 0.000000 1 2.500000 49.364000 45.733070 47.418750 -18846 2 0.000000 -1.000000 2.500000 49.364000 45.733070 47.418750 +18846 2 0.000000 -1 2.500000 49.364000 45.733070 47.418750 18847 2 0.000000 1 2.500000 51.660000 41.756281 47.418750 18848 2 0.000000 -1 2.500000 51.660000 41.756281 47.418750 18849 2 0.000000 1 2.500000 53.956000 43.081877 50.931250 @@ -18867,7 +18867,7 @@ Atoms 18851 2 0.000000 1 2.500000 56.252000 47.058666 50.931250 18852 2 0.000000 -1 2.500000 56.252000 47.058666 50.931250 18853 2 0.000000 1 2.500000 49.364000 45.733070 54.443750 -18854 2 0.000000 -1.000000 2.500000 49.364000 45.733070 54.443750 +18854 2 0.000000 -1 2.500000 49.364000 45.733070 54.443750 18855 2 0.000000 1 2.500000 51.660000 41.756281 54.443750 18856 2 0.000000 -1 2.500000 51.660000 41.756281 54.443750 18857 2 0.000000 1 2.500000 53.956000 43.081877 57.956250 @@ -18875,7 +18875,7 @@ Atoms 18859 2 0.000000 1 2.500000 56.252000 47.058666 57.956250 18860 2 0.000000 -1 2.500000 56.252000 47.058666 57.956250 18861 2 0.000000 1 2.500000 49.364000 45.733070 61.468750 -18862 2 0.000000 -1.000000 2.500000 49.364000 45.733070 61.468750 +18862 2 0.000000 -1 2.500000 49.364000 45.733070 61.468750 18863 2 0.000000 1 2.500000 51.660000 41.756281 61.468750 18864 2 0.000000 -1 2.500000 51.660000 41.756281 61.468750 18865 2 0.000000 1 2.500000 53.956000 51.035454 1.756250 @@ -18883,7 +18883,7 @@ Atoms 18867 2 0.000000 1 2.500000 56.252000 55.012243 1.756250 18868 2 0.000000 -1 2.500000 56.252000 55.012243 1.756250 18869 2 0.000000 1 2.500000 49.364000 53.686647 5.268750 -18870 2 0.000000 -1.000000 2.500000 49.364000 53.686647 5.268750 +18870 2 0.000000 -1 2.500000 49.364000 53.686647 5.268750 18871 2 0.000000 1 2.500000 51.660000 49.709858 5.268750 18872 2 0.000000 -1 2.500000 51.660000 49.709858 5.268750 18873 2 0.000000 1 2.500000 53.956000 51.035454 8.781250 @@ -18891,7 +18891,7 @@ Atoms 18875 2 0.000000 1 2.500000 56.252000 55.012243 8.781250 18876 2 0.000000 -1 2.500000 56.252000 55.012243 8.781250 18877 2 0.000000 1 2.500000 49.364000 53.686647 12.293750 -18878 2 0.000000 -1.000000 2.500000 49.364000 53.686647 12.293750 +18878 2 0.000000 -1 2.500000 49.364000 53.686647 12.293750 18879 2 0.000000 1 2.500000 51.660000 49.709858 12.293750 18880 2 0.000000 -1 2.500000 51.660000 49.709858 12.293750 18881 2 0.000000 1 2.500000 53.956000 51.035454 15.806250 @@ -18899,7 +18899,7 @@ Atoms 18883 2 0.000000 1 2.500000 56.252000 55.012243 15.806250 18884 2 0.000000 -1 2.500000 56.252000 55.012243 15.806250 18885 2 0.000000 1 2.500000 49.364000 53.686647 19.318750 -18886 2 0.000000 -1.000000 2.500000 49.364000 53.686647 19.318750 +18886 2 0.000000 -1 2.500000 49.364000 53.686647 19.318750 18887 2 0.000000 1 2.500000 51.660000 49.709858 19.318750 18888 2 0.000000 -1 2.500000 51.660000 49.709858 19.318750 18889 2 0.000000 1 2.500000 53.956000 51.035454 22.831250 @@ -18907,7 +18907,7 @@ Atoms 18891 2 0.000000 1 2.500000 56.252000 55.012243 22.831250 18892 2 0.000000 -1 2.500000 56.252000 55.012243 22.831250 18893 2 0.000000 1 2.500000 49.364000 53.686647 26.343750 -18894 2 0.000000 -1.000000 2.500000 49.364000 53.686647 26.343750 +18894 2 0.000000 -1 2.500000 49.364000 53.686647 26.343750 18895 2 0.000000 1 2.500000 51.660000 49.709858 26.343750 18896 2 0.000000 -1 2.500000 51.660000 49.709858 26.343750 18897 2 0.000000 1 2.500000 53.956000 51.035454 29.856250 @@ -18915,7 +18915,7 @@ Atoms 18899 2 0.000000 1 2.500000 56.252000 55.012243 29.856250 18900 2 0.000000 -1 2.500000 56.252000 55.012243 29.856250 18901 2 0.000000 1 2.500000 49.364000 53.686647 33.368750 -18902 2 0.000000 -1.000000 2.500000 49.364000 53.686647 33.368750 +18902 2 0.000000 -1 2.500000 49.364000 53.686647 33.368750 18903 2 0.000000 1 2.500000 51.660000 49.709858 33.368750 18904 2 0.000000 -1 2.500000 51.660000 49.709858 33.368750 18905 2 0.000000 1 2.500000 53.956000 51.035454 36.881250 @@ -18923,7 +18923,7 @@ Atoms 18907 2 0.000000 1 2.500000 56.252000 55.012243 36.881250 18908 2 0.000000 -1 2.500000 56.252000 55.012243 36.881250 18909 2 0.000000 1 2.500000 49.364000 53.686647 40.393750 -18910 2 0.000000 -1.000000 2.500000 49.364000 53.686647 40.393750 +18910 2 0.000000 -1 2.500000 49.364000 53.686647 40.393750 18911 2 0.000000 1 2.500000 51.660000 49.709858 40.393750 18912 2 0.000000 -1 2.500000 51.660000 49.709858 40.393750 18913 2 0.000000 1 2.500000 53.956000 51.035454 43.906250 @@ -18931,7 +18931,7 @@ Atoms 18915 2 0.000000 1 2.500000 56.252000 55.012243 43.906250 18916 2 0.000000 -1 2.500000 56.252000 55.012243 43.906250 18917 2 0.000000 1 2.500000 49.364000 53.686647 47.418750 -18918 2 0.000000 -1.000000 2.500000 49.364000 53.686647 47.418750 +18918 2 0.000000 -1 2.500000 49.364000 53.686647 47.418750 18919 2 0.000000 1 2.500000 51.660000 49.709858 47.418750 18920 2 0.000000 -1 2.500000 51.660000 49.709858 47.418750 18921 2 0.000000 1 2.500000 53.956000 51.035454 50.931250 @@ -18939,7 +18939,7 @@ Atoms 18923 2 0.000000 1 2.500000 56.252000 55.012243 50.931250 18924 2 0.000000 -1 2.500000 56.252000 55.012243 50.931250 18925 2 0.000000 1 2.500000 49.364000 53.686647 54.443750 -18926 2 0.000000 -1.000000 2.500000 49.364000 53.686647 54.443750 +18926 2 0.000000 -1 2.500000 49.364000 53.686647 54.443750 18927 2 0.000000 1 2.500000 51.660000 49.709858 54.443750 18928 2 0.000000 -1 2.500000 51.660000 49.709858 54.443750 18929 2 0.000000 1 2.500000 53.956000 51.035454 57.956250 @@ -18947,7 +18947,7 @@ Atoms 18931 2 0.000000 1 2.500000 56.252000 55.012243 57.956250 18932 2 0.000000 -1 2.500000 56.252000 55.012243 57.956250 18933 2 0.000000 1 2.500000 49.364000 53.686647 61.468750 -18934 2 0.000000 -1.000000 2.500000 49.364000 53.686647 61.468750 +18934 2 0.000000 -1 2.500000 49.364000 53.686647 61.468750 18935 2 0.000000 1 2.500000 51.660000 49.709858 61.468750 18936 2 0.000000 -1 2.500000 51.660000 49.709858 61.468750 18937 2 0.000000 1 2.500000 53.956000 58.989032 1.756250 @@ -18955,7 +18955,7 @@ Atoms 18939 2 0.000000 1 2.500000 56.252000 62.965820 1.756250 18940 2 0.000000 -1 2.500000 56.252000 62.965820 1.756250 18941 2 0.000000 1 2.500000 49.364000 61.640224 5.268750 -18942 2 0.000000 -1.000000 2.500000 49.364000 61.640224 5.268750 +18942 2 0.000000 -1 2.500000 49.364000 61.640224 5.268750 18943 2 0.000000 1 2.500000 51.660000 57.663435 5.268750 18944 2 0.000000 -1 2.500000 51.660000 57.663435 5.268750 18945 2 0.000000 1 2.500000 53.956000 58.989032 8.781250 @@ -18963,7 +18963,7 @@ Atoms 18947 2 0.000000 1 2.500000 56.252000 62.965820 8.781250 18948 2 0.000000 -1 2.500000 56.252000 62.965820 8.781250 18949 2 0.000000 1 2.500000 49.364000 61.640224 12.293750 -18950 2 0.000000 -1.000000 2.500000 49.364000 61.640224 12.293750 +18950 2 0.000000 -1 2.500000 49.364000 61.640224 12.293750 18951 2 0.000000 1 2.500000 51.660000 57.663435 12.293750 18952 2 0.000000 -1 2.500000 51.660000 57.663435 12.293750 18953 2 0.000000 1 2.500000 53.956000 58.989032 15.806250 @@ -18971,7 +18971,7 @@ Atoms 18955 2 0.000000 1 2.500000 56.252000 62.965820 15.806250 18956 2 0.000000 -1 2.500000 56.252000 62.965820 15.806250 18957 2 0.000000 1 2.500000 49.364000 61.640224 19.318750 -18958 2 0.000000 -1.000000 2.500000 49.364000 61.640224 19.318750 +18958 2 0.000000 -1 2.500000 49.364000 61.640224 19.318750 18959 2 0.000000 1 2.500000 51.660000 57.663435 19.318750 18960 2 0.000000 -1 2.500000 51.660000 57.663435 19.318750 18961 2 0.000000 1 2.500000 53.956000 58.989032 22.831250 @@ -18979,7 +18979,7 @@ Atoms 18963 2 0.000000 1 2.500000 56.252000 62.965820 22.831250 18964 2 0.000000 -1 2.500000 56.252000 62.965820 22.831250 18965 2 0.000000 1 2.500000 49.364000 61.640224 26.343750 -18966 2 0.000000 -1.000000 2.500000 49.364000 61.640224 26.343750 +18966 2 0.000000 -1 2.500000 49.364000 61.640224 26.343750 18967 2 0.000000 1 2.500000 51.660000 57.663435 26.343750 18968 2 0.000000 -1 2.500000 51.660000 57.663435 26.343750 18969 2 0.000000 1 2.500000 53.956000 58.989032 29.856250 @@ -18987,7 +18987,7 @@ Atoms 18971 2 0.000000 1 2.500000 56.252000 62.965820 29.856250 18972 2 0.000000 -1 2.500000 56.252000 62.965820 29.856250 18973 2 0.000000 1 2.500000 49.364000 61.640224 33.368750 -18974 2 0.000000 -1.000000 2.500000 49.364000 61.640224 33.368750 +18974 2 0.000000 -1 2.500000 49.364000 61.640224 33.368750 18975 2 0.000000 1 2.500000 51.660000 57.663435 33.368750 18976 2 0.000000 -1 2.500000 51.660000 57.663435 33.368750 18977 2 0.000000 1 2.500000 53.956000 58.989032 36.881250 @@ -18995,7 +18995,7 @@ Atoms 18979 2 0.000000 1 2.500000 56.252000 62.965820 36.881250 18980 2 0.000000 -1 2.500000 56.252000 62.965820 36.881250 18981 2 0.000000 1 2.500000 49.364000 61.640224 40.393750 -18982 2 0.000000 -1.000000 2.500000 49.364000 61.640224 40.393750 +18982 2 0.000000 -1 2.500000 49.364000 61.640224 40.393750 18983 2 0.000000 1 2.500000 51.660000 57.663435 40.393750 18984 2 0.000000 -1 2.500000 51.660000 57.663435 40.393750 18985 2 0.000000 1 2.500000 53.956000 58.989032 43.906250 @@ -19003,7 +19003,7 @@ Atoms 18987 2 0.000000 1 2.500000 56.252000 62.965820 43.906250 18988 2 0.000000 -1 2.500000 56.252000 62.965820 43.906250 18989 2 0.000000 1 2.500000 49.364000 61.640224 47.418750 -18990 2 0.000000 -1.000000 2.500000 49.364000 61.640224 47.418750 +18990 2 0.000000 -1 2.500000 49.364000 61.640224 47.418750 18991 2 0.000000 1 2.500000 51.660000 57.663435 47.418750 18992 2 0.000000 -1 2.500000 51.660000 57.663435 47.418750 18993 2 0.000000 1 2.500000 53.956000 58.989032 50.931250 @@ -19011,7 +19011,7 @@ Atoms 18995 2 0.000000 1 2.500000 56.252000 62.965820 50.931250 18996 2 0.000000 -1 2.500000 56.252000 62.965820 50.931250 18997 2 0.000000 1 2.500000 49.364000 61.640224 54.443750 -18998 2 0.000000 -1.000000 2.500000 49.364000 61.640224 54.443750 +18998 2 0.000000 -1 2.500000 49.364000 61.640224 54.443750 18999 2 0.000000 1 2.500000 51.660000 57.663435 54.443750 19000 2 0.000000 -1 2.500000 51.660000 57.663435 54.443750 19001 2 0.000000 1 2.500000 53.956000 58.989032 57.956250 @@ -19019,7 +19019,7 @@ Atoms 19003 2 0.000000 1 2.500000 56.252000 62.965820 57.956250 19004 2 0.000000 -1 2.500000 56.252000 62.965820 57.956250 19005 2 0.000000 1 2.500000 49.364000 61.640224 61.468750 -19006 2 0.000000 -1.000000 2.500000 49.364000 61.640224 61.468750 +19006 2 0.000000 -1 2.500000 49.364000 61.640224 61.468750 19007 2 0.000000 1 2.500000 51.660000 57.663435 61.468750 19008 2 0.000000 -1 2.500000 51.660000 57.663435 61.468750 19009 2 0.000000 1 2.500000 58.548000 3.313991 1.756250 @@ -19027,7 +19027,7 @@ Atoms 19011 2 0.000000 1 2.500000 60.844000 7.290779 1.756250 19012 2 0.000000 -1 2.500000 60.844000 7.290779 1.756250 19013 2 0.000000 1 2.500000 53.956000 5.965183 5.268750 -19014 2 0.000000 -1.000000 2.500000 53.956000 5.965183 5.268750 +19014 2 0.000000 -1 2.500000 53.956000 5.965183 5.268750 19015 2 0.000000 1 2.500000 56.252000 1.988394 5.268750 19016 2 0.000000 -1 2.500000 56.252000 1.988394 5.268750 19017 2 0.000000 1 2.500000 58.548000 3.313991 8.781250 @@ -19035,7 +19035,7 @@ Atoms 19019 2 0.000000 1 2.500000 60.844000 7.290779 8.781250 19020 2 0.000000 -1 2.500000 60.844000 7.290779 8.781250 19021 2 0.000000 1 2.500000 53.956000 5.965183 12.293750 -19022 2 0.000000 -1.000000 2.500000 53.956000 5.965183 12.293750 +19022 2 0.000000 -1 2.500000 53.956000 5.965183 12.293750 19023 2 0.000000 1 2.500000 56.252000 1.988394 12.293750 19024 2 0.000000 -1 2.500000 56.252000 1.988394 12.293750 19025 2 0.000000 1 2.500000 58.548000 3.313991 15.806250 @@ -19043,7 +19043,7 @@ Atoms 19027 2 0.000000 1 2.500000 60.844000 7.290779 15.806250 19028 2 0.000000 -1 2.500000 60.844000 7.290779 15.806250 19029 2 0.000000 1 2.500000 53.956000 5.965183 19.318750 -19030 2 0.000000 -1.000000 2.500000 53.956000 5.965183 19.318750 +19030 2 0.000000 -1 2.500000 53.956000 5.965183 19.318750 19031 2 0.000000 1 2.500000 56.252000 1.988394 19.318750 19032 2 0.000000 -1 2.500000 56.252000 1.988394 19.318750 19033 2 0.000000 1 2.500000 58.548000 3.313991 22.831250 @@ -19051,7 +19051,7 @@ Atoms 19035 2 0.000000 1 2.500000 60.844000 7.290779 22.831250 19036 2 0.000000 -1 2.500000 60.844000 7.290779 22.831250 19037 2 0.000000 1 2.500000 53.956000 5.965183 26.343750 -19038 2 0.000000 -1.000000 2.500000 53.956000 5.965183 26.343750 +19038 2 0.000000 -1 2.500000 53.956000 5.965183 26.343750 19039 2 0.000000 1 2.500000 56.252000 1.988394 26.343750 19040 2 0.000000 -1 2.500000 56.252000 1.988394 26.343750 19041 2 0.000000 1 2.500000 58.548000 3.313991 29.856250 @@ -19059,7 +19059,7 @@ Atoms 19043 2 0.000000 1 2.500000 60.844000 7.290779 29.856250 19044 2 0.000000 -1 2.500000 60.844000 7.290779 29.856250 19045 2 0.000000 1 2.500000 53.956000 5.965183 33.368750 -19046 2 0.000000 -1.000000 2.500000 53.956000 5.965183 33.368750 +19046 2 0.000000 -1 2.500000 53.956000 5.965183 33.368750 19047 2 0.000000 1 2.500000 56.252000 1.988394 33.368750 19048 2 0.000000 -1 2.500000 56.252000 1.988394 33.368750 19049 2 0.000000 1 2.500000 58.548000 3.313991 36.881250 @@ -19067,7 +19067,7 @@ Atoms 19051 2 0.000000 1 2.500000 60.844000 7.290779 36.881250 19052 2 0.000000 -1 2.500000 60.844000 7.290779 36.881250 19053 2 0.000000 1 2.500000 53.956000 5.965183 40.393750 -19054 2 0.000000 -1.000000 2.500000 53.956000 5.965183 40.393750 +19054 2 0.000000 -1 2.500000 53.956000 5.965183 40.393750 19055 2 0.000000 1 2.500000 56.252000 1.988394 40.393750 19056 2 0.000000 -1 2.500000 56.252000 1.988394 40.393750 19057 2 0.000000 1 2.500000 58.548000 3.313991 43.906250 @@ -19075,7 +19075,7 @@ Atoms 19059 2 0.000000 1 2.500000 60.844000 7.290779 43.906250 19060 2 0.000000 -1 2.500000 60.844000 7.290779 43.906250 19061 2 0.000000 1 2.500000 53.956000 5.965183 47.418750 -19062 2 0.000000 -1.000000 2.500000 53.956000 5.965183 47.418750 +19062 2 0.000000 -1 2.500000 53.956000 5.965183 47.418750 19063 2 0.000000 1 2.500000 56.252000 1.988394 47.418750 19064 2 0.000000 -1 2.500000 56.252000 1.988394 47.418750 19065 2 0.000000 1 2.500000 58.548000 3.313991 50.931250 @@ -19083,7 +19083,7 @@ Atoms 19067 2 0.000000 1 2.500000 60.844000 7.290779 50.931250 19068 2 0.000000 -1 2.500000 60.844000 7.290779 50.931250 19069 2 0.000000 1 2.500000 53.956000 5.965183 54.443750 -19070 2 0.000000 -1.000000 2.500000 53.956000 5.965183 54.443750 +19070 2 0.000000 -1 2.500000 53.956000 5.965183 54.443750 19071 2 0.000000 1 2.500000 56.252000 1.988394 54.443750 19072 2 0.000000 -1 2.500000 56.252000 1.988394 54.443750 19073 2 0.000000 1 2.500000 58.548000 3.313991 57.956250 @@ -19091,7 +19091,7 @@ Atoms 19075 2 0.000000 1 2.500000 60.844000 7.290779 57.956250 19076 2 0.000000 -1 2.500000 60.844000 7.290779 57.956250 19077 2 0.000000 1 2.500000 53.956000 5.965183 61.468750 -19078 2 0.000000 -1.000000 2.500000 53.956000 5.965183 61.468750 +19078 2 0.000000 -1 2.500000 53.956000 5.965183 61.468750 19079 2 0.000000 1 2.500000 56.252000 1.988394 61.468750 19080 2 0.000000 -1 2.500000 56.252000 1.988394 61.468750 19081 2 0.000000 1 2.500000 58.548000 11.267568 1.756250 @@ -19099,7 +19099,7 @@ Atoms 19083 2 0.000000 1 2.500000 60.844000 15.244357 1.756250 19084 2 0.000000 -1 2.500000 60.844000 15.244357 1.756250 19085 2 0.000000 1 2.500000 53.956000 13.918760 5.268750 -19086 2 0.000000 -1.000000 2.500000 53.956000 13.918760 5.268750 +19086 2 0.000000 -1 2.500000 53.956000 13.918760 5.268750 19087 2 0.000000 1 2.500000 56.252000 9.941972 5.268750 19088 2 0.000000 -1 2.500000 56.252000 9.941972 5.268750 19089 2 0.000000 1 2.500000 58.548000 11.267568 8.781250 @@ -19107,7 +19107,7 @@ Atoms 19091 2 0.000000 1 2.500000 60.844000 15.244357 8.781250 19092 2 0.000000 -1 2.500000 60.844000 15.244357 8.781250 19093 2 0.000000 1 2.500000 53.956000 13.918760 12.293750 -19094 2 0.000000 -1.000000 2.500000 53.956000 13.918760 12.293750 +19094 2 0.000000 -1 2.500000 53.956000 13.918760 12.293750 19095 2 0.000000 1 2.500000 56.252000 9.941972 12.293750 19096 2 0.000000 -1 2.500000 56.252000 9.941972 12.293750 19097 2 0.000000 1 2.500000 58.548000 11.267568 15.806250 @@ -19115,7 +19115,7 @@ Atoms 19099 2 0.000000 1 2.500000 60.844000 15.244357 15.806250 19100 2 0.000000 -1 2.500000 60.844000 15.244357 15.806250 19101 2 0.000000 1 2.500000 53.956000 13.918760 19.318750 -19102 2 0.000000 -1.000000 2.500000 53.956000 13.918760 19.318750 +19102 2 0.000000 -1 2.500000 53.956000 13.918760 19.318750 19103 2 0.000000 1 2.500000 56.252000 9.941972 19.318750 19104 2 0.000000 -1 2.500000 56.252000 9.941972 19.318750 19105 2 0.000000 1 2.500000 58.548000 11.267568 22.831250 @@ -19123,7 +19123,7 @@ Atoms 19107 2 0.000000 1 2.500000 60.844000 15.244357 22.831250 19108 2 0.000000 -1 2.500000 60.844000 15.244357 22.831250 19109 2 0.000000 1 2.500000 53.956000 13.918760 26.343750 -19110 2 0.000000 -1.000000 2.500000 53.956000 13.918760 26.343750 +19110 2 0.000000 -1 2.500000 53.956000 13.918760 26.343750 19111 2 0.000000 1 2.500000 56.252000 9.941972 26.343750 19112 2 0.000000 -1 2.500000 56.252000 9.941972 26.343750 19113 2 0.000000 1 2.500000 58.548000 11.267568 29.856250 @@ -19131,7 +19131,7 @@ Atoms 19115 2 0.000000 1 2.500000 60.844000 15.244357 29.856250 19116 2 0.000000 -1 2.500000 60.844000 15.244357 29.856250 19117 2 0.000000 1 2.500000 53.956000 13.918760 33.368750 -19118 2 0.000000 -1.000000 2.500000 53.956000 13.918760 33.368750 +19118 2 0.000000 -1 2.500000 53.956000 13.918760 33.368750 19119 2 0.000000 1 2.500000 56.252000 9.941972 33.368750 19120 2 0.000000 -1 2.500000 56.252000 9.941972 33.368750 19121 2 0.000000 1 2.500000 58.548000 11.267568 36.881250 @@ -19139,7 +19139,7 @@ Atoms 19123 2 0.000000 1 2.500000 60.844000 15.244357 36.881250 19124 2 0.000000 -1 2.500000 60.844000 15.244357 36.881250 19125 2 0.000000 1 2.500000 53.956000 13.918760 40.393750 -19126 2 0.000000 -1.000000 2.500000 53.956000 13.918760 40.393750 +19126 2 0.000000 -1 2.500000 53.956000 13.918760 40.393750 19127 2 0.000000 1 2.500000 56.252000 9.941972 40.393750 19128 2 0.000000 -1 2.500000 56.252000 9.941972 40.393750 19129 2 0.000000 1 2.500000 58.548000 11.267568 43.906250 @@ -19147,7 +19147,7 @@ Atoms 19131 2 0.000000 1 2.500000 60.844000 15.244357 43.906250 19132 2 0.000000 -1 2.500000 60.844000 15.244357 43.906250 19133 2 0.000000 1 2.500000 53.956000 13.918760 47.418750 -19134 2 0.000000 -1.000000 2.500000 53.956000 13.918760 47.418750 +19134 2 0.000000 -1 2.500000 53.956000 13.918760 47.418750 19135 2 0.000000 1 2.500000 56.252000 9.941972 47.418750 19136 2 0.000000 -1 2.500000 56.252000 9.941972 47.418750 19137 2 0.000000 1 2.500000 58.548000 11.267568 50.931250 @@ -19155,7 +19155,7 @@ Atoms 19139 2 0.000000 1 2.500000 60.844000 15.244357 50.931250 19140 2 0.000000 -1 2.500000 60.844000 15.244357 50.931250 19141 2 0.000000 1 2.500000 53.956000 13.918760 54.443750 -19142 2 0.000000 -1.000000 2.500000 53.956000 13.918760 54.443750 +19142 2 0.000000 -1 2.500000 53.956000 13.918760 54.443750 19143 2 0.000000 1 2.500000 56.252000 9.941972 54.443750 19144 2 0.000000 -1 2.500000 56.252000 9.941972 54.443750 19145 2 0.000000 1 2.500000 58.548000 11.267568 57.956250 @@ -19163,7 +19163,7 @@ Atoms 19147 2 0.000000 1 2.500000 60.844000 15.244357 57.956250 19148 2 0.000000 -1 2.500000 60.844000 15.244357 57.956250 19149 2 0.000000 1 2.500000 53.956000 13.918760 61.468750 -19150 2 0.000000 -1.000000 2.500000 53.956000 13.918760 61.468750 +19150 2 0.000000 -1 2.500000 53.956000 13.918760 61.468750 19151 2 0.000000 1 2.500000 56.252000 9.941972 61.468750 19152 2 0.000000 -1 2.500000 56.252000 9.941972 61.468750 19153 2 0.000000 1 2.500000 58.548000 19.221145 1.756250 @@ -19171,7 +19171,7 @@ Atoms 19155 2 0.000000 1 2.500000 60.844000 23.197934 1.756250 19156 2 0.000000 -1 2.500000 60.844000 23.197934 1.756250 19157 2 0.000000 1 2.500000 53.956000 21.872338 5.268750 -19158 2 0.000000 -1.000000 2.500000 53.956000 21.872338 5.268750 +19158 2 0.000000 -1 2.500000 53.956000 21.872338 5.268750 19159 2 0.000000 1 2.500000 56.252000 17.895549 5.268750 19160 2 0.000000 -1 2.500000 56.252000 17.895549 5.268750 19161 2 0.000000 1 2.500000 58.548000 19.221145 8.781250 @@ -19179,7 +19179,7 @@ Atoms 19163 2 0.000000 1 2.500000 60.844000 23.197934 8.781250 19164 2 0.000000 -1 2.500000 60.844000 23.197934 8.781250 19165 2 0.000000 1 2.500000 53.956000 21.872338 12.293750 -19166 2 0.000000 -1.000000 2.500000 53.956000 21.872338 12.293750 +19166 2 0.000000 -1 2.500000 53.956000 21.872338 12.293750 19167 2 0.000000 1 2.500000 56.252000 17.895549 12.293750 19168 2 0.000000 -1 2.500000 56.252000 17.895549 12.293750 19169 2 0.000000 1 2.500000 58.548000 19.221145 15.806250 @@ -19187,7 +19187,7 @@ Atoms 19171 2 0.000000 1 2.500000 60.844000 23.197934 15.806250 19172 2 0.000000 -1 2.500000 60.844000 23.197934 15.806250 19173 2 0.000000 1 2.500000 53.956000 21.872338 19.318750 -19174 2 0.000000 -1.000000 2.500000 53.956000 21.872338 19.318750 +19174 2 0.000000 -1 2.500000 53.956000 21.872338 19.318750 19175 2 0.000000 1 2.500000 56.252000 17.895549 19.318750 19176 2 0.000000 -1 2.500000 56.252000 17.895549 19.318750 19177 2 0.000000 1 2.500000 58.548000 19.221145 22.831250 @@ -19195,7 +19195,7 @@ Atoms 19179 2 0.000000 1 2.500000 60.844000 23.197934 22.831250 19180 2 0.000000 -1 2.500000 60.844000 23.197934 22.831250 19181 2 0.000000 1 2.500000 53.956000 21.872338 26.343750 -19182 2 0.000000 -1.000000 2.500000 53.956000 21.872338 26.343750 +19182 2 0.000000 -1 2.500000 53.956000 21.872338 26.343750 19183 2 0.000000 1 2.500000 56.252000 17.895549 26.343750 19184 2 0.000000 -1 2.500000 56.252000 17.895549 26.343750 19185 2 0.000000 1 2.500000 58.548000 19.221145 29.856250 @@ -19203,7 +19203,7 @@ Atoms 19187 2 0.000000 1 2.500000 60.844000 23.197934 29.856250 19188 2 0.000000 -1 2.500000 60.844000 23.197934 29.856250 19189 2 0.000000 1 2.500000 53.956000 21.872338 33.368750 -19190 2 0.000000 -1.000000 2.500000 53.956000 21.872338 33.368750 +19190 2 0.000000 -1 2.500000 53.956000 21.872338 33.368750 19191 2 0.000000 1 2.500000 56.252000 17.895549 33.368750 19192 2 0.000000 -1 2.500000 56.252000 17.895549 33.368750 19193 2 0.000000 1 2.500000 58.548000 19.221145 36.881250 @@ -19211,7 +19211,7 @@ Atoms 19195 2 0.000000 1 2.500000 60.844000 23.197934 36.881250 19196 2 0.000000 -1 2.500000 60.844000 23.197934 36.881250 19197 2 0.000000 1 2.500000 53.956000 21.872338 40.393750 -19198 2 0.000000 -1.000000 2.500000 53.956000 21.872338 40.393750 +19198 2 0.000000 -1 2.500000 53.956000 21.872338 40.393750 19199 2 0.000000 1 2.500000 56.252000 17.895549 40.393750 19200 2 0.000000 -1 2.500000 56.252000 17.895549 40.393750 19201 2 0.000000 1 2.500000 58.548000 19.221145 43.906250 @@ -19219,7 +19219,7 @@ Atoms 19203 2 0.000000 1 2.500000 60.844000 23.197934 43.906250 19204 2 0.000000 -1 2.500000 60.844000 23.197934 43.906250 19205 2 0.000000 1 2.500000 53.956000 21.872338 47.418750 -19206 2 0.000000 -1.000000 2.500000 53.956000 21.872338 47.418750 +19206 2 0.000000 -1 2.500000 53.956000 21.872338 47.418750 19207 2 0.000000 1 2.500000 56.252000 17.895549 47.418750 19208 2 0.000000 -1 2.500000 56.252000 17.895549 47.418750 19209 2 0.000000 1 2.500000 58.548000 19.221145 50.931250 @@ -19227,7 +19227,7 @@ Atoms 19211 2 0.000000 1 2.500000 60.844000 23.197934 50.931250 19212 2 0.000000 -1 2.500000 60.844000 23.197934 50.931250 19213 2 0.000000 1 2.500000 53.956000 21.872338 54.443750 -19214 2 0.000000 -1.000000 2.500000 53.956000 21.872338 54.443750 +19214 2 0.000000 -1 2.500000 53.956000 21.872338 54.443750 19215 2 0.000000 1 2.500000 56.252000 17.895549 54.443750 19216 2 0.000000 -1 2.500000 56.252000 17.895549 54.443750 19217 2 0.000000 1 2.500000 58.548000 19.221145 57.956250 @@ -19235,7 +19235,7 @@ Atoms 19219 2 0.000000 1 2.500000 60.844000 23.197934 57.956250 19220 2 0.000000 -1 2.500000 60.844000 23.197934 57.956250 19221 2 0.000000 1 2.500000 53.956000 21.872338 61.468750 -19222 2 0.000000 -1.000000 2.500000 53.956000 21.872338 61.468750 +19222 2 0.000000 -1 2.500000 53.956000 21.872338 61.468750 19223 2 0.000000 1 2.500000 56.252000 17.895549 61.468750 19224 2 0.000000 -1 2.500000 56.252000 17.895549 61.468750 19225 2 0.000000 1 2.500000 58.548000 27.174722 1.756250 @@ -19243,7 +19243,7 @@ Atoms 19227 2 0.000000 1 2.500000 60.844000 31.151511 1.756250 19228 2 0.000000 -1 2.500000 60.844000 31.151511 1.756250 19229 2 0.000000 1 2.500000 53.956000 29.825915 5.268750 -19230 2 0.000000 -1.000000 2.500000 53.956000 29.825915 5.268750 +19230 2 0.000000 -1 2.500000 53.956000 29.825915 5.268750 19231 2 0.000000 1 2.500000 56.252000 25.849126 5.268750 19232 2 0.000000 -1 2.500000 56.252000 25.849126 5.268750 19233 2 0.000000 1 2.500000 58.548000 27.174722 8.781250 @@ -19251,7 +19251,7 @@ Atoms 19235 2 0.000000 1 2.500000 60.844000 31.151511 8.781250 19236 2 0.000000 -1 2.500000 60.844000 31.151511 8.781250 19237 2 0.000000 1 2.500000 53.956000 29.825915 12.293750 -19238 2 0.000000 -1.000000 2.500000 53.956000 29.825915 12.293750 +19238 2 0.000000 -1 2.500000 53.956000 29.825915 12.293750 19239 2 0.000000 1 2.500000 56.252000 25.849126 12.293750 19240 2 0.000000 -1 2.500000 56.252000 25.849126 12.293750 19241 2 0.000000 1 2.500000 58.548000 27.174722 15.806250 @@ -19259,7 +19259,7 @@ Atoms 19243 2 0.000000 1 2.500000 60.844000 31.151511 15.806250 19244 2 0.000000 -1 2.500000 60.844000 31.151511 15.806250 19245 2 0.000000 1 2.500000 53.956000 29.825915 19.318750 -19246 2 0.000000 -1.000000 2.500000 53.956000 29.825915 19.318750 +19246 2 0.000000 -1 2.500000 53.956000 29.825915 19.318750 19247 2 0.000000 1 2.500000 56.252000 25.849126 19.318750 19248 2 0.000000 -1 2.500000 56.252000 25.849126 19.318750 19249 2 0.000000 1 2.500000 58.548000 27.174722 22.831250 @@ -19267,7 +19267,7 @@ Atoms 19251 2 0.000000 1 2.500000 60.844000 31.151511 22.831250 19252 2 0.000000 -1 2.500000 60.844000 31.151511 22.831250 19253 2 0.000000 1 2.500000 53.956000 29.825915 26.343750 -19254 2 0.000000 -1.000000 2.500000 53.956000 29.825915 26.343750 +19254 2 0.000000 -1 2.500000 53.956000 29.825915 26.343750 19255 2 0.000000 1 2.500000 56.252000 25.849126 26.343750 19256 2 0.000000 -1 2.500000 56.252000 25.849126 26.343750 19257 2 0.000000 1 2.500000 58.548000 27.174722 29.856250 @@ -19275,7 +19275,7 @@ Atoms 19259 2 0.000000 1 2.500000 60.844000 31.151511 29.856250 19260 2 0.000000 -1 2.500000 60.844000 31.151511 29.856250 19261 2 0.000000 1 2.500000 53.956000 29.825915 33.368750 -19262 2 0.000000 -1.000000 2.500000 53.956000 29.825915 33.368750 +19262 2 0.000000 -1 2.500000 53.956000 29.825915 33.368750 19263 2 0.000000 1 2.500000 56.252000 25.849126 33.368750 19264 2 0.000000 -1 2.500000 56.252000 25.849126 33.368750 19265 2 0.000000 1 2.500000 58.548000 27.174722 36.881250 @@ -19283,7 +19283,7 @@ Atoms 19267 2 0.000000 1 2.500000 60.844000 31.151511 36.881250 19268 2 0.000000 -1 2.500000 60.844000 31.151511 36.881250 19269 2 0.000000 1 2.500000 53.956000 29.825915 40.393750 -19270 2 0.000000 -1.000000 2.500000 53.956000 29.825915 40.393750 +19270 2 0.000000 -1 2.500000 53.956000 29.825915 40.393750 19271 2 0.000000 1 2.500000 56.252000 25.849126 40.393750 19272 2 0.000000 -1 2.500000 56.252000 25.849126 40.393750 19273 2 0.000000 1 2.500000 58.548000 27.174722 43.906250 @@ -19291,7 +19291,7 @@ Atoms 19275 2 0.000000 1 2.500000 60.844000 31.151511 43.906250 19276 2 0.000000 -1 2.500000 60.844000 31.151511 43.906250 19277 2 0.000000 1 2.500000 53.956000 29.825915 47.418750 -19278 2 0.000000 -1.000000 2.500000 53.956000 29.825915 47.418750 +19278 2 0.000000 -1 2.500000 53.956000 29.825915 47.418750 19279 2 0.000000 1 2.500000 56.252000 25.849126 47.418750 19280 2 0.000000 -1 2.500000 56.252000 25.849126 47.418750 19281 2 0.000000 1 2.500000 58.548000 27.174722 50.931250 @@ -19299,7 +19299,7 @@ Atoms 19283 2 0.000000 1 2.500000 60.844000 31.151511 50.931250 19284 2 0.000000 -1 2.500000 60.844000 31.151511 50.931250 19285 2 0.000000 1 2.500000 53.956000 29.825915 54.443750 -19286 2 0.000000 -1.000000 2.500000 53.956000 29.825915 54.443750 +19286 2 0.000000 -1 2.500000 53.956000 29.825915 54.443750 19287 2 0.000000 1 2.500000 56.252000 25.849126 54.443750 19288 2 0.000000 -1 2.500000 56.252000 25.849126 54.443750 19289 2 0.000000 1 2.500000 58.548000 27.174722 57.956250 @@ -19307,7 +19307,7 @@ Atoms 19291 2 0.000000 1 2.500000 60.844000 31.151511 57.956250 19292 2 0.000000 -1 2.500000 60.844000 31.151511 57.956250 19293 2 0.000000 1 2.500000 53.956000 29.825915 61.468750 -19294 2 0.000000 -1.000000 2.500000 53.956000 29.825915 61.468750 +19294 2 0.000000 -1 2.500000 53.956000 29.825915 61.468750 19295 2 0.000000 1 2.500000 56.252000 25.849126 61.468750 19296 2 0.000000 -1 2.500000 56.252000 25.849126 61.468750 19297 2 0.000000 1 2.500000 58.548000 35.128300 1.756250 @@ -19315,7 +19315,7 @@ Atoms 19299 2 0.000000 1 2.500000 60.844000 39.105088 1.756250 19300 2 0.000000 -1 2.500000 60.844000 39.105088 1.756250 19301 2 0.000000 1 2.500000 53.956000 37.779492 5.268750 -19302 2 0.000000 -1.000000 2.500000 53.956000 37.779492 5.268750 +19302 2 0.000000 -1 2.500000 53.956000 37.779492 5.268750 19303 2 0.000000 1 2.500000 56.252000 33.802704 5.268750 19304 2 0.000000 -1 2.500000 56.252000 33.802704 5.268750 19305 2 0.000000 1 2.500000 58.548000 35.128300 8.781250 @@ -19323,7 +19323,7 @@ Atoms 19307 2 0.000000 1 2.500000 60.844000 39.105088 8.781250 19308 2 0.000000 -1 2.500000 60.844000 39.105088 8.781250 19309 2 0.000000 1 2.500000 53.956000 37.779492 12.293750 -19310 2 0.000000 -1.000000 2.500000 53.956000 37.779492 12.293750 +19310 2 0.000000 -1 2.500000 53.956000 37.779492 12.293750 19311 2 0.000000 1 2.500000 56.252000 33.802704 12.293750 19312 2 0.000000 -1 2.500000 56.252000 33.802704 12.293750 19313 2 0.000000 1 2.500000 58.548000 35.128300 15.806250 @@ -19331,7 +19331,7 @@ Atoms 19315 2 0.000000 1 2.500000 60.844000 39.105088 15.806250 19316 2 0.000000 -1 2.500000 60.844000 39.105088 15.806250 19317 2 0.000000 1 2.500000 53.956000 37.779492 19.318750 -19318 2 0.000000 -1.000000 2.500000 53.956000 37.779492 19.318750 +19318 2 0.000000 -1 2.500000 53.956000 37.779492 19.318750 19319 2 0.000000 1 2.500000 56.252000 33.802704 19.318750 19320 2 0.000000 -1 2.500000 56.252000 33.802704 19.318750 19321 2 0.000000 1 2.500000 58.548000 35.128300 22.831250 @@ -19339,7 +19339,7 @@ Atoms 19323 2 0.000000 1 2.500000 60.844000 39.105088 22.831250 19324 2 0.000000 -1 2.500000 60.844000 39.105088 22.831250 19325 2 0.000000 1 2.500000 53.956000 37.779492 26.343750 -19326 2 0.000000 -1.000000 2.500000 53.956000 37.779492 26.343750 +19326 2 0.000000 -1 2.500000 53.956000 37.779492 26.343750 19327 2 0.000000 1 2.500000 56.252000 33.802704 26.343750 19328 2 0.000000 -1 2.500000 56.252000 33.802704 26.343750 19329 2 0.000000 1 2.500000 58.548000 35.128300 29.856250 @@ -19347,7 +19347,7 @@ Atoms 19331 2 0.000000 1 2.500000 60.844000 39.105088 29.856250 19332 2 0.000000 -1 2.500000 60.844000 39.105088 29.856250 19333 2 0.000000 1 2.500000 53.956000 37.779492 33.368750 -19334 2 0.000000 -1.000000 2.500000 53.956000 37.779492 33.368750 +19334 2 0.000000 -1 2.500000 53.956000 37.779492 33.368750 19335 2 0.000000 1 2.500000 56.252000 33.802704 33.368750 19336 2 0.000000 -1 2.500000 56.252000 33.802704 33.368750 19337 2 0.000000 1 2.500000 58.548000 35.128300 36.881250 @@ -19355,7 +19355,7 @@ Atoms 19339 2 0.000000 1 2.500000 60.844000 39.105088 36.881250 19340 2 0.000000 -1 2.500000 60.844000 39.105088 36.881250 19341 2 0.000000 1 2.500000 53.956000 37.779492 40.393750 -19342 2 0.000000 -1.000000 2.500000 53.956000 37.779492 40.393750 +19342 2 0.000000 -1 2.500000 53.956000 37.779492 40.393750 19343 2 0.000000 1 2.500000 56.252000 33.802704 40.393750 19344 2 0.000000 -1 2.500000 56.252000 33.802704 40.393750 19345 2 0.000000 1 2.500000 58.548000 35.128300 43.906250 @@ -19363,7 +19363,7 @@ Atoms 19347 2 0.000000 1 2.500000 60.844000 39.105088 43.906250 19348 2 0.000000 -1 2.500000 60.844000 39.105088 43.906250 19349 2 0.000000 1 2.500000 53.956000 37.779492 47.418750 -19350 2 0.000000 -1.000000 2.500000 53.956000 37.779492 47.418750 +19350 2 0.000000 -1 2.500000 53.956000 37.779492 47.418750 19351 2 0.000000 1 2.500000 56.252000 33.802704 47.418750 19352 2 0.000000 -1 2.500000 56.252000 33.802704 47.418750 19353 2 0.000000 1 2.500000 58.548000 35.128300 50.931250 @@ -19371,7 +19371,7 @@ Atoms 19355 2 0.000000 1 2.500000 60.844000 39.105088 50.931250 19356 2 0.000000 -1 2.500000 60.844000 39.105088 50.931250 19357 2 0.000000 1 2.500000 53.956000 37.779492 54.443750 -19358 2 0.000000 -1.000000 2.500000 53.956000 37.779492 54.443750 +19358 2 0.000000 -1 2.500000 53.956000 37.779492 54.443750 19359 2 0.000000 1 2.500000 56.252000 33.802704 54.443750 19360 2 0.000000 -1 2.500000 56.252000 33.802704 54.443750 19361 2 0.000000 1 2.500000 58.548000 35.128300 57.956250 @@ -19379,7 +19379,7 @@ Atoms 19363 2 0.000000 1 2.500000 60.844000 39.105088 57.956250 19364 2 0.000000 -1 2.500000 60.844000 39.105088 57.956250 19365 2 0.000000 1 2.500000 53.956000 37.779492 61.468750 -19366 2 0.000000 -1.000000 2.500000 53.956000 37.779492 61.468750 +19366 2 0.000000 -1 2.500000 53.956000 37.779492 61.468750 19367 2 0.000000 1 2.500000 56.252000 33.802704 61.468750 19368 2 0.000000 -1 2.500000 56.252000 33.802704 61.468750 19369 2 0.000000 1 2.500000 58.548000 43.081877 1.756250 @@ -19387,7 +19387,7 @@ Atoms 19371 2 0.000000 1 2.500000 60.844000 47.058666 1.756250 19372 2 0.000000 -1 2.500000 60.844000 47.058666 1.756250 19373 2 0.000000 1 2.500000 53.956000 45.733070 5.268750 -19374 2 0.000000 -1.000000 2.500000 53.956000 45.733070 5.268750 +19374 2 0.000000 -1 2.500000 53.956000 45.733070 5.268750 19375 2 0.000000 1 2.500000 56.252000 41.756281 5.268750 19376 2 0.000000 -1 2.500000 56.252000 41.756281 5.268750 19377 2 0.000000 1 2.500000 58.548000 43.081877 8.781250 @@ -19395,7 +19395,7 @@ Atoms 19379 2 0.000000 1 2.500000 60.844000 47.058666 8.781250 19380 2 0.000000 -1 2.500000 60.844000 47.058666 8.781250 19381 2 0.000000 1 2.500000 53.956000 45.733070 12.293750 -19382 2 0.000000 -1.000000 2.500000 53.956000 45.733070 12.293750 +19382 2 0.000000 -1 2.500000 53.956000 45.733070 12.293750 19383 2 0.000000 1 2.500000 56.252000 41.756281 12.293750 19384 2 0.000000 -1 2.500000 56.252000 41.756281 12.293750 19385 2 0.000000 1 2.500000 58.548000 43.081877 15.806250 @@ -19403,7 +19403,7 @@ Atoms 19387 2 0.000000 1 2.500000 60.844000 47.058666 15.806250 19388 2 0.000000 -1 2.500000 60.844000 47.058666 15.806250 19389 2 0.000000 1 2.500000 53.956000 45.733070 19.318750 -19390 2 0.000000 -1.000000 2.500000 53.956000 45.733070 19.318750 +19390 2 0.000000 -1 2.500000 53.956000 45.733070 19.318750 19391 2 0.000000 1 2.500000 56.252000 41.756281 19.318750 19392 2 0.000000 -1 2.500000 56.252000 41.756281 19.318750 19393 2 0.000000 1 2.500000 58.548000 43.081877 22.831250 @@ -19411,7 +19411,7 @@ Atoms 19395 2 0.000000 1 2.500000 60.844000 47.058666 22.831250 19396 2 0.000000 -1 2.500000 60.844000 47.058666 22.831250 19397 2 0.000000 1 2.500000 53.956000 45.733070 26.343750 -19398 2 0.000000 -1.000000 2.500000 53.956000 45.733070 26.343750 +19398 2 0.000000 -1 2.500000 53.956000 45.733070 26.343750 19399 2 0.000000 1 2.500000 56.252000 41.756281 26.343750 19400 2 0.000000 -1 2.500000 56.252000 41.756281 26.343750 19401 2 0.000000 1 2.500000 58.548000 43.081877 29.856250 @@ -19419,7 +19419,7 @@ Atoms 19403 2 0.000000 1 2.500000 60.844000 47.058666 29.856250 19404 2 0.000000 -1 2.500000 60.844000 47.058666 29.856250 19405 2 0.000000 1 2.500000 53.956000 45.733070 33.368750 -19406 2 0.000000 -1.000000 2.500000 53.956000 45.733070 33.368750 +19406 2 0.000000 -1 2.500000 53.956000 45.733070 33.368750 19407 2 0.000000 1 2.500000 56.252000 41.756281 33.368750 19408 2 0.000000 -1 2.500000 56.252000 41.756281 33.368750 19409 2 0.000000 1 2.500000 58.548000 43.081877 36.881250 @@ -19427,7 +19427,7 @@ Atoms 19411 2 0.000000 1 2.500000 60.844000 47.058666 36.881250 19412 2 0.000000 -1 2.500000 60.844000 47.058666 36.881250 19413 2 0.000000 1 2.500000 53.956000 45.733070 40.393750 -19414 2 0.000000 -1.000000 2.500000 53.956000 45.733070 40.393750 +19414 2 0.000000 -1 2.500000 53.956000 45.733070 40.393750 19415 2 0.000000 1 2.500000 56.252000 41.756281 40.393750 19416 2 0.000000 -1 2.500000 56.252000 41.756281 40.393750 19417 2 0.000000 1 2.500000 58.548000 43.081877 43.906250 @@ -19435,7 +19435,7 @@ Atoms 19419 2 0.000000 1 2.500000 60.844000 47.058666 43.906250 19420 2 0.000000 -1 2.500000 60.844000 47.058666 43.906250 19421 2 0.000000 1 2.500000 53.956000 45.733070 47.418750 -19422 2 0.000000 -1.000000 2.500000 53.956000 45.733070 47.418750 +19422 2 0.000000 -1 2.500000 53.956000 45.733070 47.418750 19423 2 0.000000 1 2.500000 56.252000 41.756281 47.418750 19424 2 0.000000 -1 2.500000 56.252000 41.756281 47.418750 19425 2 0.000000 1 2.500000 58.548000 43.081877 50.931250 @@ -19443,7 +19443,7 @@ Atoms 19427 2 0.000000 1 2.500000 60.844000 47.058666 50.931250 19428 2 0.000000 -1 2.500000 60.844000 47.058666 50.931250 19429 2 0.000000 1 2.500000 53.956000 45.733070 54.443750 -19430 2 0.000000 -1.000000 2.500000 53.956000 45.733070 54.443750 +19430 2 0.000000 -1 2.500000 53.956000 45.733070 54.443750 19431 2 0.000000 1 2.500000 56.252000 41.756281 54.443750 19432 2 0.000000 -1 2.500000 56.252000 41.756281 54.443750 19433 2 0.000000 1 2.500000 58.548000 43.081877 57.956250 @@ -19451,7 +19451,7 @@ Atoms 19435 2 0.000000 1 2.500000 60.844000 47.058666 57.956250 19436 2 0.000000 -1 2.500000 60.844000 47.058666 57.956250 19437 2 0.000000 1 2.500000 53.956000 45.733070 61.468750 -19438 2 0.000000 -1.000000 2.500000 53.956000 45.733070 61.468750 +19438 2 0.000000 -1 2.500000 53.956000 45.733070 61.468750 19439 2 0.000000 1 2.500000 56.252000 41.756281 61.468750 19440 2 0.000000 -1 2.500000 56.252000 41.756281 61.468750 19441 2 0.000000 1 2.500000 58.548000 51.035454 1.756250 @@ -19459,7 +19459,7 @@ Atoms 19443 2 0.000000 1 2.500000 60.844000 55.012243 1.756250 19444 2 0.000000 -1 2.500000 60.844000 55.012243 1.756250 19445 2 0.000000 1 2.500000 53.956000 53.686647 5.268750 -19446 2 0.000000 -1.000000 2.500000 53.956000 53.686647 5.268750 +19446 2 0.000000 -1 2.500000 53.956000 53.686647 5.268750 19447 2 0.000000 1 2.500000 56.252000 49.709858 5.268750 19448 2 0.000000 -1 2.500000 56.252000 49.709858 5.268750 19449 2 0.000000 1 2.500000 58.548000 51.035454 8.781250 @@ -19467,7 +19467,7 @@ Atoms 19451 2 0.000000 1 2.500000 60.844000 55.012243 8.781250 19452 2 0.000000 -1 2.500000 60.844000 55.012243 8.781250 19453 2 0.000000 1 2.500000 53.956000 53.686647 12.293750 -19454 2 0.000000 -1.000000 2.500000 53.956000 53.686647 12.293750 +19454 2 0.000000 -1 2.500000 53.956000 53.686647 12.293750 19455 2 0.000000 1 2.500000 56.252000 49.709858 12.293750 19456 2 0.000000 -1 2.500000 56.252000 49.709858 12.293750 19457 2 0.000000 1 2.500000 58.548000 51.035454 15.806250 @@ -19475,7 +19475,7 @@ Atoms 19459 2 0.000000 1 2.500000 60.844000 55.012243 15.806250 19460 2 0.000000 -1 2.500000 60.844000 55.012243 15.806250 19461 2 0.000000 1 2.500000 53.956000 53.686647 19.318750 -19462 2 0.000000 -1.000000 2.500000 53.956000 53.686647 19.318750 +19462 2 0.000000 -1 2.500000 53.956000 53.686647 19.318750 19463 2 0.000000 1 2.500000 56.252000 49.709858 19.318750 19464 2 0.000000 -1 2.500000 56.252000 49.709858 19.318750 19465 2 0.000000 1 2.500000 58.548000 51.035454 22.831250 @@ -19483,7 +19483,7 @@ Atoms 19467 2 0.000000 1 2.500000 60.844000 55.012243 22.831250 19468 2 0.000000 -1 2.500000 60.844000 55.012243 22.831250 19469 2 0.000000 1 2.500000 53.956000 53.686647 26.343750 -19470 2 0.000000 -1.000000 2.500000 53.956000 53.686647 26.343750 +19470 2 0.000000 -1 2.500000 53.956000 53.686647 26.343750 19471 2 0.000000 1 2.500000 56.252000 49.709858 26.343750 19472 2 0.000000 -1 2.500000 56.252000 49.709858 26.343750 19473 2 0.000000 1 2.500000 58.548000 51.035454 29.856250 @@ -19491,7 +19491,7 @@ Atoms 19475 2 0.000000 1 2.500000 60.844000 55.012243 29.856250 19476 2 0.000000 -1 2.500000 60.844000 55.012243 29.856250 19477 2 0.000000 1 2.500000 53.956000 53.686647 33.368750 -19478 2 0.000000 -1.000000 2.500000 53.956000 53.686647 33.368750 +19478 2 0.000000 -1 2.500000 53.956000 53.686647 33.368750 19479 2 0.000000 1 2.500000 56.252000 49.709858 33.368750 19480 2 0.000000 -1 2.500000 56.252000 49.709858 33.368750 19481 2 0.000000 1 2.500000 58.548000 51.035454 36.881250 @@ -19499,7 +19499,7 @@ Atoms 19483 2 0.000000 1 2.500000 60.844000 55.012243 36.881250 19484 2 0.000000 -1 2.500000 60.844000 55.012243 36.881250 19485 2 0.000000 1 2.500000 53.956000 53.686647 40.393750 -19486 2 0.000000 -1.000000 2.500000 53.956000 53.686647 40.393750 +19486 2 0.000000 -1 2.500000 53.956000 53.686647 40.393750 19487 2 0.000000 1 2.500000 56.252000 49.709858 40.393750 19488 2 0.000000 -1 2.500000 56.252000 49.709858 40.393750 19489 2 0.000000 1 2.500000 58.548000 51.035454 43.906250 @@ -19507,7 +19507,7 @@ Atoms 19491 2 0.000000 1 2.500000 60.844000 55.012243 43.906250 19492 2 0.000000 -1 2.500000 60.844000 55.012243 43.906250 19493 2 0.000000 1 2.500000 53.956000 53.686647 47.418750 -19494 2 0.000000 -1.000000 2.500000 53.956000 53.686647 47.418750 +19494 2 0.000000 -1 2.500000 53.956000 53.686647 47.418750 19495 2 0.000000 1 2.500000 56.252000 49.709858 47.418750 19496 2 0.000000 -1 2.500000 56.252000 49.709858 47.418750 19497 2 0.000000 1 2.500000 58.548000 51.035454 50.931250 @@ -19515,7 +19515,7 @@ Atoms 19499 2 0.000000 1 2.500000 60.844000 55.012243 50.931250 19500 2 0.000000 -1 2.500000 60.844000 55.012243 50.931250 19501 2 0.000000 1 2.500000 53.956000 53.686647 54.443750 -19502 2 0.000000 -1.000000 2.500000 53.956000 53.686647 54.443750 +19502 2 0.000000 -1 2.500000 53.956000 53.686647 54.443750 19503 2 0.000000 1 2.500000 56.252000 49.709858 54.443750 19504 2 0.000000 -1 2.500000 56.252000 49.709858 54.443750 19505 2 0.000000 1 2.500000 58.548000 51.035454 57.956250 @@ -19523,7 +19523,7 @@ Atoms 19507 2 0.000000 1 2.500000 60.844000 55.012243 57.956250 19508 2 0.000000 -1 2.500000 60.844000 55.012243 57.956250 19509 2 0.000000 1 2.500000 53.956000 53.686647 61.468750 -19510 2 0.000000 -1.000000 2.500000 53.956000 53.686647 61.468750 +19510 2 0.000000 -1 2.500000 53.956000 53.686647 61.468750 19511 2 0.000000 1 2.500000 56.252000 49.709858 61.468750 19512 2 0.000000 -1 2.500000 56.252000 49.709858 61.468750 19513 2 0.000000 1 2.500000 58.548000 58.989032 1.756250 @@ -19531,7 +19531,7 @@ Atoms 19515 2 0.000000 1 2.500000 60.844000 62.965820 1.756250 19516 2 0.000000 -1 2.500000 60.844000 62.965820 1.756250 19517 2 0.000000 1 2.500000 53.956000 61.640224 5.268750 -19518 2 0.000000 -1.000000 2.500000 53.956000 61.640224 5.268750 +19518 2 0.000000 -1 2.500000 53.956000 61.640224 5.268750 19519 2 0.000000 1 2.500000 56.252000 57.663435 5.268750 19520 2 0.000000 -1 2.500000 56.252000 57.663435 5.268750 19521 2 0.000000 1 2.500000 58.548000 58.989032 8.781250 @@ -19539,7 +19539,7 @@ Atoms 19523 2 0.000000 1 2.500000 60.844000 62.965820 8.781250 19524 2 0.000000 -1 2.500000 60.844000 62.965820 8.781250 19525 2 0.000000 1 2.500000 53.956000 61.640224 12.293750 -19526 2 0.000000 -1.000000 2.500000 53.956000 61.640224 12.293750 +19526 2 0.000000 -1 2.500000 53.956000 61.640224 12.293750 19527 2 0.000000 1 2.500000 56.252000 57.663435 12.293750 19528 2 0.000000 -1 2.500000 56.252000 57.663435 12.293750 19529 2 0.000000 1 2.500000 58.548000 58.989032 15.806250 @@ -19547,7 +19547,7 @@ Atoms 19531 2 0.000000 1 2.500000 60.844000 62.965820 15.806250 19532 2 0.000000 -1 2.500000 60.844000 62.965820 15.806250 19533 2 0.000000 1 2.500000 53.956000 61.640224 19.318750 -19534 2 0.000000 -1.000000 2.500000 53.956000 61.640224 19.318750 +19534 2 0.000000 -1 2.500000 53.956000 61.640224 19.318750 19535 2 0.000000 1 2.500000 56.252000 57.663435 19.318750 19536 2 0.000000 -1 2.500000 56.252000 57.663435 19.318750 19537 2 0.000000 1 2.500000 58.548000 58.989032 22.831250 @@ -19555,7 +19555,7 @@ Atoms 19539 2 0.000000 1 2.500000 60.844000 62.965820 22.831250 19540 2 0.000000 -1 2.500000 60.844000 62.965820 22.831250 19541 2 0.000000 1 2.500000 53.956000 61.640224 26.343750 -19542 2 0.000000 -1.000000 2.500000 53.956000 61.640224 26.343750 +19542 2 0.000000 -1 2.500000 53.956000 61.640224 26.343750 19543 2 0.000000 1 2.500000 56.252000 57.663435 26.343750 19544 2 0.000000 -1 2.500000 56.252000 57.663435 26.343750 19545 2 0.000000 1 2.500000 58.548000 58.989032 29.856250 @@ -19563,7 +19563,7 @@ Atoms 19547 2 0.000000 1 2.500000 60.844000 62.965820 29.856250 19548 2 0.000000 -1 2.500000 60.844000 62.965820 29.856250 19549 2 0.000000 1 2.500000 53.956000 61.640224 33.368750 -19550 2 0.000000 -1.000000 2.500000 53.956000 61.640224 33.368750 +19550 2 0.000000 -1 2.500000 53.956000 61.640224 33.368750 19551 2 0.000000 1 2.500000 56.252000 57.663435 33.368750 19552 2 0.000000 -1 2.500000 56.252000 57.663435 33.368750 19553 2 0.000000 1 2.500000 58.548000 58.989032 36.881250 @@ -19571,7 +19571,7 @@ Atoms 19555 2 0.000000 1 2.500000 60.844000 62.965820 36.881250 19556 2 0.000000 -1 2.500000 60.844000 62.965820 36.881250 19557 2 0.000000 1 2.500000 53.956000 61.640224 40.393750 -19558 2 0.000000 -1.000000 2.500000 53.956000 61.640224 40.393750 +19558 2 0.000000 -1 2.500000 53.956000 61.640224 40.393750 19559 2 0.000000 1 2.500000 56.252000 57.663435 40.393750 19560 2 0.000000 -1 2.500000 56.252000 57.663435 40.393750 19561 2 0.000000 1 2.500000 58.548000 58.989032 43.906250 @@ -19579,7 +19579,7 @@ Atoms 19563 2 0.000000 1 2.500000 60.844000 62.965820 43.906250 19564 2 0.000000 -1 2.500000 60.844000 62.965820 43.906250 19565 2 0.000000 1 2.500000 53.956000 61.640224 47.418750 -19566 2 0.000000 -1.000000 2.500000 53.956000 61.640224 47.418750 +19566 2 0.000000 -1 2.500000 53.956000 61.640224 47.418750 19567 2 0.000000 1 2.500000 56.252000 57.663435 47.418750 19568 2 0.000000 -1 2.500000 56.252000 57.663435 47.418750 19569 2 0.000000 1 2.500000 58.548000 58.989032 50.931250 @@ -19587,7 +19587,7 @@ Atoms 19571 2 0.000000 1 2.500000 60.844000 62.965820 50.931250 19572 2 0.000000 -1 2.500000 60.844000 62.965820 50.931250 19573 2 0.000000 1 2.500000 53.956000 61.640224 54.443750 -19574 2 0.000000 -1.000000 2.500000 53.956000 61.640224 54.443750 +19574 2 0.000000 -1 2.500000 53.956000 61.640224 54.443750 19575 2 0.000000 1 2.500000 56.252000 57.663435 54.443750 19576 2 0.000000 -1 2.500000 56.252000 57.663435 54.443750 19577 2 0.000000 1 2.500000 58.548000 58.989032 57.956250 @@ -19595,7 +19595,7 @@ Atoms 19579 2 0.000000 1 2.500000 60.844000 62.965820 57.956250 19580 2 0.000000 -1 2.500000 60.844000 62.965820 57.956250 19581 2 0.000000 1 2.500000 53.956000 61.640224 61.468750 -19582 2 0.000000 -1.000000 2.500000 53.956000 61.640224 61.468750 +19582 2 0.000000 -1 2.500000 53.956000 61.640224 61.468750 19583 2 0.000000 1 2.500000 56.252000 57.663435 61.468750 19584 2 0.000000 -1 2.500000 56.252000 57.663435 61.468750 19585 2 0.000000 1 2.500000 63.140000 3.313991 1.756250 @@ -19603,7 +19603,7 @@ Atoms 19587 2 0.000000 1 2.500000 1.148000 7.290779 1.756250 19588 2 0.000000 -1 2.500000 1.148000 7.290779 1.756250 19589 2 0.000000 1 2.500000 58.548000 5.965183 5.268750 -19590 2 0.000000 -1.000000 2.500000 58.548000 5.965183 5.268750 +19590 2 0.000000 -1 2.500000 58.548000 5.965183 5.268750 19591 2 0.000000 1 2.500000 60.844000 1.988394 5.268750 19592 2 0.000000 -1 2.500000 60.844000 1.988394 5.268750 19593 2 0.000000 1 2.500000 63.140000 3.313991 8.781250 @@ -19611,7 +19611,7 @@ Atoms 19595 2 0.000000 1 2.500000 1.148000 7.290779 8.781250 19596 2 0.000000 -1 2.500000 1.148000 7.290779 8.781250 19597 2 0.000000 1 2.500000 58.548000 5.965183 12.293750 -19598 2 0.000000 -1.000000 2.500000 58.548000 5.965183 12.293750 +19598 2 0.000000 -1 2.500000 58.548000 5.965183 12.293750 19599 2 0.000000 1 2.500000 60.844000 1.988394 12.293750 19600 2 0.000000 -1 2.500000 60.844000 1.988394 12.293750 19601 2 0.000000 1 2.500000 63.140000 3.313991 15.806250 @@ -19619,7 +19619,7 @@ Atoms 19603 2 0.000000 1 2.500000 1.148000 7.290779 15.806250 19604 2 0.000000 -1 2.500000 1.148000 7.290779 15.806250 19605 2 0.000000 1 2.500000 58.548000 5.965183 19.318750 -19606 2 0.000000 -1.000000 2.500000 58.548000 5.965183 19.318750 +19606 2 0.000000 -1 2.500000 58.548000 5.965183 19.318750 19607 2 0.000000 1 2.500000 60.844000 1.988394 19.318750 19608 2 0.000000 -1 2.500000 60.844000 1.988394 19.318750 19609 2 0.000000 1 2.500000 63.140000 3.313991 22.831250 @@ -19627,7 +19627,7 @@ Atoms 19611 2 0.000000 1 2.500000 1.148000 7.290779 22.831250 19612 2 0.000000 -1 2.500000 1.148000 7.290779 22.831250 19613 2 0.000000 1 2.500000 58.548000 5.965183 26.343750 -19614 2 0.000000 -1.000000 2.500000 58.548000 5.965183 26.343750 +19614 2 0.000000 -1 2.500000 58.548000 5.965183 26.343750 19615 2 0.000000 1 2.500000 60.844000 1.988394 26.343750 19616 2 0.000000 -1 2.500000 60.844000 1.988394 26.343750 19617 2 0.000000 1 2.500000 63.140000 3.313991 29.856250 @@ -19635,7 +19635,7 @@ Atoms 19619 2 0.000000 1 2.500000 1.148000 7.290779 29.856250 19620 2 0.000000 -1 2.500000 1.148000 7.290779 29.856250 19621 2 0.000000 1 2.500000 58.548000 5.965183 33.368750 -19622 2 0.000000 -1.000000 2.500000 58.548000 5.965183 33.368750 +19622 2 0.000000 -1 2.500000 58.548000 5.965183 33.368750 19623 2 0.000000 1 2.500000 60.844000 1.988394 33.368750 19624 2 0.000000 -1 2.500000 60.844000 1.988394 33.368750 19625 2 0.000000 1 2.500000 63.140000 3.313991 36.881250 @@ -19643,7 +19643,7 @@ Atoms 19627 2 0.000000 1 2.500000 1.148000 7.290779 36.881250 19628 2 0.000000 -1 2.500000 1.148000 7.290779 36.881250 19629 2 0.000000 1 2.500000 58.548000 5.965183 40.393750 -19630 2 0.000000 -1.000000 2.500000 58.548000 5.965183 40.393750 +19630 2 0.000000 -1 2.500000 58.548000 5.965183 40.393750 19631 2 0.000000 1 2.500000 60.844000 1.988394 40.393750 19632 2 0.000000 -1 2.500000 60.844000 1.988394 40.393750 19633 2 0.000000 1 2.500000 63.140000 3.313991 43.906250 @@ -19651,7 +19651,7 @@ Atoms 19635 2 0.000000 1 2.500000 1.148000 7.290779 43.906250 19636 2 0.000000 -1 2.500000 1.148000 7.290779 43.906250 19637 2 0.000000 1 2.500000 58.548000 5.965183 47.418750 -19638 2 0.000000 -1.000000 2.500000 58.548000 5.965183 47.418750 +19638 2 0.000000 -1 2.500000 58.548000 5.965183 47.418750 19639 2 0.000000 1 2.500000 60.844000 1.988394 47.418750 19640 2 0.000000 -1 2.500000 60.844000 1.988394 47.418750 19641 2 0.000000 1 2.500000 63.140000 3.313991 50.931250 @@ -19659,7 +19659,7 @@ Atoms 19643 2 0.000000 1 2.500000 1.148000 7.290779 50.931250 19644 2 0.000000 -1 2.500000 1.148000 7.290779 50.931250 19645 2 0.000000 1 2.500000 58.548000 5.965183 54.443750 -19646 2 0.000000 -1.000000 2.500000 58.548000 5.965183 54.443750 +19646 2 0.000000 -1 2.500000 58.548000 5.965183 54.443750 19647 2 0.000000 1 2.500000 60.844000 1.988394 54.443750 19648 2 0.000000 -1 2.500000 60.844000 1.988394 54.443750 19649 2 0.000000 1 2.500000 63.140000 3.313991 57.956250 @@ -19667,7 +19667,7 @@ Atoms 19651 2 0.000000 1 2.500000 1.148000 7.290779 57.956250 19652 2 0.000000 -1 2.500000 1.148000 7.290779 57.956250 19653 2 0.000000 1 2.500000 58.548000 5.965183 61.468750 -19654 2 0.000000 -1.000000 2.500000 58.548000 5.965183 61.468750 +19654 2 0.000000 -1 2.500000 58.548000 5.965183 61.468750 19655 2 0.000000 1 2.500000 60.844000 1.988394 61.468750 19656 2 0.000000 -1 2.500000 60.844000 1.988394 61.468750 19657 2 0.000000 1 2.500000 63.140000 11.267568 1.756250 @@ -19675,7 +19675,7 @@ Atoms 19659 2 0.000000 1 2.500000 1.148000 15.244357 1.756250 19660 2 0.000000 -1 2.500000 1.148000 15.244357 1.756250 19661 2 0.000000 1 2.500000 58.548000 13.918760 5.268750 -19662 2 0.000000 -1.000000 2.500000 58.548000 13.918760 5.268750 +19662 2 0.000000 -1 2.500000 58.548000 13.918760 5.268750 19663 2 0.000000 1 2.500000 60.844000 9.941972 5.268750 19664 2 0.000000 -1 2.500000 60.844000 9.941972 5.268750 19665 2 0.000000 1 2.500000 63.140000 11.267568 8.781250 @@ -19683,7 +19683,7 @@ Atoms 19667 2 0.000000 1 2.500000 1.148000 15.244357 8.781250 19668 2 0.000000 -1 2.500000 1.148000 15.244357 8.781250 19669 2 0.000000 1 2.500000 58.548000 13.918760 12.293750 -19670 2 0.000000 -1.000000 2.500000 58.548000 13.918760 12.293750 +19670 2 0.000000 -1 2.500000 58.548000 13.918760 12.293750 19671 2 0.000000 1 2.500000 60.844000 9.941972 12.293750 19672 2 0.000000 -1 2.500000 60.844000 9.941972 12.293750 19673 2 0.000000 1 2.500000 63.140000 11.267568 15.806250 @@ -19691,7 +19691,7 @@ Atoms 19675 2 0.000000 1 2.500000 1.148000 15.244357 15.806250 19676 2 0.000000 -1 2.500000 1.148000 15.244357 15.806250 19677 2 0.000000 1 2.500000 58.548000 13.918760 19.318750 -19678 2 0.000000 -1.000000 2.500000 58.548000 13.918760 19.318750 +19678 2 0.000000 -1 2.500000 58.548000 13.918760 19.318750 19679 2 0.000000 1 2.500000 60.844000 9.941972 19.318750 19680 2 0.000000 -1 2.500000 60.844000 9.941972 19.318750 19681 2 0.000000 1 2.500000 63.140000 11.267568 22.831250 @@ -19699,7 +19699,7 @@ Atoms 19683 2 0.000000 1 2.500000 1.148000 15.244357 22.831250 19684 2 0.000000 -1 2.500000 1.148000 15.244357 22.831250 19685 2 0.000000 1 2.500000 58.548000 13.918760 26.343750 -19686 2 0.000000 -1.000000 2.500000 58.548000 13.918760 26.343750 +19686 2 0.000000 -1 2.500000 58.548000 13.918760 26.343750 19687 2 0.000000 1 2.500000 60.844000 9.941972 26.343750 19688 2 0.000000 -1 2.500000 60.844000 9.941972 26.343750 19689 2 0.000000 1 2.500000 63.140000 11.267568 29.856250 @@ -19707,7 +19707,7 @@ Atoms 19691 2 0.000000 1 2.500000 1.148000 15.244357 29.856250 19692 2 0.000000 -1 2.500000 1.148000 15.244357 29.856250 19693 2 0.000000 1 2.500000 58.548000 13.918760 33.368750 -19694 2 0.000000 -1.000000 2.500000 58.548000 13.918760 33.368750 +19694 2 0.000000 -1 2.500000 58.548000 13.918760 33.368750 19695 2 0.000000 1 2.500000 60.844000 9.941972 33.368750 19696 2 0.000000 -1 2.500000 60.844000 9.941972 33.368750 19697 2 0.000000 1 2.500000 63.140000 11.267568 36.881250 @@ -19715,7 +19715,7 @@ Atoms 19699 2 0.000000 1 2.500000 1.148000 15.244357 36.881250 19700 2 0.000000 -1 2.500000 1.148000 15.244357 36.881250 19701 2 0.000000 1 2.500000 58.548000 13.918760 40.393750 -19702 2 0.000000 -1.000000 2.500000 58.548000 13.918760 40.393750 +19702 2 0.000000 -1 2.500000 58.548000 13.918760 40.393750 19703 2 0.000000 1 2.500000 60.844000 9.941972 40.393750 19704 2 0.000000 -1 2.500000 60.844000 9.941972 40.393750 19705 2 0.000000 1 2.500000 63.140000 11.267568 43.906250 @@ -19723,7 +19723,7 @@ Atoms 19707 2 0.000000 1 2.500000 1.148000 15.244357 43.906250 19708 2 0.000000 -1 2.500000 1.148000 15.244357 43.906250 19709 2 0.000000 1 2.500000 58.548000 13.918760 47.418750 -19710 2 0.000000 -1.000000 2.500000 58.548000 13.918760 47.418750 +19710 2 0.000000 -1 2.500000 58.548000 13.918760 47.418750 19711 2 0.000000 1 2.500000 60.844000 9.941972 47.418750 19712 2 0.000000 -1 2.500000 60.844000 9.941972 47.418750 19713 2 0.000000 1 2.500000 63.140000 11.267568 50.931250 @@ -19731,7 +19731,7 @@ Atoms 19715 2 0.000000 1 2.500000 1.148000 15.244357 50.931250 19716 2 0.000000 -1 2.500000 1.148000 15.244357 50.931250 19717 2 0.000000 1 2.500000 58.548000 13.918760 54.443750 -19718 2 0.000000 -1.000000 2.500000 58.548000 13.918760 54.443750 +19718 2 0.000000 -1 2.500000 58.548000 13.918760 54.443750 19719 2 0.000000 1 2.500000 60.844000 9.941972 54.443750 19720 2 0.000000 -1 2.500000 60.844000 9.941972 54.443750 19721 2 0.000000 1 2.500000 63.140000 11.267568 57.956250 @@ -19739,7 +19739,7 @@ Atoms 19723 2 0.000000 1 2.500000 1.148000 15.244357 57.956250 19724 2 0.000000 -1 2.500000 1.148000 15.244357 57.956250 19725 2 0.000000 1 2.500000 58.548000 13.918760 61.468750 -19726 2 0.000000 -1.000000 2.500000 58.548000 13.918760 61.468750 +19726 2 0.000000 -1 2.500000 58.548000 13.918760 61.468750 19727 2 0.000000 1 2.500000 60.844000 9.941972 61.468750 19728 2 0.000000 -1 2.500000 60.844000 9.941972 61.468750 19729 2 0.000000 1 2.500000 63.140000 19.221145 1.756250 @@ -19747,7 +19747,7 @@ Atoms 19731 2 0.000000 1 2.500000 1.148000 23.197934 1.756250 19732 2 0.000000 -1 2.500000 1.148000 23.197934 1.756250 19733 2 0.000000 1 2.500000 58.548000 21.872338 5.268750 -19734 2 0.000000 -1.000000 2.500000 58.548000 21.872338 5.268750 +19734 2 0.000000 -1 2.500000 58.548000 21.872338 5.268750 19735 2 0.000000 1 2.500000 60.844000 17.895549 5.268750 19736 2 0.000000 -1 2.500000 60.844000 17.895549 5.268750 19737 2 0.000000 1 2.500000 63.140000 19.221145 8.781250 @@ -19755,7 +19755,7 @@ Atoms 19739 2 0.000000 1 2.500000 1.148000 23.197934 8.781250 19740 2 0.000000 -1 2.500000 1.148000 23.197934 8.781250 19741 2 0.000000 1 2.500000 58.548000 21.872338 12.293750 -19742 2 0.000000 -1.000000 2.500000 58.548000 21.872338 12.293750 +19742 2 0.000000 -1 2.500000 58.548000 21.872338 12.293750 19743 2 0.000000 1 2.500000 60.844000 17.895549 12.293750 19744 2 0.000000 -1 2.500000 60.844000 17.895549 12.293750 19745 2 0.000000 1 2.500000 63.140000 19.221145 15.806250 @@ -19763,7 +19763,7 @@ Atoms 19747 2 0.000000 1 2.500000 1.148000 23.197934 15.806250 19748 2 0.000000 -1 2.500000 1.148000 23.197934 15.806250 19749 2 0.000000 1 2.500000 58.548000 21.872338 19.318750 -19750 2 0.000000 -1.000000 2.500000 58.548000 21.872338 19.318750 +19750 2 0.000000 -1 2.500000 58.548000 21.872338 19.318750 19751 2 0.000000 1 2.500000 60.844000 17.895549 19.318750 19752 2 0.000000 -1 2.500000 60.844000 17.895549 19.318750 19753 2 0.000000 1 2.500000 63.140000 19.221145 22.831250 @@ -19771,7 +19771,7 @@ Atoms 19755 2 0.000000 1 2.500000 1.148000 23.197934 22.831250 19756 2 0.000000 -1 2.500000 1.148000 23.197934 22.831250 19757 2 0.000000 1 2.500000 58.548000 21.872338 26.343750 -19758 2 0.000000 -1.000000 2.500000 58.548000 21.872338 26.343750 +19758 2 0.000000 -1 2.500000 58.548000 21.872338 26.343750 19759 2 0.000000 1 2.500000 60.844000 17.895549 26.343750 19760 2 0.000000 -1 2.500000 60.844000 17.895549 26.343750 19761 2 0.000000 1 2.500000 63.140000 19.221145 29.856250 @@ -19779,7 +19779,7 @@ Atoms 19763 2 0.000000 1 2.500000 1.148000 23.197934 29.856250 19764 2 0.000000 -1 2.500000 1.148000 23.197934 29.856250 19765 2 0.000000 1 2.500000 58.548000 21.872338 33.368750 -19766 2 0.000000 -1.000000 2.500000 58.548000 21.872338 33.368750 +19766 2 0.000000 -1 2.500000 58.548000 21.872338 33.368750 19767 2 0.000000 1 2.500000 60.844000 17.895549 33.368750 19768 2 0.000000 -1 2.500000 60.844000 17.895549 33.368750 19769 2 0.000000 1 2.500000 63.140000 19.221145 36.881250 @@ -19787,7 +19787,7 @@ Atoms 19771 2 0.000000 1 2.500000 1.148000 23.197934 36.881250 19772 2 0.000000 -1 2.500000 1.148000 23.197934 36.881250 19773 2 0.000000 1 2.500000 58.548000 21.872338 40.393750 -19774 2 0.000000 -1.000000 2.500000 58.548000 21.872338 40.393750 +19774 2 0.000000 -1 2.500000 58.548000 21.872338 40.393750 19775 2 0.000000 1 2.500000 60.844000 17.895549 40.393750 19776 2 0.000000 -1 2.500000 60.844000 17.895549 40.393750 19777 2 0.000000 1 2.500000 63.140000 19.221145 43.906250 @@ -19795,7 +19795,7 @@ Atoms 19779 2 0.000000 1 2.500000 1.148000 23.197934 43.906250 19780 2 0.000000 -1 2.500000 1.148000 23.197934 43.906250 19781 2 0.000000 1 2.500000 58.548000 21.872338 47.418750 -19782 2 0.000000 -1.000000 2.500000 58.548000 21.872338 47.418750 +19782 2 0.000000 -1 2.500000 58.548000 21.872338 47.418750 19783 2 0.000000 1 2.500000 60.844000 17.895549 47.418750 19784 2 0.000000 -1 2.500000 60.844000 17.895549 47.418750 19785 2 0.000000 1 2.500000 63.140000 19.221145 50.931250 @@ -19803,7 +19803,7 @@ Atoms 19787 2 0.000000 1 2.500000 1.148000 23.197934 50.931250 19788 2 0.000000 -1 2.500000 1.148000 23.197934 50.931250 19789 2 0.000000 1 2.500000 58.548000 21.872338 54.443750 -19790 2 0.000000 -1.000000 2.500000 58.548000 21.872338 54.443750 +19790 2 0.000000 -1 2.500000 58.548000 21.872338 54.443750 19791 2 0.000000 1 2.500000 60.844000 17.895549 54.443750 19792 2 0.000000 -1 2.500000 60.844000 17.895549 54.443750 19793 2 0.000000 1 2.500000 63.140000 19.221145 57.956250 @@ -19811,7 +19811,7 @@ Atoms 19795 2 0.000000 1 2.500000 1.148000 23.197934 57.956250 19796 2 0.000000 -1 2.500000 1.148000 23.197934 57.956250 19797 2 0.000000 1 2.500000 58.548000 21.872338 61.468750 -19798 2 0.000000 -1.000000 2.500000 58.548000 21.872338 61.468750 +19798 2 0.000000 -1 2.500000 58.548000 21.872338 61.468750 19799 2 0.000000 1 2.500000 60.844000 17.895549 61.468750 19800 2 0.000000 -1 2.500000 60.844000 17.895549 61.468750 19801 2 0.000000 1 2.500000 63.140000 27.174722 1.756250 @@ -19819,7 +19819,7 @@ Atoms 19803 2 0.000000 1 2.500000 1.148000 31.151511 1.756250 19804 2 0.000000 -1 2.500000 1.148000 31.151511 1.756250 19805 2 0.000000 1 2.500000 58.548000 29.825915 5.268750 -19806 2 0.000000 -1.000000 2.500000 58.548000 29.825915 5.268750 +19806 2 0.000000 -1 2.500000 58.548000 29.825915 5.268750 19807 2 0.000000 1 2.500000 60.844000 25.849126 5.268750 19808 2 0.000000 -1 2.500000 60.844000 25.849126 5.268750 19809 2 0.000000 1 2.500000 63.140000 27.174722 8.781250 @@ -19827,7 +19827,7 @@ Atoms 19811 2 0.000000 1 2.500000 1.148000 31.151511 8.781250 19812 2 0.000000 -1 2.500000 1.148000 31.151511 8.781250 19813 2 0.000000 1 2.500000 58.548000 29.825915 12.293750 -19814 2 0.000000 -1.000000 2.500000 58.548000 29.825915 12.293750 +19814 2 0.000000 -1 2.500000 58.548000 29.825915 12.293750 19815 2 0.000000 1 2.500000 60.844000 25.849126 12.293750 19816 2 0.000000 -1 2.500000 60.844000 25.849126 12.293750 19817 2 0.000000 1 2.500000 63.140000 27.174722 15.806250 @@ -19835,7 +19835,7 @@ Atoms 19819 2 0.000000 1 2.500000 1.148000 31.151511 15.806250 19820 2 0.000000 -1 2.500000 1.148000 31.151511 15.806250 19821 2 0.000000 1 2.500000 58.548000 29.825915 19.318750 -19822 2 0.000000 -1.000000 2.500000 58.548000 29.825915 19.318750 +19822 2 0.000000 -1 2.500000 58.548000 29.825915 19.318750 19823 2 0.000000 1 2.500000 60.844000 25.849126 19.318750 19824 2 0.000000 -1 2.500000 60.844000 25.849126 19.318750 19825 2 0.000000 1 2.500000 63.140000 27.174722 22.831250 @@ -19843,7 +19843,7 @@ Atoms 19827 2 0.000000 1 2.500000 1.148000 31.151511 22.831250 19828 2 0.000000 -1 2.500000 1.148000 31.151511 22.831250 19829 2 0.000000 1 2.500000 58.548000 29.825915 26.343750 -19830 2 0.000000 -1.000000 2.500000 58.548000 29.825915 26.343750 +19830 2 0.000000 -1 2.500000 58.548000 29.825915 26.343750 19831 2 0.000000 1 2.500000 60.844000 25.849126 26.343750 19832 2 0.000000 -1 2.500000 60.844000 25.849126 26.343750 19833 2 0.000000 1 2.500000 63.140000 27.174722 29.856250 @@ -19851,7 +19851,7 @@ Atoms 19835 2 0.000000 1 2.500000 1.148000 31.151511 29.856250 19836 2 0.000000 -1 2.500000 1.148000 31.151511 29.856250 19837 2 0.000000 1 2.500000 58.548000 29.825915 33.368750 -19838 2 0.000000 -1.000000 2.500000 58.548000 29.825915 33.368750 +19838 2 0.000000 -1 2.500000 58.548000 29.825915 33.368750 19839 2 0.000000 1 2.500000 60.844000 25.849126 33.368750 19840 2 0.000000 -1 2.500000 60.844000 25.849126 33.368750 19841 2 0.000000 1 2.500000 63.140000 27.174722 36.881250 @@ -19859,7 +19859,7 @@ Atoms 19843 2 0.000000 1 2.500000 1.148000 31.151511 36.881250 19844 2 0.000000 -1 2.500000 1.148000 31.151511 36.881250 19845 2 0.000000 1 2.500000 58.548000 29.825915 40.393750 -19846 2 0.000000 -1.000000 2.500000 58.548000 29.825915 40.393750 +19846 2 0.000000 -1 2.500000 58.548000 29.825915 40.393750 19847 2 0.000000 1 2.500000 60.844000 25.849126 40.393750 19848 2 0.000000 -1 2.500000 60.844000 25.849126 40.393750 19849 2 0.000000 1 2.500000 63.140000 27.174722 43.906250 @@ -19867,7 +19867,7 @@ Atoms 19851 2 0.000000 1 2.500000 1.148000 31.151511 43.906250 19852 2 0.000000 -1 2.500000 1.148000 31.151511 43.906250 19853 2 0.000000 1 2.500000 58.548000 29.825915 47.418750 -19854 2 0.000000 -1.000000 2.500000 58.548000 29.825915 47.418750 +19854 2 0.000000 -1 2.500000 58.548000 29.825915 47.418750 19855 2 0.000000 1 2.500000 60.844000 25.849126 47.418750 19856 2 0.000000 -1 2.500000 60.844000 25.849126 47.418750 19857 2 0.000000 1 2.500000 63.140000 27.174722 50.931250 @@ -19875,7 +19875,7 @@ Atoms 19859 2 0.000000 1 2.500000 1.148000 31.151511 50.931250 19860 2 0.000000 -1 2.500000 1.148000 31.151511 50.931250 19861 2 0.000000 1 2.500000 58.548000 29.825915 54.443750 -19862 2 0.000000 -1.000000 2.500000 58.548000 29.825915 54.443750 +19862 2 0.000000 -1 2.500000 58.548000 29.825915 54.443750 19863 2 0.000000 1 2.500000 60.844000 25.849126 54.443750 19864 2 0.000000 -1 2.500000 60.844000 25.849126 54.443750 19865 2 0.000000 1 2.500000 63.140000 27.174722 57.956250 @@ -19883,7 +19883,7 @@ Atoms 19867 2 0.000000 1 2.500000 1.148000 31.151511 57.956250 19868 2 0.000000 -1 2.500000 1.148000 31.151511 57.956250 19869 2 0.000000 1 2.500000 58.548000 29.825915 61.468750 -19870 2 0.000000 -1.000000 2.500000 58.548000 29.825915 61.468750 +19870 2 0.000000 -1 2.500000 58.548000 29.825915 61.468750 19871 2 0.000000 1 2.500000 60.844000 25.849126 61.468750 19872 2 0.000000 -1 2.500000 60.844000 25.849126 61.468750 19873 2 0.000000 1 2.500000 63.140000 35.128300 1.756250 @@ -19891,7 +19891,7 @@ Atoms 19875 2 0.000000 1 2.500000 1.148000 39.105088 1.756250 19876 2 0.000000 -1 2.500000 1.148000 39.105088 1.756250 19877 2 0.000000 1 2.500000 58.548000 37.779492 5.268750 -19878 2 0.000000 -1.000000 2.500000 58.548000 37.779492 5.268750 +19878 2 0.000000 -1 2.500000 58.548000 37.779492 5.268750 19879 2 0.000000 1 2.500000 60.844000 33.802704 5.268750 19880 2 0.000000 -1 2.500000 60.844000 33.802704 5.268750 19881 2 0.000000 1 2.500000 63.140000 35.128300 8.781250 @@ -19899,7 +19899,7 @@ Atoms 19883 2 0.000000 1 2.500000 1.148000 39.105088 8.781250 19884 2 0.000000 -1 2.500000 1.148000 39.105088 8.781250 19885 2 0.000000 1 2.500000 58.548000 37.779492 12.293750 -19886 2 0.000000 -1.000000 2.500000 58.548000 37.779492 12.293750 +19886 2 0.000000 -1 2.500000 58.548000 37.779492 12.293750 19887 2 0.000000 1 2.500000 60.844000 33.802704 12.293750 19888 2 0.000000 -1 2.500000 60.844000 33.802704 12.293750 19889 2 0.000000 1 2.500000 63.140000 35.128300 15.806250 @@ -19907,7 +19907,7 @@ Atoms 19891 2 0.000000 1 2.500000 1.148000 39.105088 15.806250 19892 2 0.000000 -1 2.500000 1.148000 39.105088 15.806250 19893 2 0.000000 1 2.500000 58.548000 37.779492 19.318750 -19894 2 0.000000 -1.000000 2.500000 58.548000 37.779492 19.318750 +19894 2 0.000000 -1 2.500000 58.548000 37.779492 19.318750 19895 2 0.000000 1 2.500000 60.844000 33.802704 19.318750 19896 2 0.000000 -1 2.500000 60.844000 33.802704 19.318750 19897 2 0.000000 1 2.500000 63.140000 35.128300 22.831250 @@ -19915,7 +19915,7 @@ Atoms 19899 2 0.000000 1 2.500000 1.148000 39.105088 22.831250 19900 2 0.000000 -1 2.500000 1.148000 39.105088 22.831250 19901 2 0.000000 1 2.500000 58.548000 37.779492 26.343750 -19902 2 0.000000 -1.000000 2.500000 58.548000 37.779492 26.343750 +19902 2 0.000000 -1 2.500000 58.548000 37.779492 26.343750 19903 2 0.000000 1 2.500000 60.844000 33.802704 26.343750 19904 2 0.000000 -1 2.500000 60.844000 33.802704 26.343750 19905 2 0.000000 1 2.500000 63.140000 35.128300 29.856250 @@ -19923,7 +19923,7 @@ Atoms 19907 2 0.000000 1 2.500000 1.148000 39.105088 29.856250 19908 2 0.000000 -1 2.500000 1.148000 39.105088 29.856250 19909 2 0.000000 1 2.500000 58.548000 37.779492 33.368750 -19910 2 0.000000 -1.000000 2.500000 58.548000 37.779492 33.368750 +19910 2 0.000000 -1 2.500000 58.548000 37.779492 33.368750 19911 2 0.000000 1 2.500000 60.844000 33.802704 33.368750 19912 2 0.000000 -1 2.500000 60.844000 33.802704 33.368750 19913 2 0.000000 1 2.500000 63.140000 35.128300 36.881250 @@ -19931,7 +19931,7 @@ Atoms 19915 2 0.000000 1 2.500000 1.148000 39.105088 36.881250 19916 2 0.000000 -1 2.500000 1.148000 39.105088 36.881250 19917 2 0.000000 1 2.500000 58.548000 37.779492 40.393750 -19918 2 0.000000 -1.000000 2.500000 58.548000 37.779492 40.393750 +19918 2 0.000000 -1 2.500000 58.548000 37.779492 40.393750 19919 2 0.000000 1 2.500000 60.844000 33.802704 40.393750 19920 2 0.000000 -1 2.500000 60.844000 33.802704 40.393750 19921 2 0.000000 1 2.500000 63.140000 35.128300 43.906250 @@ -19939,7 +19939,7 @@ Atoms 19923 2 0.000000 1 2.500000 1.148000 39.105088 43.906250 19924 2 0.000000 -1 2.500000 1.148000 39.105088 43.906250 19925 2 0.000000 1 2.500000 58.548000 37.779492 47.418750 -19926 2 0.000000 -1.000000 2.500000 58.548000 37.779492 47.418750 +19926 2 0.000000 -1 2.500000 58.548000 37.779492 47.418750 19927 2 0.000000 1 2.500000 60.844000 33.802704 47.418750 19928 2 0.000000 -1 2.500000 60.844000 33.802704 47.418750 19929 2 0.000000 1 2.500000 63.140000 35.128300 50.931250 @@ -19947,7 +19947,7 @@ Atoms 19931 2 0.000000 1 2.500000 1.148000 39.105088 50.931250 19932 2 0.000000 -1 2.500000 1.148000 39.105088 50.931250 19933 2 0.000000 1 2.500000 58.548000 37.779492 54.443750 -19934 2 0.000000 -1.000000 2.500000 58.548000 37.779492 54.443750 +19934 2 0.000000 -1 2.500000 58.548000 37.779492 54.443750 19935 2 0.000000 1 2.500000 60.844000 33.802704 54.443750 19936 2 0.000000 -1 2.500000 60.844000 33.802704 54.443750 19937 2 0.000000 1 2.500000 63.140000 35.128300 57.956250 @@ -19955,7 +19955,7 @@ Atoms 19939 2 0.000000 1 2.500000 1.148000 39.105088 57.956250 19940 2 0.000000 -1 2.500000 1.148000 39.105088 57.956250 19941 2 0.000000 1 2.500000 58.548000 37.779492 61.468750 -19942 2 0.000000 -1.000000 2.500000 58.548000 37.779492 61.468750 +19942 2 0.000000 -1 2.500000 58.548000 37.779492 61.468750 19943 2 0.000000 1 2.500000 60.844000 33.802704 61.468750 19944 2 0.000000 -1 2.500000 60.844000 33.802704 61.468750 19945 2 0.000000 1 2.500000 63.140000 43.081877 1.756250 @@ -19963,7 +19963,7 @@ Atoms 19947 2 0.000000 1 2.500000 1.148000 47.058666 1.756250 19948 2 0.000000 -1 2.500000 1.148000 47.058666 1.756250 19949 2 0.000000 1 2.500000 58.548000 45.733070 5.268750 -19950 2 0.000000 -1.000000 2.500000 58.548000 45.733070 5.268750 +19950 2 0.000000 -1 2.500000 58.548000 45.733070 5.268750 19951 2 0.000000 1 2.500000 60.844000 41.756281 5.268750 19952 2 0.000000 -1 2.500000 60.844000 41.756281 5.268750 19953 2 0.000000 1 2.500000 63.140000 43.081877 8.781250 @@ -19971,7 +19971,7 @@ Atoms 19955 2 0.000000 1 2.500000 1.148000 47.058666 8.781250 19956 2 0.000000 -1 2.500000 1.148000 47.058666 8.781250 19957 2 0.000000 1 2.500000 58.548000 45.733070 12.293750 -19958 2 0.000000 -1.000000 2.500000 58.548000 45.733070 12.293750 +19958 2 0.000000 -1 2.500000 58.548000 45.733070 12.293750 19959 2 0.000000 1 2.500000 60.844000 41.756281 12.293750 19960 2 0.000000 -1 2.500000 60.844000 41.756281 12.293750 19961 2 0.000000 1 2.500000 63.140000 43.081877 15.806250 @@ -19979,7 +19979,7 @@ Atoms 19963 2 0.000000 1 2.500000 1.148000 47.058666 15.806250 19964 2 0.000000 -1 2.500000 1.148000 47.058666 15.806250 19965 2 0.000000 1 2.500000 58.548000 45.733070 19.318750 -19966 2 0.000000 -1.000000 2.500000 58.548000 45.733070 19.318750 +19966 2 0.000000 -1 2.500000 58.548000 45.733070 19.318750 19967 2 0.000000 1 2.500000 60.844000 41.756281 19.318750 19968 2 0.000000 -1 2.500000 60.844000 41.756281 19.318750 19969 2 0.000000 1 2.500000 63.140000 43.081877 22.831250 @@ -19987,7 +19987,7 @@ Atoms 19971 2 0.000000 1 2.500000 1.148000 47.058666 22.831250 19972 2 0.000000 -1 2.500000 1.148000 47.058666 22.831250 19973 2 0.000000 1 2.500000 58.548000 45.733070 26.343750 -19974 2 0.000000 -1.000000 2.500000 58.548000 45.733070 26.343750 +19974 2 0.000000 -1 2.500000 58.548000 45.733070 26.343750 19975 2 0.000000 1 2.500000 60.844000 41.756281 26.343750 19976 2 0.000000 -1 2.500000 60.844000 41.756281 26.343750 19977 2 0.000000 1 2.500000 63.140000 43.081877 29.856250 @@ -19995,7 +19995,7 @@ Atoms 19979 2 0.000000 1 2.500000 1.148000 47.058666 29.856250 19980 2 0.000000 -1 2.500000 1.148000 47.058666 29.856250 19981 2 0.000000 1 2.500000 58.548000 45.733070 33.368750 -19982 2 0.000000 -1.000000 2.500000 58.548000 45.733070 33.368750 +19982 2 0.000000 -1 2.500000 58.548000 45.733070 33.368750 19983 2 0.000000 1 2.500000 60.844000 41.756281 33.368750 19984 2 0.000000 -1 2.500000 60.844000 41.756281 33.368750 19985 2 0.000000 1 2.500000 63.140000 43.081877 36.881250 @@ -20003,7 +20003,7 @@ Atoms 19987 2 0.000000 1 2.500000 1.148000 47.058666 36.881250 19988 2 0.000000 -1 2.500000 1.148000 47.058666 36.881250 19989 2 0.000000 1 2.500000 58.548000 45.733070 40.393750 -19990 2 0.000000 -1.000000 2.500000 58.548000 45.733070 40.393750 +19990 2 0.000000 -1 2.500000 58.548000 45.733070 40.393750 19991 2 0.000000 1 2.500000 60.844000 41.756281 40.393750 19992 2 0.000000 -1 2.500000 60.844000 41.756281 40.393750 19993 2 0.000000 1 2.500000 63.140000 43.081877 43.906250 @@ -20011,7 +20011,7 @@ Atoms 19995 2 0.000000 1 2.500000 1.148000 47.058666 43.906250 19996 2 0.000000 -1 2.500000 1.148000 47.058666 43.906250 19997 2 0.000000 1 2.500000 58.548000 45.733070 47.418750 -19998 2 0.000000 -1.000000 2.500000 58.548000 45.733070 47.418750 +19998 2 0.000000 -1 2.500000 58.548000 45.733070 47.418750 19999 2 0.000000 1 2.500000 60.844000 41.756281 47.418750 20000 2 0.000000 -1 2.500000 60.844000 41.756281 47.418750 20001 2 0.000000 1 2.500000 63.140000 43.081877 50.931250 @@ -20019,7 +20019,7 @@ Atoms 20003 2 0.000000 1 2.500000 1.148000 47.058666 50.931250 20004 2 0.000000 -1 2.500000 1.148000 47.058666 50.931250 20005 2 0.000000 1 2.500000 58.548000 45.733070 54.443750 -20006 2 0.000000 -1.000000 2.500000 58.548000 45.733070 54.443750 +20006 2 0.000000 -1 2.500000 58.548000 45.733070 54.443750 20007 2 0.000000 1 2.500000 60.844000 41.756281 54.443750 20008 2 0.000000 -1 2.500000 60.844000 41.756281 54.443750 20009 2 0.000000 1 2.500000 63.140000 43.081877 57.956250 @@ -20027,7 +20027,7 @@ Atoms 20011 2 0.000000 1 2.500000 1.148000 47.058666 57.956250 20012 2 0.000000 -1 2.500000 1.148000 47.058666 57.956250 20013 2 0.000000 1 2.500000 58.548000 45.733070 61.468750 -20014 2 0.000000 -1.000000 2.500000 58.548000 45.733070 61.468750 +20014 2 0.000000 -1 2.500000 58.548000 45.733070 61.468750 20015 2 0.000000 1 2.500000 60.844000 41.756281 61.468750 20016 2 0.000000 -1 2.500000 60.844000 41.756281 61.468750 20017 2 0.000000 1 2.500000 63.140000 51.035454 1.756250 @@ -20035,7 +20035,7 @@ Atoms 20019 2 0.000000 1 2.500000 1.148000 55.012243 1.756250 20020 2 0.000000 -1 2.500000 1.148000 55.012243 1.756250 20021 2 0.000000 1 2.500000 58.548000 53.686647 5.268750 -20022 2 0.000000 -1.000000 2.500000 58.548000 53.686647 5.268750 +20022 2 0.000000 -1 2.500000 58.548000 53.686647 5.268750 20023 2 0.000000 1 2.500000 60.844000 49.709858 5.268750 20024 2 0.000000 -1 2.500000 60.844000 49.709858 5.268750 20025 2 0.000000 1 2.500000 63.140000 51.035454 8.781250 @@ -20043,7 +20043,7 @@ Atoms 20027 2 0.000000 1 2.500000 1.148000 55.012243 8.781250 20028 2 0.000000 -1 2.500000 1.148000 55.012243 8.781250 20029 2 0.000000 1 2.500000 58.548000 53.686647 12.293750 -20030 2 0.000000 -1.000000 2.500000 58.548000 53.686647 12.293750 +20030 2 0.000000 -1 2.500000 58.548000 53.686647 12.293750 20031 2 0.000000 1 2.500000 60.844000 49.709858 12.293750 20032 2 0.000000 -1 2.500000 60.844000 49.709858 12.293750 20033 2 0.000000 1 2.500000 63.140000 51.035454 15.806250 @@ -20051,7 +20051,7 @@ Atoms 20035 2 0.000000 1 2.500000 1.148000 55.012243 15.806250 20036 2 0.000000 -1 2.500000 1.148000 55.012243 15.806250 20037 2 0.000000 1 2.500000 58.548000 53.686647 19.318750 -20038 2 0.000000 -1.000000 2.500000 58.548000 53.686647 19.318750 +20038 2 0.000000 -1 2.500000 58.548000 53.686647 19.318750 20039 2 0.000000 1 2.500000 60.844000 49.709858 19.318750 20040 2 0.000000 -1 2.500000 60.844000 49.709858 19.318750 20041 2 0.000000 1 2.500000 63.140000 51.035454 22.831250 @@ -20059,7 +20059,7 @@ Atoms 20043 2 0.000000 1 2.500000 1.148000 55.012243 22.831250 20044 2 0.000000 -1 2.500000 1.148000 55.012243 22.831250 20045 2 0.000000 1 2.500000 58.548000 53.686647 26.343750 -20046 2 0.000000 -1.000000 2.500000 58.548000 53.686647 26.343750 +20046 2 0.000000 -1 2.500000 58.548000 53.686647 26.343750 20047 2 0.000000 1 2.500000 60.844000 49.709858 26.343750 20048 2 0.000000 -1 2.500000 60.844000 49.709858 26.343750 20049 2 0.000000 1 2.500000 63.140000 51.035454 29.856250 @@ -20067,7 +20067,7 @@ Atoms 20051 2 0.000000 1 2.500000 1.148000 55.012243 29.856250 20052 2 0.000000 -1 2.500000 1.148000 55.012243 29.856250 20053 2 0.000000 1 2.500000 58.548000 53.686647 33.368750 -20054 2 0.000000 -1.000000 2.500000 58.548000 53.686647 33.368750 +20054 2 0.000000 -1 2.500000 58.548000 53.686647 33.368750 20055 2 0.000000 1 2.500000 60.844000 49.709858 33.368750 20056 2 0.000000 -1 2.500000 60.844000 49.709858 33.368750 20057 2 0.000000 1 2.500000 63.140000 51.035454 36.881250 @@ -20075,7 +20075,7 @@ Atoms 20059 2 0.000000 1 2.500000 1.148000 55.012243 36.881250 20060 2 0.000000 -1 2.500000 1.148000 55.012243 36.881250 20061 2 0.000000 1 2.500000 58.548000 53.686647 40.393750 -20062 2 0.000000 -1.000000 2.500000 58.548000 53.686647 40.393750 +20062 2 0.000000 -1 2.500000 58.548000 53.686647 40.393750 20063 2 0.000000 1 2.500000 60.844000 49.709858 40.393750 20064 2 0.000000 -1 2.500000 60.844000 49.709858 40.393750 20065 2 0.000000 1 2.500000 63.140000 51.035454 43.906250 @@ -20083,7 +20083,7 @@ Atoms 20067 2 0.000000 1 2.500000 1.148000 55.012243 43.906250 20068 2 0.000000 -1 2.500000 1.148000 55.012243 43.906250 20069 2 0.000000 1 2.500000 58.548000 53.686647 47.418750 -20070 2 0.000000 -1.000000 2.500000 58.548000 53.686647 47.418750 +20070 2 0.000000 -1 2.500000 58.548000 53.686647 47.418750 20071 2 0.000000 1 2.500000 60.844000 49.709858 47.418750 20072 2 0.000000 -1 2.500000 60.844000 49.709858 47.418750 20073 2 0.000000 1 2.500000 63.140000 51.035454 50.931250 @@ -20091,7 +20091,7 @@ Atoms 20075 2 0.000000 1 2.500000 1.148000 55.012243 50.931250 20076 2 0.000000 -1 2.500000 1.148000 55.012243 50.931250 20077 2 0.000000 1 2.500000 58.548000 53.686647 54.443750 -20078 2 0.000000 -1.000000 2.500000 58.548000 53.686647 54.443750 +20078 2 0.000000 -1 2.500000 58.548000 53.686647 54.443750 20079 2 0.000000 1 2.500000 60.844000 49.709858 54.443750 20080 2 0.000000 -1 2.500000 60.844000 49.709858 54.443750 20081 2 0.000000 1 2.500000 63.140000 51.035454 57.956250 @@ -20099,7 +20099,7 @@ Atoms 20083 2 0.000000 1 2.500000 1.148000 55.012243 57.956250 20084 2 0.000000 -1 2.500000 1.148000 55.012243 57.956250 20085 2 0.000000 1 2.500000 58.548000 53.686647 61.468750 -20086 2 0.000000 -1.000000 2.500000 58.548000 53.686647 61.468750 +20086 2 0.000000 -1 2.500000 58.548000 53.686647 61.468750 20087 2 0.000000 1 2.500000 60.844000 49.709858 61.468750 20088 2 0.000000 -1 2.500000 60.844000 49.709858 61.468750 20089 2 0.000000 1 2.500000 63.140000 58.989032 1.756250 @@ -20107,7 +20107,7 @@ Atoms 20091 2 0.000000 1 2.500000 1.148000 62.965820 1.756250 20092 2 0.000000 -1 2.500000 1.148000 62.965820 1.756250 20093 2 0.000000 1 2.500000 58.548000 61.640224 5.268750 -20094 2 0.000000 -1.000000 2.500000 58.548000 61.640224 5.268750 +20094 2 0.000000 -1 2.500000 58.548000 61.640224 5.268750 20095 2 0.000000 1 2.500000 60.844000 57.663435 5.268750 20096 2 0.000000 -1 2.500000 60.844000 57.663435 5.268750 20097 2 0.000000 1 2.500000 63.140000 58.989032 8.781250 @@ -20115,7 +20115,7 @@ Atoms 20099 2 0.000000 1 2.500000 1.148000 62.965820 8.781250 20100 2 0.000000 -1 2.500000 1.148000 62.965820 8.781250 20101 2 0.000000 1 2.500000 58.548000 61.640224 12.293750 -20102 2 0.000000 -1.000000 2.500000 58.548000 61.640224 12.293750 +20102 2 0.000000 -1 2.500000 58.548000 61.640224 12.293750 20103 2 0.000000 1 2.500000 60.844000 57.663435 12.293750 20104 2 0.000000 -1 2.500000 60.844000 57.663435 12.293750 20105 2 0.000000 1 2.500000 63.140000 58.989032 15.806250 @@ -20123,7 +20123,7 @@ Atoms 20107 2 0.000000 1 2.500000 1.148000 62.965820 15.806250 20108 2 0.000000 -1 2.500000 1.148000 62.965820 15.806250 20109 2 0.000000 1 2.500000 58.548000 61.640224 19.318750 -20110 2 0.000000 -1.000000 2.500000 58.548000 61.640224 19.318750 +20110 2 0.000000 -1 2.500000 58.548000 61.640224 19.318750 20111 2 0.000000 1 2.500000 60.844000 57.663435 19.318750 20112 2 0.000000 -1 2.500000 60.844000 57.663435 19.318750 20113 2 0.000000 1 2.500000 63.140000 58.989032 22.831250 @@ -20131,7 +20131,7 @@ Atoms 20115 2 0.000000 1 2.500000 1.148000 62.965820 22.831250 20116 2 0.000000 -1 2.500000 1.148000 62.965820 22.831250 20117 2 0.000000 1 2.500000 58.548000 61.640224 26.343750 -20118 2 0.000000 -1.000000 2.500000 58.548000 61.640224 26.343750 +20118 2 0.000000 -1 2.500000 58.548000 61.640224 26.343750 20119 2 0.000000 1 2.500000 60.844000 57.663435 26.343750 20120 2 0.000000 -1 2.500000 60.844000 57.663435 26.343750 20121 2 0.000000 1 2.500000 63.140000 58.989032 29.856250 @@ -20139,7 +20139,7 @@ Atoms 20123 2 0.000000 1 2.500000 1.148000 62.965820 29.856250 20124 2 0.000000 -1 2.500000 1.148000 62.965820 29.856250 20125 2 0.000000 1 2.500000 58.548000 61.640224 33.368750 -20126 2 0.000000 -1.000000 2.500000 58.548000 61.640224 33.368750 +20126 2 0.000000 -1 2.500000 58.548000 61.640224 33.368750 20127 2 0.000000 1 2.500000 60.844000 57.663435 33.368750 20128 2 0.000000 -1 2.500000 60.844000 57.663435 33.368750 20129 2 0.000000 1 2.500000 63.140000 58.989032 36.881250 @@ -20147,7 +20147,7 @@ Atoms 20131 2 0.000000 1 2.500000 1.148000 62.965820 36.881250 20132 2 0.000000 -1 2.500000 1.148000 62.965820 36.881250 20133 2 0.000000 1 2.500000 58.548000 61.640224 40.393750 -20134 2 0.000000 -1.000000 2.500000 58.548000 61.640224 40.393750 +20134 2 0.000000 -1 2.500000 58.548000 61.640224 40.393750 20135 2 0.000000 1 2.500000 60.844000 57.663435 40.393750 20136 2 0.000000 -1 2.500000 60.844000 57.663435 40.393750 20137 2 0.000000 1 2.500000 63.140000 58.989032 43.906250 @@ -20155,7 +20155,7 @@ Atoms 20139 2 0.000000 1 2.500000 1.148000 62.965820 43.906250 20140 2 0.000000 -1 2.500000 1.148000 62.965820 43.906250 20141 2 0.000000 1 2.500000 58.548000 61.640224 47.418750 -20142 2 0.000000 -1.000000 2.500000 58.548000 61.640224 47.418750 +20142 2 0.000000 -1 2.500000 58.548000 61.640224 47.418750 20143 2 0.000000 1 2.500000 60.844000 57.663435 47.418750 20144 2 0.000000 -1 2.500000 60.844000 57.663435 47.418750 20145 2 0.000000 1 2.500000 63.140000 58.989032 50.931250 @@ -20163,7 +20163,7 @@ Atoms 20147 2 0.000000 1 2.500000 1.148000 62.965820 50.931250 20148 2 0.000000 -1 2.500000 1.148000 62.965820 50.931250 20149 2 0.000000 1 2.500000 58.548000 61.640224 54.443750 -20150 2 0.000000 -1.000000 2.500000 58.548000 61.640224 54.443750 +20150 2 0.000000 -1 2.500000 58.548000 61.640224 54.443750 20151 2 0.000000 1 2.500000 60.844000 57.663435 54.443750 20152 2 0.000000 -1 2.500000 60.844000 57.663435 54.443750 20153 2 0.000000 1 2.500000 63.140000 58.989032 57.956250 @@ -20171,6 +20171,6 @@ Atoms 20155 2 0.000000 1 2.500000 1.148000 62.965820 57.956250 20156 2 0.000000 -1 2.500000 1.148000 62.965820 57.956250 20157 2 0.000000 1 2.500000 58.548000 61.640224 61.468750 -20158 2 0.000000 -1.000000 2.500000 58.548000 61.640224 61.468750 +20158 2 0.000000 -1 2.500000 58.548000 61.640224 61.468750 20159 2 0.000000 1 2.500000 60.844000 57.663435 61.468750 20160 2 0.000000 -1 2.500000 60.844000 57.663435 61.468750 -- GitLab From 6d94fc1b3d64ae95a15cacc4dadc3fd944638d08 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 14:07:30 -0400 Subject: [PATCH 376/469] include cstdlib in lmptype.h since we define ATOX() macros. --- src/lmptype.h | 1 + 1 file changed, 1 insertion(+) diff --git a/src/lmptype.h b/src/lmptype.h index 12fa6cc4fb..ad00df6c63 100644 --- a/src/lmptype.h +++ b/src/lmptype.h @@ -37,6 +37,7 @@ #endif #include +#include #include // requires C++-11 #include // requires C++-11 -- GitLab From 47fc31d00577e6299705ba64defe5ae7e6bbb00e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 14:21:53 -0400 Subject: [PATCH 377/469] move inline functions to the only place they are used. no need to use size_t for indices that are small --- src/USER-MEAMC/meam.h | 15 --------------- src/USER-MEAMC/meam_setup_global.cpp | 17 ++++++++++++++++- 2 files changed, 16 insertions(+), 16 deletions(-) diff --git a/src/USER-MEAMC/meam.h b/src/USER-MEAMC/meam.h index da55805790..4e5b298ffb 100644 --- a/src/USER-MEAMC/meam.h +++ b/src/USER-MEAMC/meam.h @@ -234,21 +234,6 @@ static inline bool iszero(const double f) { return fabs(f) < 1e-20; } -template -static inline void setall2d(TYPE (&arr)[maxi][maxj], const TYPE v) { - for (size_t i = 0; i < maxi; i++) - for (size_t j = 0; j < maxj; j++) - arr[i][j] = v; -} - -template -static inline void setall3d(TYPE (&arr)[maxi][maxj][maxk], const TYPE v) { - for (size_t i = 0; i < maxi; i++) - for (size_t j = 0; j < maxj; j++) - for (size_t k = 0; k < maxk; k++) - arr[i][j][k] = v; -} - // Helper functions static inline double fdiv_zero(const double n, const double d) { diff --git a/src/USER-MEAMC/meam_setup_global.cpp b/src/USER-MEAMC/meam_setup_global.cpp index 503ee65496..b66aafa06c 100644 --- a/src/USER-MEAMC/meam_setup_global.cpp +++ b/src/USER-MEAMC/meam_setup_global.cpp @@ -2,6 +2,21 @@ #include using namespace LAMMPS_NS; +template +static inline void setall2d(TYPE (&arr)[maxi][maxj], const TYPE v) { + for (int i = 0; i < maxi; i++) + for (int j = 0; j < maxj; j++) + arr[i][j] = v; +} + +template +static inline void setall3d(TYPE (&arr)[maxi][maxj][maxk], const TYPE v) { + for (int i = 0; i < maxi; i++) + for (int j = 0; j < maxj; j++) + for (int k = 0; k < maxk; k++) + arr[i][j][k] = v; +} + void MEAM::meam_setup_global(int nelt, lattice_t* lat, double* z, int* ielement, double* /*atwt*/, double* alpha, double* b0, double* b1, double* b2, double* b3, double* alat, double* esub, @@ -56,7 +71,7 @@ MEAM::meam_setup_global(int nelt, lattice_t* lat, double* z, int* ielement, doub setall2d(this->repuls_meam, 0.0); setall3d(this->Cmax_meam, 2.8); setall3d(this->Cmin_meam, 2.0); - setall2d(this->ebound_meam, pow(2.8, 2) / (4.0 * (2.8 - 1.0))); + setall2d(this->ebound_meam, (2.8*2.8) / (4.0 * (2.8 - 1.0))); setall2d(this->delta_meam, 0.0); setall2d(this->nn2_meam, 0); setall2d(this->zbl_meam, 1); -- GitLab From d4503a05a47b94e65eaaf47910234abe835bc47a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 14:22:33 -0400 Subject: [PATCH 378/469] mention that cstdlib is included in lmptype.h now, too. --- doc/include-file-conventions.md | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/include-file-conventions.md b/doc/include-file-conventions.md index c9f8bd5cb1..132f2ec4eb 100644 --- a/doc/include-file-conventions.md +++ b/doc/include-file-conventions.md @@ -107,7 +107,7 @@ Include files should be included in this order: #### pointers.h The `pointer.h` header file also includes `cstdio` and `lmptype.h` -(and through it `stdint.h`, `intttypes.h`, and `climits`). +(and through it `stdint.h`, `intttypes.h`, cstdlib, and `climits`). This means any header including `pointers.h` can assume that `FILE`, `NULL`, `INT_MAX` are defined. -- GitLab From f5bf86b32d668d9fcbe1e5e80089f620ddcfab9e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 16:27:00 -0400 Subject: [PATCH 379/469] more improvements to CMake build for USER-PLUMED on MacOSX default to shared linkage on MacOSX to avoid linker issues from configure/cmake library detection differences link/depend on GSL and LAPACK explicitly only for static linkage --- cmake/Modules/Packages/USER-PLUMED.cmake | 18 ++++++++++++++---- 1 file changed, 14 insertions(+), 4 deletions(-) diff --git a/cmake/Modules/Packages/USER-PLUMED.cmake b/cmake/Modules/Packages/USER-PLUMED.cmake index a9c5a59338..0b3d13cd70 100644 --- a/cmake/Modules/Packages/USER-PLUMED.cmake +++ b/cmake/Modules/Packages/USER-PLUMED.cmake @@ -1,15 +1,25 @@ if(PKG_USER-PLUMED) - find_package(GSL REQUIRED) - set(PLUMED_MODE "static" CACHE STRING "Linkage mode for Plumed2 library") + if(APPLE) + set(PLUMED_MODE "shared" CACHE STRING "Linkage mode for Plumed2 library") + else() + set(PLUMED_MODE "static" CACHE STRING "Linkage mode for Plumed2 library") + endif() set(PLUMED_MODE_VALUES static shared runtime) set_property(CACHE PLUMED_MODE PROPERTY STRINGS ${PLUMED_MODE_VALUES}) validate_option(PLUMED_MODE PLUMED_MODE_VALUES) string(TOUPPER ${PLUMED_MODE} PLUMED_MODE) - if((PLUMED_MODE STREQUAL "STATIC") AND NOT LAPACK_LIBRARIES) + set(PLUMED_LINK_LIBS "") + if(PLUMED_MODE STREQUAL "STATIC") find_package(LAPACK REQUIRED) find_package(BLAS REQUIRED) + find_package(GSL REQUIRED) list(APPEND LAPACK_LIBRARIES ${BLAS_LIBRARIES}) + list(APPEND PLUMED_LINK_LIBS ${LAPACK_LIBRARIES} ${GSL_LIBRARIES}) + find_package(ZLIB QUIET) + if(ZLIB_FOUND) + list(APPEND PLUMED_LINK_LIBS ${ZLIB_LIBRARIES}) + endif() endif() find_package(PkgConfig QUIET) @@ -59,7 +69,7 @@ if(PKG_USER-PLUMED) list(APPEND LAMMPS_DEPS plumed_build) if(PLUMED_MODE STREQUAL "STATIC") add_definitions(-D__PLUMED_WRAPPER_CXX=1) - list(APPEND LAMMPS_LINK_LIBS ${PLUMED_INSTALL_DIR}/lib/libplumed.a ${GSL_LIBRARIES} ${LAPACK_LIBRARIES} ${CMAKE_DL_LIBS}) + list(APPEND LAMMPS_LINK_LIBS ${PLUMED_INSTALL_DIR}/lib/libplumed.a ${PLUMED_LINK_LIBS} ${CMAKE_DL_LIBS}) elseif(PLUMED_MODE STREQUAL "SHARED") list(APPEND LAMMPS_LINK_LIBS ${PLUMED_INSTALL_DIR}/lib/libplumed${CMAKE_SHARED_LIBRARY_SUFFIX} ${PLUMED_INSTALL_DIR}/lib/libplumedKernel${CMAKE_SHARED_LIBRARY_SUFFIX} ${CMAKE_DL_LIBS}) elseif(PLUMED_MODE STREQUAL "RUNTIME") -- GitLab From 528ec75f8879af135ce256b02bb4882d4c9e4768 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 16:38:40 -0400 Subject: [PATCH 380/469] special case for MacOSX not needed --- cmake/Modules/Packages/USER-PLUMED.cmake | 6 +----- 1 file changed, 1 insertion(+), 5 deletions(-) diff --git a/cmake/Modules/Packages/USER-PLUMED.cmake b/cmake/Modules/Packages/USER-PLUMED.cmake index 0b3d13cd70..5c35e13bda 100644 --- a/cmake/Modules/Packages/USER-PLUMED.cmake +++ b/cmake/Modules/Packages/USER-PLUMED.cmake @@ -1,9 +1,5 @@ if(PKG_USER-PLUMED) - if(APPLE) - set(PLUMED_MODE "shared" CACHE STRING "Linkage mode for Plumed2 library") - else() - set(PLUMED_MODE "static" CACHE STRING "Linkage mode for Plumed2 library") - endif() + set(PLUMED_MODE "static" CACHE STRING "Linkage mode for Plumed2 library") set(PLUMED_MODE_VALUES static shared runtime) set_property(CACHE PLUMED_MODE PROPERTY STRINGS ${PLUMED_MODE_VALUES}) validate_option(PLUMED_MODE PLUMED_MODE_VALUES) -- GitLab From 882b2301bb21413eb3d464c74a0e4b5cac5131a3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 16:48:50 -0400 Subject: [PATCH 381/469] handle shared library extension on macosx for plumed runtime build --- lib/plumed/Install.py | 7 +++++-- lib/plumed/Makefile.lammps.runtime.macosx | 5 +++++ 2 files changed, 10 insertions(+), 2 deletions(-) create mode 100644 lib/plumed/Makefile.lammps.runtime.macosx diff --git a/lib/plumed/Install.py b/lib/plumed/Install.py index a59200d1f8..e34fc9236a 100644 --- a/lib/plumed/Install.py +++ b/lib/plumed/Install.py @@ -6,7 +6,7 @@ used to automate the steps described in the README file in this dir """ from __future__ import print_function -import sys, os, subprocess, shutil +import sys, os, platform, subprocess, shutil from argparse import ArgumentParser sys.path.append('..') @@ -130,7 +130,10 @@ if os.path.isfile("Makefile.lammps.%s" % mode): print("Creating Makefile.lammps") plumedinc = os.path.join('liblink', 'plumed', 'src', 'lib', 'Plumed.inc.' + mode) lines1 = open(plumedinc, 'r').readlines() - lines2 = open("Makefile.lammps.%s" % mode, 'r').readlines() + if (platform.system() == 'Darwin' and os.path.isfile("Makefile.lammps.%s.macosx")): + lines2 = open("Makefile.lammps.%s.macosx" % mode, 'r').readlines() + else: + lines2 = open("Makefile.lammps.%s" % mode, 'r').readlines() fp = open("Makefile.lammps", 'w') fp.write("PLUMED_LIBDIR=" + os.path.join(homedir, "lib\n")) for line in lines1: diff --git a/lib/plumed/Makefile.lammps.runtime.macosx b/lib/plumed/Makefile.lammps.runtime.macosx new file mode 100644 index 0000000000..d0ae6e82a5 --- /dev/null +++ b/lib/plumed/Makefile.lammps.runtime.macosx @@ -0,0 +1,5 @@ +# Settings that the LAMMPS build will import when this package library is used + +plumed_SYSINC = -D__PLUMED_HAS_DLOPEN=1 -D__PLUMED_DEFAULT_KERNEL=$(PLUMED_LIBDIR)/libplumedKernel.dylib +plumed_SYSLIB = $(PLUMED_LOAD) -rdynamic +plumed_SYSPATH = -- GitLab From 2b288bc9e05e39fd58c6709636451beccc0da20b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 16:53:27 -0400 Subject: [PATCH 382/469] add missing mode keyword for substitution --- lib/plumed/Install.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/lib/plumed/Install.py b/lib/plumed/Install.py index e34fc9236a..d56b68b877 100644 --- a/lib/plumed/Install.py +++ b/lib/plumed/Install.py @@ -130,7 +130,7 @@ if os.path.isfile("Makefile.lammps.%s" % mode): print("Creating Makefile.lammps") plumedinc = os.path.join('liblink', 'plumed', 'src', 'lib', 'Plumed.inc.' + mode) lines1 = open(plumedinc, 'r').readlines() - if (platform.system() == 'Darwin' and os.path.isfile("Makefile.lammps.%s.macosx")): + if (platform.system() == 'Darwin' and os.path.isfile("Makefile.lammps.%s.macosx" % mode)): lines2 = open("Makefile.lammps.%s.macosx" % mode, 'r').readlines() else: lines2 = open("Makefile.lammps.%s" % mode, 'r').readlines() -- GitLab From bc79412203448c480362c1583b37b4f1f2b7a3f3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 30 Jul 2019 22:54:02 -0400 Subject: [PATCH 383/469] list(TRANSFORM ...) is not portable to older versions of cmake. work around it. --- cmake/CMakeLists.txt | 61 ++++++++++++++++++++++---------------------- 1 file changed, 30 insertions(+), 31 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 2fc7fc8307..187b41e980 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -497,37 +497,36 @@ if(BUILD_LIB) add_dependencies(lammps ${LAMMPS_DEPS}) endif() set(LAMMPS_CXX_HEADERS - angle.h - atom.h - bond.h - citeme.h - comm.h - compute.h - dihedral.h - domain.h - error.h - fix.h - force.h - group.h - improper.h - input.h - kspace.h - lammps.h - lattice.h - lmppython.h - memory.h - modify.h - neighbor.h - neigh_list.h - output.h - pair.h - pointers.h - region.h - timer.h - universe.h - update.h - variable.h) - list(TRANSFORM LAMMPS_CXX_HEADERS PREPEND ${LAMMPS_SOURCE_DIR}/) + ${LAMMPS_SOURCE_DIR}/angle.h + ${LAMMPS_SOURCE_DIR}/atom.h + ${LAMMPS_SOURCE_DIR}/bond.h + ${LAMMPS_SOURCE_DIR}/citeme.h + ${LAMMPS_SOURCE_DIR}/comm.h + ${LAMMPS_SOURCE_DIR}/compute.h + ${LAMMPS_SOURCE_DIR}/dihedral.h + ${LAMMPS_SOURCE_DIR}/domain.h + ${LAMMPS_SOURCE_DIR}/error.h + ${LAMMPS_SOURCE_DIR}/fix.h + ${LAMMPS_SOURCE_DIR}/force.h + ${LAMMPS_SOURCE_DIR}/group.h + ${LAMMPS_SOURCE_DIR}/improper.h + ${LAMMPS_SOURCE_DIR}/input.h + ${LAMMPS_SOURCE_DIR}/kspace.h + ${LAMMPS_SOURCE_DIR}/lammps.h + ${LAMMPS_SOURCE_DIR}/lattice.h + ${LAMMPS_SOURCE_DIR}/lmppython.h + ${LAMMPS_SOURCE_DIR}/memory.h + ${LAMMPS_SOURCE_DIR}/modify.h + ${LAMMPS_SOURCE_DIR}/neighbor.h + ${LAMMPS_SOURCE_DIR}/neigh_list.h + ${LAMMPS_SOURCE_DIR}/output.h + ${LAMMPS_SOURCE_DIR}/pair.h + ${LAMMPS_SOURCE_DIR}/pointers.h + ${LAMMPS_SOURCE_DIR}/region.h + ${LAMMPS_SOURCE_DIR}/timer.h + ${LAMMPS_SOURCE_DIR}/universe.h + ${LAMMPS_SOURCE_DIR}/update.h + ${LAMMPS_SOURCE_DIR}/variable.h) set_target_properties(lammps PROPERTIES OUTPUT_NAME lammps${LAMMPS_LIB_SUFFIX}) set_target_properties(lammps PROPERTIES SOVERSION ${SOVERSION}) -- GitLab From da3b91a744731789f723a314fb41e68bf7cc92b1 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 31 Jul 2019 03:11:44 -0400 Subject: [PATCH 384/469] Remove not existing files from USER-PHONON Install.sh --- src/USER-PHONON/Install.sh | 2 -- 1 file changed, 2 deletions(-) diff --git a/src/USER-PHONON/Install.sh b/src/USER-PHONON/Install.sh index a73f529cfa..26104b45cf 100755 --- a/src/USER-PHONON/Install.sh +++ b/src/USER-PHONON/Install.sh @@ -42,5 +42,3 @@ action fix_phonon.cpp fft3d_wrap.h action fix_phonon.h fft3d_wrap.h action dynamical_matrix.cpp action dynamical_matrix.h -action third_order.cpp -action third_order.h -- GitLab From 3cc8508795fefedd4532d27dfeecc1957f6144bf Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 31 Jul 2019 03:22:22 -0400 Subject: [PATCH 385/469] Add missing definition of NULL in USER-PTM header --- src/USER-PTM/ptm_initialize_data.h | 1 + 1 file changed, 1 insertion(+) diff --git a/src/USER-PTM/ptm_initialize_data.h b/src/USER-PTM/ptm_initialize_data.h index 4e7f3e8f0a..87111b1282 100644 --- a/src/USER-PTM/ptm_initialize_data.h +++ b/src/USER-PTM/ptm_initialize_data.h @@ -15,6 +15,7 @@ THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLI #include "ptm_deformation_gradient.h" #include "ptm_fundamental_mappings.h" #include "ptm_alt_templates.h" +#include namespace ptm { -- GitLab From 0fa9cd5004d35a50dd9943a1fec649dcb72f9c78 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 31 Jul 2019 05:03:59 -0400 Subject: [PATCH 386/469] use utils::strmatch to simplify checks for compatible thermostat/barostat fixes --- src/REPLICA/temper.cpp | 34 ++++++---------------------------- src/USER-MISC/temper_npt.cpp | 5 +++-- 2 files changed, 9 insertions(+), 30 deletions(-) diff --git a/src/REPLICA/temper.cpp b/src/REPLICA/temper.cpp index 46fc3af649..2352a7de48 100644 --- a/src/REPLICA/temper.cpp +++ b/src/REPLICA/temper.cpp @@ -31,6 +31,7 @@ #include "finish.h" #include "timer.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -94,34 +95,11 @@ void Temper::command(int narg, char **arg) // fix style must be appropriate for temperature control, i.e. it needs // to provide a working Fix::reset_target() and must not change the volume. - if ((strcmp(modify->fix[whichfix]->style,"nvt") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/asphere") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/asphere/omp") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/body") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/eff") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/intel") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/kk") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/kk/host") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/kk/device") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/omp") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/sphere") != 0) && - (strcmp(modify->fix[whichfix]->style,"nvt/sphere/omp") != 0) && - (strcmp(modify->fix[whichfix]->style,"langevin") != 0) && - (strcmp(modify->fix[whichfix]->style,"langevin/drude") != 0) && - (strcmp(modify->fix[whichfix]->style,"langevin/eff") != 0) && - (strcmp(modify->fix[whichfix]->style,"gld") != 0) && - (strcmp(modify->fix[whichfix]->style,"gle") != 0) && - (strcmp(modify->fix[whichfix]->style,"rigid/nvt") != 0) && - (strcmp(modify->fix[whichfix]->style,"rigid/nvt/small") != 0) && - (strcmp(modify->fix[whichfix]->style,"rigid/nvt/omp") != 0) && - (strcmp(modify->fix[whichfix]->style,"rigid/nvt/small/omp") != 0) && - (strcmp(modify->fix[whichfix]->style,"temp/berendsen") != 0) && - (strcmp(modify->fix[whichfix]->style,"temp/berendsen/cuda") != 0) && - (strcmp(modify->fix[whichfix]->style,"temp/csvr") != 0) && - (strcmp(modify->fix[whichfix]->style,"temp/csld") != 0) && - (strcmp(modify->fix[whichfix]->style,"temp/rescale") != 0) && - (strcmp(modify->fix[whichfix]->style,"temp/rescale/cuda") != 0) && - (strcmp(modify->fix[whichfix]->style,"temp/rescale/eff") != 0)) + if ((!utils::strmatch(modify->fix[whichfix]->style,"^nvt")) && + (!utils::strmatch(modify->fix[whichfix]->style,"^langevin")) && + (!utils::strmatch(modify->fix[whichfix]->style,"^gl[de]$")) && + (!utils::strmatch(modify->fix[whichfix]->style,"^rigid/nvt")) && + (!utils::strcmp(modify->fix[whichfix]->style,"^temp/")) error->universe_all(FLERR,"Tempering temperature fix is not supported"); // setup for long tempering run diff --git a/src/USER-MISC/temper_npt.cpp b/src/USER-MISC/temper_npt.cpp index 9fd4bd6d06..1fff222835 100644 --- a/src/USER-MISC/temper_npt.cpp +++ b/src/USER-MISC/temper_npt.cpp @@ -33,6 +33,7 @@ #include "finish.h" #include "timer.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; @@ -97,8 +98,8 @@ void TemperNPT::command(int narg, char **arg) // change the volume. This currently only applies to fix npt and // fix rigid/npt variants - if ((strncmp(modify->fix[whichfix]->style,"npt",3) != 0) - && (strncmp(modify->fix[whichfix]->style,"rigid/npt",9) != 0)) + if ( (!utils::strmatch(modify->fix[whichfix]->style,"^npt")) && + (!utils::strmatch(modify->fix[whichfix]->style,"^rigid/npt")) ) error->universe_all(FLERR,"Tempering temperature and pressure fix is not supported"); // setup for long tempering run -- GitLab From 4011f6650de39065bcd616d19bc8cdf69e065e18 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 31 Jul 2019 05:05:17 -0400 Subject: [PATCH 387/469] first step of adding timeout support to temper commands --- src/REPLICA/temper.cpp | 4 ++++ src/USER-MISC/temper_grem.cpp | 3 +++ src/USER-MISC/temper_npt.cpp | 4 ++++ 3 files changed, 11 insertions(+) diff --git a/src/REPLICA/temper.cpp b/src/REPLICA/temper.cpp index 2352a7de48..24c79c45bf 100644 --- a/src/REPLICA/temper.cpp +++ b/src/REPLICA/temper.cpp @@ -71,6 +71,10 @@ void Temper::command(int narg, char **arg) nevery = force->inumeric(FLERR,arg[1]); double temp = force->numeric(FLERR,arg[2]); + // ignore temper command, if walltime limit was already reached + + if (timer->is_timeout()) return; + for (whichfix = 0; whichfix < modify->nfix; whichfix++) if (strcmp(arg[3],modify->fix[whichfix]->id) == 0) break; if (whichfix == modify->nfix) diff --git a/src/USER-MISC/temper_grem.cpp b/src/USER-MISC/temper_grem.cpp index d0e2fa5606..abc18b2ddf 100644 --- a/src/USER-MISC/temper_grem.cpp +++ b/src/USER-MISC/temper_grem.cpp @@ -71,6 +71,9 @@ void TemperGrem::command(int narg, char **arg) nevery = force->inumeric(FLERR,arg[1]); double lambda = force->numeric(FLERR,arg[2]); + // ignore temper command, if walltime limit was already reached + if (timer->is_timeout()) return; + // Get and check if gREM fix exists for (whichfix = 0; whichfix < modify->nfix; whichfix++) if (strcmp(arg[3],modify->fix[whichfix]->id) == 0) break; diff --git a/src/USER-MISC/temper_npt.cpp b/src/USER-MISC/temper_npt.cpp index 1fff222835..ea8cc08369 100644 --- a/src/USER-MISC/temper_npt.cpp +++ b/src/USER-MISC/temper_npt.cpp @@ -74,6 +74,10 @@ void TemperNPT::command(int narg, char **arg) double temp = force->numeric(FLERR,arg[2]); double press_set = force->numeric(FLERR,arg[6]); + // ignore temper command, if walltime limit was already reached + + if (timer->is_timeout()) return; + for (whichfix = 0; whichfix < modify->nfix; whichfix++) if (strcmp(arg[3],modify->fix[whichfix]->id) == 0) break; if (whichfix == modify->nfix) -- GitLab From 58404946db5680811dbd6122d6e4fae84f1cf13b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 31 Jul 2019 23:26:13 -0400 Subject: [PATCH 388/469] add timer timeout support to temper commands --- src/REPLICA/temper.cpp | 7 ++++++- src/USER-MISC/temper_grem.cpp | 5 +++++ src/USER-MISC/temper_npt.cpp | 5 +++++ 3 files changed, 16 insertions(+), 1 deletion(-) diff --git a/src/REPLICA/temper.cpp b/src/REPLICA/temper.cpp index 24c79c45bf..daa17c4cf4 100644 --- a/src/REPLICA/temper.cpp +++ b/src/REPLICA/temper.cpp @@ -103,12 +103,14 @@ void Temper::command(int narg, char **arg) (!utils::strmatch(modify->fix[whichfix]->style,"^langevin")) && (!utils::strmatch(modify->fix[whichfix]->style,"^gl[de]$")) && (!utils::strmatch(modify->fix[whichfix]->style,"^rigid/nvt")) && - (!utils::strcmp(modify->fix[whichfix]->style,"^temp/")) + (!utils::strcmp(modify->fix[whichfix]->style,"^temp/"))) error->universe_all(FLERR,"Tempering temperature fix is not supported"); // setup for long tempering run update->whichflag = 1; + timer->init_timeout(); + update->nsteps = nsteps; update->beginstep = update->firststep = update->ntimestep; update->endstep = update->laststep = update->firststep + nsteps; @@ -213,6 +215,9 @@ void Temper::command(int narg, char **arg) for (int iswap = 0; iswap < nswaps; iswap++) { + if (timer->is_timeout()) break; + timer->init_timeout(); + // run for nevery timesteps update->integrate->run(nevery); diff --git a/src/USER-MISC/temper_grem.cpp b/src/USER-MISC/temper_grem.cpp index abc18b2ddf..e05a27bb14 100644 --- a/src/USER-MISC/temper_grem.cpp +++ b/src/USER-MISC/temper_grem.cpp @@ -130,6 +130,8 @@ void TemperGrem::command(int narg, char **arg) // setup for long tempering run update->whichflag = 1; + timer->init_timeout(); + update->nsteps = nsteps; update->beginstep = update->firststep = update->ntimestep; update->endstep = update->laststep = update->firststep + nsteps; @@ -235,6 +237,9 @@ void TemperGrem::command(int narg, char **arg) for (int iswap = 0; iswap < nswaps; iswap++) { + if (timer->is_timeout()) break; + timer->init_timeout(); + // run for nevery timesteps update->integrate->run(nevery); diff --git a/src/USER-MISC/temper_npt.cpp b/src/USER-MISC/temper_npt.cpp index ea8cc08369..d40ca3b707 100644 --- a/src/USER-MISC/temper_npt.cpp +++ b/src/USER-MISC/temper_npt.cpp @@ -109,6 +109,8 @@ void TemperNPT::command(int narg, char **arg) // setup for long tempering run update->whichflag = 1; + timer->init_timeout(); + update->nsteps = nsteps; update->beginstep = update->firststep = update->ntimestep; update->endstep = update->laststep = update->firststep + nsteps; @@ -214,6 +216,9 @@ void TemperNPT::command(int narg, char **arg) for (int iswap = 0; iswap < nswaps; iswap++) { + if (timer->is_timeout()) break; + timer->init_timeout(); + // run for nevery timesteps update->integrate->run(nevery); -- GitLab From 75c1e2856600482807da4930775cff527cb53eb8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 31 Jul 2019 23:28:57 -0400 Subject: [PATCH 389/469] fix typo --- src/REPLICA/temper.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/REPLICA/temper.cpp b/src/REPLICA/temper.cpp index daa17c4cf4..cd14de9475 100644 --- a/src/REPLICA/temper.cpp +++ b/src/REPLICA/temper.cpp @@ -103,7 +103,7 @@ void Temper::command(int narg, char **arg) (!utils::strmatch(modify->fix[whichfix]->style,"^langevin")) && (!utils::strmatch(modify->fix[whichfix]->style,"^gl[de]$")) && (!utils::strmatch(modify->fix[whichfix]->style,"^rigid/nvt")) && - (!utils::strcmp(modify->fix[whichfix]->style,"^temp/"))) + (!utils::strmatch(modify->fix[whichfix]->style,"^temp/"))) error->universe_all(FLERR,"Tempering temperature fix is not supported"); // setup for long tempering run -- GitLab From 074ae06b36918819fc9d040afbf046a036e53164 Mon Sep 17 00:00:00 2001 From: Michael Brown Date: Thu, 1 Aug 2019 02:19:49 -0700 Subject: [PATCH 390/469] Bug fix for eam/intel per-atom energy calculation. --- src/USER-INTEL/pair_eam_intel.cpp | 1 - 1 file changed, 1 deletion(-) diff --git a/src/USER-INTEL/pair_eam_intel.cpp b/src/USER-INTEL/pair_eam_intel.cpp index 9d2629ef1c..32d7e74cbc 100644 --- a/src/USER-INTEL/pair_eam_intel.cpp +++ b/src/USER-INTEL/pair_eam_intel.cpp @@ -451,7 +451,6 @@ void PairEAMIntel::eval(const int offload, const int vflag, if (tid == 0) comm->forward_comm_pair(this); - if (NEWTON_PAIR) memset(f + minlocal, 0, f_stride * sizeof(FORCE_T)); #if defined(_OPENMP) #pragma omp barrier -- GitLab From 207976f4e9ddcb6a12bdfed741acdc808dd1d3eb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 06:11:05 -0400 Subject: [PATCH 391/469] avoid abort when timeout appears in temper commands --- src/REPLICA/temper.cpp | 5 ++--- src/USER-MISC/temper_grem.cpp | 6 ++---- src/USER-MISC/temper_npt.cpp | 5 ++--- 3 files changed, 6 insertions(+), 10 deletions(-) diff --git a/src/REPLICA/temper.cpp b/src/REPLICA/temper.cpp index cd14de9475..00ca062ecc 100644 --- a/src/REPLICA/temper.cpp +++ b/src/REPLICA/temper.cpp @@ -215,12 +215,11 @@ void Temper::command(int narg, char **arg) for (int iswap = 0; iswap < nswaps; iswap++) { - if (timer->is_timeout()) break; - timer->init_timeout(); - // run for nevery timesteps + timer->init_timeout(); update->integrate->run(nevery); + if (timer->is_timeout()) break; // compute PE // notify compute it will be called at next swap diff --git a/src/USER-MISC/temper_grem.cpp b/src/USER-MISC/temper_grem.cpp index e05a27bb14..692f78cf9f 100644 --- a/src/USER-MISC/temper_grem.cpp +++ b/src/USER-MISC/temper_grem.cpp @@ -237,12 +237,11 @@ void TemperGrem::command(int narg, char **arg) for (int iswap = 0; iswap < nswaps; iswap++) { - if (timer->is_timeout()) break; - timer->init_timeout(); - // run for nevery timesteps + timer->init_timeout(); update->integrate->run(nevery); + if (timer->is_timeout()) break; // compute PE // notify compute it will be called at next swap @@ -250,7 +249,6 @@ void TemperGrem::command(int narg, char **arg) pe = pe_compute->compute_scalar(); pe_compute->addstep(update->ntimestep + nevery); - // which = which of 2 kinds of swaps to do (0,1) if (!ranswap) which = iswap % 2; diff --git a/src/USER-MISC/temper_npt.cpp b/src/USER-MISC/temper_npt.cpp index d40ca3b707..55c9aadc6f 100644 --- a/src/USER-MISC/temper_npt.cpp +++ b/src/USER-MISC/temper_npt.cpp @@ -216,12 +216,11 @@ void TemperNPT::command(int narg, char **arg) for (int iswap = 0; iswap < nswaps; iswap++) { - if (timer->is_timeout()) break; - timer->init_timeout(); - // run for nevery timesteps + timer->init_timeout(); update->integrate->run(nevery); + if (timer->is_timeout()) break; // compute PE // notify compute it will be called at next swap -- GitLab From 892e4759df463d0439a44d4997fd277331cfb7d7 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 07:02:55 -0400 Subject: [PATCH 392/469] protect Spectrum MPI detection from failing to compile with MPI libraries implementing MPI version 2 or 1 --- src/KOKKOS/kokkos.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index a353c3dd18..dd0aca2a9f 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -208,6 +208,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) MPI_Comm_size(world,&nmpi); if (nmpi > 0) { +#if defined(MPI_VERSION) && (MPI_VERSION > 2) // Check for IBM Spectrum MPI int len; @@ -226,6 +227,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) if (me == 0) error->warning(FLERR,"The Spectrum MPI '-gpu' flag is not set. Disabling CUDA-aware MPI"); } +#endif if (cuda_aware_flag == 1 && have_cuda_aware == 0) { if (me == 0) -- GitLab From 86e3740fb337bafb1a8c5ea77909361ef2da2235 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 07:03:51 -0400 Subject: [PATCH 393/469] use more common syntax for CPP's "defined" keyword --- src/KOKKOS/kokkos.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index dd0aca2a9f..6fd8f46e43 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -236,7 +236,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) cuda_aware_flag = 0; } else if (have_cuda_aware == -1) { // maybe we are dealing with MPICH, MVAPICH2 or some derivative? // MVAPICH2 -#if (defined MPICH) && (defined MVAPICH2_VERSION) +#if defined(MPICH) && defined(MVAPICH2_VERSION) char* str; cuda_aware_flag = 0; if (str = getenv("MV2_ENABLE_CUDA") @@ -247,7 +247,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) if (me == 0) error->warning(FLERR,"MVAPICH2 'MV2_ENABLE_CUDA' environment variable is not set. Disabling CUDA-aware MPI"); // pure MPICH or some unsupported MPICH derivative -#elif (defined MPICH) && !(defined MVAPICH2_VERSION) +#elif defined(MPICH) && !defined(MVAPICH2_VERSION) if (me == 0) error->warning(FLERR,"Detected MPICH. Disabling CUDA-aware MPI"); cuda_aware_flag = 0; -- GitLab From 2a74832a1e662f8090562598b350b5b4fae80f0a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 07:04:24 -0400 Subject: [PATCH 394/469] protect MPI library version detection from incompatible MPI libraries --- src/info.cpp | 7 ++++++- 1 file changed, 6 insertions(+), 1 deletion(-) diff --git a/src/info.cpp b/src/info.cpp index 0d54c6d001..21297c52c6 100644 --- a/src/info.cpp +++ b/src/info.cpp @@ -354,10 +354,15 @@ void Info::command(int narg, char **arg) if (flags & COMM) { int major,minor,len; +#if (defined(MPI_VERSION) && (MPI_VERSION > 2)) || defined(MPI_STUBS) char version[MPI_MAX_LIBRARY_VERSION_STRING]; + MPI_Get_library_version(version,&len); +#else + char version[] = "Undetected MPI implementation"; + len = strlen(version); +#endif MPI_Get_version(&major,&minor); - MPI_Get_library_version(version,&len); if (len > 80) { char *ptr = strchr(version+80,'\n'); if (ptr) *ptr = '\0'; -- GitLab From e3c91626c841226e97f7f8784346a3bca315ec34 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 07:07:21 -0400 Subject: [PATCH 395/469] need to include update.h when exceptions are enabled --- src/error.cpp | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/error.cpp b/src/error.cpp index 656c957ee2..e5e9179fda 100644 --- a/src/error.cpp +++ b/src/error.cpp @@ -19,6 +19,10 @@ #include "output.h" #include "input.h" +#if defined(LAMMPS_EXCEPTIONS) +#include "update.h" +#endif + using namespace LAMMPS_NS; // helper function to truncate a string to a segment starting with "src/"; -- GitLab From a6bd86eb77da12f691165e7c8c4a9b4af81696e4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 08:14:03 -0400 Subject: [PATCH 396/469] make USER-OMP code compatible with pre-c++ 11 compilers again --- src/USER-OMP/thr_data.h | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/USER-OMP/thr_data.h b/src/USER-OMP/thr_data.h index edff17cad3..68673e7503 100644 --- a/src/USER-OMP/thr_data.h +++ b/src/USER-OMP/thr_data.h @@ -31,7 +31,7 @@ class ThrData { public: ThrData(int tid, class Timer *t); - ~ThrData() { delete _timer; _timer = nullptr; }; + ~ThrData() { delete _timer; _timer = NULL; }; void check_tid(int); // thread id consistency check int get_tid() const { return _tid; }; // our thread id. @@ -136,7 +136,7 @@ class ThrData { // disabled default methods private: - ThrData() : _tid(-1), _timer(nullptr) {}; + ThrData() : _tid(-1), _timer(NULL) {}; }; //////////////////////////////////////////////////////////////////////// -- GitLab From c967c0956170b0b9e7fd8f1124f0a71b09d7f5fc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 08:14:27 -0400 Subject: [PATCH 397/469] correct compilation error with exceptions enabled in main.cpp --- src/main.cpp | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/main.cpp b/src/main.cpp index b7f6adbdda..85e25aa2e4 100644 --- a/src/main.cpp +++ b/src/main.cpp @@ -23,6 +23,10 @@ #include #endif +#if defined(LAMMPS_EXCEPTIONS) +#include "exceptions.h" +#endif + using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- -- GitLab From e57c3c04d0261d61fdd12267b81d55d76289ba9d Mon Sep 17 00:00:00 2001 From: Michael Brown Date: Thu, 1 Aug 2019 05:32:18 -0700 Subject: [PATCH 398/469] Bug fixes for use of uninitialized variable and strict-aliasing in USER-INTEL. --- src/USER-INTEL/fix_intel.cpp | 6 +++--- src/USER-INTEL/intel_intrinsics_airebo.h | 4 +++- 2 files changed, 6 insertions(+), 4 deletions(-) diff --git a/src/USER-INTEL/fix_intel.cpp b/src/USER-INTEL/fix_intel.cpp index bdc47827ab..83a22f0562 100644 --- a/src/USER-INTEL/fix_intel.cpp +++ b/src/USER-INTEL/fix_intel.cpp @@ -352,15 +352,15 @@ void FixIntel::init() if (_offload_balance != 0.0) off_mode = 1; if (_precision_mode == PREC_MODE_SINGLE) { _single_buffers->zero_ev(); - _single_buffers->grow_ncache(off_mode,_nthreads); + _single_buffers->grow_ncache(off_mode, comm->nthreads); _single_buffers->free_list_ptrs(); } else if (_precision_mode == PREC_MODE_MIXED) { _mixed_buffers->zero_ev(); - _mixed_buffers->grow_ncache(off_mode,_nthreads); + _mixed_buffers->grow_ncache(off_mode, comm->nthreads); _mixed_buffers->free_list_ptrs(); } else { _double_buffers->zero_ev(); - _double_buffers->grow_ncache(off_mode,_nthreads); + _double_buffers->grow_ncache(off_mode, comm->nthreads); _double_buffers->free_list_ptrs(); } diff --git a/src/USER-INTEL/intel_intrinsics_airebo.h b/src/USER-INTEL/intel_intrinsics_airebo.h index 2b55b41ad1..cadf80bbe8 100644 --- a/src/USER-INTEL/intel_intrinsics_airebo.h +++ b/src/USER-INTEL/intel_intrinsics_airebo.h @@ -2223,7 +2223,9 @@ public: } VEC_INLINE static ivec unpackloepi32(const fvec &a) { - return reinterpret_cast(&a.val_)[0]; + union { int i; flt_t f; } atype; + atype.f = a.val_; + return ivec(atype.i); } VEC_INLINE static fvec mask_sincos( -- GitLab From 8f5cd8661f1fa5007faa72a3d3dae036b80b5524 Mon Sep 17 00:00:00 2001 From: oywg11 Date: Thu, 1 Aug 2019 16:38:19 +0300 Subject: [PATCH 399/469] Fix communication bug of ILP --- doc/src/Eqs/pair_kolmogorov_crespi_full.jpg | Bin 181806 -> 50604 bytes doc/src/Eqs/pair_kolmogorov_crespi_full.tex | 2 +- doc/src/pair_coul_shield.txt | 2 +- doc/src/pair_ilp_graphene_hbn.txt | 28 +- doc/src/pair_kolmogorov_crespi_full.txt | 24 +- .../bilayer-graphene/BNCH.ILP | 1 + .../Bi_gr_AB_stack_2L_noH.data | 1372 ++++++++++++++ .../ilp_graphene_hbn/bilayer-graphene/CH.rebo | 1 + .../bilayer-graphene/in.bilayer-graphene | 49 +- .../log.5Jun19.bilayer-graphene.icc.1 | 128 ++ .../log.5Jun19.bilayer-graphene.icc.4 | 128 ++ .../ilp_graphene_hbn/bilayer-hBN/BNC.tersoff | 1 + .../ilp_graphene_hbn/bilayer-hBN/BNCH.ILP | 1 + .../hBN_AA_prime_stack_2L_noH.data | 1372 ++++++++++++++ .../bilayer-hBN/in.bilayer-hBN | 57 + .../bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 | 144 ++ .../bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 | 144 ++ .../misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP | 1 + .../USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo | 1 + .../misc/ilp_graphene_hbn/gr-hBN/in.grhBN | 64 +- .../gr-hBN/log.5Jun19.grhBN.icc.1 | 155 ++ .../gr-hBN/log.5Jun19.grhBN.icc.4 | 155 ++ src/USER-MISC/pair_ilp_graphene_hbn.cpp | 1675 ++++++++-------- src/USER-MISC/pair_ilp_graphene_hbn.h | 8 +- src/USER-MISC/pair_kolmogorov_crespi_full.cpp | 1685 +++++++++-------- src/USER-MISC/pair_kolmogorov_crespi_full.h | 8 +- 26 files changed, 5442 insertions(+), 1764 deletions(-) create mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP create mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH.data create mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo create mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 create mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 create mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff create mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP create mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/hBN_AA_prime_stack_2L_noH.data create mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/in.bilayer-hBN create mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 create mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 create mode 120000 examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP create mode 120000 examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo create mode 100644 examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.1 create mode 100644 examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.4 diff --git a/doc/src/Eqs/pair_kolmogorov_crespi_full.jpg b/doc/src/Eqs/pair_kolmogorov_crespi_full.jpg index e9d306d5050faa7957b9a827b2546d03e0efd10b..7ac14f3d0bb59750b6a17b5ec71a052e73de4cc6 100644 GIT binary patch literal 50604 zcmex=jBrGDzC8j7YA!!&nLrJ-O+qLT|>gJYKju92px2qZ%n*=5%6*f+p zHuJ_!DK%54u&Wl%E8fo0!$|MxfhDaQ+D?7i7@}O+9U)X9EyAm8T=gja#?9dCSN7%y z9*QgJTl=HR$lm8hYOqR+_%@!&a#c&8uYRRbJoCBxe}<*;jq?8)rtaGRpW(#>D`N)6 z$0z2*NGZQxcb2DX$+@#V=kjzXZqb^k6s=I;((zSerr_FQOXDI}zf)eCOr?HY!i)Th zdU?YNT{049eJXbNyK2f_>x)Z2*;+sL`c?YkbIj8vFzjd$akl)l z@rl@;+^{$Q86K2xog=jPaxtG4Z&7jUyr=tiC0pmV^lV+TE9%4kn#b}7bh%jBBzyXsa`>Q*&0Usfi` zWmc}KdG;*VoL-HVvn^{ZFZ%uTYII{LEn~3!{ps)XeVPydU0su4)~^)vZI0W`ruo_( zw+kh80=vZa{#^RDI%FA(UmRD^>PnqZ@w>~92lf1rdb%y)OjgmE>yKtOybxd&y(|~{ zd-5W!8LSVzDl&HIcrClwv+az+WHY^c5Av7W8(2+l4%WQVx;@BU>}ku}X2D&?yOkWi zoOm%a+4*!8dx*E-#Le~g`fBqxT>8)O_q$DfeVl`y46DBNPk~Q9C*ph~A8cRdcU|gv zzFXgpN1TlFW_&%rj4N?_Oz*k-?GKlkocnoxnc@0%1={x)|GRW_>j^R6kaCeIZ%JiUZ{Xkd$bvoX9o1Rx7sNY@k9%1z67Mr9>%X<(*XQuB z{+q8&f6jLzT}@KVbdkxMAMIi{MX$8KJW`|jhWFhL(=DqjW!er`EuX&RKSSpFE$ihb zyp$4}*;3H2e7$C>?}}aTxIV4%`pBfn<*fNRZSF5Lp$GxS! zx3vQo2i0!eW%+Ner%Twa>nrYblwGg`J?FnqHRr!vz*)hh zh$b{4^ysCFr3|VvbYDRJ1#oAKORYg6Ao>~S@I&t#= zgN5Di;5d~u(+U~M-j_MG|47~Yb?m1^-2FZBD;7s>f4%Z#Z1U@g zrdw{l3VfXNV3P9Zr)E+3DM_om zCA#xOFAK0pYMOPXx+$B#_~uf&UAiVHVOvoOckIpXV>2~-Kg!IKZ{^&*J^S3n9~VzwOP%E#zRO}!Z2G4!C$GGp@v}07zjpTh zS1*;9pO>o&3D_BUd!ME8*;$|i6#qi=Ezn|V$3i;e?d+F=# znu&HTD}vcJNOLQ$y0}tRI(yyQ&sO^iJf*FV-k&{9XlmS(Nr`9rXQ^FX=X2@Hsj6j< zpRHiH9P{aJzR{)9)vP}rUHV;kY%#~9Yb+}}&KLVU{iVNiDXu+uX8xY7w%vhq+twwlqagU)JZXgbB5NPPGHOhs77(HXV+Mj1>HRProX3b*kUH3v-2+U)GX& zUJ%<`I62&Ea&x%#q?$evuW)hp6W1@vr*WUPvwqZieZnrK@XxW$=LAz)&29JT{OJ3B zRO{-duxTszy%Ncv%2#~C?6|pGPHo@G)pJkUS(}*#cYQx;eu;VY!XGiWrQ>dgZ?@UK zusoyGW#!h3E6*yGzFp^g+Vif_748eGbgrxx)b>m4ys8=y*rK6w_LRxqFZXkce>bpZ z7UlQfNarZ&z4iKZ;IRyT%`cz*w)y;;o)tbtaMtW)O7D1cZh5WB*w!Ocdz1@_qVeoY2 zq#08?OE=oC(LVA@XhP*WFSE)1$}7uUIz2N(Ruo4LWGyx;nOs-< z`p0(Oq|K=zXRjtluibN6qAm2=6vv%K*DaDCalH5U(eY&Ndo4KWSkSItti~B$FP`1W z-aR?muq*b`jj!vi3f5%LtZld+=exFaqFVC3E$g$V8mLUp)YLTBPwh-Te)IFJYwW9z ztoT&j_sb()@Dra;&!?aj0gsYQw07?O(EN9G&C0(E&lLpzZHttxjw>mt-TrskZngbe zw>;Bd#i9P;pv$DW$E160XZ<$vI`S*??S;LDvzNRS^~yi_+FtCqi0qmoXL;9z(#4mA zeYDf$Y9gLIxOP4`Yt7sZNs;3I`wjOWGQYAXqsS{ux7>1RQNq-0mWUnp`kdufdEeGZ zuAH7_lq~ptnpH3-IKHPSJ~T(FXmnqzOzeJtp9|R zjDV$U?EFddH@2Qz_`z$cmdMHp3w`EFsbrq?>Xi!e_M55|^7NHg$;ru+*R=}FY1(pO zk*Bt=x5nPm%f6-8W0K_yz(u>nn|)!2SvpUt3r&4$>ZZ8y`p%f%3;!7oOuHuWIcs`( z>GSkIuFCmt3mxZw;y&?Q`^`RA`DHTc7w+D+bjTF`&!8;3_QG6+tx@y8U%zX#j63no znwz&RzTOn}Ik@Op(EYi!oQKkDvS!ByXZe-woOj@f$=-=^`$8_&HNL27+BVZ!^#V7a zrtAK&!lE@6Tdwl0_3z!}ezP>xW}33jvEFH0UVis-l)Q3;uTN#|#WX+tqU5!_kAAF6 zUZGH;Dtg!UV0=jFWb?Z}OiY>k)vQz#Gfo}#lUCI|<#eRi2)*43=ukY~@fCLWhd zd$!`fb#1i=au*Mw#|6;$c;jyLtvxYu)s^RL zhZc)f^Gs4%u)O8RDdQ=tvJInb%}$>1Rr!-#lPCCWugw;B$-7JR-(^HbL_~}4*}KO| zOO-p>+c_#Y+|qK#+Tfj;7Z*D8G*8tIshlM=*V0WY@7K#^w-dC@KU;j_{2l+U|1N*W ze}nJx@8(F+JF8lrb6wo3eQ9a#@x_xfl~%s~v1iUz z-<6Z}T!ItNMQ>TDd*SiarKV0HX`*Xn-tAWiORZmf`>aU3_1~lANouhXq0|3%CLY$4 z&Qe<{*O#+8ZtmlN=N+v)zfJOQY&GmS)5+Vla;b8+;WVuk#xEynEQ#0tc=?IavQM_o zYj$W)(=@HsZaJ57RraCRc~h6rMz1>ti%BI|iFfnLc~|e!J7D{keuSw#3do=c+n!zlBO>aza9?OZDW#mrt+y?BR6l z%C&nlou0G4=2z7+X^~mzxO7U~?+4n^XST{8FTdWGH?gN&XYQ)qiHu6r4CD6CQUTnwb5Gb%AHw_H@6nCT1{K2c{KBV10Qdy zoqCk|{mfe1iI4tWiw$zv_xK=PjJ87vEQ&yRbk!;c!jf2cfp>aX(*pe0-m8yft&fd%j0` z)pz~Y7Ok7J<>Y1QiS3h2ZI12A6WeYjsW)p@%jc6}Q`)|H`doXYr@#D%@%+UitX6YR zW|?r!Q5Am87O-4zo9xLfPoIl9@9u0)aZfLuq#bp z%9+Q&z+l4~wBwMZwT@;=>qMPHZf6xI9)Gk-=Ay7-b^np6$D^O>_xc=@UETDpKQD|Mva+S!trVrPcCR`Z6Y4yIGqzrrK?? zPI}sVdgUy+4eOLNuSz%>KQ+ESO}yf;;j43sdzHJ^PPbm|bj5peQ{2?bWeciSD)gPZ zX1zG3>HXFvT5qGjCEVQjpTVPKqg?dt2{|XFP0LzVYwcOH=*-7k+qU@a*mQ@p!Rdy` zzBlVU)_y!&H+$-j_Y2hRoU`|$=H1)v!se#5Lfkv`lWXx6m#2C$ z<+C4dE7$H&4BvHsg0tL&z1fSD#kCcaG?#1kY&@GRWRWwMZQaI|+1z{5oUZSD6`b+p z*q?g~SKefM6(}<^sWwa@Y@yxpB>{6iBaGDq3f*2WoYmsE^lj9szc0JFDuci3TuQsh zuyldJO?H!7hK|2^mr{QDs?0jHD|E?C5z%S626`9zHm&VBuzcgq;JePM-EMKBuH~h% zQ~NmURgV{id{aH_abe@VHM4@nyhH!o_`BJM%_{Cq_@-Oa^uAio{j~dRuXdw{_Twv- zZe@Cr$qtH>rmdd1PgmO3t9EA8hc^ox>V-FzTQ2>4>w3&QjyG-BU(Wt_>&(eLpGwou z8-D&ScS^YEKZEjx%hzNlSI^Yp{B0aMv&8sV(4Upn?)T%LzAjaizLV-Q{qBZ^A3M*_ zJg2ZAG3RCEf*8}&du{I+ZTnJb>cu*3e~?eHgF~q8tjaFGaJ{07hZm{8ik0QFy?XWP z*-K6jRy-GV(X!F!pn8pf#lQryz1b2wU)|Q4H(PASi`4ZDGp=oV6fG`w<4I0Zscd2Q z{%Lof_!$*fy}dOz^wq?|h?6TtQZ}DHR<180`Q!85xwB?S&AA^RbNgnbWc0P&HhXsK z`rNs4>B^lMNBj8l^0;|amDs*;a#{vmUDc;)6mnFe@|jp*b#6oBm0Z`;|73Ttiq^%p z>Lx$a^J_k*>R0@_%g<+7$RxXUt_t&PB_2Jvb>UcV)m45YR^N#oSJJHRuA1DR(YL`^ zYR8u+E7tLEK73|6Yk9~w{q)$4;#r#lpB!G7Q@6A0vj56`o}YHDde*=G{0H5X-hY4o zYPl~{1;6~{BBAF)j`y-|1W%d726*<)Y&^~l8UOMf>l$a@xLRQ*+|e$Jf> z=VT_vn&oKTu8sO7^xdaPY46f!iqhro?RGUQ_-(VjioINmB3X21t!Qz{s^0L3@B0dy zhPl=LmYX6DrhL8{ZPgQMnC;lhGLf<9H_HxTk$=bh0*g#^)n;6mcC~IXQ8sAXRJeQE z`q^(bW=bzPR4^~Or(V%6?uYSCYsvEsx$BO$UaYg+`Ss=A$LpS+oPOG`=Iw3O#>dIh zm0i0_nl|szbaXm8Z`P+x&*zA(l)T(}qNB&TUvoL9YF_NL^$x99xvp(D$($n{GfC6o zL1QNCO1GU{hsyodN^Lowy;DnAQ{gbDO>@be&0hD5zF*HRJ7*mGpJCzWqw;TVKRkc8 zZ05gqhVF^~8MX*Mc%^peq*(WNRdt!3W3!|qls7)psO`IS;?R+EJ=31GrIl?leaJC8 z>edA{zs|i(Mx0)~iY&|h0#l|hoAGt?w=Ns)$CBr&zpeao%y|AG>&$ff_CFFw*e%c1 zKR9MM=lR!UxkYaO+RuyBZ_aPGFTIuhOHLl)h*|&I8(KEkZ~6X^PpHvp&9|=1tV`YZ zOWthg3SXeYeLa8qe}*8ZvsqWpaGtsSHFNXq%azvk9q;{*1eV9tu9n=M>8B{8|444d z9H%$;Ce3qOsTMbV$0U<&CzG|7zwc1`wKr_)ZRRBtt-V@q?U?nr^UK-q&Wql9PPP1d z+UrSBd05@5{|wI0yXckY^Xgj9x2LBqH2LDyX{+` zJCE}u+uGY@FLq~b>FZy4U1^7)h<={Hqq;>?x1IatJ!$8uU$ZtFsCR8So%<_`G4aIh zWK9{Fxs#4x*mG(|tc=iRwc?7h0>v#;rBpPtXMMF2U3seie!=tg$HgbT=ll~M@3Z7u z_++h3AK%RDn=mo`8@rda>suL{TV{bLzg@Iusb&lJJkuW%y2|)WS7^W#&)HEC$xm|D zOly0(ZuRBY$@71?{1g4paQfGZ{|uY2P5;8;asI;3NB!S&KRkc8+qd5N@E5y^#eZkl zSpHsjIsU>2!OH7z6)L>b)l0d4KiX@t*W||8t=SEC*SDv~7S4GtrIxZLMnrO7t$kBu zYEIhCFUNMJTOKoxn``^+$e!4ciQnVTzTEZvwd6Vu>oAtUAI5u~nS!M*dp4GK`u65;e=<2s zd;04gpF%wsimIE3=$+=BsMb>Ra{2nG(&l{KN`IRPyEP-;Dp#+T;=6H$=k1#wUt1*} zvCXSrSH*G4tbQdSVz++n!xueyT@DKbkIk53XV!2vOMFgmpVg6x+}=^i;o4yvE(I=8 zcNSe4u(&3t@L2w~5(Wka6aK)E;@`Kr=UgogZplf>T$buQx%T4LO!vhFc?E8j zC&d-RJWoztW^svM<516ipI-`0y8n`Eg8#YS+5UTf$o-3oyH?-YwRy#jzV550SHw2< zY7_>1s43gqar|M9yY*^Ctx&&qlVi7UN1rJSn#rZ|N<43Vs=7e0rknJ}%v0BWUVuF3 zw61N->+i3n=01P6Z*A@K+rEe1uDe_6EzoabotsvBBd2o99m|dH!gV`NEcm#5b`Ya@ z#RPc~)tmFKmNc4J*d4t%>qypC^|OKJ@B3(``9Hna*f*cC$WHy-R-5T-6a=QM;=THO zrFHXamE)hz_!hg#oeTeZtS)b<(&kK=S3xaXbHB{7^Sh`}?sQY4f9tzBRxBVFF^cAS zv%D1T4!gAFduULo?XkNVhn|bsCaQW1ZCG<#tgCN%$bW`}>lZ78I`@>h3Y5+;o^dVF zEN`umtdh^HwMBl1HeAgNQ=aP7_4d>^lh02tANMzN=nM0%W5tV>df!zoJG*Y963@FJl{bYZg4a?slQwRe6<9U*&*5`Z?{vL-VZHmv zpG|*zk3>qzr`B>@*L-@{WVTR~$&qV!8oShWUsxPn@#Rm@`sLwg3=b`kn0P8BGtlIy z)O??kw7W;t=AKRP&AGQ~+0LZplWp9hSHDf3>wI<7i(7{U*JZ7pIe$*z#V`F=g8wr} zbRJ%~=EvjBYdZDUJ+%zla(AU@xkghCn=5m_fUsRqw z*m3w4ua3BAZq8e^P1lPoOU%uzXY%#;as;_u*p<7fy}T^t`O?_dlx^!4%EdigW}#ZL z_0ro9sirgTd`sEoop$4Nw9Y@dTl!M58nGKE-a5t+Jw4KFy%u-yVd3N1Cq7L*yLR0q z9rvkcWaFws`L8*CV+y`e@G0U`{D4XuG=+fC4 zDTcXAJ|6SryVzMIB&}L_cHV5EovCepx27gHrTye~3;ApNlB@J}hsTq-UPWP=I(z-@ zD}$01{W0T$U0wPYCR@oJ=q*}1Uv$~}>nc6_C*PLK74|jjalf*7veEiF-BVT@mAisJ z{TB85E$j4X;mQ{)es}NkfB=N{W_d-3lfi`t6kGS7C{TV^si+?)Ggrxa_(LVtf&uWu7p zgk4xL)lXX8a5=A<$oyc_xU!PD4U~te>Dr|Q;Uc?*YuZjs7CJETa4-_ zmzl3suAyqc=V#M?yynvfb%}V}hV5sT7G^A6yjVBLc!6e3NkG9@q1af}i7&PZPFFR3 z%>{hvVl4EfI~AAkNiGo@kw267@spm^zTkyo3ptoqs1*SvJE)wzc^I)!87zqg#Y zleccEv|O;c-!8Gw)0HzO$}_E5yz5=DP0Svn9UgDBIj-H1QQVj{cm7=Eo!bk(UM)Uk zv$U+Vbm`nFuCF+d$Lh%40)?8PRxh@O z&2XFP_RCFPOlEINsHn~2WmdDDWUDuCn{!L=-Mq@XdQWDuT#ZiK6}soTgsx{-sELE+ zErF#nvTG+l51YDWab)$k(_s?dKNg5hV-}r#PN{TH z?YtcwpzJkc@pUU3n_X+1&K)^%ZD#V}&zHV^ODoZyE3V>EQs;Vm&#u=(-i9e#E}xjJ zJ=u3*lxwn}=aqR^{f*XK6KXo$x#Q9r!FK7!W!}*%gC<9Fc3$G?y(AFz?5j}ATF*Oz zQWahsBvg~ruTOVj($2gpEXK{WYxY)=?;G5OsZP27$EvoADFA`9!Bpn&A-Z}d?)Vlc9w$eY}dr61RoPEG@U%dZQq`!QJc3~zB>9` zyH@Dzqs`YgeRcYGrtXC51j%lzNwE*jLL?vTd9|=FpK*$E&g5gU9{1&0PwrS0I&JA* zrz2TRUJNVch2~bL-~IY@|LNM02R-**Jn-g^VqbdB&reV^)$GlL=UT~&Z%(L6RynS} z>qpC_qHQNLjra75%(xUSb(=5SyE~6jShw%Nb1Ap1eS0@P*?jF}a8lUUu1kgi-`~94 z9`df^R7`h~$^@%pzEY9fUiMv97wNt8d6M*dpADNtrX*TrZ>pJ9c&WL|&*$8gJD1Pu zOxk*0w=`|Wjl<=~W@XRazSQ(`eC)PkwzuD|+wt}5ZHr^Z6KxN$+nB9+_Hnb_MHjuP z9Z6bq`{&oh?z=tp^3k3P@6}tb3;mw<*OP72T9FOQIBgW~Wt&ZMP1;!1+PYg<3h=3=)j8Pv}2F%DjX~h$-U&| z^wf}f)%8womu`b+r5{e_7{2p2JrnrNtZGWI`jaB3kmUSWnb~U5*G2ow0{Jeoy*?-E zT z^PA$ICu1^dC5uXzhujnjt8DiyTe5Fw^_J^LrNuTMcz9t}l;GNO-_U}TysoLcEfm__ zwigB~&fJ}I@2TxH+ui$T9hA&F?UOl2N&J@KzfaR^|1+ow+JD^{+nv7bKf_Mm&_A;e z?w`$@w9M{e|Mw}o-~Tk|{LirV)SGBq^S>vu)<3z&`{zbB<0b|M2KG50idU6QcfK)U zVM&eR&cZWi`|{F_w(Zz8ZN}Z(6L#3BWmgAWYK_|K>9_VwTX^vVb%Ud>rt9yl4U+b( z`T8__iGIGq_V;~XWvrQ-ZpLhwv~AM8;?Tc!#Yb#q_)fYC)#XeKdl_6Dq$%_Dv|(nE zc#2P-Z@`vx-Ro}UD_IJTs;<7GFT(zy%=Ap#cIBIa%0-o`dlT2{p3_s?V!p$2+MKf& zlw#h@-TC0#maM4>i$pCZU3ihD#BfJgJrbV$H0q8^10r z^e(!ReRrl0-AGkx_s)2I497iXNG zuuo>9r;6X&H-SHXi$@0Zz3*S2_v&PRR$5wS{`?hj&t5&->&P+t_C2X*x2P;rzv|j3uywlqjsGK<}PO~f?yOhI`x``n$k7QI+pwDs*- zt8bdD_c`aDUH#5^(xE5%AJ)cOG2YbiU8vPr_IcO4?aBU%g{2dxo!`yP?epur3`zB{%8HW*y^Po6V3Hnfp5EhVikIu9UNzI(>W9=h5PV&Vs8*kis zoNHMA)!^UF_;a2~8zx*d+q&;mX+=-e%#c3;J$^G3h=m z{qx8<#^_M$dGF+7n@@xopHV!w{-HujcuJUJ!GX+`PU6qhy#r@{OwHGgnJA~QnbReq zHSdzvN#={%XM_4qI10HfD`_(OaO>{(MKZTFDmqrz9T6+?DK6-`^6B5TC*gf{^R_IO zp4N5b8HeEC#!$QJ@}D#QPCVr``QFE^FMYLh`E-{4b_{io>%3my^jfN>I=MjCJ9^QR z_8TcdE^Ucoz1~ru=gwB;;kl&tcJnr~a{+s|s}+0BdE1jLovwLRe14f>Px{x#5{&P= zSf1E_Xt6o)pJBFo|M_PrOX6=V@N@ppz~Ov`|L3NPKmXFa9O7>IMLwxhv&=BmgI-09*gon(`ny%AkKaDer5iFnA{Q#Fpao$ zZFw__gX7SBnSly_iY z6tWEW5vkW_b}{+dU#~X(XUfy zyQaO$Dx0!us;#bm3h%1T4bu{|H&5Ah?%y^m|7Dh|-ahB#t*f_jd%1o8>B-VOd-rwC z_tN!v)T#Y7JL2TCjti?deP1J-bEEazk#wI6oj;E{FXT=Xm}748R_$z+{(_}1-*wIJ zTVdMk5G9G`P2pW$D2&+BzN&fUCkam;Y;w{MSgH}_Pf=WblK>vhlDU!UJzkF72K zk=;|3EPsK4fr0Uz1bV} zY$}`BUZwPD%heWNQP){6_O;X8(r}{jq+NE7xmr6ivm1HpY%l-Wub{9UFL1_lQH)4QIi zuJyZ>bY$s{H9i}&-2Pq>UUb#t_E{IFubG$L?&G&L5}q@=GosSL&g`=u7cP;4OZI>^<>Sfn2PQD-f zLZ^$a*m8esgLf&pKCPDPw|&Xe`nPhDGt4 zdNXLNfA^b=$E?}rAP+G(*PYt&W?owJqL*zfzfNb)sty<5H)kD3`qh-#RqnaMb9J__ zp8Dd%uZ5efT!oy|`3%0QtxTVDJ#)FvionShM@$b|_%z4`bHCPE*gMNtx-74*@5HRx z^CRS?!~`B(`gH1D&vdr!X-8j{n;JcPE~3Q|(V0}tqv(~~Wij`=er?(LRbV$TFlcd~ z^q<DS-cUtXO+OTJv26rt3gUr23m7+gi{~Y>p_Twx+-ojNYCe5pv^VK`k^3b&J zCZ)Xag zJ;^)$G5kizc9C$ek8>oZZf#rbuibm&El2sEfv}~t|%ysT63nlSKspG z54OeI6DFRVW#PT&-{ac2#2^Pn>CrQ=Wp1iI2**H0@OO^Ax z&ZU$IVzOs%r&NRlP7!`!K6mx%@4dfXZ`QT&d(S5qZDqgi&Ceq7t9d77%%0D@+iAG| z#_K6RJvK`1xNY4XUHp4umxOOlaf!>jBMY8B7da|s_IjSeHJzY~0%C z{_Fj=;yF(YkG=Bg3w*L^g&kk><*ko<^W%59>|Df{vG;7y6^+!{(;huK)K&29@|M11 zC7Dq_mL?xrSfw2MjK6KplO0!=?O0`7x5;y%^D2wmQ7b34nY{0uDKK9vVK&z7Fc?qxfjr&LE?QIgwdCnPr6?pLtvWQ`Y2nU7T3ZVJDBa5QLjnqJ_W;Q19I zk5(D^?91xiTQpnJ#h+u!d9w_cd3wPgPYEBdvo2KCvM=O1|KWC&&#QQG8C$^()7FF= zhdLcyzKP{@?XP^f$ebD5u3i(FsrU2T+O-o@K07Juym|Ro&}hpBrOf>6AsUlkcN;LC zeP3!-mpCu)PeoaCq#Z7J~Th&oXG0@=KW!RYdw5IwryWsR#@nAow-o6v32Ld9gFYGmyb!=K8ZJJ z;`AxgH`mwCHv75{CPM6047HhKjd6IK`4nJJO z^D$yg?o7>$DCLhQepi)Ea|_#&@;GRcx#>0)pH`uyuLo1q6gGW1W_q2;s_1H}VN%xg z*mCVkk1F;B*SC7>xUCIcUaYsN%S1hF-m2%{(oJs9nHel=EnOTo@oseHeb=ecLfT=c zbG+`a`SV02Q}^A!!oAg5y-mV~duFb+nx%SiTCCHZv#OI^GFBh$vwAGEVBPZY7q_*q zt;l(#)oHSJ?;@E+$NRT$eERj|t@seFsmpQ-Yx1}y7^Cl=yoEniYYhEbO>KxwsxiS=Q+o zX`9rwCbhc3i%k05(oz+j9$mWrW!d4WyOUi#c}~4q^pnYW;VbX^5%xdN{gnSZ-S*L)q+j061OH-9PziYqFMXtWZ z|1(|WKZCMzc6!O>l;i&yn5}1YJN0}$cH~{!%qWn*F6a6R ziu~5?RXdunWs6Ir;eQ6+oyXsoWbWO#(l6%3zZ0j7F1^aq|E|3Ke*JOA?cj`tAXuE< z$X!`kaZZ;#*3w;T&P{QVyZhEHSkZNMtMu2Mm63frj=fAO2y!Lz{fD126HdJ8=2iKt z`b?#I&&{qpjtW<2r{HO=#VI$9Be%9zc+Qy;CTcV7&K%El{reFU7Q}4)$QvHHEoEv7N8adsDN3Ptk zU|7e|FCS?dKY4fdhS%mhjH;wpS>EI2dRg`NsURdAd%aQziAB#h1?5 zpf9hZ&s^B$k#zdfl#5d3uDjoPnC_V`f1KO$%A|X{9$&xfUHRku|~n@ue$SV%zqJN=dKdW@Y_bmWHCL$qAFy9lU=F zdv_Uh%!xi_T*Y?$-RZV#^<7>%etTcf)ZN#3N~?O;T8S4w)<_8lfBwVy)cLft;mrxI z3j*fo*86m{_VT{pr0(`@dU@HGm3R1iYh5!=CeHJ=cqia{GWmG&X{j~Un~H@p>*}++ zycg&SZp$lLWBIagm)FY~OP3pNeE<5z>1o~?h5b8DDSYf|ov_F1$l|vz?@o`2_#rXX zaQX6}tRkME$&dc5YUb20zFbpl5c!`$FYnfqLv@A~$J+kbZv8PUS?c}kb+!zl;S*BL zj71k7^EG|DKh^z>_vdXtuWe~{OWbsmCC*%S7M>bsYZjg~2gJ4_og}i@jYGe`(i*+lNgin$2$UIri(w z?q4A*|7C1cznih9w50dvK8vELc~VamBR1}n4Bn>Jee9-mxaFz&D#Zy5nX8}K7N1_d zonx-BMbFjCkw%jur`$49bAFnYz2niM(9~yv{B6maQBOB7D%ELwvAbmI(^*DWb{>D9 zd@ZGO@yuqg?-~rNw1nr_G`Pmatlq76^eKnF)j{u#q7Hn|zDe(x-S%(lS>;b|Za=5H z?TneUa^Jek`sd}?aj-v+wbR=o~zyUymoU> zvUU0u?dsEFaZCRMrx&{@TLx#AJ?pGEw<||IX4dN5_kTrPbatkBTo2~CJ8k(Azs>6; z6Ms$LCUoS1zI#~@W6PNtg|3+KmuH_zQp zn6mPezI5)Kx7$p=o-3a7q(UouMbd4?b(dmJ1pT}%l6Xi~zBXoQ(V64P@AWw6+`n`@ z`pQbvm90J#gV^SH-jxzqTsCoOVxK~F)Lxd#sYWta7y{H4|1-2GK4brL)26Q8SXJrY zQKlmKA5L-!^=Bs^fBxAhi0O1qN9kvImXGS5rMEw^tos#Ix_L@tV`t$rRcDoX*4oY@ zYZtwqDm+JSs>r;9^*sjKA#P^2M&-i(3Y&TLoxZKF-~6B9%%!T&UAL_H{zR&Ns3&n??m*bx2aw zE^cK_{?gv|??gkW?mGR;Y8hYnE@_!u@mw|C&Mhf) zTar6BaMw}U=<9CrQfH2JMae~lZ(Xf1)#IGD!}KJD!s+T8Ke^bwNyrYkw(->a*LBNY zMH+1@Q8Qn7^Vr{=Dxclh-cK{Py#HL;^y7yelPCUq{`9J)fp$o{Q-I7=%Sd;x+vhe! zJd%2}F>GqM`<;{b7F|iH*Z5j?y7<@}l`GiZBqw*!8td!2+d27Bt7nn22FJ`sN(p6EJuCEt%U3t-JWD+H}ytb(Dma@lG zy=D2^gqJC-$p~Bci^c!F|KYZ3dy7BDKbLNrfY`L2_t88ET`p-#G zX3H<0E4F^W_q5Kn{DfV#z9)mHAF7y?b?0j9k?nu3pD@e(q*}8$t7K)Z&kuXygj>op z{4F<~o4WOv{4sfc!yr@ZGii@MaWd~tT((Rw4W>4mz=)s&3G z^Q3*F)iUe0T$#AoiB)RDV?8#p_T?KLjL*M)|7}u6#P#3btPj?iu9a?oR)3c>b=$7K z^X@@^m2dy}v%9%B;^No*?w9L$o!1}wdam#V(}!&JXw`Qj7oO)iEh>HT*YBKsbjKkb zc4;S*s|)?SPUf8A+`WcvW6Z~0&n8{ip>yR%u;1F#p&B_F$Au=oc(QIqO`6U7s;}3l z&s$YyvNb#CTUMTEi%6bb!i~GxN4DN6U056(HM!(ur}X@F)^^vX>{L)WBa-~+sr&48 zH+1#5c5d{TCnUTgIq%a_&f@D%^B%>e|333{>HGOvS9LcZU!gizqC70@UfW~7iz{a* zzC3?BzNNA%on=Pe()0xJguPW_OSEHU#g^peDS%cwkHZPwK+b6u;D z&fsZ@uR`V}rcCgxo|X6O<+|HR8;qYA9o?Y8ZN2{I@!5e z@zCm&b$UiOk21%;4L&O!o0!jgRhWS5-?rsr>AB_YXau?@LwHPKlI%*&Y%m_UuhztN0?;tHml;I}Zllo;FueKf>U$ z$!*o-+}@|R>JA>4Q+ek#Z*ITzo=ug$CI#CyLIW4|1gcN=e`oPBBsQ0~Ve``K&*t7w zHheC+Y024>T(@&f4&M=Z7k|JfZGq0Y=H0K)OtWSh)g%Q^nL2=^Fi(_X73Hw+pEKtbFQ0hQtYdLq zZC!e9%l3WyRd#5bJ?ITS;&P)rZTh)oMQ`T>IBItUa>l0zZCb3mbcaXGhE+b_P8_** zQZDbV<|fW1@51H#mK7E!rH1`WSrjUjS;c!wbNV8gD?xVId&+$yc@An=C(pGyJUQn` z)%1lf`qAg#oVE4#-Mi|3O!BkvO_^(t9l4iz`%g$`YIo4G3uk5gP6~%N#%BDC*SI>( z-r~l$+ReVVpLndZD0%m2rmx!P>p{7i!B;MxRNg%0%i|Q?Rzn*b{RC%8lPxC~XG(Kr zD$Ly%U8<$fKjG2&x=)iIEK|7s=I~7O@SL03e3xsoma0TCpSZ+!eevd(uhImxi)Opu zyz*S?kL}f6<`dFx)#R2Ph@HXE8tyNiTYUb`@*A)1uCDyIsCT3MomEj^^mrK@zZ`K@ z`nl}JyNl*IOCuhB*q3|e{aoW`*Jfn?JM{P88Mc+XisxTC{rL6AzcrCh9$)`w|90_X z_pjaBGOwazxHs{u$vATV`TD0p_xIV8bx!m5eX}Tu%u?IpDf%2l#5QmS)q^Q6D>Rx3BH&}V$hHp^A5e%|p3lKpohnZ5rr+_k*!CaTbS z(r(h0sry}~ZhR!vulMo0ee&OH%N0&dni?KacI`KK^WS zOUI_1JYB8nYZ{KvyJL_U^-y}v(S6D`Q3qzLyeXV-Gf&~~J|3M-McudZj*Cv~VY{~B zrk2*OlUtwcez4KS;x2vjpbI)T* z#`G)P+-W>_mwVyrhNOa)a zecxt1X?>c!)z4+_Q_GWAmN|0SLMgV{k7NK-Ily@ZCHoB*@3%WCYMCF zov6w?-G1S=jrlzHg)grkpZSJ8Q_5BIyKYc%ltGoVNl2u1vftmiTp!;_KC+*+Oz5xi z*2W93*VfIOxBlF0@y&P+tmobC?0sd%mVxZyLi*A(5@$;{737(J%U`zZU;h>% zr{jp3x^~L<}`|pYEt5;3?t{nR7xzs};+k3%!F?l}^dR|;=>v=oF zQ%!P3^xxQ+qbpyX+p{v^?2#=_tA3dH?ddR8*I2}n+v9X2z+EC>lBblIr|XjJTram- zB5|#+dkuR{ug4@yT&i`vW{{WU9&Nm1(}^|NO1Nv7oYwkX`0Q?*x2i~Xvd*L{Yf{oquF@*}WvH3ic0%Cv zqjRc8HXFQeNiSLQZk^4C3sYC#I@E3%_L`@A%fE~2+S56H^o8v2_*b{(`F59`YQNu| zYF=dZNNbm@_%id5@E!B_9=-nd!)e|b{`LBoy33S*^N72Zap~nu2p)m_a@QYzTQ60lM#(acUH2gMzt2XN=Y~^ z$+|3+RjPSTzsO(Z>?vd4Ew^)v~`SE+pPhn4x-yf+?CKU#U{$;4yXPFruBd2&WQb+zaro%;7+=^gr@!>LoabRo4IGbzvatq+;jFP^JM3#6Zb7sD(W-weq{Rms(|G3m1(Ml zHO;oGf3&{cwrqvT=i>Qgzq7kHSnTidT=K`6>&Ma=@kiC`+Y0Oc7Oy{|UGMXo=koQt z%l^&$_O>VevR#8+gVy(YiKzGcZvUIGUL)%Fw%hr6b93@`WxqRD{PueMj+tMs%k7)> z_`2PUV+Qu;UmUppt@WqN-?wM~H8E^)kYb;t#5wx>PMf|jeK;J zV^KjE>-l%T72S#_Z@Me=@~y|21Lvko>())SUvH=_lVo)(^4um#=I(6epi({U%L3`j z@)>UHreCdLKD&2nj*?&VqM)CSPybEZe%5cpbffHLVn4P{mTL*($!AGVdG4CoCj2O{ zXI<{8u$eI*ZJu3F-OIeT=S$dMhM0gYcOMs7Tt4x9b4IV=$&lOuQb&cAOV3s;o4;k^;insZl)cJ) zRM+^bTeUQ2-;^0jT~XmeE9cmT8CPBpTpqeQqA$&J;i{+^Dt+%Xrqt9L&G>R_W`CJ& z>50-BX3x(d&p*vS7s5LIONZ{xjV4v)DP`zEWj(sOZ0Qx8*{2Sr$*)yZN1AP>|wPpSk+${>?vpVY%ex zd!@Ip+wGo}S8Mp|^HqkY#cz71f2v`;dZz6kck(@NE6cfuWB)TSe^}G?sM)+`#dW*c z33pzU&3b;fC;hTd@}I~ruX-3*QeVnt9Cu&bsdD!3qo{@=LY}jTs^1!*s+@H%O(bYiGTUq>Cd8n-_`#!I5PNE2Q@C$ z7fw1J{k25vn3c%dn=uhDlZDiaBlmqUPo3w{YS`s{yLM(OuiUkrAvJ&dk|uAP<|Y2^ zxyX`9VN<8ylKFXW?@q}V=k%wU2Y%hIai=Ua8r0Dn`XNIfYce?Ny5>GwcQurKQrNM%99DF^3MJh|5bNkzsCN(C;u~Ca6sjWm9=u2 z9r3swJ!wMg-o08S8iA_XPC|>_Cd?IH>NTV3E*o;OvIgTknUsBvmkfEH`h)4ZHX|-B}+!pG*zhaouY6VOyWu{dIxLcYc-d>^(*mzx?X=-%FKW^|tokj@u7*`K0<~{#5(f^nU%x7XQC_;Yl}N?tkYTTCesY z|JmUP-U$p0O!{~4lscA#?maWTb}#RxXv-&_OI96T!V|T;X7ll9LB~|qXvI(8lI}a% zdTshu=Ik^1rIFt@o{YM+gwyo!hjftPzo`r1P)A;Sqi<8Z@6@44}Z1XMpHQF{?oLIbak->7+ z-*Ezm*F*$qtL>W`?&mL*@ww!eta_`3{h|A!ZfZIiOMSX$Oto=&vZ8)-@};yx;xo3k zew6C{y;fY#Y@=KCwQpY^yWJHq zVO@M{l=zW_eW7}-0ULsabRFZ5_w>3Zu8rFyennGN_+|Iu=)KK$6IAj8wWjS{n3j~6 zjeUVQv-6#p+aYoK0g^Q*mpM?T}4%-xW)HTtqFF_`E7nQ!C~%*E^c^ESfWWum8C>pag@48PV2JcmKv% zYt8*zbX)h)^)`-a!JP9g&-~(_usLbJ&eVv2c_};YEhv@Q6!f(BYw_gwzI#=sUA-77 zy>9j|E4%QI7R|FK9-Xu`Yw;aU-MDQY3?`##d}poO|C-+1pn0dPFtx1Vma3FFcyN z&-{8m18;SZ6YrW=vrcWdJ+Qra^{a2<9F|v>{8rICb7M*F)|TT;m+~@yFVoF?VYJ-k zw_MqgS9#nwE*q~azn#dy&^mYOZNWI>KXG>hC(kT2_pD++ zzMb>R%ad;(_O5Ib7V2}mH(y>{V#Cp>MNSL-I=AMzyn1w(t0pD%-8cTopXQ$&eubI! zeQmwYzRdDq+;Wk%%-79|SbT0RU38{fQ@i%>NAFoj&Rh#SwmEj2yGlZKzmH^Zz(K{# zuw{>*1g?0pcWz2m#DS9<2?ba7hHpGEYr*{svvHi^FQ?!HJ_H3H{V!istQ$J5`aw>bKp4nM;mr*#7KawqaTkYBtq9v{z zy_1{;OwM+jzKVADxoy1dz5bfcySgh9#Y}VAwmssTU@c{KU#n~PjC)JHlm0XGg}uBp zbIv4N1G~*Tl`OSav&=I2b?>fX*C~nVW+xVXQag5%rS|OBr#ponF|}Ax7@y8=aXrX9Jt=HxMr z3ww)Khol|~Y}p?Zb>PN}7tfwF&JFq;eaXUNeUwwtl{EpGGab0XK1IggFnYJ(fp6rC z%BB6T2XuBDuUQ+bZQ(rmaqs*~fBrIMBtDuotKhF(dVw!*O5uFJyK1cwVhi7jw$z+D zxSs!0nA1fyo3*!}nmwv|t}j*VSgVuK|LAY}vz?;RoTWWWZ+z8Q`}^^`tMOt&U@o6cK(HToXW?`XZN
E^}{?E)^AOic~_b11j4=}y?8#J4&!?qt`_IthJf&~%_Dj=NJW)|LcpX}w;;5EX)o1nR`=uwmdOm&eK4qneML*d? z(iI}Vd_ShTc74z3eX)-7HQt9F59=!WSOpXvbDB#rsf1QvjrZ3o|lx|96e8{?Df{!TYAiZS($-Bu&(fY z_R_zN=jPhP%+(TmrPuSSt24&E>~MdyQuM{3dr=d&?^Q3mn&@J#+CA~SpXW3cQ=!c< zXD2PZ(>y8T-eRs)1_p-b=_lHYEld0DerkUFe%{n|rQ8cw<5{1NA1!;Euyw23qVFY_ zmq~B&%(c3DTkO-yzo+Cq0#B!2i=D1ol#!F0)0A;r-LI%^JC9Vj%VGH=e%foMSI*lw zX!y}uVbXZDnhtFNt|ah>a~i8>d5|Jn&#G<=S0y113=2hU0B-|sugY+Bk6 z?b5fNTg|1#=WadI#~@(dR;Bo;@RaYV_n#*^zh9S?9UoBoTWD+B>=~t7{WmRFO4Tqf zK7BFl!)Ya(x$9o9iz~lyX^CjdH;rF&o#u)?FATcJSvkx4f=#*EdvD=rF8-qL_rt#C z2g~X-MhJ6Vs%YA_Y0aD?$)>MoAF+J8x!fZ$CvCzAVU(}5aa)J+-%m3R2VK9c-s@?w$5-*}si~_ol4qJtOIvGnNW!PMO3R|Am3h*Q zN17rFclLT$*DP|HdS0!^^|8T>*D6kuvPm6B9{YCORGwII*twde%wOD`7%ImHg6Q_9Prg$wCUj3}}bG!JaknmeCF0-l;85`)uMHmwdxWUv8K9T(l%+{9xXI&na}pJ zcKIMvm9u>=JB5z8t;#EO*~qk2v-kR*-^Zt}xA%KnU90@%-Gx1Rj}mjsT+e3h+H8Gx z?xNDoo^Q6^VO?pHW-r|7`cU9WwoISHd6}MVE2^r>%BGx|lPYxF^!)PH(l04Y58|KZ zO`5ymLjNbJ$Mb)l3RHgf)aS$TN3TxGCzqy9%S|l3`R&Xvi&Kj<1+}`KN35Fu^r-LM z$TZ=QFzws1nKOAd9%*ac=6>U@;Jl>gKetXfcXZ~~87n3!nz%;IuBnZCu2w}B)3#2@CLYLMl)T&tC%ZlF`81w9G40x?%XRCv zKKPgVF5_mwy7}EV#ALXiY;|}TYkL1LcjUECMqDKxU#8rgS{@QrkP-5*xOkCBcT~(X z9{)aHw&nUSvo2-!yq?*>p#0vv=&$3+(obIN`aKhkudhupRqQ|d+`RUF$@U|WH)aJH zZaTK$cI-6OwpHAMnORO#rAzGO7EaRZcPdCKYdUwk*ldCWgJs!oOV8qvyZ?$Tecohw zUb#MbH(yDk`R{o@yKdh;A+31MUjOwgPro&yQK7C?$yU$hmcHCML;H?Zr_9B0598zY znTOu>>u9^}`h4oX_%WRml}FPbD3IQ`t*ZR%{2A5}f4 zJhz^)v&{2l2?K+J-nA9K*ZsO@7*iA;Y)~i@sGW6E=GQN!gceR+kZ@Du69?ll&B^?q#Zc;ac~%R6PK8s{&j%@y~`Z;Ji;ac$a_TdO99ektoK zoIbC4#ckQB*}rF1IS0>4xvA{K7AT?18W`nV9=Q2Qt8cBre4~i4ODQhlm#0-dllpVe zcuL^Az0W#hcCHeX+wt&SevqX088xjHQ?*Wa`Kk+^+40DowaK5~BSfmyvOjh1bN&w} zdOBbEoSx>s#&WCbY3FG|EfW|RL>7MQezPYuPR#n6^U5D8-)|kVj1pXD_QlXG_p}vv zgqFhE`rG+)wx14@%G>qW?#fZQw0o`7_Z1rLNe*50(q3kdddSYDKh0N|s}#SM={4VO zRio)?nv-zT&vxc9v+H*iEzj5I-T40a?#q3}+t(Eb#%DZeuF~Cp?0t`$?$i~v@9my9 z*8Xy6E;bK{x4Otu`({^MucBQ+-BNe&iLR*<)|OZHsQ0ZuxAWN3nv}m<6C61`RE?6n z{AOCZPMFi=ePxk{!d!z$mnmU0t~;I5*jsvG)0gW~FPH5AjnW=ts0HsA4We|J9VqjW zh64ysqW>djM>nhN&kN79IL>{LH;@z|l&QFQ_9x|e-1 zXgU|Vi}P>6{jaLNZ=XoL`nF82v2kv!pcRYtP`AN zPo0}#@GMihQ2V6U1GhHGDg3%=QrXe318*lrJD*a0n_Z$C<$U^be!9eM$?G}ER?j7m z70yYvIA`4N^Vs72!#U~lZH4m>TZs5aZqWMh^n#EF(|?9H@*;a3lV&Qfd=mBh)6oNS zO;h(j&*Tl%JHGva%g?Nz(=GqTZJCz6sbXnpmbG?^$BERenI;}nTipFP4_K|`!)0RN7LK>{&~0Fzq@_E z=ds1@yYtJ}uX8AVf5Fao()~EA>R1069$XW@TUj;r;q8~U#TWfPaIOuSmR}++cz2s& zUq!-HrB0722UfC~7?}opX7?EGY&@2*PwZ&C^}0*S);eqBpQv+Yp5Lr3G5Mgc(}C|U zMd{2DU%g)!C3W00P6!J+S3b#6<;-r;h1DvBN-np0-MTzZx@#O-sxp7yQJvtGbD8f> zxuW!M$=bU5`3ntxy?e4I?W)RN=DMRQfirr(={*&y(%f=qN~XuuDOX-Be)-B&y+%2B zA$vw#QP>VqZ@rH{FKtg3430BhukNK9Z|7KeenNEA+aAy7+&Qb~O?sA@qZBNa;O=F0 zZS6;|cbU19qmC~AX1sE`%F{Nr)|!PmsjEDa7ZSfYn9@}?(J^oqZm|;&cl(04IN&axmu%}MqnBk9P ziN8)utvB7?TBQ~B^|61?lUI+!{@k;;ksn{)5MzT5I%&YVlvv=xu+-QaoGyzqEk z?XuQJb#wQ&wx`YEPQve*J7*SqZ8VT1XrxEQd|4XDrxKU zUw#^G!l5A>)mEgancQE$G9yZ=^V^@&uCn9Diz-XQcTF$x1Q%DODA7nXc#`%@nP{X{q#Hh<>rF*IH{!#om52`59Z#*Zgdcxr)^jZUruT5oR8cciOjx0;_v#NimvRpt^sn+rDAti15H zTRrL73ew70u<9RLUQ>&TgLHkIj;t~{nZ7KIq`ckJ(q?`+zHayHZ9D%n z$g$r6t7l+8uwXs(pWk{Jtwwz`YWHA>>TZau5=`P^--LY`I0)-w`k zzg{-$v32e?!=5L#$M$Z^TJ`VC8Xc*$>wW4o!oud*IWo>aD!RJJVVb+ZR5Q)A`qY4} zbF+(AImJYauJlT3yZYkVX#4hMx=JRuW|TdX z-M2(tWz*I>mwAkHvU}d|yPa;GVhavG#%TY!x2>nSRS6w`8fC|M>FaU*^J`wMyP&vx z(XAx2&wKklC3l7$(c8UNAnfus<0pk*RcGBgayIX#$nGV3GhKF@DqrGOXg!-6=B2H_ za_U96f{h}! zp#j0Rb!YAgS=OM)^43LPV#;=`c(AEktl&r5eqr8?71c(^uTNE-+`ILr*W7?b)|^7( z^Ly5Y9a*L>X>!-}+$o7G=OhI-E((g^Z4~P}r*PTK+~deTX}z?(iLOr#w{J-|-(%nr z5qo)cc4b*Us&sUDV>ES+Na^12>Po-_5rlsp&l~r?WC9_Taj3v6Nyr zv54L*bC##89o8B>Y5V<8Xi55%rI!17&Ym)UIM46*)cuFeeNW%Ny{&dx=Dyigx$6r1 zFWE#qDQuFLOX_r$j8>jlvD-SO%2F=HW$xCQovl*^bCgP9p?j9Dr!xZS;^;l=*m&Kz%Ie3p7oM;qQc958ru15 z|F~3;x2q=TKSTTS-SJ22CPvn|^-nCGVzXaqYZANbq<^6qy08AWZ<_t#)b1TOnU`P9 zd(nKm?smq+YyN@9L_G4PVsE;cmh_!b)}I)5oW-y^=zzm7VeutaLR+3jxz*R-e(!lh z`_;>>T-T?*niFyJlxgzi%PC1_7u#n#Z)S;{^OI%a+o_G(dsaEhcW+%;tXk9ibLv#9 z=PnZ-)j#2iKeuhW;o+)d-96X7u1|>4nc{0)cIA5JcAwByA7+~ARjhs8oxAqY@)dWK zymF4L?eqQcQbgvpmr?OA;R$?@A*TXfE9`^ktf{iF#>1<6&})~Z|gZqL~$dGtl4#`MX({3?@8R(c;|yZA)v(=*N| z8@;stGaUC9{8AfV7#7s~@zd(6-|J_^pIEcP=DNpZwc8;w*JID9{me<9F1_wZd~kW% zl@D!?wZ3gT`DKOP4+aL-lAl~}GV{&NFPLl`ttJ|*4|7y zx#Z>9?oC!jT8(F429=!PxN0nucP=L_J1afS;ig=_vAL4Zjf2venTeS`Q`c^l3M#3+ z=x19Q_KE*^@U~;ym)v1|yeRGY1^X%KWl!Jg*hXL5ow#Au+Fc8LUd*+e^lDYt)%BIu zR}bCu>hRh5_2)58fk*{i>(jS&8})W%-0t77@&-%%(ziQ~PWIh;e=<*yVT%96s_aG4 z5#Lgly)jk|(qygPQ*~c^-m*<0oFC3c-$;4SxoP_RH5-+_bG%yiEnw0VQ`y+!SbK&= ztHQRvxq3C@NKBPZz;ikCixnH(!KRb!@_tNNit(_~j%~TYM>T}KYi(LG5b@kjGzQy)y zGq3+P{amt9ja5vtm+PwHgooK-FE*{*`J(e#U_Hm8uJ1GQ59>Sq)7+h0?DH+VxAxiF zp6uS9`V_U(WBj20?BF08?}>8PrMQkuH;+d z7JRbr@`<_8Mf*%xK2RmNhWL+M&_mHx<=zOO=yJuYAmF+Y~YqQy*go}GGN_RCynr>fRoyFdCkHah3 zdfB-P;lUrS?M%PSms@lyTx3K4XXZWov&$##|Fyku|DU}LHUAkj@5R@jIDY*2-$&;E z8U95#WnR)3U;Knqy4^MWYi?#*-h(GmFSgodd+9|)^15n#+pNEP1^?`h-q-qn`F{PIX7_of(mQ@yz+z&E0LkrlmD*Bd042Do=4? z_Q!>hU%q`k{b6d-n}u#m(@&ZUx9V}*Ma(_-Geqjf&E1R!HIcm>cb?B&U?0G@;62CwR zn{9F*Lb^H|o~N)o$4Sk-^=5aNZkD%lme0gUR^wB#PFK^vi$s0ef6dF{-OHpVm!FHc zB{r{{&i!bIQ;O-+MbD?7%-vp2e1*X((*C(+or_>8Ft=au6s*^l!3 zR+KEe`Dx`d<1Nb!kAGWc*3CEjp_IZ;X6NRx()Q1LWUcoeT4$HsRb=#9dRml_+3_uT zxj*i1c*-gAV$N6VjI^hBa~l(mta`Dy|o}iwk6gQQ`g@8dGX-Qzjt}+tPUKM z?N=zB=$W#~lX-D6OP;A*R!Q9iJ4=O(^t`A?8;z2g7CiXRkpBKSYt={AvV^`bfhSil z|1qV@P`vi_yBQM>o(N?x%d6}&U*EFl=4oZVH5}JW6)#u(Zcb`z)j0W6`Qp3jxm{uUw^Mnj}7+U zz<%sd(q*y3@li5{isjXHrKhK#f8Q6f?XGTpY4e*^J6_D*=rU{T^A(@7uN!zsq=s${ zddR!&**X0U^QO3RZ^(|=GOgglkKDTd3>;lI1z$QJ(bTCGKAaWyDQr*9gB|J_P2brk zub18PH_0Q*`tY`$eJi#kMVr0USpR&xikzulf8K`+jel2cpQdi!@{aeIh2gGkyH#`p zS@Wu^zI1)LuChYAcDci!b_IvUHM159IiERa*fXOj$@jj+@rOO>wO?-MJeK%l*dOmx z-@%&wZ{~jnq5E5^d+jT@p8sc<&wJCUlJ}wCve}wzckW;J^U=o*LI&%mXtrJx+hdok zre$$su*^_2kyP$`&Zt$^3Iv}Z8y$NmfQJ@FXP^PpT`$^#XaM0gvxp-wf)~-`+O1Af98E+f7?E% zS87JCrFkV~JnT^Yezj4s!|LMKs-IVjZ71Jc9eL62*|Y6yvwi2xmQC(GF)dv@ zdzIkkgUN;8ZZi74`?R{_x9c`%;r#A%6BY&=-3(ftz4-NYjoiXnT@F;O?eR{? z_t%(nS3ARHZI|Fe-BsKHy*Xbm88qI`6;aO!*%{=TGP&dL9O*ul^xnR#r{-qaaf-FY zUsFDA-N?RiMfI@_N|sxiuFl!9Rj4UBDZH>kWv}OpmVA3q3#GdLH|Cl1XTNcIkJg3*q+0POE23;VpK3dToom*|CM2j-|VI&fRv? z$mgZ)i)byQcZZGh)b=$O|1~)E=I`RyN5aCE{;Ih2=*pu@myUGK`8j3s>)CO)RwYcj zS;BFnL`gL2^0%v3vtqu9)TUf)(l{RJZuF&1?L0^JOvjiw6``Up<<((-7XI00v8GDl zk<%4EzD;E^i+T4t-!GN-3*Gp7UDr(24OuUfb{c6s*~?sfJ4(Fy;iv68eA-hoQ*?Xz zs+YQ|_1SC}*sW3O@+`_XCTfaqc1UklPutZk3MIYCNio}|w3>KrU8N{ATdH0oVs6%! zi!X9?C+2i{eJV0LvO4D4t2^iJY>Yo?wkYD!deuZDk*-jwKL?AFklcWt`UO`nKlm(ox59H~>*=H*;Ha+S|BU|RC>z1r2Yrsn0gykA`0b+kKZ z-jbVq{|+40N~-EUB^i}6ai+3&H%ph*zdOATJAZaQlstRx&3a!xl@<9VnI-uF3%R?C zo;+V1)AM<lwX|nJzToJxch|k zoCuY-Yx&Rm@#?>Mr~68HeZKPJntiJU^H%N*GVL<3`@Q;Zu3x~8Xo!8~tfmHC)$=-$+Up)@ZoExw?a8d`q7`mE^Jf)Atj+3~ zvC{L{d)ew|FB=2*EG+U^!}}~=QM1|m^)!(SQTxtsyC0+a*`lU(pT*rZQOnxTJ~??w zH*%SW?Z;q89^T3ud+*K_n3fs+PUcAM%$M_%D)k=iRz1IR*XLz&S+@=^c=|E+-i>_E z&$drh7^QEhqR%!jXy{0n6NjLON;%k*jH_xmsnRq>In%J>+-R%!2 zum6=f|E&HLd+{>Yw^{LDSjDbeZC>#``&z>Dw8*KyJhm>3I>y=gFKEfKH8W4n65Vh+ zBS_=O(uWTYU2(o(p?FhhyZdFCFXwN{Zw&bKUAUy(zC=du>&mrTrf=PS`L^pbncEjS zI6}QPT-qX2dC2Fw+NF(FDxbb?K9l*8JGbW2uWcu)@9sGqnWV=eHRp2j`5x}hKGAQJ z_B52H>|(w+abNZ8jFw&N7UX=N=kv1F3OaCF_g zb7IQ!t=n`RuFP%HYII(7UHogV?#**S3lt;IWlvZfI4$BsS+v!jdDkwvEY<6~5pdE) z_ODP+dXkvYX^HCwyOvtV)LDxxq`- z`Nhr4M9!RR@n6yLsCr@3nrD-q8ZT1IFPs^(>|0jemeflcQ4u{kC!)$+czg5tkGRF& ze`fsccx z+HtQ_<-DRi@lkXC`FR&sA1jTz_q@=;>W;Sb^y%Any$Nov{Ji(#dgYoLC(#LoYU#OO zZs*(ro&U*I{?YsN_FnJAN}ZQ+Gg{uVZMRn6y(Y3JaiQ~*GKUB5Mxh-Oug|&X+})CS z^(o)-M^-+aRVlmIXgcclWtdy;Wo*y$*wMfsqJ4gC{)#=@O6KhN73R=r8!NedNAL`# zs;#@+7KfhKU)DJJaxMF1?Yli`1xW>cx2CH!$%eX!n(0`6N;h18`PlT8z8!yV9+Itf z=G&;$tzP=)8Q*=q$p^&GEWDJlNb-(qREn@g&`EBsXDydrbUj@uzSvd0cg|+_X`)#d z*80r7D&*Ynv0$yadckskHN%W2zn9h|6`skQ$y|9?{a)%f(fgZHem##Y;cwAa`IbEK zGf%R#)RX8fPgl=VOp)8IF1)%rTc%>KNxq_4$GZ>V`z;ErqPnhjd=Wia=D#cL&w9&i zmZwAi{3>6#BG6^kvEo}XOZi?#UbFR@C-?Stm(#I}%DZ$cW41Z`XV8tia_i0sA1|Xh z$5_Q^HblmxTwby+II1Z2b4j>p*6qGWi?w#k-B_Zq*2nGSJek}ZcbEcZNfdiC6;079 zi<+A}bKi;yi{oAt1&h2o*BZS4#MCW28AM|r^G)k;sc@4&ttasInP`rb++B_-5tG)e z4!L+`^UK>()#6LuO!3J(>v46*^`hNf<>qOsHy;LlTFy1e^HWf2psnP*CAZEW=d;(1 zJ^b|YhO=L7m!^9<{7Bk-=Rd>aO?|RQwmwQ*`LUP%`E?)Deeq_cbEn2LTfNF|=JT}n z{dCXsnBTwd=db=!99Ld@#4~%ht!Xc(m4xRv8CB=qLYmfB zvl4%wUUhbf)_lb?!8)%#D>r-pi`;9aGkMC+s&$XM^yD3`xSrteI_f*YT5qDyJhMrD z&xE*Ur_hPI8zCp5kC)D4WV} zQ8gpLw%K{3q{@ptx0-1yU0J-IbWZvGsA==937hU+5tF$qqMYjY=U?wE?WC(+OSCQ; zs_xMCuu`91@hA74+ox&u4LoJa8acC$KK}G9X>Rb=lTre22pX@&MKT6eJEq#i`Z>{#pfX1UrshQ{0eL5Ie3rgb!{PXWESY%};U$neYYuQV_ z&ZRdl>hx=umam()OXt?xZO-)}eVnovl${GUhJWPLt(QNtl=(=h*k&h{P zo9FrODqHg^&T8`x{YlT?ZGL@vK~?7FW5tWPqf^dTy7;El`E#9*x8FTmE6eMpLUV|S z)ylNXw-Y(fZ*V!kPUGfvuWS2OTJAX4(57>fwPn+Z`)WEDUaa=n<-e$C$);&1K09&B zv}~C*eNoVTd7;IcXK%aQ5((@461UQA$*ah!>Ai)^b{we6(eV{5Q;RrL%T%^Z;6)y8%bCn24ljk(^^2zVybn6Hbz6M$0_G=)etZ;7D+pISqieUycfM%swzDDOzs+|pn>Fdc#;rv~OsNe= zw0|=RW;-r2OU>3wnsfc~jn^*Q#0`6PEGzFnx!C_iXJL9(dXeYO&T9$S536)`-!HSgqggXc|CMh})Acu8_hhEYt@2h&%c?v6D|%y9a`TkJx6POPx9B|D_A+nL>Po-U9oGyj z*I3?~H7!o}lKzfMFHGL~rh0Bpb5k@@la0(_l6zq2KC_tX@bZmY1Y&2NZ?s7KR^QwA zcj}j^+b^0m5Dgwo04Fv!l{CGdacH9Jz6KYDU0{lN~4KEq46OtM&SPNRHC-2{+Dt`?I#& zD1GJLHUCasm9E;9{`q7}(}DSZF^|tgo>rFH>2oUR$Cqqp_pKXur|#Eice*qsu2aGq)ld3Y)Txe~E<5LV_@VGq(&2ktAMchpsWRX9>G`+5eP_63Jvu`-Xx?dD z*|YtbZpx*!ZyNjF`&#X-`BiW~$tdQ|eV-fQ?Dk(}Cp=e9oc{4++2b#QKUo_-aeJ55}$NpNq zN`Zan$K1PDw=5|->MR_Q#CL7-#rOP6!wS2cIKJnYE?yI-`nF?+P=s;hnOmX!8I$Z6 zA+`HCNBfJ$vPz)APC8UfhrHe9iT8lJEH|Q$?=FZ9kV9An9}Utl5^w#eS1a z&%e@^Nb;@QH`gs{@;2!&mpcwOz2)BoIuewDfiZT2bY0@rxwTox6N<_+?i+qI*{GUt z882t^>}mP;2(A9@Czk}I>aYB!8ENWn<(48iS2gEty7=1myi@)?C;GL_L-)Bq``mYE zhT?h!C0{&D_nPbLdV(CbA@w~Esxb2X}vzE zEj`I!v}U3CB(0m5N^3Xx?y5RbZ?ossCU^Un-e&2gCuOhA-1bbWa<=B|j8?nLSgGuTia_&KYqoSsT-HfKG{EYiKD5@)i8;Z=8CqB+80l(4&`=n zGG6)dQ`4V@I%e6ZQ^j5=0h@}NDHI~YKA-RCz>F>AlmAs#nAKlutrpkY2 zE|+lBtV5fWr!-#edDL4n>D;X}J%QVD1)H*B+fsYx_Et+R5!iIAv*#H{XK>Nn51aM# zTvyz*3V6lB%2K-Cvr;qX*fZ*PX1=Z%}eaW$mV_6}Q)Fs@8jL zx}BS$&Ksxh40d zx84YNK4aFOO7LgA^-#-+1&y#L5?&eLM=Cdb=MyH>xBYBC8iTCx6N=p2`+tLL2V zaaiPQc?^&srx1Ca@hNCFJD~F+!k=4bNYg* z_RB5)Gt7>-E1WuU=kAH?UYrV8cwv$M&y_4UqC0)pKDA!yw)MsqP41G2dp*ydaNQ|U z*c-Oe>E6QZi7x`@EoYlGQ}UelIWNCo0!de+Uv7LB@O*k0N6fCbPoe~GK8)78Ynya@ z&Af(r`_`(Ol&yRuFV+9z*SGt>_q_3P3Oyu#{;g}sX_nTvTARi8zDQQ=Q_E`-ITfAy z!exo)Gr@>6Ta~L%dwIIl&T^T$%I!wAPU}YN+ePU{()VXhtxwsqXOU*u%DK`a^>U4c z=}XOj9NNa%5tAD8{QCOT&!2uB+;;6`@60}(9k*2Tr@l;0yeJn}TAkOj_xO@_iDW(T z7dLl_JDF-;);JTs@T955+K1woZI0A`T;FT|CH_kMwGW#PFhn*u$ad7#bJ<3j(ru00Qm-V{jd8}}<;Y5`-$)s@8zq>gmU7NNW0iSwd+EKCY#7_n?2{&Z@Fr(tt+o`wuwc~R*RbQXrE&0%-+I%v)(qW(Pz0L+;8<` z-eZX={h`ulpNG~>f7-J3@ZITCKgV@cmh76lt~S)KCdxlY8_nHP+&UtO}S@2ZXC zW8a_hvA2Kp?-rP_bVBRp-=VPvhZUOx~XZqa_uyq`;RtRMK(Td3C$&5u~WCL%lsp!k@5Xq;m6HKuDsds^|+7Ho%gZ2 zvoap<`@O=^bcV60`Han(@4uYPn6c!Ndsx_&Um2dB(GygBoJx*NiDYegHTl?$XN5a? z?ELO{AIS%$!Bm#d;+RC()v-ieiFLNpBZQjPdAA2`O z{byL1e)RoMMTh?kZ&|zl8jE!>XubcU^JDLS1{DqYzY8|jFH6e5DD&O7ShjB7nnen^ zrDqtG7f-%aaoK6QYbJL|g|TzYv_Iuj-+6B{jcgU)_Tz5Yt?XXYD|=0@%QY7@@Wxg+ ziAGM@x<7iMF{|zdt(SikC3oHr`Vh4;#`k8cX_h_uK8*(l6iBEsoi` zmQ`p>6E*nA`S@?z?DS{Kdwxo^nHKXPO%eOizhDn{ZZXBuBPEr{N>ENwk>bsRzLc_e%hflA=#X%TFY%M&$6sk zXI+p#`9MzWlj$i!_B%bNc&u72`rUA^%;gZ_$r6X>+HXlsy3SQ|?gz)^_jgnsL(hjC zGERBfX)U<)AcywyoqLb^rAz(!cI)UV-HlpXpFjQ0QF4)~l&j~9UtnAIt=lH|q?Nm- zTlRS?Ptu4yG2K#7H=#POs&}Qs?Ol`Rh^bZQ1g+fZmEyKI%xkenKw68;Oh>o$U{2%M z(=~05rJgsHnHQ{Fc;D&N-Rdu`?-X|4e3%WD^QoAM#?$w2UjI z+{MO`UU#nR7KTKLxMVD>I_h=y*eemKw1+Ww{?=dmD}VR0kgVmBj`hwVGLysomBO{V zTKYfT_|IVX<;ts^b+%zQSaZ%?TDNeseE%w;h(6I}T~B9R()n_$^3o((&x!66e%g9p znlfkIf#+P4K0Pa$c2qU1TqSv4wq?x1EZ4sMbKWMLwc8}MCgZNx#*Vx5w7SkEhT1zn z5!0TtapGB#jeCoxoe-JDI%U%G9`AmQe;v=?HNMT>_D4&ZJ!x0fwC8))S|4*(Z`ID6 zbz!5#Y2DCcp&<@$<0Es16bR{NuJ=QySBikkGXq!s@q5V_*l9pOe z@|!J}SH`vJlW0*0_aDwLi=yUv4BPEV zUt9K`h%ybIE|#|VQud}vGBU#IUWF1TmrC!O-?6u}#`Wmy2RUD(-nl$u-P%&-^iZ$= zI@b%Wr9Qk}VQ*%0+)a7&k$F+|@!2YRnWk5@n=h$7l9{GhkqAj%($jueQBPekMJ8)lQ>xQ&;$XObIvDnG_s%SK7|xm)+IqdboDR_MJsfKQ75HJUOewWar*PGNn_`slM6zMK9iVlC~yGnV|Rt@B7nb zw{Mu@vvJwfe7&x-_b=OBn!M1Z@>uT6`FXR_?Ph)v^@3f_R&42Irn9tH`{o~UIInCoIO*NXm zZa|*YS%1=P zVYlQc?tsfeGk0uYTm9R9gZr=dhwE83dv+LF@BV7H>)f5qUU%khb1Xi;EbO=D4~_E= zv!bR&p01iyYu~t0?d8V0*5@(Yof2=HRAm~DEcy^p?BvGLqh)ncsM}z{Wz~f#eeTl2 z#v8XNUC!Nh+ogAH$EC%-%Wmh+^;Gvs&v`Dl^8{p{M8zee`)B*@rV0mL>I+IXURb!a z|77U8WUv1WyM(`{1$}8{TB1G8WWwVq$961r+p4sck!sM7DF!cAC)Y4)?JzBm-e&Ic z%_FAEQ?GD_qUD(#)wSCgcxx?JX6?51iA|jvdHtHy4(DSk23vz?q!dLhQ~1x&>wTSn zV)6akF}w*C$Ciq&letyqv0Z9PoSpr$S-)~KmL`ue%S#Ak)K!Y)Zd=F zYSP1J(Z`NFKUSx)c^BLEX;ROb{7o;t4?q3&`<>3}`L?@`$tG8HJqu31X;_+>dTrS@ zu9ltv)^6!r3)ZK5)Xf#%p_452Sn738a!fLG&z9lKo@9wXkd0eEl9_)&+N;cGi__Ap zbtV0Eb=N&L-)X*Qf$mwZ(5DM4GJ_W#+n!RTrExdd(rmTPR^Qj1$GRr2yzG2=R^+bN z+iXGO;8N?}FUeXrapm$UvG;j$H>|2QZFNa2<|(&4XvF?3lufAarEl1!je9Q&F4gdx z8{~Sn`=W(n#GKZQsp>(VZZG>U)m-%~-dOZ@m4>0=acjnlYadl>7S~KZn_irHhUewu zjeAb7k-U9nR-uZgNZ%4~*$%TkC&acLS^V;3a-T|ewtmQrdytgKV506&EGm1&=YpB` zG0{DHb)(acy{o!eB`z*C8C)n@ap=}zxrpZ^O zI%el5UyZt$r;3y8^kP2!c=q7gMz6)iTi%@Il({qS(pIx&l@*G6jdyP<(ex}X^|{;{ zk>&Sf&!(**JKE0Z#kPH#GAlD#>H!%ltG2alIlg%5 z-6?;!vPau^tupfY_jaeSs^!FDpS8OJ76zs-e-UVTBfwGp^}?mEDqZI`o!3wD(`S3R z?#G2k+mD%R+%4R`<iC;Y4|mOspHf9`7<7!$v3JrJ{(hKE|XbUH^D<* zd}&r{QgVh{ar5TGhZjBeaJhBuMx#~hI__(7ULlzrmQKyyDto^lUuDM?tQIxX$+YuC z*u+S-Wg$~NUFXg8NBW%4t9CK*uWl^h*1GGxnQ2LzS(5uo&7aq%*xU_# z@owk3i#xs>e)tykZs%+M__EUL){mv$&Pl%8TXyc&<9z?)Qg7#$oV#(Xwy<~evYqGb zWnQmezs#U%wbYenZ=0@fe4a;UE?hDv#J6Fym&x9ZJJZC{dVkz^Hn}fx+xP1^v+Fs@ zxy3z?B_;7KUSC`{`DNaceZRLatVo`q!nr7Wr+@2|`22O%*6KZz6TVJ8@T|JtEX267 z?&443Jz>k!d$wBMn6!6M)TR?p&w1aJoVw5a=&g9c{jEmdkH>ymoACaYv4zm- zZNk2rtV>$HsW0pK`YiS1k8|B?B(-?nwJy~%b9uHjZg0>cshP8DmuiNzE?l}lN&2!o zzx?@Pzo|Xa_qUbbGn;H>y3*-f&T2U`Tkc%rlisqW@!^uw;PrsBZ+<_(dvr#E}me|$Ts_t@<87>Tg*_qApxtAAB*Id>~_Tj@FDxuxgV83;dc zvwZvEfxA<9%*n_F85JAmKDOMMTkgI$Oy+dxg|nAvDz9>60sW`JLaiY(>(fJjvHqmUE-rS=Db$JH1~)v(-$ZQ?rZ1 zWk*;4nzfZDyYBj3cH#Zc;M;1Ub~W(myC+Nc@-1JhW>DzV{ABLuXG~E);&R+7{L7W%25vttMC4 zBD1dMZwl$S_$+4KoXvOd-(jZtY<;MD(MKfx~Z(|r6bK;9<^GR>^imeY35bK)#W~)?yM3Hxvg<3SM~PG zytgyhJxZ4DW!w5_3%^acDQ{=#sVvL4*A9y9dS|JsbJ?md+{mLP%Tc^x-|?*Mcs-$# zu4O%^qK z>6!`Grb>43o?m}FapQ9>y}r)AmDh6%ig};hUf41vt9Gl1Z_-M@?7akJjkO)n4c+>~4!ezEG^#$6lZuWsu~JE=6Y`n*-i)OlOiuG*J8!FQ5+ zey_h)XV1gCrdlyaH(5(W%5R!}P^Qo4yWo6ly|qQz-&RfcUsH9@Q+3PiM>cDj8gIWd z&(T>K+8(w4#L}+PmX+(4wM7bOUeR_D`1P}Q*@@q04r*B*(%BuUWWKbweYe3zn`0&W zr(JVeDyQ|Q;py>5CKg78TR$h6YG}qE4wRo2Ryz6XRK60wJ@fOt!sTYV&WxF~R{8c$ zuK=+HJ+JreN|&p5D~{cJZ%e(^+Md#!-_xc4bqZ}+Ht|QRuUF*TYsSBql=i-C-Bc;J z>*3{&-Q6s{f`2X&)=5sG0=E*YR-AZJtw8?WnIsGTpJSg zMzH1glbKtfXJET{$u97mp5YB+J5~3a>pwfp zKbdcq*0)DxiR`VIyK*^>)}~cWUy62RoBUp$-gj4{%Q#1BFe!(vZpT3o&0v6{gYRPmH!#0 zn8eO}tbh7c+f=pSy4t+5_DfrCmvp>2XZ6fe+UxDd*Kd55p3^xi7IA&q&2z?^F3pNF zUcRib?X&H@UGYB{9(|j&d(V%G6Q5Mi=j;pB`?A;i@weYIraP|O`@nG4chMbH=AyeRG7HJXPwipH<2wdO!d*0*+TpqWlJ+b`yF!)O6ynU;*R%qv?m@R#n>*ae>$7=QJMMq~u zzQ1%*>TL1Cs^>)kW=fjDix(|fF=<9Z|5jJ`C(eszUA#Fr_99!cSitHbthoUbGKy3$=D`rDU1RrA};cTNAac6Dlo@T(VFbPd?;_ueck zKQ4NDr~hm%YtC1{yS{Jt3H|e2;6=3MDh}7fr>xhO>N#f5dAvqVQoKF-Mcm41m7BlD zyn4@K%DCANZfyNl;*9?tl6cA4CJ z^NF{DTiaJmy7_I-fwN|lZ+^4BnE7q8Pt0ZEZ2_AW2W6GKofy$@ZG~8Xlz`z`RXWAC4&J}ODw;d@s?8CKSeOg$~#nX1@Lku%?Dv$a6S+dvX&R!mi zWyg+M3x$K6)Y<|{^Ikl zX{@VM+4Nm^Mf_CzWIjnsGdg_Z^J(uro#w_q6Fr|elc6=NSmViC?$x(;J-nL3#}#R4 zzAcT7U1@>wGj^R-p1Dq9-jS(sovNoNFX#NEd0v+LhWKB_Yj-(4z0N&fsc&}ku4vr# zExF&%XTl4V2%}2o&m!*v#dZX2UsjYgKjhs9H3`A|Q_A=KHq1@vJ8u*@ z^RTSL^0k&P`;JaJcB1k2L{F1TGhbv~Xg(Vhntox+mx(1}x7$?$7Uxb`ov0LWY3VbG zC(G>(zOq*K*vYP}-kGvjn|a@!mXEnNO*ZbSKWWoc+-?+hR(fS?*_yZCzN~vBw)wDf zmv70W)4}Y}2xn${WwRq;b>Pjc&z-wo;uO3i%VjK0&D4Z)rN4Tw^whWRzC{!K?rB|<4%$(@IeFz3?Fr$!!X1aFyzSL;7Mils`-rRb!b@yNUiQYc zEM?ctSJ>neG2PkhdMeA~x{5t*n?K*Z|M+p=t9c12Mym1OS@)m$XS;K)Ny3wi$b~Vx z9#$JgUgPbIQq4Zq>JjnGB;9PubbpuWrhs{6z1bEz@7z*?Z9KQ)gAh zr|(y9?U^&N@?o{GTKP$qAcvEZ(=8m9@U8V0*z7A6bz|P0#e7^`w_VPAM5(+zck#KX zhR-=ZP36-`&pvOvE~V*{S$S^fGv~v)&J}m|ramp-()-$*;nMt?w#PH&@7Sw}#Qk_- z^`D__F;9TTujj7P*W0oMlS}g_SsxdcjCw70UnOg8{ce7jNjvsU%Ih|qH+6Y#cc1fI zgM&fWChs=DW`}RJ=hSN2F z{GJHd3-0ah*mRU5e$9-tl@3d7)oxt%3;0rcGWNnJrBmmM`{Qep4p$wV_1Nxh=fPdC z|L8o3*0Iw#%G_~u!Nrm&vttV<9`jgIx?{h8TVt2ijj0P4ip`sGUGB)*7ndil2OXpk zXKUDhMa%jvv(x>wI3;VwkVLK4{HfiliFInadba+$?6$E}x878-_euZoMM;yT#^CI> zb31hQhh!OMEe!Po4ut;*9)#$&e5xk(_5}xb<}9aCt4i@fEPZdu%~mpwjn{#^U=RBy{} z@7Nn#VoomVjlY}pa&GM8Db*&W&(r=+IvcsOQu{NbciC<|5&ehrrLL~+7F?kIZ0fdT zS;ed04cRtEe%6{9cI#EhuDNTJG#=;d+$8<&o~7cJWR~TvmYz}3a^eek&pzMkmuRCa z_Tq|lj?eUo)z)plv{bgoZthVmNqhP0-mY?!zolPpJkeTM7P4~fRr}pRSGMX$&2`^t z*e<^J3RlqQPtBFj`@hsYyF0mTYU%cvLVhdfV8LbPrpageSFZZGcw*h`+;zLu{rMZc zWWwj9f7HA^QQOw-=yILQ-McPG9eO+?Lcr?lyTI@(e&3he+;i-#RJNLCjULC7{|t+c zyJXzqRSQh8+H^E}Yet@J@XlR3EJTtHO?cBOw`@&-W3`k1x$ArDQ(0I3zE$|2;p+^w zwZ2iE$Tnzg)V-*2{FwSLPd`QL5V{xe+rz`y)?_Pza^ny&nPYw@4q*BN2ANwaT; ziSVjSy0KL51?R+be4e4<{GT&qn;vuuIscPlw_URJ@aZ?Hj(SU;KjZT8`m@@zCnso= z_kD@)PV3LEJ{kYkrv2Z;t^2?3QCq4kwC$mRN{)HzzNSy}gdRLu7~60=YHP^LY33{K zADNp!k~#HT*@Ix>#-xpKYFeR(7k3!&doSS{3kqv+r!dteg!C zWnM`y6HWFg>%JtIEBDf4PsCyFor_f!a#x6-`1Gt(J49@Stya;68!snqd-(BKuwLt% z8X=vX$}thsx6kxCDedFr#=v!7&m!Nbl4<@e?-Mt=qW30=@+7|VZVH`opY63*sPz^x zxk&+Q_LjMwyM1A+@*Ou({<4BYY41<5YMo~{Jf7*hkTtb*6XQP~jm=xXNyW9j>^*HP zCAn<(>)unw!Cv=oZ!_+%bbGn5_3g{o3uk5T+j;EPV+$_Tr+igg*4N$oH2p^Ro9frI zr=QfHCTG5iw{Me^hmoWEr>~jf$%QkFH^*F^+bkDz?Qf~)o9j1xPOh9DQ*%=9hN|;s zuFpZ*lfN%56o2$j_0O$JL!}os-+s+rvLGvy@!YyenYVVYUZ(Q8d&4fiXwBM?U5*xW zog!u4)J>Xu;{Nq@#TC8`RrhmdL}msgoo_#1* z=k1(yRmn;G7IWS&E4{5MlUaFw!`ZJV62I=P6d z!m^NyD>q5rI_;-+e|M9Hmb95Of??f! zrH|X~x>kL8$Pw7ZGqE&lT1M}-2kq7=tL{(UI?-JA!e>jSrmweom-%Xc$^UXR%kAgS zgk~D5s{71Ybi!{=(-)0N9O^z|fhtqtOfPKe(vL0C z*=u^;*W@~ARz>2#e})QupZtwGF8fICnOaE*1_p+6hI7&-j~VwozHD*+anED>^^(Vbe4O~7!OY+6k8(+c{3q$~ z%9M}4x-<6jTW{*C3YW=ttJ`pE*Tq`hq?u1OHL@Hx6>VLncT9Hv`JM%SSx!;hR=&bn zzt}#W2)ere%WM(jXKB~emniT2aNp^`!|mxoWi2LW&QA6TnDaU2lfCuwa`*OsE4S@) zxD>L@#%->!>aFfH-6-+)*QVOm&3Ui*a`MwAwzmEF^zK*sNq&v6*l17PZyS9Ba+;zA zL)NtVf9;)cAt>ot>7KW6>Lc4luD-087&W8|E*&M}F_vzt5~YJay}`O-P| z&ADp+8QRyv+NZxhv^RFkY*k^-KIarp9nHHvd;NT_D%+;U9W zq@Jq>HYti-IWa}$?Z$Ym7fXd_R{u#+O}5aKZ9nCe<92FBU+>cGo8+E&KRjdbpW&2E zc=$|~vr7)2ENeM_;_mra`DJU_mWD3g;<(`GB)7AZRvr3w{oweZ7LzUDT(z2nU}r7e#ps1|YL>tBm?3Hh})TKSf}ynAwF8EfuZe;sFa?NYBL znY>LimHWLf%)1n_vEw=Ow1W$unJ+$kz;)f#f?JhO|1%t3s=Z+I#=>dcL%JR<6pJWy?FFr>=H9_D||XO~lEHd{<*xvrn}vA0w{BZu1u{@13{Es`um0x5>S= z6%sGG+$MdDdVX=PYMT4&+hsp@z1Q3SVp(R;`YCgEo~;rp*ySC)y6>p@$xSyut@c}{ zv@t$Xy=R-v&U5F>TnS%O_6@ zEcz8aC&6{^#?MpJEfn^i*WGnEzisb|NRwQJx8->U*YM=M47A^9xzI~U_$2$cN5xOx z3A_KD5Fd44SO3~4oBFNSr|zsdcKXzN-Llf}l3y~vG|pSTAa=`@J+G>~cPEvb^p>BT zG5h=1myw@UH8Z}*o>bJ*4ZnP0`pYjj-<&NdTsc$ug>O_<*_Rpjon_|5^juiBO|9hS z&Fs^cj_`VTnYxjU=Q`Q3f@ zJ$K*wusO4~ubAs|S!Md_D$W$cidK1ezHwdbjQv^mv$`_ zy!KV^-DNJm&AT58y>8`73#pRY_@2k$*mcQ+YdJcC_8wWW>}B*Mow%fw<*Y%KNvUrw z)8&Hh72lk$u((RRQ|02n=0%oAch20;HN(>GW^te4jneJTzQ&uT|Ge63-m2GgQfI}R z+DpoD2WNE52wStJXr*HPl<9qIUU~CwySr+&cH&IU7m;s%{gO=Fsua3y_bRvBrhR57 z1(pWy+x2qY@#S960^M`h&3e6YR_>hab;d8dnm+9}@BUVx~W{>@8&VxNIUG(?RdA>Zr3Hgl-|tRH2GwXW{r`~f#BV%=dJx6 z^TbZ$I7_GNgO4p$+uas!yymf_a)0c$`yo1o&yJks)%bcpKX&_7Etbp^$8M+J-DdLj z{No8C-w&KBX8Sbz*|DD7b0-$DpSM`PGGb=!&4W^2zu4!AySx=|nN=tCpJB6+l;zfg zbw93Kr)I7B{rz^#^p$0HPfyg$`S57(-TN~vA6~tAHEX%Lxw%%@wwOmx9_{!nsvEaA zYsJM?VY(4ZE{AA^EV#@cP}wGxIeX^5+iBZ=*s^`j*Rjja7m=3Qrf^r~;k)RhvgV zDy;UXiOa(r59PvZo3?#9zB2dC+ZC5G=lfK>@-u$ff5kX}vHx_^#G7}5eA#E1C{J)% z7WjO{l7+2D_V?WTE<4d|Wkz*IO!&I}qSBL-j(SWLf8Afnp1*#bZLMo{f%<*EyhhCj zr}HbdzpS37yy|vF=cOmRwQet{RPD^ayz-~CaGQyu@zKsu*DFU?R&Q*Up7!plSw_Mv z9j{s1xen8JM|xBxU%!6&2$7!`TLr@(0gnq!-GGPe1qT*1~Yn zy}zSZS;=o+FSYAxcjnh0XI5R@ICY|E)+F~Q9@_#Mt1N7Sls?SeSY`4mlE3(_-OC^y zUAGx~gih;BI;}G4i^ifYpvItYi4N!h@)wa+**)3IW`T*vQm@y6k4QGKzrnEjY9Tw{ zg?C!F&WE)g_KSRAo_Xok&*-k$&a}PNc7gH*>tvUGJo4&`!S)^E`r+%1S2+7@XzFtN zSbSsClb)`#R!f7HhAw0Sn`YRPEH~qrJx{X4--u)OM|-F;p~}F(aBRth6E(+OSiK)j zTp5^~wPELmoyx+|&w5X9?8$EJFe&z09n!UNoneoLf77{RhCS7P4U7U9{~R-1XSi<1 zv0blwl4A?O=Rsp#Rs?mV>E6Ru)oZd&Gac*=H~L-Y&fjIT-yn2@Y;@Vo2!0R28QC#@ z*1Jz#dp6~res+PA&@{_+K8<|K^EO8AQ0Vif*5&$O?Ml+!X))ad+d# zV*#F9E?u4V?9*GjDfPZ-W$Ydn%fIc6*e3RJn=Xr==E5cFX4Zb8C;0BEhaMJOmYbcC z?7!>N%v)D?t#X+^HH+)}=iA|5d;i}4w!Ou(-mzrv$+?OXR@N-Lo|TyLyss+9IzVe^-jYV{~4}qvwfDX^7G9;|9jtbZ+>Q7d-KS3ZT7!<_cNUTGu;01^50yK{|rwL zSRGXZ+^I=@W}huIGPD&oy-kyPf<`CgH5{{D0rrrf&SR z;_piLV_!M7{xfi!{;gW^*C?)UQ~vshZo$Vn>5`U`n(s2K%R*ky_nErsiT0(}bJ8Cz zv6uXEpfvW%T*I&;QE|Kd@5I+iJu*m}ETW#LaL8=J*;KBNQ#M+?61b7MR8nEydHEh^ ziT2}@(o^%!_h|}?uiKS!+567K((`>2SG=Axvtz}ciAOsZmNc0-Z_Gd99xu9mdBB?^ z-VZgUPgQCzt?ZIMU8c#Tbf?6>b(V_n${Xr_>_4KrY@YvQ{Ah?H`nP;xG~a&) zhst+ndHv6J-;9rzzBhAj(45w@OK%FLiyas7Dmm#TxZYvI;z?_~DywrMPhJs8RC~Ft zMzXP&pxn_RE(%#FJ; z@@}m%xLaoITYk=X+m3VQ3Jjm)d@5AuUb*qf?K=CX+2In$8lN5wwzj(7D>Qp^l6!cH zZhm*v?U1zxS=JT0oqD%YDE4g7+_eWTZSg3#(v`XRt$Efwy_rdo@$Fl-O?@}Ue+aLo)#^av0V8w z+nT*AC%#v@`7dn4Tq!fBy~S;&S6z?oWoLLdZ{3UMmT$!0`Fq5O@?6ZBIrHp`*M^~r zZWl6Nzq&o+Y@5ZQ?mm|Y>D=c#kFHeRa8t*8>ZWB!tB#wsZPS~+*UmlHg28Ft&u8lI z7A@jPUl$jxwEe4jlB1RRjA#B9);b$!|C>{K%aP-f`=_TG_U}@zYW9~-ZC%M3rg3lo z94`~EiB4-fv@;l=YMtCu_5ASNuYyl!rCkWVDE@E4x!7r!c5hf6X}47VO*fMw=bjmB zp6FVwxXLYKw!dof>VjFyH+>A>iM%+RvdL!0bs@2xO1rP}`_$RDzy4GFpFytH*0%UR zgPURh&kfAJAzw^01H!Kyt(EECC^fBPP2yM6sxNCNZaIF;Vve4{ZQ)#(TTgctiKIO}E;*g^OB#;3R*aQ zo$jO4c|9v;#0D9C)34t<{ppf#FEipk-I*0uc5v6pwKrQ%zUbX%@OF#WmZmzxT~pWn zoUXuN*zrY4QYh%lCQZQ}w=hrfT0fUnHV3YpTKe%SQGEE_Lt60 zsqL9I3ojQbZ_u!|S#)69y4=pA^X^Q1AMoY)!yk3)kIR2dzijdK_+QC$_Rr2aINNbQ zW6ukEzU)NIBd509@(5$etM4zBNoT4}XsW)j-J~<-+PSJMoxfZGA(2Zj9+(lssx`?o z=ziSMq}(p=D_`8I&fr@l1+5e)rzDnq@>(a!HuH>t+kG|fMH4+mriwTjO)uT#8MRHV zw6Ak<;S<*viCy>Q{k#`Pdj*{~F6F+et{rQ3yC!?WsRJRR{I_HMYy7LdR(bL+N;t7& z*~PQvmao)pe4cDM)8)L>IQBOG*Edlc{Wbc|iJf?@`q{i<>U90`dG0d>6f(O{&q(&y zUY55ZL+s15bLThz@@}l$zwx2WLAA-g>$~2GS_ZpqxFKL>x<+%!iSxF}vm~cZdd`(p z)HnSDXF;0De}+j_#TlhJ_PVaJpIeu6b22jgXRy3??C-3w=kH}t+F!fT78g*pewore zjX%9N@@4K@KZ}fsp8dqWva%?RkWGy`|$G~B+B`$&(JqCS0}e|cXExf zzf4lqg7}$19L3GIPFz2+_SZuVyFmBD6Po9q*VEIe+{#9AJ zRMKU-+yuv6+;bnjFgh~Rt~JA}G+=tAO0AcYsm|1k&(qCXrSe*fCh@$WS|f$jw8Cy2 za-Bjbd+KRM%oN9a%Py(D?#%FdwJpq9aZN>j=O)<(hP(BP7cKkG@b&h7`}ZPm z^IspRc`j#}x%0Z^m-VLmZrIA}w10UT@;A&Y{PthP^7z$Bow2jzq%U|ZIH{NUF@PhUJa8=H=6Q7Qlb Fn*dRQd(!{_ literal 181806 zcmex=Q7dr z6G%aV00ScnGa~~d6EhPlFE=~0C<8MKD;pydI|rwr5SOrssG^v-l#-!@q_SmrL}dB& z87sEmP%*Y}EGnJ3Y1@@+sz!l{SFhhxGk0<>EUTEh!^A48vT@^Ob<@o*!C?~@{y)MX z#mLCO3<^b<0~i>Xm{}NE+5R74a1mr+Vg@;ok%@(gm7AH7lZlyuk%d)INSIAgM9EN8 z*~rm2P{q_Kv5Z~J#4M<=sJwCGR@F`0oP(1ls<|W=mtOpTi-Cukk%38&S&+e=VgCUJ z7X}uGQDQU<@TCKfEwBEy{){ZXwC>M;hV$_@C6xVxItGLJeZdmYFK{55xXy(vcI`_Y1DXcDk6`J2vb^m^?|Hsge?@g+ecV2tn zyXV2{4Ni`MJFciaWp8%$jI^1Xyv@UQO>kP8+HzHS^)>G%Mn|o?^tmj2h4H!IINj#n zr0DoPug^S*|7RWU_@Cj;{e|`4`%^A|+_nDa^`lR6>s4<;slQeDe+ILid%0iAMekU0X=1bbY%(tn1Jw|4RWXGr_Y{hwh^wR+;r>oZU6|5LWE z`9H(W{Z9WG-pid_{doS@+kO8Tn*TFAW&h96dEEGO{a5c9{~7*HXZ_ExU)h@H09)iD z23tvA6_K8aewrZxQ|@-}RSqv)fA6j&@9dSUO~Wt034Z5lF6m!d`e*OIx2Ct{)9%M_ zH{CjKso|DwX4f{SYC5}ItKgl!HaW$_$8L{9PTQJwt4^(c=fQsFfKH3X3HLMaUNE0} zwWse@*9-T3r(Uglwd&XE{VU%yuX4V&-|l|L>ErvlU)vSE{kP>G)0e#DyvZ%oo1M?f zc@^?4wpqJ*Mr7BKo_>bVCrAB?WXpoKu57&)n<-K5D`Od~w=F)l-2XB26Z?-^HJg1( zX04xH7r5tq(B4nq3?~Q2{Abu&c;4>H+D%_OO^Ysz?b;o+y-PpvvO(ab_^ILs%Qp4i zKWbYp|Lew=*`5YP&nl{)1V$C|z6gE#=ic>;v1tp1&AynICvDI-`|-2tfN%SyYbm;i z|5!esAIa5Ya?N}9?xmAY{LL1$UbSvcol^IHsZ6N@)@BUTQyyqu{_7dvbNY|^Kgs_L z>VKyHXJ~Kuw`BdX)PKVN8F>CPO#bKnpW*Ojl=^4c=J2T4xfw-C$i!mD*R9dhJxR@?U<_kNn(qZqoJIQfCeKS0DeKTDdMbeV0XG zu5z04@9**3?{~(A*M^su#)j7Zy?Z}2_U_%#mzC_RFP>`3w)Dq}y8MN@p(|(0Z-~6}`l9iNPr+L``K^BX zsrIgt>}f7HDm}hw>pyWxYpH9wle~|u`zPkwvf5YsSO zP}+>?PuHF^?wi)#U63em`hA!AN}K--$8E*W#=ZE}d&}}}^up_*$9}zATvq0>?ERIV z@-M&YVtTBX#<-l^emgcKSK;L8(vpiV+pbIQ*zQ-Je0j0j)LUCptBYR*mZof1Y+1Hu z-MUwAcs%k~?|Qdy-K*f)PFtV5EfJq(vNTGlHsYt|0iDQ-se$|np|zr+*K1=#uLm$X z$RCOPwD9xvj~m~ujOcTH!BUw%Vb|6=w(4_TM?Rdly_a;|Pia5D?1hA7xwg`Mx7O4j z);Qh&R#JVV-f|hG-m0`+@9blvcLbW$JkJi2pKh)3>YH%bv=Y1ZS<~MxnHU**Icj6( z3K#EllkUB#$v$0GwArcDvP?Wuj4$im`&(XSO}X7t(u+iAGv6+Aex&O9JtQ{%hiqt^ z;m-#@|9yMD=;!yD8vhy8WZI|Q`_=vQVW#oi{Y^i+*1ApG{E+ur&#GMOuurjfZ)@Hb z>U?u--|QPxBs@Hya-6@#v9IbVyO}+fEb)bxFKW`~NUoAV1 z9~A!B=syGJe}=aDlm8i1|1&&%5Ue|0jMb`srS`{}^)3Gy4%(d=p1<&VPoZQ^WlI|5_)w?6{#RUjAr) z@3fV2U!U-=uX%qtW{YELKQfTqE(htXFRrX`p+OO zbUIe(zGc12%hme3-(3Fu@2l|js*|hvH(SNl&$gc)e*b6WkE{O~_OITzZ};n6)3|2T zR`AZfU+;KvYH4VBnc~gR()#ey(AxOeANOOYD!k%~|LFYZy=iRPx!MD(%XO~?vh!a5 zEZ%=Hmi6L&%~f3|HJ_gi@eG-AJy*oPw)DR5*K@m*rIRhJx$61rPxelJ^7`?+^_O-X z?d)y7_-EZ|{ZqRiKbtsVg0yd>^5-R6vtIv^Tj%C<&}CuaN{^#^Lieb+)EEW#JfG#Z z%~7n5$a%)VGudazwvd_IzPMU( zg=o*(Gjplwe}(|RjpqApQ!lEhJ<9M~S9RRtY%celxmiY8hYoF6v;Aes>~c;)Rjrn? z7>$FI+pU&OyK3>%=jW`S{Xcq^7u`O;Ci;J6IZ|m%u8Xu>A)mA-uvQrSBy65y) zUdQ6K_FTOc_{${F7rU%l79YiTjWz6ITuAqwOMHJ;CaqRp^tWruz5R#v)_&r8 zR>^&BzkS@P&-LnGzN(+E7y0vQ;>}lU-hDasKJty+rtUqtp;OPjay;YZcFD5!7iX7o zk3r9xBB>j9Z2r!9yQ)8WbA0XWmz(Oh?H6SKZu%qsKZEYShyNMUFPHVaJM}&7!Y03- zwp-PIq-&wU)TO4n)P1xT$?|0nSMe|;D{LK4O93Qzhf6`w4TiYMiT)f+PbW)t< z5tFWW%JXi-gw1iYYAM#E#?3 z)~2q_eZDc}+$I5Goi}Ty@ovAGC1uPgGIPz}!*af%tDB$f*lLjP*1IF7En;q(!r`BL zZ_W(0&^+?A>OaH96Rl+_2bj46Z?6%2df?B^_j=i-OHY@@Pip_yzsNCHd+o0237^z? zo^AR*CHAnlN%x=I^G!>+XFZ-#xxCO=B2I1hloYAM?}c72{}&YHD9LM;pzN4*A$_Xo zT~@QTwUWGnzr~o#oI?(NovhW+)^+4XLxoCsc^Hc=$Nloe(z3YN-in#x6H4R4lb!3F zAGrS7Du5#uUG!tL+f{c3P|Oy zynC7d>{V?OX%(9@yXJp<7ijf){(8B+A~+rLA`qOm4b+Tzax;on&~m zin7f6-jazca~^9%Ud--4KYO{>-~CVaOzLU6%6E4L=L_!;8Pj=Nb>(eiH@do?b2#U+ z+wo7x5tG#+^WD7M_T}#Cy=PE&wj|c1q-pk|U0lmnRli+!<6Pb9NvHZ*K1DDeW;>*~ zB~Wm>{1&ZlH|EVsscULh-iSG5eX-~Iv&+|d8|KeExbRTU<8Siw_8fNE9?Nm>PkEiz zO(*;1x6J?a9xxHvtDGyc+HB3d`Ur+f;mZvSoexT`u6}k-(l+PrWAls^cQ3npEPJ?l z+UxAOqK=2Svv+wbt(%>@s8e&ux=lJjZptW=WkyKl|@XQs-+PUCpppsw%zY zuadm}&LKgLd)Y;^?}ux@y1%06#QjU*ch%Lt)=r(cEo651JNXs2-7oR4;n;r0d$ta< zSr)B#l{>c3nBfP4<d|)vKazz6`v+_u8yPovSSMs@jhV^`kaS?U>w~m^0a{mitLc)%*o} zHowYZIpZq6z4F+7Lz#ak-sz@SeTiedpm@)@RL)yyIe-2Hoi(Rr-zNL#%N*7cGCIG<hmfPB0rw-pr zniwnNdu@rz;%|3Nx92_NlxCm0UTfR)wDigf<6|!l?2%fgbF{O{Z`Ip;=LVU!@LRVw zSpAlo{W&wweZ5mo&GqtMJ{i{z7;eal+4Lr=U87e&@M?2N+UC_lyY_X&JABBy{#f4W zenotA+tlZC=Xb_VYoF%1>D?@gWJ9i(<`b@EUD*`1HS$cz;u?dEp*cMJwZlL5Jzgr6 zzfAP9)wg+dGV^Cvyq~<@F!Ri>H@|bL)z1q|G`Q=#dF}1(l~-1AKD4;?J*_iqUdh!` zm2DR_RzK36blGEfp224g)4q+)%jf3)3HZ;zZS{M8>)JQ#Z9_|oU-R39-qlWNYD@e% z>F)lXBUz8Uytc3M{k-auxR>7Sz4MmUuH0FvalCTYDowqofAnAcdi=-o&AsyKznbbR->z#L#p^DWOqI0w z<|laf<2k>1QakuE4yL;8PwQe@aCXUy!|c{Glb>BUx`E;1iRZEA3wb>RudePr^6TvR z!fWEQXFt5=8m7BsLEoAgqS>~0)Y@d%mVFgnd&5+cHGG~gkE*uco9*`+cx^xAZ>zX| zB7C}K`^q0B%U`XU%cShPbV01%P0v@dXWLdT%vu;Fkh5r(>AbaGsczl1#y|CMzBv`! zcj~yu=GfRns>_Wxz9@@jd|kye?Z7ADRa*ZZC8liCS-mJa%w=06w^#~`YU%R}b2H*v za9ze644d-RlY3wzHpH6ffhlEVwuQ zvgzH-Q&|_PZK}@I?%liQ3`_I19F^OL;~lR0XH~jQf2(hKe~0P89OpfAaxN9mi@R;+ zTX`@1n%26>bD!;X+pz5BRkzDus*^QtF59iNDt?V4dthGK-R|!mE6?!!6Wn6+*`};TGx^z;HJJbOdAw7+ za$@1`&j#|1=S-XB-kDZ~EWA6ZwI!n4BUPZ-T6ZkVT#R1!^;j?x%s>6OKvLK-8xHQTkn;EeJ7vB{tQfZ2s@?|!6#tM znDysnuAsJ5LN$xzgVH$XXAE`baZcuU!%AivdL^#7loKJjbeh;vL0&^#btg{= zi}&kP>hrB+=(L&+b~2p`!aM>vz=bg*jOv zF$8Ig~d9-kq6&}1sf-nuI%y;^9`T7PX740xju?tEDz7>(ZAui;_s0?$0jVQ-MRAI zUv1G9FE%edv*@39hMpKt{i)zr9iOwjVvjzzoACNqcyj5B^OZiiee$y{w>{*o&tC1> zz5Ud=$Q#$oioe&L&9~N9R9_^Y|7y;PWyN1ku%6+Mme^&G$~Yldyv#ejGvepEcWrOD z*DLN8+%3I&*XmzWb^bQ6KT3SYRL8SQjD2e8j~Q3*2KLvAhTaXmdcFMj0fv@2L#glU zc%AXbo?SlQm)H5$L_c_?bhB1DU|E=QVA7#M{ybOzHJLqfeb2Z1PhNk_jQuUt zvE0`2$=}y2zOsZy*UsDI)&I=G=W}1A((T-$O%|?qmx(ni-G8}H`d{(i?f&*!PytDzW8f$IsWcCgKM_>cl&>Qp7Wo<&!?{{$f$6`o9h#& zO-L4(yY92%>7VW`5}Whp?KoE!Sne0%$+G3T#JS>4vtO?Rg}|?b_I|sn-E)4=e=5E% z_fQp+EOYk{;l{V8bHZlTJiAo$>FSI5ZZS8!Zz?~Yx8bITxADA4*T*^wzs*Q^`Z~>M z`)Zyj?ZmWm`(|~Xd$Ln4dS=eWC6#vGW!-<{8vSymPWw%izoLEf#63IRoY#l8f0}V% z-HKHf0ET6J^zKMSq+X)u4azWjVEn-i=(UJ+;4F=}T#IK16K=d~rz)V}4y z{I+MROk`UZ@jp=0nD%1lHoZv~%g!swAMh}pnDtP!+}Cts?5x!)tGqOq&3?J<*4ur% zo?9nb?&Gh#To?IK{Xy2^u-B%(@itd-Z>v1^4UYe8C3jx`l*YDMZ?~C*#;(~JoLju_ z_hai?^V_-q-fq?~p0IJ6M`YKV%Q<`6=XFnLo0i#n$L#cqn{HhjYi{#JuDN@=X5H1& zphIuNT@S^VKT}$jmA&rQpDbRXrKeY1xtHzOk{h+S_}3m@t+}zOyQfAuhQ1ceO-x9V z*7{hkch$*CcXC*#*4xwVS{c*KV@pGCmzu3Nou(fNgL0ZhMDQEv;5C6%{{^K z)p4(7mt|i*UBI+cgMp)gp#y_x7XP--_-rlz$z9_7Z%iX@Z#R5p8d;TlX`|LO(M)Z2 zqw8hsf{)$zKa=&5e}8!4`P*-1pLoe4ZJ)MDZ}y^fGaW>2xh_q6UUhV3)mh)j>q$p9 z71KhtJ|M?6K%b-@;}3}UFn;A^Y@&6eD+J)*nwuiv8@rWwS?rx4!qS!kHY`&ddB{dTI4LCg+>!zOMb#AH0{@ac<|$ zBUw?q<~;k)P_-&=P2HxiA)lsg{CX@q^8K^$N0;Z;to`xp@=>*~Jq>S6edA*Oe7|&O ztADx3x}J;6ZY?yyZU78v%Hzv zi5X91UpJNb&a}&Kjd8xEDSj(tU-y=JnXmhPX-sYl;+6JtI=vyf?7Z~TDNBl{-m=Ks zHTlPT^@{k#%}-D6D%z=}c7Ac)8HOawpDvw3*JAbyJ>#%D+P&D(kw9rNa`=CfL^ zTW0iRw@==eceitg$-J})#;e#gU+q?TdG5io^h-^OLR;3Ktw^ncb9C`Kn3_;DskDkmHI=Z2OS>`Hq{#5wqoMel0#y#nh z#|r19%g3Zk{=IpuaQ@vn>GHcR&VQMkxWB9VVX~dwo4&u#pIa?E`{(R^U9IOU!xA2U zUXw2NR=8X1<>|SC*~_0C3#`iCJICWlddkIA?z~%W?5=|Oy3t8xl{32ce%KfLa-R9c z9qJjYj^DLx4_WPbB~SFG$d*9$iIXx??ayZ|yY+UrrpI#$H!nHg{kPuf1unK^>r#8V zDf;!ZBFm_{wL4za+l$Xs@L0hdB$-%MVDWDK!Kl{6g!8-3uZ-L>VT({^{=#Oj>A9!Z zpZf4-f%uQ>6Bjl<{qcK}c&W>qCFymtt^2J_o-Whc679Uo_`~ZzCruzWNoqf9UmCnABa#co-HtPbV z)J4x1ElyWdiS#~n=J@8R9aDRYx^KL+ILY>MccQ|<$F)}+FPry^Qjq+=b6_fpZIWX+odU|zSSv}JWyjS{9&~D`Sxe|j3>=*KK@~KYyau3 z(>Gdvc_FZ8&n*3Kf8<=#W?e|UbhLeT?HblUeKV^sFg`i&#=xY&pv1tW@LFz<-u+Yi zdn#vtHN9qJbn&fJ)vlGxcI3_K_*FdPi2Ls7oa}A8o`(m`HM}Q&``s_?eXsKO8E?Ct zQC2WF<$mW`o1fc1GW@)L;e^tZ;_|Ed>fes0Y`y$))hC>8&tTD6yJbtH?w8y0F}dqrzF&9iZO?O1cBy;ZRC;c`)5DrWe{cMn z+S%(r_p{ZKtLGjkO$ra0b@ZUarqJI{KhNFVvufYTr9XA0miErEDO<%Wt+u%JvVT@w z@(iit_tyxhs_mMzsXv^Yt`=E>sGD%x7_&Z>n&kf+v8@3Dm8zN&b?={ zif@0lwc^6p-`_2pRMYfrU(?NY+mHL_sC^cFl^?fb=IXGVwWc{Q>qL(}oSfZv^QC24 zcU@ZN;`7;?JdOkgm9)Km{%h~FsqAx7H(lb|cKf~khk2RL{0z@osLQWk9Qj;k+gj<6 zHLlC&tlAf~!Taw;Rkio^Z!QH-_TOG=Xsh!&_nxbuMo?QO3*H}Ke?2_Yg&(}LIzu0_lVrH$# z^U}!B#4Y)1%T`Als(jjETU}xpWf|~p&7?2g&hjE*_6t_Gh4pgR_U_1^ar?}?+Nz4j z2VX6}wKs=d<=~FZ-J-`0>l2s6X78<8F!g(xP3KbOzE=n8Tb?|g75O>$;)!ksrp}z9 z)G~HpaJlS1QQmp`r}EalsV}yM`HIKPZ~l_)A|?_ZQt;^7+``vd&9WlrUOwkK5hZ)X z$UWBV(Ck%@eT9Cl+_vK^$9^vPqvA7bU$Va8`~K#gHshU_rL#r(XBRIEdw$LB?d-d; zrZaYwNcM^}O=}N5{p7Ly^A>l?q|I< z_dk4oE_!dH=iJ%*bhEy=POc5SY8vzM!c(JG)6nm~YF|D7v8#FcbKmXf>So-wdillw z?J?_*U)T2i+;8x-k~k7}IpuKVXd|F)Mlzn;0oKfZ#@-uo$i(OlMnK_@nUVo`Ei_Co4J*nft@`5zV* zHB>WvKC~sn?}FLa`X-z^ zncHK}$KIJGXZXo}!HmmSYyJr@sV={~>dLazDUN5h^cy^pRZ4CxUMjcOQAD_M^NfGx zistQ_OD5@w%`SK>jy4qtpB zx}vJpX$Cm0x>?z{xDDR&j`zpWx z^NRNVCp$i!cfT8(o>7$cto7>E-DX8ns~7G5U1W4I;N|wHC_g)0@%$S{O~PCsr+Mz0 zJh^DL#f@jLECY4J>J>hQ%-WbXudLwhsm=v=O-1j=8h_!K|DsIHZu?KQXLp1|pKZFc z{_!I%`%AXBzpPrlr+B|tNknGV^;ti!%scs9=dSgV%X0D6I(vd{+^pDH`ZHu-!K9te zmeZIR>>>jf{aYXSGKu;3J(cYrg}w!rWT(xw{I-)hIjdeGrtFJp_uUX->xGx@JpQ#` z)-u~M{(9e8ZrzmD8$X#t)<{`gGV8p!zPLQ0DC7={4+F=!gVOa1^M&{6|Frg=qxgDP z?yX1dn)fQbilfd4?+8+aGsrGKu)y=cyfBb#^y<_U{;~(ENoj>f}tl^Q@_BZw68!79J>$(n~ z-n>wI^80_~OFHT&)x8p4_{lx_nQD0HGyBVBqEGANV(aF;GWpLiDfz?7zlVNJ|9S9h z{~s57H0~7fTmKmj=zos+^~ygTYuEo_`p;lG|5<0we})|$vlXB0KYaLO{Ug7RUSIm>{jB$1T^hwS zN$YxQ-1oSZ`r_+SmFFDY?H0y)b^5oM*Sfc@f^&|YF|U^1+$+5^bWyjNbIEhi>N2&O zqhI6wzjuX;&Hd5()AREb*PW3p_sjf#KA(PtFWB3&r+E4;o2@tA@F`8qxq0h^y3AcQ z$qAD~A8#?ZXL_h2z9gOD(*2WvYW7{WJ|FV_C{wCHYqkB{g#FrEFPiVx-Y9Rhde^6q z`&Mwd@4d!k@>}HhxuzE#**9MbrH8sdjyo;5Xg8Pk?uDOMD=?hZZ!)l5``P&8#*eqJ zJg`{4u~zYq|CihD_Fb<6LgzoK-&?|eJy7jU*{(S$@88agKE3YhxBDwM1m%4E&#+m} zYx@lMZ|Se*xGy>Rrh0l&og4eseUkgk>|A!uVbA`iKl?vJAK&co=O1IXah?5BP`3`K~+y7l~ zQvMlupH=?;*?&Fv4ufXH>;D*j>VIfIssFM2udeF(A20s#{?EWv-?RTeLs@M1oc|1L z`+M>qmVYq+&oFmht;^qyzmtD(X8&jS!TvV>=6{Aw`#-IJQ6DS)>ny`R@BV}C-+TTu zEIGg7Kf^7K`~MkuYGNwp#Ok#^2iC+TX_iS^ew%g=7DEh3gN1T7Xl#keRP#epYfQSd$;X!Xx!OA!PsT?wnwuh zXI*!eIftS z?^OQji$CG9F_-7p#;Gq)uK0J5k5Nmjw9G6rW|2vDtia9m#9L?mL@lc~WbHYtsCxTz z7XPv9v$~GmYc|jq&|3Ym>K1ohTEvX?UQ^PxwF>nw5r3TignPrEjH>f|(>6q2yY)qE z&fIHVI=Axn+h(~XsdsNInjNe1ak}2(TWeh!uci8(@7Mj=-BWSD>2tl=&wmTfO+NLr zgv+4xMce(Gu~y;M?_Pz~mHxYNxU*ZgFSNWkOmcd4-aEg@*UP)UNVsy6l6Px>Uear3P` zS0aC=1q59=>!7vA&il>UnnjoG#NZNA&eeGA};9IeS&#%VVFO6;3YuKG7%nfm!|YblHf?cQ!kA zWoA4xTbn%J^loOn+SK31MU^#q9eRxnbCwdN*~+!G6vzg9#nyI*;%UG?pk_UF?SrB=zfZoU)A*5WoX z(SczX&s>c)jUw_=4a^I@@A*{aSs&b@A;o2Dy+g z2@K%w;ekK-cU~L*Ek7`~b+=CTmhbj&{(Sw?xAN`R`&G4*CZ=|zt=jP~|C>(CGcjkM z=hEq)#m^ajxo&wp@uyG!vEAp4Eg$SR`0^yWF6qyIhAXqe=U5)9xUKtG|IfK+i*7xy z-)`yex@47M#QD!3*ZqFI%y`}HWS^IhKRv7LZ+{{d$NPBaJ<~3&-9lpd#t$#5G6*Y8hcuiyEm;P6{JcSX)wUkmOm-{7z!f1SPNXKwBHudYd1T$%0m>d!Pa<%_Yg zQQ=2q4eic9w$~_KGVSUyEB84&_Fi<|a{lhBJ{_BPd(~cBoU5;^zpE#DtZx5)$zz4{ z?>Bo?{VVTJjlfgj(~k3|^n_;q-5*t|;RGhfQ@-<-Mk zRmtnnb5oWcyU>-TvP$Op#Nbuyt)SN@TX5QetfT6$F2RT$fXd*Pc?J* zg=*uTWQkwN@;=GmlO_K3B>!h{T=DPy*DdO;Hq&qIjZb`jJ#M+^aczzB>z$vU`Sj|v z-RhGWFWfTJ)&&+#2?;Kr)M2y1e`nsqEiA&7lI^^A)J~^}+-|b9+I}*f^)cV-;_s)P z2lqZG^PA6qH1KOxL8+((GvD&WO-ucn)>xITeaN@so1WL@T^Fpr%=*uuJ^M*cN~Dcb z)PDx~pZ2l)GFRty^Hk2yxW4AIA?9%yKXI9Kz+Wd?o_O9@}I$PeESL1BD3euhKFa9)V3ICI9 zg(%GZK>Y_NE2WI~VL*^V8z?*?I3ju5Wo@v-jri(D_$?R_f|r z((HJ+RC{7jgtsQAa?Z5aiuMx`U)Jrq>}lQ2o3i@kwbg!-UTc-!zM11<)3Rb#^r5}y zPgjQ*y|@=QZDmQHQeezJJ|i;Zy5a3F*FI`3eR<-oo20R3_9j<$NzXJj z3ywQ)voHTN&zFgpb2Qhje7o;ILu}#pgvQHytFI)8KQRl-Rts&7e=W5zX^qF~ zUBbJyq6g@DP#54R*KF#68XqY&NPQhK{$4*LDhttiaW0iCyTF}XfHb3`Nyrb+qn21tf|e~8P?!x z-mm@U&c32&z7o$)FPNphb9X-f&j&v&pUNap`t+-R&rg%m=()vFrgFOuR$UM5j$NV} zwpo&0qPgSx6tQo0uz zeX-wMmd^r};SQe1e_ABdHK-=F8*+WKcr-o3qUZ^d?|nnlJ6 z`tvS$Epsg{@%rcQ*R|f=?dsg_{l4INN%XQ+yPV7S|7VamKQ(ho<*M-GzIv};_+3s& zT9X>RI9{_j#Lhiva{c!$nVMVk4*%9)axe9!?yfw^YxT{c9otX6Xb$jcr+y7z{)1`kgyINQutwNOgtN1>{uaWBV(r3$8@*Ms?7HgX6QpAMUB_TuK6S4U@?XBC^~ z-8lHkUM%~@^OuH;HVS8Q-0uy+vcj85S*XwPUyre6BYAKu8rHfC~1ecz3vx+yY z`uJj<`RAVpUyIpoex_ei`TSPV1z(}L(PwQ>pD_7nytP&1*@|az{PRlWB5P7Ur*Ded z8d{;@J^9(Ie-~lp<*fDkvi1$LmCahlq^(uPm%pyJ4oUj5 zb?0@zQ;r+sDy61xIv*(9Z?r~wsgH>%Q^M}JsneT{Cg0CIT_sZDS=H<)maA~5$~NlK z6_&qD`{Q~4GuYKsKjrc}fAE(q(5@Ce(UwYH${B1n>K7;yYEbDSM>aor#7@t z3%$a8r!I6=zqQo0^P$0?>)t+BjA&(rEd=Qpl)a(4?~a`5KYbZbTS=S6R( zUA@V;?oIyItvTKqGRt&|H4j`W`enM?xZ7^cTc+U88C*gpd)-64Q#l*2mp;li$U1Q) zA%#K2JApxoEA7winn~Z~i+<@&KNx?s`|I*w^Ifa<=3oE2Y1hl#1k1gq@|(r&>i?+q z->y}9l<-*err$}srWrSPWi33D^u0V~+RUEpZSi*Z4a@5-o^Aek^g&4cm-vb6{gbQ~ z3!IxVtLV}nr|m`OUr3(KnN^)L*>7TM)}~Xzv-h6sxcbPX^n!X>+QBt)s@pz4c>nNP z|Hts>SLZ}s?cevCd&~Cpe7EiN7reS6 z{#@wVvVAwFB-dUIclW#Nk->I0YW{X-lNa`8+g|TpD8MKn#k$g)OLQq`KvO^~hbAXO zP=gqgX}ei!iqq!>dDC|7-=vhxb7IYnYa8CoxNh0vTRg+%*p{UIgE$j(#|&m3^1_+*h*fX*&Zq`<7g{EI78Dxm9q=u895G zDM?Bj7nl7gHdp7B`p;mu*6Y}$>Y8<{4lrg*n_HgIiVA4G{wn+4B~i`fZ)wi)vEQSN zo|PSMD+!I9KlP?$fNnP9=Il9#UWl};@m!aAmuU)1dWmwmsr2*WXKB)pjVCyNTBmbW zuK&Hfv*N7#^MB@K+pf`HJ#%L1Z&tp!X$|SEb9bd&ip)*UG(EF;^XjX+W0fPfM`;-y zdf8_Fga1d?^bcRd&c4Y{uqwP%=Vog&`?P=Hj;NUB_NJ#EtzB1Wt?JxABRXALJ7-qa zy8c};pItXDz9|wNp8V}^KX2=jt?UmbKf1s5+q;vdp9?=tYMx!c>Ua10hxK!R9$neh zY4Ui>NwpbX`^$nh{f@o7&O3?GC241F{M&OGS9w%TUTZ}y+Y%)7Kz+rWH4h!XuWJ8S zl<%4T#D}lPLeFxp=$~rA>la?;ht?}xv$gil{!#kNXyuL7=Pxd-S-CK>=5@n?Uv<&D zH}0#S7+)fDZ|dLJ$7gTyv(EU>Fm0pK6Aj)sVcQtkEEh3=22dE76xL0DwCXum34d$7 z`~JMP)w`cvyQg_E`fu=|*-BILL)IMdT)V8kEa;|1wn|@Fu>4>D_m?fsnV(F$+xAFM?NbB8OYh&gef$+q)s=60 zcjnES%PAJsxpT|XnOjywhlFiPD>q>I<9%RV_v+UxL*5_S`0?lEpYHuT^H+v(g6r2{+k%A~rdyt+{EOHLb%eZ{-6g;5 zwKi{B@e>kLWJ;knXv?@as4NRPF9rf`SnsVWKmRq9x)b#;=Snd`n+ z>*gl!t4Lg2tsefP=ZE)W-v10q2fxYP_I&YIO^o}Ev#7s$<=yEoZZBE3;`OFpfgszZ zi=s^Px7vnGShRFq$nWjHrk&H8`*GRH>s#we?Lz8Y@~rd!#Qyl5V#9r~Z0esavz#qf ztXMWTEOOiF+%M_B$_s>rW?SCYe6F)AcyH*r8JBAf+ZlO_=VTf*R{U7Je`Zlzop!M3 zhsW$6GOPFXAK4dr>ch@gyLZRs?rCh)@LaR@*Pi2TPj1M$E)Md4^e2_|?#8Npai;B) zimup3POI-ve7aL=x0YbJ^t|=^^`mv8x~$AyRfLX}da_J*wJo0Wc235;8JB(1Eq^_? zJhtnxe9Uvp^Ix8SpTQ^Gdm{hE?B$g^Pj8reS1Lx{^szvvdAQZ*Rg-Rdl`pkF)V+M& zj!j=yX9c`Gw=;9@rCVE_mTbNn8|vq%`)6OqtFpY?Clamp_6eD>&V82k+}tr!wtdIx ze{O4!74kW!O+5T`T6kpjbaSVz`IB6Alx}YBJUeT_U0s1=#*?d9&xy|o)Z5E-;-#7C zD_y^%g>x&m{aQBJqw0$D$(ib0`P&ND%~Co$=~V8vo5yxNj(Ki*jH}F|;^D>3v6J%o zYW*rj>&*@R88fHXzvW(S`0~`R)xV=lRMxakzip)N$fmQ{XZg-Zfi3qxeTmwt|FJgC z-08^dOYQ0V_IRz-S+#y;#D3xZ<*)3I-29Y&Kl#qzFa1(Km(QwXGfbO#`^)<`(=08# zMK1A+Ue8&!>SI{cdDrYs@_)TGxBWS58Y)|U>xygKe+I6jW?APS@As}Qdvg8FuHTn$ z&RxEFN5!(;bqlku#JujX__q7~wpq_pqN1nld%Dl$uFF>6`eieZ)x9mua4z1wyZ`Y& z+aoWeWo^=rS8TkcTDze#E`tBboJV(K>!vNA^X#X}q<8PHzFt}x-(J*RwDnWWzdKJ| zr~Y~O=SD{Tq8y7pMBn{s z=RW3sRzEgCL+@=GE@ox#FbRWi5UFl$pI}i=+y53ws_*JD%`S)NM68c1!h_ z{h8p{$(M7BmD~mQ2V~j?P0oIHS8X+O<$|~cs#@2jO6QrbIa+l(c2>q}$%xF3?JHMZ z{mgz=ER>x?XWp&%%YOdr-PrS(U32R0in~89C2V_re7VutsdXFGHLl0inYcRF#fo-J z?Ts%{Ee)-%xT}5qM8dTT+qCu0+>&5Ya!HuZ%#-2wg6o9atCn{S>wal}+&%T|ACr15 znee-Dah1>3r9S^T-{$m>MU&5DzR!MrXX1+qVXxl&_S}|}&-->(=*x58Hs4UsF1~b~ z?8kvQ2j9&9yUloj!>-{;7U2>*%8SPwcpT9|?qKo{3m{^4hmqlO}IG zwS2n$lAyT5>C@(J*qbiC__)U*m$jN(e1y}vP1}-=ZkoMx?w)gn>x@C!=XKBX+|6^6 zC5{<>Jy$&E-?QiodS$Mc_$kaAaqLC0YM&x=F@yG-bDdkmw6njO@JIjJyDxv< z`tPeC-+W<8eo$zC_(*sj+-^+$U^A@rYN!SN&i z`kQJ}_&PN2Oh56xu*>?z^^bqmkFD=`p_6ggR^PaIh2F2=qF15429f2fr+(I-`8hmA zt@6h_W`2$2(5s&#uddmyacY|F>tLB$sV^`Abwq~6(e{a*&Ir4t;VpW{E{EB|PF zgL!6%XY2PHv1@mqdOxR<$@9I|$INu;By(H7i#(_6ufO$Qd%`krc3M@kyV-5Nx7vj> z&)--3WS;ZSZ=a`y|IzEybK|<-3TfI-Jhs}QXkNzIM;bSO?RPD@n7Z)Q1daT;Q!cKX z>2D+!xp>xmB#YcZx^eu8lS;j;(LW@2z|OPT%dspO=4@8wVY}Vr6_qr_SZkG`6fq z+;gv7I`?z={r?Qj{rkQ=N?iRhE8}|KbusVH0ax8)wbJ$8Oqv+v88GMj=@%C#&AT%v zj4SZ-pILfGPl|`ntCQ|ejjjK>F0iz2KlkUu{Wtfv&MlFeT)D?$i+beBsGYJY$%hL2 z)*TKOiPL|wt-Z6N;7(!bPo9KZUo$@(nsDiMUefLShWvKzPsXo! zPDU@CcgOrvP;_V5yL$KYiTh1`izdlxox7Q`Wyh}MMY>rRewjSq`sCJe<5^*87aZjJ z_9`!!#Obv0(TUc_k2j>t^V~34zTYqAVQ4JJPhpAE>(kmd-il3mZg85dL}=~XV*jwS z{kGNL%y*Za&3%32TkOr)@DS~QNKsXVt-Lo{V;FcgyD$_=`#UZSoc-?8+wv8`x73%N z(s*?_wQc=&U)$1SzcqJ#Iv=IFY}U&;x!Z2%_7<)y+*aI^{;KF*+ivYu>p$;awf;Xt z@42gy@uA`6|3bsd|1*48dAd=+uJ7l&AKjn6)Xe(+zTjhb%$ew=i>EFx)V%Y(y6n=5 z+v22># z>sM=vR&3q%uOYlnbJ4EVtIJle_G(+va&Fa){|vD|HTm=fbhS^Hh5qD`S-tvi%B|hG zp`yLNK41SlBes*{-^BR26&qKt+O)dhn|@mQ<@p*i&X4=g)-oMx*0o75qC@^X1>UyEg27`bCnn!s_+)OG4JG{yy3^yLtD~rRlFV zw_SQ0?_wY5E+2C3)@}8j+hsp?pFUasSXM2;r&G^Ef_Rn$8bQLM~Q|tBa z?7UV!+bki1xuG;}`FV?Wi`}L7Hs`f2{G3-BGi6(>?l<+$4ebpL?YX{4s` zyw5+*PX9C4+|%=PYUj1x%j1_^NuCm@`%Kp?lPBYlW>a)>OnPeEp3pVf=Id@>QGcv` z?C4>u6i|2@b!%2Raq_Vc56;7?(}?V zI^oZ`trxx&EZ(E)+jLFNS?bcOzso;HRe$$eUY(u)Y(Afz?ano)7KRjV-r;_C+o}60 zQ(~9>TC!~Bz2_CFZKrN8y&M?3bG}_sYno)(w#x5CeCxXdR)p^S8@AJJN%$kJl2(w{pp(s@Lo63)lAs8~n2TyIQqq zUFhb=d#am`?vb-){8jna%WAd1`3Z&hKLU(a{>c-&w}9te)%{g--^NX>XYcGPW7LX2 zVZLI|;fa@~ao%U{UHnV>SaL@A$M6-M(q(#^Ix|>ApFWX#y>8a)WgwK@TXH!jIkxnA zOs(nl*utLV*wSN$;F_SP*06u!FNVe6|2|m-0lQYMU$tuetyTNChA^Fo#%cWv)l3OKZ74H&wG0vd8v7+ ze$KL+@5E&-Kjmf^7aK|Hy#(`@hA4e^>AR`)>dC`+qMbEHnNkmi{~ZrI7x;7unxd|2_3;|NC9* z@4fP{Y>}ut@=SCO%%4?+q zpS(%A6Y)`Lo%CWwtD`MRdO_Yo`pK*BeiHm~_QzB=xxC(wM^7%Vx_j|(>CMgWVpqw2 z)t+%kV|S`S&(`8O?{HWywcFKCkccG8J z+cq3=&s+7#NNlO0&(o+QsgDGdq(as?M{8Pc&sx{3=Ps8XeY&oYYRE`7?raok{qOU8^tn~fGq3Cf*V_s4BT_P$lCcCGXh zlDstM)uN>fy}e#^^sEpOVRT7PNsCjCoftbY{$}jmy9XH7MKdr8xbN2QtrKRwxV!b( z-1JvhywsQH!^vg;S_>+9^Cw(ZvCa*z5eiBmVZ9$s+ldDMchT)AT3 z?p~R_Oc*(O=*;hxKms=e_bY$0Qi5br~ z@d@Wk9X#EV%>9w|*E;=)e;mJe`c>;MZM*&I*52gvF}h20Q{_&^r~GAG?Ge9iQMb;U zccF*weEd48w6CWm)Sc7JUn+B7=w;vU{7+^-PVW9Qqi9|6xvGCB7VKAey>;Dnhhj~E zN9Tj$uEu1lO7G!!TxL3N)y|z4bPA2mFM9KJTiB{S&EHmKwv}E* zSMo33TY536mj9B?SDrcb^H+r0W&iQ5Y;QaJ=C)h@`#;Y+_U`#wx%ZdyHV@;z2Y23aJybcT4+(_*OVtSuByB1v}SC%8~NhL^G8q0Rklw3owL)<-7)WR zi0_}2WZ%BSYh9g|#msd*mU(z{e}Lso1IyRJde^w0hp%it8hfMakHwizp5JCnFW+A* zt-Rp5dpBR@$Np#Oc2+(WBAl9(MV7zRncizB1b^0wBj6qu|Ge%kuucd>{J$#Ov!Xw%>4D{kTrpc5zwpU+#rBW@qi&+8y%7 zrB85;@$Hy18~Um{Pdw{OkGuR>?fd)N|2DiT5c80isaU5b_x|m<{cKAnTS`vZUVE-) zh}oSGS2BK7WN=$Ca@9+x}q4(+||Cg}6^ zetO=$(8%B&HQ(9i^Sd40tSh+Y=d~p#a}TMBsjZXLWp+2*!r>q6xJOEW2r@X}+aYx;RASdhEXYds7uPCumt!+?pTkcxdgTS$Yp2 zA6=rJvh-=ZSK*3zFTR-kXPExydj6{^$F9!gYu?*Gvv^;wXhF8hzn$6_t={{t`1Gn+ zGUG>Pg=G4hZL_wU#-8@L+3~zh)W#QL^8RZ(H7-Jy+biv?!+s_%UGrON#a;*64?VRkM=kgm; zwKfT@(&pZ^Yq7kv;_h`T+Il?lj(=aTsQ7N*vDdryn%2g~UX2aC`nC3J{kwhZ*027% ze)a1A4BD&bX3Oi(7yHl9@%U-*wXnSNRUd;k?m4#NRoLdZ}QC2&9)9Bg0mW;EDI88Gy zu0O%goOg3|+RImycyBM5zVeHwh@iKxu&2tGt0tGP$C_LRHCt}I;WA2#(>Z-=wtdiV z?akU|mP=D|FMR&B?L{?jZ*kY28`mVKehb&XzI3*U+_VdUQv(_peyrt`5{N6|y%}|3 zYSXo)KVvy`wBEg`o*N{8&FD|y{yX0<)_-aKQ2%WOI^R0_;G%S5lpW~2@}EKdgZYoS z&t|{6lsx78&a_>tSKZn+`TOdR07bNvMtXx~}|ntCC}Kd&}>~q)Xhk zIL8(LVNcC_tJrkC8oSl)dZK~leBxi;_g{-Gy>?$qYtyNfFKnlThKAhEy%Joz?SAdI zbGOs2(=DxQ9nY=a_iNpMhV!f5zhC$7KSTZ7`2P%C{~5IAzWeoh_v_cM_pe{~>(_sV z^789{zyB+@YOJ61`1AU|kL_O?KR*Ah$x_z(!}^-LzR{~LTIqlLl^}qnzYhFdZd$d_&Jay&y<$eV|%H5WCaB;hr%Cx_`9_-{@VynMZ z^UJig+j^N?+JnycU3thHIca9-gM)005rP3T?p_SdF>y%`59_KA-?UETWOjdJ z7JnvQ=lCX?`PAwY9M#fCZM6F?*L*#?)1T}4#+R-af3n-HES|Mlq~uW5Qtp73RF2cR zAN&72z3w?r#ws}HdFh;0t9HNL_WSL&q7CdN8D)FKeIkK=CPV->-Eql zX)fVkf8RZk?zHK-TL}AF$w^C8wBEfCnIO7G>)pHeM_96V@813T-Ma_N=0EcP^!%Lq ziPlZhr|WD!{rYUDv~n?H_J*kB>i-OLSNd1?JKyAuTQ+yv{+icYUR!Iew=LZ!edwTl z`_(y9J56&==eYO;6r$wk_rRtqje6$LHT;#kVS)md{sWl3`R{qZ^#4t$@`FQcR&Z$AJtf_0_HhhY?Gpob=`Wr`4`IA+er`KL`_kX4|@6>abumAF9T$kVR zqyA*!&+Gp_&i^v=i6$o ztzNbM_o`K^_Mck4@(TB#>GE^y-%I{y@SHDKzeVuI4=sM|y0rQ0PR|{Z^$(UB$!+IYyd$!bqjib&3CsSHO?vg_ zl^fZvyv?iGU8FTldEe%?wl8t7-OB#CrU`vou*BRW?ZU$iN@|Z!CnYE(omqEk`-_tc zTgods&w9N&HvN5(xBZ^|?wfAxd3#~%RfF)yOSc`}@KR*~!*P@0c1W`X|CMRyKD&KB zAG`Hu^;EZS@12~3o`yfM*_L*d(W_&7?A6O|7tTCgbFDK&LgL1;?)ATY|EZ`wDy_QM zb@9cC%|$OoznpJa?v(E&(^Wk2UF7<^b6)0$&$w}OX^XnU!PRg0kG^JJc4l4{dR>Qd}HjZ_HIJ z|El~?p8S7?3FZEu7k+5}_wC$qh6rYdts2=&7iylH@b2BTo>wf2ig)jKU7Ff7P4t&z zf`X}&X(+Q&vee~$H=b=gYqx4`U*Tk_L$6kEPUh%2{as0W_wSw8|1&&(-+%we`I~#s zKAzb>x%Icqe}+jr)oYe~v;M3dzP#pU`qHh{XGAM=S9+ZM+!ua*NlMQ9OIr;(bEVcz z&0H>cZm!yItL=GL!!^nn7_xO$D<-ytONBnx3%@Y#aPobvIpbXWtBbvD>kubAdstPD=O zaBAPo1xG^Nc3CHsz5W^1lec!&@r^&H#9qz5Hs@@fPuwY?C3Sfd!s1UR+}a#m`(_dA zggYylf3CB;Te!}6&SQyVcDvK9bLTI!n;-Lb{<`8h{~3HCy@DQaSc(?Dg=g z<)O7#@@xTiLs$AftVUj%;?740tU( z&CRgPbJY{6wRiU>Jd4v(<~5rZr=}&RC1hnfDM&Bp!a{G`gr^y+qC95I*N!#pjFy_E zB=}k9jq(joZj+NdBqBo&B}^2WF>lrff&BKFy8cO1-c8F9l;vi)z?k}s;i6cF zfe#Dgg8iy-Yi543pSpHBU#-mC$@@w=EBGXzdAZqdve@~Hea*gWtIsXolHb3o+uiwu zb=b}1;Mn5TURUd4Z|%;QWqDgtCXF#}%4WZ|jh3HMeEWB&-Sy+Su~GTl5q-D2xqdN^ zT$KC@c<+XOH&rdU7BD+}Ziw3Tm!&rr>!mbWhwWt#3EOkic|l z?*7SY?R|a6r^RP~UvAUA(EC&0#I?2O-V3iR$zTiIBs}G(xrBGv&zT*$y7Dtcq*gt4 z%U-|P^vcCYd;;EDQq2$kGiW+jY(8~o@%fLRv?7+jF62|UO1*pi^HVGH_?>ozS+C}D zB_6wfGuGpF-lxq*v$eL})|ed{we{HjX*X?4Z$D0(s>`RMdvN&$ZEus+r#8R5u$1X* z<|*}%1IHJ8Y`rndnU!=2K`Bu$qrdx^J{HZ&Wy!ztg}oJ(<`KT}V!OnqlS*qfD^gRn3(h}FGnv{t)oAMVd7&?~mu{V9w(QgN+tcQ( z|DqnOQ!~};Zb;r4xzn{O8F!Wji$2e`j+^Z8g9k=)XE|YSN=acepJoD@gj(xc7 zo%y@AZ}ys6cR$tqo^@4sTgHx;{3pBTY%y6Ec7KPX2v>- zYM!x6YFEZQq0*^B*QFkuqo5)$rE5k)Zfbf>TXy%XXjYpP5PZraT;BEDwVKr4&*G_Z9*=kQPbjuo&9mpo zri{nzk8RAQyjBS;5kFzMX3n7#zfxa3p1bDOrN$*St?U0IpiZsjk#aXaRD%wzQ_y;rZ^jg5_sy?XU}czAqxc=-45 z@ZVQLFNO--6_^^@8G04ekSs0zT3Y%&JU%>t!P1%mbWXp;)L&mio{4nlyY2NcTYov@ z>&tB4dAZNZ{@SFdD61|}iG9Cr)|*8;JvVWsnh0KWy`%k2p(#se*{odty6122U3h$t z?|t2WhRo~cpTG9^7H6}kKd(zV%RVFOz|{n7rg zt}OL-4fAO|Nw3SgpStyZXn%Q6;o+)og{1}m8AQXqXXk#r?*8ehrtg&(c2B>G3x2*^ zX3J`Ko$qGaskzsjE&YA>Te@|5g{_{*w_)DwWQ&>pzW*8S8?L)q(zjXk`N7A3{3kuJ z=#%a=-lg*V=IJ8KA6H%!_4w*bUEXXhv0Zb)mekZxiB}nIcjCL>3ExhVsWZuc@-yi5 z&oz&Kobh>LvX=G9rpSMKu_Y$#z8Aiw2_)5q`_JWjNnX59DMSa&D51)~_Y}Vu0(qq!@%jYjM zJ!ZG_T-^-AGsidn>5QE=sc}Qq@^b>g6VA_d^Km*;E|)B+E2?rd_qJ`{q`vA5$H(Gl z?x-!|n`Pyy&U@{0$y9&eueW2W?reN&mtI-8Z);)t=7~0uZ~SgY=7+}VvkB+D%sdyj zt#j?Nl%wKX%UJY2{@8W#k2?Qz=KR`}gHbcw%#;^>j(^IWHN`I1Jbc28NiCVV{{nwr zU1hz0iv5S}{{;A)|1;d_oA{rh@x;{lXUiXbzZ9?e*1A3Mo4@7ipT&pfd^flkoop>% z^;bOZ%lx>WP`TN6q7H3eZCSh~Tz6rrT((cWx!l2Xm&3Gkmgqk-`(=4A!Om@8=nj6C zPg@^_pa0kO`MJZFc$ZS%V?S84*f$lg+<*GjUCU3URZrI)UX$B<{>`dX_OI*m#a^D| zzkKw#Q~2GSx2NJ~&A)qok7v~f^B$Z1Cu`nDee<93Y}(@MrD4wtD)0Yv`z*`7^oGpZ zgqOBLwb#C#S@$jPb;+bz8|;dnmx}$K_oA)*REBzQ@soG6-Z`y5{v%so&R+kD-jnje zU(AUeq1SyLS)84D+wI-~)8d%2H4RlCZg0%G{H68r-}jRvjs5#yntZ(RE!AML^}83A zwViqT5xjkCEGpOR;>}9c4sY(Qxmy$ROL#@lkL?oQ>P=tBx-ars9Jlmx;-dAtJkOt5 zH*2-Z(MA2Qcy6liJE^p4X5i&zFESTZ=PcUwSUx!K_w%r=*Wc9a?))@WDfo@;#=qSe zGb@+PI_>g#Ua@=1$?tBjK3%Zd+aFgc_3yK2*U~z9cMtQ4d+%lGJ`Ho@|F-I7t=IW= zHcLzAcdZJpwS2xicTwrB97XNYc^A(xv(Ih=~{yQB+j_c zvL+V~eK$AM_L`(OOMKyZou4i8OCQg+(>Wx6cCFQxI!mh)YY!Y|nQ6_%uekK~X13b6 z$}L+qA2px&cjwi)HJhq_Kh}DBX_>8f;KMuov&${=PG_wCyz1?@*}2Uuadc>f{&o z%5t-J+|2rIcRhFRk&kiNmZr>pt@+!2J?7k;Y4YtLPoLngC3{NK#OrtG2715UVz}`| zS)n5izZ)LAS-$?d#$(C0{eAp)Q48!0Yc79Wb-wxQId@Io@Z^Z^Ec^YRednu> zY;;O0jGkV)`r_Ja8XdpB7fye}w=^Z=LRg-oZpp$!Vd=}%Rdvs*te*IFWw#hpWY=fo z%zhW^(=Ewu|JL0+U_GslVbl7LMg}|AmhV<(Iqth!mUC(LrL~g^qo;P3|MKro*E+Li zwceGQLl$p-%`pv+v$`M?mw(`bnfdJ7>w5E-x2hkT%OMPOs~g)mNoSx%lpVV@WtK*gYV__<>mEz@BU|~-pRE}YN6CZ!Bq>T zK$G0BR;}6xLaSe`VqjN?>;_$xf8v<&>-9(CKbk&i3BDCH|4Cnc{kP>_>FaL4xj1E4 zpUg_P*iTi@V~ciM^INURXfwNQaVRV%+3I;{@w(sBAJtFWck)hk_{pC2D=li3PsM3} zxbC^}GuQHhT@gT;M!Oct%NKi}iQbX@Hv9Bc{u{Z<`DQCPd4p?% ztFH*H2z~bW_4*0<8W;I*ou9kBZL?4D-aWCAMSIwF>le%M>CQI@KK(uVTfwc1AHEve zUSzvlvs}4*_R+cfc=pKnt@B`<`8hJ){H}iQPjTt;e>2yI*0>!kEldB;aK&)?DSzt~ zt?AR{Ip%ry++SPvWO?47JIUIgwyrHYzHCC&KchOc_hpf{mp*>{_=vc6@3PQ0PiNiC z{?yL4F)}B($ot(hx1_SNxTa4*aiPDbiWGcva=hH0H~oHTc%-Y@?VNW%W$HEN&D;6& z@R`?6g|R{tzN#--`#~=2(;2?PR$l6FxBPmNKQ-#Dr$ao=gtC6Zsw& zZ!*hAZtB<^c6{@>i_`T?w*J~~ViR94kD`#F$M!?(-o1KceO6vhUjE*NpYmVQ zlh#&5AG>I0^wC>WU+wd*-tsdtPU`c&*Zb}copQeR#kCm`r>q3F&$wsNrdU~O{Oxk4 zS)f^~o>5`dLZ!a2Ysvf9T7OLa$7|0}KXd=w`tL<)_EJBqCO@_}{^V~F@b7zI&7*a9 zr<`p(XE-x@>orf;H2w15%su}ZQmYep-=2Raa#`Gto37VuRo0c?&&ghYIi2@Bt3vTZ z=XS3hU&7+g2q^qhTr%sfO}nzwsqeZm?W&8@&g`7y7Gb#CT!!_FXXEFiQ!~S2ByM^u`9FDnaK6#^t>)g>Ph2~DHLj}fy^n^xjJ%x9yr=Om_G~^l z&*0f!wq?H~y|%t;e0opbcW2m=FTO5YCa%BvdP~O59qG4JR;_&X&hm4*)Urjh5`D7w z-8i@O&(9EB#=0MU-+GPDn%-QU@3X0R#f{^lyH1M-O{<(&vGvgId20^s6*?-;zjUcg zaj(wH7MUKA6hH|^Pj#Kk~t>ozE4pO>veWvHlg;UQ|&)a&@x`ZX} zE>}l$Ynt}fj(3e~->y+UsUar3If?PryIa*;-drjzsop8OXWe|I#h-5OyP{{fU-0X? ziL9?!WFi`!{O|D(~N{$n}wN)BfEHq!vo;ev!3n-6}qFW8W1KPhWlh zCbcxLtZJgtr=;oT#_Zyn`T^4>beD7d3tF%8bJcqVm3XK9wE`c%c%7Bm*D0T6 zr%vXdWca&o-M)3})~)}2_4?b=`dhDm$JA%9e_NVd`ge`jx~}zqUcGv^ZvCrQ@7BK> zL9q!rOOL#iFsgURZ&etLc<5HRksJ_=Yvqo9b+`Q}KeL*B)vqn4rw*RCSQ>41JH*_! zzh&yq6K;=OThgC|KVCCUYmW5t`zt26*Poua(N*!M)#~l9>i(AaSDpFKpd0<@^zX*s z{~7*FtGxbqRhR2ab90Lgo+ntPr^o)(k$>}5u(tHFtjqec$Q7XV|}gb$`JM@lRLx>FnPjzyCkO$@IDPw^nREKgCwv?VJ1@ zi~B1q=Y($JYrdm#(frpO*OxsusfX;O(nHO%ZXK16pS$_cmdXB{Z-2fxc0+a6>p71< z-COjE>D#jjb)^cS99J~Idc?GNqO&sLs`djG4}!=$-y^}kc+y;%02x@G_TYr*rv^t^?UaV0w?Z{2!*Kz50V zA-DGX{c3H#D)zClD!+HV+P&q07VDp_`Q7^O*x&zW_!Rj({@W_m%a2w+yMJoF{`%d) z{HDeK85}Q(J>=C`uY0>(Yq`Z*Ri){UQCE7*ww_&K8^0{?qucH)Dw{PsZ56+|hu(O) z?0nJc9!k@gQEQiek6$+9DeKp}-%7t4ZCoA7Y4Ad0##Y|@ z-;@2OZCL+(=2YJLeNT=waH&q9c`PYz|HxjSIsFOqAJ4b{8M0Ti#Qu}^@88c_?%%%O zsN~+=NBWB2>?Yb9-<~x0g>CTJn)HRS&n9)g{mZ1LX_=k6ZMwd#(wvlFwZe(NZ0feH zd3?((OwN0l#A{Ex`~T^2uq|D*c$zw6dWz5fwmzoqlZ`=6ip*RTIKCGt>1)W5Pa z<}~pSS!T|*OOfz*@cFO#F^f&4cR_fX`S_>tFEQ4=l}F|t$Md&)eb+C zRb8uJz3N)^YW=retN*@Q()*tws{GOEKT>rJ{~3(yt^PB-dve!Gm#g>m%CGOL&%7+P zD|K9POp!Zy@x|;3U!`i3B-a_YZ8Uv#wsua9j!tq;?lyr$sgs*S3gPCwRghBx-Y5; zVxi$zZ}8qPGrhpz<~2y_&?LLZ_bQ&x+PUR>{JXzGn@|5dn$P=n>XxYZ#Kk_=HQUxE zCne8TUv)`1_%gqUZ;xu7=#rK@m%j!kiygeZHP}5jD)s#t>*PPi(Z}kZc0byG@JzJX z+e>%qW}H&gus{9R@10Dc?yqI{_T=meydP;g!{T$5|K-fyEvNIZy`DCsB~SF4`OlP} z{~6x<>YO*(SgHQ-o4ki#;Q1*9yJszJzBc*Nd99$>wld|EFMZSIt*~x?5ipgV|7+#i z`m7^9XV~7}IdM{N%kw`|Dw^z{Bp;jGd?Khe?Do;wrC|XXj~85?xm@d)<`LF5qa!!h ztYO*|aPsDAqi(lM+2nP(#)7}&G!M7!I=Sh7Zuq6u+xvx&e_9prqFjGYC7-q6R88k2 zySmLO=c7yy8<(p|OI+7W-iF$?i?s)2|-cyL5)dacyz!b=Oj^7OBp* zyDPbAUBjWtEhekQ=CZAId3%2br_*6Z6Q&Y!W+X4uG>{_k4 z?{|v4*v}^Rqx*s%%7w0p)-hipCw^XWh2gc|VbaU3?WTmSdb9X@?yTo&XM_SvuU>6Q zE){drvv!+!a^1e(f=#n+a&E0@-0hoeeQ~P)r8QL%a=dx|<)3<1G;rvij+${`1OL@f z7t!R8xb<}H-03fsK58%Cz2k52qv}Ve zIp5Ez$*N$MJT^OB@_6r`*I$p-&HVeH;m@6^UVr2TCvKRx_-9{RTYs`3zu?8nmXwf? zWVbiU$;uHW{;pe-<>ij9$}~+mIyq!g&c($klk#rv@?6warM_&}qiS_*Xb{XdOY1f?pw&YKCEYWdg}1*kDKHt)r7UIseW~8Mc1ld z?^di^^=tR6@{aq*W6DfZ>@|NZxL6t&qEfST!qtCYT_Jh4_kNw})mIK|nH-Q+5;Po5 zopAd{^ZqTTKQaDO`Szb->(%Di{|wyh-zM73{m)=m{{HKKhD*I2e;n`MO8v?3pFya) z{?@C5>;5yeHvjgR=l7pszV-KC{~2Do-ckQyZ~LF&=m-D5|H5^i+F$+8Ao8D~!_NIb z!@-Z24m&W-jG^Z-&a7GgD(w7!omZXo^u9#B{OjE0pTggor-fRC2XsF#-y=Ue;(O6C z=LL2Jcg-c6H+mZ8YHbnep7OD4X_?mH`r@BahmU0an>KsT=d_b^wiQW#SuZZz!PW5f zP5IQdb%$1qYA{6n)z{i^cB=k`!qHS zZWd>|yRBQ}k!z*+d6kNLN0&?0Gy2QEU3U2=U+|$9Wp71qov3)aY0rlbH&>msDCY0p z+8eKY^0wLj!)A(^Z*p^0n>@DUfY^BCw@7*yyINo zybTOz;qwZn({IEa-c!bJQ{v@5t=rRZ z#QVsRE43A-Igt{govBM3PO)x2^n2?L&8~#IB@PGl7YRvk+_$c4)o&r8Ra(vWyZxtD zn=f83exIwlZo=vF^{W3$^QX-ch@cd|TGm*+gn7rE}Dnl1cd#l6%o%Brzx zs%x6lKfd167M**;PcVM{T>l>J>8mnC-e>%H`ubk&C)-DVzrCnYdm9$)@pE4N5krpnpUdo&MaB8{`A5rbLRYKkeao7&5y79|4L6d7{9ptss7bj=lierO`Z8_ zo$byH-gS?D3MKt`%b#lO=Gz%-?#{V$dfD-ru1`yUWBkeI;e!VcA4jkFEsx8);#e!3_a{ISTOc;m#+0h4*=x_LXFHp*2M*OdAyd)u~uVt>V?vvQlt z?z#$;Ts)<<;Gw9wXUO-zF)n1 zlD&OKwawl-=QkgAE&lLs&mWyt$GVU2m)6?#e%FOufSM7ISW?wJ9@9Yyv%$?X|3JMw5Q2 zE&uEj``1NI_um(N{rU-ff&Up=&OCH`9`m1J`t?aGi@kKM=UxpcczR28mTr>J;&|8F zcmFdOK3%14{rr2b3v|w|4Dn$%RN+X74QS?Clhe0u z&-#VCH*VauOKaWl^|x&2O0B8U(fFM!Dn7N9v(&M)G$gLh_GjqT_UWnpWVXM_e{Rz&rnF)D=BGtF#Dp+r@2>W zU;c9DzSD~GxZ)@$wcZ;G-<77M2}K_LCzKauSIndKc*(52j=tCW2u1U zKcjDVYUrJvo+2fIv0pA{S&^i#t(7U)pkeg+WzHBA5|5dJN1#0b9=gs zjq}G@fA!bsxLw(K?q=TCqNP&*3P15gF-UjEpPjQTMQ`T3ji09WUe8{)YuDw;6LdYU z#%>8+s6O}5($uY=`MchiAN(_^BEId{B_q|nWqDsYKB+IfI!j~KT5VaQg$j>$S9ByS z`p{%HRDw){`;{#Q>Hoqx#vpP_a8neRU?KaYQ{ zfAQ$cDgPO&ga5hR|5_B7{-O0h!=c;Hs{dquUjKFai^u04{Aakn=l;L=V)=jGA1&YJ z|7Td8|DU02pXz^xyQjUcG;pcXe%l#(hm&phKQaEdN|o0CYTn;}{hwi}v>?HzQuhx3 z4|Uc58M+_L|NUoO^u1Gpt(rbxp&bk}NQgY4Q13!A^_vE&9tb6$D#^JQ? z{Iz-YJm)7{r`&4>;ujZVEd)nWeym{)j`~0$tftUM| zZe7$|x%B%=+4C=dC9Xa?^X8quzkGl6SKHoyviT|VvHhGjYPH|AFN&{P+q`?Nz`m}n zZXb(MJ4546EnZi5b@Jnwc;V@y0`b-hH?I!*mDm4TdE#$<>k~gywcCr%l^)x<$GYk- z^R%GVAzUTexrM6&x1L(!>=7~T#yP|OGr?{-mrlLT{Tf*MY0;_NO1I@}s`7D7O)=Z) zJvDznx6Cq1xwxrX=jr9`e&)VxXJ;>7_G;a(QyG&yUv7JqyKdKWi=#I4FWh0@t8DbV ztz6Fjmh^S`on0H&pZt}ozi2VD#@SGO}wzbv|Qjc;|{bCWxY zUVU%3yqkJ;{?)8I>;64svvrxeZcnyw^0EFUk5eYCUcOsexa`+Tj`Jnflh;aD@GNz6 z{^S>)&VO94V7q{|)=!gb%Xwo3*Zk~LE*HA9z~oEU>Z+T|&sNO5%j9+ZY$i9i9(&i> z(|KYBOe^I6#J@;=njCqvCSSFAYS^-gs@+$n2u)Kto4MOR^leRc%e85{%KmLXv*WJi zK9SSi>7o0sRzA(-QC(*quI+bwX_C^VLsjY0E9c(L{+2x_cl%|@U-SLvmdd5y(0Y?E zGkH;9)l@Bii8Hx}=SDBk`&!A9?kjpM;)b@7P@&$(DOY`cQrWYT-vs;qXZT!x-SUc@ z?xPo{Qndf=z7=)(FZbK**uvkd^D|x;WSl;BI6@`r)knF)6G>0EOggUmaO+8vnQl&3 zw5&Eng)XVvHhcDL-B*5ThyL-_G1}OFdVk!u`tAPEnkk-{p1p4_u31$WbI9tl)6Dg; zx(3&3V1fp(ieYPcf$~DEAp1Xv@rbQ%&-Fc9=tVrS`n-e$h z8ox!c=GDS=_DwzB+je%B@9m5FqA{^ z)_cXY-8pM`-mK1fy|4T2y28wB?-Xy=InFG3UhwT%=IN3$n||&EnlaDCF2;6C?46-; zGAnY;%*}TG&san6+@8wuBz$qpwbNm7F<}k05;_|`d8L|nJh^r)P~X}xZ|QB58wOK* zcWW@6c;(URbUSK)sJ8j6lq;a-qjlz;QvzR&Wk7Ju=?aOaLnoo{Tb{oX8nT^lsB?&`|B zd~+7P5}W3}u+2363Io4gF1XyDCHN|y;X*C{)t%`}S5BYZK6h{ak=r)y&+9s#@jjS) z-g2qe+Ml2AtY3Cjr$;60ulH2{{7tKDRz=Ku@lN;FsZ*iq+C{(LD$ZfOw$JF7{ia)2 zHUBdx{@WOQp~h-?er8eeb35Iml0Rop{Hm#8{^G=y;CI#*FKd@CzAq7WPhs*K2Zt|K zs!mCsCiA?*WL`9vojARK>!sZ)uGJzLx|P>XEmyZ&RPk#2bMF;b+O8d3dnk)R;hy^r zozjhcnv%jgJv~R;x=!Ur3dNmywD_E6_SJ-ETAOF4El8YjEqcw>xJJ?I=i1x5)*m_M zaNyX6w&s@pbYXsev5Rbi69Ws+Ud}jVW!W7olykOQZN-wCtHWL{>n;)YRoQag*Yvu) z3zLgWid%|XN|=jlnTt#KO+nG`W#Q#uP<#K*8W#r_1{Vgl7KW@A7q?X{E?KKu+&~MI zKzP^uR{MKb{xeM6{x@by^j9YO;D3homHYqfduIP<`lF(^{~5mK{%80Yeq{geotae=7+uy;IH3AP zRnDTnXJXwY%|DNq`NZzdqV_ z6H~5p?exCS;c}{9=tTaz6$jdP{dEex8}Ih2Bkx$(s#kBk zPqnOCzguXdqTc#%`-OyF{p(u4dgAw|>nFW8t=hch>wgBr>mhrK&IcE`+_rpOm-p86 z#;^4OtK4^8vaeN>(u|+GJy36hRNb|%L)-YO%eEcLn6t)v|MjOmd!m<5;s`E(R%!F6 z;Lq(psWqz)zuIDM_;yp|r}E|Z7p>As+?Mp%_d%p@gy^BF#MF(hTi2V-J9qVd%;O2i zp8HPztH#~GY*Dt_tdseRR%$O>rLw3xxmLu#ws70*m-}{}+nu>@=doLF*A@3}oRcnj z&M0n{tc@L?S4+sJtEUQO7O`|6wAn7Wz_xvEj&jw;caO~qZRQ13#~fVS6TWlNDxs^cVn<#mvg*$I@h@0jwb@x{%95iRsXClXM1Pw`U!FH7 z_28E0SGv|_=gocL_dK!O@1acTl6gv^ThAQdcq{05);7PabN(jh0?#chy>&2|9xBGs-pOd|AR(8+ZZMSphF9RJDGv~SG z`O6Z=iYM{a>FTWdoqwV3*iX|9+B2i(9QWE%@%~t*_V!oGtLNoB_{O_9Z@SdG;;*ji zvBx)<&)n#5pZg{DPHxnCv0bOOx980&I48O|cEP%rl7-e&?u3@9R|+mxQ%wyF?Y;c{ zlk~?$zf8Br)D~5LzAbyaD>8HX<7a!rb|r33%QIJyuUm9?rM2nB{m1_Nm8|$@KJjLf z>Ep$2HFqkvn?LWHa<(+rTFUf=$=dgdDY==X!l&X>3_+Xn6VW`=O!t--a?U8Kcee2_JdP{if;G)FmHg6}-=oYPg^*+6F?$y=5N`AjAyRkm% zt#yvm{dv??oFExCfkuGGL9bJ+V5IXT~QkbuvL3sQl`w6V~>g?ZeSQ;I_ z-K=c3+T{v!-xb{g^Idb3-iJ+airQSb-sx8MrrzyW-981BaXh`r*Q zyXD(;%VQ$$nfrGBXXwr?J7@f#VTsG91{V09t%}L9tlOep!aQSVul~tr>g#KMlXbtY zX}xMr_ME4x^_n45|Lpy^?mxq{Mb&@p?tVQN|DWO9e}*sbR`374d)NBk@AjWlpMrB` z#L?Qz>qCC9i@*AN>f2X~U+Id^%lZ1#E7sl5Tj_LpLA<~Huk@F5p1KMo@A7!L&UjOI z{<2xw+ioXIo@!0nFSdR~Oyz%uM@hHOE2e}drhPT{Sz2iJGjI8g$EG16l^62kzR!`Zg==X8NFPc*L_dz{>`LyFyB=G=-F8jKZu87@^GtVC=q&U){qdYWKgX7< zKdau0S@gYGofTbW6=3?0|c7S57B5wCpqg??IJ_0+qk47bK9JeAfq z6JJw*Lsq6NW|mI&s%=}_o$TsN802ieJmjtj$ypfh2di|2c_0QKjTc&P{Oi{l1cKcI>SDC+dJ$@H&sj>6f(Jw!F|HR+DyeeYTI(Bp=;B+MkGJ-ei=|O3&X}JZ<*6X~nCm)5WXb z$HpXxgsU%iN(9M`)} z`L7*A&c^-OY>%hEsk8Fj_n$%e$$o{0KN5@q^)Z>ZlsqeFo>qOxz+}B^u|uTdo?ul?q9!-i4z)lCyHL^=#3N< zj1N%`1+8Td4Gq0}_iJ!NnHNuc*ppiO8AtBv>^T>_@Ph7_8SlD%LRECHgkS4m|FAaq z>eT7Sg1pN1Y`&|S^!>io>($p*Jb!=L;@Gd3-;c>REZ%3jXK~zTZM};Zc7MKRHaqsw z@k_tVUMnh_rtP%#{Br(HhN|lGj}Z-jo#I#Ia<93wYyY}pWwl?vUwXQ?Yq`EZd42Kw zIsX|Ro!;_i){eJ(`zMs-K2}&;r?cwwzs}+%S61cZi|sh|UHItlSuT5fR+r8E*Bw1I zv;2kVzw0r3uCLBKqst!G(iygT$>W>1K8rs4dil@Y16Kb2jehGd<^PGF5vzZ7%j8p< zjxlS#?1)^g z&3J5hW%bqD-!@GOyf!m)i|TEC*~M+E^W%0L%VpPFx^BzeDN05KI-B+896R!5cIxX5 z-;UNiKD~C+oPQe~*B^|n6~C;#a^c#otD}?pH#$C^^Ue2jcuqpjcd>~^*P@T^HGB8$ zWk}nFwb>`!Z~S7B-L_KHF5^qT>oa*9xuzdCmY2v)zG8D$^fA};1#^#nT{pYx?X+{I zw`6WFx->OW@^V#g)7^{p&EZy8j|n-O+-6-Drp9|{;?5ODjqMjb{(R=RU8$#XDP-?! zyXeUePwYD(d+?*oy0f!pt$sH}v{_#{g74e{#w%f_X zY&w2?^~p0uHEAMCWWUy(zPy|9)sl^7k`Y%f-&|5s`04Ngrkyt!IOZ1rb^T{2ZZCQ! z_L#lZHJjgWUW>S_`CMXhQ)2!D`<3_8_-^l>d;PZCi>)iGm=w?Mt_`?vW!T-FHE-6k zSu?z4dnC>o_pdYldaSM{^Z;%zj%`6;>f88Z zjp?WPj};lv|V`Iy|EWX-+PUdhLAfBV}$aGTM*!rqem ze2V4kpUSwieKXno>E_NLHeQ|h=qrD?9vA7f*6j+udm_lES2sh`ZX{<;?p0; zTsIMQUf!{0&DS3rKHu{{{3Lp_^XqfB-FS}AYihW*$yQB%(b^E(wtr!-6`MyWqV zf6B7P28vGQ4PfB!2))2wnwn&q=2qtx)%(`&;>&aV$Hn$nx}Wf>4qv=^X3pe)4(-J& z3dCoH8JvCHY0Xo+>3QrH_tW+XtIO8j4wG`LyEygcvzr;)M4UO+$J=Yvsl503y({Q` zz$fuT&lgx-ebuyWV|Yr+UeWWF=Pj1q+!7!5Ui;d;_2thmmj2KbJN4?h=CK{=dwVbG zZjaRZW_oCcTj}1fFK*8lfA+O6{m?DLd0+dN>->Cdm%Yx;F?{01Z!68XcW)`3ogMaj z*{Yb=9an^=yx8s@y{aiMptFCSS+vnNjb-nQ+x^LN6wx=GBoWT)RXP>=YX;wscS^87syKI-wt~Arzcs`=2ZmMZ)@5J53 z5xY10O_cT6Xz3iPlHK#ZCo#KcZHJrw+}STJu5oFy-_Hy6oE4QWVZ^}NV`ye@G-0B# zvB^UgIi8aD%S#nC6hzL4liZ8>Q)}- z>K%1x-TMP9RZVWH0Vny2B>Te^EP z9-2+Oc=lVk#-@a;w$fX27x`Yi9CG=3jPvGi6+gn)AKsrnwfy+S8aUmyS4v-|b$ z(!Wo3$#d)5Uv~|4d|VrGSM=u3?^jDpOdnq_e|o<@DET1we}-$J%j#QZKWqLsIqv&^ zhH7~ZgOnM{rq)NZ~yL}@^k-`d)D>&dmM}BMW0KUdt>dl-@<#N z+>RdGa{ZU#e}*}`kG~hYsTNq6GpSHnTj}ANlHzcEnFVcsE}i+=a3^2NX%cVt%(#WI zzgq6P-i&`4taIJ{{%4Jh7ul!UcF&PtaMWqicEfE;HOq6&%1*OZTLr=U|8XS=-%4|fqcC(jyp>iEumdVjXwc=F`S2_vZGA*CW5b z`f=`h&eevznX`V_{50v>$#c7S)jHSJm;1Y(8q2;6XFlz~z$vD_5Wap#Aaehx?KF zwxLzbZ~nb`_bhsa*6+n$d!qB#74JHCKT15h_Vb*#bKdr^e}8atU82_cb^As4E0*p! zay9h#e+I?!(rA^w9d|=RdY@k|nm={f&U1!yR<73Fa<0A(+@~n+Nw(L2*p)fA`BC}f zU9NpM?(*979$ED5oY}b>hgV4X#0bB&+j-sp{^A?YrE>e1UzX0ElbrjpCwIojFY>*g zE`8dSzx$tmQ&ZQkEfeZbC5qnoe*HFs-LG|TviJSTKK6F;t$*ez8&@s+b7tE4eP^5Y zH+6sBre-?VSfzB?L!QcuejJiW~~`AS~R@2-HtB1UlxBW`n{%_&@m-C{3-uUo*;y<&= z>n=R6K0bYy_5JWeKALLZrdo1r`rHv_D}VLzhL@#P?paH+y{FGk&)x8L_S%o9D_-Sx zJzS&OdAP0Yo>uk86U%IifArTy{!Lo7+w01n$>(0gnLqb8x&1l$rq`N>v#qOiLvQLN z>&?1hdG@n*M&FM^RyV|t-3$(w$_YQ(D{tMJ8lF7g{FLQB*C{Sb?ORWOEc!r5=(xq2bE@Z6NS@{SFACAn449(&iToXuk)Te|_2POrvgVHsW47khiQ1&0LQ487{_ zE99@Gv+d_ql`U6o>z<0<&)xiO*}NUcZs*S3_PgY|bH11_+VlR{>#~e} zZ!`b07FXFEdHc0nYU;BObMt4cn|xyD?fFj5^RMUht*CiuQZgxDwPt%Zb8y;hOWWyl z+y&2<=LgFjd1$lxOJv+V_X+3ywH)gF&ir)y)W1Tva>p0_zDRYum@AgYzFHq#c6j%! z3wk%U-`M|JO^0vE&pl^7t}l5V&Dyj1@`=53T9?j}du`tJ@%bXgi0?C3ioeqLS!c4N zxO%Pkf-CcPOvpHP*<<73Td(_LUG^7?YTaCNhx_=)z8E(z<4S3TF1_u6lfSKt+<8@< zLu=liE!X|k3+2r!U!T8of96l2rGCqPKAobrjW1WyX+oiKL_K$YsJER?;OF-$X>vEV zZqnA?bM5l^)FpFH{oBm9y<*$$*Bif8ZC_mRUAkaR?x(~0TUHr(-%`o`vP<6aRhdUt zm$jv5b#2$?)2p^i{(5R@8o9^0I_67GX*u_nvi7(7=W_PVir##6<~l}Yu1Ev6Z5&VY zXEk&jJ-sMbqxstDgo{Sk7{Y6ROj&I@ueF)2aZ9P2>a4e?RSl_o3GduH8|a@=rgRNcnf znJ>ANb=51K4m|UVt*pOom2p+=cHLgLjT_J0bUJRHC@XcfIe+f!dKs5r@2qA^>%Q2Z z`17Y#@=f=XR-fD#zq?m4aZ|oVbK1}Rq6tg$X0KM(_#2(-u`NI35YP02r?noQYrOj2PRm&o-+GmUW8Jlq+Am>;)Og!_BdT7#JAE_6 zV6}ZBZ)?yCrla#>Z_3`h*xDZ3%Nh_XUjFoX>D7wzg8KLQJ@e*%+I&&3=0C%Qy52AD zvuX;@eC=p>F0=dWwNs@*)fdEGa=n&3?H>8+nq)=w<47(ak(OO1Uf~uK*Sha=a$BFZ zWly}+IY*uQ;y-Wq*Ys6tS@Ay(+WRuE_SLRA?QhF3#;xA%bLWAr=aYQX6LkyMgnzg+ zc~y3Q@za&FGEht3NlZ-qT=UiVFV%hQeT89tXOF0mHt zm9W?!pB|~L>-c$ZUM}zS#H8&;j)!fc@;|-Vx9)|^!ZqFMm#dy?^DcZ_H*=ZF61zPz z?9w00<+exXT#GbOjIxeKytol!^YW5Y_o#g47rCw9r zx8SjVQpInRxf@Sw|GGVIT4l^efqz1?eHl2ehOg;-xv}D5fu(=x`ngXIeEBC>WV5%@ zPWQ<@U5?ha^YKsrv`@eOdaIhSIp??u&)fT{ zivuO%)3$b}ybJzj>w4wPv}CCr6A#C1_AdR}aX;{@YPJ6P>&KV(tH%6WKl?+ySy_Mf znXBT#@4Dx{+7!R7GGBMj)c%{YU&?;Z-;$p^V_o9Cl52Ke*_AGK$InW=$=!eUu3_)) zM~iRgPdz5>|JhG5`^G}Bhy!*Ln>D#AXdk|W`^ctV~^!rDOtZHW0@!qQXu`clE=2%@_hoo=W zfvnsiuk4){f*srY}T@KMl(&m zp8K6YCtd1sNZ@_T+ZN{xzx;asU9v8{b56PRr+wCr{oC2(%7t$%+RdL9^J~K8$gkna zPgopcL+_T>hU|VcTR-eSL+>XJChp6d+iy&r-zgD2ckXHCkDIs^KMCqfEAC$X>fOF~ zCiVRLqw8>hJxkwjb`7U*kL)6xdtDx%*^z)#@n|vYu_(FA*p7 z?!INLZu@Eb)8FKycGP|Lzw=}D(e>t4=X;J{m9~pjS^HV!>Q_(8uC^F+SB|Z!TY{Wd z?d%V$d$eb*w?U!a!WpuAe@&jzXu0EI;HNvYr}>_3zW>PM*pkK-+dusli#xNY!qS9e z(ar5{G0i?H_dJiZ*avJ~d&_N~ITMGo+oRa2=8jvA9F~`!b>y|%H{E@{+@~kot+mUJ zS#hZ@wbu6S_Wd(IMt|ISsk&eB?yon(U(c`3=dGFl{G`go+*bSSi%Kc4zujAWS*hrK zjzP4+)Dt_|{DQ;7djgN`Jhz)wG~ws(ZpX9JPM+DPs>ku>;iitFtmPqJ_v#(EW@$40 z^jXt4Wqi50>(BV?3IDQdYsPwwwMUP=o^C(aRP&qauE~s&lG2h-HEO)hg;;I)x|dhZw0X(w3L)V77bnaaCm_4Z5I`(ODLCS9_>w<0RXHZ{4ntnS0& zjsF=q#L`w@*l+y%*!r8#tHjmb%z1Y6DZkIhRlmyatv+0J`$y=PY_~vnjm1}gF86LL zSgO3{D#wP&dBocjdTi$Td?gZX2KA8JEl)_obvtzg4vPdj4fT|y`J>^_ zO0Ck5>AQRhm2xXvdc)@I>hu-2Rta4)eR=Yq>SeXW7q-i%MW`gnn3U?De{1`|OoX$;sby-jK z)v2AoC;PgJde2w%&;Gvhd-~h_bt~Ub*)ac7O>W!OKkad?UE1yLvPaij<^1)3W?5^x z-&|!^;?{%RKjdXkriyHRo_s3o(%Y4BPQeqHPT44ZHn<j~%NV+@*;8W=iQVynL2n_h46`~G9=6JKB1h8+z4 z&N}~s!S>Z5r)QSDG5NNqf9|nc3%;*ZIC@HOx5cFCQ+zE`)dVK^8=n21cb4s3_|;cJ zT^VJ8(vB?y*Sp?b*$ys8wO=X21Wq}LFM`x?4Ui~zu=X_RP_o?}PJ6x@|oGjzGw$b~@qaUm0b#K1+`P_1; zD;MV`-2c|IT=4l@)zp%}9{;zzB6km4to|80zx1vBQT2~YAMc%~^{?|;?$52SvLt1m zx(IAm*|L3+UY4c5pb^E=1bNpr7 ziH>&)nPZO@#vI+i^izIv(akdwyGxZH+h_+jm^^f!b#ddLeZOwy(+7!@5RVnk7tr(|zl_i|-^(D7O1TWR}NrlN_IWtY%-QGr-Vs@U#>Sif#yYXCeyipz4yU)^n1lghizI`W7q78EiYP^2{hnV@g!H!P2Xh*KOB2UtY1Lf@9TI zx7G0}JtewTdpXW({8%yLm`C<1-D~%Lj4o zr%$u+L~C+E-Rk;!`8xU{|J@wEvIM@?X3 zt^$>>C9BnsvIhj;mU+5n&GHtjxgQtReRykgT}6f z>dM4zTL1F&u4&xcu0|KUl-aY)J6^F_`f|};-9@L@+>-br5F9aU(Z#8aPd%O(1;+9} zOWbUx*7Y(f%>VJ%?j3)37u&x-aNg-w!oxLJcZLaXeJv7F^F-uM@RE2p@586Icz(&5 zQ+)0ByXI~BH`jG9TNil0WV&Olh=1rRzj(6T-cHuqMPK|3H|CD)sb=p1VGRBn(=a1c4I&BUHei@xyVOwpmajM%Lt740`y>lHH&gy|n^P0uKFTH=T>iC4^ z8egi`-mQ15p59oQb!_U|GrLO?v}8lieE-mNl(VB<*F5ON$t`9pouB^dc3rT$caCk+ zUy~2FD_vEXbIw(@?Vq&I-CrcUJS2YlWOm_`78&*RT&K@IP)z?aaW>PwD?xdY3qG%H zzWVC%)sxF!y?U|9dcsqS1KO|N9r@3o-+oJsH6%oV{hN+-1EVB(?`r4re{a71XW;zt z;j{1WD|M~2%B9_wEV#K^qM}5oI&=4J)hRc(=Jf~kMwXr2zu|`5<4@5K%Xw$GZ}EI{ zWcM*c!SnaFx68Z#*;}>v#65>+{}~kJmiB#G&iv$VYfJLE@F%9LYPYYha=Q2FHrKQJ z?rZkF4VZ4_%eFkH(l2Al)U~tcDH}(vv<&`oE{|W-*+uSX{i7SZ&y?>E`4jpl&*7xS z#pw~RCVsDOiMHK5HMG8NU-*u@tp8rV-d4BUeN*WrGiR;LZ?C6YYkvKeIp@)JyTd>3 zeLTL;l9j)$YV(9`FXz0TdG^qa6(2ipuKjY7>&+G!rwP1Q`sXe_cU|pL#w)?nM^BPB z{bxwykJ4QK-2BwrTYC4V==;qR{c}i4;jF!8KIbvP_DMw_|FAv^KUp%1BVuk%U;8JW zFo7$&ry38>ozh^-oBOgd{q(8C$1#%)`1_|Do(>IcmfSq;yZEt9y8p6Nlh*vyPFIM` zF`1FGKsNOC62Iz4_TiUnPd??7e67VI^E7Gg?H6y>zR51L4f?w^zI3|Yqi2e8YwkqMQg(0D$!)HZY`@ed&lSF&#V34r=U(pq0L?q=r-wY$nDcsmc+#qnRi(L; z3NMuIdZO%d)Ah(PV{iE^-&xzdeGTVs-nHuOcb#2bYZi6oE|u51cdzTmhY#TkYyF<< zif<0eeC1LsQ9eI*()`!r?3`hicfwv~u6w0({fDQ@Ij8WDFSk=3CO?^z{&JCZZuif* zGd|B(-Yiyr&8qrz|Izp}*A8T_F-V9N=DWT2N#>~u+h&?OHdOO;pZfIS$G4Yq)?(9D zXW!WK^7^V(*Js~#FkKy3(Hixc^|IXMuf4iT?%9m;Qdj3Ylt-W6^S3_z$IZ{F+p4A? z{ZUgQ+x{f|!j;bOfNvJpriFYf5Bempw)N-^$G_E!zLat5DqqnnI2SNu!G)4iNsf=L z+alEsCkwhPy1cVhZ}qvIZ?oj)x-LH88oJ6f>bFYr!tARr+%nydx*Ridjt$B?JK03Y zQP=eN^|zPb-Ot^AJ9o2$J?B5?X`j>^c1Fv!Z=PxITz+?cRsQ8^Cv#MmcAdX%9T&7c zV%yxZX?A_G*CTAYS0!6L|5W%})HUd`&yL{Nx@u=5ySqO<;_NP)b7s{uQM4@jr?@tAzc<%2el`XEc_2 zVrkm6{Zsn0!|YN!9%Lpyw)nb)!O+(LdU6Mg-S2C?SNF6h&i|?T$%bd?tf*BNTjp=u zbD4kh(qvovBicUEhST<5eYhq3i{ZSfkFSPVow%IaEA`^r$H3O$IZ@`567H>^k=bP9 zy`XzaSk6P0>v<1V1!7sZTy>e|8f!FbrPjP3=epFE&CXr+E4SzMww>p8CtI8=2rK(~ z|W|iKF4#rw@Yu?u=6wD%FwPImvtuI zew?DB`1JOxT~TYM760scBDr#Egx7J4V||ZRW?Lt`HJP(5)V6421b?@6@%;Y#Q}y%y zSe&)EJ70L`tM_;0#F8GrUhMT(ebL^(3$I$Hh=oK;sR}YD7pgsC(p+VERW|F|Nm27- z?>DbZ|D3#%H%!i1Vq-;RO!ob$`ii!aH8bwqu6V1aBvQ4b&)@8wdT?g8_^lb*4>O!9+^PWgOz;GT^ zs58L#{oAImk36=yTv_4eZZRHdy|16IXRF;^ZPpufw_I<|x^=gfbeFw&xofo+colN) zzTe3)>FS$Yrk|*tSAI$SU+%}sQ_oV8Q}?p-J^K54c5UsgwJDYM-3m*#_U$k{((HRV zPU-fG&a zcWrucICFc?`pn3uvWE|?)m-Aub=!jVQqQH>$Z)S)OI~yQv70!tF7=OhY;}{9;U%^` zt@Cg1QR9>L*>fmop{8+|=LwD@`$N{9EB9Q@S93n()8};S_lu-f?t7*EZGGSQ;sP%2 z$MsxS8Z+bG_gvd6wI$%6-(9}vmYeok<>WNq{qcRS8Tam>u%!z{G=dHkncT2f{F&$0 zzF=eV;u%J~Qx_|V9{HHb@^lgF^aWAND>pRFUL2csdC}?Mc_|E%sUJ$O*O}Q}dUy3j zJ%44M?5%ZXt3I#Z9y+znSvq&>Gpp8hW>dq0a}DP&dl#JRFxPY2{=Bm5p0fYu?~K2H zV^L|#pW7#sFW>L7p7e3)#4|my$r~!FTXL?~{_E6~R#f)bd0ur+&N9=hx-uo4J=(p+ z%kTD@pEEso^IvJC;rgjR;}2Ps^=`DT^PIC)d)Gpnrs*l#O1t*U$DO_5n;xHCs`2_w zR`yz-$2;_=eOe{(J>kc<=5sl@Dw%JtPw)+^jlG+3G&HiE@&b_O&FzS=B_{bR9XEXCt=hV9s`AV8Hx=y`WcdBXKyLa#2{ocL%cLU?J>{+Ux za-aU2`BtCpSN5qtO@~5D0J9a-^wruONv-P{3j#+eeZHj%j zP5knwcgm4_?w8-+oGiUFF|McJ_osW-eeGE<52tnMZgx>wBkOuE|B>DN%QXug@V3^k zxUtS;%e<7%__8g*rG{rbVs+QCnjE{aQKLSJndx?j<__=x_0kcXw~Aua(JIT<$BY zu&Bc#Z&#MmF6(!bcI7U+ojpHCP*F%oNJ>#_qoUSoA?bB%yw>m9wQKk4)u1yNOFUXu zw7v1j>+r~X(X#6I>ecIa?b^R<*YDN8R|cP-y(IFt_Y?m|{SQwqX^JX-9)6{^_@&nu z>s*13p2u@$ZdvWsTKJi*YRTCpE?ZJqe`#*Ey?k+Vc;4%1r9Q*mHECB1Cw={%m#V0^ zR7rO4YMoPhd1|Jg&G}xhi#cXIrN4h_(#_awov}x(uLr33$=GQ*>u};1}Zkhi1k6)j~PZ0W<^J}K;LFd!E54B(H z=4U3 z>OEBdtS_}C@8*%k+s@2(SNi08$n(YO=Nj%tX-C!hwugqyG|9Q{`_++U@})KLjFR^+ z-~0D-!%x}rZ+4w8_ASVKRu`)M<KN#}B6&{?@wv>0F3xa(tM! z=!gA+PmAYX@4WR>Fyj82o8kA||3)88{}I&lm6q zy=Xc+W9{6jDs9haFoX&)2r8(5wD=fX?SEK&&1BbI-lskt+hTW7XxYn*WpC@dUti%q z`Srr>ob;5CTk~EWYdfVrx9pU**1X~=SMJAdng5}%JY81%(WA>Jm&m+Yecz@^>1%kO zv)0>PE3W2GoDeH#T)X9V?WS2?5$SJFD)*LN_TBHl|8mUR-fg!I#w*UbXm|3#{j{R3 z!hi1EuQ_;UweOdI$G`r~nQp#OS$^OC*>hBTFV#+a^>XgF>oNJujOT7WX7?tj{DWP| zagMuxe;yAjp0j1r>O#Hga_24oW#uKNt~aeLw|e~g>+fk^Rf4*od+ME}YK#9$==`{P zwaDK3G25%x<;N}h60@}Sb=TFowL3Sx`n6rZ?SYJFYWRcIrTlTX=lo<3JyPR7!6^2g z{^TMF$+|S&HM2H8JvlKv^v^c^AInepHf(ymNp0@k8A{6&4H(vyAvUMgiTua8@&3`5 zQ+N(Cs%QVV_t}4jPrqmUXZRG~dD{Fx!`1Eo8IHya{bzXhbm=PxRw3NG*{x303(nH4 zoc~d_@;}2qr8ec;r|SckmzRCd{WQ5;PhN(>Q9@?a=s|nhuw<5dN<_O zp6&Zvf2PamWSy@+E<3ku;o|+;Pj(zi=FtDuZkKp**}qq-uilJh6+L(KNa)3qNs+c2 zH)X3YTKTr;Z{fDC?A|Z8C6B*5XS}X(PWpd_$WJ=gBDhkE>h5PvPh^Z(?d*9YCwSAk z;B-k|cAk@&l98V5*}1EHXBs5kE%yr#&Mom2*?vFgvBb&NJ(Dla{`#Lm`{(A>rs1Iz zUdl*MiZcn0{jh9z+C`_vnZYmj8PCc868P-b^ZfPi&lyj4`djt({?1x?#*Zh1N>


f3Lx*ADvS9&1>_-r}JF=JSE+>t8YA4e!t@O_ho7~jbE14?$>3{ z$v9iNHnLVYPRW~3wc_h7ldOZQ({yGpI6K+w#g>eVtD+P@8$n-nm%Y8<9UJ7zB6Qhh zlBaFyMU$`BeNB(;dMt6}KSTMiTf&FtdB2TYzv1)i^}$__r%p+~zVP$2%F@*Np-;Ay zD4Pg}YwYyW(%gO0MJ_`9&h~;^Oq_dq4!6A%PTj(eajU6(fw1--RaNE_=RboS<~D~qWw3V zo@}-G!BPLrSp`qeZQD6*Q)2D`)5*u`TIYPNpKdXKvCf>Trw5kpdaK%d@V(;x)$L-t z!s2xvnnaw~`FFm+>Lqixxk`E*_e*>@&$6rTWcftFbs?dXtj%JVTW`v!^JRAUb1tvE zRl=z8q){|eZ%Veku+Vx1Bc|6IwO6m+b90M&TuIisu#8Jn_o^pkZw_|qO-(q+#y(+c zd}qVd@{7FjSD3W-Mt&;XKHK*G<9N;kmDQWeR@<-s^eHNONwDByuW+R$8>R&bx!u&+ z^^t$V#+R|B%O;hJNu3Ozyf$o((bOo{+czybDmeqSVxx=JXZ>dgOV7O9oAYnJtxWc7 zvkMFKWDwo)EKzMQy64A7<%_l@bCY9eP_^fj>~_)zU>!Y?0B!zlf|a}%72Egzxk)mJZxJV zw#&9ZZO)Tv7os*7F7eJ)3+lQYsh+j7x8S{7UvyYXa`uAwO`TKJ>yk`1eAM0+U!QvQ zLNCMBsS~gMiTHa9#h;pniGl ze}?wO&o=*g_jdmGhkxe#UH>Q7KkNMG-P`K#cdMvQVT}6E@Z?w7{tsVjuGP=IyZPTA z`^hhF{bx9Q@pI(A^0M>4KXj%tIR0mt^iQ^G|McHSwYQwB*;})u%1my_lD4bC?c^Ub^CR%h<|3 z=?_P4nCgXptN*II*@{NoPp<6@Ee$UavQF$>e}t{+;5_G&)B5^`AJ<UK%!cSIyd_%p{t@$5{by)jAJqQfPU!pRI(Nh7Mqe~Pd4sRy zQ0lG|Iie^lqD%M-e|&70eCQqd_<{QFe%>!C z^-HwoOtUI;T;p4J`%c0#OMk9iAzIy@d$JB4Ojr{Bt3}nmT;s&~liSw6_?6pN_T$fo z?+QOYe44NQ>AiGE+BKzKmdj?Vm2xiR>tA^PK6=s8eSecU z;r_PtpMf9G3i$ijMcXoazx*S;=1=~Iog959->i?jpkA>xeM0cPr3n+Cnc6kX`bb+Vqu zyNTR7#(cTrjSIt}xV3Ap*VGlItDc;g?rpr>%=*uUKfPCC?6jq_PvmW}?m8CxQh-8|>{oL+^gFRDIoyVp?c$iHFh?MZ4*%Wl1Ucj$(Q zdSZE*d7XLrmF3EEcXrNRYC7NBc#OQq|G6fMe5)#zuFOD{v}sbdD==1;ai zF253{KV^OY`zhxIuf7huy8^0OhOI3we$K+p# zHm>@+>h_+v72B_uZG5eF>ez!wGiBp-#=lQ26MH!Y8Ib_Do~@_=};Md&x}A)h06{CdE&8GJbXDz^<=*xi$&M z3Z3q~{pzFns@8ck6S9AGShp6XZ8kaUzuA7SxV^+PJ=bmj8GPO^t2bP{b@J_(bHALw zZtwH9|Nab*KlXahc21x0%e^JPPv$>^l)UV{32*Fj=jAI-`C9X@XM!)+1#@Gp@Iq9X5N-wx^LFGo8ofqkInX5{aQHv#C-0R=kG*EzBJfVecPsL z#_>vRb;?{&&}F{ldTVj$iq~JyWt*=6dp$prY@mm%T9vSmAj~QLB)DrjOui zk1dUrl`-B&7q*vZpWQDu|MWxiz0?14`0t+n@J5RF`Kk4a>FPUIpFD1Id|hD1sRyvPHC+A98!KdWLmV;+bNR*YcdygCC6@FHuK#5yt?^52g?tHAAi5VM)!HW zgU_#PTKk1xt`Dx7y}W$iq*MEod$un)*mJq<&Fh}4JhB#p{0jdMsUA*uSGRq~c4yJ@@iAk6*V}?8x7e#^)`s_8=g>cjdX8$CH-N3>0lk z2)Gcs`JB$i%k#Bm?{kGVG&96XY4x}fMqq)O5K zckv#btH0dsJ-znsY5VwWiHSd7{%2s{@V;*Dr}m9ndl~0S@2uoqAJzH%#*T~EU;a54 zCcZg5^4i!u1nitH^2Eg6{L{^f)`kFPnkLRBM@z+sz#)g!eR%ewnvwD^0 z@-NQ$7ZOq?dqU?|QBYo-bD8$VKeJEnc@~$yq*Uu|>DsO*d*?4M{kJ`RO|bCJlJ3pN z3U5r9F=KL^*uI11yOsHamtT*3(;PADk8ja(uC}*}rPOD{{&9F^^+iU%sm^TWeb3wO zTldaC6;~p4r)Wl@(&e*r{QUjeuj%>ER$cVlZ2jSNmv$`r#5d`%X^4N?uQ$tn+>cE? zrFrM~YvC;uvww!Yv0+!=x2j`Wz2fcT{q`$#)|zD;(k(ZxyMJ8&$dR>C&IX;oejeE< zW1#JuzW>mVd$ls}a(Wch_R7l~-MT}-&FLfiyP((o8+Tu6eSOn&Th7;JKbL(<71H+& z|D;y*cb!(-B)rw%_QL#|(fU)37JK`iG8gZ*)_EB7ytXviHf2KkviWC^%~D)9>*cZ? z$97DdeBkOPp4sMUS9Jw)F0w?Mx!M*k%2?1;wWQ1Q^*Y1e5?@=>%dv$$$x@Fcj@iwy zdA|5m?my*|pKMz7rbchizUj4k)6%f%8?Wrzy?gi4i$6l|-oNUv-*vpEUh;T?lCVxh z(Nkl=g~BEZBI(ZYTP1m?$G>l2Y|3vIE&FM=Uij3yyd9}|a#yd1^;|M*mQ0?QEgqSj zIHTg0>e{{wPcLtaULCO_>#KKcmz8Pm^VEk6=N%27wP#MX+{K(#90sfn-r82e>xDlg zu6U#Wq9tk(+o}`Q@=3mVe1E1K-PCd{+d8sYt6>d?-^vCa?v1;4Esng%%=T`7fW!pZ zG8HrP(gNdKb%wQxM=iK#&p$4|>34|z&WPLgy?Kr1_o~)z`gy1}v1oGHlHPw({~3<1 zJ-?==dul!R^hg)&%QdrRde$=>?BPxQbLzszo_N=S`D#DcKmE^e{jdM5((^M`&bR%f z=YHsoz+dLM6_?LQ*;MjhsunFxxqJDSdEKTxJHMoDDy+E`%A#xXDn#^J6zki&8oQ-` z{Ftis@x+OU0x9DipI_`{evqu_A&B+W5jC>RrO{I&XmU{ORIm} z`SHCsYswDWms6%jx8FahyDq-0aIWFD_vx8M1%)SG{+yk; z?)G{`rK_?gzxTcU9vo|O?DpGrJ8%4F@c*gR{PN1rk}q4fyk%ckkbTS6y7^mGnzDV{ zoI}r7iwk_pGIYyqnWOVI?rvPgul1G7&%5tw-5fq&?`F!a6N=L6@?F24_q@BetbN_* z_tD>~uDd<_ux;1TQ-_c5ELW^Q@v!PiubJzfw?*Qcd~R4BkDa#hQdFeG(HrxxWJw1o zztLZG%l)Rv^tBql7@x^X?ze6UXS;Txc=CI%)9>?SZ+o#FO|)G@ME5J8_&JNpJEqh?TE2@AA5J! z-0ey0HQ8L`&i8&4KC{NA{4w*vJ&$f3yc0Ta=hJtdoiCQ(dh9;2Xw%g&;r`@U^>6A^ zrYG!~_g2(9x9-b!cg^?Pe!t%KJ1Kuo-A2o^|4eN;0~T#7)V^M8D9Qh%PCuqU_|3G9 zU*>yyn?1dFX0hq@9L-%9FMPgSCT{63`DdEIx$F1e`r2;07Pj}=WeSz61^>_sq$R$oEMWkGv_>idpZ8Dn8?3e-FN;`7xre?w@>T* zEI;Mi#>~gFYJR&$XkY(zcb0Jlcles85AH3QeQaxn)a_0#`}x6>9NCN3r0MQ8RWTH` z^(kAv{PZk4*VFm79$!D+S+2Zz!m|LiIPHgDUZ?f$sj%B+c=eRh?ZY3BG3D|~)ptm( z=9fQVZ$AIhPZ_Ou5AU#FA_Ky4PHiGxc?U z8LGQI|0&*h_-FFzdDWk5#C}8>cYJ(Te^$7(=ehm5;^4LJM^2o~1>JuBsYv(k3C%gr zEl>58ohzR6bD}-TQYBFq}2<$R&6fx7(3Ah4*ib{xsBg z+U|c_nsB}T(80e;{MGBv&;9+k{>!3w!hhuF{bzXeL;c@>2JLA@^I!dE=&C;=ul%3k z!H<`Ti$8C>^>W?q_uEV_`xbAzojWHvw)DE>x!bvO{=G?-I95F8`S)arUr+u@X@9D` zrMlwf&Ru6xCmnS6Y8z^c>7W_WmR34i+U{7hc<`rG@S{xG_B_r}I(P1E&p zIolqsRt(K3(7xehzhZ^WpLMI>z1p>Y=k>R5>Xv5xaoOJ?Kl^9UeoK}8lYYv3&3ZO< z+s9M-ORDP}Psgk_z4t52%QQUY@{E`3Ru=_cy}5s<{gR|DYO}K!b!fI$n`DVEcj^nHt2fD>`ndsS$9{blw6luHYqB*r|$8( z_a8h9rkUA0ReN8WH1TJ_@7bSzv1_e8xxVLpi(IL<%F#(Dr~Q8W_55ptkE&Gz&0Kf;X z*1u;tZ>-zx_R=8u>-v(sv#zt$_Px7s$1c^W>1oWP#xq)PgHofOo2=R@w(l&<7f-PZ zTP@5C3_H{&RlQs`OYLNn73h?!b%y=ROpnU%eCWab@Nv3&U_p^dGfjc z4An9ZSBI}!|I0i0-TI$%!}(UW&gfh9UgE9H_p4>Qp5(K>S+#HX{?d;#YF52_wO^(t zYu%|g4FCFH3UA;^*`NK`cUtJ~dE3v--r?wbF_!iH){tqgDc{a@sjTwydc7-4eV_5N zU-|2HXKpiIcjH*$969~Rr@QLQ_@e&>Xx0CY3B7u~wD#&>&<$k&inoV{mzI{6*2czP zy?Xt9c>Jwb4$n{de|zPIpP z_v33ti|w^Qavy;~l7x4eF9ef8__um8RLa)4buq5pkY^{M>R-&b_mxHs=} zsP$d5w2+(YyS-N7y4spWhjJdiJ{INR<9GMByh(Vp*pBqgM;||);j!fA$!QUDYIQZ^QBk45b|ETZ{?E7TD3_*2cDOT+_$(MTQH^We$3lB z$?_j(?BrE$mz(=6O!MG;zvCUfv0E)aTej?bx9<46)+x@v)*Wj9<+18(vg7LubFyL$ ze@o5T`FqoP@tv<2b}jt3Uhi$4d3dbs)bI&CuUGu|&+skedfXqkx=TO#k{`{_DUayd zQ}5o``@|-F#)aI!hbN!VI<@hrcE!uklX)AXmS5lAzxJBWhs{>5anHYJT5Vf1BguFB ztN4X={K~(+#b51Rw@!6WF?|tJWMP~haJoDnu+q0)_=G=c@Pcvd^sosp1O@fw* zKZ`9Z_C&3@QgQf=XRXZR+N|~;x;xKo?Vk6isp{M1eeZK>ySImAbe+`g-4=NG)t#8< zZrdyl?SB03w*J$qo}}*Q(&_I5*Uh~D^H%c9ir~9>*^hRd?<+Vjm27dotKh`Cju!!E zU#%z?|8 z$%aicqT)Y1CNb*qy#>uRF1k|l5I@Al4_a{Jrt=i>hvj=ul6(5qlux9ewp-7}FB z(q3z2b@AT`wY5(OJsexF8Eam$XwAd#$L`y6CBzg^9Jbe_uZ=7X5oQHaxsG_UfCn2Qy%87VAAQ>8k+JUhiL7_)*DXB}pGXs+i}^~E*KIQfBu2=zAbTU zKb@*wY24P>SF&uz?XUVFX{TLd)n{5A4_I2Lmv~_}zx&Mm*abzuQYZZ`np3*X)Jbn^ zNN2gJ!RPwj7QZ)ji)H7`syKgV)%>KWWb60qjDy!VKl|Q4!#?f%{aO11U3OKvJTrS) z$Nur{$>m=>pXT>F7HHHu2)qPhJ1{r**}aeVzNvy-yxXWXpfTQC+DudAh~rZMv)Gu-`lJz3R%{UvG;a zy}PsAFqh%qsYeqFzdScy_3P%H&7~Xse80D!+pk#T*kAs+b?K9%)sg8}vs=TC%Wkb-SS)?TP5AG2rx#aUuST9N zyC^($(p?vO%PTd_uCq@b_V9GwmGd$7s7C7t^;_4L|5I8&quwfD&ht3q%kScP_CDjC z)m3*QwfJf6-z_yYtHW*{JE^$+<$80Dqaog!S?jvCc>h-Ny`44pPA%KH*gfWJR^9*j zuYC65Wv9O`oG-KH*4Jm(LLV*H&X-+!Wp-G}*6Jd)KWq65^rWU7DfrKDjOEX1bIXGt zr8e_&tUUGnb&|7_#-CY>4=)!mdhumP^wjsEje7zv?tNjnJ>})ZKk*a4{M)a~n!3gH z(<|2f3r<{nInnFf?d3NvKafAat9{L3#W~uV)+*h+w_G<~&MhnYniBMT>#>{XOnyJ+ zzx&Bv`Cs7rs;Tei?Gm3Y8THm|N7YmH#rAGtZdIFEzN#p$FSz7+#3A(!>(pKMi&M=y z9aZj|Ow2oaXHSu?n*5bj+vgn!trX+=S(^QyA#F{sp2jV_ZAR;f0G5b9vukFj zKVB}E+ST!yKl!WZ?aO~BZdYA-<)>9-{uaNJ8AtCNnbNXp!e`$rGyF{7z1N;vJA3o3 z!)tO5ty4>QtfZ0}^&$K0PhiThZKc1Ao?PGg^y{Th56|44b+`WBOUnt@ZuCY@W$)mW?YOg?`NO=QfhOP2&0aqD z%k`RN%Wr>QK6mS};${CC^2)Bizij!t?04Di_;to#&K3SXe`D9Hcl%Gja>?t+SiP@n z)$3im_O08!?$xVxpc_Wl?ayAdGq68+-~HqFyAB_zO)^eN){0k zaY#wJT>g{&tPf4haVBd#p9X%CNxWJ&>(xKMkL#t@Ur-E>ybbkI@!{d&@q6R1UjH|V-Cpqce+KjY;_?3~GD<*Pm%`lx}I4|Bab^H_}6Qa~N;k zU;BWMHEMU|_s5?Jj^8aG&0mkwlzIBo{>rY^zyC9wuPfR0@1OaH_dhLG?c0Cqjn}IG z4A~pC{=Ry)&;PwY`}O%c+TO4EQ9Qx&=%lEsoQx45~wQP3oI>T){&&I}n zzZ&~B_WtkHyVkw`vwHWc{|x(H?ca0sZg}k7@batm`+n_ywg23&)%$<1djH#h4}+yO z+svxRH;ncL`%T~CKf!kPtFP;#&m@NJbAP(!Ue{7vjo!%gui~!n_L|Q!=)4qMerq{j zxBH}gxi>f8{byL}DYi;0FY`yBuaK{6$Ze@*^JZ)AyPYm^J=Wy9b?&yC=iePOTxUGz zx&3a5<5$*he`Hd2KS1woulB-STN|cMxH~nL;olM0_)_Q6@YwIc+^aUN=1-k)qqQvb zQF&=dsPomS*Y7*mhnL4*y;@qEZTtFWaooW_{xbHvw}15Crk?y~YWz}F?WZY~y{yky zC6zz@YOQ)*h_CW>-iEcZi*&76KPeUZ&iQg=^U`t+`(UY)c~k7Juldx!d--1X@;OVr zepuh%7wILoZEdIZ{M9?z&7Xhi+SKc|0s`mXsq{;rf2R=n`~YWaVL_;cPoyWVG2&YJ%6+OKqQAw={lzx#ml@5N zT6pW~^H{lRuXlTEy(}5G)l7f#^}g?;pFH-`ar;AiUp=nisa&r=>D;>&>pz<=Yz+}( zPrty~UZ&;yqkp+<`G1DE8pA(%X6MemzWe^VpltCfm&DlpihuRzo(*3Rn5%T#|NFPB z!x8J>n_kUH)j!|u>yvD)`aLsu((Jm+HIM!?{Mh@?MAJ{~V#dDIr#riicmm#A8V=aiprhwabfOH^CL_zJUMsGJcx9-*30d5r?n%D9rUEtGn&CO;18JxeYIb>LD+t+SAP6?@%&s-jsvMpZf z^{&X%@89ft^Yq@T7YDtro=bnYGH2^2n|zZud1lvq3uespuklgcQ=Wgo?x!?rYB`naEM?yKW_0`$~h@YFF**1NCspCR+#;pwqw4xi|7Gkmv1b=LAZy;+wXb9S%K{+t#YFmdAkwAPd} z3k8I<)ia8w*oKF=hlM+bmlg%wWzY8bIal}Gt~YKgBQKrhw^rIHCA!onG4^iV#C^N> zt@4;*!LPZ?<4a%Sxm_ZAjgFp6%@3(sy3c$5?a8j%p^ASe@%9|vHFcue@0_OMtxxZ1 z3TrQluAOCHk}>b-Q|Qbdhm^=+*UmR-LMrcqDe|god%s zEvFLo5HmBo`emLR7WtN2ZTA+x(!J%i*3xa_j^Ni}?O#@#b*Lw=u$|wQs`YB4{o>p! z`Ag1lz5Cuh`6{cqclg?{W3$s^5}vu-nU-E0aBE>!#E}gy2b+B&BV+^Dbf$+mm%6by zgnm;^E-ep|*{k8#a(B|ar8`|5vX!EpdUU28WMjQCHMW_-C;!WY&d{qN=^vSFgHO#@ z`_I5puV`@7%UWRXyXdofjl3leN!u)nOIh&cw0U3fsVt4VTjQ=?nc^zC{U)zS@xK2I zX@#3++`F^moN-UO$#teGox%w_}TYp1+)1IRB2tz3#`ijT(J>TcqpND2zU+kJa7A{rab@JHi z;;jd+UY-!RZ&%K)obow!$HS`^uKSg%jq1%2l{ojlX3womS?+}&rpGS;0HujKmpI%UqQdA~HLhy;fgF8h@~ z*Y57dIp0>j-@R)0s&(&P?S8d;)w}-;r*`jJ_x|_Y@b{&b<)K$&ug2aFz5DO`)%&6U z%CE+LjlZ?-KSS1>Eeu6v3`}aGU(#!y*Tp>C>wFjZmIr z(A<{3{A#2$Yn!iIL4aWH*SlxtoM{%*{c<<;%XO>TkDCwvG7Xzp|J8p&T6 zzn;f-#`;)APY$|}_)AXvxx{k&s#(kVkG{y-+BN0s_NV4kUI>+Ei=BL$S-ZJM`10oU zC+44Ek!MNYc4?l=k2hPdS+3ah_kY~!a%mI)e};_@UY;t=_;**{cD+^UsyBZ7n+yNA z-La~dpL3`CS@)uhB94pVcp}9!aUZ*C?zyUw7xt(&u6C`xZ{U zW*U%p`TYH!sh8uodwiQ5cW29UpY)K4{?@&Y6UZ za`KAa4Ec83>g_i3tG;$K?{97?_$&Tr-XEKsbvKV^KDUq;`nPm_yE_|e?0<%-Z!hjx z{q6Ve-K%!*`+X*I`q_OBzbkf_f1Jav8ykA@vSr%mm}Z;bf8RJe1(*M4$W^c3dWC`O z5#Ra~s)o1hB~HE8nbq}L{Qb$bbw`DNz5VvlEBn}r_ut;Ue%*5EACuauti+tZLYG}j z^8fPkT`*o9{CMXnG5@1yEq<0vIo4IZ{m!|`zOH4rYsGq7-tRU$7joI^d2Vp%s_N`z z^)u%h_L^O{`dg~||D01?A?NCPx4ueeZot=zv0qb6 z@1Fe3>HUxO)6vbV&0ah%4!B>xQmSJ9iePb?_d6xv~Tji?K&p^aaw<_ezBdyp4(6F<){4k(!JdHh1kFE9*auWt*+^4o4K-3 zFWKx=cKKYci)*KGk4{bKVC z{~2z6sn@c8u=w}S{TFB7sDJY-?7-$Nv7)`&X|igzbGffhPBPi8tedtis7%v+;y*Uk zmxW*Nf4RFVRqJLM(|Ma;7wnQ$y=^69=jKZp8g5HVc6Zt>zifrxn*2p;>_18VN&a)< zlb`O#`%hn|n0}t{CH>E)@9*OaKFii;{M^SrKUmg1QttCV)hgHY(sRo%TFG8gWdB(D zDrakNuN|M|yzARHu3dWhWYW1($JIsa>fN7-R2*5ja?Y#8F^jJ}5;$fsB{grQz&Sp_ zrh1?3o>$jQyHg71Z`8{1eWZ_0$zb85o4qdpb>xE{IV&jAt3m%Hw!oRu!wI#bg%weQyD@(=IqcHD_8 zPw{dzh+lgw#qD^`6BDl6yS=$i9-b|f;TS1mYJZ?ZUa#hBjeoWK?!Y}4pY?~;OU7E+&sv+qU*|9Q%gle( zb63jABl|_X7ceLlp6-b%o+|C5w5u*FSoGwHt-|LFw~6>U8D94Na&G7CnDqBob6$Tr zck8iz{IarR_LbLie^@-dciAq&`o8Ub=_M`4r~R4|eeCD2bg6wSO8a6q*Pl7$l`4}e zYg#kU?D(^nJuBx1pTAtcUv@5ccJIXSnEwoJCpFjA|GJ$$C;dOe&&jJVe>nE;+{PbG zRk5X$WB)U_Y|X#E^_s=a+HI%JE|%HY=5PD0*(y>vM^SKf&fnXw_ubZR-F83c_1yCL z$E7oVE@y%2WKZ{^m%|K9E>l=wG)QD}UrwetZMb;yNMpnD3`ANqgaYX2nnKSQ{xSUpGl zAKiWF`;X1H`p*zq*Qf8Z{P(T-pUnOUjBau z{hgpo>3+=FT>m$^{!i#f{eSPG;+8N3YJ)F9!bUVr`Onb1eD-U@NBmR;9 z%$_~VcV6G!Py1#c{-qqd?ee?8c{5%FPU#fScrNvJuDPGutN#qHX8-c+{TBT=cjH)b z&yPKSOFMa9?e^C{u>I8gW7Bp$`@nrO_1{^x;?k-2Lmxg3uZ=yQ-1Im4WU0^Qdg-%i z0qTF;UR*x>-Y=!Mv@Gte+R_`Lm9pXu|5mSj_b0phko}}O`TKlj5;Ib(%)=)<4V`cL zVV&R6V?SoSmi;Dm*7ii@cbmkyrUkor!zZrIR85`wXYTB4nT5gE!f&`)DIWXfeY|bY zuGgny!UeWle#xKvdd1Du-{Q-xmI>Tc{pDY@`{C}{DVyuh-gLbky85KTp~>eLmW8Ke zZ_&D1Cb@4{*5#bHk?Rl5esb<={-=DFFVmM^xG5KY=*k;`fBet&BW*HfhgPlK6y?44 zms0BDrS(cqW!dR@KaU$vKJ9DPvEp@cwamH~(O-*}p6=iMllMZg&As(Xf6iqmm%dP$!)Kn|34KHtPZ?Rf@W2d&?YlqjDvj42hpSW>i%16%ZKlM-kmfd>y zGx&x1Io-=I{;WE8YVw73Atz65jeGW=q1;L}aKZ-TAnj@+`K75!+dc*8#_pKX;r*pc zY0K&`j~zF~ey`e9+V}HeTko5>@sErj>i3xc?PkAGovXh1%Zv#9jXa??cb}KVFV34Z zYw@~MCXOE8rgdgq-FM|{kW<&Rox$(!zp9XAzkBM#j#Dq%Cq1w5Grt%Y;&Xg;>U{e( zw@Z{~?dao_wv>7P$ zJx34j*`}}YDek^aYfz{6>La^1-qXLfoHu5l-`;?=$6s&Wsh)A%s8(O+Ys{9GwFi!$ zyz%DKhN~}5O1kaz6)DN<@=)!0HHlNLtLnMsZHtSxhRbH0EB<<}xVQ9}-Oh8x^Ix8S zZy=*CJ>mXEbHC5U(-WuSKa7(j&LWu8)5lW^2Q} zD|TXQ^a|#qA>mouCNfN)`Hej@V6t?Hh)%861l2inqlCLF!gv16&w3XtefrW>y@`iy zjZeQ4n5%U1&~EK4sc`X{eP=b^$?d(gS~zC=f>OQGtd%D{j8BJ4JKU4^y)I{wDVx{2 z{*=Yl&RwqIHGY5ZulUa(oPKhCZGZ9iOE%fh=4C#SI65mm|MLD#5lFd4vz3o!dqv_M`ukVR{AAO`QRj6J! ztZ70=XZbpn+j*DlTz^-Jzs!1hSgm_o%G;Eb38Hh2-qvjvSd|)`F+DwPm(Uxg7l)>W zm5IOEl^W2=-=69w%pF_#o1uS$R($7$icP;h8ol8^u&waaBjhO7Fy<)dv`~CpWLXKBd6wKf{UdkM4g}5zjn( z^{o8lc&jhJzirKa`k!H1lwj|}kQsTAjz?s_PrsEl{nosmH_>6wW_etFYtSE)HBI<# zuJj4ZwB;#*KBw=?`9Eg z>SreTchg7+UnNvc7fa=jHOnPA<#$tl6i3PSNE+ZtjnNZ&Ma28a*h=Puh857vm;V zzS^wot5&ZM^Oi)qwcU72Vd_QQuSxyNPusd%e@;KQFKL~{il3L;KGn%aS3FLi zBq+0~HFELRsny$V=kNa6|KLkDYnqD4{n~Aze-`!K)7*ADXVLF;%agPJ{WV_xEIGIC z{Py?1|GlZ5pMLq>?|tvrUw-?m?mxrs*Iz)?`V0MXXWvfM+5CB4)rZGf{}~q6nzu); zzmcXa^WON7&56a!UTEz-esM38WbDF6_YZBVXj!5z(mJL1+WT`MNjH0VOj9$v=kVM1 ze%h)K^?Yl2=u8!p<4kYzUaakjn${Z2XzeylTg_p8-E>85wSHEIQ;QQdJpw!DwTJ!+ za1CRs?U0=8*D-CXg5+w?x#_2-+b&oyv{xf{OyIfN2tXSX)jmaj4`#KVRKQWqdG)piYC}^C} z9qzMqi_5x|-OHM0JCw#b`$XMzE`7!j+Z)E3#!$wxTTy81{Qen{p|OoW1luRv{V~0B z!uRk;uCcKVEGi2?4JugED&aqaW99nRs#T4Bu`l8>V_%hotPvCFAtd!1(R=0~$fXn`>1H_hdP|)iZMzzHcM1a^=CS>BShwb|FVy17_XYpV{vJN|s%P4yt#N{*^t->@w!dio(iz5C^Jb?@dLOie!cDc_1LZa zb)~msH}<^VwmaG4cI?LacR|+>8u$Er^Vr^JUb^a}pM2JJQdY5Vj<43(bo|`3D4{H| zi1N5Nv5-33>$RnKy?^`-ZLibawyHGw`s~mp9SzZucX+o7_Pdyz=jT@3uekc%zE?{H z_cQ-J#GDuV{$AzWi(a?oFI22OcsTdpT{&$=)wtaU7w$7THzPbH%JcAU-}rU6v%1z@ zK33wNx^b$0Szz|XIL9yM51;=u-|}bSPv%Kf&UtN3fAxvF3O<}TM$ zOtbl#IP2bSJACr_o1jSFZNJneaioS`kIofzRTaJOYt|pR`+f9Jwal&DJx9L82|s*! z$1?TGUeT<>9+&{6dC(`v1>>kUR1b_psA2&ApGW0_;Q^_A*#d-tE&A8ggU z0`Fe9R&j~B34BqzgFzG2c&^y^ddEEB*3(graTY`S}88 z_-E`n&pXq7#)`X%KSl2LeouM#v0&$)ZGJ+#zD6#;^KWC)pRN0|ul)43Tru72P(+l@ zBTqkl&!r(d_u8#LzasQTSFh4!M&YoPp$j6FWx38N2^V2m<8eJY7?UdZ8@2Kf>L9*R>nqIcT*SlNuey*P8 zcj;nTzx0}`m$;HGFQ&Z{z9~BCzQj4>xg!3xTW(97GyZbhe$O{X&jtg|96hlhuUmX_9D{d=X6)BiC0 zhh$@QWxel*c}*)de%|Tc8&Rcxt&peS>8n?k@jQeli<+3`oDzT*5ZpWpm{7j*t(cX4rR$!c+1;o`Qc#clPfRjYo1(E3&DSIspx zla!n&Ia6@v%t*&s~0y@t-4jS z{A5_}uGNWaWtOgGaIas{sQs5qdbeo%OD@4*vnmZm-yh%>WU%l0@Qa6Oh07Q7X+O1Y zeG+`tc_vC=o7t-~2ep{AMO%3o{xhf^f3W!XvHDBtH|pQAc<-OKXW{evqJ^`b&$l^z zPNHa?V{oCyC$4#i(#|Gc-F$QVDv#54#g>J$H%6w$d+ZH$*PD0RXJ5&x+3D8WbCM;F z9d1&()?nyxjO*^hw-GZr%&)~czTw&>{6YVUTxgx@_t=<2-jS2e9N@T`;$O7HHkXaAA&?P{axe+D(LkLQ&uj`*1dYpz(` zcRaKC`6a2P+jeJfD|cfmN_QM zaISm$Q%<{sMSp+x^^>0>i?V`tt=^xQoYyV4KVMpVm*DR8@y&|m*vl1XYKG!{g^J4`Ru&n&;Eu@-k&Bv zzN0*?`0B_143~nOHu|*pOf6bg_jcdY*pmz1UbuP?p+*d@;P>yy~Zh-K^7OTYL1lek}YntF!jX6ye9la?k$u3I&K zQro&oOR5%$TjXyO2>!g?H)VGAF3H={Ig95OPZhds_4m4#mhzA04)|F{}esO1KxWsh{_aDZZmt!8k3zpA|eE;QoPX0E2{ch{{ zQ+A4XdDX+M&dI*9-pJB^;)h=Ld?N}^Detz@4x-$ z@8bI|moKjO$Xr*rYQ_0icYU6kZu74+{NepMD$f7M`j6p?Vd?^xe|^k)@33q0ZHd2b z`m*t%RlbYEXV;dUdpGOkEz$nlmbWc@)jXA#nfU6OTw8v>>)q)KwZ)$jKR*0;`B=i% zeRmSIf5(1yiE_{QG4pqO+}35M?DS$E)z>9|$qaawH^-`euH84o;?p}WOC0-o?)u!% z>1ogRe((5vZsD02^*`dX*Kf(*qWAL6rKqXaJoA)v=KQ)Suy3W^y4x!z_uLQ76+P+p zHs!&yMfcq8a=KpRF4KLe^`GI{eftyruk_NNerbBQCUUa)u|n&vpf&5)=jGnMy*+{9 zqQ145N{adljm2l~$DBX@G$TBR_ikD8!}eTiqcc2?aZz! zu4Wdyy?*J7xTBGu&$GYTd+*stiC^pGo|*Sewt0E%epcqO%h{8R&zbyZxV)+R)o~7` zdHZ9pMuuGSkKKMhw%FDG;NHXQWy>$sef%l2Z&Q43`j_g{iA7R-f8){=}lE0+Y_leJtp^|1JK*r5k@|>7``y%CEM0r=;n1?v2s2L;I4K2Ors| z_Pk#1p4Gxi_jA3o64zUg)+W`)9_rW5PSiKG;in)b0=3a{2WWn{5f31a+i7ZT=xwT;7m# zYxd=dy>4bkYo4-g(eC>3=>)@nhA!n<&+n!_lC^YvC^0TNmBmi2HdSiFwt&u-e{Y-IZsR&)F~Y-nOjRdfa$>*V$wD zwrJ@;F5m227}XxSDb#dg*3wyGs`}^e@?KpVsgM_Xg1a;-a?01F%iQA0>(05YUp?dH z49#sCo-U_06fXZPp0054bb0Qy>pxd1t(*P$d&;Wo=VN+TpR*U)SNr46^PrcvY}Mb_ zZ9iM{>``P>mD;E8ncJcx;%yl(-d+5wWcn%d-Cz1|nmzy0xnlZ<{|vR;ePy!0Wv9il zo=mb(=XqRX#aMdR@#DK_$7h0ib2T@ui*>)Kb+L3>UwClM^W19%J!##V+lqgGzi+pTUo*w2Uf8f*+F2<#Pzhj+O23FiP zbNYEv?Q8S8<2(8i*S*|SudA(ZYVvbW2y51MM!u_m-p;$6JfrNK+|I~`{)uzuPAj`+ zrQ5wcd)c&G8~wjO*Ps5SH~QpV?Rj6{+mxM~8MOI+#nkexZpF{mTK5`FT`l`|vdp*W z*f#dJ7jqR?i_AIs-uLf}zVkd6GaeU-*E@VZw={El!oT(ttBSin z|1yhSwd_S1chYHRuac9tQ~kf(wq0BN$983~QQs@Av({%{mTvKNU3~Ruc`ei5`z!24 z{xkGg)@aZF=U-F%!0&a2Kz@3PadhMpZ7F${la%MK3zPl?0R8#Kup?)Ggs4| zaBNAOw`=RiJKLt*|6FnBPVl5KGso@mif0P$6g-w%{U$K^be(og(lYg;=mnlLHV3@l zD!{O=EI9w8!{hAuZFa1c)h6XZUdP|KpBKK#YWLkrdB6APDQgoaMu7>wWKEx&B)z;Jo~a8)}IK z@1@f1r!7m@vN_NBFn_z`t-@`EJ^#||UKdR({G#|VM$Y-s-}@Rrx9k3m3#s_e(2?}x zU07*&iCONCYo}hnKH=i`degh7C$^oRtMf=P^Rb=&#~ix{*7mwquc!UgzEpbM>4^T5 z$aSwe)~#Hm>X>|mf$K?%O6h-w!_z;Uyl2(>ee+j+@s0Ce{I$DmT(;-D`}cUikZ8ZC z9DUJ=vuB?%YR7e+`DbRKx~@;~N1y%Ay+3ySXZU>J$L;?N z&+d6k%`&!e?&ylXvV`n@IKWfLgH1fs!uR-FA^Nz1It=mwxS66Uxwa1qt zCB?;U0)kxmM+!4@SpzPc%s;)ac*Yi^)vL^><;*mm?7dCM=y~YWwc3IW@~Gir{xSdf ze})PBY%0I}XVCq4UOMsEif^mcuDzBC&QAUJ=2O0vnOo)ak0Db#l@Yjf<~*v4Bkj^5*+alW%ob*XD~`rnrO5~y0-k-t@PNtKL1)bRbJ1@|Gs+t%|GuKZdWa^ z7oA^rUgAgI+YLHT4W-TR>C0^II-0#|){EWGHf>w>UE5ovaQ?d68PDc=&Ch!+_4wtq zQ>&NVJSKAd`q7`FcR%dDVE*XrD?UxtyZy~S%k_KCm4${UDZI^A(ptSyYWJ&O^Y$~C z)|{8SEM=N#qVnpK$2g0mtr>P1uR1;RdXkx0Y^jUw_bBHddKHtd@-tR3@Afo3 zHYxV}#rH}x_65hUdcWFc(^6iUn=z~B)c#)HZ9D7EG}Cj%>qK3BKmK|9P0z}?|KYy} z6`$uHVQ+uQZ4x+V>-5Qr*Pl<0_IdHxXz!vV|K;i7Qg7#OyXv;_TN#hxy8AxMCc9id zx9jixJT;5o{gXrWXI-DPYW0tZQ(x zY~%euwZc?qy;}KGBkQG>`zpoaw%>`Y_SPlWJh$y$ICtZ=Qx2t>cnd`BY+99pyN$c%;PfsoEEo`Z8HkxaC&hDw*9z?r&VX%Y|3-o810nE%2tWa93ALM@C0Redt}r=p8)ilE*+Z zIOptkoU^Yp?)lH)RyhC1#|gpm``;@5e!lr~*H7a|$v10_%tDXYuBx7~<4H*SnrVMJ zS#)bBe)cOk_@rvbzq-CfQ8(g!UoEP474kE5ExGNx<=C&6(;vEjj;i5)#6KnazDttX z<(J-jfA93uTDJe)@`?VbA3c|7?zMkyBXw=IP)4`@Y?@Yk0;vX})W!z*56Z*X2idddEDseyN}HvVP9_*steima@et1OV)E~^?;wsmrQO7{I))}6LC=x#ZmSa8kb zkV~#2-vfQWoin}eTfD8fC)v{KWgUm2x}Ar;;PUl#F7|#~rW-yf)4P6AF{di?XHIGG zf|dHmEn3v-jbq+#o-T9R*vRAM`kVV!Ub}kN=XK9x-#1e~=f2DS{3~Ss(eKB9o7Z+f zQNQ}ZFXP)~?vzXVd4szceX#ckX&y)!!=8mPd-T-tIc9HMPxS zar~+c_jB@Bv#mO1by;ZACF>Or^{$?H`&03o<;M?y<})7rT4sM_CtucTedDF&U(?&$ z&(2knx)LUShTGzk@RnD9%JnaPocTlG_vI5sGc5DM_U*r5u}`me$CP)gPv1Q!x0Z8H zj;UbbJ?l3z%^ur)-kD3Sw_SB3-@Kc}H)wuvN3Ct@CcnLIR!Txrro4CdO`K5mI9D+5 z<|fX!`+mROe%;Zh1YHqLjJn!-0g@27R@?Ad9k9=KfHMe-~ z*WaH{EZ>}?u}1mEeYL9nmRr5tjP6!MoV$O=NMQ10Sihf+OdEK2uO8>%}58eCq^yizJM23GS9-Z3zXS-VZU+2Z_((|X>TUv3i zRJl)V|7Y#|<=nmzg?ILC{Wt5;4?Fj%<^ngbKTQj^Z-2a$y)5hMwhxbU|5`g+GP)HV ziTux?`EA<7iT&;UwYoY#m!!l*n+F*M`QK5w*i+5sk@xiR^>x?pnn;^u-BlGYc$oXe zQzZDVtNC@`;yD@VUyoZXDUW<4bLzGK>phqFFMnRQsxIx#^jlA()Tfn4S4WgzlYg++ z*UUUKZhpkXNll4+)}}rWdp74C*Ndx%b%ND&_+%Hg-F$z!rtk3Goo#cLsm19j?atYC zLFm+8_|);$yfW>!z%|$vtQ3y@O1HvS4I`t+fKY% z68iJ{?RB?a&Pku)wxwuJm|MK}-BX*@8eYAeSuxMLE8p^5vFY`?TkaBbnU6J0xL6c1 ze|}KJTFEn&>rckyYp$$~Hu$J}YxnC@b5FdyHcz|pano+8_wfdQPCjvaea7N%R$aNm zku$kr42r5+u0Kwvm1KWxJ+XS$;-BYr=be7W6Pdkg=GC0M!}ChF|NiGCwP;z)`~6Q} z^gn%EvU&ZpM4wdu?VrAF*)G!(w)Mo$*uwh#pBGpjl@rWAbIf4*v!h{3H&*_fasB6x z`|q9Y%S`{?xc$1P?$Mh1PAx-!pQ`^15B(p1Qr!R6eQxo!byiPLHr1cMIajD*Zng02gP+A&qnYZ53 zQyb=<`Ve`>fxqoX24_i`Tm12V-sg(Am$AoctTxkmC-rHQ$xF{4y|IG-8d!^r9cmAL z%zyBH;(vw*V)rgQ5WG9{xWSQgTik!g{hDq!b^YSR)4I!MF4jNwUZm1};wLS4gUBN# zlee!adN{k>%KU1{mSDmE4CsTE_6HhtvlcB~Bkq=VXaOUan!%bIhZe5-WURf(c;AVx zccpZ+6x#z?f%HPexcM0w|%QtIq-jqspGQWlm1t&w*B7) z=bw7^tn&Aa|4p_#{GTC1slL&YlfnLE;SY^}ALoCW`Az<}qfqRl`Th1Xf69V%{=7bR zC(OR*%DTxfZt3Pk->zc4`{&E+wD}9NzPTN~w063-(vOVumN{parEWO6C^~<2+R57A ze{V0~hBp)a1VGKi?o!=F<{<}`Yx*v*+PF+JJ@g54DRa;bZ{-L{mA5OE8I^){b3!+k zmzHhbYPxE(^rEdB8}D~cjbI2@XY2p{`Er@R*+&(Dr-C}U_h!Bmn{iI|>AJd)J`bh+ zGj=U{?=jOdb6ElWS|NSkb{z0f0T-YxgbTE$%HIeLq0MSjQ4|H<)@zemEp^p$*Y zp`NMIF~!Win%`dkt=;cBz28%I`k|@&vaUW}{dR8Xm+KN)_x8t5j6F4b*(|I4O|u@G z{{C_7XUoUsC%>Qg&rtk!`oG0qPlaT{w4|H=)D)gOnA5mCGS@V(;om(6mHTfn(%oLBEUTRBg;`h)RJ5u@+rlh=Y1c7F&++MeP( zvE*p(6PfG-n?0|s(JWh+n3YkO7khS{o~h{02Bxy3%ll=uKA$_gZnesOuQNIPYzB*N zubP{6e$%9NYFn1atM{F*tNhRK@b-^gezW7lFVtnP{N=uTe{yHt>3hF;?tZWCk9#HT zwNkfg|G7;0yp)5BzIkik)D%&kvBhyow(0B*dGmyG*A<_spM3Dc_J92Uoc}Z2t(*9t zp^tNc#nWvM0~ds+y#2o0w`gi`tEaiJS$EEz)S}%&O{<`N9j2%-dU1)aVPSDw z9bxo>>Be8(U4q;8uDQJO&9BwTb55J>eXDnNZKAN$A!TbN?cJ}g{PDHZdSEYIuT&RR z{p6f4iFgAPTgzF3!Fp#Gh|1s@V=Jxbd71bP(hW? zig$V!e_oXGUh~hIck}c&k^h$R-nskzvHAUZ0bkBf-ZQI}`_dk>+n1MFq-(ZqD9)I- z)UEiE;`@s>_jsdIz2aJ0UQMgGEu%f{{FDhDh2o2sNG+be!#~Yh?QyP*q*YW5rFLoWH#3(vTt88y>iBM>^D|}iTsu2%9hx&?(JF=2>*p+4{?sC736uEdM>DQ3 z?OG+$y<^QD1BU&pKl19Az4MRlEIGXC!tGz5c1NR-s;;=dyaA@VVgc z>AP+x#uo0svFQE6TE^8SUyqgk-nVyX|&Rl1DyX-~wqMy4LFPoh`cTRe!>0MhH>vOv_%a6}~ z`1wCWpZ2={4Ek+9?G*R_XV|&thn=l+{J)QKyFUK?wd>uBRqK|{*&VdLv1V<1t<;u} z{j1;oTB6+b(^|efe(Tqg)$jhj{m}j{vQMt*ilPBMa%-%1+C}Yj#7fU{AXYk zQmEPaLHncaqjzuJzU-f6v;0rgw|m)t)c&!?*7w_c#?&YMXW+@aCdJzSpJDR!e@C-c zdi=Y%GHUsv`cGT9|1(_txBu%KdvCR?ldpaH!_dLNG0${!Z%}y7^OwEB_bt!=>q(Az zZuy_#OTw#fe~ivfnE%Hq)+)F8%G8uo+&6-IulmQVnEkE)P4)5ZH$@G%?YJKMWvb`3 zRq3%CH)TGL-!6GyI{W7RtVx%o)~Cz}uMPH7V@vXMH9J*t)mGy8j?#Uc{LjEXC42Ys)AI}WY~&)BJVzy8`)+r1 zB+l)7{r>f$_g}uxjN1RKx^}sf|Ig`%ZI#Qf&wuzSEO*!6eMe_)VhyiPxwv}u-}Res zFt`;lFu~Sr)D6r5+Xnv`Y97?IU$JTWe9-!;YP;K$S~Xpb=&gFbPqq|Wo_Hd^Ws0Nh z6NMC|v`CG6uFdAXcilXV%9`6wYE1f-yK)92n~oIAwg$u0SOJ5K1FQG_Qq)onf zyY}x?Fpg{%OWDTA+1MB{L*j141cAE(6Yhp~hF-mTH8#GuJMg8bT&C};&!N9ES5Js(xE(%xbdz&zP|h*i<`ijjZ=YIIU)#E!=kCWmpVANm8qL~r zc5UWliDQD&5{I>wjg59I8*6V;(%z&58qJ!jo3MaYgE1?D>)O^{1|6mq4h(E7Tv)PN zT(VYVfevusT3(a6sq}69T>q)^6Q%oZ|7Q@dv%AU9^dWX>y{_7Xb6Q%O%R{H-Zn|A7 z`ETwWmLto~m7S_QtvBU;Xz?_{-|*;F6ZvGI)8P=6o0=vcS`y_Dt|4t z4Ng2}9q(K#D=e&=yLH*S3I7>Z9M(?hZg=cGx7G2L$SvKsyI0!gUG-+WQc+RO+K)f=voD#c9lg$6ulTrSYRZL+Cl{??OuIYdUHRHO#fH;o z{N5QS?YBENeCwTbiM!V4rFc3VqRyq-h#gv1p*wR!X6&|}Mk_P(v$B3?Z&&iDhi^RO zc3|_KvoX(J=qhjcE?Ix#>W*`YCvq-X)NDHSTEFPoi?FqyJeIaZn-yAa4v}8ENa9#g zzQfK#pSx7AFN~B`JGR$#<&Aa5>&5PeT*~B+>ZmkUc?jz2UUrGx6zRL|w#D_B>^aXZ z4z|?Vzn-sG5j@4@)xCMIP40=Fx-h+cnTwCV+Hc-DXYE~cT*9?4h`xAfIn%vrW5UaG z8$WE++jLCL@=bHg?PD8?9!ebg<5;)4`$@e(?W5p%r(Y&+`?YO-#OLeWnbDE%o5F9} zJFdDU{&vNp)7I8g3%1+Trp!%VEGrs#$anIwS@}~-F4x2ymaecAdL(xF;xn0W8E)wd z7oYxQjH{Ct&e2|Ud*v;oSjLLkd*@x0XL^_Q=+d@NHdQ;dS(bZlo_PIYP?$|z`sB*o z$hX^U6Amn_xLv*B9M^)xi@aw;{%DKbTy5X?SNHAh$?=YnACgeV14k*@40iohdtFdTh#S-+imTAH-jzzm0y;=Rx56@XXj7x z#KQ>{7Og1{HW;S+h$lQKeEx8w{SDKQ({(vog_~9{HWR%5-bT;x{PoE{`WAk;dM5Mk zxvcosb(a^5n(JJXR-g>rD?kwfG$a`&3)-g=!tpOM#l@O5@y5S1;u| zczUc+C-2U&`!D7F?^(>w*dlm!Q()j8wWl}JEAF`XNx%Ln?RqpY z^7x9r+shW`ehKu+-Lr+S`20>=Kc&{wE3W*@cVEBFcaEr4dsN$ss}E21Rx7t)heoA?bR7@^3Ti z9PE$GyZ>$1hV1CKWwPa6h3+X z^Ygm@4Do+8cDMXzV1K^<$3D*g4Es+#owNMc{zvmavY+_R@Wak3B7-4Vdw#31Z^(Dg zSd&oIlAET&!LjAOF5jZDgJl$!|+GTFPM31&-eLo zpEv5I!RJa#>$ze=-V^S~d9VEaZBE$L6R9gU|7X~~HCSqgUwNc#>cz@M`9al-w@i+X zbY`hxIwPH6cJ=#%^HQJr-mUw?zh3d(k-T5KeoO7Yx5{rul8Q*WLwJ~@Yl&)UcxZ}g zZS2+9tFhOw#$NxvQ~pl*qt%aBH{F#kS(pAq&RG7^&8%rXRiX2CE%$hF#$Hi2dhu@V z_g>|B+ct)p{mQuSI_r$mI)TeBh5MgoubVMJfZMapNy#lm@#zDV@FcnLCvm3bC3fN8 zVnfU8%fD+0Fe)iB3h7HJ39eFFxJq!*u66H^WVKYkU$tu0s|5^BUf@dAdHv2mnRlwU zpA0{ezpV0!jrPCLC*9MRJ^7t8`8Q8W%oLt-ucsFcLe&im-d(%oba?vb!YsE{EmnHd zQg^+us$N`XKkKDt7sCYEHkU_odo?cZ_WJ#Af4bu0PbHz#uSWc?KfG?$k^I%0e(g-Y zQ6;l{)9bS`b$Ny*rXi-Y)#m=1dbjS|`F!QYXMVprHa)~Nxy*r4GKPWm-}SHefA2s4 z_o6|H`SO~_NpGj|n>m#CIh()mTB4>iEl*YSqSho?KPK+KXTN)SUyM4nI=Me>+WLqU zyVfO7{%fT_W8FSs*VnOESJoKw=zHO;-U_~(7z^{XO0c4}yLvQAxGaIDSq**}&)R*&yFKSe(LclV{5{|vY8 zb-dpGZ~kqSKPR;h{IEHn^5k08{Jbd>Hl#US%v*FaQhk-I=A7*9Uv{p4yvclGan$ej z=-s`WZ{D)%pWZ(szbBsc%PRiruggz{uTxNd{cr!byS>Y#il<%b$*K5UKQG(E?RasY z$=)u*@_7C}-o_}VKjp&yzK?5n z?=Jq~bh$lT`~39Y3(o?z+1|tyYu%D6$vNu1e1Vy5aO_|C3k+J5nw0((*=YP{c%uBc ze0QN$w`}a!Qu+}|{OfZ&ba3Kdw zGRVGic_ZW1nPz+LT(4v3^S0X*J5TxKa#wjflj8Xk{f{QTt&g;Eja*m%WZ7Rcy-7b^ z4YpLPPkHw7Uh2ZS$#0`e{xj%BwoQ*Nmfx(UK3!_fYpINNrMJCXzx-$D+b{q1cF)ys zS5K!dd@Hsy3*l$F;Y+_iRZl^OZD< z=2AMjuH(S`ht5BqzyD|UdHa&;{56)TyQh@<`+l{UD!8u1ZS}GElIJBJ&riFbig+;Z zxln=L8*%N@qxT}tDBX%YotCpiX8YCM)2j1xf}KCD?|*D(c`0s-qwra-N)T7oL<#^wB?V9KVwEjkG;zFPy3ahvc#;pGv9R4#`Ic=jWY34+>bt_ zZBW~iZ4ef2FLdCfa$qgyZY9qFYPPX>Isw5wo{+ zUudPu%O%!syY^45*>+p!U+BM>6Z_(8ua~_{ExTRw^Z?JYv_qQ{C(iwPb7rLI*U-?L zqId6yhKAn#8yZ@7RYy=@y?~(LoAnDZIr01X zNA-O@Q+yB4)Bni*oa3}mj;#8+i|1^a?<~4?%FWJK_w)RnIY*+D6jsEPfi|=;6&zN;jPjS7~%5T=KX|)SLOSd}^*pbj#PGuwB<;PkY?Ht}yqRthAfProN~LTdLLG2A{brzU1fW!~3f1 zD_?wzN@xANUu2Ej=2CstxsO+yTCklmZEx?(y17bk{=TZOkJ}12PFy4H;p=;9x8rKJ z_e0J2KpM2}m>y6WIF#VZwbll+EOuIM19d+M5d!9#`q&_8 z`j?34{+a3L&8n}}Mm6FI8%(nZ*BW-6eq!H~K0r&Y5j~d)3w3 zVdtXP%&OY>qp)Ue+Nbs-$LA*Ke^{5WD?aY*@(bn9igd-(P1p2?&kRf2zUGtO$JKk) z1QsX;n2R(2Sjb?zVG=J@b89-cPKY*ZuBy^!u*=3?_bF;Sb(s9MSzG_`*U*eVUE@ z`O8vSe~(M7Ke=jF&%E#R{)#TUu<_~_`+#S2&&!><{YJwyTb1?K9o@CMA5M2)j@}x( z+AwpI%!+-x)9xM-&Ed1>`m;4xm2=;PO<|$-$;HphmUL;I{B^Ri+u-unNp8L0Rw)X) z1!ylwyPKnMy4B5r_u5ltiLH@aOnyI@)vx*LzVDy5nu~W9&si+_dft-v-IeZv2Ifs>*oZ@Wj_uC|o;KDlTWJMS|SIm=V8 z1FyU*JhQ5xWL9XBrjF7vv7K=VJvqrLrN``^nqAx_m9x9Gc-Ol-Ijfg*Y3w?sxy{M^ zh0Xy>gNNU)OCNc7@@V0fUtE<>j;xB!x}^QKbo<2m{ga>QmM7G--St_$-|oHC+P7(E zZ)+y+o^s=#d&Y{6Dbw~H3GQTx6-<3>xL#kp>y6WY25zyc4brQn7Yaakqgr6R$q+#A(O_OoU`26 zQ<#G{+qXaQMOv8A>pgRlDwc9w4ftndX_q`zSnsz|Vdk^1o#Injml$`f@sY@7;5hYw zK`G%h|MHs0L2tgwTi&WZuDI^|?JrfIw#?Hvy{I*DuhUhjyXtx()y(eYT2uRcc@~`f z^y1w$TOSM8?x)iK@_Odx^m^5cuF0K!E%radqx{EOjjggbs=t@a*>fWxbKj~R?d`4= ze6_MkWtZPympbn17*Q2+yPdn%FJR{G&F?c2kMP zoK4f$uU3}}{8;b*e!fbq@zcZCY<~Gq_j39CY+ucX_e?u_~KIh}Ik!hiY za#a>}oW1(o`O2GTuCuKQSh~0LxaOV%HC>L23VJJR%B7F&j$2~e8(A+P_$c!AlT4AHo0f+ruGlKIRc*&bHPKh4MM7&?j>?+) ziUoZAaqOaDZ;-!F_Oj0HDHmC`T=p%!9$RwE^q65!!jlA{?1*QEXN{7h(yncIcj9c1 zwzARg-cHtEpuilSYYnXhaqU_dV-?)0In)9X06&KCW-?lsF>e+4j->&L&znp6{Z=3G+ zb2qNXJels0d~?p0=cc;HXFl?(^UZpHyFV|iZH{&DMgGql-*}m-e+{h`vArK$ryJfM zv?YMsMW^*d`j4pMEu2=HcCG$3akaJd+{gbe%}W0JB>#_RwdnF)b@n#T?_Iy?lCPJU zn^D^)c}Z*Q#C6}|^1m!EsaPrI{a0pFq&H7+XW9zO>#m-ppIo(V02-@t)?F?UjC}^4{;|Zu@S}JZg1qm1)OYA>F{g zrd-E*QXfTYTr-BYLcze_J3dK;SY+|}rAO04>( z>IM5&{qvfoxoFnPZ|Tx<%lc zX`z(GUpDUQsFt6VMfH3O9<6M7n##y$9_+Q}+sDv43AxAnR(}qf#WQEe7o~N9QfuQX zX7>Aa30EDqzb^GB_Fwg*NLSB$nUBOw%7f2-SSH$&^L#?s{O>QXXT4l>^YY)z7vEg% zYH8bl=BDe6MK?>zFY0c+_4M!N!*X$7L>Fe?cYQvoSO2|o(!$g#b)A=UlbgOo^YBP7 zo#%XA*ZiMw<+Jb7v00{vr_VNC7pb;1;iB*7FD8jC@_Rh1&eqBK_rH(1X6IbzUFT-I z{?K}xxck@j#aFd!C0-Kz%kyM$_VbXbyYH(gO1yh`s9)=%PlCn;)8AIs+ME_gL;o{0 z=f@vku<7ZsQ^q>QHR+Em{F*sPg@!S7~pLvAdLropC<)Q^!Wv+-0&< z#-{gikIic)KjmL!eQvI$oq5NrQ`6UX{CF0cdg`!zvE%Zp(-B*nOBS1~zhbvl<1|Bo zzINs5(*>Uc>Z%`$@cCUkueRjr)~9}~o1cwdc%Pl|S|K-|+ig(syf*=bxUuLQFWF_ zul@{;+_*>W{*Ku=L{F0n>YEKRG`6qL>cl1i! zT|DuTg^m@^3wO&;47(FDk{s5YRrYIPu5g=i&tr>og>z~-zC4zflHqPvTWi;x_)4Sl?S8MxZ%pTFc$^K9DUizd zp0RD;KKqT%M%iwumzO@?SX|w0nB-)i51pW^rZZ|$r8kQ#0$@L6WlER8L((^qf1dVAj8qJ~gkQ|H?3b?LdG zf9GvG)wwS*r#;kk+h4o7(@s*mAM-00#dH5$J*~37>-ef`lg}(DNu25a!#(qL?Zj8B zJZ`-=o9^*q-ugAyIlt>aSCg&XahWgn>E_&^w7Z)$a|IV(ne*b{vDDI+r;j}T<8VD& zW!hiei;E{b-RTr~cUFCOv2`V%hwm>-{$4 z;{hMcTccyLWd*l)+swGXAV_Zeq^0))K2MkPdK@@0?J?gi`!$i1m%TP+__}&e;^p!{ z|0uoYp2U7>3JtK(m6m7OR%>rK@LYh&Y0a_dfX?0&QEP5qh0 zi~p7!Sh}hIYhXje8i!ZE7jZ=}1WYe=P%@2E4s~uV@yk88>#I@qoYGmm+AE4rd&f%L zd{Ha3mbG+Q#7(tbep}LQ!#8c1+&n#d@f3mL#g%M&f>%p|qNNgDzTA$>;)@LocMS>s z`n5DXKKyQN{Pn9>W9z40FJ9!r>Y|$DT$*U;d>M_$F2R`w8VYla_`pQIs$i>~uH8xy`Ikj-vtyfe2 zGl=aq-F8@W(~je}+bh#Aeg0{2?tWQN-|@@xS(PVwtgavZv;V=J)&5uJ+*fhhy6sqJ zV$YV}yu`F+RST=4C87t^LoP4R7% z-8g@l{VyYlWA}GU9=icLj!@p&P}(fDOtxxchP?RWOMlkO|JFNqDVY5~gEQ0mzv?sF zgT5yn-x~ig=k)xb{|x^bKs(QD`TH~!s@Ku*DH+{`+OJ}aT{aE6xbUh2ZY2fqN z@ADHv=iQ$i_dKS2j$!?#sOLUw^ETbi+2k7(ZSi~SeV3PoS?lKQPL|GEB%R;$*W{ee z*&oxY-7Jq{#fg)-O+PAZ8Ep*&fhoH^bMcgoph_e zD{?o@dNXbJ>lsh~NZMGQWq+K!y3A56Q{naADz_8QRIiyF6DtpXwsqBC$G(vJZ+~yQ zsO@*%l?AKTz1@EJ z&xHOXyB0+X^8avG{v;*zuuiqHX_fAMjk_Dxy*askHeZZQU)TlSiiUXQkIyx8j8-X$ zU%fs-tM5Jo(@qUUVe=#S?_2+$()CwQy3Ri&{-1$6f9Cs-%g^n<7QeXrvgW^U%m4K5 zfAwV1`G?&98CtiW`Tpbb^Z3{L7mxmt|Mh+Le}>cVlK(TDtW(#y|DPf3{(lD18t?xM zyQfWG$spqO0Qsy1@MHrT;qHIZ{Md2vp9W83p3nLEccNpR zkzevlDql%j{AaKaSXFcV$E?r%yt8j^>$!jb=Xt^E%2%JOzqsd2NS8Twx&Br8b5W0H zywaB@uG4Pki#chb(xh`Otb47?B*YG+I)H9>r@@9MXQx| zKR&jFqkC14yY9nP`&a3tF8L-GR`K=CxwATE8+|^p#s1jfq1D#FWW0ev5G~CT&!zng z8MY(8pkke`Jlr=-OZcW2I@wd>q}n=(6Yd^nu8+mv%w4*RZ|0ti$F9=5vYxVd6hR{r|)>(}S6)wXf5_2KL9+>fvQQ62gC z`pmNZ`{n-qso7KgpCSGH;q%A;?D?Dc^!nEd_SzrU9YBj@ntf}3Ka%tRr2e$7|H;1# z&+_ahU)UU5JG1L?Z}gdi=da`hPFr1#?TS zeNC_Xnp~FxUC+1c^|~Fuve)f;EOBht>z-t2J(eu*{Ds%2diL`-*4BB`-;~~u^S`X;c?)j5dYq#?J zs;j?j#ddNBEW7e3(&3uc)f3M)d=UNNam6H8R*+ZZs7j=}+lHK3xi>dubot&^T-LE@ zUgyhoJDxOzU!NWySGV78-=4p5=fkJRUw!@E{QCVmxoZ_)pT(|!e|-Obd40M63^zZ2 z`26udgT8%4W$E8I#`|@q7Z{Xyj9;u1cK-68f&KNr(pMZF7SHEyo_p)((xVpB=Wl*m z+PK}ts=e-!?)Rr_S9_|hv^u?v&)l`-QdyVvs-}~VQ?{Quu<}LN6l>!{GkUp_WOnaf zWon`$A)Z_k>cU!jtXbH#bt zIfX8&85SA_uDR^GnB&Da52cH<%}%N{r@d606qUVf*6aRFyuFvc-|k$qS(pFMT=o)^ zDwCk2N`KiyUA{HBglscAGi}!fZo%EF&u|3&tz&fdj9h8@J!$IJZQq*Q-W?5j9>4Y8 zF8N{>-hC;INem+12@k*it94x!p;vb5tlf6zj2D{Bu@^6`8 zFEV~*9!ZfYmYDJOiFo`M!?!_M*EyBf-<+4gS{r+}Hnw%$yM61fxv)8w$Ct5WMc%mo za#Mup^#pVOd%O1Ude^=F?Gw`y)$4EX28xFM`|4U6zxM!x3j>P-7Q!)f|IyFSLU*Sh zjhb7e*mdstpN%(O+8V~r+IIJF|AW-cdON3XwB4_tlhbW>`nH1leBHSs7gZECEt+xB zwk*;*NJ9JaAGx)!#8vUe8zu}Z@{X-?e*SRsmnysN zAElr9pYOZ+w7-2}`sb%J?e|M-o%PE%*%j&{ddzTL>F=Fy=Gun*+wq^_%zcStw`+Hv zv}a}d&%j}xwykpYm3`lTY$m-pm)Y8Lek~OpEysUSAz4Q3$x;c05B`;6=DK6hXC#><)f(vg~zn+}*;y**g z>K}(HMOSt2{@M^L$a^vV%*Tu}hTDfTnd0VgPr7}?RJAOwH9dbjlkK*g?@>FBKZ=(2 z(O2uX-mj&#fZ^lvyi_3lc!wG zc{_XCsTFrGhjVH)w}{+TExBv^?Yimi+pqE$UHAVwf7xx(}SEPp$k>SvTKa?oZ9WJ-gn&3f_MC-F|`o(?_nf2mE;Q z^2&X-3fs-s-&**#J-oQwvOoIE+0w;53odV4tL*)}{Px?r`T5sSJyjfZ=u_! z^8&LXU#Gu(`@FgK?I-C+TCS_xYaV@!yQuPbp2{cZIlt$(6z+b$ta8843ZvZB%MIt6 z|C+hdyjs-lG*|z#mGar!FRbG9JG`xMwo^{p;;B*d&Z*iEGAF-OheWSDTb4b>{Lv z%f)dIb1#*yX%XFgPcL%qvbS3TXRS1uw65YacjnLEi8%}PUxs{j_nnx0WJ>UlD;HGb#vdoUemr+I`=~5 z{0UDoR|nNBJ++o6?#gqkKQ>cVM_TKz_~jd#`swLpZa<|*4}SROWwL$R@MW(0JE65w z`}S?^Z=aleJ>%kPwzV@h=G>hu=6f;Y?Cg->ysL}DPQL0cJ3D*vx=w|=EF~9J0=<2O zJ#9@vL+vri0&h>(&b_MV#WhO4gqEV6X9?!ETf_rh}YZNVG@lkc#o*Q3YMwoWm zGB(?_{`33$E2ntHjk|xk7+V;Y#@%x^zGvgv!0oDYb7QA)_NS%WCT67l*}iP@ zY;pNnC*KOl+_-Uy@7AO9{ps2#_O6w4E|cll?mw%Ss{yKC3!Ntbe_K8-h?*)@Bf zXK14E%xC^lp2nHVa!=XU$ZvCet==1Yv25KfD{t4^mN~nsb7q~;>zbw2wesz@F7tJeCuP1ulVAh)&T^tA`h zS_gYi?OnNgx@4P-27vp{c6Fqfr zvey~*Buo6gam;Rp&cpi2ABAs(|9L;7rt!~%>m_zE_5#yB+K6rKxPEJ=OrN1u>dn4B zgMDr9UhO>dpTYRa%njGe_IG{IdK~?+3J@G?{W z$X=g0{R#6Q&$s^>vRAY1{wK!&R;kkZU(Ngbum3YF6)%|o;LrE}4B`jvzyFNcJmo(_ z_@Cf^3P0ulGq4}`=4IeYEuf$m2Ri+nkpx16@$<=ZYw88>o60%zUM;c zcbN9L#%vCI%*r>{dif#!Z`K!eWxu@Bd7G(`V&h`Opm+z~7(=@j_@3!p9 zFIK(SC4ZehMz?GaT`r-$>dZ3jYZlioeYlhxdfoDR+56Vw>aLe zyCi!3)5qEAZz{KOsQ%HrcYoi@^S_=S$zOfBG~{b|llt=Pud}{3#=O+EJTB?`=3vIQ zEQ|2>)2`3DA^TeHTu-ya|n48qzjtV`R?c^|Oy1 zc64;!68dM!mL<(=FXxdR&}zF|DCN9by~e9gxK#AG?EALQHqYBmo4USTyH5G--NHqg7K!H< zEm>)D$x&Cx+vTFG$X8#J%hy9Ld8&LpwkvbltjAIr^JXPWyeKGq#3Vt@-$Ifv3uzzuixx zEFFA~X#Mn^eL!NZ=YHp8L z?Af6(e&-1(;U3ktIos>X`rJM3{T^+a+JDzHx_(maSMbS4zBPI7X>rk1d!sGy*0$!w+qKmf@7$HMd)ldY2i;cZ^X+e8v$y`^?-LVe z73XyD!r$22Z_OgrtMfMBRsr4L)#zrvD*qieC2D>&RBG&R{8eqJ^nF&%kp-0h2B$}G~+)*ckOIT z$C~8t{~40Qef~2Xi#=N9KI7-1&0G6|>^MKhe0ipQsVb)~V(ZI$o}V+G+6BA0zA1Cv z+I6O6&x5orE7r|RI{m}_;H=Ug?{0p6KV{=h#(M|-O8+>%dt7AL?7epSaqY4-tFL8o zUvPRWvQ)T-z5G9e;L^<2h9ESw^di&y!bbH>813UxyyDxm$;le z$KaxkcK^DQ$u%pN8E@NhaPmH`-73o~e)N3EcbqdJE-YV0O{ia2;pMsYvNpA+Q&KHw z^~vr$)b(cd($bX~i+iWt|0)@s`=23jU3cxT$1VR9+t)_a82tX2-o5OuYQ^g?&v)zU z?v|G-R;)BiX*2%M@Lgtitk}!s{|rkO&C34IAbHfDcW;#2(ho}?mI+nmF8UPGeRZL% zxj*OIj^F8VFT^a)?z^M0{CcSJli8ZfexBPI?ECe;=JL7w&SpKz+b{p@aC&L{kvfix z{BQjB$QwsafBUy&Vr+bPY)5-(X{gSV6Z`)KzIylm_UF=yAE8&%RckcY+Nbv?zrG~t zeE8g|_m1(s_sfI(7?f4nI%{V9c3S`O=fnHXRqIad&cFJ(OQmf~#&YSp-|BuF{%-wO z7~}7gocsOA+I?P{=CiZc-N=?){QPus*xRuCv2Qi5e$Fh}TXVT)+0V}pz0ZF3`+RJN zY^UAIH|H8T9&@`~Pm?nDwES{Ud)@3Uf%lD;d%kBCxEXs#YJ=)>&(vk%-D-Dw&$g5l zOCP@3+!67nXidiZy!lq~vPajJ|FiySyJXJd8P>%@{-&H!U8}YK3FPzLO0Z-v|7rgA ztn7)>{)DJ!4>g20cmBQ1_wz{X+$TrhJ@38h>^k}O(vtrSSKn-!Uw6wk-Mhc8{rB8| zyS0lS%NONEyFUDLc>c$G$??gd&*vOk7{BP!>y0N~G+R{NO*7o$6RfhuKeqI?=9aAa z&$Z{&CAWTB^y+zP$o-rr!uOthNvmrJW4%>zM)KmZj~*XHt9JZJeB~(=UbfWQv)b%6 z%a_%+S9`XG%6v4?cF^5rF28-!6O-K&pUh3o*_L~?#Le#Zi&>J>w2rlj22QIvx#@50 z0fx`ZkmlwFa=4uICK8&CVb)?|4cb@!&)zy*>&=|g&wfANC7D~B`ZQJ2^ZUC>j;7nM z?^*OHyGEYdRVr}OcIw<2Z7VeuW4CT_m*0|J`RMnW!?n+~3_L8iuKamBw)}do`SsW@ z_hVk~o1HA3y$yU6@z!(3y<2Zfg3d6sIA=U3UEXOL_raZIk4jUY?D*cd&)!pS&elCH z4O17gmPl>P^4zTVroBYUXltX(wyImZr(}M(JUdD|jQ8ewwLjAih3_}!@cWy`f324@ zL*LDp@$TZFklSJ$lg@kB+1uVc^3Sbi=efPEhgB~ZGZyq;T)Jq(?v^PVio4%bX=Gb5^NbgxU!*EdaDGPcxP9t*9N6uNmvWt(K! zo4tOU&3A=leP^2(<{`Fi)gRl=J*vm{YX)sQywFtco~y=g+o;^#p0l1dw)GiYOX3S% zUCFVMWsXrrSN4KsJHAMGT$}a8X!(aDvtQgkCY`(H(e{XHZVQ7~{qZsn7nO^iC@o!X zFsUS>$kP0|p8$JGZqkKUH~(xZ({pi}9@A!E$Zx(Pr(Iut-r1}tAFuvk?lF0~`S5zp z`zj2QX&nq4^X=la?8>zKgd$h@Cp}ZXchu83J|?ewn-K4mjE|dcrGL+x^!8eys_FT6 zw|zhN{AcitjBlx{-hR|Pt>wW@i#`cv!y3_{<7V<>%XP#{`Yos|BG{e&y7zm51Z04H~-Ph!|xqM z*KK+7=S|GAU~vwktBb{z8+pAs{kc#5bJt(NpYZDJ^?(;=)|}Zdf9#3i$;Y*Eh_Nwx;fG}oEIn=n%y*YbznUiD2sneO2Y_GPceLs80 zX!$dL`@($di>CKQ`P9#3#+=%>XxHP=yY814NE}?Q@cQlF+cuMK&U=6F{qIkUmuu(G zd2XF<`RmW@){k;>RD=*~~oJlEAv%>1&bI&03x4<=MuM{HL#AmH6=|gG()J zu9Sn+`Pc6qBK91A{`!5wvJdZezvN!SY_?`)O>)O&b-nMiw{FV46&N7+BbnvouM1m` zEQwWkbv?JPZ)0fHFa2lo`P+K8y2hN#Sm<&|Ouj!v+w1JP%$WhYorVD&>x3=U$vWF(BoM(V8Os}c;`Pr>Kb`MCzTa>( z&|*#5U-7$f^DEZte~OoH$=vd^^Y6CI5XEUP{1v1ghI=0f7Mqy2J7lW2+vjVkN(uW- z&0e3_mHfeuyH4HY$K}sw?k-<{LcRLi`DH4>FYOk-Tp#l&%|DuD(Ys~RpHIB}x@q-J ziCvd(da@T!+8Lk!(Dmq_Gw*($_FWW^-v7_YPJg$M?X&Zr7JsT$X1}=4sp?K%Z^oRz zZ9k?xyJzr>FYvyh&EeS#UYF+v@7UB=wx_o3u+*j(?s=bbdwiy>zIobr-r0oBSwb;U zTdR3iLa+Dr~QP-L;sHfOnd!-208HLvF{yn3#PQk26|%XLdzdE1{r8tD?oQR0U`U^iGMN4c&!qCp zDgPO&ga5hR|5_B7{-O0h!=c;Hs{dquUjKFai%0+X|5l&<&+zoS;eUoF`-P|F|7Td8 z|DU02pXz^xyQjUcG;pcXzQ3-xoxq@iwBV2C{aa3dV*ID_?LWiTt4(_U8F-hUP;c51 zfB61P%jtRF-cR`P+@oRU+f(O0zgzjz&-i@ahn3!C{~C2gmTdLAUD7eH&(BZuwWY=1 zdj{^|6W`so&7CT(H);0GLofZ}i?zb$((O9$I1-dO!Bc z_Q^u~tRG!>E_Xivr|;CObuY4h_?cv#di`qEsaLDsf8V|8@4Ka28yCo5Px`UxKLcla zgZ+8sbNhcEGxzJRU0f;~`?g?hGr7j`t$>FtA8SjQ(xF1r< zE6O_I;)IDD-{ZoRlU+jW_jcTD6}?&-mK=U{YWZmfmXrn9=l{@}E_C6VG~N7^{c)$$ zmWWL8^%L?1g5FJ)oT>G6-NKx&^=#{+w8bRSvo=g`+;G4rKJv8FnWOfOWkG>OzS4F{ zZ$+c6991XZ_f39c5+dg8=H#M$w=$x)S1{n;H{~>u@X)J~z42k8cUJHnnCTS8&e!+amHylGS0-w% z|1|k-o#p!sKZQTwd2W^4lPq`Q^ZM(SztX?gf9?s@{!rt2?Ch`pXI5!ajy-#9_Pah4 zDh%4#cYA;D(?;Q^ z8eOZu?~*oHv}@g}6Is7Lt$UxxVC;dC+p*82QK;lvf6~wRdB2O#>}@_ZH!AIE{PVf% z*3O!`Dt+DwC)b$AkBgNK`G0=>$;|8RCf?QWuedK>{> zT+ZT(&*xhCg#A{r%4n+rqZ1x|QdQj+S%O^o^l^)!sb#x^Vj6KhvbPaQyvuR`2((*QQHd zp1#;1T{Pv&+WBv}=4G0**5`}Kl?c|>y_Wy}jX~5qVbJ6&u8qIMKXm=cs|w!z&EDzW z?)2@C^5*Ve7Q1WhI-}*6ER3c0)VBRhoUrNi=JiH1KF7S-?2&f<$#gH%JyWi1eiD^2 zDQ`)f?z-12GY^Dj23l6>u-#c|sh#?tAwculIg0)$%5-k+~2QSE?-)EJ(TI6tN+pI-)p}AXZRWXdHrv#NiRQ! zewg^wzeD}*%Kr?rcCjyb_qx1nN?6(3>Z$AJLyjw{$&(C z=ak2_Dt4D?`yD>%X0SdjEEsRdeV42X6lv z7VkXv?@qCx!S$s+OSb$yl~z^e=5#QlaMLGEW7by}PprCG`MU4X;s8_refp7oe?LVUps z5ha@Ay^Mf|cdl#kkpCRK*O49dQ6Nz(X$IPxAS{AVUpThIEW^HfkTkrg5*!yv2UDDV5?d~rkmOYz$ zO+D(kcK@Q8e?!&cPV8Rx>+R1hwd3y6ujk%eylpb~N8QR7w)&6N51H>peaUb#`f@?*+xO`c9!+A&ao0bT z{p3%SvioFr*^})OUo{&T^v|y9FCKwuDzjH`a0*EQl=hW@q zerw%zz4E7g?D{WG#uaNSN4}61iu%iZ!a~&VyZE#n_2TgKKO2K8>=PcxtInA$^Jwd-Tth<{rlcyqnQ{AX zn@_LLo$-oKy}nWUU*B`---Tyf4#!P3nsoWQ=FFEjCAnD_9y@(v$rTGewl8$U@upS{0BZ|}lf+uBwO5; zxE=G@>bV4T9HD=manIxL>5|9aA1nO5xoPcxhVEB0o#y{&p1 zb>Ch2g-Nq#l}F6YmRV=lmHstkX0_70*{`=hT`^l$CVyRdTHh@n{UckSFZi;*XFkWh zUyDBR>wl})`^2d&(zES$zPjGNuN+rqo;{(l{F`f>@3AGPA`h*qPYn&9t+A|l-|dv` z?0xU_XIyg7x_IDEvpCnI*tx5-D*Y68_EhPnWd3GPG5FdefwUV zbC-wUMw$Jb>nDHA=#}%8DOZz8zOsygVZYfbgG>7px;Jf_GbwL@f{I51!zw?N!i+ic zulcKU=}%`pjs1I+TXx&$OF3^>)MWR3K5<1yHhy#by+w=Lu3Cu}mTx>e?e1om=~Fk} zR8M)Rxn+KGW z)Z1JV8ae5d!m6{Pfwtv=t4?hVEjy)kzjm9atF+!G>G#XZTtkJ=?S6j4y0o-B{Ca75 z_|=QyrM0yJcYCk@jE%i|{ch})hN%Lb;iax2p)M+_SFe{oQ4Mjff2JA|S`WH3hk5^MUn5(B^NK3mK`&>o*Lq7TXtLWer@To zvSV8-XJ6fO`-;J~zpK{jY+2WNdd;efzuiS%Ts)g#wOwwvQd{5F#$66u>NSqKP3j5p zid&ht?$o(U>n`v~`-kKN8)hdSvl31775M8imHUS2U#ISjMR%S5x-8w<89c+pq3y+~ z?E-RZuH2g%(Xe4(!)*`Y{V%@@-MA2X|E*8bm1jEoixO0y?9%eCG0R}?y7y)CYLA`j zUVrUBob+1T?lt|j=pkPFmfJ^cuCaghPM18S`=22zb^UYgIq96szvs`XHAuVi`|NbT ziQXk*HSa1GDyKZZHO*(qimY`f*KYg}aW(el)bRMCBU*F5EW5Gga@5x7s5q@qgBQ9z z`uj!O>)hgRWWE3G>%Q^VyZc$YV|L!3Vj;7Cv1;X+CB5kjN<6c_@GCqBwZ0P<_3%G~ zW%QDhZqaYP?Ov1qYTq=mn8!0?A8F}D?`Yq4_E5xDKhao++RuvN5B5!ZE*J5W_w(8N zN5tbUY@7HedaZYC*4*OLv2Nwkn{uA*<-E0e#r2fz$r|<((oXAI>Dw($wY{??^xwr7 zCyu`R9k!p3S$>+9Kl>Y*>?fNiCC>@l>AOr#xxvTZ@v`>y-)W!TzuheBc;x*D<@$?v z9@pntcFf4Wv@9s9?y0e@wX$Nu7K@veA{&=eP_<0^EBtz_a8BJD@b#zm zWd-#fpMOl-^F?m@$H@<+?}x-WKK*z8={-l)q>0mR=RSFQ{oX>U$(B1=MgE;weR9W@ zncfzm{%=;T`kX3quKae+B#A1UWzvr=?c96Sg1!6iuIJs>blrE)EQ#(^#@GpgxBjf) zdUt%^x_7TC|CFu1d;H<;?4@yMDz`?hSo5-cA;arf*^bD7${#-?Sf|I{=&uc6NSsZe z=``>S;6E#tb!P5b^?p(2@@1zq7R^rf6~63~p8NfN?dIOn%dv%Xx4~{*>q+=4`rsS? zsqn_#@$q{r&b@zsPxkpe^)t&$*Zf+S8n@xl@=H};7GFG9yY+RLl(;(?C+u8tsiHj;hmwgL+vYQkX>(c9lf0XMbhdsBu^T{@?{p_k)$FA)B zZoU0r;+h;2VVT#m@vB3#PvkB8o$j(F?`%u8?Ul&fk8@sc`~7}jit|Zv>;DWMpZ+s2 zy!h+uYyP5Ecv4{gwJTqeE}6RpefRn-t@W{LQ_|hVA*LPI0xk9=n!S9xPx4>V{i53| z_uUo|S;Kd_C%R(e8@JwDbCjek<$|Zho#NfK$K%zxi$`|b`FNQvZhw4ny28da*=2d> zo>hNS_uK9C)mYl7@W-|L28WM5Oe@PcKlw!1wf?91e)Ie*RaH+EN&Wpc=fs*Fg>Nhv z&g+8PUT8$~r$w_=m%UoOuXEYF*&2(wa(hkueGTVszh4VJHNEs$8EEZdc2BzHIm6~J z;mtSfHRIUc*4BM}Y`uSfMfv=S`9^cEZGN?LYSm$``JS&YbuO5^(%$yd&lNkqtSL&ob?wSp zCbm(lU#~Mv|Kk$3|G7=yx<^j(kL-`s8vc16^XAR9i)wXyzv$@gK76Y9p3d`_+RG-h zRH{B*`FU>A@zR7zm8SWAvWH)qC``L{&Ggn6S+D)rYoMv{(h@iY16~w z8y+y*Y(s8Vsad_g8`pklXTH;$yKV@A%KKG-B7k8p)5w z=T+w!Y^v${6}DXXs%U3yNXm@L=d;frJRMtpsx$pJ6MxD*x0COG{?ckb@oUau(@A$l zMGvN~s`cCNv@%TNs>QJlTeEVjq*h0_r%dZG?rL0r+^n;sFRQES^&;P!1{rsEX}(-% zde!7B=sbhXeg7F2=ReDT(_OZ{ui$C;U5%nAXYNlfV*DMk-}O_(KiioPZ)zLa`FFg# ze!@V@`rXkP6|;8z%QGqdv$ZyG(#)+de!OE^{bsG%Kl5_S6*?IaS8MW}`u_4tKS@B| z6@}6{YGCM4IQ?|d_ea65q#cKMDN709?&d)lOxk{?4_?Wc)q3>019$CGc zU0&{I_^b7ozsW}Hi{SyDn>M<=S~T&J*QTIi|IXBPPIt5?f7RA0j_i87NGxctt&uLU(?(mzANQ*%;PuptV#WD zj`L0}@7;ED^AXc%-4w}{b99b=;)`6rZneU)9j8?Q%jD%>(%Lcnv<;YpFx86_RBdL(}cV(voBq@ zY5JqLkKax|R&=M1FTF=SHrkzCb7FKryTrfd%iXsk%7p$iOpi8tA^1yfHIu!f`)0Pw zk)LGT{?2h%@cI>Pnoy|pWkvlBx2Hinc@CDBS#DKZ)BS5b3FT(fa=BfP#p;i^zW!Hy z;?+A9#ed3w+%L-$cJUhlD4Zu{t5>G8Y9o{QYq>-x`msZ$=tsXjUE z%fmZ%lbtwo%T`mT=-s9y{;d3=eS6U})4bxh=asKz)ZALRCf9p@@$MQisbhy74bN@7 z`fF?0p0-!{+e*CM-rR8CeAji_eaUmX^Y{IJe%`xy-Ndt2?M{UipKRg+r7o=H^Qhij zbn9|R@^ZVRj~5R=*kyQkgW$x>g~Lp?;rC1OIEer{6^~IlkU0y8J1MmHWPUFS)S z?XR<{3^Sz{YgR9M#NS?DbeHjON)-&|zNLEeqWIi@>$TtS?AA=Pxp`i8#l~4ek>2+Gi#`h- zyO{Z56@TceW7i*t*vZ+MUJqa}_I@z%%|M(kVB)tIIDbOq`0@H<^-(XjSk5_A*0<$j zJNsiHjr?`}3*SyZHYxf{)Q#F(n!RzCUmBKG^JLvt-{pDMsOw@(t>`i1?g=*|ip>4j z-73xU5_Wy~{_4`xr~BFe4b@5raz{%wEn^M%0e zr|P-u9-cZY^z@F|Y=vcC_f5PVw{CSmExznz#GqYG;X0 zid|Qi`~CR#2Y)l!{R_3dUdZb2_A1$zoWCPHYPGsNZ`J3LH);P$Q)9NO`Q3iC$-gsGj1jA zIu)BP@i*=D^%XnU99}Vb?)STvEGcu+B_ePAyp>XQ^qKOEqI(lBT7;zA+>;G~~ARibY-dFKpf|>dK$)dU{+ispK zo-;xChgy7;PI>)g>#ketT9XcZZrT^S&uIAz!;DGO-wMrs)wc6~%7)z;->qM)EBqR) zvF5gP{(`RS(E+(^@VF+WQ`*~qhRPny6O(kr#&$*aqAQ*6IZ+qOTfr&H*w zs+3C@ z%U=$M-{!Br_%?m<&9`5EPG5cd@x!-YzdwBQ;jdh6WyQaFzkW@NI&?#K19wK_n#km^ zgKQCk4fEqd*t{bpu3i;gqxb5K`vQh_pn!rZOYop(-+m*R$wra2OKGW;c=@!@Jz0S=p z+aIZuH8bp%f%2yC&d{zm5pvrqBVr|k*^hYS)=ri1(Jg)cMp*B_$~rdXN9WfI*(=x^ ztly;|&$RE=i`VPcasFqRD*GYu@1OfG&c3n#Rx5w1?}x^}fB9e1zRCZ#n;iMa?W6xY z`_uI&|N8%DNa25E-c?`tFZ!SVtNPyxo1C2He_Fhc%YOgtzmj{~|D9j_Gw?pE{Qa~4 zdhQ+m&yap8+rHzT=HKH#^MBf}{Lk>F5!En`iL;;O&$sWiPb{lypZDke>t*8m4%S6J z&MLM2F8#%nyPA0$PmHHk%Aw-LpS*gr(|>KqczMYuWTx-!DYMs3JF#}k_hV`T4+`dN zo^dTDaK_rtvt;Wc_pQph7bLVWzH6d$=$2Diuez@Zp1rel)ylVYj&*k zTtV@nLtAcLb>LZcRencjlehJzfAK3z7OGxozxZ?GzSM7aqQCN(eZI*~WL@>bHc27m zpw_2vk#pyEUM#Z{(dOpsKGA<_j|0-M#aqAKRlciS&im=Rz{_jyD0hU_ zJifZ-kJsV4U7tKv9`3rHx$DcinrBiU^$uCDFq;4D%e}hZb}z1vQ)aI0PLW+)ZN!_D z+Igs2r|D$Iy0_m$RfR8>d|Y-)dE2ktb*o;kn)Pnp?d5YG*A^_BojG^wF|+Hrbvw?a zefu72-<{vJ@2WndrFKHWh@?{0@TTP>NYonJh3-*_=C~D(4YVM!D`}NQN49lW^ zn^p#p1T$^B10cho6>ylIGpF@Nhf-++**Yw|t6f))g216aIwj(U0pFZY)jSo@G4k)&|oz zJhQ`ij&~gS@wD)#;WNJivv(KQ+3ho~nqK?W{kZz9OLro`jpWq`J@KU01$#ZPPep7;!xG`{rs@*^W2c@@7eCtbbVkLpL^5JpS-0 zolU3mR-M*r^+?Z+i z93>`pf4Xy6WQp^Vbam5{Cv*h3Ri1s9)yQy6PD$a8pWD-?`r`EQCkO84Uyq!&OU>lm z-*ci&=N%a(|1%g)VGc|4DdgofU8}WOgZcW0T{R*vx9xuYa7}Wq*|A&C?Ph!vyK$`a zoN@m;voCz5=j?WX%68Dj&_;WU$h@at0zC$p8Mb}ic4dN;P?3xnv%18gR5uK(-{ zKlw}FbN%P;+AXDHeb8y)g5U*@r{iCS*>Yn7Edht$a1A% z-K@X2bLW=a+O|btndSDREo*KaTBy8>wRd7H19)-RkA{iyZ%oUtdag~ort7_Go5|6{ zFelTrR43DvG9}a0(lD10)8BWmhTb`uu%@hDVEHn`IgfwZ&o_+UZSQ~g+3jzIzxRJh z7twia@t@&(&vVKD3?2XKHG(h8|MP!-Cj95N`2P$a1XEfzPtcbBv(VqC9<24*&HDcg z2b_O8&71L`;Zwa`(*CoX{xke%XlU`aWMZ?K|JnM!t^R$>{|sWA{uuq4{qqsiYn9EC zac6Js*mKo*=7n2JE|yEq*y{!BI zYi|_V#PxCW!o}PQ4C^AbI8!EjUyAQx>W{5?oXHW-_hXimmzjO;r^OMcUFR+P_;~rP zrE~sv?h3SfEBJGE_PX+OZzA8$`73z+&Gwr<@B7z&H2tx&E>dNQ>7nzAH4iSCna1R; zn~`_b;y;7>#$)rRubMw)Sy@istaPo+ZHC*7_szJRyLrx?Bl|5X{scc*_i6V&_s6$) zPU8=Cva+n7UNb*=Pu9Nu#f-cEzH8e3cU5uZ+WAU9O^6`4M}hfdj-$mS2md~ zaqJZo-O|IDB==lu>dVJJZ)f~lXWYZ*tk~|5y!6j~#^Xjel0$OiAHB?Inwi3Ftftp; z;?0_?&(3{*H-D0y_p^F~%IHhMd$?MU{+a)@v%mcJ(lgO{%kSpNZeCnC%lG|{?#G|R zm#RE6-M2b&dTzn%y?#gLTv@}s+C@2S)=J~u-`=lk75}{Xlj6tQpK`BSiUwbboAH%> z?#}*YxiXWgC;b+?b9&=_{R^SD4_%ekdb8%|x`U^K)(G>@@;n_V5xh~HKjz{c73~|R zd6LaFJYthSoGP+77yRM$lk2&qzMg$+&V9X}^U30v(KD~0t5x&TB{y%~Ja4C>zaUH zTdygdRk;4{h|bzY+B}hUXE&X4-7`0NT5nml!nCuO&dtv~6}6$}#kL5>k1wC>RQr76 z)yl2g!}k6(%{n_HN@>>P0->_Pm^4S8l{_lFd2FBDH;1k7eH&#zuBA@H!e%bDsG=9mio*r$LiwBDw`i)BMKkRmHgh?z5cpU+INmM_rLZ=@A_-q zTX&qJZlSE`pQ&GdJ%1CazyD2m{JOfkUvJCD->G)!I`3T>eBUW>+QarUXIu&s zKO{GEy^__Ew}M6?+(s+?bb8n z?`emtx_72Enymh~IrK}b<+elRRZ??a2hD!+Y8RtrFvFksy_=WaxSW%{uk^N5?wr~i z*K;1*=iR*ix_`IC`OB8augk~Oyws`lP+;{gIkA?x+4UWPMUx z_x|0heNU&x-VHB}y&rr3ZT$OvyZ7z?GJk<<`?36~wJ)Eu%gx*Hd;2ZvU;FAeeKVi- zE|F2JGH%s2MET0x} zm96NLklK^u3m4eleO@+aW%b9ocSD5>E!(FalU;Lbvg*{w^nkDaW;6{+a4z`87?> zv-_ln$5gd78@3+5?k$qd&MW5;zGCC0cW*cA3YJ|Dy>Uc)@$_7&)WcIYV39_#wL^(LRXWwmO30@KYK0uvb< zbyr($)ZVaZt4Y|`t=@w1pHiR9udAA5KU4ML{t1=*Tsu~n?XKq!PCk>oi_NO(vek97 zRZ4rhcY1s;jn(#Y^?5yg;z`@sYm;BqzQ}ExrM6~;{Mr4B?f>TdXZY1`?X8 zO<5lF77ISUP=%RM(89+xAG=u|D<@`j8rW zzj^wjr{Zpl**K<_dR7!aZGXyo|Frp>9rnxrIav30&ky0dt%?Q-`>XIzE`iCPg(C#{rahUc&+vHDzWn)Z$F51 z_Y;0BEOTmV(A;nG%U`W{vpL1;@o9h8-c6x9)b+OhEuHr4qoAl}UbiLtYR#W7Im|ZY zKI&T+eblhs{b#`L;+^4qQ7-rYe$QIsy(4|!Eh|5@+b=x1{w#m;cG=6fz26cQ9{VJJ zHa&K~tn{{hUQv1eK_}O+g^I5y_(UIb3V*ctq2lAnrHgo#A1#`tbj-FpB>33MMRymw z2s(;vxgIO*Yg=+%;=07a{XL2|Kg{ndvKHgLxboMnU5raLzF2qsc)V?Yg#PhQwkDC& zkEf+hQw>|^xbDnb=EfU;{ywOzOZ~*Nljr)}%0h)d{~2a@_{D`kQJiRTcG>N~tZx?E zUy80yxW;E&`SsHLo$e0z=Tz`d-rw}qqI~h5-JkZqeRuiPZ`OB73$xZ$ZC-e|?0V?B zmP3}_G0|m$Wm@O1#J-$X5f*$hP0VO6^Kaga8l|RnlP2WP_^tkjt7eVopG_6(f85@G z!13zt^*TGPp3YsSwqbJH)|r;iE*5?+nC|tY`ndl**P~GnRVGG89KE~qnpI)XZM8np zl;+%y8Go|lZ$0~5{+}VwxBRbfnQ+v92IfnzpHHZ1*mmmF(@nMNt?OpjtlSsiTe|8m ztLe0hI?q3S4Gp>A>?(3SCU05C(seh_t$f*IXXUzH{jAZ;T@?l2=ex@s3;6x%w(Q5* zs@*LaCq>q!C$X}`t>-%9qH^Yx)$|i<3idzT6=1jc8RyRLT_;+rv{paq7BdV_SzW%l z``D!duG=ZPe`{^O+`if1n!a?;%J=iOe-eF?_x$AFNGW#2A`Y&=&~uvw7>*YU~c( z?(g&0ynJ2Fm)pK&;S#~tI?GDW6|8^1z2=O!rN$WC&py1+p$yg&Z4>XLJwS;&q{u& zIo+_us`%toW_om(Nz~Dba{d>C{6Pw&BIV~p1MLCKO9!DHL zYUpkKX0pbOYb%YCF4|7L>ssc!IYh|aXXU=%&tnbee!rc+uJ}s>TiRh|BV}VHV`FV) zW9{8aO1pO}Y46^o4Z8Vl_d5p$5r(Y|YqJGe*RVA(fUbUXTjAn@xcY5yEzM_AKpR9~ z`2Eq=%_o2DzJFg#Ucxk!_50aVFL?`gx^Fsn``z95X)g?AcCFRex9f3D#v0MQ{k0R0 z-B#Zgn69+w=CR=W7H2>B?aJ5}n)S2xPr$t0n=if(5_OxW-#KsM6I;ereD|D!f4R>x zS@Zc_^qxaJcT9r(Htnwn^Ez$GH2K=>n+gGQ6BoUF@i5i2@XGd@&5ydO-rlshyW1}E zlv2~}pECYO3+KJDKwxem3`IAAOCC z2+K=;GV6M?;>_zmJarE5%`c4=nwH}IcAjW$hv^HAQ(IVM(?mDrJbb<3!rs#BF`!f7zG(mcF|W2?_^Ev7zq{d?TFrG+U)4%i zo}PCk(f2b&k5=lxnt!tUIqw?Jch6t81WlaSnX~L>;3G}#y`6uW;#Qe{ z3*EQ&VSMJ&7cR>3OBK&mvJ1|8U32buLdP%j(6j273RamtrQY`$mv{ViAgiSSc@WTUpmJ*s-$FH=(+zDB1?*1tbFJ$K2s zecw+Pn|xmtZ?&eSIm}4NAk@a=io~9-7H{LrJP)HbYTfPmS$5CYDx)Cdg3hx_E2{!) zh8Lf2&*r@t`pJ5yJ@Y|t$Brj!b*}FG$>^N(UVdqffwq_N{bz~3?1IPoosNFu4!Fkl zYS*_m8w&)76&W?$j*XUA^j2L&e`^RvrgRmPk-)j{xkj7 zo}+PZ%j0dlzTP@zdc^9vU4Hwts9jOs?w&TjW)f4H!rZh9XN$i6#&PZPhQ1Vqr7BV8 z(~=h5TEDFDjjY|)BRlw*TQ(S+rqTD5u5UlA8p=YQ@WCO zSPukcSf0mK&`LpxL zpS{t$?(EXh7hAG%*{0p`PmGnbHzsa6C#&<%HGY4|tfkZSu6Y@0Zo8SzEizf7t@3o5 zXS%gn#e}=A0`8@g|4c3Sw7u&6?%4e)%WfrGFaMtWJ@;GgoY&uzzo)$$mcY2>ks{dy@(p%8bJBXUi?2x6}JB9uD2UJ|@|$ zd3wH4RVxmPV-zI*l)i+7=G_MPdvd-9`It!i#UoWbeLC94l|ZQbU6;_Y6>Yj;jO zDlnaTmGiNjy1M$&4u%UHzdn3A{q5U=#4KB}^ksWYb}(p9YBKxhsJ&muc;)BXeTKi- zJ6Fy&yH_n6xqZFDuhU0UHmpf)d7u$T7-_%^Pn=^t}v~+iypVaBai$iDb zn&c36^yjVjXB%Iq8tvgb*1u5kLu%cz-HUc_*uP#&XkACvtAska`UU)FIP4>SR{Sij zOZ*)%<8Ixg^|#-x-?e-7+WL?6KQ{hn*ggHw{QnF^w!!}yc7FU5|4*m>-O~@t|1;d_ z5BbmVu4Yq%&V;G!|LOl{5VQYY^dtB`!#np?_22F6yZ-yy`=K+QdGoNhLKbZV#@!up-pY)lPWtab+JO0A?+d`>V zt9S3-5m1s==U!JL`Z%?W(eddw=HI;2r{27Oce-P&%>Q=w_>ed%4qMmLqn4K}R z<6mh&_8xBa{mH+DCZ9H3x9DftrzrDde?m{?J+LTFeeSOPNl)2s?ey5?Vm`aFr(Rtg zI`z_F)5ZO1Wx^f8e?Be~<-HsCrfPMszwYS>;qI=7mcE(i7QGJZ^*Iw!*rvFcO>XJy z8@=31E4OH}J&d+36StA)k1M=<@;`&bKkY|c$6tz@#y>RqExLEvuAF%h#qpxm?k}*t>Ui z{2Hov|B{*~FFs*I;SNK|%aYUON=z5W21hMrFuhy%cjpuz?fq9=!c)u3%UQzyOsPqF z{G{mkQ}&{N^WWT2oBr(G-oCY|i#{Fw&){)+{kn@D=@WcaRfDE=7e~)rd*aaRJ)*PS zF8_AhIAgx!94DdtNS|Z5`-a%CVK}K3p!B z{_b2YKV@p(PrKT)S<`Nt#FVr@IeIQiDqK7NjzZ7=!E3&)d)WBYwQ9J?+(> z$Ez!~mwx@v5P99|y8q77X;ZzGWuKTmt2NuS^paoXa?MJGcN^D;>=mD(=>2Tn?b|o@ zx=py|nYO;LUt)5lol(=?D)Ie(>rCIQ`oQP^c#qxwsllD@Un?)p?$Ziern|F$a$3wH zo~=c^kGH+jcb7l0;rNZok6o=Vhp?s}ExyxKr*%Pk_wMa`_jEG^&6f?G8zsXweY%`< zPUJefyM^nF=RB4;X16=tI(PmuyZJG1=dUZC^Pl1PoadJ3>g(z&|J;vxyX@BE+%4yB zy6i5HYR|tjyR26r^3d()-?L^_=Yp20hVPi|U-H>L@@snb>$$5tgMyz; zd$;>Y#-G`%<98U(^F6Qib*8ni-hYP6X*-|1jXGTOLM-E2&%1Ii*S~M}>#TF%m3&?< zAWf`eb42crvP{36Iep77PKz@a%zeUH9(VNF#>%ckdz$v^2W@(%sm!&yYealPl!`w4Zky?37S5BiZLQ3fvy%lk zN|`mUKYH}|5z{H3l0*X04lI zX>sP{;STXIh7#@*EjpP8thCzKiu!-^H&>f*XWM%Lg>=RBd2d7Ft;#O?>V%CwEHF!@VD zlb5P>fA-%wcU`^Net7=*<)@o3g#2f4F0I%2Iel7$=AUKqQ;Zv) z@9SECs`n0QoCr zUyA3jE7Tp7d+V)pbDnqN7amioV{cxs%(;K~xxI)C5U+`$*tT4yr?EFWUyIze{za{yfLFU@_{;bTkGy85RgeR~~)>>Hf zX6yWYrP;A{$4~E=uNkCjclfsajcuLNXJxM0;&1ufq|9f2N#1&0=G8a8KA*V$y{b7u8 z)pD2j6AZ3!U%UQc&oZU7KI3Cme|iN9UzuKAxw~?na?hi4U8~L*v3}mKeCy-K&HH6$ zb~h}!EIUQ~&xC{d>=&_CU4Qs(+!bsd8(9@x2^d(zwFl5dBv2~Jw4^hFl8y98%i@#aE!!5IH z_fwzr*s@c%qt*odXPCL|$Dgy?j$f~Np1;nM-){30?Q`?WXSfAKeO^52Mk`m|T070k zRVVH2mjtDVWijp+h~(hC%NzUWILEaYk1XEuDjQv%XytY@#aA>#sz~gzB6IST$x*W| zGn#GSY%y^yWncBPThq+%amviC6Z-0ImgUc|%bUE-Kg!ZSC1z{c)ni=>PdB%e-&MU3 zX?rQu_S;3@vgeat>>-Mc%|LRrM*7ET1@KO+{ zjg76n3ff~Ae>b-7vdm{W+mjY^Yon%1KHc+tQfTGw;+LtV|z-8^wXXp_>uQ*YKUlzaE?{Smj8?A`wknL3&N z4!9ax8|ra2;JR~YDELCxo3Rt)uYXtCt-b%=yLa#3J@}XVSMoo@>-7H&SL!`3{A7Q1 zU!&%c^CaURk3Svf{SqDd?Rsm~m-V@?cr8zJ8Evc%-MYlI?fQ?z_$f0A)2{wqoGzIz ztaG((L&m?Ick<57Qu{Ss+)43KYTl-RAB>{Bx6b^T5gMyw#Vv2NOWug#{fT4io~*j% zdU1tqwt4*41*;STehRQ|XzN`XTC$b*=7wDiLfWhLE!$Rqd!qM$hI7%||1;FG9WRr- zdTRQ^wLgz|U$y$RU9Rq-inoG!oc=F$G;4{O9lE-~Ca)OOZ7 z$j$VIao>+?0zBKxLsvfeQ&r_;bMsZ8_3`Urp_3=+r=R?}&WGi^ymF=Jj3XRfr*_I^ zKJkeSoi&Z?_MFb1g^ZuHcE8D6!d_>({%vvP?*9zi)pq||wwrU!{l@428D`~A@c-C( zaQ~a@ZkF56@K3N8NIyMad3}NR_KrUrPgnkDuzu%XRcduK=8JE>x#qSB7tOt5_%^?h zzxQTB&*bTioBrJ@xH);M%+}IhWv4Wz-LlAEr}ksQ2mMEqKk}ECSJ+uT^4I>h<+saP zx08Ce-oND9&6(D>;^O2tGu*CkmMmL)%Jte+KE69KChfd^eS7P=6}vvmJ^d6Sclk$Gan!9Cxo!U{ zyP2<;`u#L_n-+V)hHIzJG_~Ek6s>pdYgo6g{l3-Kb^DW_-tnKZQfPkS+x|DvE~n3$ zT#Hhl^LduFn*T2I@M(=#-&B1*asB&@HKE!cepxy0>3#P(FkfqvLH*WnFSDBdx98Tp zemeR3eaUdWsfI6h_47TbxxMpnS+r~X-0=J@w{!QoX-AtY?|gqEbI<$vCyy=_&tG#o zaQdamk{PKo*IcJgO1kpha;jgzTCWS1XY2g0))r~$ZO(l*NA2M3qYES1wYILf`1qFb z3-KRiQE8rcoD6@Rx^{a{#m{}KcGs`b$?NvC%DK4Cbp85=vliX_%_@BBzSdsHNhiP9 zPwe--le4vUe)hI=k1E!i&Y9J?+-dvm+QOEbTV_=!w7GNq4T`hc%)S5awiQdio$lxR zDZ4tiIrwP7o^9u%8X8xm?ft#J`Nuk+{@n{1_3nNW%3?9KyrZw)cXM&i#+_%Emmhsz z)!LD+eCopui`7hfmzm!^TyZ9s{YCkU_fz)$y_CA^{F<+|<-t~} zyLMY-e?3+_Mda*JuDLbd2XkNlXP8?*gMVU7UCMOpCqWzL$v@s~{rG*tC#MCiWm^B1 zIPLhgd{@rKbISKqUA~<&&#%1dzy9K}x@|{w&zH%|{8+WFh2LFr`~0koD%JQ?JMV=* zv3R-v*|mb(Kc-E8`}nzIsf)SwjvMbM7Qe~7t18ULEG@hb@tU88Z-!@Y@?2$=9J_hf>da-P=gN+8wf*DqQ#V&Vv3LJF?tOjp zZdd6EnnYJ@jvpe6zQ~Z?DvXgn=*fsN)tuj5C6+b~= z$@Kg5zTMj=&igW(T{->sD$me4U%0LWOWxE_nK-j&<~fm;2}K9@9Es^mHWW7(Uo*$M z{lj~C(_C$tT`PBcKl)Q#;XUh5ZYBS;O7UsFXQN*Kc`12(Q@OSj&n>^0wPh=hf3w!@ z{jDZn?D03w(?g@BB#Ue3H6z6}HD%}J-d#`6KHsHvdi|5#@v+A7>_40Bkv2yoZogc&^J4wd^<0ATE}x&ilj_c&@VJ(__0`q#J4dIk-m|G~;>F%yz_P=ZC=gxvbkxTr{3A`Ni%+Rzq=eYi<=Gk zuBL6eWj>{2V&21+*{s_x-ezB+bM=y^-n5smpX5r4%RKV^ZSjpK)_aHNpVPeeYZTs14J8yRWz8R;^zvWkwR9wneNuy=du+toEy}zjkf?89vv0$D8jb z-X5QzcQN{#y4BjNk38e%ifoDNTE8&s+JU_y=8tri1>ElsS7?8rZ2hbH{(Uof<#qp# zU$hm!!fSK>)Y7_{;l3|wLe+J@-<`a6WB<-IQ!DLK9@h#T6F#(d-~P+LH)dU8tLHVJ zANoL^-!A6NEUC=Qw`<fBw%fdyc>0$7ivj9dYNB`_E6Fnh<(byl-BN`KwP>pN%RF zr@5t;KYe;NW_G1sRzpMOz4$3lFT2O7|B%{dwxdvSA%FbxmU!top^w8Bc&u5|k+X)u z=H@z#0#g0J%-%Iw59e;GG7~P}%C_l!a!!y>q}H!3S0BqPwRmI}cq-bm)ALD@{bbGE zt{1LecKI-Q&5CI|u8YR}kgPa=U2fOUh@Xr0+vFXaf5qy^^tnG+`%df%{5bVLgU!dX zi|19E|Mmbn&t%_+VM+&+cvFl?Pf1+C!eUB_he2{A=mZr zmvi{nT=;qB^>S(Be97Xi7oR=UJ{MNKtZ=u;*U44)WADG5zq8Nm^xnFi?h>Rh9v8V| zpK(jL?3RgPN1y*R)HvZEm-1@fE$+uV-h99N{OVcrdi{sV?mza+o|tPBFDGA`x_rvh zovQgqrp4;M|8f1LSXAHT#O=OGIfmMstL|A9@#WdNy_>bmb;}f=Jt5sS%T{qOShsp} zz1+`5w=))bWvx!vy?SnU_O9yZlFji)Ccco}^ZLWvS4$PIU0mD0!Rgwc*TETWHyy*Z zOHY0?UCr#Kxpe*AO)CO6=akISOqM^BJtz6+j&sIVFI8r7sx@i8n540Mk*CVM9hY4$ z`^RL=s>)tx*b5pUjx7aW26@cz%fXQU3`cmDfA#&n`eF3r++{EJ^}d?7GWg=$Aox-xJ+1ocXZrpZsUBkH}Der3vDnI*c{m?!!uljVYwEfdN+_S^qNU2Q| zJT&d8cF&S`er5jhKUZ0AwVzS4{<`J4km#J}_Q9q7&vw0Dw(BM6K8eTRgWOH8#}|<7}zW~A##%2e}>cYO%MOM z|1rI>=hEtBAFi+D_;x)`KR4Q1eXISZOCk5NT8)2A+1z?-bE(q255n2zx4Dy;(t<~`@W8^1b0~KW1+~Lt@(Mb zY~>!|Qt7&KZs(S6b``lO`|qTk((PS8{g-~+@2mTMz1Sh+=`YG9c4)P)-*bDJ;1dm-7;ix=vagv4&rH_4Hl;!k=&V>~QNo8l|wb>m~2aDev0F z^(yD2*I#a*d1BMq$+dsu`{JCX?OQ*yhK7gEZn}4EwLI?vxl85?Bc*KP&gpGwtJ=Nl z&pz|amAflmEA3jCWujO!T{5+9W9g@g7n*a9KY2D~LWR`Y&24Az4L{gh%RVuDd^N)vQ|c^K+hFy?Qr3_UhgE@bK8{*RNi^ z8(Y6`-K+l$ThH-cD}1StN$71#)e*hTN=*5Jb9D6UCk=FhW$0} z)owGN&3bcn`?5&OD>=zscT>ApdfS}0iFz1&J}fb=GpW1%(xpDjW7A45cPBNSUn2eV za2Us$uOUMBJAQ_-_uSia_~CkqpHf#PYah-r6Yq+!p6|Ed)b`qt7WdYbf_d3zmb|%e z>Y45Ns26j0G3n>Ex;P%%EPCrmxx=+@*94zT;pV)#k>%suCx6aMeg3o0z3pku?u`jq z4??$8T-dZ*G0o;_4nvuV7px+{bYL*9b$nz4GPiAN?HK_gU(>pV?A*Jv_ofSK9Q$=?mr; z)A9{J=^1yOo^EYpYOb~{OSEg^lF4V&D>u~4wwTDSSaJX3oGIpII#24HoAq+T7BNd# z?Kmeq{q~7hMY$cphE+4ueIl&RbSOnV z>kR)&95bkNfGh=qtOt7c{@uHG|K7d(&rm&4P(YADN|14(pwucs!F4Tet6!~JwQAMs zSF2wwU?}oJg_3vUbC@OGkxas?ilTzug+*+ z)Cny36%}~g;?lWUg*gF{Uz%%nWE~Wpx2h@nqrBFEkF&4Os4;ykuN<{le~)q7p^x6| z#V@Z&hP_`kq2t3=CEc@?Q|8W+j5)sZb*%7q2iLb3R&-c|CGC#rdm(l2)*+iojfvJ~ z3iFKj%%Ax;rt+9R*FHj8e|dUUXI8?)xjH3wHL-O7}v?EG~0&G&o!A6K6} z)OI#nf6=bp%VgwF)x0xzxf`MXujN%_&~E46w(dV)#3%T%9-g{(v(@75-#9YVXTRUJ zJ7=ERq@`C*X{_0{QfuEyl|?fgc`~O?J5`mQqtYjG*W}Zxna6L;GY_;i-go2J?bqwC z=eS;%`83`2UEJdS@9Q@`6l&Y@dBx9D+k0y+Y-tJk<3CGFOjbBQ<>mD9jeJkFxAA+I zv~{XoDhp$B3)+27YuEN=p-Z31e^&JVH=8#ntvYtP?^I~icHT+< z88p5A$xU1DcVx!j{|ue{?8ZM{eAut}`S5ezWma`>D>ldw4Oh}#@92;`KMktJNf7;^POK;8Kj@`0bWI=7^=M`*?lEvD) zmpnZ+F|OvM^hYm|t^6;!Rz81vJ~DuFnduR`w7dNJwo+S6PTnegnI4*Zb-lCna__uV zx4vy`{T9x^Y;uwK3snUe$iIx0V!cA5b;W-rKe0Z$ulKoH{rHkt%lQu5zwdGtURoOc z#Kq*ScW1HWw&3VJFT#3rR$8uc2$?WHn^Q7-=ZzctyH_9FSN2->QpIlbGhg+e82>o_ zbK;XZ(U13^zIGz}x#ElSKU3e|+xPI9)xV3MYxwP!S@mtQeg4PmOV_#AbNv^USTAwn zfAspw&1`9@8ku6-_4&!s-pePQKG5ap>|!-(@4`RX>P8!CEBPyoAIr=sZuvXqoI!cY zKG&b2KMrqQXOgX+zByX$*sfmP6PJ%X`B?SiR#w%bPq!DIDOVB=F^!qD*=$qNwOfTr z3&fRLr`XAu&ke}BvwHr;pRIC+8d>R9E3RvNwP-QyQI(8dpoo@$2eF3_H)|wVONN$gRGSR~!-MlN}Y7lQ{KzN?K})Yk7HUdHMHZtDrS6 z!%B2QS~N4gn)Wzm1zgZg4E^fFU;=KdFt8RO?z2K1+tC@j{?)&4`X)c8f8p2u8t(Ye zuJFgh=YKW{+R5@>5N>FBDK~X@#H$UL*F3YB{XF`8#jCIrncKE|+zxe{zN9%K;>3#= zb3$Wp$Sv2MzwoiV`q%y8f98JapYfl;Gf-D%(!#iBGd`bhtf+VDjN)JF@~QuO{fG9Q zC95|7EuFY9qKa#CS*o_l&XAc=N~^z3Um5lIhIOXgq-~-spF~q-*dM>We(dA!iZ{Q` zy+7M}GVW^rldqkX_xeJ2m}fnj@ZR8bfB)r$ksF!WxeJOz<7VI6wLdJ*JB-(AQ*UUi zevb^#>1Nxz0nZ=5ua})X<&p^N>aZt_yAyTqG<|1aQO9xOYog!eXZx+nqD7PLU;iO4 z^6J_tulp;PMOpc4FS?f#DlTy~*Wl4c^Yo@ElNzI?EDP5^J8GG+{MN2pfA71NAG=t>r`se%$T=Xf*v%l>WZP+ht0ed@}j#<*Z}2tJ}}V>TWY}-R#!!Zuiuy z_w9FwTy(X)azE$a+tTZn=f4PYKeK-JpFu0+X1%LR)v=Q?pO?(}+PC{m#r7#yS7iN; zo!c#|IxVp5y~EeOy4~wGGG5JjE18>+eR_4-y|T-59elU6Zg+{ueS6owx8vuATU%OX z7m6-+oEWj%>PFd;>JHa7)s>5~PAP5PHtSCKgDDwVOG30GOs6IBRy+%3sFaS)HkVk} z(O9dhZEn%KT7XMX+T4;e=MdA%c=f-RZ^yGtj;X$W=k}hj{}~c0#4cY{v@Bmx^Yo?W zHCy!s#jI+P>$b>lpYpwuW7}WlkS7rUKm>UU;MvM1{jX@B!DrgJjQt1kVX zuleln{5f7PEgfH7soL+f>~!Y(o4=j5=C`F=^F1&5w>wpId(uz&^UgWXOT-U#y#Mpo zC~Bgt#ogVOk*oE7KQ>#_*6hZ6t?^n*cEn^c`I$Yd{7`R zUS`vW|CBo$;xcYdkgqH;wiH;q_wmi}$pMy{3gx}6hC0#yN|5V78CVbtkRUAE@bk0W zj4D!JLbWtk*p)EkFP6s!5=KsrhaD-La+TivO}W{p|a>|I}2o z_=|yZ8#jg9yi~VMUiVo}_bK02_TY`1*B$pvof5nIf^G8rb+6Yrltx>-MMp?|dUbdE z+%3-ogmV>hFN#T5m-|0Xvdb}BtLUELnsFf|OzYe>*_CpS1QR>6GG=Y+So3z-cF`ZI zQc^2Lxvuf1&S;Laoa!Lwc0KCsG3`YP@t$61&nageVQO(Zd(J7^pkY<`$^Q%`->x52 zxi0thyV-l&`WterTfTVs#lDcYtnw=D_k1C9&~sY$TK3$hw)dQL_j_EmG)Y==>+0aaV&)?Zk;=~ni)x(jQgAI>~? zc;{XFbvIpeZ|rmbeBrj`UDgkatp77u`%GKn?q{BNE-dTxz8_~-D=xU$T)Loiq0}{% zqwUXIQMn$4MRvCIx5OJTnk%X7{}JHO&v=#wja zULLZK6MekJE}vMyBoshuL3q_ar)pRKqk7YleAoE!wo69ydSpVBt$F+O=CT@>@4Aun za*BuN>Y7I@oUSZ*@^MoB8t>`Hdig(5FEQL+4%Y!+t9!Bwe)^@<|^OW z*3{c^bFR%bv8+=^SH4-jO1|1@mZj*wlW+c1uQgjH6vC-0yhZE&yxB^t_+4dh%$rrH zkmJ3GCF*E@V(Eo+v8|b#xw1Q3LZ+BaUUXS?!KzaIC*jxRCE~UJ+OS6z4R$p zPFkCMd@mojX7$Mh&8Iq~`>X1e*`A1&rcTew=oLE0^6cv_?w6AO| z{%+eUS+eS8=H-aO8P%zEXbx=Ki~6?*TgKBR~ z%h5K|-|klWrLtxFjiY8CKl^D|px4oKeO$XGf#9aPo}koO($QrVH1$eO}dn&&zIue$>U8`_$&_>Ym`Sp*7q2 zs2R_t9Bsy^gNkmCGOraZS?`?HZFOVU{eSv$rBjw#j51x^!yC*~k}D!ms~aZQeE|_DXQ7>95zj%QD}tD_&PP z+1+OC$EO#n(^m`q^!zE)(O>!E+s568EB()Oo-*BByk4M~b=%!E-ukdvkv%)A`0}~e zs@Lq@d@Lz3b>4c>@KZ02xt%nd^&|2`v`Vz+t~W!YT2Udbm^Dd3>Pa*mpxV_F*_l8=elfj^OHIfeBtsxY;r%w zq{}SV==8f_>G{htT;uNa&r+5fcCI)Pwe{+n>Dwn9Tq^&?PrajFbm}!7rYDiRYm2J4 zN6k?>@;tgV(&D3Ha7@d*y_}I5QB%J%unL`k-x$D$!%q9nI^1*kw)SV! zl{qHyY3nviTgyDt{U&XBS@Q1g{!6>UKZReGys2t;)$~~LI*ytj^*;h0)$OKX2ZLGT1bM~Xj(rf zO$$Aib>3yszWrw-_n0htw`jKJ`s=Z`H~Z%n&n@nmW%)F}U$6PLZN&6b{wJQeRG)X> z+Ivs>R9%W+;M&=9E1GBMZhLKz{cFpmGpUC!6j#J%T0ea|&sdmS=WE5Pec^6KW}aKF zA3EoBQ|XrP^)#jD4^vF;x(R*Q#H*@wZ`rI>3X6K>H%6BAm0V1j>RvlBytXvdRQR^V zecz3}k}Nyk8BaKJo9XV^;>ex*JQEHS?fB1d@Ns_EV~eMjE?#Agr~EIT+UfRY|BQ=g zThF>VU0t^}W$&IgUXA|@iwbR=f2>)zF+p7E?CsZ+@9w(tP)yzGj@HTJom{h?sC<3l zb=v95`V|Zs(;$r)1{ZL{M&Ri-N5-_NhspQrTc@2!*P|9pSWe(|mC{g<~`W_Lt~ zw4VKCwXgRRKj)53$Hdpi#=EBr*=}BP{m#}GeKUQIWG^V`i&9+N_`8{gi@4fWmZK#}YiQfAQX4g(%Stq<{U0L9l-N&be zuS>qUcS2-&)uCfYx89B2n!C=>#?&|M?3sl+bG$b{@$#vT`&aJdp0ILJ{L&j0em0*! zNq??)n>%MYL$B%LUb|qvc`uF5Nqk;)wtA;S-NXXX&W8^_SrqS&>ZlLeR#cs{u#Uvuo}9e>(`kQmufG?5ru5v>nRDPvUU*t%$ljne8z$+hy`E;_ zDR%Sb>iai~1K-TqzwW&8)KyW*CFL<&51qNb@%(|CXId`60wb)C4S!GVq&)+wX+$?v_ zSl1fh>K^%g`V;v>byXYllEQ-gy*~c=duja~{rMmEPg`$i6#nDqk5~KMZ{+DjtXduO zm0$Y{r<>@y%V%W?$v6{H8PKqq(NTl1q89lcH?Ttx77g$WLBUCEZ(e?(Nx> z%QF{zeZ?ET=t|1ubMr*!{M?%B82Zm(Ld+&wen*7fqDyVX2TTKi5L=FYC!#WUHn zCE4~_dVIDx-$5JGuHLJwbwi4GX<5Y=_40jNzdCPEVUM`z=TOP@8Q=O-`zHB!fBLRB zJvD5N>($zF*^>J$jL9X*S8s|4U!mo*o^18ks#dH2GnfY&+5PcoD17A!mI(xZ#k^F4M%C!dWT9#8?ZSJ{r_4oVt z#YKL+8UC`id3lM8)%|t0+*ZA(um0QiBJ23!lX2^eCviNrI-6boO6A_<(~r{P7E5|B z+g{w0JOAd7vc=P@j&DoVdNwuS;lmyOM56YxPR}kXTOzM7Wd{aZ|>#REl(4Z z`qa4GHg==0F$0(C1X6n+bZE}Pn%j)cf3;uuWk2QPyjClFL(P!=?2o5vc^@-t*X^J2 z)Ggp`S*XN`Yd_AJRT`Rn*G*EKvHWZ3m&MO|g^ra+$B4YRFsGwzF1xo|sr0OJmpJW+ zn=>nV1w}7h{i3AeTFY_u?$y{8&Lw*-FNhttUF{Vf8#+6xgqv&ku2q|qR;}K>YTdtg ztKU`0^?lW!|7W7Z{bj$DSAu%{a8bzAn~#6Kj&1$+!^>>7+wy~3rfiRUdues< zBEit88kIYLx^BOkZSi#5`FEG4_n&%i`Bbz#HhOcV_uZK4b3KyBJWl>{`*|Sw((@07 zMeBs~rX1bZ8nf@lUU{e1)Yb`whNd+SLubrLJM}QqytiIAM^)%Q1N)b}>7P2Uy|*{t zccb@S3xeUuTMPSq0OJX>q_F?_j`(_SL>_})$Z53nZ9QC^$li{ zDKSddf)uBiF8swBwXnKajR_OFyfCq5LgG5tJ;C1B<|LfCKV_YDS?ffDo%)U% zTQ`brDXhA2#%-SWhqLF`8ymg3p5ZN7!5nQcU1{Osyk(2sAHTSIeBnIBh-n{+CPul; zKdHg)5ig?`8-99Csh8;I8Ard_6(=WN`gyf&Y4_f+ljp7+J-hVKt~F(!a_(N)$oT8- z8?BRO*QMOH^jtl>eBJhovov#_=coilFZgq+X5*<}$1dLu{9||T+N-NwCR^s1Pq|T2 zC;al%=RRk@O8JhNtJAbM+)=91&f9rW==9z<)860GmknR_Zg%mnU1ya|H+#htg+I9Z z<><7Nr~ht#oT<6}@|Jk3uNK_L6#`%H*>g>9?G+WhjgvnFo_gx@swXV%rSF>++Z|1A z|GT`|XZPjTyU%{?-Z1N1%9`7o-kx6gy*pj7yRnU)JjL8~PuIs;A1vnVyEtq1 ztH-+gGmWmsEblFg_br|??cpbXv-;yT+n?t}>i_D$T_UG_R_hw?y^Ll3VH;hpC`H|f z*?Tc2F~+vobn$b({|x5xvwyXQo|=FD+_6JV3Rl;gwQ#xLUistJTQL{+hmF6TeST=zF@>V4&p&Slxx3Ae z<=s0kfzbtYRzH*3KSvAulj1qvb5tMjS6r$ITqF1S_LtV2dpQffuarJ_?!)1ze-qzV zF&TZlx~)*c&s$$=Q^V<#s&h@kzwIuG(mH!JtxRm!Qp0&U3$*$9riQ83U8|fCziv&2 z{&gRFW$6zaKP%2)m7kx(`lC^{^5?(Za{H&rG1RYF_3rrj19t1yyn46l$pq2${}$9A zY5ga+F8V)%d;To@4-)7Ck|`~l8nom8I{atoDy$56PEsWT7_VcTh*H>>IzLEF&`s@8>3l6R}{AH;=K~#2~_7`cF8lTCx z_Bv&X-MpQ9vS8cV3z5fu+_zGg)Sch*_IjiKs`7fb*lPZ@yW(^%`aQ@AFlp!7=RE0Jj!)`kry$KN z{`s$LzU|r)GAVazPuU@7Zj-Es;hHn=J#;G1F3z;HxMzDi?mTz;07f&ch z>igx)D%!36bN`d*8KD+pe&F+l{wmzx(__j}Z^{Eoxu;)g9%IX$=Jv(pj)d#u1 zTs;DxKHTzKJXW*iQqJ31XXhWYsyTW&UF%Wy^;7Cr3$DqPM*5rm`fOL&(KBJr#$S2q zvjTU{*IMUreC3q?4Ec8J%hs(tvwO}IlRm?#4^>v%6xD9I?K`1TZ1J-75o?|;l5f>M zXSP4N?0inu>lNp{w4W{e*VXqxCy?D}z^X#VC&Zfkb#xW3$0zwS?r*s+gQ zl5XqFcG~>#&wN`U)bFAEspONz=hQ5zn5+$#w{9-GD`^lq;gfZ~@{})v4-f92aYANM z)|#Dy2kwgY81m|N1)5))W3_!JpYQv!-Qn`{^+c_6CV#GbdHT1$_}X9G6K-C7`DfX4 z?`wbkHeQmln;UdBF0gC;#lP)BSGT3!^IqE$lDvlf#gd)S)5rAr>}S$25whxvZtbBd&jPyBH?8*Lcd_E7j@bm_T{X|eB9 zw%1*(c(pgY*U(a31)c9b&TA{v5v8HF|tA2@<&lvZ1)qnarW7Fvq zo+l!7u9?43-1c_HTI-bQQ>R=rU3S}~*Yi@2bnY(QFZXk|sBZM|H(YtAY`Zy=cUYa( ztqo#A5|_Ddqom-~8Tcf|B_ z0e8hdX&=iz@TlmwTUP$+o^5}ZoDMCTXL_^N^juMN`$?Od{~2UI-JiQNW&bPt+zS=! zO;$&kS1y`m8+BATpffwM=(}rSYr)qu*ZSvJ|G86_|4KAmtKQyPnv1VFY|kwLP5Hd# zkF&Q#3d*;!zTaS|$2X;6g8pZ`ExL|r-78626_vSZ*6O)aDhoIM{m(FE-hYO)cT<0VT(>*X z=T5X|DS>2XCIc{;)6&ya@%cmQjEjnAt%Q4fat9{+N59=4#GM=?reYmQ8 z(QcV3E#`VpOvA5RpIH;){PLy5uRnRghp*=*E)I@za&;*UkNwZ!byhTHjIt|1Zct{Np#P{|v7r&K2(4|DPdv zanbqyh)t8Sc1w!orbz6({OQi-s=MO8F`3_!^EZ~gez8dF<@fA$_p@f@_V1QBfBAKf zY;1kcyvcscYvz0^)e6n}o185^F{9}7{S8VIF4=}!(|uo0oaO1U>>%6A-Sr*MbY?ug zb?e>Zw6)U8n`Zj5e7%0+^3t2%k^>_qS+ZX<4d8Ds-dV9z_H5zIYSse>PH?ea(7F=m zqg*P>^w(xabDW*$<2s&4o9e3fygOl{xTjzAn5MSiM^(ezd--OOGd5^Vci1hhynlV@ z&(x30`9Isw+iQC@PpoQ<`Krt<)$MFgbhG^P_BFq_9l!d*H;=BX>61SnU3=+r8OOKa zjc4CzIq#aV_R!vfNq%o4JWs3Mc@;jpUa3Pa=A~d`HLp4Idk@sgzD)M-{(1TA)rh)C+gWAj0g}_ao=WV} z*jFpNhehn%)V{voVNLHt{)yyISa-r9xxrcTy7yWD=^)6(W zf8`hFvok)POIBMm>6`Ve{|s|>hnV?$y!gK6q0|YxtVeo^f2ZCtmR#Agy}h&OTd@2R zo4ytE*1X=IT(bY;r!`rBcg+b&;d0t{w%35!Dj-n4W9ruu^U_UyuPt8|ToUW~&oFsS z&#|i$oge#{?|zxERPusw*U{P=f3HvVUB!@Yam;wmbBSYyU(Xf)-q@4;3v~R&(H_Cw zt5)ycwQAM7cmGzc+F!l<-_@W3-muT@+xN_Wee&J$h|l4L%f3nOV=QoMzaDvI%A{zo z*15;z>*h}Cmpi^G+2ri0iABA${laBVAGD|zS34?cd(Yj*k$0u))e9@$tv`6uZOZiU zM|XY&Nf~DZ)}8TdG0b;%dz>P^SGRjby$ z`!$KdOhPxoCz->6fekFh;I^itW8Dh3Rqx)tTD9(7aYE*Qh6%MlAJ4A|)4BGaL9zT+ zcz)|L@7L_PM~lCmNx7Qkm@21sT6k);PYCZk!#UgEd|!3&ly$q8UghS{xrc4)uKTRX zV=P?TwM$IrnhSTr#ZJ~qx0sF^tys10V7Fq@sr{afoV+*g#$Mrx)>xayv(Pv)LSQPl zSQrn}#@(w7tTr0%zoHtZ8d_S)lJTeG&$f#Fj~?wN%gdLUl(awf*j6-8uz1<77Y}W+zv-^q^=g^fF~gqJ`dv+(D!Vpln{l(f zo3V@eU&Peds;={g{%+%4xKQh>czsl0#$x>n!{%&5u4vXWUd3I(+$VDuN65Qmt&cRx zIuNsZSHktxZFQRV-S<7p|G7SUXTN>XT3Pn3U$WL4Ew_xGAu$R_&V*_rEEosZ~h@$?q~d1DZB5i`Q-knn%O`3k4>wH%f9^XnsOVvD{NAOZ7cXv#uA8LKzftTkhnc^0#%cc( z`MqYpjo0TLZ{8Ca`YGJH(%f#5`G1C>vefANdjns19{aU>@7I0H_3o+%*RPmSy1D)1 z7Olf`zc)NLanlQ27rg3?g!|DAuKri`9_J~9D}G$3K3m#m`_}VjojUhUJfbyGL&3Rt`9{+aYArf*)% zdN0nkMUwVFe@B3+e>5pxtk51+ay}mjxY~J&? z&l2ZY-<@6UEs^!M>vf6OmR-AY=ccH^%^@+|8Mc0I+lbg8Ai zw7d1H6BXM}#)ei*i`*T$*XUEHxb?4)%_>vl-k#Aj-n`*Q^_N3GlAeY2#?|i5Uw1O~ zu*%hArnjZj>-8TjdRz9ozRx!FNP5cs6W4xRFIaOUQ}>?!rne7neD&IVT)0qh*1L5# zvrbo@YM#0Gmdd1zB&XEhd(uniuK!Z-MP{D=#9*e&n;#!p{7q-g#m&~yNAy~zg+5vS z>*tztYMhr=&it}!iqn-@%TG`J*#F~a;Lm5z|2BFj1Z>tmP+9#pH}%%zbvBbIJImr^ouUnpfcg(Q=<+<)Pu_rJWb+6r*DTzgEPCDpsE9`lklQV7o zeoNgiw?l$h?xflP;6TklHN?$$8v>V56=S*9vFl%?#GJE}Ki+TIIig(&H z?C<Xk<^rD7g-nH)ahJmM#`=#kz`lc;&_3Oc@4p*&%_dW?-nC-Ft0NbR77iS$x%x{|j=3pVsI7DEz|SUlF@|Z_(-X3Gc-H;$M855HRJRac=LM9j(>YWlyej zEfLO+xyq-u<>{3pvv%2f1sm#4xOw|a-F69vo4K(mVWA7clh=n`w?1*Uzivt5>Dr&M zm#(b&Q`8OW?9FA*$?yHA>aSYdd17bw zbny@KEK2(~96zi!xoxY}9og3H3#wC}Wq;ndiSv3^iF@cy>#o_4t+RQf%I^E*>=U|f zvRbJ!uKLj&wb{FlpRDQbPghHd6QAGp=;oi`xWnmRmK(`VSID|>T68I&l9AN!wceNR znfLtUH)#0w^09^P(N;6F(B%`JXjshI*}QJe7TI^n#X1~O*A*OH)JsCE<_r9MCw)rJ z{&V;oh1nTb=gU0$^RMr@)XQbFt!8(w+j#Ay+Wx06=IyqgzTv&5#z+6nF{@raI+feM zJ7>o2C*Low`7{0F`#1cK7G-xA->W?M{@v=xl6}(4p1n2YdbHiG|EmAG-E}3s`;tT_ zS*g!I6X^Q&qD^|uW46yGW!D@Rhrfwg@U{Eei`{7-SDoCE^>+1?uaUc_onE@_rC!sE z_ls7nnRi=lQT6M6vvb$oIG4r!`Rc{0`KOlWJ-g37Pq?IaUT}16_R8wht2bQrl&d`W zvVh;DG;meivKtw@Q_?O^I;W?fEoI@AdSy$f9p|pfLRHm{e>L5o>zw}XaM0LkKl##j~3>+4485Qsrj^ zUoX4s@?}czlR)7~-#EjxSI++)?5bX+woyxG-u~(BAMyik`d)Re723nO=AYH4`8prP zXa4xlFm1<~vWS3+zphjBY!98-=H+!zeeRUnq;2QkTvZ8-JD9V4aR$A$&@y4|O2rf)y57_unn)knQI<=tOb9uC)^ygo#`@YkDnp0^Co z%=bQR8?LLUU10dB%-Uv+X_b*%;QHNX-}vqQ&+uYN?%CP)@<$(AMP7Ur$FuXtmz|Y= zY8Rbz?E2GiIwV)@<&w}1uh#78Q@3kE6{lyUeFAT@|a`R+T>e zilUY4q|8 zTrHfXFJ86WY{d=z^3H8jZ_SM}t&BX`zB5>3b6Wdl`7^F8*Gk^rZY}d&&GF5{qF(7| z*_#NnqK}6-G@sTgbLsw5OS$J9`^hdz>tgS&9;4?GdT&Mc83f$%Ett6T*7W6{JS6rX zcVAfUck7n>1O|0B@55JThi(b7{CUYI}*%p_&r{vhB38A@{`mW{n z*!;de`9k1?^C>}7WsARFmpo^@uDB=t?d_M}v%em{{&N1Z;{J8^i|u`$%g4VsSNQv^ z{KD$%({KHiWPO^wmV4cYzSFe}{Y(9*eHmwQwiIE?ges2t0(=f)L%_Z6;s#LNA(s#as_-DR^fcZIg~UMXBum9g&j>vcPh=6w6MKYacA z)au$PvA6bk?~m>MYt(({)u}Z(8EvoDy=Y5({kQJC{R{p0_WsLudum?nFL=F6UwYBH zSFiW2TkpAled|Z=e}eIv^;0YO|1;#+qw!PqU;F)utZ()|Apb1?dHmly{b>AY9zM~3 zYxFzfKXm={{5RQaRRf28Ud{xcZYTm5Hv_XJbK<-^DKQ}6foJABEy zuk>i&-Ov4AFRzR9NnX{s8aFe3!lsCOrfH8H%K|p;+Ig{3ymMp5%j++t9=b~}xSML? zof~}rrNXjBMfdynvliT*QttMsPWh9%+>3x;7G7%KPuJW$w)5*LUGvOT_RQl^S|K|+ zw?$dG=T0nKoPIKEQ{<_vXi9*?-=KCWlSk;Q83<-+zX!)9&w=`1M>k zFUa`gw9?4kQ=K3GJ~*W|thV6&-iv>~S8V(JpTYLj1&!mMxvWJmUw^&r)~Op+CG+0? z+x0yDZ2Rr}``c#xs+_YdyvY0bp){$qdG%8sSGX#jYP+}gw}|vr_wo?&nuK@u*1Hxg z*!1`H%2$Q@VY)g`<4!qQ#6<6$TzTKyyW-B;%RRG8vh^cBF-|mhC^@|Cf>vjXa?$D^ z(SM%Kx2v)G`OEcBQsFhf-^La1FW)>iK^+~hFV zQpec4_wW476V!DVZ7E@0A3XVIwbQTFvcG$_yvE?mg(Qmn`R~6oRpVqwWXy&cTqoEbwu4UWGdc}VF z@=Wpy)1}=14B3HI&3@&VXPR9+({-gcS!&&Pe^vQ2w|h(DUWHA~zTA`7^8N8K-TT`a z%vY;S>yg;DwZ~!Jl80yaXR$a-&+89dqJ4VJ&AR<*v696vKS}+u-OXZxzvo`Pd-jr0$_H9Mv9;xTA*BQ@Ak9jU}{`U6E@2PmG+rmY}%Dw*=sxZbGI!#VfJ**l^(y!Yuhx}O}%J2wJPnnWOS&sPQS&%(|4*C z1>`-Nr|cGQ{PoMy%xo6MX}&BMR`#lGdNp;f<71yIpOggrV!kCrnOIzFX}xH>L@viOb{>SD|Zr4w8mz!5F{`B3+ z11s(7-{f1GhCRI+e07s-rN`E#GyP7ux~>!!dA8d)YEsAPXx-$}=NoxDJzDOZ{dXnG zNy{ksjP`SX=a2sx!av%Tzo_FZO09je*N;(J*6Q3zabJUv(_ZUbyd1vq{DoX)VSQnx zt4~7CxOAso5-jSOyRo9ld*QwvXWhOuJN)gP|HVqyrn;A5%`ZcKzKYq}Kj)VGrS%hfbOc|!TTWhaJK6s3*O%Wq z^*3F-)Vpz4Z%p>0`O}u|xM{m7!pPLSYDQbH)SS)1Out`TJGjws-@5gSq<8(=wSWKW z)zjCuP19Yi&8Bg*TkG{k11$xuck6Zwt=jc&-M)RV!mRCESD*QLuJ~`^e})-rYK#9$ zd}C#Q+5b1<*U!(Ezmoqm#1+r~YkBg|Kkx9F{}~QBeir>#A;SNyTIUJ3ifVHGq^r;B zKTN1OT0f7K`R}~rpQ84h|0l#hWBum?3+gxDOjl5HI6nD51OIjAPwq9(|240z&VO=$ z)%njeRhK5M_`CYbg>7-^1~0?9HyrTP9FE}C=Y&X`_Y(Ota%_OEYwm#=e9 zKF647*|v2_-&@aZLWfta63Xq}uy5766Mxv&z2E)9ZTE|;RU3nj_LTAlM`^Rk-=D~| z=52EA{R^!dr-#Odr-lE%dxwGR>7-e9oc^NyNAG@G$@iau>))!&&&rGqch|*rE}iz; z`KMj@+uQG>xpMzD`aHC~9Eh-!mTW+%3FI z-{6^@;UT+QyI1e}8n^VdL+F=~$TMDTuU@rBxIgy(cXK=6e}=avi|f~(J6DzyrCVBM zTNie-bdy7f)&}3QYV))$KJMYKKfKv`Kjd4vwz1CBB_-9d<@bHf3f`X5Os@TU-TH6Y zG2^ROe;l$}Zt!}(@}9V(r>tzbmxtf{DKuT^Q~A6Y?du+8lU987+xIf#xKZg&Ni`1- zm7BNSwTwb*WtKHBdz~{+IMR082TT2{yBk*h-tcsmd+7HB)dQawsf5NSsl+c^_iMHO zs(sHdeE9Bs?9ZxGe=>fEFvR{1obhMzV>Jic{|tc~b-ShBy{Hep9$)nNKSTS@*YpD%U(IK{ zju)E8^8A~=TR{i+V>^dqf_K%j*B8H7T^u<*>@{C+lFYUH5dkxue9yg;e$~txne{ez zx_ii_+gdMs*Ra)2Kk=U--2UvQ{Q>fZCx002JMin;>HR|M7rpAp`?dR3NB*~6?;q6Z z|Ee=TptIkbz2(u`#(Foih^cpH+<&!NS@_+%-J2Hu`&xXp=I4}T^`anuspH2Da&{j- zf8WA$v6`>6`lfTS)+LWiF67+YWtF$;^_pd!D)VONExYx4U2(5S*TZ<(c?aIl`F-bW zL>=Rcea{a@dKXv8mo2)x@R!{c+1Z{RdjIzSysE7;*F9Q@rT8byA~@{au>O);Ge&aPmSc2*ywF}%)De* z)N_kt#gj~`e2du6-V^=0d}Xb%sBqewGJEr{dJ|u0Mw;CA%{V)|is#E}IsU-Nf3uZN z&$u8^yjE^?eEMRKm&boh-08c$GH-jt(eWapT6{4~<)wh}TJr?e*M#=zDkhYoSX)pWbU- z55F3!dPnE&XT6O5UfcgOhzrh)t=$%$rn4&Qm^xoy@i*hPGu0x7t9U0JQ+N5r7ccwq z&a{2j_p8|Z^B-uo#+hjxQ=ZBB_2P`xA1^I9{~~hM#8+RIoOEEVGnZfY{Yl&>!DYGX z*@cbK?9N{-d+QDsa?C!S?eVp*jbppRt~s}sNrp&?eky##7O!k4_wJruc~$LM@z(+c zznt#QGzs(6&{hpP&t0^3y}m&AF)p9*YqJ_su2t!~uMI61*}YbJ-Q+n+%XYuw7Y|F# zaW>w!?%FB2KVAn~8d|#z40kD-Zg6b~t?lfM|2A(~tlsg3R-30XPdJ!#>WD{8+kb{6 zrq#ki>yEUnI@0zgZ{515Y4!Zm51e=U(NKMV7k~QOuY5}{?G7m|n|FzQ`u5F=j%%-I zO*ZcFbGP`e`nsqqduwHL)G3XZlZMPIFrXXi!+ zC@C>*S$*n7R@>^`X3|oJ_MNzOO!j`N!D6G$)0!gg$}OKZeWvI{!zJ9IqIdsY;q(e( z4h_)`;JF+?k)-qb;xly&PG762o>o7%ZD-kS?tk&mmwtbodsS!EyHzJV+}6EX(|zpys{ahu zuh#uqzi-w1-@eM>sG&7_e<*Usb7Cr?caO~8`MH~h_; zGxcn$OYPGV|1-RZ``4{sulzNBap_O_nZHW+osBV#tv~tv2-B+~Q$~S1tVXpUJC){&u}TQMGFK{wwy+ zW3L?lxVAof_SyS?cbeY+YI?&r?GL~GpUX8(^*w&P{~6MD8J^!S$zK29ulIpHY%9;~ zPFH@hts_3cY46On7p+{)?%E5TU9R@J@ZH>#hp#_NQHe0k`FprbPsS=|lE-rA^>;3$X_w2s=w(5QAQ=5%f-u`Fk(C4_l_={DqY~>Wm@G7Q!u`ai>hGI*a zd_@ZGntPdC%@w#?QW|cRvu?)CkJ0Ppe>(4byFS(xHZ@=f|Q z@3+dXa{=deKlk0ZQR=VSPUdItxqe-~vTtTr=jJkN`PsjwdwdaDGb?x5mb9~b*{VYO z*;lOj&)_>T^-Knb<+c9M^_wp)DS7kYZp3oacvGFw6a%G1YJ^e=E-jo|*c-p%danbY|zn@#hsA5V$4O4r<2@mV5NqJ8G` z$XBTsIVx1PKHIwFR@3dYq_z&_;LUHvr|gM;GGF@oyTX4yk45r4S+C`;w+cOb)Lehw zv&TuZ1Iu@vwwyU-()6l5QBrpCqA$w&C$9^CeCN%n?b6cn`vlCkG`&BZbbY1SkGPL{ zf0LrT;$ojhz52Ck$?n#<`%=$}zYP1&@aU1T_WEt7-W;9k9dYF0#dCGX3U2l%wV66@ zia7FO-hT%Dz8~+r<7MCPWj?H}|o?#le0dh74{b(!n#&*)mM+*`c0@ZHJR-=CKX-}e37Yj)MwbjOxG zvn@PUTFw-`oGmXX_s#eB)UsnM&C?EUT6b4(+0DPVmUVIFE&HARJvp{`&VL5Sp!bKW z!wPE_)lB}~`ByI%TSD$j2D+5Yeiih_{C@8D6rAvOuEAU^p$N9%|+mCU&cD4V$U65_txc+K=&!P1TwAVXN z%#WAlF%$jIaMdpTV|OrTldL#*^OHG;UpVX!-o>KBH~sFaJFC;3O3U*E7-L!n;gk!? z=CChImPj5sZa;NGtl1i6NvjDpPh2*tu&>vX}m%r~n z-F|BSN!?S{##g8J^x9QE7a&yTA2M)bGiQFC?uo`tD{|w>x}wX6U2&KHkSY@6F0|b344)0{(e{@dl`h_gxE$7-__AShPGik%M zj-?NmM_rlV*{VE0>yhmv4iB?bRp!WhSH%~fHN6=&tu{_|-HP3pU+alD{EVMe#3#7% zk)3*spS{(h;B7U>Gn1YanQ-LIE7*N)ph z;k)12`Hw6PPd>jeOhwf@U-`uI(+mDH1hmd_I(~AIvxc6XiI(8UsDPdOSN+|3w8E`d zHF@&q^IC5=Y?S$ArWWbD{T|oS{Q1wX#r-_HII_MbsI!2H>~tS49dqQfixdd__NNVr@vb?1%g*I#_PTEENBYRZoI-2Bg9 z?|z;2(9+cGeeUL;=gY3YTxVt@yUZYSujEe~mlC5>CvP!G=0;=`#_o2|oc?S<;fz)P z84fRewS>oYnpml;w^3Hpe}==sKDIeUQ{zts&yx4eIuLR1)D72^@Z|W17I)hIb?z#k zJ!d!P-HS^PevUKbm|R-C-fE@pl;u^ye>8Sgz3$fc+P0K$&g*G2@9M4&(ekzpy&CdF z=zap9@&&zuJ&!s|Uxc}PZd@OjRi@qZ`sntnCbOKcEt2y&X%Sqzxwqt^SkAQI+->Jf zuS-3*JZF%0acRVqx9{|$KBirHoFBhZ>rYzSG}h}kCZ_0eSg&4hV*5((Xlu}yrMn^| zg;Wk-xuPOsUVk?IiDn1)s$GlzGk8S#Wc}OQ!20{jn)uH9yT8gm%K2&he&f5kU+%p% zm(SWXOKkRe`>Xt$x6B;Xu1xl>*V}?aD^}~KFWP#O|KHLnx9ieot?JwTHu2oUdU1+Q;c~3GdMk*_a^(V=n~iuK#k`;{4rpI-;-Y9*RG!Hz|Mbe0F=_op^!Ad!<+IN$cBRwLW-p z$kUvtP5$xg>~`-7vv<4o-12%%YD{|W*6WhzOg^dA%Rk)Vn!~*OPxj-Oe8p`mGG~RJ zu}%NX7xyP`x9m(i$5Z)BdE@7mD<-f%S*R&zhwHiF8b;BmlOWxMP)7PEqecH>tDaHhAAa}%O0Y@EBN7-%W(pO|0PKe1-2=;L2nA3w)j+w;{i&b~Y1jOV`d ziOI5@_jgZvI=glsAKJUKAS5N4yYwLIZ9?g2up z)xa=k*5^AGf8Hl-`CuYCrPF!l=XD$IuP(`Y{5CxF>D8}BdrkK1v^nm75o3I}w|<57 znlI^DJ1b6xELm}(YWu}&t1T{Cy(|2g{_n>hzu4(3j#?MJ?ym8#Je{Y^_i@#JkL!0I zuUFSNb?H8ra?gu>FHGj{IpVQk(f%TRjU3}m6~}J;ir9bU?;-s&|1#d+YoDFBc*j1) z<5lLt6=!AZzQ!$gTY2in)|7esV`|GQ*3|WGJy*PL$Eh9XZfCDEo)hl;pl@a6r|`pX zU*Gz+<5{_WX!Y~uxBp66Z*g_iE?v1x zFZG_vg_pYRs~=rs19se!S&7w`w8R^-uA$7VZ~%%%D@H_EL}C{KTn!$4~C4 zII?k?*;4uPR(Z+!h60x>-?^(x_!|9{{2||)6@RKS%%ZNv_`1e9er2h1uO^?)-o^ak zZCJ;)#c741o3=0A)s*?=N%yx-)atEYs8bPhJ0N znY(EBigjy0ZNLB1YQ>_itogTlzu(VE&$*`jG31`w@|y7H`$aFyJQiPH`CGWF(Bhj_ z?)-CcOlAk}o%(q!__Flc-66Uifzei{GT--P{f;%iZV@bTe&)%fyf5ahXA`UJyf=6J zxM1|A!{KM0+m2Gx@c1=itDnwX?eP4AuJdf$T{9w$tG0iX3hJ%+X&d4=y(R4ZguO1} zPmX-7*x&UcIK=jH{ENr^W>Ho~j#-zse2tp#bLaix)rXht5IURGx9c7)%_rLcvQOF65`a9#;{?K|u->t`9<$s;6-1d2ui@x#mD{+O< zIkT<4GR==#>S*E}lQlb|YKyjp#TDV}G09RdCYx!zTxZymEOGspL9z0SpJ%(CSk4R1 zvRQ36_t)%MeXBZ*Zuft5Sdq1AZRN|vtD)g9|1LlG;YC@VKGT-#QLnZ7(_ejhpWQZh z!&^#Dm6s^kPJb!5uC0Oj)VwK(2Hcwe439z|PS@CH`gH%Kd-hzf!q@ys{w22b z_EYJjiN30;6+JCq*sNmGpDEADpYg5lp|;VboAuEW3QgZ>7hY_*cTbB8NIW!q-lCtM=$l_BQ*^<)_^{Uu}v`4i$_J6%39Qxtv>g za_!Wpr?1v0FO5-L{HD~pL}Y8)+4yNWvrp{Y!Ff&lnD>zrTf?PQ9!_ay*OS`mUR%7X zWA(n7$1khM)>J5`{5bKZNM7{sv?$N}ESt~WTKAtpvbOKY%gfWu^lB9z-ko;)$!yiu zcfXaUM?79PebTh0M|VcMo5y9Xd;f59aMhb;v1x_(z3v~rU+RD7{e*(MwY;y(bbju0 zJ@z#|?ycmGbLO)izdp9Ib^4RKYxmk7IRD)J^`2fp{c1Ie2m9Y1TVG{EL2R=UV?zcGIf4_a}eVdcAAzrzLB)d=U!c z`ut}3<{ej6Ukgo`{6;ulGqd+v_td1x2x1BoE z!Fugj)KRm;Tbd;vgiee)x{g(Mt-$*u5f{!iBwh`aP<09~*|2ccG?7EO48cB(DW{~C z30?CsUDLl_n|1Om2lFxo-_+jFnXxbLpHN?^WCLm^|C$t^cJsXSld{t;!tP!#x`M9j zY`ACC&HDZQoaE2ydHN3?3163w-FEk#;kuo-U-lefKj3bZ`q01goc+z}XwTz!t8eeE zW8M}YmT*`o?6>dZD|gxU`#;UpyLq~;OY_^c)K%9c|E$+t5{wCSO?8*ZN4eX9TD z`u4PaZkwOpwkuTrZrYNn^!sXfn%4J8h}{CoR# zmZQqQKeoqqp0gA_Sro%AyrgDRQO$n_37OXTOaB>~Kc3xJJpX%q>7PjtD%SbUh*fB2&m+b`kaNw=;>M$I@Hx#mjQW`)hcYzMow zrPr%&$UAcAx3KgstzG+;=>KO>Z+@8nNB&Rye}-LumH#uyNVh-X?~@n)A$#Am@`)Tb z^WpEWcZHg~$bDTVeP&K>^AEu#pGv113TABacXiR1UpgzFYe!SM#3TQ&vz~>9-^@6z zyS+rLTY~8Uvmr0n78{lh*OQysqGC)-eL^>8TSs1GopoT{o`$>?rj0*-Hpn-2GoQ)W zBO!i6;(Pd`UR}E6$E>G3vXR3dc)``yFTyiv@@zarsWp~3) zt(H%F_0fOw#auK0+?ywlei17Qd{=tx=1uk<*==PveX=%}UJCauzn0Y)wQ8dGl2EnD zj-E@y*G=_)HQjr`tEQ$^do-#(zS>juYU#1V#%eQXZa8-%$7qw0(QYLp>)lF5+M70k zkNe*D{Cr1OBCD_@yGZ-Xq=$=Vy1H%sb9MS(V~%Ghjnmqn?+i@muJbMl_Wv9n89L>6 z-Pe%&HE*|Nul})Yx6gj-AIrCWlImJ#T>tfc!jrn(mF^qQl}(uPPbhNIwg~0h%FA|Z zZJSge^8G^hi+MZG-8%hZTHTKDx3`YF2GzxE|F=4S&i*!ej?Gsqv#!g|*AvFQ z)sxjk@5&1|9zFM`WsB_ni8?>*^d~R-7UJ{i!=go2J8jC6uTG&6eqr5@jTJ=RD7Oa_+&`ySuXvuAY8=&i0g(lS}9B zsd$@mduztkUDY}dPfzF0UF4zA6qUE?wD!K0%jWIQ-v^$1i{7?5ZS9=4ZT!2#dZkOY ztZS+5PuzP(d*2H86CLZ`uUhr@->SsJ6AYgoZg8Se&+PaaMYox4xM9^_bki%OD)iZ|x2<weXi@jqIB>}(C^$Nvn^{B={=I&WHjx9Tsy7-M|S+|7B# z?P+nhFV0ijX4tdCS?uOYx1P}3ujk)98@asa@5)yh{3Z+Rex`gst9;w+n)dsTzaM5+ z{2C05Po+3{VRq&)5>&dnCx6u)kR zrp%(qf^0M1wtMw{vU!2L-9`m_f=bz$Ctm&KVe-0M{q*OkNhL0GZvUt`FZ26j&bigw z;&-R{Jg$qZP<Lvad(6OP)tRlibUfphXZ@`*%i0*NLqbwYye(V4 zT$!|X=H8mc5i_>0+S;4+&-dO6_l+e_C3gLBtXtjvq+X!*QSiLeFB7-@+O|I8^L6gb z=t%cX;WzCaS6vc+yJFF4YwM{6+ihx7<|Z$e6%9P(JNekG{HZ0EYY+ca`*GvZe+D&~ z)pI`2+rLRe|Af`s?5!7MPPtfYzA}AlxRj^cd*%z7z3Hpg<&|*D_-uZ$+ctOVs`Uzg zSItVC+hkp9cE5gZ#E*A<+sp1bzjz;85;5QTOTVqNy8QE3qW-h~GYH2eKHOYwc5(La z{|uIo^z&`w^6NU@PU3ky<5vD(zdw&w${bu=6=Zs};Nj^x&nMdSdP#|i$s1mK2CSSFx^_<4p6Cs0;@;edU*LGeLHT^! zw(DXp$*(s)E?QCi_Lidm#U(2?FPNNKCiD5R{F!q#r5}Gk$v5*f%#}@ky2oy^aB0p( z8@0Z@OkU>RtbhHN-`!SzH+ssRTV2}QZs)A~o$B-a=Y5|%)mzg;UwnBTZ@1Uc{g!6< ztS499?nX~@=SzD2I!xoap>V+`j&zGZ*Mb7q-Pv3;&+NLj%C;ZJZasfFr>LMxW?lbd zsh_&hLX*}7yB&Xd{-Nu<*Vz)sm8R8&X6(w;n^qT^{a5vFxy?I6@uR5+=Nr#ZJ+7`b zaY5dcS2hcnwqISo=vlU)t`vG9u^wB1M@KM;vbNmTg{fKSAl~)5nRqIT9W_bN78= z2)k~2H0_ymgo{tIL|AUN->X~Sx2(JIS5ND6-E_gdZ{GGL&b=9Xh(R`hp`oMe07FLD zQr4+!IU}wz6|X+AH}Z-5PSJ%4RY;JGBVhff5~75-eaWO3}yw5K+?>&iTHKlW}tf7#;ld#eieDL;2<&%CPe zzP5hR=Y2f41^*R3s|~7KXzu&K(DU%h_>^<~OY^#eHr%}L;$%6oqj7tgHGAN`1Fok} zA3JpGhQY+5+qEy)!^;+DuKUAzs4MsSo71QBb=s2am))KG>06k4Z1twTvkRIdUSIZo zd3V-P_cCwp(uTYDU#?YJaD}<_yVo_2b5>WwUtNvd9M+Kjc=_Sbi0bB(o93;V{NYc2 z$&wRQ+r;K>{S@DA9Orm;p5ErgVgBEX{$A2CZ_HF(lQNmJ=X&_`OUFChd!PMhNcnd% zJbdQ*`)h95e)oSA_Tf11I6T{jKYb*X^o3sCxO$o>St}eQwS^95y#9bla7xD>|EJu-!^yW$RvZ+q(GieZj){ zV%OHK*?IrNq`McZo^HMG^6u{CB`3FU{QB?VMHQoEvA6ZVxxGo2%5Sl^O#2`@gJXwR zYmlw);?)I)z1yQh(~sX+?$3H^-=DINmfQ033fCRj=l11OO}$LT>20iqd;DToKY8!h z^ym1e8ymX{7fQ+0l$d=xbLY8K+Ojb4XOb>xh?x@*0rXkz0eNA-zCy3;R9&n)48r}|sy#oOWP#Mek+Uo`Teq5K<+I9Qgs#EEyBKLE@ohyFM@b)eY z{QF-1y}bVY?umj6r3674kS?$>*RCTiSTcIkNJwYXKwm6nxU zpY3^TNzP=^v(KWE)$UgWKi+r#WG(BxeGay%$*W8HOR7@Y421PoR!k~9Q}grK!wsjS zj+N6L%$j)i$LDa_0Y?fglasnvx2@1S8nw0X=jN0{ zzVf@jJc+Y8K3_l}F|Oxl$+i4C9i20V(-WVF_ZY&PT-_%%>oa>*dhKHHQ-+J}x)xTG-o}X@MXiW690MZYP%9-NmUkN%O_L zS+Dz7Fd8WtDH|ypX)7u1R#MV_)6w;NH>fYTd-v{r@85+fDJU^0F)%wZm^vvb$8vOB z4dv(!1%uMiD-0YbQD!6&18$=%2A9z=7!8BLw`+4W!;a=lw0vpj^XE=(8duhFgU4YL zMSskc+!-GIpW&HVUsu}Z=jY6RJ(u_$nA5Z>{rltZ*^^l7Y^ttLsLRq6pYIyCYqPzl zWqQ)2_QI#)#^y8ZBA->|>}fv#z&7ahvHO`(%`au8>iC3(uGMYKZ{Kxz&%ApF zdHL~FrsC1da%Z(2g7w8h-`uPVzgJ>=eY&Oq!^WvmC7o-e5+t1_UCe8^RPj0IwT{q| ztw$5AO2cgaGla%Hztru#!sBE@+!S8HH5~U-u2iU9&abOxV4DA*!Pw^esv3nuMdv5g z_g0r4YCM^J*KXzcTF1wh)kim-d=|ae?&7MR*PpN6D^H#=z3Z7!mFGsMRZs6*J8_qt zK7Z8vxWe_c$sT8Kd7q8FxA>L3U17ZIg|7v3?Y9?erTebmUjFUh#-7?koKr3puCKe3 z9DnUt-usI0^YiTPSmvz1{pbF|yh7QCEpN}cCLjOge5A-TA;4JfdFt99|Bl?)o_@dW zy<1r0Z|y5zv)t0wxK5~@mRni0tNpKiznwpGNLa$3lb3%)9h{oLKHtxGu4Y%l4-;Ph zQ*XJq{VFbCSci1`9*IK^B#loDCdKNf=d^TfI&>ynJyKbn(_UPW+fe4YemQ6S<)m!AoV>7|&W~N0*P<(xx|7!E-b#C<`tDQN z>7JwK0>etr-@1RW>q_>?+|Qf2-j;v+axD3Fvg`bHOPWr5dwS|G;!;&*+gLUIazS0r zvZI!{Q8Ql2)-OE$Z1$lYv5sk0_pJUiI2PP>=Y5!DTCR1&Alg=1%F!@Q|xXanQ>?JCBC!m*H&%I+;sg>yP`Mq&LdXadFLO^J@;(l+|tCrRhrt8ap6(K< ztg5@r1U|UWk*(xDIxqIKOv@x=p+D}O0hWLMtj^tjb4l+cA=X7@;cGT6|NPaXdqTEkU!YCoP=pZ%?S|K7c0bJl-bKcViZ^qQ2T$4u2%eXh6oT$4Hf zW(@neiIZ;Ltf;E3-S&I?yj_-#dl&uI+OlR(- zyDj4)Wv&}#8Rq5uGEUSp?tc7nOU}yXevaLr%XHqG{d1kgEh?w8^J~_6-@dyyzOL~x zDx4EtG0*PCrr@uAd#9dwe}AcuV3OvqmD!I!8H6vD5ZHWg>)Q)=Ds~nyEb|*Fc?prP z)z8kX_+=*-`X|M^^QW5O`g!gLO^Oaq-nsnjtW}#mrma_%+0>Kq$hB5Dt$U_;Z^VK{ zw^qG9#rq{NHd8fa+dsX%dsVOg<#zk={PU6G-K%>S?EDk^eO+bTU)2+q-o6vgl$$O0 zO}}QKVU()!a#NZ0mDLv0jKr&>cGT)EOGkih3W17 zzJ;x=``*{Db8fhWS?*oot68-ztUGsWWw+@{GqtA{HxpAHZMiEH{=_v&D>`ew6N8z* zsA)^;eEU_CgYO>xxH3X9HDTkUd}D{Y8~vryTkfcyK6%UgXvSCB+wXoESIWnE8Tr1> z6}cI9%CfIwR@UovKOKD@OXz-nwlDsV$Itt%g=e?^4t+YOdCuqW_BVy2t!-9@Bq_{W zx#`5aMc#RNh$f-###abr?Ng*$>x@Zm1YH~^{@HsI|t5!j!dZ%Bpr(z4ToiD|E)q_25by;Y<1XvfK-QUSEIk*oD37CnJtWsB3TR zwhCH)*|O*Lai6TYyC+*tyj}i2)A-y?%Z`oV_tt$YpLsWG|8oC*({sDNuDiVL$cd_@ zGbYTsC30np^@gl>Cu-Vv2?+@c2ZtPFPp`T?-|6Z?-2k`lO$o6P8`WQDonEgxzhiFb zkDHvFYpy-n!f|=Ab?9A9yeAK0CLc~AX7NYe2ow^f2SojP*T|8VgyRi*z7*MDvK zB4X8{tZN$gq^50s<;!avGp_T^+FGs58(edC^Y+{*t!?XK7EGE`eSY7W&-^RnZau6> zk6#~?dqwu<@(Y%ypH1E}Z}a&n6Fg04EU$kO{$kdC-^K6VnwFfd)eW`ioqF5S-zU|# z?0T%_hpE{&FUp{LHE-;0c|YgZ z6xI57>FQVaJXTco%1yrZv@JS0Gs8-!cHW_vlP2}vRXTb2+WC@D-37C9S~jv~-26DF zcmMt=;`}qiWOet%y{p!>7BYXXojCQujVmATocirt#PQ}yi*IDM^3qjny`G;953QH? z*In6iuHRmDc1xsvwBaizmbKPK%ia2n1BEAD-m}vri1%Dxc31<~BS!ZB3?2My|MdR+ z&v0P!+}n@SuJi^kE{dKLdwj#5T(?Cf-g*_m7L`|W^In_wb^GlOpQq1mu(ztJGB#<; zq|DI1IaMd?cW&y`yx!e^RQmJ!um2g^%`g9Fh^smK`1~^aug_mTzw`V*!`GhY{}}>j zN=^GK^{H3DS~_SOw+-_Rey4kDx&D@?&UkZk-kcETs-oAS>YX~WSZ($O(;T)* zC(Bd4lVmdU%42&uG8mU;s0NB&%Z-c*4|%xi?Jrh2o10;OqW*1tIOp=kIr>lM9}4G- zyr#{QYw9^==XVv?bJEt=b7fsmZ~V7?QJ1U#!Tp|BZ2ma+ZhE8_JNcM)ZMn1Mxx#-- z)*nm#C;Xp*=Rd>bf8PHY4j;Jl#oBoGe5bSe&b)fTT1T!Oo!ZzK`tOKpczFEtV6K?8 zT+tVjj_hFVO1PhtQ0k%@|8Cc=zrS|k`zQPV*sy<9 ztuxmDF#kvTpZTBS|H-ii-7HK9UjA#+e#z-S{QnsL^Z%*;pMjsb$M@&*kBg5iTldD! z$)+*wrp?=Ls+?Y*yGzA?m;By1Wpm1hzqLBawfi@|{&{Ngoc!P4k9GcMuz7kv{`r4~ zrLq4RrvD86&oKYre}<>UTS44^+e7~|?AiIk>X+5k)gKRjQdPNHsc&B2)_Yk?-TGu@ z{&8^^zd+rftG?fR)*k#E`@ZY_vYR($%!&guK86P0{v^F>+DVNiCSUW9xc}(4aGh?l z@8OGmGmpKKTKsFyRjc(~drqIvnUVW*w(76`8)f%RTs;4|KYO{UBKphz>2tr{j>-Lc ztiWl`YAybR!0B&xYl+2Qo&KZz;`b2q@-W-0p?9xeJ$Y-UbNYiY(d+4r1zyGT2TJ!qrA71@a%Fp`Mey``x`cKUFB)-l%U%1@cwQ!}o&FS9a)Kz!0 zwlA6{R#?CCY0SIs-+^1N?YdT^?~*=s!k?YT0(2j3bxeO(T6{w!|6=FPiS3?~&PHE2 zzGQkzoZVXeQ&+ZclwxmOe#3jU-lR8g-yc0}s2+6ZZ{-Ug>E13jZjJ04d`@?^FI&;k zZ5e4Oa!BC4Tdwx1{h?DE*gTivZ*(%sMZT{6eN|R|aqyqh#j6YZ=!EsrzkIK@zTEtJN^aj|Zr7_G=HEh+)1L%i zzOTApU`j`QtVhYI{U`K$wWnqM5nu4)`?*lBCvm;cE|jf2^6>Hdkk$VgWHLjZi&?a7 zDiWNq`sn$hZR@1;p7x!45}x(*%N5nSrwmV%Z&(Iy`}EIlu56c%dDL<48;))sXE)uN z)6~2G=Jx{oXd|a$1XG>SDj>3w&p0OPAWKPJjB8D|JoudfjHnn_+3ME=^Aq z(0#45HQ69xzj2lEw5rFApVoU8dY)Zlvwy=CWxY^K(TRVxpWNJk8Il+{i=QPbB*E#t3K+r}#(S{_;(aW_6ZwDfmu=wAnhRnhcp3xN)l#?rbIFnqax z^1s>DKaHO67nGAO_icG||Db!V{gt}TJ>lhh5B&VkFwdYhKf!OO?}DYKEa$FYRbTu> z!Nm3KBzM!OZMgdg_mgnD!MXfT|*t&C;j8x}& zWgXL1*6N-0ywi4Eog8a1ZT+WHp`VvYpW3~x(zJg!n_Zx)@8Ny-EaOa^efRuZo!ha& z;ba}Zv&cuGb6>ak@}>sKL7z2Smtpp%NC|G8PcNbcQmh2B zHdak9lXGsnXQj$L^XP`zFQ!}Vl~W2k9Jk`=$*AYb36Y++)^0kRko9%PccHv!wQprd zO@7V^(ecimTC4K+lx~#5s@t!Z)zqpl4zgso+x69NYD)L=;&uEW*)s)N~ykLLG7pS8a1u8y6&y=c>9~f z{+F_UulaFhZA|y;Z%#4C^wmPY;)7;a-d_!5M zpOf~2CD(sAtvPf_HoWttUz(`iHp9pwt9L7tPgqV_v$N#;U+pKejy^uSB>%YCr!#B4 z|Je55KYF5NzwFz9+0iq&y#q{dOLr>xTsw0$KIdYubJcqNu&Ph%J)Um9w`N8q=PUMA zM?Y)2={$KHyRBYU>FVxh{5RLlo|YeJ?e5MSyS1qA_M(TIr-=BbhFOW&M(`o zzvQ{{w`j{lpZ--nJDaB2z2^42W3!i>y|d-kue^0T&p&(FqdX@)v~WgW!V~jCnPAuU z`O}_Ryoo;QnsEBz%de}Sh;8d!bLGH~e{q4`1ri%`7)|fb<=LB)7V~Gh(t^nC9S$tcuW51$^#`%SM8_BMBbRaZjSEOGLyPclQ{d&rST{3Wk0d2TBWu5+nra7 zPPV-5eD_=5uypr{oFzxU{Y|V|S5~N;v?peX+FRpEdQ(DA@01MZTD9!vIo`?4md6a| zJhwPz*uSoL{@tEr`O9;j|Iuv!=XNkncR93KpS6|i%EsNh7`Ox? zLOHJThKA|9kU8O3dYdO`L%?jGS=TCf`DaJP&W<|0+HAwSvpq^iyOnk~IFu{A538Sk zKjQnVqjFC(m;cGF*!Fk3!lqr%ziCEIdB3GrS+wnw*bK|;y@gLoCz+q$vzBLzliT{} zDSiHHPWl)fo%?65Vz}w`S(`sI=RCj9WA>i$*YA_2UiVp7MeofPJ!ETqY-dZcl)J{; zJKakh&fmy2#P+CV4of~&3h{o2xVr&!3b)W15n^H|}3hU<#wpE&3I3cj|F1jb@ny4a z`LUqO9hFI5THf=oKb>^^?$`7SwY-Msr7~`Y{AbW}vRi34&+NDK+An9$T;DqL$EoaM zan(f|x4!swxnI25r07py;jaDWg)(M!?$eiky?KpE>i52-H}5UswiF8bx|px%e&mgC z&pSsi{9~8#kzODFvG>jKqpEYS27lLn|8Cjonxx88ho8O|`WRPTAFuygbdpx^#`2p> z&2G92?|r`Yto_TsX^w|(XD>VTRJ(Pam+rFSMODjXrB1S3_EjnIkNtK2J;-NE1jFB- zpWtoI^-9M0XkFyW>$~>v*&DQ{@6WmAnQ_j3rN@8nQCt1K@QZ$Km~_e0$qPfIw^r_n z&9gksx%$m%)dh>uM>)YFZ<}CJoVj5-eac71L`w5?`-MS_RJ&w04b)8(F zwW;t=ncJ&te|~J*dHU>Bl{w3*Om1syNv@ytWJ_RKYO4GC30Gf<8GOmPcH272aaZZv zOOl^8e{Iq9xfT3#YVtE3-5(9J)9!OU&j{<#y6K)3{>E$be7By64TpXton38XRkZoKMaEsR9|a$e z6>e_Nekf~l=v??Y!>QAQ--X6Jmb_oPxkqH;AD1}xw{_7^=I}ogpIfEAq~v{0CHvBg z8?RbDZI#eE%-O}-b#Zsq6W`!@7Zz!Mowb#3dgX>kyIQl~Oq@JxQEYlt+*`BfEAy51 z?%gx@p3-0UXYzJcc9Pp9j+g6Mp8GY)@W;90-=^Mc!;C7g#1(HVyZx@G>}#3y-`nXq zdG~X2=RAK^ZV)z4{*%ptZy%yI{mGwg%Gp)2{{wrt;OP}JxQy+x`_AP(VVdr+FIw(d zc+(d}&Ufo3p5)ba+aq(Y*5qY_0ae6Pb%2O@I3>oPV>FZ&GB> zZE1TG`$PKnMgKfMrJlaAH+pFW_ac|u@6IeL?2Y-tuThdY!z+KO<(h5#iz>>6XC3;u zSIjwi)NfNo+I`9onE@+%{{5F{`ni+{~CB#_}tuSiyq2kue+UY zT=VO|QBk2|x8AN3b3L?DukGe_`=paEw_kp}a#4Nz{k8kw+VjQnZ}+med1Z>b{CTso zUEMjmRwYl0%85BS@3iK=+bgFQ%Z8-S{jlujZOQZ3|1+3dJ!zA>*+1ueNtjI7Kkl;R z*ZZUX`Sn#=Z@L&+*R%5K$CP}hFecI6GoNnRbaL0J=jEczJJc&<<^KG6FY|H1ex`kb zbIk6UyjlI_-m=y6o=!R@E4W==wpGMwkGIeyzOVOQ$}B@(`Teg@2NgsfAGGC z=BLI_%BkzUs>*!#=J$SxE9KbznqB$hRsCg=i!-;LOFt)e$^Pr~xUH3&qNH3)^!Dw^ z)=gDOmp>XV>3BK#-0RoVSMO7*^R#7sUA=$B&;GNy>(Az6*{t z*ZMh&O6*qIz9`aS@}!wH&5_n;SMIUl-o0eD#@QzlW?hYI4pKE_bgzyS?I{ z;5yTsyT_l{XUgfl*phg4(P`!z=fm3U{w_aSxXbVJC+EIRbsqBCtGjGD(spfQ_~%#{ zd85zv&a!<`=iC>#?Ya5u&V=x7jVh6^r{A2z9Oh#4rR$_k)lXIRE8FxJnYOF1)vMa@ z=m@N}1zocj?c#d5 z%WLVrlPlNVdOIh5<@S#%HHLeBT>i4{?)>g>@yo~db8kO({0}&z&{5bz@#_R@Vy%KmEjbS7%L| z!spu)JaX+qOm{2B3V)b7kt3M<*zC?_jvm(-T@IXin{eNotu@q`@6gAi>yDqC8yRP- z9PV*TL?JzCw>Gagqf(u70c-GU>(FZ-f5iRE{PtmeiT822wympfpWN5J#l&m3xxxDw z*MfhibvFrK{1!XCaGz=Kl6%`OPLVw?ahvDSlgVvc@>hqQeZwbPHZ^_|4q&Z(1$qPkE8Gk>_UaXR}h=wf$L{E+Yge1Y;$3(c4Yd9$(!&8L#L1KEJu|$HlKi!T$^3xaOZ}j|Kv0mr&Tu2*%&3AxvEEI zgXgk2d8Ub1kL)?Ss|1d&AoSzY${XIPnNc* zGKSq@d7cj3Hy>A63PxPIx}CRMesXF-^=bD_!73-AUcj?p5i>U#wZ+7=a zge@#9=-Pa_F!##Uq-{GhrPM@u1-lOI+GJ+({%BUvu{F1zi90P>WyB> z{RbV>Vg=)40~&bCauQ=Ntj(6%l+1TDn`^U?;ObrX9)!2guDbv1{u5p^aeITG(d~bV zD_3Ru#$5k3eRtsYFX!E2UiV2X+bqqSe(uk&u;rrur`x$6=SqH&R$3cpcql*V$$f=& zvo$vf#(Dpo*x-1!Szdq6s*kymhts7lz1uHibIrO>>Fy@)#}zBSytq4S=e3A;e?z6; z{LAxRa^v5O{OxaUXxyiw5?kl)I z@z-^`PxmvP{keAbreukSb=RbM+3)wHOGM$zG2m0;sT2kyGxC~ zO(|X$WcGsn>zV=L^`YnCnm39(V9d2~XVD`KlqmUHo}Jy;12=E)&ZZmeMU24*$12 zZNh#3Tao2e)%oi(<)edZBSRNGlr}tNzwO%Gf=6DVFU`Uwqy{S@AFXGRm zqqK2RwEvXC#6RIoU-kX`9QnQG9)HVHxcmj{Y?{!Mli9CM=0^Rv zxc2E%ADg99cScM%+n%&m*o{GJasvb6O8O4Nui9&h`6lbuH9o(~HM4B?)3CEI<{GK3 zPU)OGalzf--bACNLHEv?-k$pU8_T07kMF-1RbQMwYg<{@Y~`NZ-y5H=*~=O7seb0} z{Y&*uXG~4+EIK{kb%KA+b7{Mv?Hq5v)Hq38f4%M9vn7|)g-+@k&b?apRb=b&yZboK z{jtASv9)l1->>wLR~@M4zq9e!vwi>esvr9(uYBqA`YX#* z56E9$_Sp4OXw$0~^Y_)e5RZu`Xz6TQw_awqmQ7RFCm_h;RKFtK9>2NOgb%*#?kQ_E769X5W-_Im$C zgXdNE@zw8NtTIk!^$wc#%wWa3*38H)?~kzboIax0z~FJCOu;lIG`Qwq^!(5o{ol_# zd!`3`Tz-!I#2o&*q=TW!tL-Md7Jco`v}KpKYxpJAC~>vtG1un1|IJ>reAzZ$%eQyk zG?F#)`98|L{uwR&VP*W!C2KBPhv=W-oz1vR|3$ySy7Ut2;Eag)B0(UDFMjsHdD(XH%!G zGwi)GaqkyRk6TAgcdHaH`>pkI&FycOZl0Uw z^O9V(u9 zZnll9X5UnPMSaUfJPK=g=Bjr41wS=N{Bgr1xLsUwc30VADZ@wm?ETAk_NM-4F!y_| zJ6rIG%G+HgZ$2;zJTAyClij&Rn_qGB{EC~eE}t-;w&s;S+ow4f){0C?kBwyt^oetR z5+k=H>G+#U@u${STRxpXTpG3M=ky1cn<9T7>RV-ScA>R>$?tTb&|O>i`5G5&x${Wn zj?(gPAvaH4yBu`ydi>^?H-}R9-Fo@;zIATJc?6L`qw&-7Pdb%(4_+9qZ_PXa%Be{2HJo@pUL9%<& zlb@F^lpNR_HTz)UHm-|t)0gMvXGN!PSy^Y7bG`ZTpUy3NZXYkS+4p@G-?Y0n_f;3` z#qrt{Y(F(=)lYtPCy&}!?9b~`4Rv|ehVA_1^!`oUONObpTbCZI`ROqsa!;#ly?fEQ z{%iSr#a3@C*d$ym^J(_=3aL4v($@YP&z5faJLzX`Pj|&7r>Cy#{g(Zjc3bdI{GYDn zpIBYq^S=2aHs|p6pTQUQGN1W-Z7#3H(rHU)Z{>0gi@K$8xo?)cr_IX9+lv;@_@a8l zY;teO%|FGx^IqJP6tDh!)k-(J|Fc~C)ph!}kB01=t8}?$(}`W-Zf|EC3|T1ecgi9( z_unj)Sw1s#x0T=ip8e%t&wmET==+COI&41iWATN$6MGErPMv?R?(mztPjyAF`mCRI z$ym$5`1kZkk*NjKax?B;$y)z;V&JM3tEQR$Is0)=L}uRQb4wid3-><=+|~Kq?P^hV z_|!jjUM9nxudGd>rG_i%hdSW#kR_ zPh{}-ePNXQkNw*84O<#shLvTPKdG3yfPvMh0LT0Wy;hspmgfbgTs?hUD{FFD@3o?b zv7dWOd_{zBhK7I!!AmdNn%&NM{ykaZTv4F)hlAF|ug_1DpFV%W%==foR%)6mhp#xZ z>)fdqx5U?%X8smQNe8DeBqO4xeN#*z(;O&!WYBzJ%{7L)k|IGY(`TV^T zJI#KaeE#-_yUlakz&-v8OEp|}lyTb9sO&ulZhZJ*aqrOSi9gfKGp$Mk*49g& zTt3M)HKSfVGxOR3>N|X@(u|vnIQ}!Z+)xx+d#+rq z=G}_>t4}*B-DRtC-M??C=-Qd5?Jt^U950zV>GtP{&1olN-d$Z>5_B$2?!mNwhpV58 zdWY9MF05f*eQLq)>U6cXmmlX&Gh6m>&+KDsCT3rJ_MR^T>6FkDJe$#+7xewRgh}r)JMtxhdBS=Pp^BmX@=6xApFZx#lPD z%1_Q)bFv}f@&-na+nS4Xc8jhNGb_ET!{GiU;MD0qKT4w6mss03+DY!ba{0yeea~L6 z$(Ng2D)6-I{NkFGC*qUN=5$6L_Wkg1*>ux~s#l$BFP{#d6?FILuJbRSh+NNByOv!L za_b4J+j_Bcd|Sg>yVqS`m^|U)W{wVzFb}t*ZkzJvnfkKzL~L{1T(af5)UruYnd=OD z5>_tnc`Ej`{n6r|d~bxJmn%nol%Mr_U(JHQKmNQ`T9zidV#AEP+ipM4F)y6iZks5& zX`0EoTl>R({uX|(%{@~tdf`uTTgBbTnvR|PQ}(?2W#l*a{KFqE64x)Rw`V^5@X~_a z_Odqf6+SBN&5_D|vGbj~{Tq8ZclnPGLNESj&`*7M_Uz}rPX=7uttUTS&)plEP`M+| zvh3Ks!i}Kan}Ytg>U?Lee(5RCSJ6Fv@$309VKYpozxFBJ@u>4a&B^$hbwN(a7xuQU z;XN1;x%G3;Gv%4VS=V;|IkkUU*T)UH(~k7b*nCZH+fT(Gf1ZT-hkdsze0n~h@>#rRxM{_eA)?5~#B`cBPh-mV`-%UXO7zcqC=TQ|i` z+nr3t5-md;r{_BmZ*_=qnw6~4U z>Aj|JF3DwmZ#wDxpW&-d=$gyNuijVsSXboc#@7<9w&u{h2@k&b2Nd}2f8IA+YRX#S zO`mVO+ifxpv=zB&X6CV6@YnwAsiwC%J&sz2a(W!Mdi+_+!#L-u&Z|XHZ~O1h-OGM* zZ}^eQ^$UNbu3dY1%Ga*L(y3MlZkkHJd)Ry?chQ+A66@FXEqb;{Ugecqk>aDwy`9rj zzS-WYvdCGs<1F*U$A1o&i|^HmpYh`GM)oJ$TBl0ME&AJ;BX=V2^&+NquUD_+v99q} zSMEGq#?m`ePFCP2Blo0>t5>gHwM%G~*6ZJ~bzikt|0uAvuiaN!zV1i$9v@xJ7yZ3_ z7t=mn-Fv3FM^oGU-0Mw68~u--=ty%5<@|^M9;y-Vf z#pZ6mJO9t^a_PBC_e|sCo^{E&dS{=k{?k?MtM?W6U)|jJJSH}vb>6%9j@u{hH+1mk zED)5ES~(-6r>5QfSn5I91@{R3N{iT$@hgiH`y?+OT zq#9Chg@L1if2y@LXL#$hO_8dPwZFdLxV~9<@@D_pZZ6J8j%^Qo(lTdB_tn6(L$=*6 zp+#>WFP)Tkm*q-msL5sDZAW|#Cio56{nPRbdvDfkzG|mep<-`q9c@3-N)mDak8f?Klu1OqqSz8{>gDEIKZ z?VEp-zVC0}`Q`jVTUYjH`p%Wtru=7!%sZ?4Y*u;XW7+VYV%9ke?*3DnpQ-K(4)@<5^ZNVpefD)-*)Wzw&TLt-Yrk^6;Tw^u6RTAgOY~2wdoC_?zWiKh>28l5$NGdbWo7QC7Imxf24CFm zc1z{1tf{YU>5+Yh&bZ!K_$Wu9fA+~k=Z)$e$~1at6shO^><8( zF~xoSOx!|jp{>7eu-RVZWW3wkdt<72>HVuG;{R=0Yy3y$zKQ&oS>N~nzJbcUX~OWv zH{etLWTiio!!}=4+Wmg@?@wlxN7O^+e4V~P&#q<5L5*fviGQcpMC4U#{1f8MEjhgO zQMBf?Rd(mzZCtl1fBQ9YJO7A$#?L!Ha9)VZTDIZ+Q`@=czD8U84!D$+J>{snME|p7 z>9TmUWUBUc+b%t}dT{`8$SM&Gt&l~ftf8M_%@{IpU&VL5!ds`pxTQ?(J zbWxW5gvTE~XI|UwEo*vT@^;$Um&IB);$O`(57t>A{yX@-#WBOWT9q0`e|pUDlCW;?!C8Q)#lYJA1i-<8hvT@PyWaAZ|rNyRG1U< zmAy4~e`DX3@K2kU{yQzZ)vb9^bgl9H^Fa@-xmQ^|mXCQqC;4?xZP~HU*VY7F`}Kr% z(~iG;)>fV87Ef%NlDSVbTb1ABD5u2nw^NS43uMokv*@Aj$KTt0eT)AyNQR$3np!w> zS7rLiI^Jcrhr;`-s*NXo`VytO&AfDP*lxXRj=$eVKh7-++%3Ikzun#1&0oA@%Z`cM zjxC<^_|(%6uWqb*Fhy+do%@Q-kG-R9rX97P{lxgg8-4jpC1)0|>{ndZQLB1C&ivXv z>9~*={(5P;hmWOP{Uj#9ze9d<`=NIU4H;pt3@@#jw_tZL^S0gz0^h^;#hFawye(=?JlWy*;e{Te8HnQJAH4KYqv5M`P@Es zVO4GDJK^GQb#>>JC!W8Y{^rBl#>$|3n?IGyFaBAz^;xw3lBrKau2eo(e7A9KaOZ`} zp0!$YrLM`(PTr%Ov*YmBS*3e9OeCCc$9(EDypfnH>%4pO@m$H7OR@!Pk`Kj8pZ=hC z`Ht=0m)TS7^S`fOChEKPKf|KK8z*EsKACf~FY;y7gFR|`*`=yVJO36g$%!%wzNEQ% z-X0HkMSZ`LqeX_Go z9kxh1dGubwt{Zfvy1RV&gr|4dY=yRcoD;Ra@RoU-mck*(|Hr{hif;d%bSHkhgP*(%Q0assFnv8rLVh`Bg7ndqMTpo?{oKFFcIP zyY@X~*S!^dlK!TdiQSt#6rP^(&e~-Bu`>Eb?S<*bf1Wcp&XBl&?1`oLNAY(XVg>cK ze7IS8PH9WP{53xVyfrJgWL)TcB~&kTCTqd6`{oDpFT0d%zI?3k>7LsYRbq8|Yc}uj zOYP2FH*Y_KQZTz{AcKN`zq-BBj@WL?{873eM-e@?oSF@XzCw&&nM=+t=qg~ zvU{@QH-^f382O49^IpuGch3G(-tDE|-Y+x1=263a_({#>NAju#oO3ttc`pBXzw(0f zZ|9`PuWj4y(UxdGCwuO;-=%*y%)XPo&g`7&^_T1R@0Kvt`}%a=`uFP{D<7}^wS2DT z(VFv5yMyg6p8j(*V^dJxT=OMWx{FnBUfsoCTz*zZye^V4`ibv6yST|-OTXB)ck?d& zwfXbsjc<}>I(wW>%!~TtW3%You`i!(_SyC_DkMCA{KH1d;G=@uZiTf`rbRX1j&~R~ zN5~&x&W#pduUC0=RcC}S#>q%*151( zb7vI3NR$0y^H}OU!#gueQ&TT1<_RS$r@wl;&E%?C;gplh*OlL{d2DfAYEj?Mb2pC_ z_AkF~zoWhXu)5#GrGM0Z>|8R-TWQai_|P2-X5C8m-6)^^HkL0<*VnNB&yzXsJ9D1O ze(p(6xpv)tzr4?L+nUE;JJ02RT=~MQRdjP_-0qhhC+d|yRz0bjpR%=o$uF;2Bw3qKZ$ zEq`*~YTJj6UA< z*kbwApTAkFX7o=~4S)3^+v53!%_rH6lN_KU4nq6tJE9+65`JoaYW4Zz87sck?RyZo zSu9S`ddh{ot+$Ld{%tybEL}c-%D;`<-bO9kn|XR_!4%Ph9N*)s0yhbF?t0boq&9kM z#eatVSE{z#OrHOA?)jGZ$y2&x54%2I_UhZOElq2lEKFC5TQ+IO_0NH|tSOC?oH=)= zZE5l8uALZJQhcAU^kbc_d~464eN%sWeYW+^ziE`cIrH_c&?@Wr(>;@-Q*OF^pVl*T z>AG9S6N7aZT1D-8xo@TYJ+&MAOfFuX`fpy)z4!f}yq*+om^j&Ot7)5T_=kT%XEd!F zYVuawT?^1otzBb!YwM&vC7-OcuWVU8`|-`=FBtQdq-9-DzaIVLH`893%I{aDC$Jn( ze)qE1cfY`7o{BezbMJTDpB$I`Y3buv=?gXYFKBupxNBj+yFC}#XYDLMSJhK(Qa&wl z+3x3jp=M&&xc%(o z%($NCyyCYtZ(06Yzj50(iDk3jua3F9B75DIuc4>rPv7*P;iuo8)zdD1V}F&rwv8&*-_2(}@#8kRz;`E(t2GK=J~mnJ-37gqZ!WyE z_wIiBVe87wkF$DaJYnCgHZAsM-r+DsU!(o6u1+~){O;BJ6P;4;rdT_2KYze{Y~B*c zhVQC(cef>6J^j3U$<5hjudU0T=6>}Rdpmpirqk;-%}$qkG08J?S6BYF!gaf{=Wd>p zEUA>n&792Pn4prDUZTKYn&RSG9-^cio?2cC>Qr2L(J2_v8z~4n662;|?AOrH`111l z(9rMYUxVcLWz@y~^gq%*Q|!g(+#7eRkGuX|8U6XW(%t7zR%dP5mbvcTn``zb@AKU# zzLgfUxjJK_x0KG?aKWoDo|a6Rk+mpL_Cxx|!b`T=>6xD$KkeSV@8+v@4;FjxpYx(t zaNGIp80R_bH@(-q)^RHO?)BEDx}UR`JgMATXcm#}xbD5I*g>)YDDc3Avp&@B*O?V-E;<>wxSw!PaKcS+rhE@%?)7Cwrnd zg>DS*e7%19%RSxutX402{G%)U<6-XAeBm?guSZ0b-j$a>)*GB}`b}!>4%2Vib#sos zY2ZqETCiVKf5xi4{}~=hZ@s6Y9I0LU+2pGE)(g+3U9^pJ`#0;fWY8`{$8$Fh&B!+N z*>omrw@rS_oPDWc+fJ_7ZFWEJY@OVCi~3;kBl5kP>u$a~cd+XD?C;!utCfH9l}~?b zlyAlCa#wxM^Bi6In3;_o=gfcQw>+MFy|(1GttlD?ShEswm5wX0TLTa-Dq z>aHE@ww?vACK!C(k(QbLZP_I?KHEJh#VKEpzq{@txz$y-@IQmtuE#7p9{tg|ui{%9 zZ+fy|R`apdr<(f@uDAP@SX%CR<@CdoSwgG67p}={PuaXL|38C|eZOGc{)e2;!{Wk1 zAO6gJ%-{1tUY|+j_da)*IyoonJse$YSnNJ9^t^%OfeiNT|J*9tJIbDytY)cQzP`$S zr}wkX&-d#Vx%E7+R!`XQ_WR54ZpW<3&RMPZ?+cE3oAg5L_{Pu-v0u8o&dXR`cJn%R zYQ>aYi_P{foNpDf&GMJr?UxznS~+*VvtIo%sNu}2buX$`@0!slYq0u=qn7#3H3mTe zt^AYYz8f@pIJJK@JZlhj{LQJ=@A7{rz5Lq!O!KRG-E47}54usgdzgQ&wOMYceMfKF zPWNA`(+jt{?u{4M_gi{>`4sQ?o9|^6pPkMvwM;E+QJdQBZRB11zGwerKj%;JCv~^I z$}Ov&R{GAisQ&a{(dVyMy`8?haNTr)-OKtH&bQ8*#rr%#-ZD|~kKE?1Sr;{R3?`&~ zY>BxNvnE)2+Tzrgj32fqd1PK`Ogh_j=B((Hl1`o8DC29*UNLWaFYH-+xi{)0&&?^a zjs^|^rx!1IS^C`h4Nurvk*13;v<$@-9-F%3(q3=JESX#Vx;Dl((^VcY?Mzv>{(Q~q z{|v6DewaUMTJ|+Jb??WQ9-MKfVOzP~nM^m=y$iW& zJ~QR(wi)LNx1GF^rle-Yrl!XwJ4^7Rz{WF+l5Ut?=G>MnD|1sVCvv-g{GD06vy~=k zX7=A*Rh7NYzKrYD5BE=hkA4pSB=~N-S+Zn|d}SDqU(<%k+!-yK4=5w{5(cSM{}EPicI~z0AI!VY7DsUh?VW>DiAT zhQ^01{;^*E(5FS4HYJ%A%XCa#(=$cp`pr+brvLgIqa}Di#cNgjXXDA{HH}+Ce_L3d z-L=D)XVv;DJKMH5Jz}dD#_}JT%YM`H{FEK;C)nq0Sob&mardP!{mzN2JoL7y?p(9G zdyvb(#F*>@i=hZx|+-FyUOFqn7m6`PBxx}&JIgcfd8P9oc`72rC z`1^CkbN;)gT2bHR_&fJch|hJMukOCPV$7cJGku(^%QMIE zM#gu!CC7G`%z0_cow41B^X+*{SGOaZ({-=s+NZ72Is5Ld&EN3NTjE787E63deP(g= zMkDLXhuhNbO}d`5+RNh6r8Pgxvo2?!+M2a=YjYl>?aX?S+T|x%rwe@9-~E*P{qEyu zo?SflBCKllqO@me7Z+?)jLT0BeX@0~&aZp#IerKC{b~AHJgsVe$Eg>eR$f%N7!@R# zdNC-gyC`K=Mzls)NYHKjWph`1Kdks}znf!U{_4myXs!XkM=?aG^l zH90@|{+PYTVE!6CyRf~V_3qyJv-ePrMfZN!Pgk`CKFBq^xvKd*_nB7sR9!O^ zW_779Kdlp6!pzs+5{mxexarP6L5|zURjz;B{3CaDY(Vnk^+C&5m;LaZ9UEUHwzlM| z$iHK6zn(HzEx5UF$90#FKYgzp(tP~0<85!@vb=Tt`W8DQg=el?Hshx0J65i2w`~_L zZ<+M!=0#DaE2|QBOrC1_=`yEBZ200O6Yl0-m{P^iA~IE&^V*zK>l*DYE!@3H-+WJl z2=A5WdqUQyHyn3As{1K_b4By?D!r3ZpTv@{OrC3gS+cqAGymQ22i57`TkmOH-75EL zmgml+`SVX+O%RS%ndBPsxFk^J%jKNxj;J52uI7i={Hr-r?RibcBlL%m$$sHtOIEwP zGtBNWUiP@X+2ZfV^_R7jbx%&482;w=>t)k=x848GaHt^a!^5w7l@1GXlkau9Ex)vV zN5m67vA3^6XGA@_Hallq$(gmwj&HG6tDL>@ZFv z`eB(TZ`#DUJ?po9Zf>dOv1Z@ZcZpRmLQj2noKe~$99)w0Ij-WFTI{=9|9omP;&k5CyV>2JZd|*(GwP_a@Vb}V z>R+szC@LG_#QEsW^CAW7E6NC(BD^Nl40*>>rsst_cf#T65>Pm&+;Rd_`$h zxsSRR%8vdP&s=l$vAKulF1=_APnU4-+RNd-TW(uDZz-0uJ!vtuJgZ*v>7M5kuWYM& z=AE_Qa7kE(>D?u9@2AFjak?{1&( zhu4=^x$={qlFKzOHgC(kS$IkPc4lvJ&zngfV*dV4w>bZ~sJnN|?bqKQ zOWvE`7^gIU{y#+aOeITkpsiUzfa}bK2u%&`(=Y-^te{@8^aT z7H)gJZpW|ZHOse|9xJ=Dd%E?qqn~H7O3!yvT_tcOsy1z|P~WV_v4K5n4sB{pnz!q* z#4*FgVV>DN$r8ux=3j_BbibeRlkfD}e)G>dKR?RGR>swLeYn~@$@A-fhL`-BCoZaZ z{a(g>u5HDt({qmA{WM?dhfz7&E;- z<9Kb?GXRsN? zX}g!LlTmkCyS3irvTM-IMc;H^Uwrp@mHy|ibBx;LI|MK7`}p(2j~zdr^j?pwT5ntJ zx#dg5-YGZBA}=qAnYinVO8lnlpM(C~_-A`Y!uHr{<*$ED_T31!Umk90bNOV=cI5+q zs^&yCKZ&_#ryn+9|JB)j8}rWjUccJOASTm)#$Sl(Y!&O516wbKEy;+Noj&8)tyLFf z*!ee4m-+s<>@Vln=Z8d8U33=QU2Z&U5gT{VveuPT!dR2_8~-z~FMhbb|6NM!UiKop zo-fW}|2n^%y;WH*WcFL%?`7_m4gbz=IJ56=rugX)B^Aj7D}PPB^5^FZ}U)aVkdhRmCvu5|xZ)v{LPfhoAuH5xL#>`dL>_5Y~ z=vvd`@6Yjm@l?6sX(H(FGSSsm$W!I(u~}-fsvf&sz8qWFlf7)#W2x8RTTPA`_Alc) zQK!ovZ1%ujxZE!3P*>&r}k=JkT@Z{_Ce z&KFMG$xJK!)6a8l+q{3)9-m|SmX)Wj{lW2bUU=d~S;5`W!YjYYmG~5ACYPqhCg>mR zzNkCxd{5n4pLr!upRntFO})i8dFuDzlEsU3O8hDdr*vd~f4^Y`Pck3z5cOn`MTNt;)2Isyi@v&fD%bUU`J2RA_R^o84{f9W-Z=F8?fTnAMzimI_sr}3vE5F470;xL=k`24>;F!uGQZVex617; zU(U93?G5I7zx-)(#*a6u%Y?iw|Av_cYh`Skon0h+^zhsN472vg+Wk)b^q;{}rS|IG zg#9y$w$9tPKk?7R+ok`0YrlKS2%YP6h0w%VQ+ z*Qg>prP$}UrS6&)8R^J)9ACV9+nKqGZob|UHp$8CpQD{azMYi+?A87s^taV+nERih z@~!;(Cw8Ip7ENWZh;e_q$vkZ1d6C&YLFM7A^9A;8ICXUOlI$yYJk3j|t(|k>Kg03& z_Iq5`-?Q&e5v!B3k#uq{F@LSkpK$SRZ%LS3>|D;6`SqXosyP3d{5@bU|0HX9L#^HG z4gbyFuwMJur`KP;2QL3JS-#c(o%ogg=lIvuKT<^JF4%YdA7lNj^PgR|)!%Xd)bu<4 z2kXCV`?Eqf|1%WoPdWa{r%u#kF$GZd$e-eVTmL}(=bHZvCf@0P zkGS0ASN$g^-~FFKsJttDNzM1uzha|TT@aZVwp;7_uCJaIdy6$?p6T8)+Tgcl|EA}W zc{eZ3PBTl~edF$&jJv1SibQUbUT(o6|I_%H{;FT~dxCasd4ELzl>eMXx~ER4{oYi5 z-e%u|qFGTs$#eEye7f# zFE^KY24@(bpImV_WL4>`Q#)UZS1i4fcQ2Fu>XMke)oFUO*H%7k4Qx;e8R&Sf)8=5P=`8->o{#asvPuXO5 zpT%=u_g+t5ye70)`-xrPfseaF_z(5`IeyCgY5Mfl6Hk8(NxM;#y+-Rq__8nDH7~rE zJq?wZ)H$_E?%9JM{~63rK39snWM|#*cplR>W4`|k6Sn@mxF_V2K*9oJOP$plKk%A8 zFwB~I_eIU`=uhr#H4jhkkY)OPs`9wX*-|uO5uYdNJ7?tUYZ|Wv3Gz&ZV z^t}0}XrtYZrQETTx0-tT)fc~5d3F1Yo<&8gSnkfcu9{jd_bqn|Yw6~lwJBNMAMbwr zefqwx`k6oakJpu}JWer>bLxKPrx{eU?`^?8sW+QxX%z zf3DiS-PzyQ-;r|9OtV?z#Iwv--EM+!15!?|vii^PY{}i#DVH2szW!%;@nTZd>;4}b zvM(LHyK+{gwC>}DM;E7+b*wSlaQ@bn*9jAEKE71ub#2Oe>$x+|W?r6hB0|zA^y5jd z9k2elrLe9S>oUqr`O4pPZ|a2WRTnR8H=cKWNeP3oUvBni&yT-E&6MW`uAK94|GHle z7qh0`D$(nDF0Hx5H%)PlPT8t-`Q6s9&Q7wpZ}Io$ZOL=?g{K*mo|`+*`YvgBK5^$7 z>o+s5iO%L(|9j%h$k_i3)w?G;iB9D_J2z=bdeDWb{B_zv4PjgR%gY}zD4E{9`!&9t zfoW%sJm2}qhFxKAM1IFOOa9usN-Su1a`R+o_rS{n#Xi&frgqoe^hq_nxj*S?**c;7 zl2=`(-jDgu;Q5`AZDn4x(9`CS3#O(%Ql=Yoq=h3JLpvFJZ%mjPD{%Mf)vG7hwk>8` zb22BgTkL?gFf;ceW+v%HLPDz)wRY{=wR-jHmEv-W&D$#G`OZK7-1Tfz`qXRtvo#<7 zJFEG#|8cHOEzjN=na{mTu3xX6QF=~TX!eX5EUHD*?ut)xIdU^m#^ZEYey?JQ`Zc?t zFY2r61=<^b$z0dmruz6i-_LK4uWxyE{?Ye;jOWU^mrR|c+v;T$Ui#tY(RrG0!fodT zHhJd#oNZAWyTd=MFKYGPe#aFh=0Dm+Pi;B*`^UDd3sx~HdV0PTRkmkaW%I9!+B#1!yg%xorDe_QQ%@Lr*IJ&QaCCQG&cWnIJ+qm$3$LYK zXtSxhJzI6P)#s%Sj4pFJ_&)O*zq~*7z4phgkM6HLUSoJBeedE6cXuYe_lVs0^3s$I zANwsF)n0~tIQe5e|72a z@{G&xGp+{w7VOzr=%uw@`|#06VuBKpk@L@7xhwwFrN=U0_uu&5`Dy{e9u<}xl3=_`{fuB~N`E>v{?{Hn-9;azCY(e2BYv?(oL*>`1X1GmkJ zpgFG>i7cA=*exU{Ip$E=Tq{W@xw}>}VQwJ|TUG>iD{U_PY53$k_ae2eZ+59|Yp@nv zz^bU6IN!)=-QNt4o1*+Fc^B?lmq>4WeRbghMotazwUQQZ_brate>G=H_8OkpMe_@q zrmne_UEFhFV*9-H=M3Y_;**mc$2^XTToJ-XJX)R)xH z?YX%^YnLP2s$J(+pAWrr_{{4~=e|wzoO1l1i2khJ9qvwDKQ4cny86?O=aCyVx6fL8 zxqtg#bBkA>-+eu`=WIEj@upm@SR=>WsSVe)lq>Gt?EX*Xys?9kX}t-E*<3iO%J|N&6dCMSk0` zC!KxubIq{LAGXzSW@eRo{xtulYhJs0<9g|cKNC;stSP&yc~dRxVZ^(S8Qo>`?Cq2+ z&&}HL^o*?fl==JJy|DU##e&-_=#F~N_8@7Y>yd+8>owSU@gt_l1XfA2T# zxw6#Gi%<7eY`&kh{LFQ`bLJJdnjXKqj$itTbLxTOCezgN zBSof*2{z)yU}&sd98WcA*+oG z`1bUjT9c9W?$zs^p8F57ADwCc;@|5p#y7r*REIAwigS#ebl3gP*5k<^OTpzPS+_lImIF(C0~C( z?=$z^?UpO8vbbF@JlG|`)%I#|ZOQeV#|MpB8#lITM;+-obE<`bZB56St`{yYS#P@D zty;D2-K$mApaq1?DXt}u1%y{Qu9laVLl+Q+e5%{q|9XE~-Nxl_^)J=!|5pD>@NfBx zdh0L$8P@z&zyI?;!;(LL9`awQi+}R3{G0y%_y00GelM?l{;z7;_8sxz(~I|<`4Ve4 z-G7yf)u#JZrmxCVOBxmjWUaBkdrjJA-wBIQwUbZT0zbZ0QG0g(sKe2dr;IP{=iWN` z{om~UHLZRoMd#MuxfQbGKf}~WyTdIp&riineDnK-U)N&MDL2ik%h&a0>?rA&^J7iI2;5*XzaV z8Z6|~{>=C*#M*O8c;}(U^WBM==gN^&v0#c6pxQx`qGsq z_x(PttoPl}?;R3j4(1%6`fwR$EI(`Ro_`QSesPz5 z!d<181x@M8X1$&kF@JJO+pfi%W+k1oYY#WNC)y-`{z0AN*_10RVQ1d`cr;_%RA@k*pSJ6t~q%3_jRvgWdB@IlDWV3+iYFC?myWjQOCtQm!3XTTo>FPbk_Jn z?u@*~FxKir+f^RQ2z*xqZ3PT;lbgvg?|+ z6!-E+Mcq7_Epu$Ya>Bm2g)`oC3Fn)xS-+%ctH!S_T`vyBEYE+JRk|wY*VzYeg$s@P zZkfhSc-xQ@E6kb`0$OxBuc@%V&`R zKepR!DX~_XmAg*HGC8`t;6H=MF{`(~r%swtGD|S9_v6>QN1BhF$Xs`O`%5M43V_%D;eZTH|Uq1KIy_~)Yq2(8C+Pi|UU-o>_#pJiKC3(@eiIH1n*>eT+ zp4P7VHvRQ~hTXcwSvF7i_gG(=U1Z3S>dkeOx<-|$v=My=YBMPE?YD6+q~^dMXy__?>qfIXTzD)RME@a`TLBg+U@>Z# zI%k{F)1CL+Ew5e`mOj4Tp5@~%CBNDzx6b4ZNB2JcC0bM5x$4zU@B5$p99Hj^mG}{x z^?1iR+qt!k>eG#%zFT)dDsodK^IFBs36GloGceb7US5A>=coHY3)XMjvwiuAU$d%` zOy^&;IQn$w`^5>;4(C%vL=NYy=$_3xcXPVr<=k(62OeA8_F1>gY}fXUw(PN=`lr@% zzmyK{l|J+_&$a4>*5lkQ$KK0_zkVNk_^A1@-`T7B)znH8MUKj^GunN;LwWt@?FW7Q z4^Dkredf*ejr-hp1&eoSUcUdIK{!NPWR_lVamJ*|r0a{mWiz{mU3Q5xyjLBSlNP^l z>Xv(vTOP~2UvwsBS^49?;-|`UwDuo+XvhD_^zH87()v>wKH7wG#71mro_wUqe!t0O zv5)K8&ZM87yZ+Iu(-)*I`)B+q*rfmd%=*X6-u`Kf3@_Q}r|0~MttV@KM$(ZZ?ML3v z%49#Ozh==M%ZK&8Rb8HGzxF=ev+cmY1s4x>E?=|XWu|x3bF1ddpN)I+_w2nD$JtkM z{oVaf*Me)Z=VZ=b_I~QgpFP3(iNEt7t3O(#7<)fVe{QCKM%6Ogb#KL8^*EpXy)toa z_?zC)tFd1@UX-8F6}hdYzOL(pv)OOsZNDDp8rtiAa-ZBLE>`_)>+0UT3HxUDGrRUZ z+o^iL^w*C*PMP_-p?538q@~`hYkPm@>%%{Np(kWL9)8+B*=Cs&HB-DL`~K;Y%hLjfAZ2k>mRp2ueaW@w z(W!UuM*U|Hnt$SY^rI{9L_h9+{B!!pd3%2{ZgLNh@;_*Mx97S2(`(kkQeN*CFOhz( zubB2ros3#kHrH=+=ueEPA zW4W!?Gxhs|6AF`Oul-b-TY6~SQk~+;g6A=7xBX{W*mt$XJO6aD+*OfRF3V<{Q20|!Ry4GD&NiMq%Pp7uX>onGB;&DR`W5Csd$M#^8?P>w zcBnsg{`rfH@_*7_zc8mL=Xsxq+fh0zbYADSDU&h% zpLTQVbt#Q$b!W@>9G|yl(sw=9!*9Q_On0ifdctyPU#@t3UCdH_OP|)slYEbbc#0bB z>zCDCwSPue^uIK--;*!ruiLT0{n5V8$zS6a)~Wonc=2-0zn8avPi?xX)yy)v>>J;{ zzkmJbZJA$mJN~;<;G4%P?N%Y4?5|InxUbSBqzS%C|jqcfz$f^Z8-5zpht5oWQsw{yK;*Qqq^_uKh*viLjgJoco2(hhzRp0DuDtu|`^ zXukMJ#%F#pbbF_tE_qS04!~{k6T@~*R{QRuV-AE&Ksq*`^$4%Ru6XLqbaw)c1C^=D9vV();?hJLT6^re+G{i zS2*{w&s41qj^mIn)X?b(jY~1HjajjOtF-Dn`=dXfoYP$kE6y!pAGxuX8bzRT2nEkBii+Wl#f z&u&)w&3P04j`eW*=0*1x&*-Zx$X8bTWLz42tm`%Nxh$Du+I+#`Ie(|Ad*m*vyq=Tx z()Fjyra#e-D*8I}FCN?dRAySy-^-`|Z1*fW`|8!7n#g1E0*TI{N#;(cz6YzD$M1jg zpFy?0Ec@_k`J+(PYPjiN*|E>8Y+eSc>-9 z{E4Vrx$u;J$EorY{gWS89Thd*ayaeMb*t50uUESDh6G#qUVai+T(|6}%Y}1cSIuvw zy8N4+UUXMA&t4#(Z*M@tcJ9Sd~rB|Y_&)QYlmdx2a zZQadBx6Ziibxbi2)ZMVzJTrISuJ_x5gWvn-FT0i76WRT>ro8)fs8hXU+56tDp`kYt zY;Rkh?|Zp>)uJsgA6uFgb|zl`Y+6%4IY98A;oaigfX`K51Fo-sVp;H6>E5nwMG+s9 zAMAWGxBt`M*B6`lH7-gE%l!GKoDjanW9Pl%-om-t&KdR=&UtS6uP0gJ*K^DN3|D*V zKCgXz#MXY4c|d)kM(R_myn zp$5}d$J}w))v;vDvESMI3>M$c=`nWs_$_ztl<3&Pp69A1{~6fI=UiRzr~X^M*Eyr> zKiprg`>fGYv+GuR`X-Y)PuZn~ZLf9)`)I7H+~ZRs^IRg-8SDhQO4uvc}mN%-^ahme6-%9>-{P{B5-hU-GzelDY z-MKq&#^;o2fv2ji_bEqRy7X9cM`Y-iQcbys-TQ~dtwwpJCcb=^Lt~_~x_Vtdl zccRX`n0oA$fl1$g21C|qZ(le|NZj!{JzvxE+@AbPmL@69dwWhUW)}-L_qvq3Bb{b?oe#4boas zP5XmoF1--h_-4i-0jW(|D;KM!WnG*vS16x+Yt2jPjS+zct%*;2k8`c%;EjyE zaP`#FACFY?qw6%~C+zpw?yIR+|8O6(@8{5}XrIKxCHmhyPDH#^^Sx7RG%IiBp4=N! zyFG398|plN8~pav?BwiRf#@G~Higxn)jRH%o_llhaD8C)>?M(VEAQ85nBCm6Cggfh z;g+pY%RZ`Z{IzYB<8>KDg>FjCUc}eQ<5zC{y zjn+ryZ?UfAu9~-dTds=Kj-t?TA796>|?REAp?M17qa~E}L zFFUz%+0E;@#p{ZjJJr&j7#3B&$#yfmJ*VN%-l`w}f~70|`S+KuX>3|s8C%8^8K@jp zl=ZPx>B3F5i@AQ{WzuHH!mr+2U(^UO>xBLdH=5GQTzFT%zMj2|w=^n8V_o-xU0IurZ%o<1)qQM>+}DVym3pUEtZpcp zS1NpB=T`X{j;C+s2!?o_@lBoc_tA09f}MUZ#V(rNJ{z@G*n8)cc^kaeuIhifEcKpoPk-L-?H)_F`D}{R z{_^U}(``3R#iLhWOHxUH6DGO+>|@0R50#{}{sl#axjyPNO_rBC$vW4j>|w~oye2QL zWxrmoEAEo{`ulsP;+ufRY~^6yN@6KczVCDFS@o@ z^w;!nduFzH{^>i>-}pb7mcP zb93M3I-BFgH;s&&v&D37znERN=9ZbK+1uF)voaQRRjEvy^>W>=$BiHF*`Kvw*IV?l z&f33i!DqSb=-!o=UK#Li&6ecm6l+_t%~7{-?v&U=JCD7K-(Rxm{F3?Wo;m(*=a*Tx zYo^MVsK~&%GU*b$@sd3=vbW!j+k5M7Y1Pj-hn5civTNZpdnNlyf26aS9k}=2M%%BK z@5xSX?z<}-Y&|#anN#L^J@UssyZ*0yF$*tD=2|)HuKU6*CSG0+%sLmLt$U%_|K9)D z_I3ZU{|qOp{xcZ;XArLWZd)gH=2hZbz6RwYt6B>D?ud_{XSA6%F`wKQZOy7SZbsRga>q z&);>LT6ov&M`=jG{YAT)nl|oryxkkQU~gDbyt{U-;9axx`%Nbqn)eb}}l z@n^liTub+^UT9Lpw%}{qSnN&*gqv{&@F15AEoG ztM%M3{gR9RS5q(lz)Yo9_}21}o3b(H>8vMq^ld-asPgufm&)Q=p@u`1j=r&4t9%VN z_ZF_6SO0>4!qXeeU+7gPd{*x?scb*L=Vop>-~QUKLOgdKMr?~~{>O9jjN_*`jfW`# zlO{d7aQXA}yq?=%F6<5RTOD)n>v@^cIAOixJXou2f`FZuM$74w7wms>3i&D5RZ z9rL%;zeGDQurp_#@$ZkzZl%Yhe}60=tS-j7HjVeitf#V4xl@!{CGOs^+I)TPW~cS5 z19zTrI@kJeN~xxlaQx(5ADNbfUU$n<+AAK*pCo1PzA(KmENm*}#@aRvF zs(t&u;DbKnNAbVg_s1$|ee^zkEM#TCr_Ucg@avoJ{Q5PMHKME1?Cor}&Ufo>d-$K* z7pYOTG;_|@S*52VW^DJ)cAlfXI@#;p*#^=3DY?Zrw1S%Uo$RZg!4-6@vp2JYRd8zP zjVZ!9L9O2}hlq-p;r-F90KvH(ymyo5PwX!~UNOJdyf|Q${TsW5 zZ;ZH$`!y;rt?#kfRc5zS<-V2M_I$Z{MVqyJ{Xb9M_$4}dZD7ZmYqRurU+=UmIVdg_ z_@Vuyrt!zO9@lO6LRMFbj`YUO@WlejHM@W@u^OboWKQ%w@5B&P}n_)!wwr8aIRos&ZehgWqoVYuby3W^;cN^25r&3uO8l4omcRP4DWQ6?gHh)||S1kB+u^sa$-r{B2yP$!d?~zw|ei zJ}I4W{Zojq?bb)Z0?)Zt%|2aZ@io2Lp|$Jrk296=r{6r@xNH6Ou%{2UefrZN9@9K= za`zGUR=I!icFXnMN||$tKURE8zoPW}tGwb#!_xy(SBt1n#kIB!!pMd(<0!By_IFDi3h&q=i{EnQc3taxtW zY=h!gG3MqAgDRhvZt_`u#j3YxHrrX*x+77CuPNRKv1;H}C(^&Sukh_)=+{+V>Yf-NpS%@7k_Ex^(?+bvKEfnR_MGot6T37I6x(Y+B9y$yo36 z_J1nq- z)K&Gfrk%TZ+ib1Y)DKVE=B@ha_Ot6}^b5&LcFR3puK(kC zbCy)C`FZ4QSL}P;sLVO1PJ5VcwtsdiH07=D)vK#=-{`Ac$UE3vayhNr{8OFffo1QG z^mEtw@9_J*XX)qK+dKbh`lNs96+iyE@1xX5{<_?IW@+1HKc`-{{1?0RZeQ`yk8`$} z)a@1h7^8Lk)ZXwirv!P0%ct~j#<3jPEXegX)m>xzkLif?nwzniT)ZSQQK)pcxtwEymqYrngf{=9rE zCVE}b9={v8SM7W+?0oF9y7u$L_%#zuqx-pE6!ZujUADBeWAcRDJ=tQ~f6r%c^DSDM zbw8v~Fn9H-Q`b`;KM7y%e(2q*n&vvy{S))cPAuvXMXUu+USNu@6?qW!+xoNd} z;1io){~7F~i~3f*=fe@BN_WIiCGjayER=R`t=9t>0vG_Pv6xGKDuA?*{{{oKYsmq z->ujFGOD}h@#fvdtKQ^Yk=pu_?RnPQMNNNR=cQZ6#(7=+(|xn*`T48MwtxKj;3ub> z9OL?XN;&&3e_xa%v-nir?ck@SrP4=hew#eil`PZr_*ph{>fEVo(%hC^J9dcC{Iis+ zL2akD*3a2z|4cqHM}B7I;nr)?S9X@GuQ6JEO)2oVdC{uekDJavOOt)QsQTm$9ieQS z*&Dod*FQgb#=hcf{<7EU5@!WBPTa8Z&7;J}H;x>2-|oAZmhCd9J?9AYA^DzWmkc zpSV9&ewwPj?32m&SlQ*xdseDEHTmvpXa4-C!2Ja`w9lEG`=!ZQ_ab`pEXPCE&)>)H zX|jGh=W%V}zWv5_JE|Y;@00iZ#&v4-^X1-Gwmg{=*)8(DP+jr*uislTL~`6r{H3+t zUh$c7FQ?kvJ9hisHQMvH$2^xfR#bnCed3LZUTl8uXN%VK>%9LNj4h_T z{5D53_hr!S72C=pW9P>%dv?XYw0Q2;+!mo@rWb8Zt{#u~d-_xR{W^Q89XjHVzy9%` zyZ+?UdDG%A?C<&U&*1TvHCksj*4(J+O{n90_in#<-@#uxKW&emd?mel^E&;<-&UVm zyz1Z7B6)?I-Fad6L-KztJIXu1*`@pnL%6lp(NEIPf44XNOWyPGb7bhUh;?#VTLbR? ze0}%klIu@$uIYKR{Nl_yn!VfOfRn(KRu$4k7998o!~?wPTqIP2ZTAbpvLw53x**#f@)NRc~x z%G1Khu$%S%+Qqfo4%eCl$8NbFTYkB=>~gL7b?NMVvy&}u$8J4m+`IL*(u`Yhl^8BE?Q|NzHH<3 zgllQ{+U$hwY-}c8-CO!e_{zVWz4_Ra*r_<6Sdu4`p$p4kXa+vHPxZT$x! zkF0l#D_`n7Ra^2XJL^Tu5}w?1Cp&HOSKnB(G=+it%%O?>QVdi3`_KN^aV7n2E~DkG zd4Kgk#6QWsyWMZ@?=8Qs``ui6Y|BEkC0grxzGU6_B$jpSLSA!3)D)#D+G;U7C#T(Z z)3Nyc{P;w(Ycm!q<(KvP)JhWNFDvDrVa6uHD$lHAN*(V z(vI_!`~=C5b_Z`qzLmUQ`@QnZcI#I%3q2(}?!FAR^_w5l=CuCqQk|>2=D&Kj^Sws> z;h#^<9#*i;w$FSLe{_USjIZTj=(@%n%b}a3 z9TCuU#K9$7uS8obd@l2YrTiUNCkn>jy(u{JrnE$AS#CDRjBA31Ep9Gh3?kmk&&+D= z*m(GK`0~dRXC3{H?Q5UaJ~^lR#?6SCW~Vky?3D?(Zw<=2b8ruSnW=N8WKwhS`4y=u?2uVJw#-Y>j9X{ImZ?pJ@SKAG>8 zDLW-((`&w@@lV-5f40Y2v$`GYUZ+2Kl3O1a+r+Xf<3Gb~=PRzW%Yt5*rfDha{N7yn z`@=dfx)=u;{zLR~2o2H{n}!kFTP+%(JZtXZt+Egf8#i)){(O zS|&Bl^|QGCEWKxq__M%@|y8c_gAfz`&V5y@BNqD$eRBQ?7F=- z>rFNLbw7Te8F{xZ@SI538}T{0%3@Pm%_OJH>3N>JZujeLvtNS>;On_%$IPzhmL0!r z^|t44;hc2IbH?CH5WbxJ;VKfnXmZ(0wI&YrMH&iSRZF@w)z_K$s!YBt^%L_WJzzf+8zk!?-)`t@9QHto4Jvn;M6a=Aup-0ZCV6~|1EnO>JT1{y_& z3>CiYNtXC~^PFMNbIW6f zJ?WO`ioYB)?7u(fxh2^A&vX7WIR4er{e1e<#vA&vR?-ivA2X(Jk5BvlbkeeKv$tA) zfBLxda(Yy1WYwxNv)wsUi?00Jwdm9IZoZIi(?n`Lox@E&Z_kUYGV)HlVICT$Y;++y!_S(}?Zw>c^>3;T4++f```UK%*x4Cx)|r*cx~)zu z7YsQeJLQ*I`gEc5Tf>TyB5!vl*!o9R>}fyxl8t8}89+ab+$~>62y+ zRqr`n{^X$inX74!gFZb_+dk>S+F!>1l#JF~JY2ZFEd2PB^sg_jgeksz`u*?ryl#ds zod5U|yjZt9U^s5#!2Y~;>*d((_j5}w`xbBe{eDjNx?Qh(p6716ZFvlIw3y|&;yKBn z(*gdn_+K!6z53VVQ+t#&pFGd`vYzG1L>}YbIFFLP-HuDQIr>hysw;TAn&(gborj^@ zFN#EG_D+w?{o<$ihlR>@p13fb82tb?n+cU8+g^-KUSmJEMwiv zlE8b$bt=1;yMJ4%ytDe#RppxYr**SmtyliD`jpOP;ai6;{<(d8!>jh7ZRX2u%YX9; zJ-(sK5tIMzWWxG`|k)F5F&uZfFop;^mgx*qLw({?WuN-Cpy`te#|K85ob#eZyxvS@|du95ZZJ$1=oagMxI_dfj?;mzLPLmDdbZgcM z$5gE`O1imFb-TXkgq7Fl)*s#JTf!zI7vb*#*)eOcA_qURew@UB^>eCOPoIqq67 zOERXvR|)OvJG9AY&3uoHZj)%Gmuk13>YT_>$colYIodeM|JG^)p{>RTuD^+$8r%5m z#?hbst`E{|e@qNLBXRWNr5lMp+|e2wZ8LUn)Q2XT`wQcZ*FCrww(!XV zbJs8BFXgu$JNMz|wwpP5FIbq~X2={Yvpo8%l*{c`Z05~uUH=7t_wLg5`nGw!@>0F7 zcMVxfO5N^P{##yWWmN6`c7FGaduM+BS^xghsQeC2|3cV|d|uAi~#cvZM( z)}49hZ%1kv^{S@a-hEr{t@uTi9r5w4k2w!#UY-AG_nmNEugqr`4K(lFy_za{dF$l5 z?(oXK9=}qL{|r}l`Y!sBb3b(c37 zb3)a<>lu~v+BPnYjz8@C(eiek{+`1(wtp3|jT64`ukq!ZH`_F_-Ztsod$iqc#i2)f z3zHw>dv~ob-}eu$F5HoGi_=+ zz$jt3Sgdg2ZtZuI=hmf`m*s4>{;fTu__@rZTSCd4x3<2{mJ0Dn{+5}yTyQSO&yr&k zTBk+^9bxHMQ?rJ_==9SPJLem_za2lLe(ZUZP}(c!DV3db&Yx6YeCg(vKBZXeW&6uL zKJSsfuK9XNb^n!k(`iM|Y)eJ19#*&fwS1dUxKG5M4~eT|tZu%OR&1ZWaB=M2haw+d zr=486YnS=W`t6^~oLxf#eTB~b^ba+^Uz6Rt?OgG5l|^3*e}1@Lp166+6H~MI|E6xA zc(YD_!|$*6@}%{-4+mTnmD*+%fKlOXhnH=9#we0%ttX5l1 z>;2}7jh+`?&an1MUS79+#VxJSnLDL6NoCIPU{x*Ny>fa_?2e32mXoioE?w>ZPd5HY zx?s)RR{{UBUIg6LJNGNi>*xi=z0;rGn7!mlYwxp9#_v^gF5a7*YxJ{n`K!E7f$sbw zr=MG=rrXcl|GDqBLRwfr*jj0g8~GJnD|%MFlsux5Z&oEJ&$8jqz4!WNmTPwirL`wyYVV|JdUezGuX6r%EWXS9_q<>F z|0dM&|GUbJ#%Is2Fgf#?7-fQ1OYGOA{#abU^Zla#3@_Oq{AYL@koeFc`x$p*zuqn>`Il9l-G8U- zdh;};*z(ZYSO^gtTmCyXHuUO$hU``Q?=8=IxBJz*-K$r>`t@%8_tpOyO8+xd{rkK^ z{HLD1)qjS2#{VYU+5Bh7Q2aApes2AH$^Q(V^X2Nd2;Tm}cg~BWPWt}gr*Hd}e(!z0 zYVYTR5}zXS9M7efJnEGxxo3Jw#_!ATWyVp3dR;Qh7sYMs^jqy)oP7MbpQ?Q8{d31P zC3n5rR6Irh9^-nyYp?udo@tAI{MoOiSrYn0=lb$wiTg_W=F+7SH?Q(mHEJ(h73*{2 z)E4XHBRw;>o-WpTlYjlynVthvBN`?w$uzsgth}rGi>zp{jSGX3ufd>LcSx`MA;7~K zY}&7FuXlW~`u<_}u5WhXM_0`cHT?;f4h1pPRjh%wAsm}hQH>o zoAq2e_sg-u$xnVc?+mFq`TXC-7v0ZZW&1s@ALP( ziqZKnoiD%At#=jl%{W%Pk>@_+hRty^J{RrRjO+2_-oA40?7|n*+{!HXnol_{^T>4f zov+SwKJs~Y%4q-LdH#`C`?TNAWY)#9Z;Fjx`$U9JnRMN~;uXV}&84hemybO?xj6bv z&8xX5_B&ae@eGwZ*?%*l(w61CVOY$a;6l*tN2pCuY0lOgIB3Ys)2G zJ@G2>uKapC(fwTAOJ~cjo_J(}U|{CeNhKMz((}H0J+|&Q*n7Fk*3Df$;&&+DMb7+n zcE@io`_B+oJoWh{!@iB*G?)En2$9YIbN9>bUuMUO&vc#pbMZ^seUZJ*C+=(5Bu?A1 z>+j|ZU*}u>p4J`V|IIge*T>g?WKO^My>-`)!yHG?lck#CLqNlU3m=s+-6rKD%XVwYLMYD4I@6Ihd zR`^$Cy3?QXtszcYPf81;F1h;X+}@mac#rcfC8nzxk1PG`gQC10Z*KOh_KkB&R(fc2 zD|qJp`l-jYryTjk9g%gS>RaLamnrTEZ)ShU^uDH35ach`pDVWCsrCRP=M8Y%a0C!D ztS`&@xp!9nXV_4hVKH}&n3XHjQN!T%8S`GfP2BP7VAz!(yutn!!8K=Z-f=nlIOIRW z{P|b^GZ;(We%Z8kzs~tz{Kwxfw37<_#BK8S-ru+X+Rhelyb(4%YAp>Oi+*k0^Tp&(x>9;;%mpRITL%})&u*OR@WMLzhJDxT{wpPgzuhK( zT>e;d^`F@xpIc`czOuF5b#}7vxl(_tMc*slEp?gTse9$ve}>v(SJQJly>rdx%h=T` zJ`jxkA+K7q>^J{j@gp_iozLu?cPr)nSsD2=>Xc2oiipYFRaa+5Gaj7F=vyD7Z}D4n z>a#~%QjW2xdzWi|^4$}D+~V0wE5p_M%-tT|?P$AjMdI~Ws~aB{%za{`e(YCht@^&h zD}(;#URoNOZ<#Rb_0=$QF4L%k>k6K#)%eeiGBl5UGWFEyo>%u)J=$^8dQ+!yx_R#Q zo9m?aZnWx>KRo|M+}vxK`xWmrT`t@Dr7!SleQlYZ{d4QsbER*WW%euOYyG?;D*nUY z;NjJ#JhMeN#bzI|m{s)laKy=F8_&+oJGwYU+PnY6^yQ2Gq&~bKSe55n_G0x(i>Jp9 z#=D;Gje4nC8fWU!rJ|Lc{(5eVZ%j(UquY;T%kHPnec4-ju5O0X_75Kmcf|AmasB!1 z>WwF#Su4KQe(cZQdg6rXv}$e3sxN0Z@ohc%=+2_Mn{TQvP19Z-5VbSZ#Wd&W;q9A@ zvP}~1etxp{vEJR~Pr{TGXWIDlAJevS+MECUpX(={zDFT*9{+NW+Ht?PSR+^?KagKV za(aq&gigDHox~3(W3!BU^Zl_q{?uGQT2RCG;A!vK7p{@sMMw=UfNfc^FTFIhhL|NHEF?(6Zb5C639)%VOd`R#up>h6{q zH$`pwpGDtaWU}U&yw1jL(|v+ULcPv?im2{g`01zpCTHHbe_=mv?z{Eer+$5?&wmEC z^Jm%rO2)qb_af0VFxaZldbvs7xu&({?xmUQS=a3etzVF{qVL$Mvpu^%?d4s)K0Zsd zY{9ONoA;;2#{2F!w(I!MaBJZQu3ax2>R#EezW%iM5A)yZe-r#!{xiHcsSjU&>iG}$ zU*G>K%;Wsea4+NE-caK|()K3uUsB8W|6YK~U0AXz`#;0^^vGB1?fL&Rtj^ynJjL^a z-^`NdHP5)7o=nmED*a|IcXoTm!fVSE`Yq4T*chvZiru2YmAg3h9O`_U zlhgn3i>FGRWSxDfr^%)3d5Vj6XU&`SvUh6K{fy91vtv7s87*3syQwRG{`35OxAV6Z zZ!4bjp?`+P@p<=u7=C@SH-1)WSIX4w=ku-hs2jhI`Q<x*=mO@}2fnRIR`K6zGT z#`*{mw;9`hbe1ktDfKKVnkQVaY{vEbe=NZu@J8wLk4Ln;=l5+TfE>RaequCVAJl-%Ks{wY`%6Qch)csoCY&?T)ciH!t4Q@qSKv%9K-D ztEQD-wt73|O0duKxA$|>O6+WOi^BIaS1fvNxU1`QRL#QYCvU2T28T`!{W4#3m37Ig zRj(#Vtyt8pz3=z?mf&NzbLae>^|!8tbcfaTl0yZE8d=$Ezs{w=zDyn5a0Rom3o{ob`Q-Nd|R`=L{-PBlNQSK6#-_tNP< z!}N}2GeqK--H9}f%4y#>;l1>#P4Dd)I8Gj5aABbHDRd44Vx@rj$IOp^U+m+5cYhjx zZdI4wcFDA_*DF&ckIZ(8e4NWy`oP3|@~x1iDx!VA|1%`5HsyP??EE+3w-={mZcWd> zZj|4%{buA7_JHu&!Djj|-#pr0C>I`k>C-2xAA6&E>$i5F+p#q5TY2)2S!G%W)*i}! z{Q8qom|E$Jf2z$>v{tQGv+oUiaB8#m>ix&r-u>AW@nd4v$=+#ooT{5N{$>5qys*!$ z&erPrjGaDzT+|(A&w9Q+>T@*{14N?~*)Y!{>VL&&AfNzO>1^n*My6_uARZkA=lw%-&pl z|0wIF{|x6IRbIDRyMJo6XP4JwYx9&%XIvuE5?7pCQFtc3{D#oE)S3A~zrOCDAQ#fG zYQMjd#O99=*Lc+U%vf{N_*!A6VWiyp(SE=|xfj!quJ03)-nIGQ&WDS` z+<5P{E`9F9{-a}Fi|x)W(wi?$TforrhJnT3%geImNcE4IVYyF~RV8=zO-%TxE1vPQ z`HFeY+u2J*j-6a{_jGB9Ys&WPRvPnuXKpj@dCsC$@%!Yx<{vYh*MD3mdPa3``orJ$ zPFuh36F;Y6_Ak}@i~oGpb?;3lZ!J=LQyqGG>ZiEYGvzaG9@*-2;`Qnfoe$EMrQ-VB z_N#k*Rm~Y5{h4&#(ly)GQlD?tDsEXz+gDe%TJ?CpmAbH2@|GOGGGiO%KNocvZLnCy0b`HdUc+!mC+9UlfJ=wdUQ{ox#F}v@FRc9Prk4FXYJm< ze&xqG*{AoJZ+d_A$MWehk*lwtn|}HCr;`eE+&$k1i##{3xwnz=T#$2Y<`*g5{R`6K ze9JEdUpw~koOwf3mV?gX59ju*7K{>mYqf`c_qOaC4pCbzPMz$#@X)WMTEg|!$?0+; zK^v1!&oxl|T$qs0Vxd^FDKI-oL|;6@YNNKbIW|8D{S+$kF% diff --git a/doc/src/Eqs/pair_kolmogorov_crespi_full.tex b/doc/src/Eqs/pair_kolmogorov_crespi_full.tex index 606aa8b5fe..16bbc25abf 100644 --- a/doc/src/Eqs/pair_kolmogorov_crespi_full.tex +++ b/doc/src/Eqs/pair_kolmogorov_crespi_full.tex @@ -27,7 +27,7 @@ V_{ij} & = & e^{-\lambda (r_{ij} -z_0)} \left [ C + f(\rho_{ij}) + f(\rho_{ji}) - A \left ( \frac{r_{ij}}{z_0}\right )^{-6} \right ] \\ \rho_{ij}^2 & = & r_{ij}^2 - ({\bf r}_{ij}\cdot {\bf n}_{i})^2 \\[15pt] \rho_{ji}^2 & = & r_{ij}^2 - ({\bf r}_{ij}\cdot {\bf n}_{j})^2 \\[15pt] - f(\rho) & = & e^{-(\rho/\delta)^2} \sum_{n=0}^2 C_{2n} { \rho/\delta }^{2n} + f(\rho) & = & e^{-(\rho/\delta)^2} \sum_{n=0}^2 C_{2n} { (\rho/\delta) }^{2n} \end{eqnarray*} \endgroup \end{document} diff --git a/doc/src/pair_coul_shield.txt b/doc/src/pair_coul_shield.txt index df04e76de9..8152a1a12e 100644 --- a/doc/src/pair_coul_shield.txt +++ b/doc/src/pair_coul_shield.txt @@ -13,7 +13,7 @@ pair_style coul/shield command :h3 pair_style coul/shield cutoff tap_flag :pre cutoff = global cutoff (distance units) -tap_flag = 0/1 to turn off/on the taper function +tap_flag = 0/1 to turn off/on the taper function :ul [Examples:] diff --git a/doc/src/pair_ilp_graphene_hbn.txt b/doc/src/pair_ilp_graphene_hbn.txt index 4dd244c17f..0e8ac5e9c5 100644 --- a/doc/src/pair_ilp_graphene_hbn.txt +++ b/doc/src/pair_ilp_graphene_hbn.txt @@ -13,17 +13,17 @@ pair_style ilp/graphene/hbn command :h3 pair_style \[hybrid/overlay ...\] ilp/graphene/hbn cutoff tap_flag :pre cutoff = global cutoff (distance units) -tap_flag = 0/1 to turn off/on the taper function +tap_flag = 0/1 to turn off/on the taper function :ul [Examples:] -pair_style hybrid/overlay ilp/graphene/hbn 16.0 1 -pair_coeff * * ilp/graphene/hbn BNCH.ILP B N C :pre +pair_style hybrid/overlay ilp/graphene/hbn 16.0 1 +pair_coeff * * ilp/graphene/hbn ../potentials/BNCH.ILP B N C :pre pair_style hybrid/overlay rebo tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 -pair_coeff * * rebo CH.rebo NULL NULL C -pair_coeff * * tersoff BNC.tersoff B N NULL -pair_coeff * * ilp/graphene/hbn BNCH.ILP B N C +pair_coeff * * rebo ../potentials/CH.rebo NULL NULL C +pair_coeff * * tersoff ../potentials/BNC.tersoff B N NULL +pair_coeff * * ilp/graphene/hbn ../potentials/BNCH.ILP B N C pair_coeff 1 1 coul/shield 0.70 pair_coeff 1 2 coul/shield 0.695 pair_coeff 2 2 coul/shield 0.69 :pre @@ -85,6 +85,22 @@ be found in "(Ouyang)"_#Ouyang. This potential must be used in combination with hybrid/overlay. Other interactions can be set to zero using pair_style {none}. +This pair style tallies a breakdown of the total interlayer potential +energy into sub-categories, which can be accessed via the "compute +pair"_compute_pair.html command as a vector of values of length 2. +The 2 values correspond to the following sub-categories: + +{E_vdW} = vdW (attractive) energy +{E_Rep} = Repulsive energy :ol + +To print these quantities to the log file (with descriptive column +headings) the following commands could be included in an input script: + +compute 0 all pair ilp/graphene/hbn +variable Evdw equal c_0\[1\] +variable Erep equal c_0\[2\] +thermo_style custom step temp epair v_Erep v_Evdw :pre + :line [Mixing, shift, table, tail correction, restart, rRESPA info]: diff --git a/doc/src/pair_kolmogorov_crespi_full.txt b/doc/src/pair_kolmogorov_crespi_full.txt index 9ad5bfea84..bfadc33e30 100644 --- a/doc/src/pair_kolmogorov_crespi_full.txt +++ b/doc/src/pair_kolmogorov_crespi_full.txt @@ -13,17 +13,17 @@ pair_style kolmogorov/crespi/full command :h3 pair_style hybrid/overlay kolmogorov/crespi/full cutoff tap_flag :pre cutoff = global cutoff (distance units) -tap_flag = 0/1 to turn off/on the taper function +tap_flag = 0/1 to turn off/on the taper function :ul [Examples:] pair_style hybrid/overlay kolmogorov/crespi/full 20.0 0 pair_coeff * * none -pair_coeff * * kolmogorov/crespi/full CH.KC C C :pre +pair_coeff * * kolmogorov/crespi/full ../potentials/CH.KC C C :pre pair_style hybrid/overlay rebo kolmogorov/crespi/full 16.0 1 -pair_coeff * * rebo CH.rebo C H -pair_coeff * * kolmogorov/crespi/full CH_taper.KC C H :pre +pair_coeff * * rebo ../potentials/CH.rebo C H +pair_coeff * * kolmogorov/crespi/full ../potentials/CH_taper.KC C H :pre [Description:] @@ -74,6 +74,22 @@ comparison of these parameters can be found in "(Ouyang)"_#Ouyang1. This potential must be used in combination with hybrid/overlay. Other interactions can be set to zero using pair_style {none}. +This pair style tallies a breakdown of the total interlayer potential +energy into sub-categories, which can be accessed via the "compute +pair"_compute_pair.html command as a vector of values of length 2. +The 2 values correspond to the following sub-categories: + +{E_vdW} = vdW (attractive) energy +{E_Rep} = Repulsive energy :ol + +To print these quantities to the log file (with descriptive column +headings) the following commands could be included in an input script: + +compute 0 all pair kolmogorov/crespi/full +variable Evdw equal c_0\[1\] +variable Erep equal c_0\[2\] +thermo_style custom step temp epair v_Erep v_Evdw :pre + :line [Mixing, shift, table, tail correction, restart, rRESPA info]: diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP new file mode 120000 index 0000000000..b970e23f95 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP @@ -0,0 +1 @@ +../../../../../potentials/BNCH.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH.data b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH.data new file mode 100644 index 0000000000..756123a6f1 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH.data @@ -0,0 +1,1372 @@ + Generate Bi-layer graphene + + 1360 atoms + + 2 atom types + + 0.000000000000000 42.599999999999994 xlo xhi + 0.000000000000000 41.811706494712695 ylo yhi + 0.000000000000000 100.000000000000000 zlo zhi + + Atoms + + 1 1 1 0.000000000000000 0.000000000000000 1.229756073373903 0.000000000000000 + 2 1 1 0.000000000000000 0.710000000000000 0.000000000000000 0.000000000000000 + 3 1 1 0.000000000000000 2.130000000000000 0.000000000000000 0.000000000000000 + 4 1 1 0.000000000000000 2.840000000000000 1.229756073373903 0.000000000000000 + 5 1 1 0.000000000000000 4.260000000000000 1.229756073373903 0.000000000000000 + 6 1 1 0.000000000000000 4.970000000000000 0.000000000000000 0.000000000000000 + 7 1 1 0.000000000000000 6.390000000000000 0.000000000000000 0.000000000000000 + 8 1 1 0.000000000000000 7.100000000000000 1.229756073373903 0.000000000000000 + 9 1 1 0.000000000000000 8.520000000000000 1.229756073373903 0.000000000000000 + 10 1 1 0.000000000000000 9.230000000000000 0.000000000000000 0.000000000000000 + 11 1 1 0.000000000000000 10.649999999999999 0.000000000000000 0.000000000000000 + 12 1 1 0.000000000000000 11.359999999999999 1.229756073373903 0.000000000000000 + 13 1 1 0.000000000000000 12.779999999999999 1.229756073373903 0.000000000000000 + 14 1 1 0.000000000000000 13.489999999999998 0.000000000000000 0.000000000000000 + 15 1 1 0.000000000000000 14.910000000000000 0.000000000000000 0.000000000000000 + 16 1 1 0.000000000000000 15.619999999999999 1.229756073373903 0.000000000000000 + 17 1 1 0.000000000000000 17.039999999999999 1.229756073373903 0.000000000000000 + 18 1 1 0.000000000000000 17.750000000000000 0.000000000000000 0.000000000000000 + 19 1 1 0.000000000000000 19.169999999999998 0.000000000000000 0.000000000000000 + 20 1 1 0.000000000000000 19.879999999999999 1.229756073373903 0.000000000000000 + 21 1 1 0.000000000000000 21.299999999999997 1.229756073373903 0.000000000000000 + 22 1 1 0.000000000000000 22.009999999999998 0.000000000000000 0.000000000000000 + 23 1 1 0.000000000000000 23.429999999999996 0.000000000000000 0.000000000000000 + 24 1 1 0.000000000000000 24.139999999999997 1.229756073373903 0.000000000000000 + 25 1 1 0.000000000000000 25.559999999999999 1.229756073373903 0.000000000000000 + 26 1 1 0.000000000000000 26.270000000000000 0.000000000000000 0.000000000000000 + 27 1 1 0.000000000000000 27.689999999999998 0.000000000000000 0.000000000000000 + 28 1 1 0.000000000000000 28.399999999999999 1.229756073373903 0.000000000000000 + 29 1 1 0.000000000000000 29.820000000000000 1.229756073373903 0.000000000000000 + 30 1 1 0.000000000000000 30.530000000000001 0.000000000000000 0.000000000000000 + 31 1 1 0.000000000000000 31.949999999999999 0.000000000000000 0.000000000000000 + 32 1 1 0.000000000000000 32.659999999999997 1.229756073373903 0.000000000000000 + 33 1 1 0.000000000000000 34.079999999999998 1.229756073373903 0.000000000000000 + 34 1 1 0.000000000000000 34.789999999999999 0.000000000000000 0.000000000000000 + 35 1 1 0.000000000000000 36.210000000000001 0.000000000000000 0.000000000000000 + 36 1 1 0.000000000000000 36.920000000000002 1.229756073373903 0.000000000000000 + 37 1 1 0.000000000000000 38.339999999999996 1.229756073373903 0.000000000000000 + 38 1 1 0.000000000000000 39.049999999999997 0.000000000000000 0.000000000000000 + 39 1 1 0.000000000000000 40.469999999999999 0.000000000000000 0.000000000000000 + 40 1 1 0.000000000000000 41.179999999999993 1.229756073373903 0.000000000000000 + 41 1 1 0.000000000000000 0.000000000000000 3.689268220121709 0.000000000000000 + 42 1 1 0.000000000000000 0.710000000000000 2.459512146747806 0.000000000000000 + 43 1 1 0.000000000000000 2.130000000000000 2.459512146747806 0.000000000000000 + 44 1 1 0.000000000000000 2.840000000000000 3.689268220121709 0.000000000000000 + 45 1 1 0.000000000000000 4.260000000000000 3.689268220121709 0.000000000000000 + 46 1 1 0.000000000000000 4.970000000000000 2.459512146747806 0.000000000000000 + 47 1 1 0.000000000000000 6.390000000000000 2.459512146747806 0.000000000000000 + 48 1 1 0.000000000000000 7.100000000000000 3.689268220121709 0.000000000000000 + 49 1 1 0.000000000000000 8.520000000000000 3.689268220121709 0.000000000000000 + 50 1 1 0.000000000000000 9.230000000000000 2.459512146747806 0.000000000000000 + 51 1 1 0.000000000000000 10.649999999999999 2.459512146747806 0.000000000000000 + 52 1 1 0.000000000000000 11.359999999999999 3.689268220121709 0.000000000000000 + 53 1 1 0.000000000000000 12.779999999999999 3.689268220121709 0.000000000000000 + 54 1 1 0.000000000000000 13.489999999999998 2.459512146747806 0.000000000000000 + 55 1 1 0.000000000000000 14.910000000000000 2.459512146747806 0.000000000000000 + 56 1 1 0.000000000000000 15.619999999999999 3.689268220121709 0.000000000000000 + 57 1 1 0.000000000000000 17.039999999999999 3.689268220121709 0.000000000000000 + 58 1 1 0.000000000000000 17.750000000000000 2.459512146747806 0.000000000000000 + 59 1 1 0.000000000000000 19.169999999999998 2.459512146747806 0.000000000000000 + 60 1 1 0.000000000000000 19.879999999999999 3.689268220121709 0.000000000000000 + 61 1 1 0.000000000000000 21.299999999999997 3.689268220121709 0.000000000000000 + 62 1 1 0.000000000000000 22.009999999999998 2.459512146747806 0.000000000000000 + 63 1 1 0.000000000000000 23.429999999999996 2.459512146747806 0.000000000000000 + 64 1 1 0.000000000000000 24.139999999999997 3.689268220121709 0.000000000000000 + 65 1 1 0.000000000000000 25.559999999999999 3.689268220121709 0.000000000000000 + 66 1 1 0.000000000000000 26.270000000000000 2.459512146747806 0.000000000000000 + 67 1 1 0.000000000000000 27.689999999999998 2.459512146747806 0.000000000000000 + 68 1 1 0.000000000000000 28.399999999999999 3.689268220121709 0.000000000000000 + 69 1 1 0.000000000000000 29.820000000000000 3.689268220121709 0.000000000000000 + 70 1 1 0.000000000000000 30.530000000000001 2.459512146747806 0.000000000000000 + 71 1 1 0.000000000000000 31.949999999999999 2.459512146747806 0.000000000000000 + 72 1 1 0.000000000000000 32.659999999999997 3.689268220121709 0.000000000000000 + 73 1 1 0.000000000000000 34.079999999999998 3.689268220121709 0.000000000000000 + 74 1 1 0.000000000000000 34.789999999999999 2.459512146747806 0.000000000000000 + 75 1 1 0.000000000000000 36.210000000000001 2.459512146747806 0.000000000000000 + 76 1 1 0.000000000000000 36.920000000000002 3.689268220121709 0.000000000000000 + 77 1 1 0.000000000000000 38.339999999999996 3.689268220121709 0.000000000000000 + 78 1 1 0.000000000000000 39.049999999999997 2.459512146747806 0.000000000000000 + 79 1 1 0.000000000000000 40.469999999999999 2.459512146747806 0.000000000000000 + 80 1 1 0.000000000000000 41.179999999999993 3.689268220121709 0.000000000000000 + 81 1 1 0.000000000000000 0.000000000000000 6.148780366869514 0.000000000000000 + 82 1 1 0.000000000000000 0.710000000000000 4.919024293495611 0.000000000000000 + 83 1 1 0.000000000000000 2.130000000000000 4.919024293495611 0.000000000000000 + 84 1 1 0.000000000000000 2.840000000000000 6.148780366869514 0.000000000000000 + 85 1 1 0.000000000000000 4.260000000000000 6.148780366869514 0.000000000000000 + 86 1 1 0.000000000000000 4.970000000000000 4.919024293495611 0.000000000000000 + 87 1 1 0.000000000000000 6.390000000000000 4.919024293495611 0.000000000000000 + 88 1 1 0.000000000000000 7.100000000000000 6.148780366869514 0.000000000000000 + 89 1 1 0.000000000000000 8.520000000000000 6.148780366869514 0.000000000000000 + 90 1 1 0.000000000000000 9.230000000000000 4.919024293495611 0.000000000000000 + 91 1 1 0.000000000000000 10.649999999999999 4.919024293495611 0.000000000000000 + 92 1 1 0.000000000000000 11.359999999999999 6.148780366869514 0.000000000000000 + 93 1 1 0.000000000000000 12.779999999999999 6.148780366869514 0.000000000000000 + 94 1 1 0.000000000000000 13.489999999999998 4.919024293495611 0.000000000000000 + 95 1 1 0.000000000000000 14.910000000000000 4.919024293495611 0.000000000000000 + 96 1 1 0.000000000000000 15.619999999999999 6.148780366869514 0.000000000000000 + 97 1 1 0.000000000000000 17.039999999999999 6.148780366869514 0.000000000000000 + 98 1 1 0.000000000000000 17.750000000000000 4.919024293495611 0.000000000000000 + 99 1 1 0.000000000000000 19.169999999999998 4.919024293495611 0.000000000000000 + 100 1 1 0.000000000000000 19.879999999999999 6.148780366869514 0.000000000000000 + 101 1 1 0.000000000000000 21.299999999999997 6.148780366869514 0.000000000000000 + 102 1 1 0.000000000000000 22.009999999999998 4.919024293495611 0.000000000000000 + 103 1 1 0.000000000000000 23.429999999999996 4.919024293495611 0.000000000000000 + 104 1 1 0.000000000000000 24.139999999999997 6.148780366869514 0.000000000000000 + 105 1 1 0.000000000000000 25.559999999999999 6.148780366869514 0.000000000000000 + 106 1 1 0.000000000000000 26.270000000000000 4.919024293495611 0.000000000000000 + 107 1 1 0.000000000000000 27.689999999999998 4.919024293495611 0.000000000000000 + 108 1 1 0.000000000000000 28.399999999999999 6.148780366869514 0.000000000000000 + 109 1 1 0.000000000000000 29.820000000000000 6.148780366869514 0.000000000000000 + 110 1 1 0.000000000000000 30.530000000000001 4.919024293495611 0.000000000000000 + 111 1 1 0.000000000000000 31.949999999999999 4.919024293495611 0.000000000000000 + 112 1 1 0.000000000000000 32.659999999999997 6.148780366869514 0.000000000000000 + 113 1 1 0.000000000000000 34.079999999999998 6.148780366869514 0.000000000000000 + 114 1 1 0.000000000000000 34.789999999999999 4.919024293495611 0.000000000000000 + 115 1 1 0.000000000000000 36.210000000000001 4.919024293495611 0.000000000000000 + 116 1 1 0.000000000000000 36.920000000000002 6.148780366869514 0.000000000000000 + 117 1 1 0.000000000000000 38.339999999999996 6.148780366869514 0.000000000000000 + 118 1 1 0.000000000000000 39.049999999999997 4.919024293495611 0.000000000000000 + 119 1 1 0.000000000000000 40.469999999999999 4.919024293495611 0.000000000000000 + 120 1 1 0.000000000000000 41.179999999999993 6.148780366869514 0.000000000000000 + 121 1 1 0.000000000000000 0.000000000000000 8.608292513617320 0.000000000000000 + 122 1 1 0.000000000000000 0.710000000000000 7.378536440243417 0.000000000000000 + 123 1 1 0.000000000000000 2.130000000000000 7.378536440243417 0.000000000000000 + 124 1 1 0.000000000000000 2.840000000000000 8.608292513617320 0.000000000000000 + 125 1 1 0.000000000000000 4.260000000000000 8.608292513617320 0.000000000000000 + 126 1 1 0.000000000000000 4.970000000000000 7.378536440243417 0.000000000000000 + 127 1 1 0.000000000000000 6.390000000000000 7.378536440243417 0.000000000000000 + 128 1 1 0.000000000000000 7.100000000000000 8.608292513617320 0.000000000000000 + 129 1 1 0.000000000000000 8.520000000000000 8.608292513617320 0.000000000000000 + 130 1 1 0.000000000000000 9.230000000000000 7.378536440243417 0.000000000000000 + 131 1 1 0.000000000000000 10.649999999999999 7.378536440243417 0.000000000000000 + 132 1 1 0.000000000000000 11.359999999999999 8.608292513617320 0.000000000000000 + 133 1 1 0.000000000000000 12.779999999999999 8.608292513617320 0.000000000000000 + 134 1 1 0.000000000000000 13.489999999999998 7.378536440243417 0.000000000000000 + 135 1 1 0.000000000000000 14.910000000000000 7.378536440243417 0.000000000000000 + 136 1 1 0.000000000000000 15.619999999999999 8.608292513617320 0.000000000000000 + 137 1 1 0.000000000000000 17.039999999999999 8.608292513617320 0.000000000000000 + 138 1 1 0.000000000000000 17.750000000000000 7.378536440243417 0.000000000000000 + 139 1 1 0.000000000000000 19.169999999999998 7.378536440243417 0.000000000000000 + 140 1 1 0.000000000000000 19.879999999999999 8.608292513617320 0.000000000000000 + 141 1 1 0.000000000000000 21.299999999999997 8.608292513617320 0.000000000000000 + 142 1 1 0.000000000000000 22.009999999999998 7.378536440243417 0.000000000000000 + 143 1 1 0.000000000000000 23.429999999999996 7.378536440243417 0.000000000000000 + 144 1 1 0.000000000000000 24.139999999999997 8.608292513617320 0.000000000000000 + 145 1 1 0.000000000000000 25.559999999999999 8.608292513617320 0.000000000000000 + 146 1 1 0.000000000000000 26.270000000000000 7.378536440243417 0.000000000000000 + 147 1 1 0.000000000000000 27.689999999999998 7.378536440243417 0.000000000000000 + 148 1 1 0.000000000000000 28.399999999999999 8.608292513617320 0.000000000000000 + 149 1 1 0.000000000000000 29.820000000000000 8.608292513617320 0.000000000000000 + 150 1 1 0.000000000000000 30.530000000000001 7.378536440243417 0.000000000000000 + 151 1 1 0.000000000000000 31.949999999999999 7.378536440243417 0.000000000000000 + 152 1 1 0.000000000000000 32.659999999999997 8.608292513617320 0.000000000000000 + 153 1 1 0.000000000000000 34.079999999999998 8.608292513617320 0.000000000000000 + 154 1 1 0.000000000000000 34.789999999999999 7.378536440243417 0.000000000000000 + 155 1 1 0.000000000000000 36.210000000000001 7.378536440243417 0.000000000000000 + 156 1 1 0.000000000000000 36.920000000000002 8.608292513617320 0.000000000000000 + 157 1 1 0.000000000000000 38.339999999999996 8.608292513617320 0.000000000000000 + 158 1 1 0.000000000000000 39.049999999999997 7.378536440243417 0.000000000000000 + 159 1 1 0.000000000000000 40.469999999999999 7.378536440243417 0.000000000000000 + 160 1 1 0.000000000000000 41.179999999999993 8.608292513617320 0.000000000000000 + 161 1 1 0.000000000000000 0.000000000000000 11.067804660365125 0.000000000000000 + 162 1 1 0.000000000000000 0.710000000000000 9.838048586991222 0.000000000000000 + 163 1 1 0.000000000000000 2.130000000000000 9.838048586991222 0.000000000000000 + 164 1 1 0.000000000000000 2.840000000000000 11.067804660365125 0.000000000000000 + 165 1 1 0.000000000000000 4.260000000000000 11.067804660365125 0.000000000000000 + 166 1 1 0.000000000000000 4.970000000000000 9.838048586991222 0.000000000000000 + 167 1 1 0.000000000000000 6.390000000000000 9.838048586991222 0.000000000000000 + 168 1 1 0.000000000000000 7.100000000000000 11.067804660365125 0.000000000000000 + 169 1 1 0.000000000000000 8.520000000000000 11.067804660365125 0.000000000000000 + 170 1 1 0.000000000000000 9.230000000000000 9.838048586991222 0.000000000000000 + 171 1 1 0.000000000000000 10.649999999999999 9.838048586991222 0.000000000000000 + 172 1 1 0.000000000000000 11.359999999999999 11.067804660365125 0.000000000000000 + 173 1 1 0.000000000000000 12.779999999999999 11.067804660365125 0.000000000000000 + 174 1 1 0.000000000000000 13.489999999999998 9.838048586991222 0.000000000000000 + 175 1 1 0.000000000000000 14.910000000000000 9.838048586991222 0.000000000000000 + 176 1 1 0.000000000000000 15.619999999999999 11.067804660365125 0.000000000000000 + 177 1 1 0.000000000000000 17.039999999999999 11.067804660365125 0.000000000000000 + 178 1 1 0.000000000000000 17.750000000000000 9.838048586991222 0.000000000000000 + 179 1 1 0.000000000000000 19.169999999999998 9.838048586991222 0.000000000000000 + 180 1 1 0.000000000000000 19.879999999999999 11.067804660365125 0.000000000000000 + 181 1 1 0.000000000000000 21.299999999999997 11.067804660365125 0.000000000000000 + 182 1 1 0.000000000000000 22.009999999999998 9.838048586991222 0.000000000000000 + 183 1 1 0.000000000000000 23.429999999999996 9.838048586991222 0.000000000000000 + 184 1 1 0.000000000000000 24.139999999999997 11.067804660365125 0.000000000000000 + 185 1 1 0.000000000000000 25.559999999999999 11.067804660365125 0.000000000000000 + 186 1 1 0.000000000000000 26.270000000000000 9.838048586991222 0.000000000000000 + 187 1 1 0.000000000000000 27.689999999999998 9.838048586991222 0.000000000000000 + 188 1 1 0.000000000000000 28.399999999999999 11.067804660365125 0.000000000000000 + 189 1 1 0.000000000000000 29.820000000000000 11.067804660365125 0.000000000000000 + 190 1 1 0.000000000000000 30.530000000000001 9.838048586991222 0.000000000000000 + 191 1 1 0.000000000000000 31.949999999999999 9.838048586991222 0.000000000000000 + 192 1 1 0.000000000000000 32.659999999999997 11.067804660365125 0.000000000000000 + 193 1 1 0.000000000000000 34.079999999999998 11.067804660365125 0.000000000000000 + 194 1 1 0.000000000000000 34.789999999999999 9.838048586991222 0.000000000000000 + 195 1 1 0.000000000000000 36.210000000000001 9.838048586991222 0.000000000000000 + 196 1 1 0.000000000000000 36.920000000000002 11.067804660365125 0.000000000000000 + 197 1 1 0.000000000000000 38.339999999999996 11.067804660365125 0.000000000000000 + 198 1 1 0.000000000000000 39.049999999999997 9.838048586991222 0.000000000000000 + 199 1 1 0.000000000000000 40.469999999999999 9.838048586991222 0.000000000000000 + 200 1 1 0.000000000000000 41.179999999999993 11.067804660365125 0.000000000000000 + 201 1 1 0.000000000000000 0.000000000000000 13.527316807112930 0.000000000000000 + 202 1 1 0.000000000000000 0.710000000000000 12.297560733739028 0.000000000000000 + 203 1 1 0.000000000000000 2.130000000000000 12.297560733739028 0.000000000000000 + 204 1 1 0.000000000000000 2.840000000000000 13.527316807112930 0.000000000000000 + 205 1 1 0.000000000000000 4.260000000000000 13.527316807112930 0.000000000000000 + 206 1 1 0.000000000000000 4.970000000000000 12.297560733739028 0.000000000000000 + 207 1 1 0.000000000000000 6.390000000000000 12.297560733739028 0.000000000000000 + 208 1 1 0.000000000000000 7.100000000000000 13.527316807112930 0.000000000000000 + 209 1 1 0.000000000000000 8.520000000000000 13.527316807112930 0.000000000000000 + 210 1 1 0.000000000000000 9.230000000000000 12.297560733739028 0.000000000000000 + 211 1 1 0.000000000000000 10.649999999999999 12.297560733739028 0.000000000000000 + 212 1 1 0.000000000000000 11.359999999999999 13.527316807112930 0.000000000000000 + 213 1 1 0.000000000000000 12.779999999999999 13.527316807112930 0.000000000000000 + 214 1 1 0.000000000000000 13.489999999999998 12.297560733739028 0.000000000000000 + 215 1 1 0.000000000000000 14.910000000000000 12.297560733739028 0.000000000000000 + 216 1 1 0.000000000000000 15.619999999999999 13.527316807112930 0.000000000000000 + 217 1 1 0.000000000000000 17.039999999999999 13.527316807112930 0.000000000000000 + 218 1 1 0.000000000000000 17.750000000000000 12.297560733739028 0.000000000000000 + 219 1 1 0.000000000000000 19.169999999999998 12.297560733739028 0.000000000000000 + 220 1 1 0.000000000000000 19.879999999999999 13.527316807112930 0.000000000000000 + 221 1 1 0.000000000000000 21.299999999999997 13.527316807112930 0.000000000000000 + 222 1 1 0.000000000000000 22.009999999999998 12.297560733739028 0.000000000000000 + 223 1 1 0.000000000000000 23.429999999999996 12.297560733739028 0.000000000000000 + 224 1 1 0.000000000000000 24.139999999999997 13.527316807112930 0.000000000000000 + 225 1 1 0.000000000000000 25.559999999999999 13.527316807112930 0.000000000000000 + 226 1 1 0.000000000000000 26.270000000000000 12.297560733739028 0.000000000000000 + 227 1 1 0.000000000000000 27.689999999999998 12.297560733739028 0.000000000000000 + 228 1 1 0.000000000000000 28.399999999999999 13.527316807112930 0.000000000000000 + 229 1 1 0.000000000000000 29.820000000000000 13.527316807112930 0.000000000000000 + 230 1 1 0.000000000000000 30.530000000000001 12.297560733739028 0.000000000000000 + 231 1 1 0.000000000000000 31.949999999999999 12.297560733739028 0.000000000000000 + 232 1 1 0.000000000000000 32.659999999999997 13.527316807112930 0.000000000000000 + 233 1 1 0.000000000000000 34.079999999999998 13.527316807112930 0.000000000000000 + 234 1 1 0.000000000000000 34.789999999999999 12.297560733739028 0.000000000000000 + 235 1 1 0.000000000000000 36.210000000000001 12.297560733739028 0.000000000000000 + 236 1 1 0.000000000000000 36.920000000000002 13.527316807112930 0.000000000000000 + 237 1 1 0.000000000000000 38.339999999999996 13.527316807112930 0.000000000000000 + 238 1 1 0.000000000000000 39.049999999999997 12.297560733739028 0.000000000000000 + 239 1 1 0.000000000000000 40.469999999999999 12.297560733739028 0.000000000000000 + 240 1 1 0.000000000000000 41.179999999999993 13.527316807112930 0.000000000000000 + 241 1 1 0.000000000000000 0.000000000000000 15.986828953860737 0.000000000000000 + 242 1 1 0.000000000000000 0.710000000000000 14.757072880486835 0.000000000000000 + 243 1 1 0.000000000000000 2.130000000000000 14.757072880486835 0.000000000000000 + 244 1 1 0.000000000000000 2.840000000000000 15.986828953860737 0.000000000000000 + 245 1 1 0.000000000000000 4.260000000000000 15.986828953860737 0.000000000000000 + 246 1 1 0.000000000000000 4.970000000000000 14.757072880486835 0.000000000000000 + 247 1 1 0.000000000000000 6.390000000000000 14.757072880486835 0.000000000000000 + 248 1 1 0.000000000000000 7.100000000000000 15.986828953860737 0.000000000000000 + 249 1 1 0.000000000000000 8.520000000000000 15.986828953860737 0.000000000000000 + 250 1 1 0.000000000000000 9.230000000000000 14.757072880486835 0.000000000000000 + 251 1 1 0.000000000000000 10.649999999999999 14.757072880486835 0.000000000000000 + 252 1 1 0.000000000000000 11.359999999999999 15.986828953860737 0.000000000000000 + 253 1 1 0.000000000000000 12.779999999999999 15.986828953860737 0.000000000000000 + 254 1 1 0.000000000000000 13.489999999999998 14.757072880486835 0.000000000000000 + 255 1 1 0.000000000000000 14.910000000000000 14.757072880486835 0.000000000000000 + 256 1 1 0.000000000000000 15.619999999999999 15.986828953860737 0.000000000000000 + 257 1 1 0.000000000000000 17.039999999999999 15.986828953860737 0.000000000000000 + 258 1 1 0.000000000000000 17.750000000000000 14.757072880486835 0.000000000000000 + 259 1 1 0.000000000000000 19.169999999999998 14.757072880486835 0.000000000000000 + 260 1 1 0.000000000000000 19.879999999999999 15.986828953860737 0.000000000000000 + 261 1 1 0.000000000000000 21.299999999999997 15.986828953860737 0.000000000000000 + 262 1 1 0.000000000000000 22.009999999999998 14.757072880486835 0.000000000000000 + 263 1 1 0.000000000000000 23.429999999999996 14.757072880486835 0.000000000000000 + 264 1 1 0.000000000000000 24.139999999999997 15.986828953860737 0.000000000000000 + 265 1 1 0.000000000000000 25.559999999999999 15.986828953860737 0.000000000000000 + 266 1 1 0.000000000000000 26.270000000000000 14.757072880486835 0.000000000000000 + 267 1 1 0.000000000000000 27.689999999999998 14.757072880486835 0.000000000000000 + 268 1 1 0.000000000000000 28.399999999999999 15.986828953860737 0.000000000000000 + 269 1 1 0.000000000000000 29.820000000000000 15.986828953860737 0.000000000000000 + 270 1 1 0.000000000000000 30.530000000000001 14.757072880486835 0.000000000000000 + 271 1 1 0.000000000000000 31.949999999999999 14.757072880486835 0.000000000000000 + 272 1 1 0.000000000000000 32.659999999999997 15.986828953860737 0.000000000000000 + 273 1 1 0.000000000000000 34.079999999999998 15.986828953860737 0.000000000000000 + 274 1 1 0.000000000000000 34.789999999999999 14.757072880486835 0.000000000000000 + 275 1 1 0.000000000000000 36.210000000000001 14.757072880486835 0.000000000000000 + 276 1 1 0.000000000000000 36.920000000000002 15.986828953860737 0.000000000000000 + 277 1 1 0.000000000000000 38.339999999999996 15.986828953860737 0.000000000000000 + 278 1 1 0.000000000000000 39.049999999999997 14.757072880486835 0.000000000000000 + 279 1 1 0.000000000000000 40.469999999999999 14.757072880486835 0.000000000000000 + 280 1 1 0.000000000000000 41.179999999999993 15.986828953860737 0.000000000000000 + 281 1 1 0.000000000000000 0.000000000000000 18.446341100608542 0.000000000000000 + 282 1 1 0.000000000000000 0.710000000000000 17.216585027234640 0.000000000000000 + 283 1 1 0.000000000000000 2.130000000000000 17.216585027234640 0.000000000000000 + 284 1 1 0.000000000000000 2.840000000000000 18.446341100608542 0.000000000000000 + 285 1 1 0.000000000000000 4.260000000000000 18.446341100608542 0.000000000000000 + 286 1 1 0.000000000000000 4.970000000000000 17.216585027234640 0.000000000000000 + 287 1 1 0.000000000000000 6.390000000000000 17.216585027234640 0.000000000000000 + 288 1 1 0.000000000000000 7.100000000000000 18.446341100608542 0.000000000000000 + 289 1 1 0.000000000000000 8.520000000000000 18.446341100608542 0.000000000000000 + 290 1 1 0.000000000000000 9.230000000000000 17.216585027234640 0.000000000000000 + 291 1 1 0.000000000000000 10.649999999999999 17.216585027234640 0.000000000000000 + 292 1 1 0.000000000000000 11.359999999999999 18.446341100608542 0.000000000000000 + 293 1 1 0.000000000000000 12.779999999999999 18.446341100608542 0.000000000000000 + 294 1 1 0.000000000000000 13.489999999999998 17.216585027234640 0.000000000000000 + 295 1 1 0.000000000000000 14.910000000000000 17.216585027234640 0.000000000000000 + 296 1 1 0.000000000000000 15.619999999999999 18.446341100608542 0.000000000000000 + 297 1 1 0.000000000000000 17.039999999999999 18.446341100608542 0.000000000000000 + 298 1 1 0.000000000000000 17.750000000000000 17.216585027234640 0.000000000000000 + 299 1 1 0.000000000000000 19.169999999999998 17.216585027234640 0.000000000000000 + 300 1 1 0.000000000000000 19.879999999999999 18.446341100608542 0.000000000000000 + 301 1 1 0.000000000000000 21.299999999999997 18.446341100608542 0.000000000000000 + 302 1 1 0.000000000000000 22.009999999999998 17.216585027234640 0.000000000000000 + 303 1 1 0.000000000000000 23.429999999999996 17.216585027234640 0.000000000000000 + 304 1 1 0.000000000000000 24.139999999999997 18.446341100608542 0.000000000000000 + 305 1 1 0.000000000000000 25.559999999999999 18.446341100608542 0.000000000000000 + 306 1 1 0.000000000000000 26.270000000000000 17.216585027234640 0.000000000000000 + 307 1 1 0.000000000000000 27.689999999999998 17.216585027234640 0.000000000000000 + 308 1 1 0.000000000000000 28.399999999999999 18.446341100608542 0.000000000000000 + 309 1 1 0.000000000000000 29.820000000000000 18.446341100608542 0.000000000000000 + 310 1 1 0.000000000000000 30.530000000000001 17.216585027234640 0.000000000000000 + 311 1 1 0.000000000000000 31.949999999999999 17.216585027234640 0.000000000000000 + 312 1 1 0.000000000000000 32.659999999999997 18.446341100608542 0.000000000000000 + 313 1 1 0.000000000000000 34.079999999999998 18.446341100608542 0.000000000000000 + 314 1 1 0.000000000000000 34.789999999999999 17.216585027234640 0.000000000000000 + 315 1 1 0.000000000000000 36.210000000000001 17.216585027234640 0.000000000000000 + 316 1 1 0.000000000000000 36.920000000000002 18.446341100608542 0.000000000000000 + 317 1 1 0.000000000000000 38.339999999999996 18.446341100608542 0.000000000000000 + 318 1 1 0.000000000000000 39.049999999999997 17.216585027234640 0.000000000000000 + 319 1 1 0.000000000000000 40.469999999999999 17.216585027234640 0.000000000000000 + 320 1 1 0.000000000000000 41.179999999999993 18.446341100608542 0.000000000000000 + 321 1 1 0.000000000000000 0.000000000000000 20.905853247356347 0.000000000000000 + 322 1 1 0.000000000000000 0.710000000000000 19.676097173982445 0.000000000000000 + 323 1 1 0.000000000000000 2.130000000000000 19.676097173982445 0.000000000000000 + 324 1 1 0.000000000000000 2.840000000000000 20.905853247356347 0.000000000000000 + 325 1 1 0.000000000000000 4.260000000000000 20.905853247356347 0.000000000000000 + 326 1 1 0.000000000000000 4.970000000000000 19.676097173982445 0.000000000000000 + 327 1 1 0.000000000000000 6.390000000000000 19.676097173982445 0.000000000000000 + 328 1 1 0.000000000000000 7.100000000000000 20.905853247356347 0.000000000000000 + 329 1 1 0.000000000000000 8.520000000000000 20.905853247356347 0.000000000000000 + 330 1 1 0.000000000000000 9.230000000000000 19.676097173982445 0.000000000000000 + 331 1 1 0.000000000000000 10.649999999999999 19.676097173982445 0.000000000000000 + 332 1 1 0.000000000000000 11.359999999999999 20.905853247356347 0.000000000000000 + 333 1 1 0.000000000000000 12.779999999999999 20.905853247356347 0.000000000000000 + 334 1 1 0.000000000000000 13.489999999999998 19.676097173982445 0.000000000000000 + 335 1 1 0.000000000000000 14.910000000000000 19.676097173982445 0.000000000000000 + 336 1 1 0.000000000000000 15.619999999999999 20.905853247356347 0.000000000000000 + 337 1 1 0.000000000000000 17.039999999999999 20.905853247356347 0.000000000000000 + 338 1 1 0.000000000000000 17.750000000000000 19.676097173982445 0.000000000000000 + 339 1 1 0.000000000000000 19.169999999999998 19.676097173982445 0.000000000000000 + 340 1 1 0.000000000000000 19.879999999999999 20.905853247356347 0.000000000000000 + 341 1 1 0.000000000000000 21.299999999999997 20.905853247356347 0.000000000000000 + 342 1 1 0.000000000000000 22.009999999999998 19.676097173982445 0.000000000000000 + 343 1 1 0.000000000000000 23.429999999999996 19.676097173982445 0.000000000000000 + 344 1 1 0.000000000000000 24.139999999999997 20.905853247356347 0.000000000000000 + 345 1 1 0.000000000000000 25.559999999999999 20.905853247356347 0.000000000000000 + 346 1 1 0.000000000000000 26.270000000000000 19.676097173982445 0.000000000000000 + 347 1 1 0.000000000000000 27.689999999999998 19.676097173982445 0.000000000000000 + 348 1 1 0.000000000000000 28.399999999999999 20.905853247356347 0.000000000000000 + 349 1 1 0.000000000000000 29.820000000000000 20.905853247356347 0.000000000000000 + 350 1 1 0.000000000000000 30.530000000000001 19.676097173982445 0.000000000000000 + 351 1 1 0.000000000000000 31.949999999999999 19.676097173982445 0.000000000000000 + 352 1 1 0.000000000000000 32.659999999999997 20.905853247356347 0.000000000000000 + 353 1 1 0.000000000000000 34.079999999999998 20.905853247356347 0.000000000000000 + 354 1 1 0.000000000000000 34.789999999999999 19.676097173982445 0.000000000000000 + 355 1 1 0.000000000000000 36.210000000000001 19.676097173982445 0.000000000000000 + 356 1 1 0.000000000000000 36.920000000000002 20.905853247356347 0.000000000000000 + 357 1 1 0.000000000000000 38.339999999999996 20.905853247356347 0.000000000000000 + 358 1 1 0.000000000000000 39.049999999999997 19.676097173982445 0.000000000000000 + 359 1 1 0.000000000000000 40.469999999999999 19.676097173982445 0.000000000000000 + 360 1 1 0.000000000000000 41.179999999999993 20.905853247356347 0.000000000000000 + 361 1 1 0.000000000000000 0.000000000000000 23.365365394104153 0.000000000000000 + 362 1 1 0.000000000000000 0.710000000000000 22.135609320730250 0.000000000000000 + 363 1 1 0.000000000000000 2.130000000000000 22.135609320730250 0.000000000000000 + 364 1 1 0.000000000000000 2.840000000000000 23.365365394104153 0.000000000000000 + 365 1 1 0.000000000000000 4.260000000000000 23.365365394104153 0.000000000000000 + 366 1 1 0.000000000000000 4.970000000000000 22.135609320730250 0.000000000000000 + 367 1 1 0.000000000000000 6.390000000000000 22.135609320730250 0.000000000000000 + 368 1 1 0.000000000000000 7.100000000000000 23.365365394104153 0.000000000000000 + 369 1 1 0.000000000000000 8.520000000000000 23.365365394104153 0.000000000000000 + 370 1 1 0.000000000000000 9.230000000000000 22.135609320730250 0.000000000000000 + 371 1 1 0.000000000000000 10.649999999999999 22.135609320730250 0.000000000000000 + 372 1 1 0.000000000000000 11.359999999999999 23.365365394104153 0.000000000000000 + 373 1 1 0.000000000000000 12.779999999999999 23.365365394104153 0.000000000000000 + 374 1 1 0.000000000000000 13.489999999999998 22.135609320730250 0.000000000000000 + 375 1 1 0.000000000000000 14.910000000000000 22.135609320730250 0.000000000000000 + 376 1 1 0.000000000000000 15.619999999999999 23.365365394104153 0.000000000000000 + 377 1 1 0.000000000000000 17.039999999999999 23.365365394104153 0.000000000000000 + 378 1 1 0.000000000000000 17.750000000000000 22.135609320730250 0.000000000000000 + 379 1 1 0.000000000000000 19.169999999999998 22.135609320730250 0.000000000000000 + 380 1 1 0.000000000000000 19.879999999999999 23.365365394104153 0.000000000000000 + 381 1 1 0.000000000000000 21.299999999999997 23.365365394104153 0.000000000000000 + 382 1 1 0.000000000000000 22.009999999999998 22.135609320730250 0.000000000000000 + 383 1 1 0.000000000000000 23.429999999999996 22.135609320730250 0.000000000000000 + 384 1 1 0.000000000000000 24.139999999999997 23.365365394104153 0.000000000000000 + 385 1 1 0.000000000000000 25.559999999999999 23.365365394104153 0.000000000000000 + 386 1 1 0.000000000000000 26.270000000000000 22.135609320730250 0.000000000000000 + 387 1 1 0.000000000000000 27.689999999999998 22.135609320730250 0.000000000000000 + 388 1 1 0.000000000000000 28.399999999999999 23.365365394104153 0.000000000000000 + 389 1 1 0.000000000000000 29.820000000000000 23.365365394104153 0.000000000000000 + 390 1 1 0.000000000000000 30.530000000000001 22.135609320730250 0.000000000000000 + 391 1 1 0.000000000000000 31.949999999999999 22.135609320730250 0.000000000000000 + 392 1 1 0.000000000000000 32.659999999999997 23.365365394104153 0.000000000000000 + 393 1 1 0.000000000000000 34.079999999999998 23.365365394104153 0.000000000000000 + 394 1 1 0.000000000000000 34.789999999999999 22.135609320730250 0.000000000000000 + 395 1 1 0.000000000000000 36.210000000000001 22.135609320730250 0.000000000000000 + 396 1 1 0.000000000000000 36.920000000000002 23.365365394104153 0.000000000000000 + 397 1 1 0.000000000000000 38.339999999999996 23.365365394104153 0.000000000000000 + 398 1 1 0.000000000000000 39.049999999999997 22.135609320730250 0.000000000000000 + 399 1 1 0.000000000000000 40.469999999999999 22.135609320730250 0.000000000000000 + 400 1 1 0.000000000000000 41.179999999999993 23.365365394104153 0.000000000000000 + 401 1 1 0.000000000000000 0.000000000000000 25.824877540851958 0.000000000000000 + 402 1 1 0.000000000000000 0.710000000000000 24.595121467478055 0.000000000000000 + 403 1 1 0.000000000000000 2.130000000000000 24.595121467478055 0.000000000000000 + 404 1 1 0.000000000000000 2.840000000000000 25.824877540851958 0.000000000000000 + 405 1 1 0.000000000000000 4.260000000000000 25.824877540851958 0.000000000000000 + 406 1 1 0.000000000000000 4.970000000000000 24.595121467478055 0.000000000000000 + 407 1 1 0.000000000000000 6.390000000000000 24.595121467478055 0.000000000000000 + 408 1 1 0.000000000000000 7.100000000000000 25.824877540851958 0.000000000000000 + 409 1 1 0.000000000000000 8.520000000000000 25.824877540851958 0.000000000000000 + 410 1 1 0.000000000000000 9.230000000000000 24.595121467478055 0.000000000000000 + 411 1 1 0.000000000000000 10.649999999999999 24.595121467478055 0.000000000000000 + 412 1 1 0.000000000000000 11.359999999999999 25.824877540851958 0.000000000000000 + 413 1 1 0.000000000000000 12.779999999999999 25.824877540851958 0.000000000000000 + 414 1 1 0.000000000000000 13.489999999999998 24.595121467478055 0.000000000000000 + 415 1 1 0.000000000000000 14.910000000000000 24.595121467478055 0.000000000000000 + 416 1 1 0.000000000000000 15.619999999999999 25.824877540851958 0.000000000000000 + 417 1 1 0.000000000000000 17.039999999999999 25.824877540851958 0.000000000000000 + 418 1 1 0.000000000000000 17.750000000000000 24.595121467478055 0.000000000000000 + 419 1 1 0.000000000000000 19.169999999999998 24.595121467478055 0.000000000000000 + 420 1 1 0.000000000000000 19.879999999999999 25.824877540851958 0.000000000000000 + 421 1 1 0.000000000000000 21.299999999999997 25.824877540851958 0.000000000000000 + 422 1 1 0.000000000000000 22.009999999999998 24.595121467478055 0.000000000000000 + 423 1 1 0.000000000000000 23.429999999999996 24.595121467478055 0.000000000000000 + 424 1 1 0.000000000000000 24.139999999999997 25.824877540851958 0.000000000000000 + 425 1 1 0.000000000000000 25.559999999999999 25.824877540851958 0.000000000000000 + 426 1 1 0.000000000000000 26.270000000000000 24.595121467478055 0.000000000000000 + 427 1 1 0.000000000000000 27.689999999999998 24.595121467478055 0.000000000000000 + 428 1 1 0.000000000000000 28.399999999999999 25.824877540851958 0.000000000000000 + 429 1 1 0.000000000000000 29.820000000000000 25.824877540851958 0.000000000000000 + 430 1 1 0.000000000000000 30.530000000000001 24.595121467478055 0.000000000000000 + 431 1 1 0.000000000000000 31.949999999999999 24.595121467478055 0.000000000000000 + 432 1 1 0.000000000000000 32.659999999999997 25.824877540851958 0.000000000000000 + 433 1 1 0.000000000000000 34.079999999999998 25.824877540851958 0.000000000000000 + 434 1 1 0.000000000000000 34.789999999999999 24.595121467478055 0.000000000000000 + 435 1 1 0.000000000000000 36.210000000000001 24.595121467478055 0.000000000000000 + 436 1 1 0.000000000000000 36.920000000000002 25.824877540851958 0.000000000000000 + 437 1 1 0.000000000000000 38.339999999999996 25.824877540851958 0.000000000000000 + 438 1 1 0.000000000000000 39.049999999999997 24.595121467478055 0.000000000000000 + 439 1 1 0.000000000000000 40.469999999999999 24.595121467478055 0.000000000000000 + 440 1 1 0.000000000000000 41.179999999999993 25.824877540851958 0.000000000000000 + 441 1 1 0.000000000000000 0.000000000000000 28.284389687599763 0.000000000000000 + 442 1 1 0.000000000000000 0.710000000000000 27.054633614225860 0.000000000000000 + 443 1 1 0.000000000000000 2.130000000000000 27.054633614225860 0.000000000000000 + 444 1 1 0.000000000000000 2.840000000000000 28.284389687599763 0.000000000000000 + 445 1 1 0.000000000000000 4.260000000000000 28.284389687599763 0.000000000000000 + 446 1 1 0.000000000000000 4.970000000000000 27.054633614225860 0.000000000000000 + 447 1 1 0.000000000000000 6.390000000000000 27.054633614225860 0.000000000000000 + 448 1 1 0.000000000000000 7.100000000000000 28.284389687599763 0.000000000000000 + 449 1 1 0.000000000000000 8.520000000000000 28.284389687599763 0.000000000000000 + 450 1 1 0.000000000000000 9.230000000000000 27.054633614225860 0.000000000000000 + 451 1 1 0.000000000000000 10.649999999999999 27.054633614225860 0.000000000000000 + 452 1 1 0.000000000000000 11.359999999999999 28.284389687599763 0.000000000000000 + 453 1 1 0.000000000000000 12.779999999999999 28.284389687599763 0.000000000000000 + 454 1 1 0.000000000000000 13.489999999999998 27.054633614225860 0.000000000000000 + 455 1 1 0.000000000000000 14.910000000000000 27.054633614225860 0.000000000000000 + 456 1 1 0.000000000000000 15.619999999999999 28.284389687599763 0.000000000000000 + 457 1 1 0.000000000000000 17.039999999999999 28.284389687599763 0.000000000000000 + 458 1 1 0.000000000000000 17.750000000000000 27.054633614225860 0.000000000000000 + 459 1 1 0.000000000000000 19.169999999999998 27.054633614225860 0.000000000000000 + 460 1 1 0.000000000000000 19.879999999999999 28.284389687599763 0.000000000000000 + 461 1 1 0.000000000000000 21.299999999999997 28.284389687599763 0.000000000000000 + 462 1 1 0.000000000000000 22.009999999999998 27.054633614225860 0.000000000000000 + 463 1 1 0.000000000000000 23.429999999999996 27.054633614225860 0.000000000000000 + 464 1 1 0.000000000000000 24.139999999999997 28.284389687599763 0.000000000000000 + 465 1 1 0.000000000000000 25.559999999999999 28.284389687599763 0.000000000000000 + 466 1 1 0.000000000000000 26.270000000000000 27.054633614225860 0.000000000000000 + 467 1 1 0.000000000000000 27.689999999999998 27.054633614225860 0.000000000000000 + 468 1 1 0.000000000000000 28.399999999999999 28.284389687599763 0.000000000000000 + 469 1 1 0.000000000000000 29.820000000000000 28.284389687599763 0.000000000000000 + 470 1 1 0.000000000000000 30.530000000000001 27.054633614225860 0.000000000000000 + 471 1 1 0.000000000000000 31.949999999999999 27.054633614225860 0.000000000000000 + 472 1 1 0.000000000000000 32.659999999999997 28.284389687599763 0.000000000000000 + 473 1 1 0.000000000000000 34.079999999999998 28.284389687599763 0.000000000000000 + 474 1 1 0.000000000000000 34.789999999999999 27.054633614225860 0.000000000000000 + 475 1 1 0.000000000000000 36.210000000000001 27.054633614225860 0.000000000000000 + 476 1 1 0.000000000000000 36.920000000000002 28.284389687599763 0.000000000000000 + 477 1 1 0.000000000000000 38.339999999999996 28.284389687599763 0.000000000000000 + 478 1 1 0.000000000000000 39.049999999999997 27.054633614225860 0.000000000000000 + 479 1 1 0.000000000000000 40.469999999999999 27.054633614225860 0.000000000000000 + 480 1 1 0.000000000000000 41.179999999999993 28.284389687599763 0.000000000000000 + 481 1 1 0.000000000000000 0.000000000000000 30.743901834347572 0.000000000000000 + 482 1 1 0.000000000000000 0.710000000000000 29.514145760973669 0.000000000000000 + 483 1 1 0.000000000000000 2.130000000000000 29.514145760973669 0.000000000000000 + 484 1 1 0.000000000000000 2.840000000000000 30.743901834347572 0.000000000000000 + 485 1 1 0.000000000000000 4.260000000000000 30.743901834347572 0.000000000000000 + 486 1 1 0.000000000000000 4.970000000000000 29.514145760973669 0.000000000000000 + 487 1 1 0.000000000000000 6.390000000000000 29.514145760973669 0.000000000000000 + 488 1 1 0.000000000000000 7.100000000000000 30.743901834347572 0.000000000000000 + 489 1 1 0.000000000000000 8.520000000000000 30.743901834347572 0.000000000000000 + 490 1 1 0.000000000000000 9.230000000000000 29.514145760973669 0.000000000000000 + 491 1 1 0.000000000000000 10.649999999999999 29.514145760973669 0.000000000000000 + 492 1 1 0.000000000000000 11.359999999999999 30.743901834347572 0.000000000000000 + 493 1 1 0.000000000000000 12.779999999999999 30.743901834347572 0.000000000000000 + 494 1 1 0.000000000000000 13.489999999999998 29.514145760973669 0.000000000000000 + 495 1 1 0.000000000000000 14.910000000000000 29.514145760973669 0.000000000000000 + 496 1 1 0.000000000000000 15.619999999999999 30.743901834347572 0.000000000000000 + 497 1 1 0.000000000000000 17.039999999999999 30.743901834347572 0.000000000000000 + 498 1 1 0.000000000000000 17.750000000000000 29.514145760973669 0.000000000000000 + 499 1 1 0.000000000000000 19.169999999999998 29.514145760973669 0.000000000000000 + 500 1 1 0.000000000000000 19.879999999999999 30.743901834347572 0.000000000000000 + 501 1 1 0.000000000000000 21.299999999999997 30.743901834347572 0.000000000000000 + 502 1 1 0.000000000000000 22.009999999999998 29.514145760973669 0.000000000000000 + 503 1 1 0.000000000000000 23.429999999999996 29.514145760973669 0.000000000000000 + 504 1 1 0.000000000000000 24.139999999999997 30.743901834347572 0.000000000000000 + 505 1 1 0.000000000000000 25.559999999999999 30.743901834347572 0.000000000000000 + 506 1 1 0.000000000000000 26.270000000000000 29.514145760973669 0.000000000000000 + 507 1 1 0.000000000000000 27.689999999999998 29.514145760973669 0.000000000000000 + 508 1 1 0.000000000000000 28.399999999999999 30.743901834347572 0.000000000000000 + 509 1 1 0.000000000000000 29.820000000000000 30.743901834347572 0.000000000000000 + 510 1 1 0.000000000000000 30.530000000000001 29.514145760973669 0.000000000000000 + 511 1 1 0.000000000000000 31.949999999999999 29.514145760973669 0.000000000000000 + 512 1 1 0.000000000000000 32.659999999999997 30.743901834347572 0.000000000000000 + 513 1 1 0.000000000000000 34.079999999999998 30.743901834347572 0.000000000000000 + 514 1 1 0.000000000000000 34.789999999999999 29.514145760973669 0.000000000000000 + 515 1 1 0.000000000000000 36.210000000000001 29.514145760973669 0.000000000000000 + 516 1 1 0.000000000000000 36.920000000000002 30.743901834347572 0.000000000000000 + 517 1 1 0.000000000000000 38.339999999999996 30.743901834347572 0.000000000000000 + 518 1 1 0.000000000000000 39.049999999999997 29.514145760973669 0.000000000000000 + 519 1 1 0.000000000000000 40.469999999999999 29.514145760973669 0.000000000000000 + 520 1 1 0.000000000000000 41.179999999999993 30.743901834347572 0.000000000000000 + 521 1 1 0.000000000000000 0.000000000000000 33.203413981095380 0.000000000000000 + 522 1 1 0.000000000000000 0.710000000000000 31.973657907721474 0.000000000000000 + 523 1 1 0.000000000000000 2.130000000000000 31.973657907721474 0.000000000000000 + 524 1 1 0.000000000000000 2.840000000000000 33.203413981095380 0.000000000000000 + 525 1 1 0.000000000000000 4.260000000000000 33.203413981095380 0.000000000000000 + 526 1 1 0.000000000000000 4.970000000000000 31.973657907721474 0.000000000000000 + 527 1 1 0.000000000000000 6.390000000000000 31.973657907721474 0.000000000000000 + 528 1 1 0.000000000000000 7.100000000000000 33.203413981095380 0.000000000000000 + 529 1 1 0.000000000000000 8.520000000000000 33.203413981095380 0.000000000000000 + 530 1 1 0.000000000000000 9.230000000000000 31.973657907721474 0.000000000000000 + 531 1 1 0.000000000000000 10.649999999999999 31.973657907721474 0.000000000000000 + 532 1 1 0.000000000000000 11.359999999999999 33.203413981095380 0.000000000000000 + 533 1 1 0.000000000000000 12.779999999999999 33.203413981095380 0.000000000000000 + 534 1 1 0.000000000000000 13.489999999999998 31.973657907721474 0.000000000000000 + 535 1 1 0.000000000000000 14.910000000000000 31.973657907721474 0.000000000000000 + 536 1 1 0.000000000000000 15.619999999999999 33.203413981095380 0.000000000000000 + 537 1 1 0.000000000000000 17.039999999999999 33.203413981095380 0.000000000000000 + 538 1 1 0.000000000000000 17.750000000000000 31.973657907721474 0.000000000000000 + 539 1 1 0.000000000000000 19.169999999999998 31.973657907721474 0.000000000000000 + 540 1 1 0.000000000000000 19.879999999999999 33.203413981095380 0.000000000000000 + 541 1 1 0.000000000000000 21.299999999999997 33.203413981095380 0.000000000000000 + 542 1 1 0.000000000000000 22.009999999999998 31.973657907721474 0.000000000000000 + 543 1 1 0.000000000000000 23.429999999999996 31.973657907721474 0.000000000000000 + 544 1 1 0.000000000000000 24.139999999999997 33.203413981095380 0.000000000000000 + 545 1 1 0.000000000000000 25.559999999999999 33.203413981095380 0.000000000000000 + 546 1 1 0.000000000000000 26.270000000000000 31.973657907721474 0.000000000000000 + 547 1 1 0.000000000000000 27.689999999999998 31.973657907721474 0.000000000000000 + 548 1 1 0.000000000000000 28.399999999999999 33.203413981095380 0.000000000000000 + 549 1 1 0.000000000000000 29.820000000000000 33.203413981095380 0.000000000000000 + 550 1 1 0.000000000000000 30.530000000000001 31.973657907721474 0.000000000000000 + 551 1 1 0.000000000000000 31.949999999999999 31.973657907721474 0.000000000000000 + 552 1 1 0.000000000000000 32.659999999999997 33.203413981095380 0.000000000000000 + 553 1 1 0.000000000000000 34.079999999999998 33.203413981095380 0.000000000000000 + 554 1 1 0.000000000000000 34.789999999999999 31.973657907721474 0.000000000000000 + 555 1 1 0.000000000000000 36.210000000000001 31.973657907721474 0.000000000000000 + 556 1 1 0.000000000000000 36.920000000000002 33.203413981095380 0.000000000000000 + 557 1 1 0.000000000000000 38.339999999999996 33.203413981095380 0.000000000000000 + 558 1 1 0.000000000000000 39.049999999999997 31.973657907721474 0.000000000000000 + 559 1 1 0.000000000000000 40.469999999999999 31.973657907721474 0.000000000000000 + 560 1 1 0.000000000000000 41.179999999999993 33.203413981095380 0.000000000000000 + 561 1 1 0.000000000000000 0.000000000000000 35.662926127843185 0.000000000000000 + 562 1 1 0.000000000000000 0.710000000000000 34.433170054469279 0.000000000000000 + 563 1 1 0.000000000000000 2.130000000000000 34.433170054469279 0.000000000000000 + 564 1 1 0.000000000000000 2.840000000000000 35.662926127843185 0.000000000000000 + 565 1 1 0.000000000000000 4.260000000000000 35.662926127843185 0.000000000000000 + 566 1 1 0.000000000000000 4.970000000000000 34.433170054469279 0.000000000000000 + 567 1 1 0.000000000000000 6.390000000000000 34.433170054469279 0.000000000000000 + 568 1 1 0.000000000000000 7.100000000000000 35.662926127843185 0.000000000000000 + 569 1 1 0.000000000000000 8.520000000000000 35.662926127843185 0.000000000000000 + 570 1 1 0.000000000000000 9.230000000000000 34.433170054469279 0.000000000000000 + 571 1 1 0.000000000000000 10.649999999999999 34.433170054469279 0.000000000000000 + 572 1 1 0.000000000000000 11.359999999999999 35.662926127843185 0.000000000000000 + 573 1 1 0.000000000000000 12.779999999999999 35.662926127843185 0.000000000000000 + 574 1 1 0.000000000000000 13.489999999999998 34.433170054469279 0.000000000000000 + 575 1 1 0.000000000000000 14.910000000000000 34.433170054469279 0.000000000000000 + 576 1 1 0.000000000000000 15.619999999999999 35.662926127843185 0.000000000000000 + 577 1 1 0.000000000000000 17.039999999999999 35.662926127843185 0.000000000000000 + 578 1 1 0.000000000000000 17.750000000000000 34.433170054469279 0.000000000000000 + 579 1 1 0.000000000000000 19.169999999999998 34.433170054469279 0.000000000000000 + 580 1 1 0.000000000000000 19.879999999999999 35.662926127843185 0.000000000000000 + 581 1 1 0.000000000000000 21.299999999999997 35.662926127843185 0.000000000000000 + 582 1 1 0.000000000000000 22.009999999999998 34.433170054469279 0.000000000000000 + 583 1 1 0.000000000000000 23.429999999999996 34.433170054469279 0.000000000000000 + 584 1 1 0.000000000000000 24.139999999999997 35.662926127843185 0.000000000000000 + 585 1 1 0.000000000000000 25.559999999999999 35.662926127843185 0.000000000000000 + 586 1 1 0.000000000000000 26.270000000000000 34.433170054469279 0.000000000000000 + 587 1 1 0.000000000000000 27.689999999999998 34.433170054469279 0.000000000000000 + 588 1 1 0.000000000000000 28.399999999999999 35.662926127843185 0.000000000000000 + 589 1 1 0.000000000000000 29.820000000000000 35.662926127843185 0.000000000000000 + 590 1 1 0.000000000000000 30.530000000000001 34.433170054469279 0.000000000000000 + 591 1 1 0.000000000000000 31.949999999999999 34.433170054469279 0.000000000000000 + 592 1 1 0.000000000000000 32.659999999999997 35.662926127843185 0.000000000000000 + 593 1 1 0.000000000000000 34.079999999999998 35.662926127843185 0.000000000000000 + 594 1 1 0.000000000000000 34.789999999999999 34.433170054469279 0.000000000000000 + 595 1 1 0.000000000000000 36.210000000000001 34.433170054469279 0.000000000000000 + 596 1 1 0.000000000000000 36.920000000000002 35.662926127843185 0.000000000000000 + 597 1 1 0.000000000000000 38.339999999999996 35.662926127843185 0.000000000000000 + 598 1 1 0.000000000000000 39.049999999999997 34.433170054469279 0.000000000000000 + 599 1 1 0.000000000000000 40.469999999999999 34.433170054469279 0.000000000000000 + 600 1 1 0.000000000000000 41.179999999999993 35.662926127843185 0.000000000000000 + 601 1 1 0.000000000000000 0.000000000000000 38.122438274590991 0.000000000000000 + 602 1 1 0.000000000000000 0.710000000000000 36.892682201217085 0.000000000000000 + 603 1 1 0.000000000000000 2.130000000000000 36.892682201217085 0.000000000000000 + 604 1 1 0.000000000000000 2.840000000000000 38.122438274590991 0.000000000000000 + 605 1 1 0.000000000000000 4.260000000000000 38.122438274590991 0.000000000000000 + 606 1 1 0.000000000000000 4.970000000000000 36.892682201217085 0.000000000000000 + 607 1 1 0.000000000000000 6.390000000000000 36.892682201217085 0.000000000000000 + 608 1 1 0.000000000000000 7.100000000000000 38.122438274590991 0.000000000000000 + 609 1 1 0.000000000000000 8.520000000000000 38.122438274590991 0.000000000000000 + 610 1 1 0.000000000000000 9.230000000000000 36.892682201217085 0.000000000000000 + 611 1 1 0.000000000000000 10.649999999999999 36.892682201217085 0.000000000000000 + 612 1 1 0.000000000000000 11.359999999999999 38.122438274590991 0.000000000000000 + 613 1 1 0.000000000000000 12.779999999999999 38.122438274590991 0.000000000000000 + 614 1 1 0.000000000000000 13.489999999999998 36.892682201217085 0.000000000000000 + 615 1 1 0.000000000000000 14.910000000000000 36.892682201217085 0.000000000000000 + 616 1 1 0.000000000000000 15.619999999999999 38.122438274590991 0.000000000000000 + 617 1 1 0.000000000000000 17.039999999999999 38.122438274590991 0.000000000000000 + 618 1 1 0.000000000000000 17.750000000000000 36.892682201217085 0.000000000000000 + 619 1 1 0.000000000000000 19.169999999999998 36.892682201217085 0.000000000000000 + 620 1 1 0.000000000000000 19.879999999999999 38.122438274590991 0.000000000000000 + 621 1 1 0.000000000000000 21.299999999999997 38.122438274590991 0.000000000000000 + 622 1 1 0.000000000000000 22.009999999999998 36.892682201217085 0.000000000000000 + 623 1 1 0.000000000000000 23.429999999999996 36.892682201217085 0.000000000000000 + 624 1 1 0.000000000000000 24.139999999999997 38.122438274590991 0.000000000000000 + 625 1 1 0.000000000000000 25.559999999999999 38.122438274590991 0.000000000000000 + 626 1 1 0.000000000000000 26.270000000000000 36.892682201217085 0.000000000000000 + 627 1 1 0.000000000000000 27.689999999999998 36.892682201217085 0.000000000000000 + 628 1 1 0.000000000000000 28.399999999999999 38.122438274590991 0.000000000000000 + 629 1 1 0.000000000000000 29.820000000000000 38.122438274590991 0.000000000000000 + 630 1 1 0.000000000000000 30.530000000000001 36.892682201217085 0.000000000000000 + 631 1 1 0.000000000000000 31.949999999999999 36.892682201217085 0.000000000000000 + 632 1 1 0.000000000000000 32.659999999999997 38.122438274590991 0.000000000000000 + 633 1 1 0.000000000000000 34.079999999999998 38.122438274590991 0.000000000000000 + 634 1 1 0.000000000000000 34.789999999999999 36.892682201217085 0.000000000000000 + 635 1 1 0.000000000000000 36.210000000000001 36.892682201217085 0.000000000000000 + 636 1 1 0.000000000000000 36.920000000000002 38.122438274590991 0.000000000000000 + 637 1 1 0.000000000000000 38.339999999999996 38.122438274590991 0.000000000000000 + 638 1 1 0.000000000000000 39.049999999999997 36.892682201217085 0.000000000000000 + 639 1 1 0.000000000000000 40.469999999999999 36.892682201217085 0.000000000000000 + 640 1 1 0.000000000000000 41.179999999999993 38.122438274590991 0.000000000000000 + 641 1 1 0.000000000000000 0.000000000000000 40.581950421338796 0.000000000000000 + 642 1 1 0.000000000000000 0.710000000000000 39.352194347964890 0.000000000000000 + 643 1 1 0.000000000000000 2.130000000000000 39.352194347964890 0.000000000000000 + 644 1 1 0.000000000000000 2.840000000000000 40.581950421338796 0.000000000000000 + 645 1 1 0.000000000000000 4.260000000000000 40.581950421338796 0.000000000000000 + 646 1 1 0.000000000000000 4.970000000000000 39.352194347964890 0.000000000000000 + 647 1 1 0.000000000000000 6.390000000000000 39.352194347964890 0.000000000000000 + 648 1 1 0.000000000000000 7.100000000000000 40.581950421338796 0.000000000000000 + 649 1 1 0.000000000000000 8.520000000000000 40.581950421338796 0.000000000000000 + 650 1 1 0.000000000000000 9.230000000000000 39.352194347964890 0.000000000000000 + 651 1 1 0.000000000000000 10.649999999999999 39.352194347964890 0.000000000000000 + 652 1 1 0.000000000000000 11.359999999999999 40.581950421338796 0.000000000000000 + 653 1 1 0.000000000000000 12.779999999999999 40.581950421338796 0.000000000000000 + 654 1 1 0.000000000000000 13.489999999999998 39.352194347964890 0.000000000000000 + 655 1 1 0.000000000000000 14.910000000000000 39.352194347964890 0.000000000000000 + 656 1 1 0.000000000000000 15.619999999999999 40.581950421338796 0.000000000000000 + 657 1 1 0.000000000000000 17.039999999999999 40.581950421338796 0.000000000000000 + 658 1 1 0.000000000000000 17.750000000000000 39.352194347964890 0.000000000000000 + 659 1 1 0.000000000000000 19.169999999999998 39.352194347964890 0.000000000000000 + 660 1 1 0.000000000000000 19.879999999999999 40.581950421338796 0.000000000000000 + 661 1 1 0.000000000000000 21.299999999999997 40.581950421338796 0.000000000000000 + 662 1 1 0.000000000000000 22.009999999999998 39.352194347964890 0.000000000000000 + 663 1 1 0.000000000000000 23.429999999999996 39.352194347964890 0.000000000000000 + 664 1 1 0.000000000000000 24.139999999999997 40.581950421338796 0.000000000000000 + 665 1 1 0.000000000000000 25.559999999999999 40.581950421338796 0.000000000000000 + 666 1 1 0.000000000000000 26.270000000000000 39.352194347964890 0.000000000000000 + 667 1 1 0.000000000000000 27.689999999999998 39.352194347964890 0.000000000000000 + 668 1 1 0.000000000000000 28.399999999999999 40.581950421338796 0.000000000000000 + 669 1 1 0.000000000000000 29.820000000000000 40.581950421338796 0.000000000000000 + 670 1 1 0.000000000000000 30.530000000000001 39.352194347964890 0.000000000000000 + 671 1 1 0.000000000000000 31.949999999999999 39.352194347964890 0.000000000000000 + 672 1 1 0.000000000000000 32.659999999999997 40.581950421338796 0.000000000000000 + 673 1 1 0.000000000000000 34.079999999999998 40.581950421338796 0.000000000000000 + 674 1 1 0.000000000000000 34.789999999999999 39.352194347964890 0.000000000000000 + 675 1 1 0.000000000000000 36.210000000000001 39.352194347964890 0.000000000000000 + 676 1 1 0.000000000000000 36.920000000000002 40.581950421338796 0.000000000000000 + 677 1 1 0.000000000000000 38.339999999999996 40.581950421338796 0.000000000000000 + 678 1 1 0.000000000000000 39.049999999999997 39.352194347964890 0.000000000000000 + 679 1 1 0.000000000000000 40.469999999999999 39.352194347964890 0.000000000000000 + 680 1 1 0.000000000000000 41.179999999999993 40.581950421338796 0.000000000000000 + 681 2 2 0.000000000000000 1.420000000000000 1.229756073373903 3.3000000000000000 + 682 2 2 0.000000000000000 2.130000000000000 0.000000000000000 3.3000000000000000 + 683 2 2 0.000000000000000 3.550000000000000 0.000000000000000 3.3000000000000000 + 684 2 2 0.000000000000000 4.260000000000000 1.229756073373903 3.3000000000000000 + 685 2 2 0.000000000000000 5.680000000000000 1.229756073373903 3.3000000000000000 + 686 2 2 0.000000000000000 6.390000000000000 0.000000000000000 3.3000000000000000 + 687 2 2 0.000000000000000 7.810000000000000 0.000000000000000 3.3000000000000000 + 688 2 2 0.000000000000000 8.520000000000000 1.229756073373903 3.3000000000000000 + 689 2 2 0.000000000000000 9.940000000000000 1.229756073373903 3.3000000000000000 + 690 2 2 0.000000000000000 10.650000000000000 0.000000000000000 3.3000000000000000 + 691 2 2 0.000000000000000 12.069999999999999 0.000000000000000 3.3000000000000000 + 692 2 2 0.000000000000000 12.779999999999999 1.229756073373903 3.3000000000000000 + 693 2 2 0.000000000000000 14.199999999999999 1.229756073373903 3.3000000000000000 + 694 2 2 0.000000000000000 14.909999999999998 0.000000000000000 3.3000000000000000 + 695 2 2 0.000000000000000 16.329999999999998 0.000000000000000 3.3000000000000000 + 696 2 2 0.000000000000000 17.039999999999999 1.229756073373903 3.3000000000000000 + 697 2 2 0.000000000000000 18.460000000000001 1.229756073373903 3.3000000000000000 + 698 2 2 0.000000000000000 19.170000000000002 0.000000000000000 3.3000000000000000 + 699 2 2 0.000000000000000 20.589999999999996 0.000000000000000 3.3000000000000000 + 700 2 2 0.000000000000000 21.299999999999997 1.229756073373903 3.3000000000000000 + 701 2 2 0.000000000000000 22.719999999999999 1.229756073373903 3.3000000000000000 + 702 2 2 0.000000000000000 23.430000000000000 0.000000000000000 3.3000000000000000 + 703 2 2 0.000000000000000 24.849999999999994 0.000000000000000 3.3000000000000000 + 704 2 2 0.000000000000000 25.559999999999995 1.229756073373903 3.3000000000000000 + 705 2 2 0.000000000000000 26.979999999999997 1.229756073373903 3.3000000000000000 + 706 2 2 0.000000000000000 27.689999999999998 0.000000000000000 3.3000000000000000 + 707 2 2 0.000000000000000 29.109999999999999 0.000000000000000 3.3000000000000000 + 708 2 2 0.000000000000000 29.820000000000000 1.229756073373903 3.3000000000000000 + 709 2 2 0.000000000000000 31.240000000000002 1.229756073373903 3.3000000000000000 + 710 2 2 0.000000000000000 31.950000000000003 0.000000000000000 3.3000000000000000 + 711 2 2 0.000000000000000 33.369999999999997 0.000000000000000 3.3000000000000000 + 712 2 2 0.000000000000000 34.079999999999998 1.229756073373903 3.3000000000000000 + 713 2 2 0.000000000000000 35.500000000000000 1.229756073373903 3.3000000000000000 + 714 2 2 0.000000000000000 36.210000000000001 0.000000000000000 3.3000000000000000 + 715 2 2 0.000000000000000 37.630000000000003 0.000000000000000 3.3000000000000000 + 716 2 2 0.000000000000000 38.340000000000003 1.229756073373903 3.3000000000000000 + 717 2 2 0.000000000000000 39.759999999999998 1.229756073373903 3.3000000000000000 + 718 2 2 0.000000000000000 40.469999999999999 0.000000000000000 3.3000000000000000 + 719 2 2 0.000000000000000 41.890000000000001 0.000000000000000 3.3000000000000000 + 720 2 2 0.000000000000000 42.599999999999994 1.229756073373903 3.3000000000000000 + 721 2 2 0.000000000000000 1.420000000000000 3.689268220121709 3.3000000000000000 + 722 2 2 0.000000000000000 2.130000000000000 2.459512146747806 3.3000000000000000 + 723 2 2 0.000000000000000 3.550000000000000 2.459512146747806 3.3000000000000000 + 724 2 2 0.000000000000000 4.260000000000000 3.689268220121709 3.3000000000000000 + 725 2 2 0.000000000000000 5.680000000000000 3.689268220121709 3.3000000000000000 + 726 2 2 0.000000000000000 6.390000000000000 2.459512146747806 3.3000000000000000 + 727 2 2 0.000000000000000 7.810000000000000 2.459512146747806 3.3000000000000000 + 728 2 2 0.000000000000000 8.520000000000000 3.689268220121709 3.3000000000000000 + 729 2 2 0.000000000000000 9.940000000000000 3.689268220121709 3.3000000000000000 + 730 2 2 0.000000000000000 10.650000000000000 2.459512146747806 3.3000000000000000 + 731 2 2 0.000000000000000 12.069999999999999 2.459512146747806 3.3000000000000000 + 732 2 2 0.000000000000000 12.779999999999999 3.689268220121709 3.3000000000000000 + 733 2 2 0.000000000000000 14.199999999999999 3.689268220121709 3.3000000000000000 + 734 2 2 0.000000000000000 14.909999999999998 2.459512146747806 3.3000000000000000 + 735 2 2 0.000000000000000 16.329999999999998 2.459512146747806 3.3000000000000000 + 736 2 2 0.000000000000000 17.039999999999999 3.689268220121709 3.3000000000000000 + 737 2 2 0.000000000000000 18.460000000000001 3.689268220121709 3.3000000000000000 + 738 2 2 0.000000000000000 19.170000000000002 2.459512146747806 3.3000000000000000 + 739 2 2 0.000000000000000 20.589999999999996 2.459512146747806 3.3000000000000000 + 740 2 2 0.000000000000000 21.299999999999997 3.689268220121709 3.3000000000000000 + 741 2 2 0.000000000000000 22.719999999999999 3.689268220121709 3.3000000000000000 + 742 2 2 0.000000000000000 23.430000000000000 2.459512146747806 3.3000000000000000 + 743 2 2 0.000000000000000 24.849999999999994 2.459512146747806 3.3000000000000000 + 744 2 2 0.000000000000000 25.559999999999995 3.689268220121709 3.3000000000000000 + 745 2 2 0.000000000000000 26.979999999999997 3.689268220121709 3.3000000000000000 + 746 2 2 0.000000000000000 27.689999999999998 2.459512146747806 3.3000000000000000 + 747 2 2 0.000000000000000 29.109999999999999 2.459512146747806 3.3000000000000000 + 748 2 2 0.000000000000000 29.820000000000000 3.689268220121709 3.3000000000000000 + 749 2 2 0.000000000000000 31.240000000000002 3.689268220121709 3.3000000000000000 + 750 2 2 0.000000000000000 31.950000000000003 2.459512146747806 3.3000000000000000 + 751 2 2 0.000000000000000 33.369999999999997 2.459512146747806 3.3000000000000000 + 752 2 2 0.000000000000000 34.079999999999998 3.689268220121709 3.3000000000000000 + 753 2 2 0.000000000000000 35.500000000000000 3.689268220121709 3.3000000000000000 + 754 2 2 0.000000000000000 36.210000000000001 2.459512146747806 3.3000000000000000 + 755 2 2 0.000000000000000 37.630000000000003 2.459512146747806 3.3000000000000000 + 756 2 2 0.000000000000000 38.340000000000003 3.689268220121709 3.3000000000000000 + 757 2 2 0.000000000000000 39.759999999999998 3.689268220121709 3.3000000000000000 + 758 2 2 0.000000000000000 40.469999999999999 2.459512146747806 3.3000000000000000 + 759 2 2 0.000000000000000 41.890000000000001 2.459512146747806 3.3000000000000000 + 760 2 2 0.000000000000000 42.599999999999994 3.689268220121709 3.3000000000000000 + 761 2 2 0.000000000000000 1.420000000000000 6.148780366869514 3.3000000000000000 + 762 2 2 0.000000000000000 2.130000000000000 4.919024293495611 3.3000000000000000 + 763 2 2 0.000000000000000 3.550000000000000 4.919024293495611 3.3000000000000000 + 764 2 2 0.000000000000000 4.260000000000000 6.148780366869514 3.3000000000000000 + 765 2 2 0.000000000000000 5.680000000000000 6.148780366869514 3.3000000000000000 + 766 2 2 0.000000000000000 6.390000000000000 4.919024293495611 3.3000000000000000 + 767 2 2 0.000000000000000 7.810000000000000 4.919024293495611 3.3000000000000000 + 768 2 2 0.000000000000000 8.520000000000000 6.148780366869514 3.3000000000000000 + 769 2 2 0.000000000000000 9.940000000000000 6.148780366869514 3.3000000000000000 + 770 2 2 0.000000000000000 10.650000000000000 4.919024293495611 3.3000000000000000 + 771 2 2 0.000000000000000 12.069999999999999 4.919024293495611 3.3000000000000000 + 772 2 2 0.000000000000000 12.779999999999999 6.148780366869514 3.3000000000000000 + 773 2 2 0.000000000000000 14.199999999999999 6.148780366869514 3.3000000000000000 + 774 2 2 0.000000000000000 14.909999999999998 4.919024293495611 3.3000000000000000 + 775 2 2 0.000000000000000 16.329999999999998 4.919024293495611 3.3000000000000000 + 776 2 2 0.000000000000000 17.039999999999999 6.148780366869514 3.3000000000000000 + 777 2 2 0.000000000000000 18.460000000000001 6.148780366869514 3.3000000000000000 + 778 2 2 0.000000000000000 19.170000000000002 4.919024293495611 3.3000000000000000 + 779 2 2 0.000000000000000 20.589999999999996 4.919024293495611 3.3000000000000000 + 780 2 2 0.000000000000000 21.299999999999997 6.148780366869514 3.3000000000000000 + 781 2 2 0.000000000000000 22.719999999999999 6.148780366869514 3.3000000000000000 + 782 2 2 0.000000000000000 23.430000000000000 4.919024293495611 3.3000000000000000 + 783 2 2 0.000000000000000 24.849999999999994 4.919024293495611 3.3000000000000000 + 784 2 2 0.000000000000000 25.559999999999995 6.148780366869514 3.3000000000000000 + 785 2 2 0.000000000000000 26.979999999999997 6.148780366869514 3.3000000000000000 + 786 2 2 0.000000000000000 27.689999999999998 4.919024293495611 3.3000000000000000 + 787 2 2 0.000000000000000 29.109999999999999 4.919024293495611 3.3000000000000000 + 788 2 2 0.000000000000000 29.820000000000000 6.148780366869514 3.3000000000000000 + 789 2 2 0.000000000000000 31.240000000000002 6.148780366869514 3.3000000000000000 + 790 2 2 0.000000000000000 31.950000000000003 4.919024293495611 3.3000000000000000 + 791 2 2 0.000000000000000 33.369999999999997 4.919024293495611 3.3000000000000000 + 792 2 2 0.000000000000000 34.079999999999998 6.148780366869514 3.3000000000000000 + 793 2 2 0.000000000000000 35.500000000000000 6.148780366869514 3.3000000000000000 + 794 2 2 0.000000000000000 36.210000000000001 4.919024293495611 3.3000000000000000 + 795 2 2 0.000000000000000 37.630000000000003 4.919024293495611 3.3000000000000000 + 796 2 2 0.000000000000000 38.340000000000003 6.148780366869514 3.3000000000000000 + 797 2 2 0.000000000000000 39.759999999999998 6.148780366869514 3.3000000000000000 + 798 2 2 0.000000000000000 40.469999999999999 4.919024293495611 3.3000000000000000 + 799 2 2 0.000000000000000 41.890000000000001 4.919024293495611 3.3000000000000000 + 800 2 2 0.000000000000000 42.599999999999994 6.148780366869514 3.3000000000000000 + 801 2 2 0.000000000000000 1.420000000000000 8.608292513617320 3.3000000000000000 + 802 2 2 0.000000000000000 2.130000000000000 7.378536440243417 3.3000000000000000 + 803 2 2 0.000000000000000 3.550000000000000 7.378536440243417 3.3000000000000000 + 804 2 2 0.000000000000000 4.260000000000000 8.608292513617320 3.3000000000000000 + 805 2 2 0.000000000000000 5.680000000000000 8.608292513617320 3.3000000000000000 + 806 2 2 0.000000000000000 6.390000000000000 7.378536440243417 3.3000000000000000 + 807 2 2 0.000000000000000 7.810000000000000 7.378536440243417 3.3000000000000000 + 808 2 2 0.000000000000000 8.520000000000000 8.608292513617320 3.3000000000000000 + 809 2 2 0.000000000000000 9.940000000000000 8.608292513617320 3.3000000000000000 + 810 2 2 0.000000000000000 10.650000000000000 7.378536440243417 3.3000000000000000 + 811 2 2 0.000000000000000 12.069999999999999 7.378536440243417 3.3000000000000000 + 812 2 2 0.000000000000000 12.779999999999999 8.608292513617320 3.3000000000000000 + 813 2 2 0.000000000000000 14.199999999999999 8.608292513617320 3.3000000000000000 + 814 2 2 0.000000000000000 14.909999999999998 7.378536440243417 3.3000000000000000 + 815 2 2 0.000000000000000 16.329999999999998 7.378536440243417 3.3000000000000000 + 816 2 2 0.000000000000000 17.039999999999999 8.608292513617320 3.3000000000000000 + 817 2 2 0.000000000000000 18.460000000000001 8.608292513617320 3.3000000000000000 + 818 2 2 0.000000000000000 19.170000000000002 7.378536440243417 3.3000000000000000 + 819 2 2 0.000000000000000 20.589999999999996 7.378536440243417 3.3000000000000000 + 820 2 2 0.000000000000000 21.299999999999997 8.608292513617320 3.3000000000000000 + 821 2 2 0.000000000000000 22.719999999999999 8.608292513617320 3.3000000000000000 + 822 2 2 0.000000000000000 23.430000000000000 7.378536440243417 3.3000000000000000 + 823 2 2 0.000000000000000 24.849999999999994 7.378536440243417 3.3000000000000000 + 824 2 2 0.000000000000000 25.559999999999995 8.608292513617320 3.3000000000000000 + 825 2 2 0.000000000000000 26.979999999999997 8.608292513617320 3.3000000000000000 + 826 2 2 0.000000000000000 27.689999999999998 7.378536440243417 3.3000000000000000 + 827 2 2 0.000000000000000 29.109999999999999 7.378536440243417 3.3000000000000000 + 828 2 2 0.000000000000000 29.820000000000000 8.608292513617320 3.3000000000000000 + 829 2 2 0.000000000000000 31.240000000000002 8.608292513617320 3.3000000000000000 + 830 2 2 0.000000000000000 31.950000000000003 7.378536440243417 3.3000000000000000 + 831 2 2 0.000000000000000 33.369999999999997 7.378536440243417 3.3000000000000000 + 832 2 2 0.000000000000000 34.079999999999998 8.608292513617320 3.3000000000000000 + 833 2 2 0.000000000000000 35.500000000000000 8.608292513617320 3.3000000000000000 + 834 2 2 0.000000000000000 36.210000000000001 7.378536440243417 3.3000000000000000 + 835 2 2 0.000000000000000 37.630000000000003 7.378536440243417 3.3000000000000000 + 836 2 2 0.000000000000000 38.340000000000003 8.608292513617320 3.3000000000000000 + 837 2 2 0.000000000000000 39.759999999999998 8.608292513617320 3.3000000000000000 + 838 2 2 0.000000000000000 40.469999999999999 7.378536440243417 3.3000000000000000 + 839 2 2 0.000000000000000 41.890000000000001 7.378536440243417 3.3000000000000000 + 840 2 2 0.000000000000000 42.599999999999994 8.608292513617320 3.3000000000000000 + 841 2 2 0.000000000000000 1.420000000000000 11.067804660365125 3.3000000000000000 + 842 2 2 0.000000000000000 2.130000000000000 9.838048586991222 3.3000000000000000 + 843 2 2 0.000000000000000 3.550000000000000 9.838048586991222 3.3000000000000000 + 844 2 2 0.000000000000000 4.260000000000000 11.067804660365125 3.3000000000000000 + 845 2 2 0.000000000000000 5.680000000000000 11.067804660365125 3.3000000000000000 + 846 2 2 0.000000000000000 6.390000000000000 9.838048586991222 3.3000000000000000 + 847 2 2 0.000000000000000 7.810000000000000 9.838048586991222 3.3000000000000000 + 848 2 2 0.000000000000000 8.520000000000000 11.067804660365125 3.3000000000000000 + 849 2 2 0.000000000000000 9.940000000000000 11.067804660365125 3.3000000000000000 + 850 2 2 0.000000000000000 10.650000000000000 9.838048586991222 3.3000000000000000 + 851 2 2 0.000000000000000 12.069999999999999 9.838048586991222 3.3000000000000000 + 852 2 2 0.000000000000000 12.779999999999999 11.067804660365125 3.3000000000000000 + 853 2 2 0.000000000000000 14.199999999999999 11.067804660365125 3.3000000000000000 + 854 2 2 0.000000000000000 14.909999999999998 9.838048586991222 3.3000000000000000 + 855 2 2 0.000000000000000 16.329999999999998 9.838048586991222 3.3000000000000000 + 856 2 2 0.000000000000000 17.039999999999999 11.067804660365125 3.3000000000000000 + 857 2 2 0.000000000000000 18.460000000000001 11.067804660365125 3.3000000000000000 + 858 2 2 0.000000000000000 19.170000000000002 9.838048586991222 3.3000000000000000 + 859 2 2 0.000000000000000 20.589999999999996 9.838048586991222 3.3000000000000000 + 860 2 2 0.000000000000000 21.299999999999997 11.067804660365125 3.3000000000000000 + 861 2 2 0.000000000000000 22.719999999999999 11.067804660365125 3.3000000000000000 + 862 2 2 0.000000000000000 23.430000000000000 9.838048586991222 3.3000000000000000 + 863 2 2 0.000000000000000 24.849999999999994 9.838048586991222 3.3000000000000000 + 864 2 2 0.000000000000000 25.559999999999995 11.067804660365125 3.3000000000000000 + 865 2 2 0.000000000000000 26.979999999999997 11.067804660365125 3.3000000000000000 + 866 2 2 0.000000000000000 27.689999999999998 9.838048586991222 3.3000000000000000 + 867 2 2 0.000000000000000 29.109999999999999 9.838048586991222 3.3000000000000000 + 868 2 2 0.000000000000000 29.820000000000000 11.067804660365125 3.3000000000000000 + 869 2 2 0.000000000000000 31.240000000000002 11.067804660365125 3.3000000000000000 + 870 2 2 0.000000000000000 31.950000000000003 9.838048586991222 3.3000000000000000 + 871 2 2 0.000000000000000 33.369999999999997 9.838048586991222 3.3000000000000000 + 872 2 2 0.000000000000000 34.079999999999998 11.067804660365125 3.3000000000000000 + 873 2 2 0.000000000000000 35.500000000000000 11.067804660365125 3.3000000000000000 + 874 2 2 0.000000000000000 36.210000000000001 9.838048586991222 3.3000000000000000 + 875 2 2 0.000000000000000 37.630000000000003 9.838048586991222 3.3000000000000000 + 876 2 2 0.000000000000000 38.340000000000003 11.067804660365125 3.3000000000000000 + 877 2 2 0.000000000000000 39.759999999999998 11.067804660365125 3.3000000000000000 + 878 2 2 0.000000000000000 40.469999999999999 9.838048586991222 3.3000000000000000 + 879 2 2 0.000000000000000 41.890000000000001 9.838048586991222 3.3000000000000000 + 880 2 2 0.000000000000000 42.599999999999994 11.067804660365125 3.3000000000000000 + 881 2 2 0.000000000000000 1.420000000000000 13.527316807112930 3.3000000000000000 + 882 2 2 0.000000000000000 2.130000000000000 12.297560733739028 3.3000000000000000 + 883 2 2 0.000000000000000 3.550000000000000 12.297560733739028 3.3000000000000000 + 884 2 2 0.000000000000000 4.260000000000000 13.527316807112930 3.3000000000000000 + 885 2 2 0.000000000000000 5.680000000000000 13.527316807112930 3.3000000000000000 + 886 2 2 0.000000000000000 6.390000000000000 12.297560733739028 3.3000000000000000 + 887 2 2 0.000000000000000 7.810000000000000 12.297560733739028 3.3000000000000000 + 888 2 2 0.000000000000000 8.520000000000000 13.527316807112930 3.3000000000000000 + 889 2 2 0.000000000000000 9.940000000000000 13.527316807112930 3.3000000000000000 + 890 2 2 0.000000000000000 10.650000000000000 12.297560733739028 3.3000000000000000 + 891 2 2 0.000000000000000 12.069999999999999 12.297560733739028 3.3000000000000000 + 892 2 2 0.000000000000000 12.779999999999999 13.527316807112930 3.3000000000000000 + 893 2 2 0.000000000000000 14.199999999999999 13.527316807112930 3.3000000000000000 + 894 2 2 0.000000000000000 14.909999999999998 12.297560733739028 3.3000000000000000 + 895 2 2 0.000000000000000 16.329999999999998 12.297560733739028 3.3000000000000000 + 896 2 2 0.000000000000000 17.039999999999999 13.527316807112930 3.3000000000000000 + 897 2 2 0.000000000000000 18.460000000000001 13.527316807112930 3.3000000000000000 + 898 2 2 0.000000000000000 19.170000000000002 12.297560733739028 3.3000000000000000 + 899 2 2 0.000000000000000 20.589999999999996 12.297560733739028 3.3000000000000000 + 900 2 2 0.000000000000000 21.299999999999997 13.527316807112930 3.3000000000000000 + 901 2 2 0.000000000000000 22.719999999999999 13.527316807112930 3.3000000000000000 + 902 2 2 0.000000000000000 23.430000000000000 12.297560733739028 3.3000000000000000 + 903 2 2 0.000000000000000 24.849999999999994 12.297560733739028 3.3000000000000000 + 904 2 2 0.000000000000000 25.559999999999995 13.527316807112930 3.3000000000000000 + 905 2 2 0.000000000000000 26.979999999999997 13.527316807112930 3.3000000000000000 + 906 2 2 0.000000000000000 27.689999999999998 12.297560733739028 3.3000000000000000 + 907 2 2 0.000000000000000 29.109999999999999 12.297560733739028 3.3000000000000000 + 908 2 2 0.000000000000000 29.820000000000000 13.527316807112930 3.3000000000000000 + 909 2 2 0.000000000000000 31.240000000000002 13.527316807112930 3.3000000000000000 + 910 2 2 0.000000000000000 31.950000000000003 12.297560733739028 3.3000000000000000 + 911 2 2 0.000000000000000 33.369999999999997 12.297560733739028 3.3000000000000000 + 912 2 2 0.000000000000000 34.079999999999998 13.527316807112930 3.3000000000000000 + 913 2 2 0.000000000000000 35.500000000000000 13.527316807112930 3.3000000000000000 + 914 2 2 0.000000000000000 36.210000000000001 12.297560733739028 3.3000000000000000 + 915 2 2 0.000000000000000 37.630000000000003 12.297560733739028 3.3000000000000000 + 916 2 2 0.000000000000000 38.340000000000003 13.527316807112930 3.3000000000000000 + 917 2 2 0.000000000000000 39.759999999999998 13.527316807112930 3.3000000000000000 + 918 2 2 0.000000000000000 40.469999999999999 12.297560733739028 3.3000000000000000 + 919 2 2 0.000000000000000 41.890000000000001 12.297560733739028 3.3000000000000000 + 920 2 2 0.000000000000000 42.599999999999994 13.527316807112930 3.3000000000000000 + 921 2 2 0.000000000000000 1.420000000000000 15.986828953860737 3.3000000000000000 + 922 2 2 0.000000000000000 2.130000000000000 14.757072880486835 3.3000000000000000 + 923 2 2 0.000000000000000 3.550000000000000 14.757072880486835 3.3000000000000000 + 924 2 2 0.000000000000000 4.260000000000000 15.986828953860737 3.3000000000000000 + 925 2 2 0.000000000000000 5.680000000000000 15.986828953860737 3.3000000000000000 + 926 2 2 0.000000000000000 6.390000000000000 14.757072880486835 3.3000000000000000 + 927 2 2 0.000000000000000 7.810000000000000 14.757072880486835 3.3000000000000000 + 928 2 2 0.000000000000000 8.520000000000000 15.986828953860737 3.3000000000000000 + 929 2 2 0.000000000000000 9.940000000000000 15.986828953860737 3.3000000000000000 + 930 2 2 0.000000000000000 10.650000000000000 14.757072880486835 3.3000000000000000 + 931 2 2 0.000000000000000 12.069999999999999 14.757072880486835 3.3000000000000000 + 932 2 2 0.000000000000000 12.779999999999999 15.986828953860737 3.3000000000000000 + 933 2 2 0.000000000000000 14.199999999999999 15.986828953860737 3.3000000000000000 + 934 2 2 0.000000000000000 14.909999999999998 14.757072880486835 3.3000000000000000 + 935 2 2 0.000000000000000 16.329999999999998 14.757072880486835 3.3000000000000000 + 936 2 2 0.000000000000000 17.039999999999999 15.986828953860737 3.3000000000000000 + 937 2 2 0.000000000000000 18.460000000000001 15.986828953860737 3.3000000000000000 + 938 2 2 0.000000000000000 19.170000000000002 14.757072880486835 3.3000000000000000 + 939 2 2 0.000000000000000 20.589999999999996 14.757072880486835 3.3000000000000000 + 940 2 2 0.000000000000000 21.299999999999997 15.986828953860737 3.3000000000000000 + 941 2 2 0.000000000000000 22.719999999999999 15.986828953860737 3.3000000000000000 + 942 2 2 0.000000000000000 23.430000000000000 14.757072880486835 3.3000000000000000 + 943 2 2 0.000000000000000 24.849999999999994 14.757072880486835 3.3000000000000000 + 944 2 2 0.000000000000000 25.559999999999995 15.986828953860737 3.3000000000000000 + 945 2 2 0.000000000000000 26.979999999999997 15.986828953860737 3.3000000000000000 + 946 2 2 0.000000000000000 27.689999999999998 14.757072880486835 3.3000000000000000 + 947 2 2 0.000000000000000 29.109999999999999 14.757072880486835 3.3000000000000000 + 948 2 2 0.000000000000000 29.820000000000000 15.986828953860737 3.3000000000000000 + 949 2 2 0.000000000000000 31.240000000000002 15.986828953860737 3.3000000000000000 + 950 2 2 0.000000000000000 31.950000000000003 14.757072880486835 3.3000000000000000 + 951 2 2 0.000000000000000 33.369999999999997 14.757072880486835 3.3000000000000000 + 952 2 2 0.000000000000000 34.079999999999998 15.986828953860737 3.3000000000000000 + 953 2 2 0.000000000000000 35.500000000000000 15.986828953860737 3.3000000000000000 + 954 2 2 0.000000000000000 36.210000000000001 14.757072880486835 3.3000000000000000 + 955 2 2 0.000000000000000 37.630000000000003 14.757072880486835 3.3000000000000000 + 956 2 2 0.000000000000000 38.340000000000003 15.986828953860737 3.3000000000000000 + 957 2 2 0.000000000000000 39.759999999999998 15.986828953860737 3.3000000000000000 + 958 2 2 0.000000000000000 40.469999999999999 14.757072880486835 3.3000000000000000 + 959 2 2 0.000000000000000 41.890000000000001 14.757072880486835 3.3000000000000000 + 960 2 2 0.000000000000000 42.599999999999994 15.986828953860737 3.3000000000000000 + 961 2 2 0.000000000000000 1.420000000000000 18.446341100608542 3.3000000000000000 + 962 2 2 0.000000000000000 2.130000000000000 17.216585027234640 3.3000000000000000 + 963 2 2 0.000000000000000 3.550000000000000 17.216585027234640 3.3000000000000000 + 964 2 2 0.000000000000000 4.260000000000000 18.446341100608542 3.3000000000000000 + 965 2 2 0.000000000000000 5.680000000000000 18.446341100608542 3.3000000000000000 + 966 2 2 0.000000000000000 6.390000000000000 17.216585027234640 3.3000000000000000 + 967 2 2 0.000000000000000 7.810000000000000 17.216585027234640 3.3000000000000000 + 968 2 2 0.000000000000000 8.520000000000000 18.446341100608542 3.3000000000000000 + 969 2 2 0.000000000000000 9.940000000000000 18.446341100608542 3.3000000000000000 + 970 2 2 0.000000000000000 10.650000000000000 17.216585027234640 3.3000000000000000 + 971 2 2 0.000000000000000 12.069999999999999 17.216585027234640 3.3000000000000000 + 972 2 2 0.000000000000000 12.779999999999999 18.446341100608542 3.3000000000000000 + 973 2 2 0.000000000000000 14.199999999999999 18.446341100608542 3.3000000000000000 + 974 2 2 0.000000000000000 14.909999999999998 17.216585027234640 3.3000000000000000 + 975 2 2 0.000000000000000 16.329999999999998 17.216585027234640 3.3000000000000000 + 976 2 2 0.000000000000000 17.039999999999999 18.446341100608542 3.3000000000000000 + 977 2 2 0.000000000000000 18.460000000000001 18.446341100608542 3.3000000000000000 + 978 2 2 0.000000000000000 19.170000000000002 17.216585027234640 3.3000000000000000 + 979 2 2 0.000000000000000 20.589999999999996 17.216585027234640 3.3000000000000000 + 980 2 2 0.000000000000000 21.299999999999997 18.446341100608542 3.3000000000000000 + 981 2 2 0.000000000000000 22.719999999999999 18.446341100608542 3.3000000000000000 + 982 2 2 0.000000000000000 23.430000000000000 17.216585027234640 3.3000000000000000 + 983 2 2 0.000000000000000 24.849999999999994 17.216585027234640 3.3000000000000000 + 984 2 2 0.000000000000000 25.559999999999995 18.446341100608542 3.3000000000000000 + 985 2 2 0.000000000000000 26.979999999999997 18.446341100608542 3.3000000000000000 + 986 2 2 0.000000000000000 27.689999999999998 17.216585027234640 3.3000000000000000 + 987 2 2 0.000000000000000 29.109999999999999 17.216585027234640 3.3000000000000000 + 988 2 2 0.000000000000000 29.820000000000000 18.446341100608542 3.3000000000000000 + 989 2 2 0.000000000000000 31.240000000000002 18.446341100608542 3.3000000000000000 + 990 2 2 0.000000000000000 31.950000000000003 17.216585027234640 3.3000000000000000 + 991 2 2 0.000000000000000 33.369999999999997 17.216585027234640 3.3000000000000000 + 992 2 2 0.000000000000000 34.079999999999998 18.446341100608542 3.3000000000000000 + 993 2 2 0.000000000000000 35.500000000000000 18.446341100608542 3.3000000000000000 + 994 2 2 0.000000000000000 36.210000000000001 17.216585027234640 3.3000000000000000 + 995 2 2 0.000000000000000 37.630000000000003 17.216585027234640 3.3000000000000000 + 996 2 2 0.000000000000000 38.340000000000003 18.446341100608542 3.3000000000000000 + 997 2 2 0.000000000000000 39.759999999999998 18.446341100608542 3.3000000000000000 + 998 2 2 0.000000000000000 40.469999999999999 17.216585027234640 3.3000000000000000 + 999 2 2 0.000000000000000 41.890000000000001 17.216585027234640 3.3000000000000000 + 1000 2 2 0.000000000000000 42.599999999999994 18.446341100608542 3.3000000000000000 + 1001 2 2 0.000000000000000 1.420000000000000 20.905853247356347 3.3000000000000000 + 1002 2 2 0.000000000000000 2.130000000000000 19.676097173982445 3.3000000000000000 + 1003 2 2 0.000000000000000 3.550000000000000 19.676097173982445 3.3000000000000000 + 1004 2 2 0.000000000000000 4.260000000000000 20.905853247356347 3.3000000000000000 + 1005 2 2 0.000000000000000 5.680000000000000 20.905853247356347 3.3000000000000000 + 1006 2 2 0.000000000000000 6.390000000000000 19.676097173982445 3.3000000000000000 + 1007 2 2 0.000000000000000 7.810000000000000 19.676097173982445 3.3000000000000000 + 1008 2 2 0.000000000000000 8.520000000000000 20.905853247356347 3.3000000000000000 + 1009 2 2 0.000000000000000 9.940000000000000 20.905853247356347 3.3000000000000000 + 1010 2 2 0.000000000000000 10.650000000000000 19.676097173982445 3.3000000000000000 + 1011 2 2 0.000000000000000 12.069999999999999 19.676097173982445 3.3000000000000000 + 1012 2 2 0.000000000000000 12.779999999999999 20.905853247356347 3.3000000000000000 + 1013 2 2 0.000000000000000 14.199999999999999 20.905853247356347 3.3000000000000000 + 1014 2 2 0.000000000000000 14.909999999999998 19.676097173982445 3.3000000000000000 + 1015 2 2 0.000000000000000 16.329999999999998 19.676097173982445 3.3000000000000000 + 1016 2 2 0.000000000000000 17.039999999999999 20.905853247356347 3.3000000000000000 + 1017 2 2 0.000000000000000 18.460000000000001 20.905853247356347 3.3000000000000000 + 1018 2 2 0.000000000000000 19.170000000000002 19.676097173982445 3.3000000000000000 + 1019 2 2 0.000000000000000 20.589999999999996 19.676097173982445 3.3000000000000000 + 1020 2 2 0.000000000000000 21.299999999999997 20.905853247356347 3.3000000000000000 + 1021 2 2 0.000000000000000 22.719999999999999 20.905853247356347 3.3000000000000000 + 1022 2 2 0.000000000000000 23.430000000000000 19.676097173982445 3.3000000000000000 + 1023 2 2 0.000000000000000 24.849999999999994 19.676097173982445 3.3000000000000000 + 1024 2 2 0.000000000000000 25.559999999999995 20.905853247356347 3.3000000000000000 + 1025 2 2 0.000000000000000 26.979999999999997 20.905853247356347 3.3000000000000000 + 1026 2 2 0.000000000000000 27.689999999999998 19.676097173982445 3.3000000000000000 + 1027 2 2 0.000000000000000 29.109999999999999 19.676097173982445 3.3000000000000000 + 1028 2 2 0.000000000000000 29.820000000000000 20.905853247356347 3.3000000000000000 + 1029 2 2 0.000000000000000 31.240000000000002 20.905853247356347 3.3000000000000000 + 1030 2 2 0.000000000000000 31.950000000000003 19.676097173982445 3.3000000000000000 + 1031 2 2 0.000000000000000 33.369999999999997 19.676097173982445 3.3000000000000000 + 1032 2 2 0.000000000000000 34.079999999999998 20.905853247356347 3.3000000000000000 + 1033 2 2 0.000000000000000 35.500000000000000 20.905853247356347 3.3000000000000000 + 1034 2 2 0.000000000000000 36.210000000000001 19.676097173982445 3.3000000000000000 + 1035 2 2 0.000000000000000 37.630000000000003 19.676097173982445 3.3000000000000000 + 1036 2 2 0.000000000000000 38.340000000000003 20.905853247356347 3.3000000000000000 + 1037 2 2 0.000000000000000 39.759999999999998 20.905853247356347 3.3000000000000000 + 1038 2 2 0.000000000000000 40.469999999999999 19.676097173982445 3.3000000000000000 + 1039 2 2 0.000000000000000 41.890000000000001 19.676097173982445 3.3000000000000000 + 1040 2 2 0.000000000000000 42.599999999999994 20.905853247356347 3.3000000000000000 + 1041 2 2 0.000000000000000 1.420000000000000 23.365365394104153 3.3000000000000000 + 1042 2 2 0.000000000000000 2.130000000000000 22.135609320730250 3.3000000000000000 + 1043 2 2 0.000000000000000 3.550000000000000 22.135609320730250 3.3000000000000000 + 1044 2 2 0.000000000000000 4.260000000000000 23.365365394104153 3.3000000000000000 + 1045 2 2 0.000000000000000 5.680000000000000 23.365365394104153 3.3000000000000000 + 1046 2 2 0.000000000000000 6.390000000000000 22.135609320730250 3.3000000000000000 + 1047 2 2 0.000000000000000 7.810000000000000 22.135609320730250 3.3000000000000000 + 1048 2 2 0.000000000000000 8.520000000000000 23.365365394104153 3.3000000000000000 + 1049 2 2 0.000000000000000 9.940000000000000 23.365365394104153 3.3000000000000000 + 1050 2 2 0.000000000000000 10.650000000000000 22.135609320730250 3.3000000000000000 + 1051 2 2 0.000000000000000 12.069999999999999 22.135609320730250 3.3000000000000000 + 1052 2 2 0.000000000000000 12.779999999999999 23.365365394104153 3.3000000000000000 + 1053 2 2 0.000000000000000 14.199999999999999 23.365365394104153 3.3000000000000000 + 1054 2 2 0.000000000000000 14.909999999999998 22.135609320730250 3.3000000000000000 + 1055 2 2 0.000000000000000 16.329999999999998 22.135609320730250 3.3000000000000000 + 1056 2 2 0.000000000000000 17.039999999999999 23.365365394104153 3.3000000000000000 + 1057 2 2 0.000000000000000 18.460000000000001 23.365365394104153 3.3000000000000000 + 1058 2 2 0.000000000000000 19.170000000000002 22.135609320730250 3.3000000000000000 + 1059 2 2 0.000000000000000 20.589999999999996 22.135609320730250 3.3000000000000000 + 1060 2 2 0.000000000000000 21.299999999999997 23.365365394104153 3.3000000000000000 + 1061 2 2 0.000000000000000 22.719999999999999 23.365365394104153 3.3000000000000000 + 1062 2 2 0.000000000000000 23.430000000000000 22.135609320730250 3.3000000000000000 + 1063 2 2 0.000000000000000 24.849999999999994 22.135609320730250 3.3000000000000000 + 1064 2 2 0.000000000000000 25.559999999999995 23.365365394104153 3.3000000000000000 + 1065 2 2 0.000000000000000 26.979999999999997 23.365365394104153 3.3000000000000000 + 1066 2 2 0.000000000000000 27.689999999999998 22.135609320730250 3.3000000000000000 + 1067 2 2 0.000000000000000 29.109999999999999 22.135609320730250 3.3000000000000000 + 1068 2 2 0.000000000000000 29.820000000000000 23.365365394104153 3.3000000000000000 + 1069 2 2 0.000000000000000 31.240000000000002 23.365365394104153 3.3000000000000000 + 1070 2 2 0.000000000000000 31.950000000000003 22.135609320730250 3.3000000000000000 + 1071 2 2 0.000000000000000 33.369999999999997 22.135609320730250 3.3000000000000000 + 1072 2 2 0.000000000000000 34.079999999999998 23.365365394104153 3.3000000000000000 + 1073 2 2 0.000000000000000 35.500000000000000 23.365365394104153 3.3000000000000000 + 1074 2 2 0.000000000000000 36.210000000000001 22.135609320730250 3.3000000000000000 + 1075 2 2 0.000000000000000 37.630000000000003 22.135609320730250 3.3000000000000000 + 1076 2 2 0.000000000000000 38.340000000000003 23.365365394104153 3.3000000000000000 + 1077 2 2 0.000000000000000 39.759999999999998 23.365365394104153 3.3000000000000000 + 1078 2 2 0.000000000000000 40.469999999999999 22.135609320730250 3.3000000000000000 + 1079 2 2 0.000000000000000 41.890000000000001 22.135609320730250 3.3000000000000000 + 1080 2 2 0.000000000000000 42.599999999999994 23.365365394104153 3.3000000000000000 + 1081 2 2 0.000000000000000 1.420000000000000 25.824877540851958 3.3000000000000000 + 1082 2 2 0.000000000000000 2.130000000000000 24.595121467478055 3.3000000000000000 + 1083 2 2 0.000000000000000 3.550000000000000 24.595121467478055 3.3000000000000000 + 1084 2 2 0.000000000000000 4.260000000000000 25.824877540851958 3.3000000000000000 + 1085 2 2 0.000000000000000 5.680000000000000 25.824877540851958 3.3000000000000000 + 1086 2 2 0.000000000000000 6.390000000000000 24.595121467478055 3.3000000000000000 + 1087 2 2 0.000000000000000 7.810000000000000 24.595121467478055 3.3000000000000000 + 1088 2 2 0.000000000000000 8.520000000000000 25.824877540851958 3.3000000000000000 + 1089 2 2 0.000000000000000 9.940000000000000 25.824877540851958 3.3000000000000000 + 1090 2 2 0.000000000000000 10.650000000000000 24.595121467478055 3.3000000000000000 + 1091 2 2 0.000000000000000 12.069999999999999 24.595121467478055 3.3000000000000000 + 1092 2 2 0.000000000000000 12.779999999999999 25.824877540851958 3.3000000000000000 + 1093 2 2 0.000000000000000 14.199999999999999 25.824877540851958 3.3000000000000000 + 1094 2 2 0.000000000000000 14.909999999999998 24.595121467478055 3.3000000000000000 + 1095 2 2 0.000000000000000 16.329999999999998 24.595121467478055 3.3000000000000000 + 1096 2 2 0.000000000000000 17.039999999999999 25.824877540851958 3.3000000000000000 + 1097 2 2 0.000000000000000 18.460000000000001 25.824877540851958 3.3000000000000000 + 1098 2 2 0.000000000000000 19.170000000000002 24.595121467478055 3.3000000000000000 + 1099 2 2 0.000000000000000 20.589999999999996 24.595121467478055 3.3000000000000000 + 1100 2 2 0.000000000000000 21.299999999999997 25.824877540851958 3.3000000000000000 + 1101 2 2 0.000000000000000 22.719999999999999 25.824877540851958 3.3000000000000000 + 1102 2 2 0.000000000000000 23.430000000000000 24.595121467478055 3.3000000000000000 + 1103 2 2 0.000000000000000 24.849999999999994 24.595121467478055 3.3000000000000000 + 1104 2 2 0.000000000000000 25.559999999999995 25.824877540851958 3.3000000000000000 + 1105 2 2 0.000000000000000 26.979999999999997 25.824877540851958 3.3000000000000000 + 1106 2 2 0.000000000000000 27.689999999999998 24.595121467478055 3.3000000000000000 + 1107 2 2 0.000000000000000 29.109999999999999 24.595121467478055 3.3000000000000000 + 1108 2 2 0.000000000000000 29.820000000000000 25.824877540851958 3.3000000000000000 + 1109 2 2 0.000000000000000 31.240000000000002 25.824877540851958 3.3000000000000000 + 1110 2 2 0.000000000000000 31.950000000000003 24.595121467478055 3.3000000000000000 + 1111 2 2 0.000000000000000 33.369999999999997 24.595121467478055 3.3000000000000000 + 1112 2 2 0.000000000000000 34.079999999999998 25.824877540851958 3.3000000000000000 + 1113 2 2 0.000000000000000 35.500000000000000 25.824877540851958 3.3000000000000000 + 1114 2 2 0.000000000000000 36.210000000000001 24.595121467478055 3.3000000000000000 + 1115 2 2 0.000000000000000 37.630000000000003 24.595121467478055 3.3000000000000000 + 1116 2 2 0.000000000000000 38.340000000000003 25.824877540851958 3.3000000000000000 + 1117 2 2 0.000000000000000 39.759999999999998 25.824877540851958 3.3000000000000000 + 1118 2 2 0.000000000000000 40.469999999999999 24.595121467478055 3.3000000000000000 + 1119 2 2 0.000000000000000 41.890000000000001 24.595121467478055 3.3000000000000000 + 1120 2 2 0.000000000000000 42.599999999999994 25.824877540851958 3.3000000000000000 + 1121 2 2 0.000000000000000 1.420000000000000 28.284389687599763 3.3000000000000000 + 1122 2 2 0.000000000000000 2.130000000000000 27.054633614225860 3.3000000000000000 + 1123 2 2 0.000000000000000 3.550000000000000 27.054633614225860 3.3000000000000000 + 1124 2 2 0.000000000000000 4.260000000000000 28.284389687599763 3.3000000000000000 + 1125 2 2 0.000000000000000 5.680000000000000 28.284389687599763 3.3000000000000000 + 1126 2 2 0.000000000000000 6.390000000000000 27.054633614225860 3.3000000000000000 + 1127 2 2 0.000000000000000 7.810000000000000 27.054633614225860 3.3000000000000000 + 1128 2 2 0.000000000000000 8.520000000000000 28.284389687599763 3.3000000000000000 + 1129 2 2 0.000000000000000 9.940000000000000 28.284389687599763 3.3000000000000000 + 1130 2 2 0.000000000000000 10.650000000000000 27.054633614225860 3.3000000000000000 + 1131 2 2 0.000000000000000 12.069999999999999 27.054633614225860 3.3000000000000000 + 1132 2 2 0.000000000000000 12.779999999999999 28.284389687599763 3.3000000000000000 + 1133 2 2 0.000000000000000 14.199999999999999 28.284389687599763 3.3000000000000000 + 1134 2 2 0.000000000000000 14.909999999999998 27.054633614225860 3.3000000000000000 + 1135 2 2 0.000000000000000 16.329999999999998 27.054633614225860 3.3000000000000000 + 1136 2 2 0.000000000000000 17.039999999999999 28.284389687599763 3.3000000000000000 + 1137 2 2 0.000000000000000 18.460000000000001 28.284389687599763 3.3000000000000000 + 1138 2 2 0.000000000000000 19.170000000000002 27.054633614225860 3.3000000000000000 + 1139 2 2 0.000000000000000 20.589999999999996 27.054633614225860 3.3000000000000000 + 1140 2 2 0.000000000000000 21.299999999999997 28.284389687599763 3.3000000000000000 + 1141 2 2 0.000000000000000 22.719999999999999 28.284389687599763 3.3000000000000000 + 1142 2 2 0.000000000000000 23.430000000000000 27.054633614225860 3.3000000000000000 + 1143 2 2 0.000000000000000 24.849999999999994 27.054633614225860 3.3000000000000000 + 1144 2 2 0.000000000000000 25.559999999999995 28.284389687599763 3.3000000000000000 + 1145 2 2 0.000000000000000 26.979999999999997 28.284389687599763 3.3000000000000000 + 1146 2 2 0.000000000000000 27.689999999999998 27.054633614225860 3.3000000000000000 + 1147 2 2 0.000000000000000 29.109999999999999 27.054633614225860 3.3000000000000000 + 1148 2 2 0.000000000000000 29.820000000000000 28.284389687599763 3.3000000000000000 + 1149 2 2 0.000000000000000 31.240000000000002 28.284389687599763 3.3000000000000000 + 1150 2 2 0.000000000000000 31.950000000000003 27.054633614225860 3.3000000000000000 + 1151 2 2 0.000000000000000 33.369999999999997 27.054633614225860 3.3000000000000000 + 1152 2 2 0.000000000000000 34.079999999999998 28.284389687599763 3.3000000000000000 + 1153 2 2 0.000000000000000 35.500000000000000 28.284389687599763 3.3000000000000000 + 1154 2 2 0.000000000000000 36.210000000000001 27.054633614225860 3.3000000000000000 + 1155 2 2 0.000000000000000 37.630000000000003 27.054633614225860 3.3000000000000000 + 1156 2 2 0.000000000000000 38.340000000000003 28.284389687599763 3.3000000000000000 + 1157 2 2 0.000000000000000 39.759999999999998 28.284389687599763 3.3000000000000000 + 1158 2 2 0.000000000000000 40.469999999999999 27.054633614225860 3.3000000000000000 + 1159 2 2 0.000000000000000 41.890000000000001 27.054633614225860 3.3000000000000000 + 1160 2 2 0.000000000000000 42.599999999999994 28.284389687599763 3.3000000000000000 + 1161 2 2 0.000000000000000 1.420000000000000 30.743901834347572 3.3000000000000000 + 1162 2 2 0.000000000000000 2.130000000000000 29.514145760973669 3.3000000000000000 + 1163 2 2 0.000000000000000 3.550000000000000 29.514145760973669 3.3000000000000000 + 1164 2 2 0.000000000000000 4.260000000000000 30.743901834347572 3.3000000000000000 + 1165 2 2 0.000000000000000 5.680000000000000 30.743901834347572 3.3000000000000000 + 1166 2 2 0.000000000000000 6.390000000000000 29.514145760973669 3.3000000000000000 + 1167 2 2 0.000000000000000 7.810000000000000 29.514145760973669 3.3000000000000000 + 1168 2 2 0.000000000000000 8.520000000000000 30.743901834347572 3.3000000000000000 + 1169 2 2 0.000000000000000 9.940000000000000 30.743901834347572 3.3000000000000000 + 1170 2 2 0.000000000000000 10.650000000000000 29.514145760973669 3.3000000000000000 + 1171 2 2 0.000000000000000 12.069999999999999 29.514145760973669 3.3000000000000000 + 1172 2 2 0.000000000000000 12.779999999999999 30.743901834347572 3.3000000000000000 + 1173 2 2 0.000000000000000 14.199999999999999 30.743901834347572 3.3000000000000000 + 1174 2 2 0.000000000000000 14.909999999999998 29.514145760973669 3.3000000000000000 + 1175 2 2 0.000000000000000 16.329999999999998 29.514145760973669 3.3000000000000000 + 1176 2 2 0.000000000000000 17.039999999999999 30.743901834347572 3.3000000000000000 + 1177 2 2 0.000000000000000 18.460000000000001 30.743901834347572 3.3000000000000000 + 1178 2 2 0.000000000000000 19.170000000000002 29.514145760973669 3.3000000000000000 + 1179 2 2 0.000000000000000 20.589999999999996 29.514145760973669 3.3000000000000000 + 1180 2 2 0.000000000000000 21.299999999999997 30.743901834347572 3.3000000000000000 + 1181 2 2 0.000000000000000 22.719999999999999 30.743901834347572 3.3000000000000000 + 1182 2 2 0.000000000000000 23.430000000000000 29.514145760973669 3.3000000000000000 + 1183 2 2 0.000000000000000 24.849999999999994 29.514145760973669 3.3000000000000000 + 1184 2 2 0.000000000000000 25.559999999999995 30.743901834347572 3.3000000000000000 + 1185 2 2 0.000000000000000 26.979999999999997 30.743901834347572 3.3000000000000000 + 1186 2 2 0.000000000000000 27.689999999999998 29.514145760973669 3.3000000000000000 + 1187 2 2 0.000000000000000 29.109999999999999 29.514145760973669 3.3000000000000000 + 1188 2 2 0.000000000000000 29.820000000000000 30.743901834347572 3.3000000000000000 + 1189 2 2 0.000000000000000 31.240000000000002 30.743901834347572 3.3000000000000000 + 1190 2 2 0.000000000000000 31.950000000000003 29.514145760973669 3.3000000000000000 + 1191 2 2 0.000000000000000 33.369999999999997 29.514145760973669 3.3000000000000000 + 1192 2 2 0.000000000000000 34.079999999999998 30.743901834347572 3.3000000000000000 + 1193 2 2 0.000000000000000 35.500000000000000 30.743901834347572 3.3000000000000000 + 1194 2 2 0.000000000000000 36.210000000000001 29.514145760973669 3.3000000000000000 + 1195 2 2 0.000000000000000 37.630000000000003 29.514145760973669 3.3000000000000000 + 1196 2 2 0.000000000000000 38.340000000000003 30.743901834347572 3.3000000000000000 + 1197 2 2 0.000000000000000 39.759999999999998 30.743901834347572 3.3000000000000000 + 1198 2 2 0.000000000000000 40.469999999999999 29.514145760973669 3.3000000000000000 + 1199 2 2 0.000000000000000 41.890000000000001 29.514145760973669 3.3000000000000000 + 1200 2 2 0.000000000000000 42.599999999999994 30.743901834347572 3.3000000000000000 + 1201 2 2 0.000000000000000 1.420000000000000 33.203413981095380 3.3000000000000000 + 1202 2 2 0.000000000000000 2.130000000000000 31.973657907721474 3.3000000000000000 + 1203 2 2 0.000000000000000 3.550000000000000 31.973657907721474 3.3000000000000000 + 1204 2 2 0.000000000000000 4.260000000000000 33.203413981095380 3.3000000000000000 + 1205 2 2 0.000000000000000 5.680000000000000 33.203413981095380 3.3000000000000000 + 1206 2 2 0.000000000000000 6.390000000000000 31.973657907721474 3.3000000000000000 + 1207 2 2 0.000000000000000 7.810000000000000 31.973657907721474 3.3000000000000000 + 1208 2 2 0.000000000000000 8.520000000000000 33.203413981095380 3.3000000000000000 + 1209 2 2 0.000000000000000 9.940000000000000 33.203413981095380 3.3000000000000000 + 1210 2 2 0.000000000000000 10.650000000000000 31.973657907721474 3.3000000000000000 + 1211 2 2 0.000000000000000 12.069999999999999 31.973657907721474 3.3000000000000000 + 1212 2 2 0.000000000000000 12.779999999999999 33.203413981095380 3.3000000000000000 + 1213 2 2 0.000000000000000 14.199999999999999 33.203413981095380 3.3000000000000000 + 1214 2 2 0.000000000000000 14.909999999999998 31.973657907721474 3.3000000000000000 + 1215 2 2 0.000000000000000 16.329999999999998 31.973657907721474 3.3000000000000000 + 1216 2 2 0.000000000000000 17.039999999999999 33.203413981095380 3.3000000000000000 + 1217 2 2 0.000000000000000 18.460000000000001 33.203413981095380 3.3000000000000000 + 1218 2 2 0.000000000000000 19.170000000000002 31.973657907721474 3.3000000000000000 + 1219 2 2 0.000000000000000 20.589999999999996 31.973657907721474 3.3000000000000000 + 1220 2 2 0.000000000000000 21.299999999999997 33.203413981095380 3.3000000000000000 + 1221 2 2 0.000000000000000 22.719999999999999 33.203413981095380 3.3000000000000000 + 1222 2 2 0.000000000000000 23.430000000000000 31.973657907721474 3.3000000000000000 + 1223 2 2 0.000000000000000 24.849999999999994 31.973657907721474 3.3000000000000000 + 1224 2 2 0.000000000000000 25.559999999999995 33.203413981095380 3.3000000000000000 + 1225 2 2 0.000000000000000 26.979999999999997 33.203413981095380 3.3000000000000000 + 1226 2 2 0.000000000000000 27.689999999999998 31.973657907721474 3.3000000000000000 + 1227 2 2 0.000000000000000 29.109999999999999 31.973657907721474 3.3000000000000000 + 1228 2 2 0.000000000000000 29.820000000000000 33.203413981095380 3.3000000000000000 + 1229 2 2 0.000000000000000 31.240000000000002 33.203413981095380 3.3000000000000000 + 1230 2 2 0.000000000000000 31.950000000000003 31.973657907721474 3.3000000000000000 + 1231 2 2 0.000000000000000 33.369999999999997 31.973657907721474 3.3000000000000000 + 1232 2 2 0.000000000000000 34.079999999999998 33.203413981095380 3.3000000000000000 + 1233 2 2 0.000000000000000 35.500000000000000 33.203413981095380 3.3000000000000000 + 1234 2 2 0.000000000000000 36.210000000000001 31.973657907721474 3.3000000000000000 + 1235 2 2 0.000000000000000 37.630000000000003 31.973657907721474 3.3000000000000000 + 1236 2 2 0.000000000000000 38.340000000000003 33.203413981095380 3.3000000000000000 + 1237 2 2 0.000000000000000 39.759999999999998 33.203413981095380 3.3000000000000000 + 1238 2 2 0.000000000000000 40.469999999999999 31.973657907721474 3.3000000000000000 + 1239 2 2 0.000000000000000 41.890000000000001 31.973657907721474 3.3000000000000000 + 1240 2 2 0.000000000000000 42.599999999999994 33.203413981095380 3.3000000000000000 + 1241 2 2 0.000000000000000 1.420000000000000 35.662926127843185 3.3000000000000000 + 1242 2 2 0.000000000000000 2.130000000000000 34.433170054469279 3.3000000000000000 + 1243 2 2 0.000000000000000 3.550000000000000 34.433170054469279 3.3000000000000000 + 1244 2 2 0.000000000000000 4.260000000000000 35.662926127843185 3.3000000000000000 + 1245 2 2 0.000000000000000 5.680000000000000 35.662926127843185 3.3000000000000000 + 1246 2 2 0.000000000000000 6.390000000000000 34.433170054469279 3.3000000000000000 + 1247 2 2 0.000000000000000 7.810000000000000 34.433170054469279 3.3000000000000000 + 1248 2 2 0.000000000000000 8.520000000000000 35.662926127843185 3.3000000000000000 + 1249 2 2 0.000000000000000 9.940000000000000 35.662926127843185 3.3000000000000000 + 1250 2 2 0.000000000000000 10.650000000000000 34.433170054469279 3.3000000000000000 + 1251 2 2 0.000000000000000 12.069999999999999 34.433170054469279 3.3000000000000000 + 1252 2 2 0.000000000000000 12.779999999999999 35.662926127843185 3.3000000000000000 + 1253 2 2 0.000000000000000 14.199999999999999 35.662926127843185 3.3000000000000000 + 1254 2 2 0.000000000000000 14.909999999999998 34.433170054469279 3.3000000000000000 + 1255 2 2 0.000000000000000 16.329999999999998 34.433170054469279 3.3000000000000000 + 1256 2 2 0.000000000000000 17.039999999999999 35.662926127843185 3.3000000000000000 + 1257 2 2 0.000000000000000 18.460000000000001 35.662926127843185 3.3000000000000000 + 1258 2 2 0.000000000000000 19.170000000000002 34.433170054469279 3.3000000000000000 + 1259 2 2 0.000000000000000 20.589999999999996 34.433170054469279 3.3000000000000000 + 1260 2 2 0.000000000000000 21.299999999999997 35.662926127843185 3.3000000000000000 + 1261 2 2 0.000000000000000 22.719999999999999 35.662926127843185 3.3000000000000000 + 1262 2 2 0.000000000000000 23.430000000000000 34.433170054469279 3.3000000000000000 + 1263 2 2 0.000000000000000 24.849999999999994 34.433170054469279 3.3000000000000000 + 1264 2 2 0.000000000000000 25.559999999999995 35.662926127843185 3.3000000000000000 + 1265 2 2 0.000000000000000 26.979999999999997 35.662926127843185 3.3000000000000000 + 1266 2 2 0.000000000000000 27.689999999999998 34.433170054469279 3.3000000000000000 + 1267 2 2 0.000000000000000 29.109999999999999 34.433170054469279 3.3000000000000000 + 1268 2 2 0.000000000000000 29.820000000000000 35.662926127843185 3.3000000000000000 + 1269 2 2 0.000000000000000 31.240000000000002 35.662926127843185 3.3000000000000000 + 1270 2 2 0.000000000000000 31.950000000000003 34.433170054469279 3.3000000000000000 + 1271 2 2 0.000000000000000 33.369999999999997 34.433170054469279 3.3000000000000000 + 1272 2 2 0.000000000000000 34.079999999999998 35.662926127843185 3.3000000000000000 + 1273 2 2 0.000000000000000 35.500000000000000 35.662926127843185 3.3000000000000000 + 1274 2 2 0.000000000000000 36.210000000000001 34.433170054469279 3.3000000000000000 + 1275 2 2 0.000000000000000 37.630000000000003 34.433170054469279 3.3000000000000000 + 1276 2 2 0.000000000000000 38.340000000000003 35.662926127843185 3.3000000000000000 + 1277 2 2 0.000000000000000 39.759999999999998 35.662926127843185 3.3000000000000000 + 1278 2 2 0.000000000000000 40.469999999999999 34.433170054469279 3.3000000000000000 + 1279 2 2 0.000000000000000 41.890000000000001 34.433170054469279 3.3000000000000000 + 1280 2 2 0.000000000000000 42.599999999999994 35.662926127843185 3.3000000000000000 + 1281 2 2 0.000000000000000 1.420000000000000 38.122438274590991 3.3000000000000000 + 1282 2 2 0.000000000000000 2.130000000000000 36.892682201217085 3.3000000000000000 + 1283 2 2 0.000000000000000 3.550000000000000 36.892682201217085 3.3000000000000000 + 1284 2 2 0.000000000000000 4.260000000000000 38.122438274590991 3.3000000000000000 + 1285 2 2 0.000000000000000 5.680000000000000 38.122438274590991 3.3000000000000000 + 1286 2 2 0.000000000000000 6.390000000000000 36.892682201217085 3.3000000000000000 + 1287 2 2 0.000000000000000 7.810000000000000 36.892682201217085 3.3000000000000000 + 1288 2 2 0.000000000000000 8.520000000000000 38.122438274590991 3.3000000000000000 + 1289 2 2 0.000000000000000 9.940000000000000 38.122438274590991 3.3000000000000000 + 1290 2 2 0.000000000000000 10.650000000000000 36.892682201217085 3.3000000000000000 + 1291 2 2 0.000000000000000 12.069999999999999 36.892682201217085 3.3000000000000000 + 1292 2 2 0.000000000000000 12.779999999999999 38.122438274590991 3.3000000000000000 + 1293 2 2 0.000000000000000 14.199999999999999 38.122438274590991 3.3000000000000000 + 1294 2 2 0.000000000000000 14.909999999999998 36.892682201217085 3.3000000000000000 + 1295 2 2 0.000000000000000 16.329999999999998 36.892682201217085 3.3000000000000000 + 1296 2 2 0.000000000000000 17.039999999999999 38.122438274590991 3.3000000000000000 + 1297 2 2 0.000000000000000 18.460000000000001 38.122438274590991 3.3000000000000000 + 1298 2 2 0.000000000000000 19.170000000000002 36.892682201217085 3.3000000000000000 + 1299 2 2 0.000000000000000 20.589999999999996 36.892682201217085 3.3000000000000000 + 1300 2 2 0.000000000000000 21.299999999999997 38.122438274590991 3.3000000000000000 + 1301 2 2 0.000000000000000 22.719999999999999 38.122438274590991 3.3000000000000000 + 1302 2 2 0.000000000000000 23.430000000000000 36.892682201217085 3.3000000000000000 + 1303 2 2 0.000000000000000 24.849999999999994 36.892682201217085 3.3000000000000000 + 1304 2 2 0.000000000000000 25.559999999999995 38.122438274590991 3.3000000000000000 + 1305 2 2 0.000000000000000 26.979999999999997 38.122438274590991 3.3000000000000000 + 1306 2 2 0.000000000000000 27.689999999999998 36.892682201217085 3.3000000000000000 + 1307 2 2 0.000000000000000 29.109999999999999 36.892682201217085 3.3000000000000000 + 1308 2 2 0.000000000000000 29.820000000000000 38.122438274590991 3.3000000000000000 + 1309 2 2 0.000000000000000 31.240000000000002 38.122438274590991 3.3000000000000000 + 1310 2 2 0.000000000000000 31.950000000000003 36.892682201217085 3.3000000000000000 + 1311 2 2 0.000000000000000 33.369999999999997 36.892682201217085 3.3000000000000000 + 1312 2 2 0.000000000000000 34.079999999999998 38.122438274590991 3.3000000000000000 + 1313 2 2 0.000000000000000 35.500000000000000 38.122438274590991 3.3000000000000000 + 1314 2 2 0.000000000000000 36.210000000000001 36.892682201217085 3.3000000000000000 + 1315 2 2 0.000000000000000 37.630000000000003 36.892682201217085 3.3000000000000000 + 1316 2 2 0.000000000000000 38.340000000000003 38.122438274590991 3.3000000000000000 + 1317 2 2 0.000000000000000 39.759999999999998 38.122438274590991 3.3000000000000000 + 1318 2 2 0.000000000000000 40.469999999999999 36.892682201217085 3.3000000000000000 + 1319 2 2 0.000000000000000 41.890000000000001 36.892682201217085 3.3000000000000000 + 1320 2 2 0.000000000000000 42.599999999999994 38.122438274590991 3.3000000000000000 + 1321 2 2 0.000000000000000 1.420000000000000 40.581950421338796 3.3000000000000000 + 1322 2 2 0.000000000000000 2.130000000000000 39.352194347964890 3.3000000000000000 + 1323 2 2 0.000000000000000 3.550000000000000 39.352194347964890 3.3000000000000000 + 1324 2 2 0.000000000000000 4.260000000000000 40.581950421338796 3.3000000000000000 + 1325 2 2 0.000000000000000 5.680000000000000 40.581950421338796 3.3000000000000000 + 1326 2 2 0.000000000000000 6.390000000000000 39.352194347964890 3.3000000000000000 + 1327 2 2 0.000000000000000 7.810000000000000 39.352194347964890 3.3000000000000000 + 1328 2 2 0.000000000000000 8.520000000000000 40.581950421338796 3.3000000000000000 + 1329 2 2 0.000000000000000 9.940000000000000 40.581950421338796 3.3000000000000000 + 1330 2 2 0.000000000000000 10.650000000000000 39.352194347964890 3.3000000000000000 + 1331 2 2 0.000000000000000 12.069999999999999 39.352194347964890 3.3000000000000000 + 1332 2 2 0.000000000000000 12.779999999999999 40.581950421338796 3.3000000000000000 + 1333 2 2 0.000000000000000 14.199999999999999 40.581950421338796 3.3000000000000000 + 1334 2 2 0.000000000000000 14.909999999999998 39.352194347964890 3.3000000000000000 + 1335 2 2 0.000000000000000 16.329999999999998 39.352194347964890 3.3000000000000000 + 1336 2 2 0.000000000000000 17.039999999999999 40.581950421338796 3.3000000000000000 + 1337 2 2 0.000000000000000 18.460000000000001 40.581950421338796 3.3000000000000000 + 1338 2 2 0.000000000000000 19.170000000000002 39.352194347964890 3.3000000000000000 + 1339 2 2 0.000000000000000 20.589999999999996 39.352194347964890 3.3000000000000000 + 1340 2 2 0.000000000000000 21.299999999999997 40.581950421338796 3.3000000000000000 + 1341 2 2 0.000000000000000 22.719999999999999 40.581950421338796 3.3000000000000000 + 1342 2 2 0.000000000000000 23.430000000000000 39.352194347964890 3.3000000000000000 + 1343 2 2 0.000000000000000 24.849999999999994 39.352194347964890 3.3000000000000000 + 1344 2 2 0.000000000000000 25.559999999999995 40.581950421338796 3.3000000000000000 + 1345 2 2 0.000000000000000 26.979999999999997 40.581950421338796 3.3000000000000000 + 1346 2 2 0.000000000000000 27.689999999999998 39.352194347964890 3.3000000000000000 + 1347 2 2 0.000000000000000 29.109999999999999 39.352194347964890 3.3000000000000000 + 1348 2 2 0.000000000000000 29.820000000000000 40.581950421338796 3.3000000000000000 + 1349 2 2 0.000000000000000 31.240000000000002 40.581950421338796 3.3000000000000000 + 1350 2 2 0.000000000000000 31.950000000000003 39.352194347964890 3.3000000000000000 + 1351 2 2 0.000000000000000 33.369999999999997 39.352194347964890 3.3000000000000000 + 1352 2 2 0.000000000000000 34.079999999999998 40.581950421338796 3.3000000000000000 + 1353 2 2 0.000000000000000 35.500000000000000 40.581950421338796 3.3000000000000000 + 1354 2 2 0.000000000000000 36.210000000000001 39.352194347964890 3.3000000000000000 + 1355 2 2 0.000000000000000 37.630000000000003 39.352194347964890 3.3000000000000000 + 1356 2 2 0.000000000000000 38.340000000000003 40.581950421338796 3.3000000000000000 + 1357 2 2 0.000000000000000 39.759999999999998 40.581950421338796 3.3000000000000000 + 1358 2 2 0.000000000000000 40.469999999999999 39.352194347964890 3.3000000000000000 + 1359 2 2 0.000000000000000 41.890000000000001 39.352194347964890 3.3000000000000000 + 1360 2 2 0.000000000000000 42.599999999999994 40.581950421338796 3.3000000000000000 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo new file mode 120000 index 0000000000..b98001a7fd --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo @@ -0,0 +1 @@ +../../../../../potentials/CH.rebo \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene index 8674917af2..949de4b74c 100644 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene @@ -5,21 +5,22 @@ atom_style full processors * * 1 # domain decomposition over x and y # System and atom definition -# we use 2 atom types so that inter- and intra-layer +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer # interactions can be specified separately -# read lammps data file -read_data Bi_gr_AB_stack_2L_noH_300K.data + +read_data Bi_gr_AB_stack_2L_noH.data mass 1 12.0107 # carbon mass (g/mole) | membrane mass 2 12.0107 # carbon mass (g/mole) | adsorbate # Separate atom groups -group membrane type 1 -group adsorbate type 2 +group layer1 molecule 1 +group layer2 molecule 2 ######################## Potential defition ######################## pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 #################################################################### -pair_coeff * * rebo CH.airebo NULL C # chemical -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP C C # long range +pair_coeff * * rebo CH.rebo C C # chemical +pair_coeff * * ilp/graphene/hbn BNCH.ILP C C # long range #################################################################### # Neighbor update settings neighbor 2.0 bin @@ -27,35 +28,25 @@ neigh_modify every 1 neigh_modify delay 0 neigh_modify check yes -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - #### Simulation settings #### -timestep 0.001 -#velocity adsorbate create 300.0 12345 -fix subf membrane setforce 0.0 0.0 0.0 -fix thermostat all nve +timestep 0.001 +velocity all create 300.0 12345 -compute 0 all pair rebo -compute 1 all pair ilp/graphene/hbn -variable REBO equal c_0 -variable ILP equal c_1 +compute 0 all pair rebo +compute 1 all pair ilp/graphene/hbn +variable REBO equal c_0 # REBO energy +variable ILP equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy ############################ # Output thermo 100 -thermo_style custom step etotal pe ke v_REBO v_ILP temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom -thermo_modify line one format float %.10f +thermo_style custom step cpu etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp +thermo_modify line one format float %.16f thermo_modify flush yes norm no lost warn -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - ###### Run molecular dynamics ###### -run 1000 +fix thermostat all nve +run 1000 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 new file mode 100644 index 0000000000..bb36f22d81 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 @@ -0,0 +1,128 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use 2 molecule ids so that inter- and intra-layer +# interactions can be specified separately +# read lammps data file +read_data Bi_gr_AB_stack_2L_noH.data + orthogonal box = (0 0 0) to (42.6 41.8117 100) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.00018123 secs + read_data CPU = 0.00179349 secs +mass 1 12.0107 # carbon mass (g/mole) | membrane +mass 2 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 +#################################################################### +pair_coeff * * rebo CH.rebo C C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * ilp/graphene/hbn BNCH.ILP C C # long range +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 + +compute 0 all pair rebo +compute 1 all pair ilp/graphene/hbn +variable REBO equal c_0 # REBO energy +variable ILP equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy + +############################ + +# Output +thermo 100 +thermo_style custom step cpu etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp +thermo_modify line one format float %.16f +thermo_modify flush yes norm no lost warn + +###### Run molecular dynamics ###### +fix thermostat all nve +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair rebo, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (2) pair ilp/graphene/hbn, perpetual, copy from (1) + attributes: full, newton on, ghost + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 20.52 | 20.52 | 20.52 Mbytes +Step CPU TotEng PotEng KinEng v_REBO v_ILP v_Erep v_Evdw Temp + 0 0.0000000000000000 -10037.2853168513975106 -10089.9846779678973689 52.6993611164999436 -10057.1894932863488066 -32.7951846815484842 43.6401037466550932 -76.4352884281863538 299.9999999999996589 + 100 5.4714687280356884 -10037.0338552868142870 -10064.7651651140276954 27.7313098272134866 -10032.1809546658514591 -32.5842104481769326 34.7308676709731401 -67.3150781191208409 157.8651576016785896 + 200 10.9391297820257023 -10036.9626863095945737 -10061.1437965401473775 24.1811102305520329 -10028.8556641958457476 -32.2881323443021699 28.1799358234288526 -60.4680681676962450 137.6550477173489071 + 300 16.5882020250428468 -10037.0034097789539373 -10063.5001355365984637 26.4967257576440751 -10030.8230306457862753 -32.6771048908121244 34.9238490632189666 -67.6009539540019659 150.8370795942042264 + 400 22.1194989730138332 -10037.0320901258455706 -10064.3886163746337843 27.3565262487876240 -10031.8532011416427849 -32.5354152329904451 44.2423469839209460 -76.7777622168925546 155.7316388806602561 + 500 27.6722563949879259 -10037.0233394483148004 -10064.1136184894730832 27.0902790411580163 -10031.4312007416901906 -32.6824177477829565 37.2292320482101289 -69.9116497959676906 154.2159817531989177 + 600 33.2032995349727571 -10037.0033561502987141 -10063.6570740290953836 26.6537178787960869 -10031.3274097829344100 -32.3296642461602843 28.5090732059975061 -60.8387374521216842 151.7307837178934449 + 700 38.6685221369843930 -10037.0041655805853225 -10063.3498627390818001 26.3456971584966979 -10030.8006321783104795 -32.5492305607709014 32.5646861904578486 -65.1139167511948074 149.9773238251721921 + 800 44.2185375869739801 -10037.0245724491269357 -10064.2193369538654224 27.1947645047377584 -10031.7656842933574808 -32.4536526605085243 43.3815569718683705 -75.8352096323569498 154.8107828743098082 + 900 49.6989215560024604 -10037.0283918584391358 -10064.6675188165245345 27.6391269580851500 -10032.1673975747289660 -32.5001212417962648 39.9934500237055133 -72.4935712654787778 157.3403910741040761 + 1000 55.1455117090372369 -10037.0033475406326033 -10063.6621727186211501 26.6588251779885006 -10031.3371200905367004 -32.3250526280852100 29.5735783776502288 -61.8986310057011480 151.7598578798047697 +Loop time of 55.1456 on 1 procs for 1000 steps with 1360 atoms + +Performance: 1.567 ns/day, 15.318 hours/ns, 18.134 timesteps/s +100.0% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 55.092 | 55.092 | 55.092 | 0.0 | 99.90 +Bond | 0.00050265 | 0.00050265 | 0.00050265 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.032649 | 0.032649 | 0.032649 | 0.0 | 0.06 +Output | 0.00060948 | 0.00060948 | 0.00060948 | 0.0 | 0.00 +Modify | 0.0093351 | 0.0093351 | 0.0093351 | 0.0 | 0.02 +Other | | 0.01008 | | | 0.02 + +Nlocal: 1360 ave 1360 max 1360 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7964 ave 7964 max 7964 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 1.037e+06 ave 1.037e+06 max 1.037e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1037000 +Ave neighs/atom = 762.5 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:55 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 new file mode 100644 index 0000000000..95c495b677 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 @@ -0,0 +1,128 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use 2 molecule ids so that inter- and intra-layer +# interactions can be specified separately +# read lammps data file +read_data Bi_gr_AB_stack_2L_noH.data + orthogonal box = (0 0 0) to (42.6 41.8117 100) + 2 by 2 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000147377 secs + read_data CPU = 0.0025185 secs +mass 1 12.0107 # carbon mass (g/mole) | membrane +mass 2 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 +#################################################################### +pair_coeff * * rebo CH.rebo C C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * ilp/graphene/hbn BNCH.ILP C C # long range +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 + +compute 0 all pair rebo +compute 1 all pair ilp/graphene/hbn +variable REBO equal c_0 # REBO energy +variable ILP equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy + +############################ + +# Output +thermo 100 +thermo_style custom step cpu etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp +thermo_modify line one format float %.16f +thermo_modify flush yes norm no lost warn + +###### Run molecular dynamics ###### +fix thermostat all nve +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair rebo, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (2) pair ilp/graphene/hbn, perpetual, copy from (1) + attributes: full, newton on, ghost + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 11.64 | 11.64 | 11.64 Mbytes +Step CPU TotEng PotEng KinEng v_REBO v_ILP v_Erep v_Evdw Temp + 0 0.0000000000000000 -10037.2853168516194273 -10089.9846779681192857 52.6993611164999933 -10057.1894932866325689 -32.7951846814872354 43.6401037466782640 -76.4352884281594527 299.9999999999999432 + 100 1.5180878639221191 -10037.0338552867851831 -10064.7651651139967726 27.7313098272123320 -10032.1809546658569161 -32.5842104481406381 34.7308676709827395 -67.3150781191209546 157.8651576016720242 + 200 3.0293023219564930 -10036.9626863095381850 -10061.1437965400909889 24.1811102305529495 -10028.8556641958311957 -32.2881323442601911 28.1799358234373614 -60.4680681676959750 137.6550477173541367 + 300 4.5289151089964435 -10037.0034097789121006 -10063.5001355365566269 26.4967257576439188 -10030.8230306457808183 -32.6771048907772084 34.9238490632284311 -67.6009539540031454 150.8370795942033453 + 400 6.0309539699228480 -10037.0320901258182857 -10064.3886163746046805 27.3565262487870413 -10031.8532011416427849 -32.5354152329611424 44.2423469839354624 -76.7777622168941747 155.7316388806569307 + 500 7.5873900629812852 -10037.0233394482729636 -10064.1136184894312464 27.0902790411581904 -10031.4312007416810957 -32.6824177477510176 37.2292320482201404 -69.9116497959683159 154.2159817531999124 + 600 9.1088078819448128 -10037.0033561502586963 -10063.6570740290553658 26.6537178787959803 -10031.3274097829398670 -32.3296642461160033 28.5090732060055281 -60.8387374521202773 151.7307837178928480 + 700 10.6168858460150659 -10037.0041655805125629 -10063.3498627390090405 26.3456971584962574 -10030.8006321782777377 -32.5492305607314165 32.5646861904650535 -65.1139167511946653 149.9773238251696910 + 800 12.1294107990106568 -10037.0245724491123838 -10064.2193369538508705 27.1947645047383304 -10031.7656842933720327 -32.4536526604775162 43.3815569718824179 -75.8352096323571629 154.8107828743130767 + 900 13.6509861790109426 -10037.0283918584264029 -10064.6675188165099826 27.6391269580827625 -10032.1673975747471559 -32.5001212417642336 39.9934500237184380 -72.4935712654798436 157.3403910740904905 + 1000 15.1634582940023392 -10037.0033475405834906 -10063.6621727185720374 26.6588251779879926 -10031.3371200905276055 -32.3250526280445740 29.5735783776581442 -61.8986310057012972 151.7598578798018707 +Loop time of 15.1635 on 4 procs for 1000 steps with 1360 atoms + +Performance: 5.698 ns/day, 4.212 hours/ns, 65.948 timesteps/s +99.9% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 13.997 | 14.363 | 14.741 | 9.0 | 94.72 +Bond | 0.00036359 | 0.00040186 | 0.00044586 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.40664 | 0.78485 | 1.1509 | 38.6 | 5.18 +Output | 0.00027687 | 0.00036825 | 0.00063194 | 0.0 | 0.00 +Modify | 0.0043962 | 0.0045847 | 0.0047857 | 0.2 | 0.03 +Other | | 0.01055 | | | 0.07 + +Nlocal: 340 ave 340 max 340 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 4628 ave 4628 max 4628 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 259250 ave 259250 max 259250 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1037000 +Ave neighs/atom = 762.5 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:15 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff new file mode 120000 index 0000000000..0c35f80da1 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff @@ -0,0 +1 @@ +../../../../../potentials/BNC.tersoff \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP new file mode 120000 index 0000000000..b970e23f95 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP @@ -0,0 +1 @@ +../../../../../potentials/BNCH.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/hBN_AA_prime_stack_2L_noH.data b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/hBN_AA_prime_stack_2L_noH.data new file mode 100644 index 0000000000..b965f74d30 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/hBN_AA_prime_stack_2L_noH.data @@ -0,0 +1,1372 @@ + Generate Bi-layer hBN + + 1360 atoms + + 4 atom types + + 0.000000000000000 43.379999999999995 xlo xhi + 0.000000000000000 42.577272951658138 ylo yhi + 0.000000000000000 100.000000000000000 zlo zhi + + Atoms + + 1 1 1 0.42000 0.000000000000000 1.252272733872298 0.000000000000000 + 2 1 2 -0.42000 0.723000000000000 0.000000000000000 0.000000000000000 + 3 1 1 0.42000 2.169000000000000 0.000000000000000 0.000000000000000 + 4 1 2 -0.42000 2.892000000000000 1.252272733872298 0.000000000000000 + 5 1 1 0.42000 4.338000000000000 1.252272733872298 0.000000000000000 + 6 1 2 -0.42000 5.061000000000000 0.000000000000000 0.000000000000000 + 7 1 1 0.42000 6.507000000000000 0.000000000000000 0.000000000000000 + 8 1 2 -0.42000 7.230000000000000 1.252272733872298 0.000000000000000 + 9 1 1 0.42000 8.676000000000000 1.252272733872298 0.000000000000000 + 10 1 2 -0.42000 9.399000000000001 0.000000000000000 0.000000000000000 + 11 1 1 0.42000 10.845000000000001 0.000000000000000 0.000000000000000 + 12 1 2 -0.42000 11.568000000000000 1.252272733872298 0.000000000000000 + 13 1 1 0.42000 13.013999999999999 1.252272733872298 0.000000000000000 + 14 1 2 -0.42000 13.737000000000000 0.000000000000000 0.000000000000000 + 15 1 1 0.42000 15.183000000000000 0.000000000000000 0.000000000000000 + 16 1 2 -0.42000 15.905999999999999 1.252272733872298 0.000000000000000 + 17 1 1 0.42000 17.352000000000000 1.252272733872298 0.000000000000000 + 18 1 2 -0.42000 18.074999999999999 0.000000000000000 0.000000000000000 + 19 1 1 0.42000 19.521000000000001 0.000000000000000 0.000000000000000 + 20 1 2 -0.42000 20.244000000000000 1.252272733872298 0.000000000000000 + 21 1 1 0.42000 21.690000000000001 1.252272733872298 0.000000000000000 + 22 1 2 -0.42000 22.413000000000000 0.000000000000000 0.000000000000000 + 23 1 1 0.42000 23.859000000000002 0.000000000000000 0.000000000000000 + 24 1 2 -0.42000 24.582000000000001 1.252272733872298 0.000000000000000 + 25 1 1 0.42000 26.027999999999999 1.252272733872298 0.000000000000000 + 26 1 2 -0.42000 26.750999999999998 0.000000000000000 0.000000000000000 + 27 1 1 0.42000 28.196999999999999 0.000000000000000 0.000000000000000 + 28 1 2 -0.42000 28.919999999999998 1.252272733872298 0.000000000000000 + 29 1 1 0.42000 30.366000000000000 1.252272733872298 0.000000000000000 + 30 1 2 -0.42000 31.088999999999999 0.000000000000000 0.000000000000000 + 31 1 1 0.42000 32.534999999999997 0.000000000000000 0.000000000000000 + 32 1 2 -0.42000 33.258000000000003 1.252272733872298 0.000000000000000 + 33 1 1 0.42000 34.704000000000001 1.252272733872298 0.000000000000000 + 34 1 2 -0.42000 35.427000000000000 0.000000000000000 0.000000000000000 + 35 1 1 0.42000 36.872999999999998 0.000000000000000 0.000000000000000 + 36 1 2 -0.42000 37.596000000000004 1.252272733872298 0.000000000000000 + 37 1 1 0.42000 39.042000000000002 1.252272733872298 0.000000000000000 + 38 1 2 -0.42000 39.765000000000001 0.000000000000000 0.000000000000000 + 39 1 1 0.42000 41.210999999999999 0.000000000000000 0.000000000000000 + 40 1 2 -0.42000 41.934000000000005 1.252272733872298 0.000000000000000 + 41 1 1 0.42000 0.000000000000000 3.756818201616894 0.000000000000000 + 42 1 2 -0.42000 0.723000000000000 2.504545467744596 0.000000000000000 + 43 1 1 0.42000 2.169000000000000 2.504545467744596 0.000000000000000 + 44 1 2 -0.42000 2.892000000000000 3.756818201616894 0.000000000000000 + 45 1 1 0.42000 4.338000000000000 3.756818201616894 0.000000000000000 + 46 1 2 -0.42000 5.061000000000000 2.504545467744596 0.000000000000000 + 47 1 1 0.42000 6.507000000000000 2.504545467744596 0.000000000000000 + 48 1 2 -0.42000 7.230000000000000 3.756818201616894 0.000000000000000 + 49 1 1 0.42000 8.676000000000000 3.756818201616894 0.000000000000000 + 50 1 2 -0.42000 9.399000000000001 2.504545467744596 0.000000000000000 + 51 1 1 0.42000 10.845000000000001 2.504545467744596 0.000000000000000 + 52 1 2 -0.42000 11.568000000000000 3.756818201616894 0.000000000000000 + 53 1 1 0.42000 13.013999999999999 3.756818201616894 0.000000000000000 + 54 1 2 -0.42000 13.737000000000000 2.504545467744596 0.000000000000000 + 55 1 1 0.42000 15.183000000000000 2.504545467744596 0.000000000000000 + 56 1 2 -0.42000 15.905999999999999 3.756818201616894 0.000000000000000 + 57 1 1 0.42000 17.352000000000000 3.756818201616894 0.000000000000000 + 58 1 2 -0.42000 18.074999999999999 2.504545467744596 0.000000000000000 + 59 1 1 0.42000 19.521000000000001 2.504545467744596 0.000000000000000 + 60 1 2 -0.42000 20.244000000000000 3.756818201616894 0.000000000000000 + 61 1 1 0.42000 21.690000000000001 3.756818201616894 0.000000000000000 + 62 1 2 -0.42000 22.413000000000000 2.504545467744596 0.000000000000000 + 63 1 1 0.42000 23.859000000000002 2.504545467744596 0.000000000000000 + 64 1 2 -0.42000 24.582000000000001 3.756818201616894 0.000000000000000 + 65 1 1 0.42000 26.027999999999999 3.756818201616894 0.000000000000000 + 66 1 2 -0.42000 26.750999999999998 2.504545467744596 0.000000000000000 + 67 1 1 0.42000 28.196999999999999 2.504545467744596 0.000000000000000 + 68 1 2 -0.42000 28.919999999999998 3.756818201616894 0.000000000000000 + 69 1 1 0.42000 30.366000000000000 3.756818201616894 0.000000000000000 + 70 1 2 -0.42000 31.088999999999999 2.504545467744596 0.000000000000000 + 71 1 1 0.42000 32.534999999999997 2.504545467744596 0.000000000000000 + 72 1 2 -0.42000 33.258000000000003 3.756818201616894 0.000000000000000 + 73 1 1 0.42000 34.704000000000001 3.756818201616894 0.000000000000000 + 74 1 2 -0.42000 35.427000000000000 2.504545467744596 0.000000000000000 + 75 1 1 0.42000 36.872999999999998 2.504545467744596 0.000000000000000 + 76 1 2 -0.42000 37.596000000000004 3.756818201616894 0.000000000000000 + 77 1 1 0.42000 39.042000000000002 3.756818201616894 0.000000000000000 + 78 1 2 -0.42000 39.765000000000001 2.504545467744596 0.000000000000000 + 79 1 1 0.42000 41.210999999999999 2.504545467744596 0.000000000000000 + 80 1 2 -0.42000 41.934000000000005 3.756818201616894 0.000000000000000 + 81 1 1 0.42000 0.000000000000000 6.261363669361490 0.000000000000000 + 82 1 2 -0.42000 0.723000000000000 5.009090935489192 0.000000000000000 + 83 1 1 0.42000 2.169000000000000 5.009090935489192 0.000000000000000 + 84 1 2 -0.42000 2.892000000000000 6.261363669361490 0.000000000000000 + 85 1 1 0.42000 4.338000000000000 6.261363669361490 0.000000000000000 + 86 1 2 -0.42000 5.061000000000000 5.009090935489192 0.000000000000000 + 87 1 1 0.42000 6.507000000000000 5.009090935489192 0.000000000000000 + 88 1 2 -0.42000 7.230000000000000 6.261363669361490 0.000000000000000 + 89 1 1 0.42000 8.676000000000000 6.261363669361490 0.000000000000000 + 90 1 2 -0.42000 9.399000000000001 5.009090935489192 0.000000000000000 + 91 1 1 0.42000 10.845000000000001 5.009090935489192 0.000000000000000 + 92 1 2 -0.42000 11.568000000000000 6.261363669361490 0.000000000000000 + 93 1 1 0.42000 13.013999999999999 6.261363669361490 0.000000000000000 + 94 1 2 -0.42000 13.737000000000000 5.009090935489192 0.000000000000000 + 95 1 1 0.42000 15.183000000000000 5.009090935489192 0.000000000000000 + 96 1 2 -0.42000 15.905999999999999 6.261363669361490 0.000000000000000 + 97 1 1 0.42000 17.352000000000000 6.261363669361490 0.000000000000000 + 98 1 2 -0.42000 18.074999999999999 5.009090935489192 0.000000000000000 + 99 1 1 0.42000 19.521000000000001 5.009090935489192 0.000000000000000 + 100 1 2 -0.42000 20.244000000000000 6.261363669361490 0.000000000000000 + 101 1 1 0.42000 21.690000000000001 6.261363669361490 0.000000000000000 + 102 1 2 -0.42000 22.413000000000000 5.009090935489192 0.000000000000000 + 103 1 1 0.42000 23.859000000000002 5.009090935489192 0.000000000000000 + 104 1 2 -0.42000 24.582000000000001 6.261363669361490 0.000000000000000 + 105 1 1 0.42000 26.027999999999999 6.261363669361490 0.000000000000000 + 106 1 2 -0.42000 26.750999999999998 5.009090935489192 0.000000000000000 + 107 1 1 0.42000 28.196999999999999 5.009090935489192 0.000000000000000 + 108 1 2 -0.42000 28.919999999999998 6.261363669361490 0.000000000000000 + 109 1 1 0.42000 30.366000000000000 6.261363669361490 0.000000000000000 + 110 1 2 -0.42000 31.088999999999999 5.009090935489192 0.000000000000000 + 111 1 1 0.42000 32.534999999999997 5.009090935489192 0.000000000000000 + 112 1 2 -0.42000 33.258000000000003 6.261363669361490 0.000000000000000 + 113 1 1 0.42000 34.704000000000001 6.261363669361490 0.000000000000000 + 114 1 2 -0.42000 35.427000000000000 5.009090935489192 0.000000000000000 + 115 1 1 0.42000 36.872999999999998 5.009090935489192 0.000000000000000 + 116 1 2 -0.42000 37.596000000000004 6.261363669361490 0.000000000000000 + 117 1 1 0.42000 39.042000000000002 6.261363669361490 0.000000000000000 + 118 1 2 -0.42000 39.765000000000001 5.009090935489192 0.000000000000000 + 119 1 1 0.42000 41.210999999999999 5.009090935489192 0.000000000000000 + 120 1 2 -0.42000 41.934000000000005 6.261363669361490 0.000000000000000 + 121 1 1 0.42000 0.000000000000000 8.765909137106087 0.000000000000000 + 122 1 2 -0.42000 0.723000000000000 7.513636403233789 0.000000000000000 + 123 1 1 0.42000 2.169000000000000 7.513636403233789 0.000000000000000 + 124 1 2 -0.42000 2.892000000000000 8.765909137106087 0.000000000000000 + 125 1 1 0.42000 4.338000000000000 8.765909137106087 0.000000000000000 + 126 1 2 -0.42000 5.061000000000000 7.513636403233789 0.000000000000000 + 127 1 1 0.42000 6.507000000000000 7.513636403233789 0.000000000000000 + 128 1 2 -0.42000 7.230000000000000 8.765909137106087 0.000000000000000 + 129 1 1 0.42000 8.676000000000000 8.765909137106087 0.000000000000000 + 130 1 2 -0.42000 9.399000000000001 7.513636403233789 0.000000000000000 + 131 1 1 0.42000 10.845000000000001 7.513636403233789 0.000000000000000 + 132 1 2 -0.42000 11.568000000000000 8.765909137106087 0.000000000000000 + 133 1 1 0.42000 13.013999999999999 8.765909137106087 0.000000000000000 + 134 1 2 -0.42000 13.737000000000000 7.513636403233789 0.000000000000000 + 135 1 1 0.42000 15.183000000000000 7.513636403233789 0.000000000000000 + 136 1 2 -0.42000 15.905999999999999 8.765909137106087 0.000000000000000 + 137 1 1 0.42000 17.352000000000000 8.765909137106087 0.000000000000000 + 138 1 2 -0.42000 18.074999999999999 7.513636403233789 0.000000000000000 + 139 1 1 0.42000 19.521000000000001 7.513636403233789 0.000000000000000 + 140 1 2 -0.42000 20.244000000000000 8.765909137106087 0.000000000000000 + 141 1 1 0.42000 21.690000000000001 8.765909137106087 0.000000000000000 + 142 1 2 -0.42000 22.413000000000000 7.513636403233789 0.000000000000000 + 143 1 1 0.42000 23.859000000000002 7.513636403233789 0.000000000000000 + 144 1 2 -0.42000 24.582000000000001 8.765909137106087 0.000000000000000 + 145 1 1 0.42000 26.027999999999999 8.765909137106087 0.000000000000000 + 146 1 2 -0.42000 26.750999999999998 7.513636403233789 0.000000000000000 + 147 1 1 0.42000 28.196999999999999 7.513636403233789 0.000000000000000 + 148 1 2 -0.42000 28.919999999999998 8.765909137106087 0.000000000000000 + 149 1 1 0.42000 30.366000000000000 8.765909137106087 0.000000000000000 + 150 1 2 -0.42000 31.088999999999999 7.513636403233789 0.000000000000000 + 151 1 1 0.42000 32.534999999999997 7.513636403233789 0.000000000000000 + 152 1 2 -0.42000 33.258000000000003 8.765909137106087 0.000000000000000 + 153 1 1 0.42000 34.704000000000001 8.765909137106087 0.000000000000000 + 154 1 2 -0.42000 35.427000000000000 7.513636403233789 0.000000000000000 + 155 1 1 0.42000 36.872999999999998 7.513636403233789 0.000000000000000 + 156 1 2 -0.42000 37.596000000000004 8.765909137106087 0.000000000000000 + 157 1 1 0.42000 39.042000000000002 8.765909137106087 0.000000000000000 + 158 1 2 -0.42000 39.765000000000001 7.513636403233789 0.000000000000000 + 159 1 1 0.42000 41.210999999999999 7.513636403233789 0.000000000000000 + 160 1 2 -0.42000 41.934000000000005 8.765909137106087 0.000000000000000 + 161 1 1 0.42000 0.000000000000000 11.270454604850682 0.000000000000000 + 162 1 2 -0.42000 0.723000000000000 10.018181870978385 0.000000000000000 + 163 1 1 0.42000 2.169000000000000 10.018181870978385 0.000000000000000 + 164 1 2 -0.42000 2.892000000000000 11.270454604850682 0.000000000000000 + 165 1 1 0.42000 4.338000000000000 11.270454604850682 0.000000000000000 + 166 1 2 -0.42000 5.061000000000000 10.018181870978385 0.000000000000000 + 167 1 1 0.42000 6.507000000000000 10.018181870978385 0.000000000000000 + 168 1 2 -0.42000 7.230000000000000 11.270454604850682 0.000000000000000 + 169 1 1 0.42000 8.676000000000000 11.270454604850682 0.000000000000000 + 170 1 2 -0.42000 9.399000000000001 10.018181870978385 0.000000000000000 + 171 1 1 0.42000 10.845000000000001 10.018181870978385 0.000000000000000 + 172 1 2 -0.42000 11.568000000000000 11.270454604850682 0.000000000000000 + 173 1 1 0.42000 13.013999999999999 11.270454604850682 0.000000000000000 + 174 1 2 -0.42000 13.737000000000000 10.018181870978385 0.000000000000000 + 175 1 1 0.42000 15.183000000000000 10.018181870978385 0.000000000000000 + 176 1 2 -0.42000 15.905999999999999 11.270454604850682 0.000000000000000 + 177 1 1 0.42000 17.352000000000000 11.270454604850682 0.000000000000000 + 178 1 2 -0.42000 18.074999999999999 10.018181870978385 0.000000000000000 + 179 1 1 0.42000 19.521000000000001 10.018181870978385 0.000000000000000 + 180 1 2 -0.42000 20.244000000000000 11.270454604850682 0.000000000000000 + 181 1 1 0.42000 21.690000000000001 11.270454604850682 0.000000000000000 + 182 1 2 -0.42000 22.413000000000000 10.018181870978385 0.000000000000000 + 183 1 1 0.42000 23.859000000000002 10.018181870978385 0.000000000000000 + 184 1 2 -0.42000 24.582000000000001 11.270454604850682 0.000000000000000 + 185 1 1 0.42000 26.027999999999999 11.270454604850682 0.000000000000000 + 186 1 2 -0.42000 26.750999999999998 10.018181870978385 0.000000000000000 + 187 1 1 0.42000 28.196999999999999 10.018181870978385 0.000000000000000 + 188 1 2 -0.42000 28.919999999999998 11.270454604850682 0.000000000000000 + 189 1 1 0.42000 30.366000000000000 11.270454604850682 0.000000000000000 + 190 1 2 -0.42000 31.088999999999999 10.018181870978385 0.000000000000000 + 191 1 1 0.42000 32.534999999999997 10.018181870978385 0.000000000000000 + 192 1 2 -0.42000 33.258000000000003 11.270454604850682 0.000000000000000 + 193 1 1 0.42000 34.704000000000001 11.270454604850682 0.000000000000000 + 194 1 2 -0.42000 35.427000000000000 10.018181870978385 0.000000000000000 + 195 1 1 0.42000 36.872999999999998 10.018181870978385 0.000000000000000 + 196 1 2 -0.42000 37.596000000000004 11.270454604850682 0.000000000000000 + 197 1 1 0.42000 39.042000000000002 11.270454604850682 0.000000000000000 + 198 1 2 -0.42000 39.765000000000001 10.018181870978385 0.000000000000000 + 199 1 1 0.42000 41.210999999999999 10.018181870978385 0.000000000000000 + 200 1 2 -0.42000 41.934000000000005 11.270454604850682 0.000000000000000 + 201 1 1 0.42000 0.000000000000000 13.775000072595278 0.000000000000000 + 202 1 2 -0.42000 0.723000000000000 12.522727338722980 0.000000000000000 + 203 1 1 0.42000 2.169000000000000 12.522727338722980 0.000000000000000 + 204 1 2 -0.42000 2.892000000000000 13.775000072595278 0.000000000000000 + 205 1 1 0.42000 4.338000000000000 13.775000072595278 0.000000000000000 + 206 1 2 -0.42000 5.061000000000000 12.522727338722980 0.000000000000000 + 207 1 1 0.42000 6.507000000000000 12.522727338722980 0.000000000000000 + 208 1 2 -0.42000 7.230000000000000 13.775000072595278 0.000000000000000 + 209 1 1 0.42000 8.676000000000000 13.775000072595278 0.000000000000000 + 210 1 2 -0.42000 9.399000000000001 12.522727338722980 0.000000000000000 + 211 1 1 0.42000 10.845000000000001 12.522727338722980 0.000000000000000 + 212 1 2 -0.42000 11.568000000000000 13.775000072595278 0.000000000000000 + 213 1 1 0.42000 13.013999999999999 13.775000072595278 0.000000000000000 + 214 1 2 -0.42000 13.737000000000000 12.522727338722980 0.000000000000000 + 215 1 1 0.42000 15.183000000000000 12.522727338722980 0.000000000000000 + 216 1 2 -0.42000 15.905999999999999 13.775000072595278 0.000000000000000 + 217 1 1 0.42000 17.352000000000000 13.775000072595278 0.000000000000000 + 218 1 2 -0.42000 18.074999999999999 12.522727338722980 0.000000000000000 + 219 1 1 0.42000 19.521000000000001 12.522727338722980 0.000000000000000 + 220 1 2 -0.42000 20.244000000000000 13.775000072595278 0.000000000000000 + 221 1 1 0.42000 21.690000000000001 13.775000072595278 0.000000000000000 + 222 1 2 -0.42000 22.413000000000000 12.522727338722980 0.000000000000000 + 223 1 1 0.42000 23.859000000000002 12.522727338722980 0.000000000000000 + 224 1 2 -0.42000 24.582000000000001 13.775000072595278 0.000000000000000 + 225 1 1 0.42000 26.027999999999999 13.775000072595278 0.000000000000000 + 226 1 2 -0.42000 26.750999999999998 12.522727338722980 0.000000000000000 + 227 1 1 0.42000 28.196999999999999 12.522727338722980 0.000000000000000 + 228 1 2 -0.42000 28.919999999999998 13.775000072595278 0.000000000000000 + 229 1 1 0.42000 30.366000000000000 13.775000072595278 0.000000000000000 + 230 1 2 -0.42000 31.088999999999999 12.522727338722980 0.000000000000000 + 231 1 1 0.42000 32.534999999999997 12.522727338722980 0.000000000000000 + 232 1 2 -0.42000 33.258000000000003 13.775000072595278 0.000000000000000 + 233 1 1 0.42000 34.704000000000001 13.775000072595278 0.000000000000000 + 234 1 2 -0.42000 35.427000000000000 12.522727338722980 0.000000000000000 + 235 1 1 0.42000 36.872999999999998 12.522727338722980 0.000000000000000 + 236 1 2 -0.42000 37.596000000000004 13.775000072595278 0.000000000000000 + 237 1 1 0.42000 39.042000000000002 13.775000072595278 0.000000000000000 + 238 1 2 -0.42000 39.765000000000001 12.522727338722980 0.000000000000000 + 239 1 1 0.42000 41.210999999999999 12.522727338722980 0.000000000000000 + 240 1 2 -0.42000 41.934000000000005 13.775000072595278 0.000000000000000 + 241 1 1 0.42000 0.000000000000000 16.279545540339875 0.000000000000000 + 242 1 2 -0.42000 0.723000000000000 15.027272806467577 0.000000000000000 + 243 1 1 0.42000 2.169000000000000 15.027272806467577 0.000000000000000 + 244 1 2 -0.42000 2.892000000000000 16.279545540339875 0.000000000000000 + 245 1 1 0.42000 4.338000000000000 16.279545540339875 0.000000000000000 + 246 1 2 -0.42000 5.061000000000000 15.027272806467577 0.000000000000000 + 247 1 1 0.42000 6.507000000000000 15.027272806467577 0.000000000000000 + 248 1 2 -0.42000 7.230000000000000 16.279545540339875 0.000000000000000 + 249 1 1 0.42000 8.676000000000000 16.279545540339875 0.000000000000000 + 250 1 2 -0.42000 9.399000000000001 15.027272806467577 0.000000000000000 + 251 1 1 0.42000 10.845000000000001 15.027272806467577 0.000000000000000 + 252 1 2 -0.42000 11.568000000000000 16.279545540339875 0.000000000000000 + 253 1 1 0.42000 13.013999999999999 16.279545540339875 0.000000000000000 + 254 1 2 -0.42000 13.737000000000000 15.027272806467577 0.000000000000000 + 255 1 1 0.42000 15.183000000000000 15.027272806467577 0.000000000000000 + 256 1 2 -0.42000 15.905999999999999 16.279545540339875 0.000000000000000 + 257 1 1 0.42000 17.352000000000000 16.279545540339875 0.000000000000000 + 258 1 2 -0.42000 18.074999999999999 15.027272806467577 0.000000000000000 + 259 1 1 0.42000 19.521000000000001 15.027272806467577 0.000000000000000 + 260 1 2 -0.42000 20.244000000000000 16.279545540339875 0.000000000000000 + 261 1 1 0.42000 21.690000000000001 16.279545540339875 0.000000000000000 + 262 1 2 -0.42000 22.413000000000000 15.027272806467577 0.000000000000000 + 263 1 1 0.42000 23.859000000000002 15.027272806467577 0.000000000000000 + 264 1 2 -0.42000 24.582000000000001 16.279545540339875 0.000000000000000 + 265 1 1 0.42000 26.027999999999999 16.279545540339875 0.000000000000000 + 266 1 2 -0.42000 26.750999999999998 15.027272806467577 0.000000000000000 + 267 1 1 0.42000 28.196999999999999 15.027272806467577 0.000000000000000 + 268 1 2 -0.42000 28.919999999999998 16.279545540339875 0.000000000000000 + 269 1 1 0.42000 30.366000000000000 16.279545540339875 0.000000000000000 + 270 1 2 -0.42000 31.088999999999999 15.027272806467577 0.000000000000000 + 271 1 1 0.42000 32.534999999999997 15.027272806467577 0.000000000000000 + 272 1 2 -0.42000 33.258000000000003 16.279545540339875 0.000000000000000 + 273 1 1 0.42000 34.704000000000001 16.279545540339875 0.000000000000000 + 274 1 2 -0.42000 35.427000000000000 15.027272806467577 0.000000000000000 + 275 1 1 0.42000 36.872999999999998 15.027272806467577 0.000000000000000 + 276 1 2 -0.42000 37.596000000000004 16.279545540339875 0.000000000000000 + 277 1 1 0.42000 39.042000000000002 16.279545540339875 0.000000000000000 + 278 1 2 -0.42000 39.765000000000001 15.027272806467577 0.000000000000000 + 279 1 1 0.42000 41.210999999999999 15.027272806467577 0.000000000000000 + 280 1 2 -0.42000 41.934000000000005 16.279545540339875 0.000000000000000 + 281 1 1 0.42000 0.000000000000000 18.784091008084474 0.000000000000000 + 282 1 2 -0.42000 0.723000000000000 17.531818274212174 0.000000000000000 + 283 1 1 0.42000 2.169000000000000 17.531818274212174 0.000000000000000 + 284 1 2 -0.42000 2.892000000000000 18.784091008084474 0.000000000000000 + 285 1 1 0.42000 4.338000000000000 18.784091008084474 0.000000000000000 + 286 1 2 -0.42000 5.061000000000000 17.531818274212174 0.000000000000000 + 287 1 1 0.42000 6.507000000000000 17.531818274212174 0.000000000000000 + 288 1 2 -0.42000 7.230000000000000 18.784091008084474 0.000000000000000 + 289 1 1 0.42000 8.676000000000000 18.784091008084474 0.000000000000000 + 290 1 2 -0.42000 9.399000000000001 17.531818274212174 0.000000000000000 + 291 1 1 0.42000 10.845000000000001 17.531818274212174 0.000000000000000 + 292 1 2 -0.42000 11.568000000000000 18.784091008084474 0.000000000000000 + 293 1 1 0.42000 13.013999999999999 18.784091008084474 0.000000000000000 + 294 1 2 -0.42000 13.737000000000000 17.531818274212174 0.000000000000000 + 295 1 1 0.42000 15.183000000000000 17.531818274212174 0.000000000000000 + 296 1 2 -0.42000 15.905999999999999 18.784091008084474 0.000000000000000 + 297 1 1 0.42000 17.352000000000000 18.784091008084474 0.000000000000000 + 298 1 2 -0.42000 18.074999999999999 17.531818274212174 0.000000000000000 + 299 1 1 0.42000 19.521000000000001 17.531818274212174 0.000000000000000 + 300 1 2 -0.42000 20.244000000000000 18.784091008084474 0.000000000000000 + 301 1 1 0.42000 21.690000000000001 18.784091008084474 0.000000000000000 + 302 1 2 -0.42000 22.413000000000000 17.531818274212174 0.000000000000000 + 303 1 1 0.42000 23.859000000000002 17.531818274212174 0.000000000000000 + 304 1 2 -0.42000 24.582000000000001 18.784091008084474 0.000000000000000 + 305 1 1 0.42000 26.027999999999999 18.784091008084474 0.000000000000000 + 306 1 2 -0.42000 26.750999999999998 17.531818274212174 0.000000000000000 + 307 1 1 0.42000 28.196999999999999 17.531818274212174 0.000000000000000 + 308 1 2 -0.42000 28.919999999999998 18.784091008084474 0.000000000000000 + 309 1 1 0.42000 30.366000000000000 18.784091008084474 0.000000000000000 + 310 1 2 -0.42000 31.088999999999999 17.531818274212174 0.000000000000000 + 311 1 1 0.42000 32.534999999999997 17.531818274212174 0.000000000000000 + 312 1 2 -0.42000 33.258000000000003 18.784091008084474 0.000000000000000 + 313 1 1 0.42000 34.704000000000001 18.784091008084474 0.000000000000000 + 314 1 2 -0.42000 35.427000000000000 17.531818274212174 0.000000000000000 + 315 1 1 0.42000 36.872999999999998 17.531818274212174 0.000000000000000 + 316 1 2 -0.42000 37.596000000000004 18.784091008084474 0.000000000000000 + 317 1 1 0.42000 39.042000000000002 18.784091008084474 0.000000000000000 + 318 1 2 -0.42000 39.765000000000001 17.531818274212174 0.000000000000000 + 319 1 1 0.42000 41.210999999999999 17.531818274212174 0.000000000000000 + 320 1 2 -0.42000 41.934000000000005 18.784091008084474 0.000000000000000 + 321 1 1 0.42000 0.000000000000000 21.288636475829069 0.000000000000000 + 322 1 2 -0.42000 0.723000000000000 20.036363741956770 0.000000000000000 + 323 1 1 0.42000 2.169000000000000 20.036363741956770 0.000000000000000 + 324 1 2 -0.42000 2.892000000000000 21.288636475829069 0.000000000000000 + 325 1 1 0.42000 4.338000000000000 21.288636475829069 0.000000000000000 + 326 1 2 -0.42000 5.061000000000000 20.036363741956770 0.000000000000000 + 327 1 1 0.42000 6.507000000000000 20.036363741956770 0.000000000000000 + 328 1 2 -0.42000 7.230000000000000 21.288636475829069 0.000000000000000 + 329 1 1 0.42000 8.676000000000000 21.288636475829069 0.000000000000000 + 330 1 2 -0.42000 9.399000000000001 20.036363741956770 0.000000000000000 + 331 1 1 0.42000 10.845000000000001 20.036363741956770 0.000000000000000 + 332 1 2 -0.42000 11.568000000000000 21.288636475829069 0.000000000000000 + 333 1 1 0.42000 13.013999999999999 21.288636475829069 0.000000000000000 + 334 1 2 -0.42000 13.737000000000000 20.036363741956770 0.000000000000000 + 335 1 1 0.42000 15.183000000000000 20.036363741956770 0.000000000000000 + 336 1 2 -0.42000 15.905999999999999 21.288636475829069 0.000000000000000 + 337 1 1 0.42000 17.352000000000000 21.288636475829069 0.000000000000000 + 338 1 2 -0.42000 18.074999999999999 20.036363741956770 0.000000000000000 + 339 1 1 0.42000 19.521000000000001 20.036363741956770 0.000000000000000 + 340 1 2 -0.42000 20.244000000000000 21.288636475829069 0.000000000000000 + 341 1 1 0.42000 21.690000000000001 21.288636475829069 0.000000000000000 + 342 1 2 -0.42000 22.413000000000000 20.036363741956770 0.000000000000000 + 343 1 1 0.42000 23.859000000000002 20.036363741956770 0.000000000000000 + 344 1 2 -0.42000 24.582000000000001 21.288636475829069 0.000000000000000 + 345 1 1 0.42000 26.027999999999999 21.288636475829069 0.000000000000000 + 346 1 2 -0.42000 26.750999999999998 20.036363741956770 0.000000000000000 + 347 1 1 0.42000 28.196999999999999 20.036363741956770 0.000000000000000 + 348 1 2 -0.42000 28.919999999999998 21.288636475829069 0.000000000000000 + 349 1 1 0.42000 30.366000000000000 21.288636475829069 0.000000000000000 + 350 1 2 -0.42000 31.088999999999999 20.036363741956770 0.000000000000000 + 351 1 1 0.42000 32.534999999999997 20.036363741956770 0.000000000000000 + 352 1 2 -0.42000 33.258000000000003 21.288636475829069 0.000000000000000 + 353 1 1 0.42000 34.704000000000001 21.288636475829069 0.000000000000000 + 354 1 2 -0.42000 35.427000000000000 20.036363741956770 0.000000000000000 + 355 1 1 0.42000 36.872999999999998 20.036363741956770 0.000000000000000 + 356 1 2 -0.42000 37.596000000000004 21.288636475829069 0.000000000000000 + 357 1 1 0.42000 39.042000000000002 21.288636475829069 0.000000000000000 + 358 1 2 -0.42000 39.765000000000001 20.036363741956770 0.000000000000000 + 359 1 1 0.42000 41.210999999999999 20.036363741956770 0.000000000000000 + 360 1 2 -0.42000 41.934000000000005 21.288636475829069 0.000000000000000 + 361 1 1 0.42000 0.000000000000000 23.793181943573664 0.000000000000000 + 362 1 2 -0.42000 0.723000000000000 22.540909209701365 0.000000000000000 + 363 1 1 0.42000 2.169000000000000 22.540909209701365 0.000000000000000 + 364 1 2 -0.42000 2.892000000000000 23.793181943573664 0.000000000000000 + 365 1 1 0.42000 4.338000000000000 23.793181943573664 0.000000000000000 + 366 1 2 -0.42000 5.061000000000000 22.540909209701365 0.000000000000000 + 367 1 1 0.42000 6.507000000000000 22.540909209701365 0.000000000000000 + 368 1 2 -0.42000 7.230000000000000 23.793181943573664 0.000000000000000 + 369 1 1 0.42000 8.676000000000000 23.793181943573664 0.000000000000000 + 370 1 2 -0.42000 9.399000000000001 22.540909209701365 0.000000000000000 + 371 1 1 0.42000 10.845000000000001 22.540909209701365 0.000000000000000 + 372 1 2 -0.42000 11.568000000000000 23.793181943573664 0.000000000000000 + 373 1 1 0.42000 13.013999999999999 23.793181943573664 0.000000000000000 + 374 1 2 -0.42000 13.737000000000000 22.540909209701365 0.000000000000000 + 375 1 1 0.42000 15.183000000000000 22.540909209701365 0.000000000000000 + 376 1 2 -0.42000 15.905999999999999 23.793181943573664 0.000000000000000 + 377 1 1 0.42000 17.352000000000000 23.793181943573664 0.000000000000000 + 378 1 2 -0.42000 18.074999999999999 22.540909209701365 0.000000000000000 + 379 1 1 0.42000 19.521000000000001 22.540909209701365 0.000000000000000 + 380 1 2 -0.42000 20.244000000000000 23.793181943573664 0.000000000000000 + 381 1 1 0.42000 21.690000000000001 23.793181943573664 0.000000000000000 + 382 1 2 -0.42000 22.413000000000000 22.540909209701365 0.000000000000000 + 383 1 1 0.42000 23.859000000000002 22.540909209701365 0.000000000000000 + 384 1 2 -0.42000 24.582000000000001 23.793181943573664 0.000000000000000 + 385 1 1 0.42000 26.027999999999999 23.793181943573664 0.000000000000000 + 386 1 2 -0.42000 26.750999999999998 22.540909209701365 0.000000000000000 + 387 1 1 0.42000 28.196999999999999 22.540909209701365 0.000000000000000 + 388 1 2 -0.42000 28.919999999999998 23.793181943573664 0.000000000000000 + 389 1 1 0.42000 30.366000000000000 23.793181943573664 0.000000000000000 + 390 1 2 -0.42000 31.088999999999999 22.540909209701365 0.000000000000000 + 391 1 1 0.42000 32.534999999999997 22.540909209701365 0.000000000000000 + 392 1 2 -0.42000 33.258000000000003 23.793181943573664 0.000000000000000 + 393 1 1 0.42000 34.704000000000001 23.793181943573664 0.000000000000000 + 394 1 2 -0.42000 35.427000000000000 22.540909209701365 0.000000000000000 + 395 1 1 0.42000 36.872999999999998 22.540909209701365 0.000000000000000 + 396 1 2 -0.42000 37.596000000000004 23.793181943573664 0.000000000000000 + 397 1 1 0.42000 39.042000000000002 23.793181943573664 0.000000000000000 + 398 1 2 -0.42000 39.765000000000001 22.540909209701365 0.000000000000000 + 399 1 1 0.42000 41.210999999999999 22.540909209701365 0.000000000000000 + 400 1 2 -0.42000 41.934000000000005 23.793181943573664 0.000000000000000 + 401 1 1 0.42000 0.000000000000000 26.297727411318260 0.000000000000000 + 402 1 2 -0.42000 0.723000000000000 25.045454677445960 0.000000000000000 + 403 1 1 0.42000 2.169000000000000 25.045454677445960 0.000000000000000 + 404 1 2 -0.42000 2.892000000000000 26.297727411318260 0.000000000000000 + 405 1 1 0.42000 4.338000000000000 26.297727411318260 0.000000000000000 + 406 1 2 -0.42000 5.061000000000000 25.045454677445960 0.000000000000000 + 407 1 1 0.42000 6.507000000000000 25.045454677445960 0.000000000000000 + 408 1 2 -0.42000 7.230000000000000 26.297727411318260 0.000000000000000 + 409 1 1 0.42000 8.676000000000000 26.297727411318260 0.000000000000000 + 410 1 2 -0.42000 9.399000000000001 25.045454677445960 0.000000000000000 + 411 1 1 0.42000 10.845000000000001 25.045454677445960 0.000000000000000 + 412 1 2 -0.42000 11.568000000000000 26.297727411318260 0.000000000000000 + 413 1 1 0.42000 13.013999999999999 26.297727411318260 0.000000000000000 + 414 1 2 -0.42000 13.737000000000000 25.045454677445960 0.000000000000000 + 415 1 1 0.42000 15.183000000000000 25.045454677445960 0.000000000000000 + 416 1 2 -0.42000 15.905999999999999 26.297727411318260 0.000000000000000 + 417 1 1 0.42000 17.352000000000000 26.297727411318260 0.000000000000000 + 418 1 2 -0.42000 18.074999999999999 25.045454677445960 0.000000000000000 + 419 1 1 0.42000 19.521000000000001 25.045454677445960 0.000000000000000 + 420 1 2 -0.42000 20.244000000000000 26.297727411318260 0.000000000000000 + 421 1 1 0.42000 21.690000000000001 26.297727411318260 0.000000000000000 + 422 1 2 -0.42000 22.413000000000000 25.045454677445960 0.000000000000000 + 423 1 1 0.42000 23.859000000000002 25.045454677445960 0.000000000000000 + 424 1 2 -0.42000 24.582000000000001 26.297727411318260 0.000000000000000 + 425 1 1 0.42000 26.027999999999999 26.297727411318260 0.000000000000000 + 426 1 2 -0.42000 26.750999999999998 25.045454677445960 0.000000000000000 + 427 1 1 0.42000 28.196999999999999 25.045454677445960 0.000000000000000 + 428 1 2 -0.42000 28.919999999999998 26.297727411318260 0.000000000000000 + 429 1 1 0.42000 30.366000000000000 26.297727411318260 0.000000000000000 + 430 1 2 -0.42000 31.088999999999999 25.045454677445960 0.000000000000000 + 431 1 1 0.42000 32.534999999999997 25.045454677445960 0.000000000000000 + 432 1 2 -0.42000 33.258000000000003 26.297727411318260 0.000000000000000 + 433 1 1 0.42000 34.704000000000001 26.297727411318260 0.000000000000000 + 434 1 2 -0.42000 35.427000000000000 25.045454677445960 0.000000000000000 + 435 1 1 0.42000 36.872999999999998 25.045454677445960 0.000000000000000 + 436 1 2 -0.42000 37.596000000000004 26.297727411318260 0.000000000000000 + 437 1 1 0.42000 39.042000000000002 26.297727411318260 0.000000000000000 + 438 1 2 -0.42000 39.765000000000001 25.045454677445960 0.000000000000000 + 439 1 1 0.42000 41.210999999999999 25.045454677445960 0.000000000000000 + 440 1 2 -0.42000 41.934000000000005 26.297727411318260 0.000000000000000 + 441 1 1 0.42000 0.000000000000000 28.802272879062858 0.000000000000000 + 442 1 2 -0.42000 0.723000000000000 27.550000145190559 0.000000000000000 + 443 1 1 0.42000 2.169000000000000 27.550000145190559 0.000000000000000 + 444 1 2 -0.42000 2.892000000000000 28.802272879062858 0.000000000000000 + 445 1 1 0.42000 4.338000000000000 28.802272879062858 0.000000000000000 + 446 1 2 -0.42000 5.061000000000000 27.550000145190559 0.000000000000000 + 447 1 1 0.42000 6.507000000000000 27.550000145190559 0.000000000000000 + 448 1 2 -0.42000 7.230000000000000 28.802272879062858 0.000000000000000 + 449 1 1 0.42000 8.676000000000000 28.802272879062858 0.000000000000000 + 450 1 2 -0.42000 9.399000000000001 27.550000145190559 0.000000000000000 + 451 1 1 0.42000 10.845000000000001 27.550000145190559 0.000000000000000 + 452 1 2 -0.42000 11.568000000000000 28.802272879062858 0.000000000000000 + 453 1 1 0.42000 13.013999999999999 28.802272879062858 0.000000000000000 + 454 1 2 -0.42000 13.737000000000000 27.550000145190559 0.000000000000000 + 455 1 1 0.42000 15.183000000000000 27.550000145190559 0.000000000000000 + 456 1 2 -0.42000 15.905999999999999 28.802272879062858 0.000000000000000 + 457 1 1 0.42000 17.352000000000000 28.802272879062858 0.000000000000000 + 458 1 2 -0.42000 18.074999999999999 27.550000145190559 0.000000000000000 + 459 1 1 0.42000 19.521000000000001 27.550000145190559 0.000000000000000 + 460 1 2 -0.42000 20.244000000000000 28.802272879062858 0.000000000000000 + 461 1 1 0.42000 21.690000000000001 28.802272879062858 0.000000000000000 + 462 1 2 -0.42000 22.413000000000000 27.550000145190559 0.000000000000000 + 463 1 1 0.42000 23.859000000000002 27.550000145190559 0.000000000000000 + 464 1 2 -0.42000 24.582000000000001 28.802272879062858 0.000000000000000 + 465 1 1 0.42000 26.027999999999999 28.802272879062858 0.000000000000000 + 466 1 2 -0.42000 26.750999999999998 27.550000145190559 0.000000000000000 + 467 1 1 0.42000 28.196999999999999 27.550000145190559 0.000000000000000 + 468 1 2 -0.42000 28.919999999999998 28.802272879062858 0.000000000000000 + 469 1 1 0.42000 30.366000000000000 28.802272879062858 0.000000000000000 + 470 1 2 -0.42000 31.088999999999999 27.550000145190559 0.000000000000000 + 471 1 1 0.42000 32.534999999999997 27.550000145190559 0.000000000000000 + 472 1 2 -0.42000 33.258000000000003 28.802272879062858 0.000000000000000 + 473 1 1 0.42000 34.704000000000001 28.802272879062858 0.000000000000000 + 474 1 2 -0.42000 35.427000000000000 27.550000145190559 0.000000000000000 + 475 1 1 0.42000 36.872999999999998 27.550000145190559 0.000000000000000 + 476 1 2 -0.42000 37.596000000000004 28.802272879062858 0.000000000000000 + 477 1 1 0.42000 39.042000000000002 28.802272879062858 0.000000000000000 + 478 1 2 -0.42000 39.765000000000001 27.550000145190559 0.000000000000000 + 479 1 1 0.42000 41.210999999999999 27.550000145190559 0.000000000000000 + 480 1 2 -0.42000 41.934000000000005 28.802272879062858 0.000000000000000 + 481 1 1 0.42000 0.000000000000000 31.306818346807454 0.000000000000000 + 482 1 2 -0.42000 0.723000000000000 30.054545612935154 0.000000000000000 + 483 1 1 0.42000 2.169000000000000 30.054545612935154 0.000000000000000 + 484 1 2 -0.42000 2.892000000000000 31.306818346807454 0.000000000000000 + 485 1 1 0.42000 4.338000000000000 31.306818346807454 0.000000000000000 + 486 1 2 -0.42000 5.061000000000000 30.054545612935154 0.000000000000000 + 487 1 1 0.42000 6.507000000000000 30.054545612935154 0.000000000000000 + 488 1 2 -0.42000 7.230000000000000 31.306818346807454 0.000000000000000 + 489 1 1 0.42000 8.676000000000000 31.306818346807454 0.000000000000000 + 490 1 2 -0.42000 9.399000000000001 30.054545612935154 0.000000000000000 + 491 1 1 0.42000 10.845000000000001 30.054545612935154 0.000000000000000 + 492 1 2 -0.42000 11.568000000000000 31.306818346807454 0.000000000000000 + 493 1 1 0.42000 13.013999999999999 31.306818346807454 0.000000000000000 + 494 1 2 -0.42000 13.737000000000000 30.054545612935154 0.000000000000000 + 495 1 1 0.42000 15.183000000000000 30.054545612935154 0.000000000000000 + 496 1 2 -0.42000 15.905999999999999 31.306818346807454 0.000000000000000 + 497 1 1 0.42000 17.352000000000000 31.306818346807454 0.000000000000000 + 498 1 2 -0.42000 18.074999999999999 30.054545612935154 0.000000000000000 + 499 1 1 0.42000 19.521000000000001 30.054545612935154 0.000000000000000 + 500 1 2 -0.42000 20.244000000000000 31.306818346807454 0.000000000000000 + 501 1 1 0.42000 21.690000000000001 31.306818346807454 0.000000000000000 + 502 1 2 -0.42000 22.413000000000000 30.054545612935154 0.000000000000000 + 503 1 1 0.42000 23.859000000000002 30.054545612935154 0.000000000000000 + 504 1 2 -0.42000 24.582000000000001 31.306818346807454 0.000000000000000 + 505 1 1 0.42000 26.027999999999999 31.306818346807454 0.000000000000000 + 506 1 2 -0.42000 26.750999999999998 30.054545612935154 0.000000000000000 + 507 1 1 0.42000 28.196999999999999 30.054545612935154 0.000000000000000 + 508 1 2 -0.42000 28.919999999999998 31.306818346807454 0.000000000000000 + 509 1 1 0.42000 30.366000000000000 31.306818346807454 0.000000000000000 + 510 1 2 -0.42000 31.088999999999999 30.054545612935154 0.000000000000000 + 511 1 1 0.42000 32.534999999999997 30.054545612935154 0.000000000000000 + 512 1 2 -0.42000 33.258000000000003 31.306818346807454 0.000000000000000 + 513 1 1 0.42000 34.704000000000001 31.306818346807454 0.000000000000000 + 514 1 2 -0.42000 35.427000000000000 30.054545612935154 0.000000000000000 + 515 1 1 0.42000 36.872999999999998 30.054545612935154 0.000000000000000 + 516 1 2 -0.42000 37.596000000000004 31.306818346807454 0.000000000000000 + 517 1 1 0.42000 39.042000000000002 31.306818346807454 0.000000000000000 + 518 1 2 -0.42000 39.765000000000001 30.054545612935154 0.000000000000000 + 519 1 1 0.42000 41.210999999999999 30.054545612935154 0.000000000000000 + 520 1 2 -0.42000 41.934000000000005 31.306818346807454 0.000000000000000 + 521 1 1 0.42000 0.000000000000000 33.811363814552045 0.000000000000000 + 522 1 2 -0.42000 0.723000000000000 32.559091080679750 0.000000000000000 + 523 1 1 0.42000 2.169000000000000 32.559091080679750 0.000000000000000 + 524 1 2 -0.42000 2.892000000000000 33.811363814552045 0.000000000000000 + 525 1 1 0.42000 4.338000000000000 33.811363814552045 0.000000000000000 + 526 1 2 -0.42000 5.061000000000000 32.559091080679750 0.000000000000000 + 527 1 1 0.42000 6.507000000000000 32.559091080679750 0.000000000000000 + 528 1 2 -0.42000 7.230000000000000 33.811363814552045 0.000000000000000 + 529 1 1 0.42000 8.676000000000000 33.811363814552045 0.000000000000000 + 530 1 2 -0.42000 9.399000000000001 32.559091080679750 0.000000000000000 + 531 1 1 0.42000 10.845000000000001 32.559091080679750 0.000000000000000 + 532 1 2 -0.42000 11.568000000000000 33.811363814552045 0.000000000000000 + 533 1 1 0.42000 13.013999999999999 33.811363814552045 0.000000000000000 + 534 1 2 -0.42000 13.737000000000000 32.559091080679750 0.000000000000000 + 535 1 1 0.42000 15.183000000000000 32.559091080679750 0.000000000000000 + 536 1 2 -0.42000 15.905999999999999 33.811363814552045 0.000000000000000 + 537 1 1 0.42000 17.352000000000000 33.811363814552045 0.000000000000000 + 538 1 2 -0.42000 18.074999999999999 32.559091080679750 0.000000000000000 + 539 1 1 0.42000 19.521000000000001 32.559091080679750 0.000000000000000 + 540 1 2 -0.42000 20.244000000000000 33.811363814552045 0.000000000000000 + 541 1 1 0.42000 21.690000000000001 33.811363814552045 0.000000000000000 + 542 1 2 -0.42000 22.413000000000000 32.559091080679750 0.000000000000000 + 543 1 1 0.42000 23.859000000000002 32.559091080679750 0.000000000000000 + 544 1 2 -0.42000 24.582000000000001 33.811363814552045 0.000000000000000 + 545 1 1 0.42000 26.027999999999999 33.811363814552045 0.000000000000000 + 546 1 2 -0.42000 26.750999999999998 32.559091080679750 0.000000000000000 + 547 1 1 0.42000 28.196999999999999 32.559091080679750 0.000000000000000 + 548 1 2 -0.42000 28.919999999999998 33.811363814552045 0.000000000000000 + 549 1 1 0.42000 30.366000000000000 33.811363814552045 0.000000000000000 + 550 1 2 -0.42000 31.088999999999999 32.559091080679750 0.000000000000000 + 551 1 1 0.42000 32.534999999999997 32.559091080679750 0.000000000000000 + 552 1 2 -0.42000 33.258000000000003 33.811363814552045 0.000000000000000 + 553 1 1 0.42000 34.704000000000001 33.811363814552045 0.000000000000000 + 554 1 2 -0.42000 35.427000000000000 32.559091080679750 0.000000000000000 + 555 1 1 0.42000 36.872999999999998 32.559091080679750 0.000000000000000 + 556 1 2 -0.42000 37.596000000000004 33.811363814552045 0.000000000000000 + 557 1 1 0.42000 39.042000000000002 33.811363814552045 0.000000000000000 + 558 1 2 -0.42000 39.765000000000001 32.559091080679750 0.000000000000000 + 559 1 1 0.42000 41.210999999999999 32.559091080679750 0.000000000000000 + 560 1 2 -0.42000 41.934000000000005 33.811363814552045 0.000000000000000 + 561 1 1 0.42000 0.000000000000000 36.315909282296644 0.000000000000000 + 562 1 2 -0.42000 0.723000000000000 35.063636548424348 0.000000000000000 + 563 1 1 0.42000 2.169000000000000 35.063636548424348 0.000000000000000 + 564 1 2 -0.42000 2.892000000000000 36.315909282296644 0.000000000000000 + 565 1 1 0.42000 4.338000000000000 36.315909282296644 0.000000000000000 + 566 1 2 -0.42000 5.061000000000000 35.063636548424348 0.000000000000000 + 567 1 1 0.42000 6.507000000000000 35.063636548424348 0.000000000000000 + 568 1 2 -0.42000 7.230000000000000 36.315909282296644 0.000000000000000 + 569 1 1 0.42000 8.676000000000000 36.315909282296644 0.000000000000000 + 570 1 2 -0.42000 9.399000000000001 35.063636548424348 0.000000000000000 + 571 1 1 0.42000 10.845000000000001 35.063636548424348 0.000000000000000 + 572 1 2 -0.42000 11.568000000000000 36.315909282296644 0.000000000000000 + 573 1 1 0.42000 13.013999999999999 36.315909282296644 0.000000000000000 + 574 1 2 -0.42000 13.737000000000000 35.063636548424348 0.000000000000000 + 575 1 1 0.42000 15.183000000000000 35.063636548424348 0.000000000000000 + 576 1 2 -0.42000 15.905999999999999 36.315909282296644 0.000000000000000 + 577 1 1 0.42000 17.352000000000000 36.315909282296644 0.000000000000000 + 578 1 2 -0.42000 18.074999999999999 35.063636548424348 0.000000000000000 + 579 1 1 0.42000 19.521000000000001 35.063636548424348 0.000000000000000 + 580 1 2 -0.42000 20.244000000000000 36.315909282296644 0.000000000000000 + 581 1 1 0.42000 21.690000000000001 36.315909282296644 0.000000000000000 + 582 1 2 -0.42000 22.413000000000000 35.063636548424348 0.000000000000000 + 583 1 1 0.42000 23.859000000000002 35.063636548424348 0.000000000000000 + 584 1 2 -0.42000 24.582000000000001 36.315909282296644 0.000000000000000 + 585 1 1 0.42000 26.027999999999999 36.315909282296644 0.000000000000000 + 586 1 2 -0.42000 26.750999999999998 35.063636548424348 0.000000000000000 + 587 1 1 0.42000 28.196999999999999 35.063636548424348 0.000000000000000 + 588 1 2 -0.42000 28.919999999999998 36.315909282296644 0.000000000000000 + 589 1 1 0.42000 30.366000000000000 36.315909282296644 0.000000000000000 + 590 1 2 -0.42000 31.088999999999999 35.063636548424348 0.000000000000000 + 591 1 1 0.42000 32.534999999999997 35.063636548424348 0.000000000000000 + 592 1 2 -0.42000 33.258000000000003 36.315909282296644 0.000000000000000 + 593 1 1 0.42000 34.704000000000001 36.315909282296644 0.000000000000000 + 594 1 2 -0.42000 35.427000000000000 35.063636548424348 0.000000000000000 + 595 1 1 0.42000 36.872999999999998 35.063636548424348 0.000000000000000 + 596 1 2 -0.42000 37.596000000000004 36.315909282296644 0.000000000000000 + 597 1 1 0.42000 39.042000000000002 36.315909282296644 0.000000000000000 + 598 1 2 -0.42000 39.765000000000001 35.063636548424348 0.000000000000000 + 599 1 1 0.42000 41.210999999999999 35.063636548424348 0.000000000000000 + 600 1 2 -0.42000 41.934000000000005 36.315909282296644 0.000000000000000 + 601 1 1 0.42000 0.000000000000000 38.820454750041236 0.000000000000000 + 602 1 2 -0.42000 0.723000000000000 37.568182016168940 0.000000000000000 + 603 1 1 0.42000 2.169000000000000 37.568182016168940 0.000000000000000 + 604 1 2 -0.42000 2.892000000000000 38.820454750041236 0.000000000000000 + 605 1 1 0.42000 4.338000000000000 38.820454750041236 0.000000000000000 + 606 1 2 -0.42000 5.061000000000000 37.568182016168940 0.000000000000000 + 607 1 1 0.42000 6.507000000000000 37.568182016168940 0.000000000000000 + 608 1 2 -0.42000 7.230000000000000 38.820454750041236 0.000000000000000 + 609 1 1 0.42000 8.676000000000000 38.820454750041236 0.000000000000000 + 610 1 2 -0.42000 9.399000000000001 37.568182016168940 0.000000000000000 + 611 1 1 0.42000 10.845000000000001 37.568182016168940 0.000000000000000 + 612 1 2 -0.42000 11.568000000000000 38.820454750041236 0.000000000000000 + 613 1 1 0.42000 13.013999999999999 38.820454750041236 0.000000000000000 + 614 1 2 -0.42000 13.737000000000000 37.568182016168940 0.000000000000000 + 615 1 1 0.42000 15.183000000000000 37.568182016168940 0.000000000000000 + 616 1 2 -0.42000 15.905999999999999 38.820454750041236 0.000000000000000 + 617 1 1 0.42000 17.352000000000000 38.820454750041236 0.000000000000000 + 618 1 2 -0.42000 18.074999999999999 37.568182016168940 0.000000000000000 + 619 1 1 0.42000 19.521000000000001 37.568182016168940 0.000000000000000 + 620 1 2 -0.42000 20.244000000000000 38.820454750041236 0.000000000000000 + 621 1 1 0.42000 21.690000000000001 38.820454750041236 0.000000000000000 + 622 1 2 -0.42000 22.413000000000000 37.568182016168940 0.000000000000000 + 623 1 1 0.42000 23.859000000000002 37.568182016168940 0.000000000000000 + 624 1 2 -0.42000 24.582000000000001 38.820454750041236 0.000000000000000 + 625 1 1 0.42000 26.027999999999999 38.820454750041236 0.000000000000000 + 626 1 2 -0.42000 26.750999999999998 37.568182016168940 0.000000000000000 + 627 1 1 0.42000 28.196999999999999 37.568182016168940 0.000000000000000 + 628 1 2 -0.42000 28.919999999999998 38.820454750041236 0.000000000000000 + 629 1 1 0.42000 30.366000000000000 38.820454750041236 0.000000000000000 + 630 1 2 -0.42000 31.088999999999999 37.568182016168940 0.000000000000000 + 631 1 1 0.42000 32.534999999999997 37.568182016168940 0.000000000000000 + 632 1 2 -0.42000 33.258000000000003 38.820454750041236 0.000000000000000 + 633 1 1 0.42000 34.704000000000001 38.820454750041236 0.000000000000000 + 634 1 2 -0.42000 35.427000000000000 37.568182016168940 0.000000000000000 + 635 1 1 0.42000 36.872999999999998 37.568182016168940 0.000000000000000 + 636 1 2 -0.42000 37.596000000000004 38.820454750041236 0.000000000000000 + 637 1 1 0.42000 39.042000000000002 38.820454750041236 0.000000000000000 + 638 1 2 -0.42000 39.765000000000001 37.568182016168940 0.000000000000000 + 639 1 1 0.42000 41.210999999999999 37.568182016168940 0.000000000000000 + 640 1 2 -0.42000 41.934000000000005 38.820454750041236 0.000000000000000 + 641 1 1 0.42000 0.000000000000000 41.325000217785835 0.000000000000000 + 642 1 2 -0.42000 0.723000000000000 40.072727483913539 0.000000000000000 + 643 1 1 0.42000 2.169000000000000 40.072727483913539 0.000000000000000 + 644 1 2 -0.42000 2.892000000000000 41.325000217785835 0.000000000000000 + 645 1 1 0.42000 4.338000000000000 41.325000217785835 0.000000000000000 + 646 1 2 -0.42000 5.061000000000000 40.072727483913539 0.000000000000000 + 647 1 1 0.42000 6.507000000000000 40.072727483913539 0.000000000000000 + 648 1 2 -0.42000 7.230000000000000 41.325000217785835 0.000000000000000 + 649 1 1 0.42000 8.676000000000000 41.325000217785835 0.000000000000000 + 650 1 2 -0.42000 9.399000000000001 40.072727483913539 0.000000000000000 + 651 1 1 0.42000 10.845000000000001 40.072727483913539 0.000000000000000 + 652 1 2 -0.42000 11.568000000000000 41.325000217785835 0.000000000000000 + 653 1 1 0.42000 13.013999999999999 41.325000217785835 0.000000000000000 + 654 1 2 -0.42000 13.737000000000000 40.072727483913539 0.000000000000000 + 655 1 1 0.42000 15.183000000000000 40.072727483913539 0.000000000000000 + 656 1 2 -0.42000 15.905999999999999 41.325000217785835 0.000000000000000 + 657 1 1 0.42000 17.352000000000000 41.325000217785835 0.000000000000000 + 658 1 2 -0.42000 18.074999999999999 40.072727483913539 0.000000000000000 + 659 1 1 0.42000 19.521000000000001 40.072727483913539 0.000000000000000 + 660 1 2 -0.42000 20.244000000000000 41.325000217785835 0.000000000000000 + 661 1 1 0.42000 21.690000000000001 41.325000217785835 0.000000000000000 + 662 1 2 -0.42000 22.413000000000000 40.072727483913539 0.000000000000000 + 663 1 1 0.42000 23.859000000000002 40.072727483913539 0.000000000000000 + 664 1 2 -0.42000 24.582000000000001 41.325000217785835 0.000000000000000 + 665 1 1 0.42000 26.027999999999999 41.325000217785835 0.000000000000000 + 666 1 2 -0.42000 26.750999999999998 40.072727483913539 0.000000000000000 + 667 1 1 0.42000 28.196999999999999 40.072727483913539 0.000000000000000 + 668 1 2 -0.42000 28.919999999999998 41.325000217785835 0.000000000000000 + 669 1 1 0.42000 30.366000000000000 41.325000217785835 0.000000000000000 + 670 1 2 -0.42000 31.088999999999999 40.072727483913539 0.000000000000000 + 671 1 1 0.42000 32.534999999999997 40.072727483913539 0.000000000000000 + 672 1 2 -0.42000 33.258000000000003 41.325000217785835 0.000000000000000 + 673 1 1 0.42000 34.704000000000001 41.325000217785835 0.000000000000000 + 674 1 2 -0.42000 35.427000000000000 40.072727483913539 0.000000000000000 + 675 1 1 0.42000 36.872999999999998 40.072727483913539 0.000000000000000 + 676 1 2 -0.42000 37.596000000000004 41.325000217785835 0.000000000000000 + 677 1 1 0.42000 39.042000000000002 41.325000217785835 0.000000000000000 + 678 1 2 -0.42000 39.765000000000001 40.072727483913539 0.000000000000000 + 679 1 1 0.42000 41.210999999999999 40.072727483913539 0.000000000000000 + 680 1 2 -0.42000 41.934000000000005 41.325000217785835 0.000000000000000 + 681 2 4 -0.42000 0.000000000000000 1.252272733872298 3.330000000000000 + 682 2 3 0.42000 0.723000000000000 0.000000000000000 3.330000000000000 + 683 2 4 -0.42000 2.169000000000000 0.000000000000000 3.330000000000000 + 684 2 3 0.42000 2.892000000000000 1.252272733872298 3.330000000000000 + 685 2 4 -0.42000 4.338000000000000 1.252272733872298 3.330000000000000 + 686 2 3 0.42000 5.061000000000000 0.000000000000000 3.330000000000000 + 687 2 4 -0.42000 6.507000000000000 0.000000000000000 3.330000000000000 + 688 2 3 0.42000 7.230000000000000 1.252272733872298 3.330000000000000 + 689 2 4 -0.42000 8.676000000000000 1.252272733872298 3.330000000000000 + 690 2 3 0.42000 9.399000000000001 0.000000000000000 3.330000000000000 + 691 2 4 -0.42000 10.845000000000001 0.000000000000000 3.330000000000000 + 692 2 3 0.42000 11.568000000000000 1.252272733872298 3.330000000000000 + 693 2 4 -0.42000 13.013999999999999 1.252272733872298 3.330000000000000 + 694 2 3 0.42000 13.737000000000000 0.000000000000000 3.330000000000000 + 695 2 4 -0.42000 15.183000000000000 0.000000000000000 3.330000000000000 + 696 2 3 0.42000 15.905999999999999 1.252272733872298 3.330000000000000 + 697 2 4 -0.42000 17.352000000000000 1.252272733872298 3.330000000000000 + 698 2 3 0.42000 18.074999999999999 0.000000000000000 3.330000000000000 + 699 2 4 -0.42000 19.521000000000001 0.000000000000000 3.330000000000000 + 700 2 3 0.42000 20.244000000000000 1.252272733872298 3.330000000000000 + 701 2 4 -0.42000 21.690000000000001 1.252272733872298 3.330000000000000 + 702 2 3 0.42000 22.413000000000000 0.000000000000000 3.330000000000000 + 703 2 4 -0.42000 23.859000000000002 0.000000000000000 3.330000000000000 + 704 2 3 0.42000 24.582000000000001 1.252272733872298 3.330000000000000 + 705 2 4 -0.42000 26.027999999999999 1.252272733872298 3.330000000000000 + 706 2 3 0.42000 26.750999999999998 0.000000000000000 3.330000000000000 + 707 2 4 -0.42000 28.196999999999999 0.000000000000000 3.330000000000000 + 708 2 3 0.42000 28.919999999999998 1.252272733872298 3.330000000000000 + 709 2 4 -0.42000 30.366000000000000 1.252272733872298 3.330000000000000 + 710 2 3 0.42000 31.088999999999999 0.000000000000000 3.330000000000000 + 711 2 4 -0.42000 32.534999999999997 0.000000000000000 3.330000000000000 + 712 2 3 0.42000 33.258000000000003 1.252272733872298 3.330000000000000 + 713 2 4 -0.42000 34.704000000000001 1.252272733872298 3.330000000000000 + 714 2 3 0.42000 35.427000000000000 0.000000000000000 3.330000000000000 + 715 2 4 -0.42000 36.872999999999998 0.000000000000000 3.330000000000000 + 716 2 3 0.42000 37.596000000000004 1.252272733872298 3.330000000000000 + 717 2 4 -0.42000 39.042000000000002 1.252272733872298 3.330000000000000 + 718 2 3 0.42000 39.765000000000001 0.000000000000000 3.330000000000000 + 719 2 4 -0.42000 41.210999999999999 0.000000000000000 3.330000000000000 + 720 2 3 0.42000 41.934000000000005 1.252272733872298 3.330000000000000 + 721 2 4 -0.42000 0.000000000000000 3.756818201616894 3.330000000000000 + 722 2 3 0.42000 0.723000000000000 2.504545467744596 3.330000000000000 + 723 2 4 -0.42000 2.169000000000000 2.504545467744596 3.330000000000000 + 724 2 3 0.42000 2.892000000000000 3.756818201616894 3.330000000000000 + 725 2 4 -0.42000 4.338000000000000 3.756818201616894 3.330000000000000 + 726 2 3 0.42000 5.061000000000000 2.504545467744596 3.330000000000000 + 727 2 4 -0.42000 6.507000000000000 2.504545467744596 3.330000000000000 + 728 2 3 0.42000 7.230000000000000 3.756818201616894 3.330000000000000 + 729 2 4 -0.42000 8.676000000000000 3.756818201616894 3.330000000000000 + 730 2 3 0.42000 9.399000000000001 2.504545467744596 3.330000000000000 + 731 2 4 -0.42000 10.845000000000001 2.504545467744596 3.330000000000000 + 732 2 3 0.42000 11.568000000000000 3.756818201616894 3.330000000000000 + 733 2 4 -0.42000 13.013999999999999 3.756818201616894 3.330000000000000 + 734 2 3 0.42000 13.737000000000000 2.504545467744596 3.330000000000000 + 735 2 4 -0.42000 15.183000000000000 2.504545467744596 3.330000000000000 + 736 2 3 0.42000 15.905999999999999 3.756818201616894 3.330000000000000 + 737 2 4 -0.42000 17.352000000000000 3.756818201616894 3.330000000000000 + 738 2 3 0.42000 18.074999999999999 2.504545467744596 3.330000000000000 + 739 2 4 -0.42000 19.521000000000001 2.504545467744596 3.330000000000000 + 740 2 3 0.42000 20.244000000000000 3.756818201616894 3.330000000000000 + 741 2 4 -0.42000 21.690000000000001 3.756818201616894 3.330000000000000 + 742 2 3 0.42000 22.413000000000000 2.504545467744596 3.330000000000000 + 743 2 4 -0.42000 23.859000000000002 2.504545467744596 3.330000000000000 + 744 2 3 0.42000 24.582000000000001 3.756818201616894 3.330000000000000 + 745 2 4 -0.42000 26.027999999999999 3.756818201616894 3.330000000000000 + 746 2 3 0.42000 26.750999999999998 2.504545467744596 3.330000000000000 + 747 2 4 -0.42000 28.196999999999999 2.504545467744596 3.330000000000000 + 748 2 3 0.42000 28.919999999999998 3.756818201616894 3.330000000000000 + 749 2 4 -0.42000 30.366000000000000 3.756818201616894 3.330000000000000 + 750 2 3 0.42000 31.088999999999999 2.504545467744596 3.330000000000000 + 751 2 4 -0.42000 32.534999999999997 2.504545467744596 3.330000000000000 + 752 2 3 0.42000 33.258000000000003 3.756818201616894 3.330000000000000 + 753 2 4 -0.42000 34.704000000000001 3.756818201616894 3.330000000000000 + 754 2 3 0.42000 35.427000000000000 2.504545467744596 3.330000000000000 + 755 2 4 -0.42000 36.872999999999998 2.504545467744596 3.330000000000000 + 756 2 3 0.42000 37.596000000000004 3.756818201616894 3.330000000000000 + 757 2 4 -0.42000 39.042000000000002 3.756818201616894 3.330000000000000 + 758 2 3 0.42000 39.765000000000001 2.504545467744596 3.330000000000000 + 759 2 4 -0.42000 41.210999999999999 2.504545467744596 3.330000000000000 + 760 2 3 0.42000 41.934000000000005 3.756818201616894 3.330000000000000 + 761 2 4 -0.42000 0.000000000000000 6.261363669361490 3.330000000000000 + 762 2 3 0.42000 0.723000000000000 5.009090935489192 3.330000000000000 + 763 2 4 -0.42000 2.169000000000000 5.009090935489192 3.330000000000000 + 764 2 3 0.42000 2.892000000000000 6.261363669361490 3.330000000000000 + 765 2 4 -0.42000 4.338000000000000 6.261363669361490 3.330000000000000 + 766 2 3 0.42000 5.061000000000000 5.009090935489192 3.330000000000000 + 767 2 4 -0.42000 6.507000000000000 5.009090935489192 3.330000000000000 + 768 2 3 0.42000 7.230000000000000 6.261363669361490 3.330000000000000 + 769 2 4 -0.42000 8.676000000000000 6.261363669361490 3.330000000000000 + 770 2 3 0.42000 9.399000000000001 5.009090935489192 3.330000000000000 + 771 2 4 -0.42000 10.845000000000001 5.009090935489192 3.330000000000000 + 772 2 3 0.42000 11.568000000000000 6.261363669361490 3.330000000000000 + 773 2 4 -0.42000 13.013999999999999 6.261363669361490 3.330000000000000 + 774 2 3 0.42000 13.737000000000000 5.009090935489192 3.330000000000000 + 775 2 4 -0.42000 15.183000000000000 5.009090935489192 3.330000000000000 + 776 2 3 0.42000 15.905999999999999 6.261363669361490 3.330000000000000 + 777 2 4 -0.42000 17.352000000000000 6.261363669361490 3.330000000000000 + 778 2 3 0.42000 18.074999999999999 5.009090935489192 3.330000000000000 + 779 2 4 -0.42000 19.521000000000001 5.009090935489192 3.330000000000000 + 780 2 3 0.42000 20.244000000000000 6.261363669361490 3.330000000000000 + 781 2 4 -0.42000 21.690000000000001 6.261363669361490 3.330000000000000 + 782 2 3 0.42000 22.413000000000000 5.009090935489192 3.330000000000000 + 783 2 4 -0.42000 23.859000000000002 5.009090935489192 3.330000000000000 + 784 2 3 0.42000 24.582000000000001 6.261363669361490 3.330000000000000 + 785 2 4 -0.42000 26.027999999999999 6.261363669361490 3.330000000000000 + 786 2 3 0.42000 26.750999999999998 5.009090935489192 3.330000000000000 + 787 2 4 -0.42000 28.196999999999999 5.009090935489192 3.330000000000000 + 788 2 3 0.42000 28.919999999999998 6.261363669361490 3.330000000000000 + 789 2 4 -0.42000 30.366000000000000 6.261363669361490 3.330000000000000 + 790 2 3 0.42000 31.088999999999999 5.009090935489192 3.330000000000000 + 791 2 4 -0.42000 32.534999999999997 5.009090935489192 3.330000000000000 + 792 2 3 0.42000 33.258000000000003 6.261363669361490 3.330000000000000 + 793 2 4 -0.42000 34.704000000000001 6.261363669361490 3.330000000000000 + 794 2 3 0.42000 35.427000000000000 5.009090935489192 3.330000000000000 + 795 2 4 -0.42000 36.872999999999998 5.009090935489192 3.330000000000000 + 796 2 3 0.42000 37.596000000000004 6.261363669361490 3.330000000000000 + 797 2 4 -0.42000 39.042000000000002 6.261363669361490 3.330000000000000 + 798 2 3 0.42000 39.765000000000001 5.009090935489192 3.330000000000000 + 799 2 4 -0.42000 41.210999999999999 5.009090935489192 3.330000000000000 + 800 2 3 0.42000 41.934000000000005 6.261363669361490 3.330000000000000 + 801 2 4 -0.42000 0.000000000000000 8.765909137106087 3.330000000000000 + 802 2 3 0.42000 0.723000000000000 7.513636403233789 3.330000000000000 + 803 2 4 -0.42000 2.169000000000000 7.513636403233789 3.330000000000000 + 804 2 3 0.42000 2.892000000000000 8.765909137106087 3.330000000000000 + 805 2 4 -0.42000 4.338000000000000 8.765909137106087 3.330000000000000 + 806 2 3 0.42000 5.061000000000000 7.513636403233789 3.330000000000000 + 807 2 4 -0.42000 6.507000000000000 7.513636403233789 3.330000000000000 + 808 2 3 0.42000 7.230000000000000 8.765909137106087 3.330000000000000 + 809 2 4 -0.42000 8.676000000000000 8.765909137106087 3.330000000000000 + 810 2 3 0.42000 9.399000000000001 7.513636403233789 3.330000000000000 + 811 2 4 -0.42000 10.845000000000001 7.513636403233789 3.330000000000000 + 812 2 3 0.42000 11.568000000000000 8.765909137106087 3.330000000000000 + 813 2 4 -0.42000 13.013999999999999 8.765909137106087 3.330000000000000 + 814 2 3 0.42000 13.737000000000000 7.513636403233789 3.330000000000000 + 815 2 4 -0.42000 15.183000000000000 7.513636403233789 3.330000000000000 + 816 2 3 0.42000 15.905999999999999 8.765909137106087 3.330000000000000 + 817 2 4 -0.42000 17.352000000000000 8.765909137106087 3.330000000000000 + 818 2 3 0.42000 18.074999999999999 7.513636403233789 3.330000000000000 + 819 2 4 -0.42000 19.521000000000001 7.513636403233789 3.330000000000000 + 820 2 3 0.42000 20.244000000000000 8.765909137106087 3.330000000000000 + 821 2 4 -0.42000 21.690000000000001 8.765909137106087 3.330000000000000 + 822 2 3 0.42000 22.413000000000000 7.513636403233789 3.330000000000000 + 823 2 4 -0.42000 23.859000000000002 7.513636403233789 3.330000000000000 + 824 2 3 0.42000 24.582000000000001 8.765909137106087 3.330000000000000 + 825 2 4 -0.42000 26.027999999999999 8.765909137106087 3.330000000000000 + 826 2 3 0.42000 26.750999999999998 7.513636403233789 3.330000000000000 + 827 2 4 -0.42000 28.196999999999999 7.513636403233789 3.330000000000000 + 828 2 3 0.42000 28.919999999999998 8.765909137106087 3.330000000000000 + 829 2 4 -0.42000 30.366000000000000 8.765909137106087 3.330000000000000 + 830 2 3 0.42000 31.088999999999999 7.513636403233789 3.330000000000000 + 831 2 4 -0.42000 32.534999999999997 7.513636403233789 3.330000000000000 + 832 2 3 0.42000 33.258000000000003 8.765909137106087 3.330000000000000 + 833 2 4 -0.42000 34.704000000000001 8.765909137106087 3.330000000000000 + 834 2 3 0.42000 35.427000000000000 7.513636403233789 3.330000000000000 + 835 2 4 -0.42000 36.872999999999998 7.513636403233789 3.330000000000000 + 836 2 3 0.42000 37.596000000000004 8.765909137106087 3.330000000000000 + 837 2 4 -0.42000 39.042000000000002 8.765909137106087 3.330000000000000 + 838 2 3 0.42000 39.765000000000001 7.513636403233789 3.330000000000000 + 839 2 4 -0.42000 41.210999999999999 7.513636403233789 3.330000000000000 + 840 2 3 0.42000 41.934000000000005 8.765909137106087 3.330000000000000 + 841 2 4 -0.42000 0.000000000000000 11.270454604850682 3.330000000000000 + 842 2 3 0.42000 0.723000000000000 10.018181870978385 3.330000000000000 + 843 2 4 -0.42000 2.169000000000000 10.018181870978385 3.330000000000000 + 844 2 3 0.42000 2.892000000000000 11.270454604850682 3.330000000000000 + 845 2 4 -0.42000 4.338000000000000 11.270454604850682 3.330000000000000 + 846 2 3 0.42000 5.061000000000000 10.018181870978385 3.330000000000000 + 847 2 4 -0.42000 6.507000000000000 10.018181870978385 3.330000000000000 + 848 2 3 0.42000 7.230000000000000 11.270454604850682 3.330000000000000 + 849 2 4 -0.42000 8.676000000000000 11.270454604850682 3.330000000000000 + 850 2 3 0.42000 9.399000000000001 10.018181870978385 3.330000000000000 + 851 2 4 -0.42000 10.845000000000001 10.018181870978385 3.330000000000000 + 852 2 3 0.42000 11.568000000000000 11.270454604850682 3.330000000000000 + 853 2 4 -0.42000 13.013999999999999 11.270454604850682 3.330000000000000 + 854 2 3 0.42000 13.737000000000000 10.018181870978385 3.330000000000000 + 855 2 4 -0.42000 15.183000000000000 10.018181870978385 3.330000000000000 + 856 2 3 0.42000 15.905999999999999 11.270454604850682 3.330000000000000 + 857 2 4 -0.42000 17.352000000000000 11.270454604850682 3.330000000000000 + 858 2 3 0.42000 18.074999999999999 10.018181870978385 3.330000000000000 + 859 2 4 -0.42000 19.521000000000001 10.018181870978385 3.330000000000000 + 860 2 3 0.42000 20.244000000000000 11.270454604850682 3.330000000000000 + 861 2 4 -0.42000 21.690000000000001 11.270454604850682 3.330000000000000 + 862 2 3 0.42000 22.413000000000000 10.018181870978385 3.330000000000000 + 863 2 4 -0.42000 23.859000000000002 10.018181870978385 3.330000000000000 + 864 2 3 0.42000 24.582000000000001 11.270454604850682 3.330000000000000 + 865 2 4 -0.42000 26.027999999999999 11.270454604850682 3.330000000000000 + 866 2 3 0.42000 26.750999999999998 10.018181870978385 3.330000000000000 + 867 2 4 -0.42000 28.196999999999999 10.018181870978385 3.330000000000000 + 868 2 3 0.42000 28.919999999999998 11.270454604850682 3.330000000000000 + 869 2 4 -0.42000 30.366000000000000 11.270454604850682 3.330000000000000 + 870 2 3 0.42000 31.088999999999999 10.018181870978385 3.330000000000000 + 871 2 4 -0.42000 32.534999999999997 10.018181870978385 3.330000000000000 + 872 2 3 0.42000 33.258000000000003 11.270454604850682 3.330000000000000 + 873 2 4 -0.42000 34.704000000000001 11.270454604850682 3.330000000000000 + 874 2 3 0.42000 35.427000000000000 10.018181870978385 3.330000000000000 + 875 2 4 -0.42000 36.872999999999998 10.018181870978385 3.330000000000000 + 876 2 3 0.42000 37.596000000000004 11.270454604850682 3.330000000000000 + 877 2 4 -0.42000 39.042000000000002 11.270454604850682 3.330000000000000 + 878 2 3 0.42000 39.765000000000001 10.018181870978385 3.330000000000000 + 879 2 4 -0.42000 41.210999999999999 10.018181870978385 3.330000000000000 + 880 2 3 0.42000 41.934000000000005 11.270454604850682 3.330000000000000 + 881 2 4 -0.42000 0.000000000000000 13.775000072595278 3.330000000000000 + 882 2 3 0.42000 0.723000000000000 12.522727338722980 3.330000000000000 + 883 2 4 -0.42000 2.169000000000000 12.522727338722980 3.330000000000000 + 884 2 3 0.42000 2.892000000000000 13.775000072595278 3.330000000000000 + 885 2 4 -0.42000 4.338000000000000 13.775000072595278 3.330000000000000 + 886 2 3 0.42000 5.061000000000000 12.522727338722980 3.330000000000000 + 887 2 4 -0.42000 6.507000000000000 12.522727338722980 3.330000000000000 + 888 2 3 0.42000 7.230000000000000 13.775000072595278 3.330000000000000 + 889 2 4 -0.42000 8.676000000000000 13.775000072595278 3.330000000000000 + 890 2 3 0.42000 9.399000000000001 12.522727338722980 3.330000000000000 + 891 2 4 -0.42000 10.845000000000001 12.522727338722980 3.330000000000000 + 892 2 3 0.42000 11.568000000000000 13.775000072595278 3.330000000000000 + 893 2 4 -0.42000 13.013999999999999 13.775000072595278 3.330000000000000 + 894 2 3 0.42000 13.737000000000000 12.522727338722980 3.330000000000000 + 895 2 4 -0.42000 15.183000000000000 12.522727338722980 3.330000000000000 + 896 2 3 0.42000 15.905999999999999 13.775000072595278 3.330000000000000 + 897 2 4 -0.42000 17.352000000000000 13.775000072595278 3.330000000000000 + 898 2 3 0.42000 18.074999999999999 12.522727338722980 3.330000000000000 + 899 2 4 -0.42000 19.521000000000001 12.522727338722980 3.330000000000000 + 900 2 3 0.42000 20.244000000000000 13.775000072595278 3.330000000000000 + 901 2 4 -0.42000 21.690000000000001 13.775000072595278 3.330000000000000 + 902 2 3 0.42000 22.413000000000000 12.522727338722980 3.330000000000000 + 903 2 4 -0.42000 23.859000000000002 12.522727338722980 3.330000000000000 + 904 2 3 0.42000 24.582000000000001 13.775000072595278 3.330000000000000 + 905 2 4 -0.42000 26.027999999999999 13.775000072595278 3.330000000000000 + 906 2 3 0.42000 26.750999999999998 12.522727338722980 3.330000000000000 + 907 2 4 -0.42000 28.196999999999999 12.522727338722980 3.330000000000000 + 908 2 3 0.42000 28.919999999999998 13.775000072595278 3.330000000000000 + 909 2 4 -0.42000 30.366000000000000 13.775000072595278 3.330000000000000 + 910 2 3 0.42000 31.088999999999999 12.522727338722980 3.330000000000000 + 911 2 4 -0.42000 32.534999999999997 12.522727338722980 3.330000000000000 + 912 2 3 0.42000 33.258000000000003 13.775000072595278 3.330000000000000 + 913 2 4 -0.42000 34.704000000000001 13.775000072595278 3.330000000000000 + 914 2 3 0.42000 35.427000000000000 12.522727338722980 3.330000000000000 + 915 2 4 -0.42000 36.872999999999998 12.522727338722980 3.330000000000000 + 916 2 3 0.42000 37.596000000000004 13.775000072595278 3.330000000000000 + 917 2 4 -0.42000 39.042000000000002 13.775000072595278 3.330000000000000 + 918 2 3 0.42000 39.765000000000001 12.522727338722980 3.330000000000000 + 919 2 4 -0.42000 41.210999999999999 12.522727338722980 3.330000000000000 + 920 2 3 0.42000 41.934000000000005 13.775000072595278 3.330000000000000 + 921 2 4 -0.42000 0.000000000000000 16.279545540339875 3.330000000000000 + 922 2 3 0.42000 0.723000000000000 15.027272806467577 3.330000000000000 + 923 2 4 -0.42000 2.169000000000000 15.027272806467577 3.330000000000000 + 924 2 3 0.42000 2.892000000000000 16.279545540339875 3.330000000000000 + 925 2 4 -0.42000 4.338000000000000 16.279545540339875 3.330000000000000 + 926 2 3 0.42000 5.061000000000000 15.027272806467577 3.330000000000000 + 927 2 4 -0.42000 6.507000000000000 15.027272806467577 3.330000000000000 + 928 2 3 0.42000 7.230000000000000 16.279545540339875 3.330000000000000 + 929 2 4 -0.42000 8.676000000000000 16.279545540339875 3.330000000000000 + 930 2 3 0.42000 9.399000000000001 15.027272806467577 3.330000000000000 + 931 2 4 -0.42000 10.845000000000001 15.027272806467577 3.330000000000000 + 932 2 3 0.42000 11.568000000000000 16.279545540339875 3.330000000000000 + 933 2 4 -0.42000 13.013999999999999 16.279545540339875 3.330000000000000 + 934 2 3 0.42000 13.737000000000000 15.027272806467577 3.330000000000000 + 935 2 4 -0.42000 15.183000000000000 15.027272806467577 3.330000000000000 + 936 2 3 0.42000 15.905999999999999 16.279545540339875 3.330000000000000 + 937 2 4 -0.42000 17.352000000000000 16.279545540339875 3.330000000000000 + 938 2 3 0.42000 18.074999999999999 15.027272806467577 3.330000000000000 + 939 2 4 -0.42000 19.521000000000001 15.027272806467577 3.330000000000000 + 940 2 3 0.42000 20.244000000000000 16.279545540339875 3.330000000000000 + 941 2 4 -0.42000 21.690000000000001 16.279545540339875 3.330000000000000 + 942 2 3 0.42000 22.413000000000000 15.027272806467577 3.330000000000000 + 943 2 4 -0.42000 23.859000000000002 15.027272806467577 3.330000000000000 + 944 2 3 0.42000 24.582000000000001 16.279545540339875 3.330000000000000 + 945 2 4 -0.42000 26.027999999999999 16.279545540339875 3.330000000000000 + 946 2 3 0.42000 26.750999999999998 15.027272806467577 3.330000000000000 + 947 2 4 -0.42000 28.196999999999999 15.027272806467577 3.330000000000000 + 948 2 3 0.42000 28.919999999999998 16.279545540339875 3.330000000000000 + 949 2 4 -0.42000 30.366000000000000 16.279545540339875 3.330000000000000 + 950 2 3 0.42000 31.088999999999999 15.027272806467577 3.330000000000000 + 951 2 4 -0.42000 32.534999999999997 15.027272806467577 3.330000000000000 + 952 2 3 0.42000 33.258000000000003 16.279545540339875 3.330000000000000 + 953 2 4 -0.42000 34.704000000000001 16.279545540339875 3.330000000000000 + 954 2 3 0.42000 35.427000000000000 15.027272806467577 3.330000000000000 + 955 2 4 -0.42000 36.872999999999998 15.027272806467577 3.330000000000000 + 956 2 3 0.42000 37.596000000000004 16.279545540339875 3.330000000000000 + 957 2 4 -0.42000 39.042000000000002 16.279545540339875 3.330000000000000 + 958 2 3 0.42000 39.765000000000001 15.027272806467577 3.330000000000000 + 959 2 4 -0.42000 41.210999999999999 15.027272806467577 3.330000000000000 + 960 2 3 0.42000 41.934000000000005 16.279545540339875 3.330000000000000 + 961 2 4 -0.42000 0.000000000000000 18.784091008084474 3.330000000000000 + 962 2 3 0.42000 0.723000000000000 17.531818274212174 3.330000000000000 + 963 2 4 -0.42000 2.169000000000000 17.531818274212174 3.330000000000000 + 964 2 3 0.42000 2.892000000000000 18.784091008084474 3.330000000000000 + 965 2 4 -0.42000 4.338000000000000 18.784091008084474 3.330000000000000 + 966 2 3 0.42000 5.061000000000000 17.531818274212174 3.330000000000000 + 967 2 4 -0.42000 6.507000000000000 17.531818274212174 3.330000000000000 + 968 2 3 0.42000 7.230000000000000 18.784091008084474 3.330000000000000 + 969 2 4 -0.42000 8.676000000000000 18.784091008084474 3.330000000000000 + 970 2 3 0.42000 9.399000000000001 17.531818274212174 3.330000000000000 + 971 2 4 -0.42000 10.845000000000001 17.531818274212174 3.330000000000000 + 972 2 3 0.42000 11.568000000000000 18.784091008084474 3.330000000000000 + 973 2 4 -0.42000 13.013999999999999 18.784091008084474 3.330000000000000 + 974 2 3 0.42000 13.737000000000000 17.531818274212174 3.330000000000000 + 975 2 4 -0.42000 15.183000000000000 17.531818274212174 3.330000000000000 + 976 2 3 0.42000 15.905999999999999 18.784091008084474 3.330000000000000 + 977 2 4 -0.42000 17.352000000000000 18.784091008084474 3.330000000000000 + 978 2 3 0.42000 18.074999999999999 17.531818274212174 3.330000000000000 + 979 2 4 -0.42000 19.521000000000001 17.531818274212174 3.330000000000000 + 980 2 3 0.42000 20.244000000000000 18.784091008084474 3.330000000000000 + 981 2 4 -0.42000 21.690000000000001 18.784091008084474 3.330000000000000 + 982 2 3 0.42000 22.413000000000000 17.531818274212174 3.330000000000000 + 983 2 4 -0.42000 23.859000000000002 17.531818274212174 3.330000000000000 + 984 2 3 0.42000 24.582000000000001 18.784091008084474 3.330000000000000 + 985 2 4 -0.42000 26.027999999999999 18.784091008084474 3.330000000000000 + 986 2 3 0.42000 26.750999999999998 17.531818274212174 3.330000000000000 + 987 2 4 -0.42000 28.196999999999999 17.531818274212174 3.330000000000000 + 988 2 3 0.42000 28.919999999999998 18.784091008084474 3.330000000000000 + 989 2 4 -0.42000 30.366000000000000 18.784091008084474 3.330000000000000 + 990 2 3 0.42000 31.088999999999999 17.531818274212174 3.330000000000000 + 991 2 4 -0.42000 32.534999999999997 17.531818274212174 3.330000000000000 + 992 2 3 0.42000 33.258000000000003 18.784091008084474 3.330000000000000 + 993 2 4 -0.42000 34.704000000000001 18.784091008084474 3.330000000000000 + 994 2 3 0.42000 35.427000000000000 17.531818274212174 3.330000000000000 + 995 2 4 -0.42000 36.872999999999998 17.531818274212174 3.330000000000000 + 996 2 3 0.42000 37.596000000000004 18.784091008084474 3.330000000000000 + 997 2 4 -0.42000 39.042000000000002 18.784091008084474 3.330000000000000 + 998 2 3 0.42000 39.765000000000001 17.531818274212174 3.330000000000000 + 999 2 4 -0.42000 41.210999999999999 17.531818274212174 3.330000000000000 + 1000 2 3 0.42000 41.934000000000005 18.784091008084474 3.330000000000000 + 1001 2 4 -0.42000 0.000000000000000 21.288636475829069 3.330000000000000 + 1002 2 3 0.42000 0.723000000000000 20.036363741956770 3.330000000000000 + 1003 2 4 -0.42000 2.169000000000000 20.036363741956770 3.330000000000000 + 1004 2 3 0.42000 2.892000000000000 21.288636475829069 3.330000000000000 + 1005 2 4 -0.42000 4.338000000000000 21.288636475829069 3.330000000000000 + 1006 2 3 0.42000 5.061000000000000 20.036363741956770 3.330000000000000 + 1007 2 4 -0.42000 6.507000000000000 20.036363741956770 3.330000000000000 + 1008 2 3 0.42000 7.230000000000000 21.288636475829069 3.330000000000000 + 1009 2 4 -0.42000 8.676000000000000 21.288636475829069 3.330000000000000 + 1010 2 3 0.42000 9.399000000000001 20.036363741956770 3.330000000000000 + 1011 2 4 -0.42000 10.845000000000001 20.036363741956770 3.330000000000000 + 1012 2 3 0.42000 11.568000000000000 21.288636475829069 3.330000000000000 + 1013 2 4 -0.42000 13.013999999999999 21.288636475829069 3.330000000000000 + 1014 2 3 0.42000 13.737000000000000 20.036363741956770 3.330000000000000 + 1015 2 4 -0.42000 15.183000000000000 20.036363741956770 3.330000000000000 + 1016 2 3 0.42000 15.905999999999999 21.288636475829069 3.330000000000000 + 1017 2 4 -0.42000 17.352000000000000 21.288636475829069 3.330000000000000 + 1018 2 3 0.42000 18.074999999999999 20.036363741956770 3.330000000000000 + 1019 2 4 -0.42000 19.521000000000001 20.036363741956770 3.330000000000000 + 1020 2 3 0.42000 20.244000000000000 21.288636475829069 3.330000000000000 + 1021 2 4 -0.42000 21.690000000000001 21.288636475829069 3.330000000000000 + 1022 2 3 0.42000 22.413000000000000 20.036363741956770 3.330000000000000 + 1023 2 4 -0.42000 23.859000000000002 20.036363741956770 3.330000000000000 + 1024 2 3 0.42000 24.582000000000001 21.288636475829069 3.330000000000000 + 1025 2 4 -0.42000 26.027999999999999 21.288636475829069 3.330000000000000 + 1026 2 3 0.42000 26.750999999999998 20.036363741956770 3.330000000000000 + 1027 2 4 -0.42000 28.196999999999999 20.036363741956770 3.330000000000000 + 1028 2 3 0.42000 28.919999999999998 21.288636475829069 3.330000000000000 + 1029 2 4 -0.42000 30.366000000000000 21.288636475829069 3.330000000000000 + 1030 2 3 0.42000 31.088999999999999 20.036363741956770 3.330000000000000 + 1031 2 4 -0.42000 32.534999999999997 20.036363741956770 3.330000000000000 + 1032 2 3 0.42000 33.258000000000003 21.288636475829069 3.330000000000000 + 1033 2 4 -0.42000 34.704000000000001 21.288636475829069 3.330000000000000 + 1034 2 3 0.42000 35.427000000000000 20.036363741956770 3.330000000000000 + 1035 2 4 -0.42000 36.872999999999998 20.036363741956770 3.330000000000000 + 1036 2 3 0.42000 37.596000000000004 21.288636475829069 3.330000000000000 + 1037 2 4 -0.42000 39.042000000000002 21.288636475829069 3.330000000000000 + 1038 2 3 0.42000 39.765000000000001 20.036363741956770 3.330000000000000 + 1039 2 4 -0.42000 41.210999999999999 20.036363741956770 3.330000000000000 + 1040 2 3 0.42000 41.934000000000005 21.288636475829069 3.330000000000000 + 1041 2 4 -0.42000 0.000000000000000 23.793181943573664 3.330000000000000 + 1042 2 3 0.42000 0.723000000000000 22.540909209701365 3.330000000000000 + 1043 2 4 -0.42000 2.169000000000000 22.540909209701365 3.330000000000000 + 1044 2 3 0.42000 2.892000000000000 23.793181943573664 3.330000000000000 + 1045 2 4 -0.42000 4.338000000000000 23.793181943573664 3.330000000000000 + 1046 2 3 0.42000 5.061000000000000 22.540909209701365 3.330000000000000 + 1047 2 4 -0.42000 6.507000000000000 22.540909209701365 3.330000000000000 + 1048 2 3 0.42000 7.230000000000000 23.793181943573664 3.330000000000000 + 1049 2 4 -0.42000 8.676000000000000 23.793181943573664 3.330000000000000 + 1050 2 3 0.42000 9.399000000000001 22.540909209701365 3.330000000000000 + 1051 2 4 -0.42000 10.845000000000001 22.540909209701365 3.330000000000000 + 1052 2 3 0.42000 11.568000000000000 23.793181943573664 3.330000000000000 + 1053 2 4 -0.42000 13.013999999999999 23.793181943573664 3.330000000000000 + 1054 2 3 0.42000 13.737000000000000 22.540909209701365 3.330000000000000 + 1055 2 4 -0.42000 15.183000000000000 22.540909209701365 3.330000000000000 + 1056 2 3 0.42000 15.905999999999999 23.793181943573664 3.330000000000000 + 1057 2 4 -0.42000 17.352000000000000 23.793181943573664 3.330000000000000 + 1058 2 3 0.42000 18.074999999999999 22.540909209701365 3.330000000000000 + 1059 2 4 -0.42000 19.521000000000001 22.540909209701365 3.330000000000000 + 1060 2 3 0.42000 20.244000000000000 23.793181943573664 3.330000000000000 + 1061 2 4 -0.42000 21.690000000000001 23.793181943573664 3.330000000000000 + 1062 2 3 0.42000 22.413000000000000 22.540909209701365 3.330000000000000 + 1063 2 4 -0.42000 23.859000000000002 22.540909209701365 3.330000000000000 + 1064 2 3 0.42000 24.582000000000001 23.793181943573664 3.330000000000000 + 1065 2 4 -0.42000 26.027999999999999 23.793181943573664 3.330000000000000 + 1066 2 3 0.42000 26.750999999999998 22.540909209701365 3.330000000000000 + 1067 2 4 -0.42000 28.196999999999999 22.540909209701365 3.330000000000000 + 1068 2 3 0.42000 28.919999999999998 23.793181943573664 3.330000000000000 + 1069 2 4 -0.42000 30.366000000000000 23.793181943573664 3.330000000000000 + 1070 2 3 0.42000 31.088999999999999 22.540909209701365 3.330000000000000 + 1071 2 4 -0.42000 32.534999999999997 22.540909209701365 3.330000000000000 + 1072 2 3 0.42000 33.258000000000003 23.793181943573664 3.330000000000000 + 1073 2 4 -0.42000 34.704000000000001 23.793181943573664 3.330000000000000 + 1074 2 3 0.42000 35.427000000000000 22.540909209701365 3.330000000000000 + 1075 2 4 -0.42000 36.872999999999998 22.540909209701365 3.330000000000000 + 1076 2 3 0.42000 37.596000000000004 23.793181943573664 3.330000000000000 + 1077 2 4 -0.42000 39.042000000000002 23.793181943573664 3.330000000000000 + 1078 2 3 0.42000 39.765000000000001 22.540909209701365 3.330000000000000 + 1079 2 4 -0.42000 41.210999999999999 22.540909209701365 3.330000000000000 + 1080 2 3 0.42000 41.934000000000005 23.793181943573664 3.330000000000000 + 1081 2 4 -0.42000 0.000000000000000 26.297727411318260 3.330000000000000 + 1082 2 3 0.42000 0.723000000000000 25.045454677445960 3.330000000000000 + 1083 2 4 -0.42000 2.169000000000000 25.045454677445960 3.330000000000000 + 1084 2 3 0.42000 2.892000000000000 26.297727411318260 3.330000000000000 + 1085 2 4 -0.42000 4.338000000000000 26.297727411318260 3.330000000000000 + 1086 2 3 0.42000 5.061000000000000 25.045454677445960 3.330000000000000 + 1087 2 4 -0.42000 6.507000000000000 25.045454677445960 3.330000000000000 + 1088 2 3 0.42000 7.230000000000000 26.297727411318260 3.330000000000000 + 1089 2 4 -0.42000 8.676000000000000 26.297727411318260 3.330000000000000 + 1090 2 3 0.42000 9.399000000000001 25.045454677445960 3.330000000000000 + 1091 2 4 -0.42000 10.845000000000001 25.045454677445960 3.330000000000000 + 1092 2 3 0.42000 11.568000000000000 26.297727411318260 3.330000000000000 + 1093 2 4 -0.42000 13.013999999999999 26.297727411318260 3.330000000000000 + 1094 2 3 0.42000 13.737000000000000 25.045454677445960 3.330000000000000 + 1095 2 4 -0.42000 15.183000000000000 25.045454677445960 3.330000000000000 + 1096 2 3 0.42000 15.905999999999999 26.297727411318260 3.330000000000000 + 1097 2 4 -0.42000 17.352000000000000 26.297727411318260 3.330000000000000 + 1098 2 3 0.42000 18.074999999999999 25.045454677445960 3.330000000000000 + 1099 2 4 -0.42000 19.521000000000001 25.045454677445960 3.330000000000000 + 1100 2 3 0.42000 20.244000000000000 26.297727411318260 3.330000000000000 + 1101 2 4 -0.42000 21.690000000000001 26.297727411318260 3.330000000000000 + 1102 2 3 0.42000 22.413000000000000 25.045454677445960 3.330000000000000 + 1103 2 4 -0.42000 23.859000000000002 25.045454677445960 3.330000000000000 + 1104 2 3 0.42000 24.582000000000001 26.297727411318260 3.330000000000000 + 1105 2 4 -0.42000 26.027999999999999 26.297727411318260 3.330000000000000 + 1106 2 3 0.42000 26.750999999999998 25.045454677445960 3.330000000000000 + 1107 2 4 -0.42000 28.196999999999999 25.045454677445960 3.330000000000000 + 1108 2 3 0.42000 28.919999999999998 26.297727411318260 3.330000000000000 + 1109 2 4 -0.42000 30.366000000000000 26.297727411318260 3.330000000000000 + 1110 2 3 0.42000 31.088999999999999 25.045454677445960 3.330000000000000 + 1111 2 4 -0.42000 32.534999999999997 25.045454677445960 3.330000000000000 + 1112 2 3 0.42000 33.258000000000003 26.297727411318260 3.330000000000000 + 1113 2 4 -0.42000 34.704000000000001 26.297727411318260 3.330000000000000 + 1114 2 3 0.42000 35.427000000000000 25.045454677445960 3.330000000000000 + 1115 2 4 -0.42000 36.872999999999998 25.045454677445960 3.330000000000000 + 1116 2 3 0.42000 37.596000000000004 26.297727411318260 3.330000000000000 + 1117 2 4 -0.42000 39.042000000000002 26.297727411318260 3.330000000000000 + 1118 2 3 0.42000 39.765000000000001 25.045454677445960 3.330000000000000 + 1119 2 4 -0.42000 41.210999999999999 25.045454677445960 3.330000000000000 + 1120 2 3 0.42000 41.934000000000005 26.297727411318260 3.330000000000000 + 1121 2 4 -0.42000 0.000000000000000 28.802272879062858 3.330000000000000 + 1122 2 3 0.42000 0.723000000000000 27.550000145190559 3.330000000000000 + 1123 2 4 -0.42000 2.169000000000000 27.550000145190559 3.330000000000000 + 1124 2 3 0.42000 2.892000000000000 28.802272879062858 3.330000000000000 + 1125 2 4 -0.42000 4.338000000000000 28.802272879062858 3.330000000000000 + 1126 2 3 0.42000 5.061000000000000 27.550000145190559 3.330000000000000 + 1127 2 4 -0.42000 6.507000000000000 27.550000145190559 3.330000000000000 + 1128 2 3 0.42000 7.230000000000000 28.802272879062858 3.330000000000000 + 1129 2 4 -0.42000 8.676000000000000 28.802272879062858 3.330000000000000 + 1130 2 3 0.42000 9.399000000000001 27.550000145190559 3.330000000000000 + 1131 2 4 -0.42000 10.845000000000001 27.550000145190559 3.330000000000000 + 1132 2 3 0.42000 11.568000000000000 28.802272879062858 3.330000000000000 + 1133 2 4 -0.42000 13.013999999999999 28.802272879062858 3.330000000000000 + 1134 2 3 0.42000 13.737000000000000 27.550000145190559 3.330000000000000 + 1135 2 4 -0.42000 15.183000000000000 27.550000145190559 3.330000000000000 + 1136 2 3 0.42000 15.905999999999999 28.802272879062858 3.330000000000000 + 1137 2 4 -0.42000 17.352000000000000 28.802272879062858 3.330000000000000 + 1138 2 3 0.42000 18.074999999999999 27.550000145190559 3.330000000000000 + 1139 2 4 -0.42000 19.521000000000001 27.550000145190559 3.330000000000000 + 1140 2 3 0.42000 20.244000000000000 28.802272879062858 3.330000000000000 + 1141 2 4 -0.42000 21.690000000000001 28.802272879062858 3.330000000000000 + 1142 2 3 0.42000 22.413000000000000 27.550000145190559 3.330000000000000 + 1143 2 4 -0.42000 23.859000000000002 27.550000145190559 3.330000000000000 + 1144 2 3 0.42000 24.582000000000001 28.802272879062858 3.330000000000000 + 1145 2 4 -0.42000 26.027999999999999 28.802272879062858 3.330000000000000 + 1146 2 3 0.42000 26.750999999999998 27.550000145190559 3.330000000000000 + 1147 2 4 -0.42000 28.196999999999999 27.550000145190559 3.330000000000000 + 1148 2 3 0.42000 28.919999999999998 28.802272879062858 3.330000000000000 + 1149 2 4 -0.42000 30.366000000000000 28.802272879062858 3.330000000000000 + 1150 2 3 0.42000 31.088999999999999 27.550000145190559 3.330000000000000 + 1151 2 4 -0.42000 32.534999999999997 27.550000145190559 3.330000000000000 + 1152 2 3 0.42000 33.258000000000003 28.802272879062858 3.330000000000000 + 1153 2 4 -0.42000 34.704000000000001 28.802272879062858 3.330000000000000 + 1154 2 3 0.42000 35.427000000000000 27.550000145190559 3.330000000000000 + 1155 2 4 -0.42000 36.872999999999998 27.550000145190559 3.330000000000000 + 1156 2 3 0.42000 37.596000000000004 28.802272879062858 3.330000000000000 + 1157 2 4 -0.42000 39.042000000000002 28.802272879062858 3.330000000000000 + 1158 2 3 0.42000 39.765000000000001 27.550000145190559 3.330000000000000 + 1159 2 4 -0.42000 41.210999999999999 27.550000145190559 3.330000000000000 + 1160 2 3 0.42000 41.934000000000005 28.802272879062858 3.330000000000000 + 1161 2 4 -0.42000 0.000000000000000 31.306818346807454 3.330000000000000 + 1162 2 3 0.42000 0.723000000000000 30.054545612935154 3.330000000000000 + 1163 2 4 -0.42000 2.169000000000000 30.054545612935154 3.330000000000000 + 1164 2 3 0.42000 2.892000000000000 31.306818346807454 3.330000000000000 + 1165 2 4 -0.42000 4.338000000000000 31.306818346807454 3.330000000000000 + 1166 2 3 0.42000 5.061000000000000 30.054545612935154 3.330000000000000 + 1167 2 4 -0.42000 6.507000000000000 30.054545612935154 3.330000000000000 + 1168 2 3 0.42000 7.230000000000000 31.306818346807454 3.330000000000000 + 1169 2 4 -0.42000 8.676000000000000 31.306818346807454 3.330000000000000 + 1170 2 3 0.42000 9.399000000000001 30.054545612935154 3.330000000000000 + 1171 2 4 -0.42000 10.845000000000001 30.054545612935154 3.330000000000000 + 1172 2 3 0.42000 11.568000000000000 31.306818346807454 3.330000000000000 + 1173 2 4 -0.42000 13.013999999999999 31.306818346807454 3.330000000000000 + 1174 2 3 0.42000 13.737000000000000 30.054545612935154 3.330000000000000 + 1175 2 4 -0.42000 15.183000000000000 30.054545612935154 3.330000000000000 + 1176 2 3 0.42000 15.905999999999999 31.306818346807454 3.330000000000000 + 1177 2 4 -0.42000 17.352000000000000 31.306818346807454 3.330000000000000 + 1178 2 3 0.42000 18.074999999999999 30.054545612935154 3.330000000000000 + 1179 2 4 -0.42000 19.521000000000001 30.054545612935154 3.330000000000000 + 1180 2 3 0.42000 20.244000000000000 31.306818346807454 3.330000000000000 + 1181 2 4 -0.42000 21.690000000000001 31.306818346807454 3.330000000000000 + 1182 2 3 0.42000 22.413000000000000 30.054545612935154 3.330000000000000 + 1183 2 4 -0.42000 23.859000000000002 30.054545612935154 3.330000000000000 + 1184 2 3 0.42000 24.582000000000001 31.306818346807454 3.330000000000000 + 1185 2 4 -0.42000 26.027999999999999 31.306818346807454 3.330000000000000 + 1186 2 3 0.42000 26.750999999999998 30.054545612935154 3.330000000000000 + 1187 2 4 -0.42000 28.196999999999999 30.054545612935154 3.330000000000000 + 1188 2 3 0.42000 28.919999999999998 31.306818346807454 3.330000000000000 + 1189 2 4 -0.42000 30.366000000000000 31.306818346807454 3.330000000000000 + 1190 2 3 0.42000 31.088999999999999 30.054545612935154 3.330000000000000 + 1191 2 4 -0.42000 32.534999999999997 30.054545612935154 3.330000000000000 + 1192 2 3 0.42000 33.258000000000003 31.306818346807454 3.330000000000000 + 1193 2 4 -0.42000 34.704000000000001 31.306818346807454 3.330000000000000 + 1194 2 3 0.42000 35.427000000000000 30.054545612935154 3.330000000000000 + 1195 2 4 -0.42000 36.872999999999998 30.054545612935154 3.330000000000000 + 1196 2 3 0.42000 37.596000000000004 31.306818346807454 3.330000000000000 + 1197 2 4 -0.42000 39.042000000000002 31.306818346807454 3.330000000000000 + 1198 2 3 0.42000 39.765000000000001 30.054545612935154 3.330000000000000 + 1199 2 4 -0.42000 41.210999999999999 30.054545612935154 3.330000000000000 + 1200 2 3 0.42000 41.934000000000005 31.306818346807454 3.330000000000000 + 1201 2 4 -0.42000 0.000000000000000 33.811363814552045 3.330000000000000 + 1202 2 3 0.42000 0.723000000000000 32.559091080679750 3.330000000000000 + 1203 2 4 -0.42000 2.169000000000000 32.559091080679750 3.330000000000000 + 1204 2 3 0.42000 2.892000000000000 33.811363814552045 3.330000000000000 + 1205 2 4 -0.42000 4.338000000000000 33.811363814552045 3.330000000000000 + 1206 2 3 0.42000 5.061000000000000 32.559091080679750 3.330000000000000 + 1207 2 4 -0.42000 6.507000000000000 32.559091080679750 3.330000000000000 + 1208 2 3 0.42000 7.230000000000000 33.811363814552045 3.330000000000000 + 1209 2 4 -0.42000 8.676000000000000 33.811363814552045 3.330000000000000 + 1210 2 3 0.42000 9.399000000000001 32.559091080679750 3.330000000000000 + 1211 2 4 -0.42000 10.845000000000001 32.559091080679750 3.330000000000000 + 1212 2 3 0.42000 11.568000000000000 33.811363814552045 3.330000000000000 + 1213 2 4 -0.42000 13.013999999999999 33.811363814552045 3.330000000000000 + 1214 2 3 0.42000 13.737000000000000 32.559091080679750 3.330000000000000 + 1215 2 4 -0.42000 15.183000000000000 32.559091080679750 3.330000000000000 + 1216 2 3 0.42000 15.905999999999999 33.811363814552045 3.330000000000000 + 1217 2 4 -0.42000 17.352000000000000 33.811363814552045 3.330000000000000 + 1218 2 3 0.42000 18.074999999999999 32.559091080679750 3.330000000000000 + 1219 2 4 -0.42000 19.521000000000001 32.559091080679750 3.330000000000000 + 1220 2 3 0.42000 20.244000000000000 33.811363814552045 3.330000000000000 + 1221 2 4 -0.42000 21.690000000000001 33.811363814552045 3.330000000000000 + 1222 2 3 0.42000 22.413000000000000 32.559091080679750 3.330000000000000 + 1223 2 4 -0.42000 23.859000000000002 32.559091080679750 3.330000000000000 + 1224 2 3 0.42000 24.582000000000001 33.811363814552045 3.330000000000000 + 1225 2 4 -0.42000 26.027999999999999 33.811363814552045 3.330000000000000 + 1226 2 3 0.42000 26.750999999999998 32.559091080679750 3.330000000000000 + 1227 2 4 -0.42000 28.196999999999999 32.559091080679750 3.330000000000000 + 1228 2 3 0.42000 28.919999999999998 33.811363814552045 3.330000000000000 + 1229 2 4 -0.42000 30.366000000000000 33.811363814552045 3.330000000000000 + 1230 2 3 0.42000 31.088999999999999 32.559091080679750 3.330000000000000 + 1231 2 4 -0.42000 32.534999999999997 32.559091080679750 3.330000000000000 + 1232 2 3 0.42000 33.258000000000003 33.811363814552045 3.330000000000000 + 1233 2 4 -0.42000 34.704000000000001 33.811363814552045 3.330000000000000 + 1234 2 3 0.42000 35.427000000000000 32.559091080679750 3.330000000000000 + 1235 2 4 -0.42000 36.872999999999998 32.559091080679750 3.330000000000000 + 1236 2 3 0.42000 37.596000000000004 33.811363814552045 3.330000000000000 + 1237 2 4 -0.42000 39.042000000000002 33.811363814552045 3.330000000000000 + 1238 2 3 0.42000 39.765000000000001 32.559091080679750 3.330000000000000 + 1239 2 4 -0.42000 41.210999999999999 32.559091080679750 3.330000000000000 + 1240 2 3 0.42000 41.934000000000005 33.811363814552045 3.330000000000000 + 1241 2 4 -0.42000 0.000000000000000 36.315909282296644 3.330000000000000 + 1242 2 3 0.42000 0.723000000000000 35.063636548424348 3.330000000000000 + 1243 2 4 -0.42000 2.169000000000000 35.063636548424348 3.330000000000000 + 1244 2 3 0.42000 2.892000000000000 36.315909282296644 3.330000000000000 + 1245 2 4 -0.42000 4.338000000000000 36.315909282296644 3.330000000000000 + 1246 2 3 0.42000 5.061000000000000 35.063636548424348 3.330000000000000 + 1247 2 4 -0.42000 6.507000000000000 35.063636548424348 3.330000000000000 + 1248 2 3 0.42000 7.230000000000000 36.315909282296644 3.330000000000000 + 1249 2 4 -0.42000 8.676000000000000 36.315909282296644 3.330000000000000 + 1250 2 3 0.42000 9.399000000000001 35.063636548424348 3.330000000000000 + 1251 2 4 -0.42000 10.845000000000001 35.063636548424348 3.330000000000000 + 1252 2 3 0.42000 11.568000000000000 36.315909282296644 3.330000000000000 + 1253 2 4 -0.42000 13.013999999999999 36.315909282296644 3.330000000000000 + 1254 2 3 0.42000 13.737000000000000 35.063636548424348 3.330000000000000 + 1255 2 4 -0.42000 15.183000000000000 35.063636548424348 3.330000000000000 + 1256 2 3 0.42000 15.905999999999999 36.315909282296644 3.330000000000000 + 1257 2 4 -0.42000 17.352000000000000 36.315909282296644 3.330000000000000 + 1258 2 3 0.42000 18.074999999999999 35.063636548424348 3.330000000000000 + 1259 2 4 -0.42000 19.521000000000001 35.063636548424348 3.330000000000000 + 1260 2 3 0.42000 20.244000000000000 36.315909282296644 3.330000000000000 + 1261 2 4 -0.42000 21.690000000000001 36.315909282296644 3.330000000000000 + 1262 2 3 0.42000 22.413000000000000 35.063636548424348 3.330000000000000 + 1263 2 4 -0.42000 23.859000000000002 35.063636548424348 3.330000000000000 + 1264 2 3 0.42000 24.582000000000001 36.315909282296644 3.330000000000000 + 1265 2 4 -0.42000 26.027999999999999 36.315909282296644 3.330000000000000 + 1266 2 3 0.42000 26.750999999999998 35.063636548424348 3.330000000000000 + 1267 2 4 -0.42000 28.196999999999999 35.063636548424348 3.330000000000000 + 1268 2 3 0.42000 28.919999999999998 36.315909282296644 3.330000000000000 + 1269 2 4 -0.42000 30.366000000000000 36.315909282296644 3.330000000000000 + 1270 2 3 0.42000 31.088999999999999 35.063636548424348 3.330000000000000 + 1271 2 4 -0.42000 32.534999999999997 35.063636548424348 3.330000000000000 + 1272 2 3 0.42000 33.258000000000003 36.315909282296644 3.330000000000000 + 1273 2 4 -0.42000 34.704000000000001 36.315909282296644 3.330000000000000 + 1274 2 3 0.42000 35.427000000000000 35.063636548424348 3.330000000000000 + 1275 2 4 -0.42000 36.872999999999998 35.063636548424348 3.330000000000000 + 1276 2 3 0.42000 37.596000000000004 36.315909282296644 3.330000000000000 + 1277 2 4 -0.42000 39.042000000000002 36.315909282296644 3.330000000000000 + 1278 2 3 0.42000 39.765000000000001 35.063636548424348 3.330000000000000 + 1279 2 4 -0.42000 41.210999999999999 35.063636548424348 3.330000000000000 + 1280 2 3 0.42000 41.934000000000005 36.315909282296644 3.330000000000000 + 1281 2 4 -0.42000 0.000000000000000 38.820454750041236 3.330000000000000 + 1282 2 3 0.42000 0.723000000000000 37.568182016168940 3.330000000000000 + 1283 2 4 -0.42000 2.169000000000000 37.568182016168940 3.330000000000000 + 1284 2 3 0.42000 2.892000000000000 38.820454750041236 3.330000000000000 + 1285 2 4 -0.42000 4.338000000000000 38.820454750041236 3.330000000000000 + 1286 2 3 0.42000 5.061000000000000 37.568182016168940 3.330000000000000 + 1287 2 4 -0.42000 6.507000000000000 37.568182016168940 3.330000000000000 + 1288 2 3 0.42000 7.230000000000000 38.820454750041236 3.330000000000000 + 1289 2 4 -0.42000 8.676000000000000 38.820454750041236 3.330000000000000 + 1290 2 3 0.42000 9.399000000000001 37.568182016168940 3.330000000000000 + 1291 2 4 -0.42000 10.845000000000001 37.568182016168940 3.330000000000000 + 1292 2 3 0.42000 11.568000000000000 38.820454750041236 3.330000000000000 + 1293 2 4 -0.42000 13.013999999999999 38.820454750041236 3.330000000000000 + 1294 2 3 0.42000 13.737000000000000 37.568182016168940 3.330000000000000 + 1295 2 4 -0.42000 15.183000000000000 37.568182016168940 3.330000000000000 + 1296 2 3 0.42000 15.905999999999999 38.820454750041236 3.330000000000000 + 1297 2 4 -0.42000 17.352000000000000 38.820454750041236 3.330000000000000 + 1298 2 3 0.42000 18.074999999999999 37.568182016168940 3.330000000000000 + 1299 2 4 -0.42000 19.521000000000001 37.568182016168940 3.330000000000000 + 1300 2 3 0.42000 20.244000000000000 38.820454750041236 3.330000000000000 + 1301 2 4 -0.42000 21.690000000000001 38.820454750041236 3.330000000000000 + 1302 2 3 0.42000 22.413000000000000 37.568182016168940 3.330000000000000 + 1303 2 4 -0.42000 23.859000000000002 37.568182016168940 3.330000000000000 + 1304 2 3 0.42000 24.582000000000001 38.820454750041236 3.330000000000000 + 1305 2 4 -0.42000 26.027999999999999 38.820454750041236 3.330000000000000 + 1306 2 3 0.42000 26.750999999999998 37.568182016168940 3.330000000000000 + 1307 2 4 -0.42000 28.196999999999999 37.568182016168940 3.330000000000000 + 1308 2 3 0.42000 28.919999999999998 38.820454750041236 3.330000000000000 + 1309 2 4 -0.42000 30.366000000000000 38.820454750041236 3.330000000000000 + 1310 2 3 0.42000 31.088999999999999 37.568182016168940 3.330000000000000 + 1311 2 4 -0.42000 32.534999999999997 37.568182016168940 3.330000000000000 + 1312 2 3 0.42000 33.258000000000003 38.820454750041236 3.330000000000000 + 1313 2 4 -0.42000 34.704000000000001 38.820454750041236 3.330000000000000 + 1314 2 3 0.42000 35.427000000000000 37.568182016168940 3.330000000000000 + 1315 2 4 -0.42000 36.872999999999998 37.568182016168940 3.330000000000000 + 1316 2 3 0.42000 37.596000000000004 38.820454750041236 3.330000000000000 + 1317 2 4 -0.42000 39.042000000000002 38.820454750041236 3.330000000000000 + 1318 2 3 0.42000 39.765000000000001 37.568182016168940 3.330000000000000 + 1319 2 4 -0.42000 41.210999999999999 37.568182016168940 3.330000000000000 + 1320 2 3 0.42000 41.934000000000005 38.820454750041236 3.330000000000000 + 1321 2 4 -0.42000 0.000000000000000 41.325000217785835 3.330000000000000 + 1322 2 3 0.42000 0.723000000000000 40.072727483913539 3.330000000000000 + 1323 2 4 -0.42000 2.169000000000000 40.072727483913539 3.330000000000000 + 1324 2 3 0.42000 2.892000000000000 41.325000217785835 3.330000000000000 + 1325 2 4 -0.42000 4.338000000000000 41.325000217785835 3.330000000000000 + 1326 2 3 0.42000 5.061000000000000 40.072727483913539 3.330000000000000 + 1327 2 4 -0.42000 6.507000000000000 40.072727483913539 3.330000000000000 + 1328 2 3 0.42000 7.230000000000000 41.325000217785835 3.330000000000000 + 1329 2 4 -0.42000 8.676000000000000 41.325000217785835 3.330000000000000 + 1330 2 3 0.42000 9.399000000000001 40.072727483913539 3.330000000000000 + 1331 2 4 -0.42000 10.845000000000001 40.072727483913539 3.330000000000000 + 1332 2 3 0.42000 11.568000000000000 41.325000217785835 3.330000000000000 + 1333 2 4 -0.42000 13.013999999999999 41.325000217785835 3.330000000000000 + 1334 2 3 0.42000 13.737000000000000 40.072727483913539 3.330000000000000 + 1335 2 4 -0.42000 15.183000000000000 40.072727483913539 3.330000000000000 + 1336 2 3 0.42000 15.905999999999999 41.325000217785835 3.330000000000000 + 1337 2 4 -0.42000 17.352000000000000 41.325000217785835 3.330000000000000 + 1338 2 3 0.42000 18.074999999999999 40.072727483913539 3.330000000000000 + 1339 2 4 -0.42000 19.521000000000001 40.072727483913539 3.330000000000000 + 1340 2 3 0.42000 20.244000000000000 41.325000217785835 3.330000000000000 + 1341 2 4 -0.42000 21.690000000000001 41.325000217785835 3.330000000000000 + 1342 2 3 0.42000 22.413000000000000 40.072727483913539 3.330000000000000 + 1343 2 4 -0.42000 23.859000000000002 40.072727483913539 3.330000000000000 + 1344 2 3 0.42000 24.582000000000001 41.325000217785835 3.330000000000000 + 1345 2 4 -0.42000 26.027999999999999 41.325000217785835 3.330000000000000 + 1346 2 3 0.42000 26.750999999999998 40.072727483913539 3.330000000000000 + 1347 2 4 -0.42000 28.196999999999999 40.072727483913539 3.330000000000000 + 1348 2 3 0.42000 28.919999999999998 41.325000217785835 3.330000000000000 + 1349 2 4 -0.42000 30.366000000000000 41.325000217785835 3.330000000000000 + 1350 2 3 0.42000 31.088999999999999 40.072727483913539 3.330000000000000 + 1351 2 4 -0.42000 32.534999999999997 40.072727483913539 3.330000000000000 + 1352 2 3 0.42000 33.258000000000003 41.325000217785835 3.330000000000000 + 1353 2 4 -0.42000 34.704000000000001 41.325000217785835 3.330000000000000 + 1354 2 3 0.42000 35.427000000000000 40.072727483913539 3.330000000000000 + 1355 2 4 -0.42000 36.872999999999998 40.072727483913539 3.330000000000000 + 1356 2 3 0.42000 37.596000000000004 41.325000217785835 3.330000000000000 + 1357 2 4 -0.42000 39.042000000000002 41.325000217785835 3.330000000000000 + 1358 2 3 0.42000 39.765000000000001 40.072727483913539 3.330000000000000 + 1359 2 4 -0.42000 41.210999999999999 40.072727483913539 3.330000000000000 + 1360 2 3 0.42000 41.934000000000005 41.325000217785835 3.330000000000000 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/in.bilayer-hBN b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/in.bilayer-hBN new file mode 100644 index 0000000000..0e02104d59 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/in.bilayer-hBN @@ -0,0 +1,57 @@ +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer +# interactions can be specified separately +read_data hBN_AA_prime_stack_2L_noH.data +mass 1 10.8110 # boron mass (g/mole) | membrane +mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate +mass 3 10.8110 # boron mass (g/mole) | membrane +mass 4 14.0067 # nitrogen mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +group layer2 molecule 2 + +######################## Potential defition ######################## +pair_style hybrid/overlay tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 1 +#################################################################### +pair_coeff * * tersoff BNC.tersoff B N B N # chemical +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N B N # long range +pair_coeff 1 3 coul/shield 0.70 +pair_coeff 1 4 coul/shield 0.69498201415576216335 +pair_coeff 2 3 coul/shield 0.69498201415576216335 +pair_coeff 2 4 coul/shield 0.69 +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 dist gaussian mom yes rot yes +fix thermostat all nve + +compute 0 all pair tersoff +compute 1 all pair coul/shield ecoul +compute 2 all pair ilp/graphene/hbn +variable Tersoff equal c_0 # Tersoff energy +variable Ecoul equal c_1 # Coulomb energy +variable EILP equal c_2 # total interlayer energy +variable Evdw equal c_2[1] # attractive energy +variable Erep equal c_2[2] # repulsive energy + +############# Output ############### +thermo 100 +thermo_style custom step cpu etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify line one format float %.10f +thermo_modify flush yes norm no lost error + +###### Run molecular dynamics ###### +run 1000 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 new file mode 100644 index 0000000000..abebb8df27 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 @@ -0,0 +1,144 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer +# interactions can be specified separately +read_data hBN_AA_prime_stack_2L_noH.data + orthogonal box = (0 0 0) to (43.38 42.5773 100) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000162885 secs + read_data CPU = 0.00152144 secs +mass 1 10.8110 # boron mass (g/mole) | membrane +mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate +mass 3 10.8110 # boron mass (g/mole) | membrane +mass 4 14.0067 # nitrogen mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 1 +#################################################################### +pair_coeff * * tersoff BNC.tersoff B N B N # chemical +Reading potential file BNC.tersoff with DATE: 2013-03-21 +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N B N # long range +pair_coeff 1 3 coul/shield 0.70 +pair_coeff 1 4 coul/shield 0.69498201415576216335 +pair_coeff 2 3 coul/shield 0.69498201415576216335 +pair_coeff 2 4 coul/shield 0.69 +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 dist gaussian mom yes rot yes +fix thermostat all nve + +compute 0 all pair tersoff +compute 1 all pair coul/shield ecoul +compute 2 all pair ilp/graphene/hbn +variable Tersoff equal c_0 # Tersoff energy +variable Ecoul equal c_1 # Coulomb energy +variable EILP equal c_2 # total interlayer energy +variable Evdw equal c_2[1] # attractive energy +variable Erep equal c_2[2] # repulsive energy + +############# Output ############### +thermo 100 +thermo_style custom step cpu etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify line one format float %.10f +thermo_modify flush yes norm no lost error + +###### Run molecular dynamics ###### +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 4 neighbor lists, perpetual/occasional/extra = 4 0 0 + (1) pair tersoff, perpetual + attributes: full, newton on + pair build: full/bin + stencil: full/bin/3d + bin: standard + (2) pair ilp/graphene/hbn, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (3) pair coul/shield, perpetual, skip from (4) + attributes: half, newton on + pair build: skip + stencil: none + bin: none + (4) neighbor class addition, perpetual, half/full from (1) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 39.16 | 39.16 | 39.16 Mbytes +Step CPU TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul Temp + 0 0.0000000000 -10193.1380848266 -10245.8374459431 52.6993611165 -77.5570687695 -10208.7302118650 -36.7764829084 40.7805858612 -77.5570687695 -0.3307511697 300.0000000000 + 100 6.7965245070 -10192.8138221665 -10215.1933919318 22.3795697653 -80.9976194405 -10177.8775571602 -36.9677356248 44.0298838157 -80.9976194405 -0.3480991468 127.3994748197 + 200 13.6121753111 -10192.9217984546 -10221.8066529747 28.8848545200 -86.3703194681 -10184.2512197444 -37.1689855905 49.2013338776 -86.3703194681 -0.3864476398 164.4319052911 + 300 20.4697002331 -10192.8780091121 -10219.0294731325 26.1514640204 -83.0639240055 -10182.3487520151 -36.3041195435 46.7598044620 -83.0639240055 -0.3766015739 148.8716189324 + 400 27.2477328760 -10192.8915023008 -10218.8337311224 25.9422288216 -78.3942416895 -10181.3978178066 -37.1109676261 41.2832740634 -78.3942416895 -0.3249456897 147.6805122794 + 500 34.0398510781 -10192.9091924320 -10221.3314056924 28.4222132604 -81.7685306349 -10184.0302799036 -36.9462261394 44.8223044955 -81.7685306349 -0.3548996493 161.7982419039 + 600 40.8147194131 -10192.8859685989 -10219.3709182378 26.4849496389 -86.2783346104 -10182.6694059460 -36.2951497597 49.9831848507 -86.2783346104 -0.4063625321 150.7700420526 + 700 47.6096971680 -10192.9015812429 -10220.9496893393 28.0481080963 -82.2887300963 -10183.2081700333 -37.3937397296 44.8949903667 -82.2887300963 -0.3477795764 159.6685851711 + 800 54.4165411390 -10192.8798040842 -10218.5099898620 25.6301857778 -78.0110194568 -10181.4267315419 -36.7542088970 41.2568105599 -78.0110194568 -0.3290494232 145.9041546318 + 900 61.2580328170 -10192.8940657565 -10220.5595028458 27.6654370893 -82.4743793723 -10183.8013123118 -36.3811572492 46.0932221231 -82.4743793723 -0.3770332848 157.4901659330 + 1000 68.0452993071 -10192.8973362869 -10219.0104657947 26.1131295079 -87.1256831340 -10181.2524878789 -37.3618984004 49.7637847337 -87.1256831340 -0.3960795154 148.6533932553 +Loop time of 68.0453 on 1 procs for 1000 steps with 1360 atoms + +Performance: 1.270 ns/day, 18.901 hours/ns, 14.696 timesteps/s +100.0% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 67.995 | 67.995 | 67.995 | 0.0 | 99.93 +Bond | 0.00047219 | 0.00047219 | 0.00047219 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.030427 | 0.030427 | 0.030427 | 0.0 | 0.04 +Output | 0.000568 | 0.000568 | 0.000568 | 0.0 | 0.00 +Modify | 0.0089312 | 0.0089312 | 0.0089312 | 0.0 | 0.01 +Other | | 0.01005 | | | 0.01 + +Nlocal: 1360 ave 1360 max 1360 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7836 ave 7836 max 7836 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 249560 ave 249560 max 249560 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 1.00504e+06 ave 1.00504e+06 max 1.00504e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1005040 +Ave neighs/atom = 739 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:01:08 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 new file mode 100644 index 0000000000..8ad5875282 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 @@ -0,0 +1,144 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer +# interactions can be specified separately +read_data hBN_AA_prime_stack_2L_noH.data + orthogonal box = (0 0 0) to (43.38 42.5773 100) + 2 by 2 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.00013403 secs + read_data CPU = 0.00236647 secs +mass 1 10.8110 # boron mass (g/mole) | membrane +mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate +mass 3 10.8110 # boron mass (g/mole) | membrane +mass 4 14.0067 # nitrogen mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 1 +#################################################################### +pair_coeff * * tersoff BNC.tersoff B N B N # chemical +Reading potential file BNC.tersoff with DATE: 2013-03-21 +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N B N # long range +pair_coeff 1 3 coul/shield 0.70 +pair_coeff 1 4 coul/shield 0.69498201415576216335 +pair_coeff 2 3 coul/shield 0.69498201415576216335 +pair_coeff 2 4 coul/shield 0.69 +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 dist gaussian mom yes rot yes +fix thermostat all nve + +compute 0 all pair tersoff +compute 1 all pair coul/shield ecoul +compute 2 all pair ilp/graphene/hbn +variable Tersoff equal c_0 # Tersoff energy +variable Ecoul equal c_1 # Coulomb energy +variable EILP equal c_2 # total interlayer energy +variable Evdw equal c_2[1] # attractive energy +variable Erep equal c_2[2] # repulsive energy + +############# Output ############### +thermo 100 +thermo_style custom step cpu etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify line one format float %.10f +thermo_modify flush yes norm no lost error + +###### Run molecular dynamics ###### +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 4 neighbor lists, perpetual/occasional/extra = 4 0 0 + (1) pair tersoff, perpetual + attributes: full, newton on + pair build: full/bin + stencil: full/bin/3d + bin: standard + (2) pair ilp/graphene/hbn, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (3) pair coul/shield, perpetual, skip from (4) + attributes: half, newton on + pair build: skip + stencil: none + bin: none + (4) neighbor class addition, perpetual, half/full from (1) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 20.72 | 20.72 | 20.72 Mbytes +Step CPU TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul Temp + 0 0.0000000000 -10193.1380848270 -10245.8374459435 52.6993611165 -77.5570687695 -10208.7302118654 -36.7764829083 40.7805858612 -77.5570687695 -0.3307511697 300.0000000000 + 100 2.1550989150 -10192.8138221665 -10215.1933919317 22.3795697653 -80.9976194405 -10177.8775571601 -36.9677356248 44.0298838158 -80.9976194405 -0.3480991468 127.3994748197 + 200 4.3479236889 -10192.9217984546 -10221.8066529746 28.8848545200 -86.3703194681 -10184.2512197444 -37.1689855904 49.2013338777 -86.3703194681 -0.3864476398 164.4319052911 + 300 6.5410459590 -10192.8780091121 -10219.0294731324 26.1514640204 -83.0639240055 -10182.3487520151 -36.3041195435 46.7598044620 -83.0639240055 -0.3766015739 148.8716189324 + 400 8.7036962360 -10192.8915023008 -10218.8337311224 25.9422288216 -78.3942416895 -10181.3978178066 -37.1109676261 41.2832740634 -78.3942416895 -0.3249456897 147.6805122794 + 500 10.8535934120 -10192.9091924320 -10221.3314056923 28.4222132604 -81.7685306349 -10184.0302799036 -36.9462261394 44.8223044955 -81.7685306349 -0.3548996493 161.7982419039 + 600 12.9922130840 -10192.8859685988 -10219.3709182377 26.4849496389 -86.2783346104 -10182.6694059459 -36.2951497597 49.9831848507 -86.2783346104 -0.4063625321 150.7700420526 + 700 15.1486390879 -10192.9015812430 -10220.9496893393 28.0481080963 -82.2887300963 -10183.2081700333 -37.3937397295 44.8949903668 -82.2887300963 -0.3477795764 159.6685851711 + 800 17.3069961029 -10192.8798040842 -10218.5099898620 25.6301857778 -78.0110194568 -10181.4267315419 -36.7542088969 41.2568105599 -78.0110194568 -0.3290494232 145.9041546318 + 900 19.4832645269 -10192.8940657564 -10220.5595028457 27.6654370893 -82.4743793723 -10183.8013123118 -36.3811572492 46.0932221231 -82.4743793723 -0.3770332848 157.4901659330 + 1000 21.6507079899 -10192.8973362868 -10219.0104657947 26.1131295079 -87.1256831340 -10181.2524878789 -37.3618984003 49.7637847337 -87.1256831340 -0.3960795154 148.6533932553 +Loop time of 21.6507 on 4 procs for 1000 steps with 1360 atoms + +Performance: 3.991 ns/day, 6.014 hours/ns, 46.188 timesteps/s +99.8% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 20.152 | 20.681 | 21.202 | 8.2 | 95.52 +Bond | 0.00039643 | 0.00043971 | 0.00048381 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.43171 | 0.9526 | 1.482 | 38.2 | 4.40 +Output | 0.00028839 | 0.00037988 | 0.00064771 | 0.0 | 0.00 +Modify | 0.0046368 | 0.0047831 | 0.0050183 | 0.2 | 0.02 +Other | | 0.01106 | | | 0.05 + +Nlocal: 340 ave 340 max 340 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 4536 ave 4536 max 4536 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Neighs: 62390 ave 62390 max 62390 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 251260 ave 251260 max 251260 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1005040 +Ave neighs/atom = 739 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:21 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP new file mode 120000 index 0000000000..b970e23f95 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP @@ -0,0 +1 @@ +../../../../../potentials/BNCH.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo new file mode 120000 index 0000000000..b98001a7fd --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo @@ -0,0 +1 @@ +../../../../../potentials/CH.rebo \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/in.grhBN b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/in.grhBN index bad7b17fde..1ae1704dec 100644 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/in.grhBN +++ b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/in.grhBN @@ -5,22 +5,23 @@ atom_style full processors * * 1 # domain decomposition over x and y # System and atom definition -# we use 2 atom types so that inter- and intra-layer +# we use different molecule ids for each layer +# so that inter- and intra-layer # interactions can be specified separately read_data gr_hBN_Cstack_2L_noH.data mass 1 10.8110 # boron mass (g/mole) | membrane mass 2 14.0067 # nitrogen mass (g/mole) | membrane mass 3 12.0107 # carbon mass (g/mole) | adsorbate # Separate atom groups -group membrane type 1 2 -group adsorbate type 3 +group hBN molecule 1 +group gr molecule 2 ######################## Potential defition ######################## pair_style hybrid/overlay rebo tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 #################################################################### -pair_coeff * * rebo CH.airebo NULL NULL C # chemical -pair_coeff * * tersoff BNC.tersoff B N NULL # chemical -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP B N C # long range +pair_coeff * * rebo CH.rebo NULL NULL C # chemical +pair_coeff * * tersoff BNC.tersoff B N NULL # chemical +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N C # long range pair_coeff 1 1 coul/shield 0.70 pair_coeff 1 2 coul/shield 0.69498201415576216335 pair_coeff 2 2 coul/shield 0.69 @@ -31,41 +32,26 @@ neigh_modify every 1 neigh_modify delay 0 neigh_modify check yes -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - #### Simulation settings #### -timestep 0.001 -velocity all create 300.0 12345 -fix thermostat all nve - -compute 0 all pair rebo -compute 1 all pair tersoff -compute 2 all pair ilp/graphene/hbn -compute 3 all pair coul/shield -variable REBO equal c_0 -variable Tersoff equal c_1 -variable EILP equal c_2 -variable Ecoul equal c_3 - -# Calculate the pair potential between the substrate and slider -compute sldsub adsorbate group/group membrane -variable Evdw equal c_sldsub - -############################ - -# Output +timestep 0.001 +velocity all create 300.0 12345 dist gaussian mom yes rot yes +fix thermostat all nve + +compute 0 all pair rebo +compute 1 all pair tersoff +compute 2 all pair ilp/graphene/hbn +compute 3 all pair coul/shield +variable REBO equal c_0 +variable Tersoff equal c_1 +variable EILP equal c_2 # total interlayer energy +variable Evdw equal c_2[1] # attractive energy +variable Erep equal c_2[2] # repulsive energy +variable Ecoul equal c_3 + +############# Output ############## thermo 100 -thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Ecoul temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom +thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul temp thermo_modify line one format float %.10f -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - ###### Run molecular dynamics ###### -run 1000 +run 1000 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.1 b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.1 new file mode 100644 index 0000000000..65e32502f0 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.1 @@ -0,0 +1,155 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer +# so that inter- and intra-layer +# interactions can be specified separately +read_data gr_hBN_Cstack_2L_noH.data + orthogonal box = (0 0 0) to (44.583 42.9 100) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1440 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000152684 secs + read_data CPU = 0.00139584 secs +mass 1 10.8110 # boron mass (g/mole) | membrane +mass 2 14.0067 # nitrogen mass (g/mole) | membrane +mass 3 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group hBN molecule 1 +720 atoms in group hBN +group gr molecule 2 +720 atoms in group gr + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 +#################################################################### +pair_coeff * * rebo CH.rebo NULL NULL C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * tersoff BNC.tersoff B N NULL # chemical +Reading potential file BNC.tersoff with DATE: 2013-03-21 +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N C # long range +pair_coeff 1 1 coul/shield 0.70 +pair_coeff 1 2 coul/shield 0.69498201415576216335 +pair_coeff 2 2 coul/shield 0.69 +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 dist gaussian mom yes rot yes +fix thermostat all nve + +compute 0 all pair rebo +compute 1 all pair tersoff +compute 2 all pair ilp/graphene/hbn +compute 3 all pair coul/shield +variable REBO equal c_0 +variable Tersoff equal c_1 +variable EILP equal c_2 # total interlayer energy +variable Evdw equal c_2[1] # attractive energy +variable Erep equal c_2[2] # repulsive energy +variable Ecoul equal c_3 + +############# Output ############## +thermo 100 +thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify line one format float %.10f + +###### Run molecular dynamics ###### +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair rebo, perpetual, skip from (3) + attributes: full, newton on, ghost + pair build: skip/ghost + stencil: none + bin: none + (2) pair tersoff, perpetual, skip from (5) + attributes: full, newton on + pair build: skip + stencil: none + bin: none + (3) pair ilp/graphene/hbn, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (4) pair coul/shield, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton/skip + stencil: none + bin: none + (5) neighbor class addition, perpetual, copy from (3) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (6) neighbor class addition, perpetual, half/full from (5) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 25.93 | 25.93 | 25.93 Mbytes +Step TotEng PotEng KinEng v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul Temp + 0 -10707.2836653377 -10763.0852699342 55.8016045965 -75.2477261362 -5401.7347845703 -5322.2780768034 -39.0724085605 36.1753175757 -75.2477261362 0.0000000000 300.0000000000 + 100 -10707.0738132278 -10737.1273434298 30.0535302020 -73.2173218622 -5389.9568321958 -5309.2004092412 -37.9701019928 35.2472198694 -73.2173218622 0.0000000000 161.5734731251 + 200 -10707.0160305531 -10734.9317906949 27.9157601418 -71.6030968581 -5389.1293717071 -5307.7455440517 -38.0568749361 33.5462219220 -71.6030968581 0.0000000000 150.0804162013 + 300 -10707.0133459577 -10734.9870508108 27.9737048532 -75.0821335395 -5388.9196081501 -5308.1164952096 -37.9509474511 37.1311860884 -75.0821335395 0.0000000000 150.3919379493 + 400 -10707.0118845924 -10735.4980560195 28.4861714271 -76.3398711857 -5389.1656629670 -5308.1529507210 -38.1794423315 38.1604288542 -76.3398711857 0.0000000000 153.1470553564 + 500 -10707.0073064907 -10734.6814074933 27.6741010026 -73.3123544614 -5388.7261058688 -5307.7383573628 -38.2169442617 35.0954101998 -73.3123544614 0.0000000000 148.7812108775 + 600 -10707.0179599067 -10735.8330915547 28.8151316481 -71.9277634955 -5389.0797599186 -5308.5959984739 -38.1573331622 33.7704303333 -71.9277634955 0.0000000000 154.9156078382 + 700 -10707.0202991119 -10735.6556762202 28.6353771083 -74.6793707186 -5389.2970704981 -5308.1866033124 -38.1720024097 36.5073683089 -74.6793707186 0.0000000000 153.9492133711 + 800 -10707.0042706783 -10734.3516957279 27.3474250495 -76.3712879764 -5388.5923210533 -5307.7206382682 -38.0387364064 38.3325515700 -76.3712879764 0.0000000000 147.0249390530 + 900 -10707.0144790011 -10735.8318835748 28.8174045738 -73.6993318112 -5388.9674133804 -5308.7963924816 -38.0680777128 35.6312540984 -73.6993318112 0.0000000000 154.9278275177 + 1000 -10706.9953891527 -10733.5615396283 26.5661504756 -71.4398677888 -5388.0186485439 -5307.4414386685 -38.1014524159 33.3384153730 -71.4398677888 0.0000000000 142.8246589021 +Loop time of 55.1175 on 1 procs for 1000 steps with 1440 atoms + +Performance: 1.568 ns/day, 15.310 hours/ns, 18.143 timesteps/s +100.0% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 55.062 | 55.062 | 55.062 | 0.0 | 99.90 +Bond | 0.00046717 | 0.00046717 | 0.00046717 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.034313 | 0.034313 | 0.034313 | 0.0 | 0.06 +Output | 0.00034028 | 0.00034028 | 0.00034028 | 0.0 | 0.00 +Modify | 0.010012 | 0.010012 | 0.010012 | 0.0 | 0.02 +Other | | 0.01061 | | | 0.02 + +Nlocal: 1440 ave 1440 max 1440 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 8180 ave 8180 max 8180 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 140400 ave 140400 max 140400 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 280800 ave 280800 max 280800 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 280800 +Ave neighs/atom = 195 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:55 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.4 b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.4 new file mode 100644 index 0000000000..9ea23fb6e3 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.4 @@ -0,0 +1,155 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer +# so that inter- and intra-layer +# interactions can be specified separately +read_data gr_hBN_Cstack_2L_noH.data + orthogonal box = (0 0 0) to (44.583 42.9 100) + 2 by 2 by 1 MPI processor grid + reading atoms ... + 1440 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000148868 secs + read_data CPU = 0.00332732 secs +mass 1 10.8110 # boron mass (g/mole) | membrane +mass 2 14.0067 # nitrogen mass (g/mole) | membrane +mass 3 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group hBN molecule 1 +720 atoms in group hBN +group gr molecule 2 +720 atoms in group gr + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 +#################################################################### +pair_coeff * * rebo CH.rebo NULL NULL C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * tersoff BNC.tersoff B N NULL # chemical +Reading potential file BNC.tersoff with DATE: 2013-03-21 +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N C # long range +pair_coeff 1 1 coul/shield 0.70 +pair_coeff 1 2 coul/shield 0.69498201415576216335 +pair_coeff 2 2 coul/shield 0.69 +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 dist gaussian mom yes rot yes +fix thermostat all nve + +compute 0 all pair rebo +compute 1 all pair tersoff +compute 2 all pair ilp/graphene/hbn +compute 3 all pair coul/shield +variable REBO equal c_0 +variable Tersoff equal c_1 +variable EILP equal c_2 # total interlayer energy +variable Evdw equal c_2[1] # attractive energy +variable Erep equal c_2[2] # repulsive energy +variable Ecoul equal c_3 + +############# Output ############## +thermo 100 +thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify line one format float %.10f + +###### Run molecular dynamics ###### +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair rebo, perpetual, skip from (3) + attributes: full, newton on, ghost + pair build: skip/ghost + stencil: none + bin: none + (2) pair tersoff, perpetual, skip from (5) + attributes: full, newton on + pair build: skip + stencil: none + bin: none + (3) pair ilp/graphene/hbn, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (4) pair coul/shield, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton/skip + stencil: none + bin: none + (5) neighbor class addition, perpetual, copy from (3) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (6) neighbor class addition, perpetual, half/full from (5) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 14.25 | 14.25 | 14.25 Mbytes +Step TotEng PotEng KinEng v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul Temp + 0 -10707.2836653376 -10763.0852699341 55.8016045965 -75.2477261361 -5401.7347845703 -5322.2780768034 -39.0724085604 36.1753175757 -75.2477261361 0.0000000000 300.0000000000 + 100 -10707.0738132277 -10737.1273434298 30.0535302020 -73.2173218622 -5389.9568321958 -5309.2004092412 -37.9701019928 35.2472198694 -73.2173218622 0.0000000000 161.5734731251 + 200 -10707.0160305531 -10734.9317906949 27.9157601418 -71.6030968581 -5389.1293717071 -5307.7455440517 -38.0568749361 33.5462219220 -71.6030968581 0.0000000000 150.0804162013 + 300 -10707.0133459576 -10734.9870508108 27.9737048532 -75.0821335395 -5388.9196081501 -5308.1164952096 -37.9509474511 37.1311860885 -75.0821335395 0.0000000000 150.3919379493 + 400 -10707.0118845923 -10735.4980560194 28.4861714271 -76.3398711857 -5389.1656629669 -5308.1529507210 -38.1794423315 38.1604288542 -76.3398711857 0.0000000000 153.1470553564 + 500 -10707.0073064907 -10734.6814074932 27.6741010026 -73.3123544614 -5388.7261058688 -5307.7383573628 -38.2169442616 35.0954101998 -73.3123544614 0.0000000000 148.7812108775 + 600 -10707.0179599066 -10735.8330915547 28.8151316481 -71.9277634955 -5389.0797599186 -5308.5959984739 -38.1573331622 33.7704303333 -71.9277634955 0.0000000000 154.9156078382 + 700 -10707.0202991119 -10735.6556762202 28.6353771083 -74.6793707186 -5389.2970704981 -5308.1866033124 -38.1720024097 36.5073683089 -74.6793707186 0.0000000000 153.9492133711 + 800 -10707.0042706783 -10734.3516957278 27.3474250495 -76.3712879764 -5388.5923210533 -5307.7206382682 -38.0387364063 38.3325515701 -76.3712879764 0.0000000000 147.0249390530 + 900 -10707.0144790010 -10735.8318835748 28.8174045738 -73.6993318112 -5388.9674133804 -5308.7963924816 -38.0680777128 35.6312540984 -73.6993318112 0.0000000000 154.9278275177 + 1000 -10706.9953891527 -10733.5615396283 26.5661504756 -71.4398677888 -5388.0186485439 -5307.4414386685 -38.1014524158 33.3384153730 -71.4398677888 0.0000000000 142.8246589021 +Loop time of 15.7325 on 4 procs for 1000 steps with 1440 atoms + +Performance: 5.492 ns/day, 4.370 hours/ns, 63.563 timesteps/s +99.8% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 13.905 | 14.645 | 15.391 | 14.5 | 93.08 +Bond | 0.00029796 | 0.00040495 | 0.00046212 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.3261 | 1.0722 | 1.8116 | 53.4 | 6.82 +Output | 0.00028242 | 0.00030932 | 0.00037515 | 0.0 | 0.00 +Modify | 0.0046079 | 0.0047365 | 0.0048651 | 0.2 | 0.03 +Other | | 0.01031 | | | 0.07 + +Nlocal: 360 ave 380 max 340 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 4716 ave 4736 max 4696 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 35100 ave 37050 max 33150 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +FullNghs: 70200 ave 74100 max 66300 min +Histogram: 2 0 0 0 0 0 0 0 0 2 + +Total # of neighbors = 280800 +Ave neighs/atom = 195 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:15 diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.cpp b/src/USER-MISC/pair_ilp_graphene_hbn.cpp index b94db6a871..a050f1f613 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.cpp +++ b/src/USER-MISC/pair_ilp_graphene_hbn.cpp @@ -20,11 +20,12 @@ [Kolmogorov & Crespi, Phys. Rev. B 71, 235415 (2005)] ------------------------------------------------------------------------- */ -#include "pair_ilp_graphene_hbn.h" #include #include +#include #include #include +#include "pair_ilp_graphene_hbn.h" #include "atom.h" #include "comm.h" #include "force.h" @@ -48,6 +49,9 @@ PairILPGrapheneHBN::PairILPGrapheneHBN(LAMMPS *lmp) : Pair(lmp) restartinfo = 0; one_coeff = 1; + nextra = 2; + pvector = new double[nextra]; + // initialize element to parameter maps nelements = 0; elements = NULL; @@ -70,9 +74,7 @@ PairILPGrapheneHBN::PairILPGrapheneHBN(LAMMPS *lmp) : Pair(lmp) // always compute energy offset offset_flag = 1; - - // set comm size needed by this pair style - comm_forward = 39; + // turn on the taper function tap_flag = 1; } @@ -83,6 +85,7 @@ PairILPGrapheneHBN::~PairILPGrapheneHBN() memory->destroy(ILP_numneigh); memory->sfree(ILP_firstneigh); delete [] ipage; + delete [] pvector; memory->destroy(normal); memory->destroy(dnormal); memory->destroy(dnormdri); @@ -103,928 +106,991 @@ PairILPGrapheneHBN::~PairILPGrapheneHBN() if (allocated) delete [] map; } -/* ---------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + allocate all arrays +------------------------------------------------------------------------- */ -void PairILPGrapheneHBN::compute(int eflag, int vflag) +void PairILPGrapheneHBN::allocate() { - int i,j,ii,jj,inum,jnum,itype,jtype,k,l,kk,ll; - tagint itag,jtag; - double prodnorm1,prodnorm2,fkcx,fkcy,fkcz; - double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair,fpair1,fpair2; - double rsq,r,Rcut,rhosq1,rhosq2,exp0,exp1,exp2,r2inv,r6inv,r8inv,Tap,dTap,Vilp; - double frho1,frho2,TSvdw,TSvdw2inv,Erep,fsum,rdsq1,rdsq2; - int *ilist,*jlist,*numneigh,**firstneigh; - int *ILP_neighs_i,*ILP_neighs_j; + allocated = 1; + int n = atom->ntypes; - evdwl = 0.0; - ev_init(eflag,vflag); + memory->create(setflag,n+1,n+1,"pair:setflag"); + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; - double **x = atom->x; - double **f = atom->f; - int *type = atom->type; - tagint *tag = atom->tag; - int nlocal = atom->nlocal; - int newton_pair = force->newton_pair; - double dprodnorm1[3] = {0.0, 0.0, 0.0}; - double dprodnorm2[3] = {0.0, 0.0, 0.0}; - double fp1[3] = {0.0, 0.0, 0.0}; - double fp2[3] = {0.0, 0.0, 0.0}; - double fprod1[3] = {0.0, 0.0, 0.0}; - double fprod2[3] = {0.0, 0.0, 0.0}; - double fk[3] = {0.0, 0.0, 0.0}; - double fl[3] = {0.0, 0.0, 0.0}; - double delkj[3] = {0.0, 0.0, 0.0}; - double delli[3] = {0.0, 0.0, 0.0}; + memory->create(cutsq,n+1,n+1,"pair:cutsq"); + memory->create(cut,n+1,n+1,"pair:cut"); + memory->create(offset,n+1,n+1,"pair:offset"); + map = new int[atom->ntypes+1]; +} - inum = list->inum; - ilist = list->ilist; - numneigh = list->numneigh; - firstneigh = list->firstneigh; - // Build full neighbor list - ILP_neigh(); - // Calculate the normals - calc_normal(); +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ - // communicate the normal vector and its derivatives - comm->forward_comm_pair(this); +void PairILPGrapheneHBN::settings(int narg, char **arg) +{ + if (narg < 1 || narg > 2) error->all(FLERR,"Illegal pair_style command"); + if (strcmp(force->pair_style,"hybrid/overlay")!=0) + error->all(FLERR,"ERROR: requires hybrid/overlay pair_style"); - // loop over neighbors of my atoms - for (ii = 0; ii < inum; ii++) { - i = ilist[ii]; - itag = tag[i]; - xtmp = x[i][0]; - ytmp = x[i][1]; - ztmp = x[i][2]; - itype = type[i]; - jlist = firstneigh[i]; - jnum = numneigh[i]; + cut_global = force->numeric(FLERR,arg[0]); + if (narg == 2) tap_flag = force->numeric(FLERR,arg[1]); - for (jj = 0; jj < jnum; jj++) { - j = jlist[jj]; - j &= NEIGHMASK; - jtype = type[j]; - jtag = tag[j]; + // reset cutoffs that have been explicitly set - // two-body interactions from full neighbor list, skip half of them - if (itag > jtag) { - if ((itag+jtag) % 2 == 0) continue; - } else if (itag < jtag) { - if ((itag+jtag) % 2 == 1) continue; - } else { - if (x[j][2] < ztmp) continue; - if (x[j][2] == ztmp && x[j][1] < ytmp) continue; - if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; - } + if (allocated) { + int i,j; + for (i = 1; i <= atom->ntypes; i++) + for (j = i; j <= atom->ntypes; j++) + if (setflag[i][j]) cut[i][j] = cut_global; + } +} - delx = xtmp - x[j][0]; - dely = ytmp - x[j][1]; - delz = ztmp - x[j][2]; - rsq = delx*delx + dely*dely + delz*delz; +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ - // only include the interation between different layers - if (rsq < cutsq[itype][jtype] && atom->molecule[i] != atom->molecule[j]) { +void PairILPGrapheneHBN::coeff(int narg, char **arg) +{ + int i,j,n; - int iparam_ij = elem2param[map[itype]][map[jtype]]; - Param& p = params[iparam_ij]; + if (narg != 3 + atom->ntypes) + error->all(FLERR,"Incorrect args for pair coefficients"); + if (!allocated) allocate(); - r = sqrt(rsq); - r2inv = 1.0/rsq; - r6inv = r2inv*r2inv*r2inv; - r8inv = r6inv*r2inv; - // turn on/off taper function - if (tap_flag) { - Rcut = sqrt(cutsq[itype][jtype]); - Tap = calc_Tap(r,Rcut); - dTap = calc_dTap(r,Rcut); - } else {Tap = 1.0; dTap = 0.0;} + // insure I,J args are * * - // Calculate the transverse distance - // note that rho_ij does not equal to rho_ji except when normals are all along z - prodnorm1 = normal[i][0]*delx + normal[i][1]*dely + normal[i][2]*delz; - prodnorm2 = normal[j][0]*delx + normal[j][1]*dely + normal[j][2]*delz; - rhosq1 = rsq - prodnorm1*prodnorm1; // rho_ij - rhosq2 = rsq - prodnorm2*prodnorm2; // rho_ji - rdsq1 = rhosq1*p.delta2inv; // (rho_ij/delta)^2 - rdsq2 = rhosq2*p.delta2inv; // (rho_ji/delta)^2 + if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) + error->all(FLERR,"Incorrect args for pair coefficients"); - // store exponents - exp0 = exp(-p.lambda*(r-p.z0)); - exp1 = exp(-rdsq1); - exp2 = exp(-rdsq2); + // read args that map atom types to elements in potential file + // map[i] = which element the Ith atom type is, -1 if NULL + // nelements = # of unique elements + // elements = list of element names - TSvdw = 1.0 + exp(-p.d*(r/p.seff - 1.0)); - TSvdw2inv = 1.0/pow(TSvdw,2.0); - frho1 = exp1*p.C; - frho2 = exp2*p.C; - Erep = p.epsilon + frho1 + frho2; - Vilp = -p.C6*r6inv/TSvdw + exp0*Erep; + if (elements) { + for (i = 0; i < nelements; i++) delete [] elements[i]; + delete [] elements; + } + elements = new char*[atom->ntypes]; + for (i = 0; i < atom->ntypes; i++) elements[i] = NULL; - // derivatives - fpair = -6.0*p.C6*r8inv/TSvdw + p.d/p.seff*p.C6*(TSvdw-1.0)*TSvdw2inv*r8inv*r + p.lambda*exp0/r*Erep; - fpair1 = 2.0*exp0*frho1*p.delta2inv; - fpair2 = 2.0*exp0*frho2*p.delta2inv; - fsum = fpair + fpair1 + fpair2; - // derivatives of the product of rij and ni, the result is a vector - dprodnorm1[0] = dnormdri[0][0][i]*delx + dnormdri[1][0][i]*dely + dnormdri[2][0][i]*delz; - dprodnorm1[1] = dnormdri[0][1][i]*delx + dnormdri[1][1][i]*dely + dnormdri[2][1][i]*delz; - dprodnorm1[2] = dnormdri[0][2][i]*delx + dnormdri[1][2][i]*dely + dnormdri[2][2][i]*delz; - // derivatives of the product of rji and nj, the result is a vector - dprodnorm2[0] = dnormdri[0][0][j]*delx + dnormdri[1][0][j]*dely + dnormdri[2][0][j]*delz; - dprodnorm2[1] = dnormdri[0][1][j]*delx + dnormdri[1][1][j]*dely + dnormdri[2][1][j]*delz; - dprodnorm2[2] = dnormdri[0][2][j]*delx + dnormdri[1][2][j]*dely + dnormdri[2][2][j]*delz; - fp1[0] = prodnorm1*normal[i][0]*fpair1; - fp1[1] = prodnorm1*normal[i][1]*fpair1; - fp1[2] = prodnorm1*normal[i][2]*fpair1; - fp2[0] = prodnorm2*normal[j][0]*fpair2; - fp2[1] = prodnorm2*normal[j][1]*fpair2; - fp2[2] = prodnorm2*normal[j][2]*fpair2; - fprod1[0] = prodnorm1*dprodnorm1[0]*fpair1; - fprod1[1] = prodnorm1*dprodnorm1[1]*fpair1; - fprod1[2] = prodnorm1*dprodnorm1[2]*fpair1; - fprod2[0] = prodnorm2*dprodnorm2[0]*fpair2; - fprod2[1] = prodnorm2*dprodnorm2[1]*fpair2; - fprod2[2] = prodnorm2*dprodnorm2[2]*fpair2; - fkcx = (delx*fsum - fp1[0] - fp2[0])*Tap - Vilp*dTap*delx/r; - fkcy = (dely*fsum - fp1[1] - fp2[1])*Tap - Vilp*dTap*dely/r; - fkcz = (delz*fsum - fp1[2] - fp2[2])*Tap - Vilp*dTap*delz/r; + nelements = 0; + for (i = 3; i < narg; i++) { + if (strcmp(arg[i],"NULL") == 0) { + map[i-2] = -1; + continue; + } + for (j = 0; j < nelements; j++) + if (strcmp(arg[i],elements[j]) == 0) break; + map[i-2] = j; + if (j == nelements) { + n = strlen(arg[i]) + 1; + elements[j] = new char[n]; + strcpy(elements[j],arg[i]); + nelements++; + } + } - f[i][0] += fkcx - fprod1[0]*Tap; - f[i][1] += fkcy - fprod1[1]*Tap; - f[i][2] += fkcz - fprod1[2]*Tap; - f[j][0] -= fkcx + fprod2[0]*Tap; - f[j][1] -= fkcy + fprod2[1]*Tap; - f[j][2] -= fkcz + fprod2[2]*Tap; - // calculate the forces acted on the neighbors of atom i from atom j - ILP_neighs_i = ILP_firstneigh[i]; - for (kk = 0; kk < ILP_numneigh[i]; kk++) { - k = ILP_neighs_i[kk]; - if (k == i) continue; - // derivatives of the product of rij and ni respect to rk, k=0,1,2, where atom k is the neighbors of atom i - dprodnorm1[0] = dnormal[0][0][kk][i]*delx + dnormal[1][0][kk][i]*dely + dnormal[2][0][kk][i]*delz; - dprodnorm1[1] = dnormal[0][1][kk][i]*delx + dnormal[1][1][kk][i]*dely + dnormal[2][1][kk][i]*delz; - dprodnorm1[2] = dnormal[0][2][kk][i]*delx + dnormal[1][2][kk][i]*dely + dnormal[2][2][kk][i]*delz; - fk[0] = (-prodnorm1*dprodnorm1[0]*fpair1)*Tap; - fk[1] = (-prodnorm1*dprodnorm1[1]*fpair1)*Tap; - fk[2] = (-prodnorm1*dprodnorm1[2]*fpair1)*Tap; - f[k][0] += fk[0]; - f[k][1] += fk[1]; - f[k][2] += fk[2]; - delkj[0] = x[k][0] - x[j][0]; - delkj[1] = x[k][1] - x[j][1]; - delkj[2] = x[k][2] - x[j][2]; - if (evflag) ev_tally_xyz(k,j,nlocal,newton_pair,0.0,0.0,fk[0],fk[1],fk[2],delkj[0],delkj[1],delkj[2]); - } + read_file(arg[2]); - // calculate the forces acted on the neighbors of atom j from atom i - ILP_neighs_j = ILP_firstneigh[j]; - for (ll = 0; ll < ILP_numneigh[j]; ll++) { - l = ILP_neighs_j[ll]; - if (l == j) continue; - // derivatives of the product of rji and nj respect to rl, l=0,1,2, where atom l is the neighbors of atom j - dprodnorm2[0] = dnormal[0][0][ll][j]*delx + dnormal[1][0][ll][j]*dely + dnormal[2][0][ll][j]*delz; - dprodnorm2[1] = dnormal[0][1][ll][j]*delx + dnormal[1][1][ll][j]*dely + dnormal[2][1][ll][j]*delz; - dprodnorm2[2] = dnormal[0][2][ll][j]*delx + dnormal[1][2][ll][j]*dely + dnormal[2][2][ll][j]*delz; - fl[0] = (-prodnorm2*dprodnorm2[0]*fpair2)*Tap; - fl[1] = (-prodnorm2*dprodnorm2[1]*fpair2)*Tap; - fl[2] = (-prodnorm2*dprodnorm2[2]*fpair2)*Tap; - f[l][0] += fl[0]; - f[l][1] += fl[1]; - f[l][2] += fl[2]; - delli[0] = x[l][0] - x[i][0]; - delli[1] = x[l][1] - x[i][1]; - delli[2] = x[l][2] - x[i][2]; - if (evflag) ev_tally_xyz(l,i,nlocal,newton_pair,0.0,0.0,fl[0],fl[1],fl[2],delli[0],delli[1],delli[2]); - } + // clear setflag since coeff() called once with I,J = * * - if (eflag) { - if (tap_flag) evdwl = Tap*Vilp; - else evdwl = Vilp - offset[itype][jtype]; - } + n = atom->ntypes; + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; - if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair,evdwl,0.0,fkcx,fkcy,fkcz,delx,dely,delz); + // set setflag i,j for type pairs where both are mapped to elements + + int count = 0; + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + if (map[i] >= 0 && map[j] >= 0) { + setflag[i][j] = 1; + cut[i][j] = cut_global; + count++; } - } - } - if (vflag_fdotr) virial_fdotr_compute(); + + if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); } + /* ---------------------------------------------------------------------- - Calculate the normals for each atom + init for one type pair i,j and corresponding j,i ------------------------------------------------------------------------- */ -void PairILPGrapheneHBN::calc_normal() -{ - int i,j,ii,jj,inum,jnum; - int cont,id,ip,m; - double nn,xtp,ytp,ztp,delx,dely,delz,nn2; - int *ilist,*jlist; - double pv12[3],pv31[3],pv23[3],n1[3],dni[3],dnn[3][3],vet[3][3],dpvdri[3][3]; - double dn1[3][3][3],dpv12[3][3][3],dpv23[3][3][3],dpv31[3][3][3]; - double **x = atom->x; +double PairILPGrapheneHBN::init_one(int i, int j) +{ + if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); + if (!offset_flag) + error->all(FLERR,"Must use 'pair_modify shift yes' with this pair style"); - // grow normal array if necessary + if (offset_flag && (cut[i][j] > 0.0)) { + int iparam_ij = elem2param[map[i]][map[j]]; + Param& p = params[iparam_ij]; + offset[i][j] = -p.C6*pow(1.0/cut[i][j],6)/(1.0 + exp(-p.d*(cut[i][j]/p.seff - 1.0))); + } else offset[i][j] = 0.0; + offset[j][i] = offset[i][j]; - if (atom->nmax > nmax) { - memory->destroy(normal); - memory->destroy(dnormal); - memory->destroy(dnormdri); - nmax = atom->nmax; - memory->create(normal,nmax,3,"ILPGrapheneHBN:normal"); - memory->create(dnormdri,3,3,nmax,"ILPGrapheneHBN:dnormdri"); - memory->create(dnormal,3,3,3,nmax,"ILPGrapheneHBN:dnormal"); - } + return cut[i][j]; +} - inum = list->inum; - ilist = list->ilist; - //Calculate normals - for (ii = 0; ii < inum; ii++) { - i = ilist[ii]; - xtp = x[i][0]; - ytp = x[i][1]; - ztp = x[i][2]; +/* ---------------------------------------------------------------------- + read Interlayer potential file +------------------------------------------------------------------------- */ - // Initialize the arrays - for (id = 0; id < 3; id++){ - pv12[id] = 0.0; - pv31[id] = 0.0; - pv23[id] = 0.0; - n1[id] = 0.0; - dni[id] = 0.0; - normal[i][id] = 0.0; - for (ip = 0; ip < 3; ip++){ - vet[ip][id] = 0.0; - dnn[ip][id] = 0.0; - dpvdri[ip][id] = 0.0; - dnormdri[ip][id][i] = 0.0; - for (m = 0; m < 3; m++){ - dpv12[ip][id][m] = 0.0; - dpv31[ip][id][m] = 0.0; - dpv23[ip][id][m] = 0.0; - dn1[ip][id][m] = 0.0; - dnormal[ip][id][m][i] = 0.0; - } - } - } +void PairILPGrapheneHBN::read_file(char *filename) +{ + int params_per_line = 13; + char **words = new char*[params_per_line+1]; + memory->sfree(params); + params = NULL; + nparams = maxparam = 0; - cont = 0; - jlist = ILP_firstneigh[i]; - jnum = ILP_numneigh[i]; - for (jj = 0; jj < jnum; jj++) { - j = jlist[jj]; - j &= NEIGHMASK; + // open file on proc 0 - delx = x[j][0] - xtp; - dely = x[j][1] - ytp; - delz = x[j][2] - ztp; - vet[cont][0] = delx; - vet[cont][1] = dely; - vet[cont][2] = delz; - cont++; + FILE *fp; + if (comm->me == 0) { + fp = force->open_potential(filename); + if (fp == NULL) { + char str[128]; + snprintf(str,128,"Cannot open ILP potential file %s",filename); + error->one(FLERR,str); } + } - if (cont <= 1) { - normal[i][0] = 0.0; - normal[i][1] = 0.0; - normal[i][2] = 1.0; - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormdri[id][ip][i] = 0.0; - for (m = 0; m < 3; m++){ - dnormal[id][ip][m][i] = 0.0; - } - } - } + // read each line out of file, skipping blank lines or leading '#' + // store line of params if all 3 element tags are in element list + + int i,j,n,m,nwords,ielement,jelement; + char line[MAXLINE],*ptr; + int eof = 0; + + while (1) { + if (comm->me == 0) { + ptr = fgets(line,MAXLINE,fp); + if (ptr == NULL) { + eof = 1; + fclose(fp); + } else n = strlen(line) + 1; } - else if (cont == 2) { - pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; - pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; - pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; - // derivatives of pv12[0] to ri - dpvdri[0][0] = 0.0; - dpvdri[0][1] = vet[0][2]-vet[1][2]; - dpvdri[0][2] = vet[1][1]-vet[0][1]; - // derivatives of pv12[1] to ri - dpvdri[1][0] = vet[1][2]-vet[0][2]; - dpvdri[1][1] = 0.0; - dpvdri[1][2] = vet[0][0]-vet[1][0]; - // derivatives of pv12[2] to ri - dpvdri[2][0] = vet[0][1]-vet[1][1]; - dpvdri[2][1] = vet[1][0]-vet[0][0]; - dpvdri[2][2] = 0.0; + MPI_Bcast(&eof,1,MPI_INT,0,world); + if (eof) break; + MPI_Bcast(&n,1,MPI_INT,0,world); + MPI_Bcast(line,n,MPI_CHAR,0,world); - dpv12[0][0][0] = 0.0; - dpv12[0][1][0] = vet[1][2]; - dpv12[0][2][0] = -vet[1][1]; - dpv12[1][0][0] = -vet[1][2]; - dpv12[1][1][0] = 0.0; - dpv12[1][2][0] = vet[1][0]; - dpv12[2][0][0] = vet[1][1]; - dpv12[2][1][0] = -vet[1][0]; - dpv12[2][2][0] = 0.0; + // strip comment, skip line if blank - // derivatives respect to the second neighbor, atom l - dpv12[0][0][1] = 0.0; - dpv12[0][1][1] = -vet[0][2]; - dpv12[0][2][1] = vet[0][1]; - dpv12[1][0][1] = vet[0][2]; - dpv12[1][1][1] = 0.0; - dpv12[1][2][1] = -vet[0][0]; - dpv12[2][0][1] = -vet[0][1]; - dpv12[2][1][1] = vet[0][0]; - dpv12[2][2][1] = 0.0; + if ((ptr = strchr(line,'#'))) *ptr = '\0'; + nwords = atom->count_words(line); + if (nwords == 0) continue; - // derivatives respect to the third neighbor, atom n - // derivatives of pv12 to rn is zero - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv12[id][ip][2] = 0.0; - } - } + // concatenate additional lines until have params_per_line words - n1[0] = pv12[0]; - n1[1] = pv12[1]; - n1[2] = pv12[2]; - // the magnitude of the normal vector - nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; - nn = sqrt(nn2); - if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); - // the unit normal vector - normal[i][0] = n1[0]/nn; - normal[i][1] = n1[1]/nn; - normal[i][2] = n1[2]/nn; - // derivatives of nn, dnn:3x1 vector - dni[0] = (n1[0]*dpvdri[0][0] + n1[1]*dpvdri[1][0] + n1[2]*dpvdri[2][0])/nn; - dni[1] = (n1[0]*dpvdri[0][1] + n1[1]*dpvdri[1][1] + n1[2]*dpvdri[2][1])/nn; - dni[2] = (n1[0]*dpvdri[0][2] + n1[1]*dpvdri[1][2] + n1[2]*dpvdri[2][2])/nn; - // derivatives of unit vector ni respect to ri, the result is 3x3 matrix - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormdri[id][ip][i] = dpvdri[id][ip]/nn - n1[id]*dni[ip]/nn2; - } - } - // derivatives of non-normalized normal vector, dn1:3x3x3 array - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - for (m = 0; m < 3; m++){ - dn1[id][ip][m] = dpv12[id][ip][m]; - } - } - } - // derivatives of nn, dnn:3x3 vector - // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 - // r[id][m]: the id's component of atom m - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; - } - } - // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 - // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; - } - } + while (nwords < params_per_line) { + n = strlen(line); + if (comm->me == 0) { + ptr = fgets(&line[n],MAXLINE-n,fp); + if (ptr == NULL) { + eof = 1; + fclose(fp); + } else n = strlen(line) + 1; } + MPI_Bcast(&eof,1,MPI_INT,0,world); + if (eof) break; + MPI_Bcast(&n,1,MPI_INT,0,world); + MPI_Bcast(line,n,MPI_CHAR,0,world); + if ((ptr = strchr(line,'#'))) *ptr = '\0'; + nwords = atom->count_words(line); } -//############################################################################################## - else if(cont == 3) { - pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; - pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; - pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; - // derivatives respect to the first neighbor, atom k - dpv12[0][0][0] = 0.0; - dpv12[0][1][0] = vet[1][2]; - dpv12[0][2][0] = -vet[1][1]; - dpv12[1][0][0] = -vet[1][2]; - dpv12[1][1][0] = 0.0; - dpv12[1][2][0] = vet[1][0]; - dpv12[2][0][0] = vet[1][1]; - dpv12[2][1][0] = -vet[1][0]; - dpv12[2][2][0] = 0.0; - // derivatives respect to the second neighbor, atom l - dpv12[0][0][1] = 0.0; - dpv12[0][1][1] = -vet[0][2]; - dpv12[0][2][1] = vet[0][1]; - dpv12[1][0][1] = vet[0][2]; - dpv12[1][1][1] = 0.0; - dpv12[1][2][1] = -vet[0][0]; - dpv12[2][0][1] = -vet[0][1]; - dpv12[2][1][1] = vet[0][0]; - dpv12[2][2][1] = 0.0; + if (nwords != params_per_line) + error->all(FLERR,"Insufficient format in ILP potential file"); - // derivatives respect to the third neighbor, atom n - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv12[id][ip][2] = 0.0; - } - } + // words = ptrs to all words in line - pv31[0] = vet[2][1]*vet[0][2] - vet[0][1]*vet[2][2]; - pv31[1] = vet[2][2]*vet[0][0] - vet[0][2]*vet[2][0]; - pv31[2] = vet[2][0]*vet[0][1] - vet[0][0]*vet[2][1]; - // derivatives respect to the first neighbor, atom k - dpv31[0][0][0] = 0.0; - dpv31[0][1][0] = -vet[2][2]; - dpv31[0][2][0] = vet[2][1]; - dpv31[1][0][0] = vet[2][2]; - dpv31[1][1][0] = 0.0; - dpv31[1][2][0] = -vet[2][0]; - dpv31[2][0][0] = -vet[2][1]; - dpv31[2][1][0] = vet[2][0]; - dpv31[2][2][0] = 0.0; - // derivatives respect to the third neighbor, atom n - dpv31[0][0][2] = 0.0; - dpv31[0][1][2] = vet[0][2]; - dpv31[0][2][2] = -vet[0][1]; - dpv31[1][0][2] = -vet[0][2]; - dpv31[1][1][2] = 0.0; - dpv31[1][2][2] = vet[0][0]; - dpv31[2][0][2] = vet[0][1]; - dpv31[2][1][2] = -vet[0][0]; - dpv31[2][2][2] = 0.0; - // derivatives respect to the second neighbor, atom l - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv31[id][ip][1] = 0.0; - } - } + nwords = 0; + words[nwords++] = strtok(line," \t\n\r\f"); + while ((words[nwords++] = strtok(NULL," \t\n\r\f"))) continue; - pv23[0] = vet[1][1]*vet[2][2] - vet[2][1]*vet[1][2]; - pv23[1] = vet[1][2]*vet[2][0] - vet[2][2]*vet[1][0]; - pv23[2] = vet[1][0]*vet[2][1] - vet[2][0]*vet[1][1]; - // derivatives respect to the second neighbor, atom k - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv23[id][ip][0] = 0.0; - } - } - // derivatives respect to the second neighbor, atom l - dpv23[0][0][1] = 0.0; - dpv23[0][1][1] = vet[2][2]; - dpv23[0][2][1] = -vet[2][1]; - dpv23[1][0][1] = -vet[2][2]; - dpv23[1][1][1] = 0.0; - dpv23[1][2][1] = vet[2][0]; - dpv23[2][0][1] = vet[2][1]; - dpv23[2][1][1] = -vet[2][0]; - dpv23[2][2][1] = 0.0; - // derivatives respect to the third neighbor, atom n - dpv23[0][0][2] = 0.0; - dpv23[0][1][2] = -vet[1][2]; - dpv23[0][2][2] = vet[1][1]; - dpv23[1][0][2] = vet[1][2]; - dpv23[1][1][2] = 0.0; - dpv23[1][2][2] = -vet[1][0]; - dpv23[2][0][2] = -vet[1][1]; - dpv23[2][1][2] = vet[1][0]; - dpv23[2][2][2] = 0.0; + // ielement,jelement = 1st args + // if these 2 args are in element list, then parse this line + // else skip to next line (continue) -//############################################################################################ - // average the normal vectors by using the 3 neighboring planes - n1[0] = (pv12[0] + pv31[0] + pv23[0])/cont; - n1[1] = (pv12[1] + pv31[1] + pv23[1])/cont; - n1[2] = (pv12[2] + pv31[2] + pv23[2])/cont; - // the magnitude of the normal vector - nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; - nn = sqrt(nn2); - if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); - // the unit normal vector - normal[i][0] = n1[0]/nn; - normal[i][1] = n1[1]/nn; - normal[i][2] = n1[2]/nn; + for (ielement = 0; ielement < nelements; ielement++) + if (strcmp(words[0],elements[ielement]) == 0) break; + if (ielement == nelements) continue; + for (jelement = 0; jelement < nelements; jelement++) + if (strcmp(words[1],elements[jelement]) == 0) break; + if (jelement == nelements) continue; - // for the central atoms, dnormdri is always zero - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormdri[id][ip][i] = 0.0; - } - } + // load up parameter settings and error check their values - // derivatives of non-normalized normal vector, dn1:3x3x3 array - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - for (m = 0; m < 3; m++){ - dn1[id][ip][m] = (dpv12[id][ip][m] + dpv23[id][ip][m] + dpv31[id][ip][m])/cont; - } - } - } - // derivatives of nn, dnn:3x3 vector - // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 - // r[id][m]: the id's component of atom m - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; - } - } - // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 - // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; - } + if (nparams == maxparam) { + maxparam += DELTA; + params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), + "pair:params"); + } + + params[nparams].ielement = ielement; + params[nparams].jelement = jelement; + params[nparams].z0 = atof(words[2]); + params[nparams].alpha = atof(words[3]); + params[nparams].delta = atof(words[4]); + params[nparams].epsilon = atof(words[5]); + params[nparams].C = atof(words[6]); + params[nparams].d = atof(words[7]); + params[nparams].sR = atof(words[8]); + params[nparams].reff = atof(words[9]); + params[nparams].C6 = atof(words[10]); + // S provides a convenient scaling of all energies + params[nparams].S = atof(words[11]); + params[nparams].rcut = atof(words[12]); + + // energies in meV further scaled by S + // S = 43.3634 meV = 1 kcal/mol + double meV = 1e-3*params[nparams].S; + params[nparams].C *= meV; + params[nparams].C6 *= meV; + params[nparams].epsilon *= meV; + + // precompute some quantities + params[nparams].delta2inv = pow(params[nparams].delta,-2.0); + params[nparams].lambda = params[nparams].alpha/params[nparams].z0; + params[nparams].seff = params[nparams].sR * params[nparams].reff; + + nparams++; + } + memory->destroy(elem2param); + memory->destroy(cutILPsq); + memory->create(elem2param,nelements,nelements,"pair:elem2param"); + memory->create(cutILPsq,nelements,nelements,"pair:cutILPsq"); + for (i = 0; i < nelements; i++) { + for (j = 0; j < nelements; j++) { + n = -1; + for (m = 0; m < nparams; m++) { + if (i == params[m].ielement && j == params[m].jelement) { + if (n >= 0) error->all(FLERR,"Potential file has duplicate entry"); + n = m; } } + if (n < 0) error->all(FLERR,"Potential file is missing an entry"); + elem2param[i][j] = n; + cutILPsq[i][j] = params[n].rcut*params[n].rcut; } - else { - error->one(FLERR,"There are too many neighbors for calculating normals"); - } + } + delete [] words; +} -//############################################################################################## +/* ---------------------------------------------------------------------- + init specific to this pair style +------------------------------------------------------------------------- */ + +void PairILPGrapheneHBN::init_style() +{ + if (force->newton_pair == 0) + error->all(FLERR,"Pair style ilp/graphene/hbn requires newton pair on"); + if (!atom->molecule_flag) + error->all(FLERR,"Pair style ilp/graphene/hbn requires atom attribute molecule"); + + // need a full neighbor list, including neighbors of ghosts + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->ghost = 1; + + // local ILP neighbor list + // create pages if first time or if neighbor pgsize/oneatom has changed + + int create = 0; + if (ipage == NULL) create = 1; + if (pgsize != neighbor->pgsize) create = 1; + if (oneatom != neighbor->oneatom) create = 1; + + if (create) { + delete [] ipage; + pgsize = neighbor->pgsize; + oneatom = neighbor->oneatom; + + int nmypage= comm->nthreads; + ipage = new MyPage[nmypage]; + for (int i = 0; i < nmypage; i++) + ipage[i].init(oneatom,pgsize,PGDELTA); } } -/* ---------------------------------------------------------------------- - init specific to this pair style -------------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- */ +void PairILPGrapheneHBN::compute(int eflag, int vflag) +{ + ev_init(eflag,vflag); + pvector[0] = pvector[1] = 0.0; + + // Build full neighbor list + ILP_neigh(); + // Calculate the normals and its derivatives + calc_normal(); + // Calculate the van der Waals force and energy + calc_FvdW(eflag,vflag); + // Calculate the repulsive force and energy + calc_FRep(eflag,vflag); + + if (vflag_fdotr) virial_fdotr_compute(); +} + +/* ---------------------------------------------------------------------- + van der Waals forces and energy +------------------------------------------------------------------------- */ + +void PairILPGrapheneHBN::calc_FvdW(int eflag, int vflag) +{ + int i,j,ii,jj,inum,jnum,itype,jtype,k,l,kk,ll; + tagint itag,jtag; + double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair; + double rsq,r,Rcut,r2inv,r6inv,r8inv,Tap,dTap,Vilp,TSvdw,TSvdw2inv,fsum; + int *ilist,*jlist,*numneigh,**firstneigh; + + evdwl = 0.0; + double **x = atom->x; + double **f = atom->f; + int *type = atom->type; + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + int newton_pair = force->newton_pair; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // loop over neighbors of my atoms + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + itype = type[i]; + itag = tag[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + jtype = type[j]; + jtag = tag[j]; -void PairILPGrapheneHBN::init_style() -{ - if (force->newton_pair == 0) - error->all(FLERR,"Pair style ilp/graphene/hbn requires newton pair on"); - if (!atom->molecule_flag) - error->all(FLERR,"Pair style ilp/graphene/hbn requires atom attribute molecule"); + // two-body interactions from full neighbor list, skip half of them + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) continue; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) continue; + } else { + if (x[j][2] < ztmp) continue; + if (x[j][2] == ztmp && x[j][1] < ytmp) continue; + if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; + } - // need a full neighbor list, including neighbors of ghosts + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; - int irequest = neighbor->request(this,instance_me); - neighbor->requests[irequest]->half = 0; - neighbor->requests[irequest]->full = 1; - neighbor->requests[irequest]->ghost = 1; + // only include the interation between different layers + if (rsq < cutsq[itype][jtype] && atom->molecule[i] != atom->molecule[j]) { - // local ILP neighbor list - // create pages if first time or if neighbor pgsize/oneatom has changed + int iparam_ij = elem2param[map[itype]][map[jtype]]; + Param& p = params[iparam_ij]; - int create = 0; - if (ipage == NULL) create = 1; - if (pgsize != neighbor->pgsize) create = 1; - if (oneatom != neighbor->oneatom) create = 1; + r = sqrt(rsq); + r2inv = 1.0/rsq; + r6inv = r2inv*r2inv*r2inv; + r8inv = r6inv*r2inv; + // turn on/off taper function + if (tap_flag) { + Rcut = sqrt(cutsq[itype][jtype]); + Tap = calc_Tap(r,Rcut); + dTap = calc_dTap(r,Rcut); + } else {Tap = 1.0; dTap = 0.0;} - if (create) { - delete [] ipage; - pgsize = neighbor->pgsize; - oneatom = neighbor->oneatom; + TSvdw = 1.0 + exp(-p.d*(r/p.seff - 1.0)); + TSvdw2inv = pow(TSvdw,-2.0); + Vilp = -p.C6*r6inv/TSvdw; - int nmypage= comm->nthreads; - ipage = new MyPage[nmypage]; - for (int i = 0; i < nmypage; i++) - ipage[i].init(oneatom,pgsize,PGDELTA); + // derivatives + fpair = -6.0*p.C6*r8inv/TSvdw + p.C6*p.d/p.seff*(TSvdw-1.0)*TSvdw2inv*r8inv*r; + fsum = fpair*Tap - Vilp*dTap/r; + + f[i][0] += fsum*delx; + f[i][1] += fsum*dely; + f[i][2] += fsum*delz; + f[j][0] -= fsum*delx; + f[j][1] -= fsum*dely; + f[j][2] -= fsum*delz; + + if (eflag) pvector[0] += evdwl = Vilp*Tap; + if (evflag) ev_tally(i,j,nlocal,newton_pair, + evdwl,0.0,fsum,delx,dely,delz); + } + } } } - -/* ---------------------------------------------------------------------- - create ILP neighbor list from main neighbor list to calcualte normals +/* ---------------------------------------------------------------------- + Repulsive forces and energy ------------------------------------------------------------------------- */ -void PairILPGrapheneHBN::ILP_neigh() +void PairILPGrapheneHBN::calc_FRep(int eflag, int vflag) { - int i,j,ii,jj,n,allnum,jnum,itype,jtype; - double xtmp,ytmp,ztmp,delx,dely,delz,rsq; + int i,j,ii,jj,inum,jnum,itype,jtype,k,kk; + double prodnorm1,fkcx,fkcy,fkcz; + double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair,fpair1; + double rsq,r,Rcut,rhosq1,exp0,exp1,r2inv,r6inv,r8inv,Tap,dTap,Vilp; + double frho1,TSvdw,TSvdw2inv,Erep,fsum,rdsq1; int *ilist,*jlist,*numneigh,**firstneigh; - int *neighptr; + int *ILP_neighs_i,*ILP_neighs_j; + + evdwl = 0.0; double **x = atom->x; + double **f = atom->f; int *type = atom->type; + int nlocal = atom->nlocal; + int newton_pair = force->newton_pair; + double dprodnorm1[3] = {0.0, 0.0, 0.0}; + double fp1[3] = {0.0, 0.0, 0.0}; + double fprod1[3] = {0.0, 0.0, 0.0}; + double delkj[3] = {0.0, 0.0, 0.0}; + double fk[3] = {0.0, 0.0, 0.0}; - if (atom->nmax > maxlocal) { - maxlocal = atom->nmax; - memory->destroy(ILP_numneigh); - memory->sfree(ILP_firstneigh); - memory->create(ILP_numneigh,maxlocal,"ILPGrapheneHBN:numneigh"); - ILP_firstneigh = (int **) memory->smalloc(maxlocal*sizeof(int *),"ILPGrapheneHBN:firstneigh"); - } - - allnum = list->inum + list->gnum; + inum = list->inum; ilist = list->ilist; numneigh = list->numneigh; firstneigh = list->firstneigh; - // store all ILP neighs of owned and ghost atoms - // scan full neighbor list of I - - ipage->reset(); - - for (ii = 0; ii < allnum; ii++) { + //calculate exp(-lambda*(r-z0))*[epsilon/2 + f(rho_ij)] + // loop over neighbors of owned atoms + for (ii = 0; ii < inum; ii++) { i = ilist[ii]; - - n = 0; - neighptr = ipage->vget(); - + if (ILP_numneigh[i] == -1) { + continue; + } xtmp = x[i][0]; ytmp = x[i][1]; ztmp = x[i][2]; - itype = map[type[i]]; + itype = type[i]; jlist = firstneigh[i]; jnum = numneigh[i]; for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; - jtype = map[type[j]]; + if (ILP_numneigh[j] == -1) { + continue; + } + jtype = type[j]; + delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; rsq = delx*delx + dely*dely + delz*delz; - if (rsq != 0 && rsq < cutILPsq[itype][jtype] && atom->molecule[i] == atom->molecule[j]) { - neighptr[n++] = j; - } - } - - ILP_firstneigh[i] = neighptr; - ILP_numneigh[i] = n; - if (n > 3) error->one(FLERR,"There are too many neighbors for some atoms, please check your configuration"); - ipage->vgot(n); - if (ipage->status()) - error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); - } -} + // only include the interation between different layers + if (rsq < cutsq[itype][jtype] && atom->molecule[i] != atom->molecule[j]) { + int iparam_ij = elem2param[map[itype]][map[jtype]]; + Param& p = params[iparam_ij]; -/* ---------------------------------------------------------------------- - allocate all arrays -------------------------------------------------------------------------- */ + r = sqrt(rsq); + // turn on/off taper function + if (tap_flag) { + Rcut = sqrt(cutsq[itype][jtype]); + Tap = calc_Tap(r,Rcut); + dTap = calc_dTap(r,Rcut); + } else {Tap = 1.0; dTap = 0.0;} -void PairILPGrapheneHBN::allocate() -{ - allocated = 1; - int n = atom->ntypes; + // Calculate the transverse distance + prodnorm1 = normal[i][0]*delx + normal[i][1]*dely + normal[i][2]*delz; + rhosq1 = rsq - prodnorm1*prodnorm1; // rho_ij + rdsq1 = rhosq1*p.delta2inv; // (rho_ij/delta)^2 - memory->create(setflag,n+1,n+1,"pair:setflag"); - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; + // store exponents + exp0 = exp(-p.lambda*(r-p.z0)); + exp1 = exp(-rdsq1); - memory->create(cutsq,n+1,n+1,"pair:cutsq"); - memory->create(cut,n+1,n+1,"pair:cut"); - memory->create(offset,n+1,n+1,"pair:offset"); - map = new int[atom->ntypes+1]; -} + frho1 = exp1*p.C; + Erep = 0.5*p.epsilon + frho1; + Vilp = exp0*Erep; -/* ---------------------------------------------------------------------- - global settings -------------------------------------------------------------------------- */ + // derivatives + fpair = p.lambda*exp0/r*Erep; + fpair1 = 2.0*exp0*frho1*p.delta2inv; + fsum = fpair + fpair1; + // derivatives of the product of rij and ni, the result is a vector + dprodnorm1[0] = dnormdri[0][0][i]*delx + dnormdri[1][0][i]*dely + dnormdri[2][0][i]*delz; + dprodnorm1[1] = dnormdri[0][1][i]*delx + dnormdri[1][1][i]*dely + dnormdri[2][1][i]*delz; + dprodnorm1[2] = dnormdri[0][2][i]*delx + dnormdri[1][2][i]*dely + dnormdri[2][2][i]*delz; + fp1[0] = prodnorm1*normal[i][0]*fpair1; + fp1[1] = prodnorm1*normal[i][1]*fpair1; + fp1[2] = prodnorm1*normal[i][2]*fpair1; + fprod1[0] = prodnorm1*dprodnorm1[0]*fpair1; + fprod1[1] = prodnorm1*dprodnorm1[1]*fpair1; + fprod1[2] = prodnorm1*dprodnorm1[2]*fpair1; -void PairILPGrapheneHBN::settings(int narg, char **arg) -{ - if (narg < 1 || narg > 2) error->all(FLERR,"Illegal pair_style command"); - if (strcmp(force->pair_style,"hybrid/overlay")!=0) - error->all(FLERR,"ERROR: requires hybrid/overlay pair_style"); + fkcx = (delx*fsum - fp1[0])*Tap - Vilp*dTap*delx/r; + fkcy = (dely*fsum - fp1[1])*Tap - Vilp*dTap*dely/r; + fkcz = (delz*fsum - fp1[2])*Tap - Vilp*dTap*delz/r; - cut_global = force->numeric(FLERR,arg[0]); - if (narg == 2) tap_flag = force->numeric(FLERR,arg[1]); + f[i][0] += fkcx - fprod1[0]*Tap; + f[i][1] += fkcy - fprod1[1]*Tap; + f[i][2] += fkcz - fprod1[2]*Tap; + f[j][0] -= fkcx; + f[j][1] -= fkcy; + f[j][2] -= fkcz; - // reset cutoffs that have been explicitly set + // calculate the forces acted on the neighbors of atom i from atom j + ILP_neighs_i = ILP_firstneigh[i]; + for (kk = 0; kk < ILP_numneigh[i]; kk++) { + k = ILP_neighs_i[kk]; + if (k == i) continue; + // derivatives of the product of rij and ni respect to rk, k=0,1,2, where atom k is the neighbors of atom i + dprodnorm1[0] = dnormal[0][0][kk][i]*delx + dnormal[1][0][kk][i]*dely + dnormal[2][0][kk][i]*delz; + dprodnorm1[1] = dnormal[0][1][kk][i]*delx + dnormal[1][1][kk][i]*dely + dnormal[2][1][kk][i]*delz; + dprodnorm1[2] = dnormal[0][2][kk][i]*delx + dnormal[1][2][kk][i]*dely + dnormal[2][2][kk][i]*delz; + fk[0] = (-prodnorm1*dprodnorm1[0]*fpair1)*Tap; + fk[1] = (-prodnorm1*dprodnorm1[1]*fpair1)*Tap; + fk[2] = (-prodnorm1*dprodnorm1[2]*fpair1)*Tap; + f[k][0] += fk[0]; + f[k][1] += fk[1]; + f[k][2] += fk[2]; + delkj[0] = x[k][0] - x[j][0]; + delkj[1] = x[k][1] - x[j][1]; + delkj[2] = x[k][2] - x[j][2]; + if (evflag) ev_tally_xyz(k,j,nlocal,newton_pair,0.0,0.0,fk[0],fk[1],fk[2],delkj[0],delkj[1],delkj[2]); + } - if (allocated) { - int i,j; - for (i = 1; i <= atom->ntypes; i++) - for (j = i; j <= atom->ntypes; j++) - if (setflag[i][j]) cut[i][j] = cut_global; - } + if (eflag) pvector[1] += evdwl = Tap*Vilp; + if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair,evdwl,0.0,fkcx,fkcy,fkcz,delx,dely,delz); + } + } // loop over jj + } // loop over ii } /* ---------------------------------------------------------------------- - set coeffs for one or more type pairs + create ILP neighbor list from main neighbor list to calcualte normals ------------------------------------------------------------------------- */ -void PairILPGrapheneHBN::coeff(int narg, char **arg) +void PairILPGrapheneHBN::ILP_neigh() { - int i,j,n; - - if (narg != 3 + atom->ntypes) - error->all(FLERR,"Incorrect args for pair coefficients"); - if (!allocated) allocate(); - - // insure I,J args are * * - - if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) - error->all(FLERR,"Incorrect args for pair coefficients"); + int i,j,ii,jj,n,allnum,inum,jnum,itype,jtype; + double xtmp,ytmp,ztmp,delx,dely,delz,rsq; + int *ilist,*jlist,*numneigh,**firstneigh; + int *neighptr; - // read args that map atom types to elements in potential file - // map[i] = which element the Ith atom type is, -1 if NULL - // nelements = # of unique elements - // elements = list of element names + double **x = atom->x; + int *type = atom->type; - if (elements) { - for (i = 0; i < nelements; i++) delete [] elements[i]; - delete [] elements; + if (atom->nmax > maxlocal) { + maxlocal = atom->nmax; + memory->destroy(ILP_numneigh); + memory->sfree(ILP_firstneigh); + memory->create(ILP_numneigh,maxlocal,"ILPGrapheneHBN:numneigh"); + ILP_firstneigh = (int **) memory->smalloc(maxlocal*sizeof(int *),"ILPGrapheneHBN:firstneigh"); } - elements = new char*[atom->ntypes]; - for (i = 0; i < atom->ntypes; i++) elements[i] = NULL; - nelements = 0; - for (i = 3; i < narg; i++) { - if (strcmp(arg[i],"NULL") == 0) { - map[i-2] = -1; - continue; - } - for (j = 0; j < nelements; j++) - if (strcmp(arg[i],elements[j]) == 0) break; - map[i-2] = j; - if (j == nelements) { - n = strlen(arg[i]) + 1; - elements[j] = new char[n]; - strcpy(elements[j],arg[i]); - nelements++; - } - } + inum = list->inum; + allnum = list->inum + list->gnum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + // store all ILP neighs of owned and ghost atoms + // scan full neighbor list of I - read_file(arg[2]); + ipage->reset(); - // clear setflag since coeff() called once with I,J = * * + for (ii = 0; ii < allnum; ii++) { + i = ilist[ii]; - n = atom->ntypes; - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; + n = 0; + neighptr = ipage->vget(); - // set setflag i,j for type pairs where both are mapped to elements + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + itype = map[type[i]]; + jlist = firstneigh[i]; + jnum = numneigh[i]; - int count = 0; - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - if (map[i] >= 0 && map[j] >= 0) { - setflag[i][j] = 1; - cut[i][j] = cut_global; - count++; + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + jtype = map[type[j]]; + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; + + if (rsq != 0 && rsq < cutILPsq[itype][jtype] && atom->molecule[i] == atom->molecule[j]) { + neighptr[n++] = j; } + } // loop over jj - if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); -} + ILP_firstneigh[i] = neighptr; + if (n == 3) { + ILP_numneigh[i] = n; + } + else if (n < 3) { + if (i < inum) { + ILP_numneigh[i] = n; + } else { + ILP_numneigh[i] = -1; + } + } + else if (n > 3) error->one(FLERR,"There are too many neighbors for some atoms, please check your configuration"); + ipage->vgot(n); + if (ipage->status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } +} /* ---------------------------------------------------------------------- - init for one type pair i,j and corresponding j,i + Calculate the normals for each atom ------------------------------------------------------------------------- */ - -double PairILPGrapheneHBN::init_one(int i, int j) +void PairILPGrapheneHBN::calc_normal() { - if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - if (!offset_flag) - error->all(FLERR,"Must use 'pair_modify shift yes' with this pair style"); + int i,j,ii,jj,inum,jnum; + int cont,id,ip,m; + double nn,xtp,ytp,ztp,delx,dely,delz,nn2; + int *ilist,*jlist; + double pv12[3],pv31[3],pv23[3],n1[3],dni[3],dnn[3][3],vet[3][3],dpvdri[3][3]; + double dn1[3][3][3],dpv12[3][3][3],dpv23[3][3][3],dpv31[3][3][3]; - if (offset_flag && (cut[i][j] > 0.0)) { - int iparam_ij = elem2param[map[i]][map[j]]; - Param& p = params[iparam_ij]; - offset[i][j] = -p.C6*pow(1.0/cut[i][j],6)/(1.0 + exp(-p.d*(cut[i][j]/p.seff - 1.0))); - } else offset[i][j] = 0.0; - offset[j][i] = offset[i][j]; + double **x = atom->x; - return cut[i][j]; -} + // grow normal array if necessary -/* ---------------------------------------------------------------------- - read Interlayer potential file -------------------------------------------------------------------------- */ + if (atom->nmax > nmax) { + memory->destroy(normal); + memory->destroy(dnormal); + memory->destroy(dnormdri); + nmax = atom->nmax; + memory->create(normal,nmax,3,"ILPGrapheneHBN:normal"); + memory->create(dnormdri,3,3,nmax,"ILPGrapheneHBN:dnormdri"); + memory->create(dnormal,3,3,3,nmax,"ILPGrapheneHBN:dnormal"); + } -void PairILPGrapheneHBN::read_file(char *filename) -{ - int params_per_line = 13; - char **words = new char*[params_per_line+1]; - memory->sfree(params); - params = NULL; - nparams = maxparam = 0; + inum = list->inum; + ilist = list->ilist; + //Calculate normals + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; - // open file on proc 0 + // Initialize the arrays + for (id = 0; id < 3; id++){ + pv12[id] = 0.0; + pv31[id] = 0.0; + pv23[id] = 0.0; + n1[id] = 0.0; + dni[id] = 0.0; + normal[i][id] = 0.0; + for (ip = 0; ip < 3; ip++){ + vet[ip][id] = 0.0; + dnn[ip][id] = 0.0; + dpvdri[ip][id] = 0.0; + dnormdri[ip][id][i] = 0.0; + for (m = 0; m < 3; m++){ + dpv12[ip][id][m] = 0.0; + dpv31[ip][id][m] = 0.0; + dpv23[ip][id][m] = 0.0; + dn1[ip][id][m] = 0.0; + dnormal[ip][id][m][i] = 0.0; + } + } + } - FILE *fp; - if (comm->me == 0) { - fp = force->open_potential(filename); - if (fp == NULL) { - char str[128]; - snprintf(str,128,"Cannot open ILP potential file %s",filename); - error->one(FLERR,str); + if (ILP_numneigh[i] == -1) { + continue; } - } + xtp = x[i][0]; + ytp = x[i][1]; + ztp = x[i][2]; - // read each line out of file, skipping blank lines or leading '#' - // store line of params if all 3 element tags are in element list + cont = 0; + jlist = ILP_firstneigh[i]; + jnum = ILP_numneigh[i]; + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; - int i,j,n,m,nwords,ielement,jelement; - char line[MAXLINE],*ptr; - int eof = 0; + delx = x[j][0] - xtp; + dely = x[j][1] - ytp; + delz = x[j][2] - ztp; + vet[cont][0] = delx; + vet[cont][1] = dely; + vet[cont][2] = delz; + cont++; + } - while (1) { - if (comm->me == 0) { - ptr = fgets(line,MAXLINE,fp); - if (ptr == NULL) { - eof = 1; - fclose(fp); - } else n = strlen(line) + 1; + if (cont <= 1) { + normal[i][0] = 0.0; + normal[i][1] = 0.0; + normal[i][2] = 1.0; + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormdri[id][ip][i] = 0.0; + for (m = 0; m < 3; m++){ + dnormal[id][ip][m][i] = 0.0; + } + } + } } - MPI_Bcast(&eof,1,MPI_INT,0,world); - if (eof) break; - MPI_Bcast(&n,1,MPI_INT,0,world); - MPI_Bcast(line,n,MPI_CHAR,0,world); + else if (cont == 2) { + pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; + pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; + pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; + // derivatives of pv12[0] to ri + dpvdri[0][0] = 0.0; + dpvdri[0][1] = vet[0][2]-vet[1][2]; + dpvdri[0][2] = vet[1][1]-vet[0][1]; + // derivatives of pv12[1] to ri + dpvdri[1][0] = vet[1][2]-vet[0][2]; + dpvdri[1][1] = 0.0; + dpvdri[1][2] = vet[0][0]-vet[1][0]; + // derivatives of pv12[2] to ri + dpvdri[2][0] = vet[0][1]-vet[1][1]; + dpvdri[2][1] = vet[1][0]-vet[0][0]; + dpvdri[2][2] = 0.0; - // strip comment, skip line if blank + dpv12[0][0][0] = 0.0; + dpv12[0][1][0] = vet[1][2]; + dpv12[0][2][0] = -vet[1][1]; + dpv12[1][0][0] = -vet[1][2]; + dpv12[1][1][0] = 0.0; + dpv12[1][2][0] = vet[1][0]; + dpv12[2][0][0] = vet[1][1]; + dpv12[2][1][0] = -vet[1][0]; + dpv12[2][2][0] = 0.0; - if ((ptr = strchr(line,'#'))) *ptr = '\0'; - nwords = atom->count_words(line); - if (nwords == 0) continue; + // derivatives respect to the second neighbor, atom l + dpv12[0][0][1] = 0.0; + dpv12[0][1][1] = -vet[0][2]; + dpv12[0][2][1] = vet[0][1]; + dpv12[1][0][1] = vet[0][2]; + dpv12[1][1][1] = 0.0; + dpv12[1][2][1] = -vet[0][0]; + dpv12[2][0][1] = -vet[0][1]; + dpv12[2][1][1] = vet[0][0]; + dpv12[2][2][1] = 0.0; - // concatenate additional lines until have params_per_line words + // derivatives respect to the third neighbor, atom n + // derivatives of pv12 to rn is zero + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv12[id][ip][2] = 0.0; + } + } - while (nwords < params_per_line) { - n = strlen(line); - if (comm->me == 0) { - ptr = fgets(&line[n],MAXLINE-n,fp); - if (ptr == NULL) { - eof = 1; - fclose(fp); - } else n = strlen(line) + 1; + n1[0] = pv12[0]; + n1[1] = pv12[1]; + n1[2] = pv12[2]; + // the magnitude of the normal vector + nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; + nn = sqrt(nn2); + if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); + // the unit normal vector + normal[i][0] = n1[0]/nn; + normal[i][1] = n1[1]/nn; + normal[i][2] = n1[2]/nn; + // derivatives of nn, dnn:3x1 vector + dni[0] = (n1[0]*dpvdri[0][0] + n1[1]*dpvdri[1][0] + n1[2]*dpvdri[2][0])/nn; + dni[1] = (n1[0]*dpvdri[0][1] + n1[1]*dpvdri[1][1] + n1[2]*dpvdri[2][1])/nn; + dni[2] = (n1[0]*dpvdri[0][2] + n1[1]*dpvdri[1][2] + n1[2]*dpvdri[2][2])/nn; + // derivatives of unit vector ni respect to ri, the result is 3x3 matrix + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormdri[id][ip][i] = dpvdri[id][ip]/nn - n1[id]*dni[ip]/nn2; + } + } + // derivatives of non-normalized normal vector, dn1:3x3x3 array + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + for (m = 0; m < 3; m++){ + dn1[id][ip][m] = dpv12[id][ip][m]; + } + } + } + // derivatives of nn, dnn:3x3 vector + // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 + // r[id][m]: the id's component of atom m + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; + } + } + // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 + // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; + } + } } - MPI_Bcast(&eof,1,MPI_INT,0,world); - if (eof) break; - MPI_Bcast(&n,1,MPI_INT,0,world); - MPI_Bcast(line,n,MPI_CHAR,0,world); - if ((ptr = strchr(line,'#'))) *ptr = '\0'; - nwords = atom->count_words(line); } +//############################################################################################## - if (nwords != params_per_line) - error->all(FLERR,"Insufficient format in ILP potential file"); - - // words = ptrs to all words in line - - nwords = 0; - words[nwords++] = strtok(line," \t\n\r\f"); - while ((words[nwords++] = strtok(NULL," \t\n\r\f"))) continue; - - // ielement,jelement = 1st args - // if these 2 args are in element list, then parse this line - // else skip to next line (continue) - - for (ielement = 0; ielement < nelements; ielement++) - if (strcmp(words[0],elements[ielement]) == 0) break; - if (ielement == nelements) continue; - for (jelement = 0; jelement < nelements; jelement++) - if (strcmp(words[1],elements[jelement]) == 0) break; - if (jelement == nelements) continue; + else if(cont == 3) { + pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; + pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; + pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; + // derivatives respect to the first neighbor, atom k + dpv12[0][0][0] = 0.0; + dpv12[0][1][0] = vet[1][2]; + dpv12[0][2][0] = -vet[1][1]; + dpv12[1][0][0] = -vet[1][2]; + dpv12[1][1][0] = 0.0; + dpv12[1][2][0] = vet[1][0]; + dpv12[2][0][0] = vet[1][1]; + dpv12[2][1][0] = -vet[1][0]; + dpv12[2][2][0] = 0.0; + // derivatives respect to the second neighbor, atom l + dpv12[0][0][1] = 0.0; + dpv12[0][1][1] = -vet[0][2]; + dpv12[0][2][1] = vet[0][1]; + dpv12[1][0][1] = vet[0][2]; + dpv12[1][1][1] = 0.0; + dpv12[1][2][1] = -vet[0][0]; + dpv12[2][0][1] = -vet[0][1]; + dpv12[2][1][1] = vet[0][0]; + dpv12[2][2][1] = 0.0; - // load up parameter settings and error check their values + // derivatives respect to the third neighbor, atom n + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv12[id][ip][2] = 0.0; + } + } - if (nparams == maxparam) { - maxparam += DELTA; - params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), - "pair:params"); - } + pv31[0] = vet[2][1]*vet[0][2] - vet[0][1]*vet[2][2]; + pv31[1] = vet[2][2]*vet[0][0] - vet[0][2]*vet[2][0]; + pv31[2] = vet[2][0]*vet[0][1] - vet[0][0]*vet[2][1]; + // derivatives respect to the first neighbor, atom k + dpv31[0][0][0] = 0.0; + dpv31[0][1][0] = -vet[2][2]; + dpv31[0][2][0] = vet[2][1]; + dpv31[1][0][0] = vet[2][2]; + dpv31[1][1][0] = 0.0; + dpv31[1][2][0] = -vet[2][0]; + dpv31[2][0][0] = -vet[2][1]; + dpv31[2][1][0] = vet[2][0]; + dpv31[2][2][0] = 0.0; + // derivatives respect to the third neighbor, atom n + dpv31[0][0][2] = 0.0; + dpv31[0][1][2] = vet[0][2]; + dpv31[0][2][2] = -vet[0][1]; + dpv31[1][0][2] = -vet[0][2]; + dpv31[1][1][2] = 0.0; + dpv31[1][2][2] = vet[0][0]; + dpv31[2][0][2] = vet[0][1]; + dpv31[2][1][2] = -vet[0][0]; + dpv31[2][2][2] = 0.0; + // derivatives respect to the second neighbor, atom l + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv31[id][ip][1] = 0.0; + } + } - params[nparams].ielement = ielement; - params[nparams].jelement = jelement; - params[nparams].z0 = atof(words[2]); - params[nparams].alpha = atof(words[3]); - params[nparams].delta = atof(words[4]); - params[nparams].epsilon = atof(words[5]); - params[nparams].C = atof(words[6]); - params[nparams].d = atof(words[7]); - params[nparams].sR = atof(words[8]); - params[nparams].reff = atof(words[9]); - params[nparams].C6 = atof(words[10]); - // S provides a convenient scaling of all energies - params[nparams].S = atof(words[11]); - params[nparams].rcut = atof(words[12]); + pv23[0] = vet[1][1]*vet[2][2] - vet[2][1]*vet[1][2]; + pv23[1] = vet[1][2]*vet[2][0] - vet[2][2]*vet[1][0]; + pv23[2] = vet[1][0]*vet[2][1] - vet[2][0]*vet[1][1]; + // derivatives respect to the second neighbor, atom k + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv23[id][ip][0] = 0.0; + } + } + // derivatives respect to the second neighbor, atom l + dpv23[0][0][1] = 0.0; + dpv23[0][1][1] = vet[2][2]; + dpv23[0][2][1] = -vet[2][1]; + dpv23[1][0][1] = -vet[2][2]; + dpv23[1][1][1] = 0.0; + dpv23[1][2][1] = vet[2][0]; + dpv23[2][0][1] = vet[2][1]; + dpv23[2][1][1] = -vet[2][0]; + dpv23[2][2][1] = 0.0; + // derivatives respect to the third neighbor, atom n + dpv23[0][0][2] = 0.0; + dpv23[0][1][2] = -vet[1][2]; + dpv23[0][2][2] = vet[1][1]; + dpv23[1][0][2] = vet[1][2]; + dpv23[1][1][2] = 0.0; + dpv23[1][2][2] = -vet[1][0]; + dpv23[2][0][2] = -vet[1][1]; + dpv23[2][1][2] = vet[1][0]; + dpv23[2][2][2] = 0.0; - // energies in meV further scaled by S - // S = 43.3634 meV = 1 kcal/mol - double meV = 1e-3*params[nparams].S; - params[nparams].C *= meV; - params[nparams].C6 *= meV; - params[nparams].epsilon *= meV; +//############################################################################################ + // average the normal vectors by using the 3 neighboring planes + n1[0] = (pv12[0] + pv31[0] + pv23[0])/cont; + n1[1] = (pv12[1] + pv31[1] + pv23[1])/cont; + n1[2] = (pv12[2] + pv31[2] + pv23[2])/cont; + // the magnitude of the normal vector + nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; + nn = sqrt(nn2); + if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); + // the unit normal vector + normal[i][0] = n1[0]/nn; + normal[i][1] = n1[1]/nn; + normal[i][2] = n1[2]/nn; - // precompute some quantities - params[nparams].delta2inv = pow(params[nparams].delta,-2.0); - params[nparams].lambda = params[nparams].alpha/params[nparams].z0; - params[nparams].seff = params[nparams].sR * params[nparams].reff; + // for the central atoms, dnormdri is always zero + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormdri[id][ip][i] = 0.0; + } + } - nparams++; - } - memory->destroy(elem2param); - memory->destroy(cutILPsq); - memory->create(elem2param,nelements,nelements,"pair:elem2param"); - memory->create(cutILPsq,nelements,nelements,"pair:cutILPsq"); - for (i = 0; i < nelements; i++) { - for (j = 0; j < nelements; j++) { - n = -1; - for (m = 0; m < nparams; m++) { - if (i == params[m].ielement && j == params[m].jelement) { - if (n >= 0) error->all(FLERR,"Potential file has duplicate entry"); - n = m; + // derivatives of non-normalized normal vector, dn1:3x3x3 array + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + for (m = 0; m < 3; m++){ + dn1[id][ip][m] = (dpv12[id][ip][m] + dpv23[id][ip][m] + dpv31[id][ip][m])/cont; + } } } - if (n < 0) error->all(FLERR,"Potential file is missing an entry"); - elem2param[i][j] = n; - cutILPsq[i][j] = params[n].rcut*params[n].rcut; + // derivatives of nn, dnn:3x3 vector + // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 + // r[id][m]: the id's component of atom m + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; + } + } + // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 + // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; + } + } + } + } + else { + error->one(FLERR,"There are too many neighbors for calculating normals"); } + +//############################################################################################## } - delete [] words; } /* ---------------------------------------------------------------------- */ @@ -1061,70 +1127,3 @@ double PairILPGrapheneHBN::single(int /*i*/, int /*j*/, int itype, int jtype, do philj = Vilp*Tap; return factor_lj*philj; } - - -/* ---------------------------------------------------------------------- */ - -int PairILPGrapheneHBN::pack_forward_comm(int n, int *list, double *buf, - int /*pbc_flag*/, int * /*pbc*/) -{ - int i,j,m,id,ip,l; - - m = 0; - for (i = 0; i < n; i++) { - j = list[i]; - buf[m++] = normal[j][0]; - buf[m++] = normal[j][1]; - buf[m++] = normal[j][2]; - buf[m++] = dnormdri[0][0][j]; - buf[m++] = dnormdri[0][1][j]; - buf[m++] = dnormdri[0][2][j]; - buf[m++] = dnormdri[1][0][j]; - buf[m++] = dnormdri[1][1][j]; - buf[m++] = dnormdri[1][2][j]; - buf[m++] = dnormdri[2][0][j]; - buf[m++] = dnormdri[2][1][j]; - buf[m++] = dnormdri[2][2][j]; - for (l = 0; l < 3; l++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - buf[m++] = dnormal[id][ip][l][j]; - } - } - } - } - return m; -} - -/* ---------------------------------------------------------------------- */ - -void PairILPGrapheneHBN::unpack_forward_comm(int n, int first, double *buf) -{ - int i,m,last,id,ip,l; - - m = 0; - last = first + n; - for (i = first; i < last; i++) { - normal[i][0] = buf[m++]; - normal[i][1] = buf[m++]; - normal[i][2] = buf[m++]; - dnormdri[0][0][i] = buf[m++]; - dnormdri[0][1][i] = buf[m++]; - dnormdri[0][2][i] = buf[m++]; - dnormdri[1][0][i] = buf[m++]; - dnormdri[1][1][i] = buf[m++]; - dnormdri[1][2][i] = buf[m++]; - dnormdri[2][0][i] = buf[m++]; - dnormdri[2][1][i] = buf[m++]; - dnormdri[2][2][i] = buf[m++]; - for (l = 0; l < 3; l++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormal[id][ip][l][i] = buf[m++]; - } - } - } - } -} - -/* ---------------------------------------------------------------------- */ diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.h b/src/USER-MISC/pair_ilp_graphene_hbn.h index ae4662cdc5..32bee4a10f 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.h +++ b/src/USER-MISC/pair_ilp_graphene_hbn.h @@ -21,6 +21,8 @@ PairStyle(ilp/graphene/hbn,PairILPGrapheneHBN) #define LMP_PAIR_ILP_GRAPHENE_HBN_H #include "pair.h" +#include "my_page.h" +#include namespace LAMMPS_NS { @@ -34,9 +36,10 @@ class PairILPGrapheneHBN : public Pair { void coeff(int, char **); double init_one(int, int); void init_style(); + void ILP_neigh(); void calc_normal(); - int pack_forward_comm(int, int *, double *, int, int *); - void unpack_forward_comm(int, int, double *); + void calc_FRep(int, int); + void calc_FvdW(int, int); double single(int, int, int, int, double, double, double, double &); protected: @@ -74,7 +77,6 @@ class PairILPGrapheneHBN : public Pair { void read_file( char * ); void allocate(); - void ILP_neigh(); /* ----Calculate the long-range cutoff term */ inline double calc_Tap(double r_ij, double Rcut) { diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp index 0009531ca8..bfebb0c553 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp @@ -20,11 +20,12 @@ [Kolmogorov & Crespi, Phys. Rev. B 71, 235415 (2005)] ------------------------------------------------------------------------- */ -#include "pair_kolmogorov_crespi_full.h" #include +#include #include #include #include +#include "pair_kolmogorov_crespi_full.h" #include "atom.h" #include "comm.h" #include "force.h" @@ -48,6 +49,9 @@ PairKolmogorovCrespiFull::PairKolmogorovCrespiFull(LAMMPS *lmp) : Pair(lmp) restartinfo = 0; one_coeff = 1; + nextra = 2; + pvector = new double[nextra]; + // initialize element to parameter maps nelements = 0; elements = NULL; @@ -71,8 +75,7 @@ PairKolmogorovCrespiFull::PairKolmogorovCrespiFull(LAMMPS *lmp) : Pair(lmp) // always compute energy offset offset_flag = 1; - // set comm size needed by this Pair - comm_forward = 39; + // turn on the taper function tap_flag = 0; } @@ -83,6 +86,7 @@ PairKolmogorovCrespiFull::~PairKolmogorovCrespiFull() memory->destroy(KC_numneigh); memory->sfree(KC_firstneigh); delete [] ipage; + delete [] pvector; memory->destroy(normal); memory->destroy(dnormal); memory->destroy(dnormdri); @@ -103,934 +107,1001 @@ PairKolmogorovCrespiFull::~PairKolmogorovCrespiFull() if (allocated) delete [] map; } -/* ---------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + allocate all arrays +------------------------------------------------------------------------- */ -void PairKolmogorovCrespiFull::compute(int eflag, int vflag) +void PairKolmogorovCrespiFull::allocate() { - int i,j,ii,jj,inum,jnum,itype,jtype,k,l,kk,ll; - tagint itag,jtag; - double prodnorm1,prodnorm2,fkcx,fkcy,fkcz; - double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair,fpair1,fpair2; - double rsq,r,rhosq1,rhosq2,exp0,exp1,exp2,r2inv,r6inv,r8inv,Tap,dTap,Vkc; - double frho1,frho2,sumC1,sumC2,sumC11,sumC22,sumCff,fsum,rdsq1,rdsq2; - int *ilist,*jlist,*numneigh,**firstneigh; - int *KC_neighs_i,*KC_neighs_j; + allocated = 1; + int n = atom->ntypes; - evdwl = 0.0; - ev_init(eflag,vflag); + memory->create(setflag,n+1,n+1,"pair:setflag"); + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; - double **x = atom->x; - double **f = atom->f; - int *type = atom->type; - tagint *tag = atom->tag; - int nlocal = atom->nlocal; - int newton_pair = force->newton_pair; - double dprodnorm1[3] = {0.0, 0.0, 0.0}; - double dprodnorm2[3] = {0.0, 0.0, 0.0}; - double fp1[3] = {0.0, 0.0, 0.0}; - double fp2[3] = {0.0, 0.0, 0.0}; - double fprod1[3] = {0.0, 0.0, 0.0}; - double fprod2[3] = {0.0, 0.0, 0.0}; - double fk[3] = {0.0, 0.0, 0.0}; - double fl[3] = {0.0, 0.0, 0.0}; - double delkj[3] = {0.0, 0.0, 0.0}; - double delli[3] = {0.0, 0.0, 0.0}; + memory->create(cutsq,n+1,n+1,"pair:cutsq"); + memory->create(cut,n+1,n+1,"pair:cut"); + memory->create(offset,n+1,n+1,"pair:offset"); + map = new int[atom->ntypes+1]; +} - inum = list->inum; - ilist = list->ilist; - numneigh = list->numneigh; - firstneigh = list->firstneigh; - // Build full neighbor list - KC_neigh(); - // Calculate the normals - calc_normal(); +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ - // communicate the normal vector and its derivatives - comm->forward_comm_pair(this); +void PairKolmogorovCrespiFull::settings(int narg, char **arg) +{ + if (narg < 1 || narg > 2) error->all(FLERR,"Illegal pair_style command"); + if (strcmp(force->pair_style,"hybrid/overlay")!=0) + error->all(FLERR,"ERROR: requires hybrid/overlay pair_style"); - // loop over neighbors of my atoms - for (ii = 0; ii < inum; ii++) { - i = ilist[ii]; - itag = tag[i]; - xtmp = x[i][0]; - ytmp = x[i][1]; - ztmp = x[i][2]; - itype = type[i]; - jlist = firstneigh[i]; - jnum = numneigh[i]; + cut_global = force->numeric(FLERR,arg[0]); + if (narg == 2) tap_flag = force->numeric(FLERR,arg[1]); - for (jj = 0; jj < jnum; jj++) { - j = jlist[jj]; - j &= NEIGHMASK; - jtype = type[j]; - jtag = tag[j]; + // reset cutoffs that have been explicitly set - // two-body interactions from full neighbor list, skip half of them - if (itag > jtag) { - if ((itag+jtag) % 2 == 0) continue; - } else if (itag < jtag) { - if ((itag+jtag) % 2 == 1) continue; - } else { - if (x[j][2] < ztmp) continue; - if (x[j][2] == ztmp && x[j][1] < ytmp) continue; - if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; - } + if (allocated) { + int i,j; + for (i = 1; i <= atom->ntypes; i++) + for (j = i; j <= atom->ntypes; j++) + if (setflag[i][j]) cut[i][j] = cut_global; + } +} - delx = xtmp - x[j][0]; - dely = ytmp - x[j][1]; - delz = ztmp - x[j][2]; - rsq = delx*delx + dely*dely + delz*delz; +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ - // only include the interation between different layers - if (rsq < cutsq[itype][jtype] && atom->molecule[i] != atom->molecule[j]) { +void PairKolmogorovCrespiFull::coeff(int narg, char **arg) +{ + int i,j,n; - int iparam_ij = elem2param[map[itype]][map[jtype]]; - Param& p = params[iparam_ij]; + if (narg != 3 + atom->ntypes) + error->all(FLERR,"Incorrect args for pair coefficients"); + if (!allocated) allocate(); - r = sqrt(rsq); - r2inv = 1.0/rsq; - r6inv = r2inv*r2inv*r2inv; - r8inv = r2inv*r6inv; - // turn on/off taper function - if (tap_flag) { - Tap = calc_Tap(r,sqrt(cutsq[itype][jtype])); - dTap = calc_dTap(r,sqrt(cutsq[itype][jtype])); - } else {Tap = 1.0; dTap = 0.0;} + // insure I,J args are * * - // Calculate the transverse distance - // note that rho_ij does not equal to rho_ji except when normals are all along z - prodnorm1 = normal[i][0]*delx + normal[i][1]*dely + normal[i][2]*delz; - prodnorm2 = normal[j][0]*delx + normal[j][1]*dely + normal[j][2]*delz; - rhosq1 = rsq - prodnorm1*prodnorm1; // rho_ij - rhosq2 = rsq - prodnorm2*prodnorm2; // rho_ji - rdsq1 = rhosq1*p.delta2inv; // (rho_ij/delta)^2 - rdsq2 = rhosq2*p.delta2inv; // (rho_ji/delta)^2 + if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) + error->all(FLERR,"Incorrect args for pair coefficients"); - // store exponents - exp0 = exp(-p.lambda*(r-p.z0)); - exp1 = exp(-rdsq1); - exp2 = exp(-rdsq2); - - sumC1 = p.C0 + p.C2*rdsq1 + p.C4*rdsq1*rdsq1; - sumC2 = p.C0 + p.C2*rdsq2 + p.C4*rdsq2*rdsq2; - sumC11 = (p.C2 + 2.0*p.C4*rdsq1)*p.delta2inv; - sumC22 = (p.C2 + 2.0*p.C4*rdsq2)*p.delta2inv; - frho1 = exp1*sumC1; - frho2 = exp2*sumC2; - sumCff = p.C + frho1 + frho2; - Vkc = -p.A*p.z06*r6inv + exp0*sumCff; + // read args that map atom types to elements in potential file + // map[i] = which element the Ith atom type is, -1 if NULL + // nelements = # of unique elements + // elements = list of element names - // derivatives - fpair = -6.0*p.A*p.z06*r8inv + p.lambda*exp0/r*sumCff; - fpair1 = 2.0*exp0*exp1*(p.delta2inv*sumC1 - sumC11); - fpair2 = 2.0*exp0*exp2*(p.delta2inv*sumC2 - sumC22); - fsum = fpair + fpair1 + fpair2; - // derivatives of the product of rij and ni, the result is a vector - dprodnorm1[0] = dnormdri[0][0][i]*delx + dnormdri[1][0][i]*dely + dnormdri[2][0][i]*delz; - dprodnorm1[1] = dnormdri[0][1][i]*delx + dnormdri[1][1][i]*dely + dnormdri[2][1][i]*delz; - dprodnorm1[2] = dnormdri[0][2][i]*delx + dnormdri[1][2][i]*dely + dnormdri[2][2][i]*delz; - // derivatives of the product of rji and nj, the result is a vector - dprodnorm2[0] = dnormdri[0][0][j]*delx + dnormdri[1][0][j]*dely + dnormdri[2][0][j]*delz; - dprodnorm2[1] = dnormdri[0][1][j]*delx + dnormdri[1][1][j]*dely + dnormdri[2][1][j]*delz; - dprodnorm2[2] = dnormdri[0][2][j]*delx + dnormdri[1][2][j]*dely + dnormdri[2][2][j]*delz; - fp1[0] = prodnorm1*normal[i][0]*fpair1; - fp1[1] = prodnorm1*normal[i][1]*fpair1; - fp1[2] = prodnorm1*normal[i][2]*fpair1; - fp2[0] = prodnorm2*normal[j][0]*fpair2; - fp2[1] = prodnorm2*normal[j][1]*fpair2; - fp2[2] = prodnorm2*normal[j][2]*fpair2; - fprod1[0] = prodnorm1*dprodnorm1[0]*fpair1; - fprod1[1] = prodnorm1*dprodnorm1[1]*fpair1; - fprod1[2] = prodnorm1*dprodnorm1[2]*fpair1; - fprod2[0] = prodnorm2*dprodnorm2[0]*fpair2; - fprod2[1] = prodnorm2*dprodnorm2[1]*fpair2; - fprod2[2] = prodnorm2*dprodnorm2[2]*fpair2; - fkcx = (delx*fsum - fp1[0] - fp2[0])*Tap - Vkc*dTap*delx/r; - fkcy = (dely*fsum - fp1[1] - fp2[1])*Tap - Vkc*dTap*dely/r; - fkcz = (delz*fsum - fp1[2] - fp2[2])*Tap - Vkc*dTap*delz/r; + if (elements) { + for (i = 0; i < nelements; i++) delete [] elements[i]; + delete [] elements; + } + elements = new char*[atom->ntypes]; + for (i = 0; i < atom->ntypes; i++) elements[i] = NULL; - f[i][0] += fkcx - fprod1[0]*Tap; - f[i][1] += fkcy - fprod1[1]*Tap; - f[i][2] += fkcz - fprod1[2]*Tap; - f[j][0] -= fkcx + fprod2[0]*Tap; - f[j][1] -= fkcy + fprod2[1]*Tap; - f[j][2] -= fkcz + fprod2[2]*Tap; + nelements = 0; + for (i = 3; i < narg; i++) { + if (strcmp(arg[i],"NULL") == 0) { + map[i-2] = -1; + continue; + } + for (j = 0; j < nelements; j++) + if (strcmp(arg[i],elements[j]) == 0) break; + map[i-2] = j; + if (j == nelements) { + n = strlen(arg[i]) + 1; + elements[j] = new char[n]; + strcpy(elements[j],arg[i]); + nelements++; + } + } - // calculate the forces acted on the neighbors of atom i from atom j - KC_neighs_i = KC_firstneigh[i]; - for (kk = 0; kk < KC_numneigh[i]; kk++) { - k = KC_neighs_i[kk]; - if (k == i) continue; - // derivatives of the product of rij and ni respect to rk, k=0,1,2, where atom k is the neighbors of atom i - dprodnorm1[0] = dnormal[0][0][kk][i]*delx + dnormal[1][0][kk][i]*dely + dnormal[2][0][kk][i]*delz; - dprodnorm1[1] = dnormal[0][1][kk][i]*delx + dnormal[1][1][kk][i]*dely + dnormal[2][1][kk][i]*delz; - dprodnorm1[2] = dnormal[0][2][kk][i]*delx + dnormal[1][2][kk][i]*dely + dnormal[2][2][kk][i]*delz; - fk[0] = (-prodnorm1*dprodnorm1[0]*fpair1)*Tap; - fk[1] = (-prodnorm1*dprodnorm1[1]*fpair1)*Tap; - fk[2] = (-prodnorm1*dprodnorm1[2]*fpair1)*Tap; - f[k][0] += fk[0]; - f[k][1] += fk[1]; - f[k][2] += fk[2]; - delkj[0] = x[k][0] - x[j][0]; - delkj[1] = x[k][1] - x[j][1]; - delkj[2] = x[k][2] - x[j][2]; - if (evflag) ev_tally_xyz(k,j,nlocal,newton_pair,0.0,0.0,fk[0],fk[1],fk[2],delkj[0],delkj[1],delkj[2]); - } - // calculate the forces acted on the neighbors of atom j from atom i - KC_neighs_j = KC_firstneigh[j]; - for (ll = 0; ll < KC_numneigh[j]; ll++) { - l = KC_neighs_j[ll]; - if (l == j) continue; - // derivatives of the product of rji and nj respect to rl, l=0,1,2, where atom l is the neighbors of atom j - dprodnorm2[0] = dnormal[0][0][ll][j]*delx + dnormal[1][0][ll][j]*dely + dnormal[2][0][ll][j]*delz; - dprodnorm2[1] = dnormal[0][1][ll][j]*delx + dnormal[1][1][ll][j]*dely + dnormal[2][1][ll][j]*delz; - dprodnorm2[2] = dnormal[0][2][ll][j]*delx + dnormal[1][2][ll][j]*dely + dnormal[2][2][ll][j]*delz; - fl[0] = (-prodnorm2*dprodnorm2[0]*fpair2)*Tap; - fl[1] = (-prodnorm2*dprodnorm2[1]*fpair2)*Tap; - fl[2] = (-prodnorm2*dprodnorm2[2]*fpair2)*Tap; - f[l][0] += fl[0]; - f[l][1] += fl[1]; - f[l][2] += fl[2]; - delli[0] = x[l][0] - x[i][0]; - delli[1] = x[l][1] - x[i][1]; - delli[2] = x[l][2] - x[i][2]; - if (evflag) ev_tally_xyz(l,i,nlocal,newton_pair,0.0,0.0,fl[0],fl[1],fl[2],delli[0],delli[1],delli[2]); - } + read_file(arg[2]); - if (eflag) { - if (tap_flag) evdwl = Tap*Vkc; - else evdwl = Vkc - offset[itype][jtype]; - } + // clear setflag since coeff() called once with I,J = * * + + n = atom->ntypes; + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; - if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair,evdwl,0,fkcx,fkcy,fkcz,delx,dely,delz); + // set setflag i,j for type pairs where both are mapped to elements + + int count = 0; + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + if (map[i] >= 0 && map[j] >= 0) { + setflag[i][j] = 1; + cut[i][j] = cut_global; + count++; } - } - } - if (vflag_fdotr) virial_fdotr_compute(); + + if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); } + /* ---------------------------------------------------------------------- - Calculate the normals for each atom + init for one type pair i,j and corresponding j,i ------------------------------------------------------------------------- */ -void PairKolmogorovCrespiFull::calc_normal() -{ - int i,j,ii,jj,inum,jnum; - int cont,id,ip,m; - double nn,xtp,ytp,ztp,delx,dely,delz,nn2; - int *ilist,*jlist; - double pv12[3],pv31[3],pv23[3],n1[3],dni[3],dnn[3][3],vet[3][3],dpvdri[3][3]; - double dn1[3][3][3],dpv12[3][3][3],dpv23[3][3][3],dpv31[3][3][3]; - double **x = atom->x; +double PairKolmogorovCrespiFull::init_one(int i, int j) +{ + if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); + if (!offset_flag) + error->all(FLERR,"Must use 'pair_modify shift yes' with this pair style"); - // grow normal array if necessary + if (offset_flag && (cut[i][j] > 0.0)) { + int iparam_ij = elem2param[map[i]][map[j]]; + Param& p = params[iparam_ij]; + offset[i][j] = -p.A*pow(p.z0/cut[i][j],6); + } else offset[i][j] = 0.0; + offset[j][i] = offset[i][j]; - if (atom->nmax > nmax) { - memory->destroy(normal); - memory->destroy(dnormal); - memory->destroy(dnormdri); - nmax = atom->nmax; - memory->create(normal,nmax,3,"KolmogorovCrespiFull:normal"); - memory->create(dnormdri,3,3,nmax,"KolmogorovCrespiFull:dnormdri"); - memory->create(dnormal,3,3,3,nmax,"KolmogorovCrespiFull:dnormal"); - } + return cut[i][j]; +} - inum = list->inum; - ilist = list->ilist; - //Calculate normals - for (ii = 0; ii < inum; ii++) { - i = ilist[ii]; - xtp = x[i][0]; - ytp = x[i][1]; - ztp = x[i][2]; +/* ---------------------------------------------------------------------- + read Kolmogorov-Crespi potential file +------------------------------------------------------------------------- */ - // Initialize the arrays - for (id = 0; id < 3; id++){ - pv12[id] = 0.0; - pv31[id] = 0.0; - pv23[id] = 0.0; - n1[id] = 0.0; - dni[id] = 0.0; - normal[i][id] = 0.0; - for (ip = 0; ip < 3; ip++){ - vet[ip][id] = 0.0; - dnn[ip][id] = 0.0; - dpvdri[ip][id] = 0.0; - dnormdri[ip][id][i] = 0.0; - for (m = 0; m < 3; m++){ - dpv12[ip][id][m] = 0.0; - dpv31[ip][id][m] = 0.0; - dpv23[ip][id][m] = 0.0; - dn1[ip][id][m] = 0.0; - dnormal[ip][id][m][i] = 0.0; - } - } - } +void PairKolmogorovCrespiFull::read_file(char *filename) +{ + int params_per_line = 12; + char **words = new char*[params_per_line+1]; + memory->sfree(params); + params = NULL; + nparams = maxparam = 0; - cont = 0; - jlist = KC_firstneigh[i]; - jnum = KC_numneigh[i]; - for (jj = 0; jj < jnum; jj++) { - j = jlist[jj]; - j &= NEIGHMASK; + // open file on proc 0 - delx = x[j][0] - xtp; - dely = x[j][1] - ytp; - delz = x[j][2] - ztp; - vet[cont][0] = delx; - vet[cont][1] = dely; - vet[cont][2] = delz; - cont++; + FILE *fp; + if (comm->me == 0) { + fp = force->open_potential(filename); + if (fp == NULL) { + char str[128]; + snprintf(str,128,"Cannot open KC potential file %s",filename); + error->one(FLERR,str); } + } - if (cont <= 1) { - normal[i][0] = 0.0; - normal[i][1] = 0.0; - normal[i][2] = 1.0; - // derivatives of normal vector is zero - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormdri[id][ip][i] = 0.0; - for (m = 0; m < 3; m++){ - dnormal[id][ip][m][i] = 0.0; - } - } - } - } - else if (cont == 2) { - // for the atoms at the edge who has only two neighbor atoms - pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; - pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; - pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; - dpvdri[0][0] = 0.0; - dpvdri[0][1] = vet[0][2]-vet[1][2]; - dpvdri[0][2] = vet[1][1]-vet[0][1]; - dpvdri[1][0] = vet[1][2]-vet[0][2]; - dpvdri[1][1] = 0.0; - dpvdri[1][2] = vet[0][0]-vet[1][0]; - dpvdri[2][0] = vet[0][1]-vet[1][1]; - dpvdri[2][1] = vet[1][0]-vet[0][0]; - dpvdri[2][2] = 0.0; + // read each line out of file, skipping blank lines or leading '#' + // store line of params if all 3 element tags are in element list - // derivatives respect to the first neighbor, atom k - dpv12[0][0][0] = 0.0; - dpv12[0][1][0] = vet[1][2]; - dpv12[0][2][0] = -vet[1][1]; - dpv12[1][0][0] = -vet[1][2]; - dpv12[1][1][0] = 0.0; - dpv12[1][2][0] = vet[1][0]; - dpv12[2][0][0] = vet[1][1]; - dpv12[2][1][0] = -vet[1][0]; - dpv12[2][2][0] = 0.0; + int i,j,n,m,nwords,ielement,jelement; + char line[MAXLINE],*ptr; + int eof = 0; - // derivatives respect to the second neighbor, atom l - dpv12[0][0][1] = 0.0; - dpv12[0][1][1] = -vet[0][2]; - dpv12[0][2][1] = vet[0][1]; - dpv12[1][0][1] = vet[0][2]; - dpv12[1][1][1] = 0.0; - dpv12[1][2][1] = -vet[0][0]; - dpv12[2][0][1] = -vet[0][1]; - dpv12[2][1][1] = vet[0][0]; - dpv12[2][2][1] = 0.0; + while (1) { + if (comm->me == 0) { + ptr = fgets(line,MAXLINE,fp); + if (ptr == NULL) { + eof = 1; + fclose(fp); + } else n = strlen(line) + 1; + } + MPI_Bcast(&eof,1,MPI_INT,0,world); + if (eof) break; + MPI_Bcast(&n,1,MPI_INT,0,world); + MPI_Bcast(line,n,MPI_CHAR,0,world); - // derivatives respect to the third neighbor, atom n - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv12[id][ip][2] = 0.0; - } - } + // strip comment, skip line if blank - n1[0] = pv12[0]; - n1[1] = pv12[1]; - n1[2] = pv12[2]; - // the magnitude of the normal vector - nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; - nn = sqrt(nn2); - if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); - // the unit normal vector - normal[i][0] = n1[0]/nn; - normal[i][1] = n1[1]/nn; - normal[i][2] = n1[2]/nn; - // derivatives of nn, dnn:3x1 vector - dni[0] = (n1[0]*dpvdri[0][0] + n1[1]*dpvdri[1][0] + n1[2]*dpvdri[2][0])/nn; - dni[1] = (n1[0]*dpvdri[0][1] + n1[1]*dpvdri[1][1] + n1[2]*dpvdri[2][1])/nn; - dni[2] = (n1[0]*dpvdri[0][2] + n1[1]*dpvdri[1][2] + n1[2]*dpvdri[2][2])/nn; - // derivatives of unit vector ni respect to ri, the result is 3x3 matrix - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormdri[id][ip][i] = dpvdri[id][ip]/nn - n1[id]*dni[ip]/nn2; - } - } + if ((ptr = strchr(line,'#'))) *ptr = '\0'; + nwords = atom->count_words(line); + if (nwords == 0) continue; - // derivatives of non-normalized normal vector, dn1:3x3x3 array - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - for (m = 0; m < 3; m++){ - dn1[id][ip][m] = dpv12[id][ip][m]; - } - } - } - // derivatives of nn, dnn:3x3 vector - // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 - // r[id][m]: the id's component of atom m - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; - } - } - // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 - // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; - } - } + // concatenate additional lines until have params_per_line words + + while (nwords < params_per_line) { + n = strlen(line); + if (comm->me == 0) { + ptr = fgets(&line[n],MAXLINE-n,fp); + if (ptr == NULL) { + eof = 1; + fclose(fp); + } else n = strlen(line) + 1; } + MPI_Bcast(&eof,1,MPI_INT,0,world); + if (eof) break; + MPI_Bcast(&n,1,MPI_INT,0,world); + MPI_Bcast(line,n,MPI_CHAR,0,world); + if ((ptr = strchr(line,'#'))) *ptr = '\0'; + nwords = atom->count_words(line); } -//############################################################################################## - else if(cont == 3) { - // for the atoms at the edge who has only two neighbor atoms - pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; - pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; - pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; - // derivatives respect to the first neighbor, atom k - dpv12[0][0][0] = 0.0; - dpv12[0][1][0] = vet[1][2]; - dpv12[0][2][0] = -vet[1][1]; - dpv12[1][0][0] = -vet[1][2]; - dpv12[1][1][0] = 0.0; - dpv12[1][2][0] = vet[1][0]; - dpv12[2][0][0] = vet[1][1]; - dpv12[2][1][0] = -vet[1][0]; - dpv12[2][2][0] = 0.0; - // derivatives respect to the second neighbor, atom l - dpv12[0][0][1] = 0.0; - dpv12[0][1][1] = -vet[0][2]; - dpv12[0][2][1] = vet[0][1]; - dpv12[1][0][1] = vet[0][2]; - dpv12[1][1][1] = 0.0; - dpv12[1][2][1] = -vet[0][0]; - dpv12[2][0][1] = -vet[0][1]; - dpv12[2][1][1] = vet[0][0]; - dpv12[2][2][1] = 0.0; + if (nwords != params_per_line) + error->all(FLERR,"Insufficient format in KC potential file"); - // derivatives respect to the third neighbor, atom n - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv12[id][ip][2] = 0.0; - } - } + // words = ptrs to all words in line - pv31[0] = vet[2][1]*vet[0][2] - vet[0][1]*vet[2][2]; - pv31[1] = vet[2][2]*vet[0][0] - vet[0][2]*vet[2][0]; - pv31[2] = vet[2][0]*vet[0][1] - vet[0][0]*vet[2][1]; - // derivatives respect to the first neighbor, atom k - dpv31[0][0][0] = 0.0; - dpv31[0][1][0] = -vet[2][2]; - dpv31[0][2][0] = vet[2][1]; - dpv31[1][0][0] = vet[2][2]; - dpv31[1][1][0] = 0.0; - dpv31[1][2][0] = -vet[2][0]; - dpv31[2][0][0] = -vet[2][1]; - dpv31[2][1][0] = vet[2][0]; - dpv31[2][2][0] = 0.0; - // derivatives respect to the third neighbor, atom n - dpv31[0][0][2] = 0.0; - dpv31[0][1][2] = vet[0][2]; - dpv31[0][2][2] = -vet[0][1]; - // derivatives of pv13[1] to rn - dpv31[1][0][2] = -vet[0][2]; - dpv31[1][1][2] = 0.0; - dpv31[1][2][2] = vet[0][0]; - // derivatives of pv13[2] to rn - dpv31[2][0][2] = vet[0][1]; - dpv31[2][1][2] = -vet[0][0]; - dpv31[2][2][2] = 0.0; + nwords = 0; + words[nwords++] = strtok(line," \t\n\r\f"); + while ((words[nwords++] = strtok(NULL," \t\n\r\f"))) continue; - // derivatives respect to the second neighbor, atom l - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv31[id][ip][1] = 0.0; - } - } + // ielement,jelement = 1st args + // if these 2 args are in element list, then parse this line + // else skip to next line (continue) - pv23[0] = vet[1][1]*vet[2][2] - vet[2][1]*vet[1][2]; - pv23[1] = vet[1][2]*vet[2][0] - vet[2][2]*vet[1][0]; - pv23[2] = vet[1][0]*vet[2][1] - vet[2][0]*vet[1][1]; - // derivatives respect to the second neighbor, atom k - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dpv23[id][ip][0] = 0.0; - } - } - // derivatives respect to the second neighbor, atom l - dpv23[0][0][1] = 0.0; - dpv23[0][1][1] = vet[2][2]; - dpv23[0][2][1] = -vet[2][1]; - dpv23[1][0][1] = -vet[2][2]; - dpv23[1][1][1] = 0.0; - dpv23[1][2][1] = vet[2][0]; - dpv23[2][0][1] = vet[2][1]; - dpv23[2][1][1] = -vet[2][0]; - dpv23[2][2][1] = 0.0; - // derivatives respect to the third neighbor, atom n - dpv23[0][0][2] = 0.0; - dpv23[0][1][2] = -vet[1][2]; - dpv23[0][2][2] = vet[1][1]; - dpv23[1][0][2] = vet[1][2]; - dpv23[1][1][2] = 0.0; - dpv23[1][2][2] = -vet[1][0]; - dpv23[2][0][2] = -vet[1][1]; - dpv23[2][1][2] = vet[1][0]; - dpv23[2][2][2] = 0.0; + for (ielement = 0; ielement < nelements; ielement++) + if (strcmp(words[0],elements[ielement]) == 0) break; + if (ielement == nelements) continue; + for (jelement = 0; jelement < nelements; jelement++) + if (strcmp(words[1],elements[jelement]) == 0) break; + if (jelement == nelements) continue; -//############################################################################################ - // average the normal vectors by using the 3 neighboring planes - n1[0] = (pv12[0] + pv31[0] + pv23[0])/cont; - n1[1] = (pv12[1] + pv31[1] + pv23[1])/cont; - n1[2] = (pv12[2] + pv31[2] + pv23[2])/cont; - // the magnitude of the normal vector - nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; - nn = sqrt(nn2); - if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); - // the unit normal vector - normal[i][0] = n1[0]/nn; - normal[i][1] = n1[1]/nn; - normal[i][2] = n1[2]/nn; + // load up parameter settings and error check their values - // for the central atoms, dnormdri is always zero - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormdri[id][ip][i] = 0.0; - } - } // end of derivatives of normals respect to atom i + if (nparams == maxparam) { + maxparam += DELTA; + params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), + "pair:params"); + } - // derivatives of non-normalized normal vector, dn1:3x3x3 array - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - for (m = 0; m < 3; m++){ - dn1[id][ip][m] = (dpv12[id][ip][m] + dpv23[id][ip][m] + dpv31[id][ip][m])/cont; - } - } - } - // derivatives of nn, dnn:3x3 vector - // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 - // r[id][m]: the id's component of atom m - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; - } - } - // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 - // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 - for (m = 0; m < 3; m++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; - } + params[nparams].ielement = ielement; + params[nparams].jelement = jelement; + params[nparams].z0 = atof(words[2]); + params[nparams].C0 = atof(words[3]); + params[nparams].C2 = atof(words[4]); + params[nparams].C4 = atof(words[5]); + params[nparams].C = atof(words[6]); + params[nparams].delta = atof(words[7]); + params[nparams].lambda = atof(words[8]); + params[nparams].A = atof(words[9]); + // S provides a convenient scaling of all energies + params[nparams].S = atof(words[10]); + params[nparams].rcut = atof(words[11]); + + // energies in meV further scaled by S + double meV = 1.0e-3*params[nparams].S; + params[nparams].C *= meV; + params[nparams].A *= meV; + params[nparams].C0 *= meV; + params[nparams].C2 *= meV; + params[nparams].C4 *= meV; + + // precompute some quantities + params[nparams].delta2inv = pow(params[nparams].delta,-2); + params[nparams].z06 = pow(params[nparams].z0,6); + + nparams++; + //if(nparams >= pow(atom->ntypes,3)) break; + } + memory->destroy(elem2param); + memory->destroy(cutKCsq); + memory->create(elem2param,nelements,nelements,"pair:elem2param"); + memory->create(cutKCsq,nelements,nelements,"pair:cutKCsq"); + for (i = 0; i < nelements; i++) { + for (j = 0; j < nelements; j++) { + n = -1; + for (m = 0; m < nparams; m++) { + if (i == params[m].ielement && j == params[m].jelement) { + if (n >= 0) error->all(FLERR,"Potential file has duplicate entry"); + n = m; } } + if (n < 0) error->all(FLERR,"Potential file is missing an entry"); + elem2param[i][j] = n; + cutKCsq[i][j] = params[n].rcut*params[n].rcut; } - else { - error->one(FLERR,"There are too many neighbors for calculating normals"); - } - -//############################################################################################## } + delete [] words; } /* ---------------------------------------------------------------------- init specific to this pair style ------------------------------------------------------------------------- */ -void PairKolmogorovCrespiFull::init_style() -{ - if (force->newton_pair == 0) - error->all(FLERR,"Pair style kolmolgorov/crespi/full requires newton pair on"); - if (!atom->molecule_flag) - error->all(FLERR,"Pair style kolmolgorov/crespi/full requires atom attribute molecule"); +void PairKolmogorovCrespiFull::init_style() +{ + if (force->newton_pair == 0) + error->all(FLERR,"Pair style kolmolgorov/crespi/full requires newton pair on"); + if (!atom->molecule_flag) + error->all(FLERR,"Pair style kolmolgorov/crespi/full requires atom attribute molecule"); + + // need a full neighbor list, including neighbors of ghosts + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->ghost = 1; + + // local KC neighbor list + // create pages if first time or if neighbor pgsize/oneatom has changed + + int create = 0; + if (ipage == NULL) create = 1; + if (pgsize != neighbor->pgsize) create = 1; + if (oneatom != neighbor->oneatom) create = 1; + + if (create) { + delete [] ipage; + pgsize = neighbor->pgsize; + oneatom = neighbor->oneatom; + + int nmypage= comm->nthreads; + ipage = new MyPage[nmypage]; + for (int i = 0; i < nmypage; i++) + ipage[i].init(oneatom,pgsize,PGDELTA); + } +} + +/* ---------------------------------------------------------------------- */ + +void PairKolmogorovCrespiFull::compute(int eflag, int vflag) +{ + ev_init(eflag,vflag); + pvector[0] = pvector[1] = 0.0; + + // Build full neighbor list + KC_neigh(); + // Calculate the normals and its derivatives + calc_normal(); + // Calculate the van der Waals force and energy + calc_FvdW(eflag,vflag); + // Calculate the repulsive force and energy + calc_FRep(eflag,vflag); + + if (vflag_fdotr) virial_fdotr_compute(); +} + +/* ---------------------------------------------------------------------- + van der Waals forces and energy +------------------------------------------------------------------------- */ + +void PairKolmogorovCrespiFull::calc_FvdW(int eflag, int vflag) +{ + int i,j,ii,jj,inum,jnum,itype,jtype,k,l,kk,ll; + tagint itag,jtag; + double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair; + double rsq,r,Rcut,r2inv,r6inv,r8inv,Tap,dTap,Vkc,fsum; + int *ilist,*jlist,*numneigh,**firstneigh; + + evdwl = 0.0; + double **x = atom->x; + double **f = atom->f; + int *type = atom->type; + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + int newton_pair = force->newton_pair; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // loop over neighbors of my atoms + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + itype = type[i]; + itag = tag[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + jtype = type[j]; + jtag = tag[j]; - // need a full neighbor list, including neighbors of ghosts + // two-body interactions from full neighbor list, skip half of them + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) continue; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) continue; + } else { + if (x[j][2] < ztmp) continue; + if (x[j][2] == ztmp && x[j][1] < ytmp) continue; + if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; + } - int irequest = neighbor->request(this,instance_me); - neighbor->requests[irequest]->half = 0; - neighbor->requests[irequest]->full = 1; - neighbor->requests[irequest]->ghost = 1; + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; - // local KC neighbor list - // create pages if first time or if neighbor pgsize/oneatom has changed + // only include the interation between different layers + if (rsq < cutsq[itype][jtype] && atom->molecule[i] != atom->molecule[j]) { - int create = 0; - if (ipage == NULL) create = 1; - if (pgsize != neighbor->pgsize) create = 1; - if (oneatom != neighbor->oneatom) create = 1; + int iparam_ij = elem2param[map[itype]][map[jtype]]; + Param& p = params[iparam_ij]; - if (create) { - delete [] ipage; - pgsize = neighbor->pgsize; - oneatom = neighbor->oneatom; + r = sqrt(rsq); + r2inv = 1.0/rsq; + r6inv = r2inv*r2inv*r2inv; + r8inv = r6inv*r2inv; + // turn on/off taper function + if (tap_flag) { + Rcut = sqrt(cutsq[itype][jtype]); + Tap = calc_Tap(r,Rcut); + dTap = calc_dTap(r,Rcut); + } else {Tap = 1.0; dTap = 0.0;} - int nmypage= comm->nthreads; - ipage = new MyPage[nmypage]; - for (int i = 0; i < nmypage; i++) - ipage[i].init(oneatom,pgsize,PGDELTA); + Vkc = -p.A*p.z06*r6inv; + + // derivatives + fpair = -6.0*p.A*p.z06*r8inv; + fsum = fpair*Tap - Vkc*dTap/r; + + f[i][0] += fsum*delx; + f[i][1] += fsum*dely; + f[i][2] += fsum*delz; + f[j][0] -= fsum*delx; + f[j][1] -= fsum*dely; + f[j][2] -= fsum*delz; + + if (eflag) pvector[0] += evdwl = Vkc*Tap; + if (evflag) ev_tally(i,j,nlocal,newton_pair, + evdwl,0.0,fsum,delx,dely,delz); + } + } } } - -/* ---------------------------------------------------------------------- - create neighbor list from main neighbor list for calculating the normals +/* ---------------------------------------------------------------------- + Repulsive forces and energy ------------------------------------------------------------------------- */ -void PairKolmogorovCrespiFull::KC_neigh() +void PairKolmogorovCrespiFull::calc_FRep(int eflag, int vflag) { - int i,j,ii,jj,n,allnum,jnum,itype,jtype; - double xtmp,ytmp,ztmp,delx,dely,delz,rsq; + int i,j,ii,jj,inum,jnum,itype,jtype,k,kk; + double prodnorm1,fkcx,fkcy,fkcz; + double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair,fpair1; + double rsq,r,rhosq1,exp0,exp1,r2inv,r6inv,r8inv,Tap,dTap,Vkc; + double frho_ij,sumC1,sumC11,sumCff,fsum,rho_ij; int *ilist,*jlist,*numneigh,**firstneigh; - int *neighptr; + int *KC_neighs_i,*KC_neighs_j; + + evdwl = 0.0; double **x = atom->x; + double **f = atom->f; int *type = atom->type; + int nlocal = atom->nlocal; + int newton_pair = force->newton_pair; + double dprodnorm1[3] = {0.0, 0.0, 0.0}; + double fp1[3] = {0.0, 0.0, 0.0}; + double fprod1[3] = {0.0, 0.0, 0.0}; + double delkj[3] = {0.0, 0.0, 0.0}; + double fk[3] = {0.0, 0.0, 0.0}; - if (atom->nmax > maxlocal) { - maxlocal = atom->nmax; - memory->destroy(KC_numneigh); - memory->sfree(KC_firstneigh); - memory->create(KC_numneigh,maxlocal,"KolmogorovCrespiFull:numneigh"); - KC_firstneigh = (int **) memory->smalloc(maxlocal*sizeof(int *), - "KolmogorovCrespiFull:firstneigh"); - } - - allnum = list->inum + list->gnum; + inum = list->inum; ilist = list->ilist; numneigh = list->numneigh; firstneigh = list->firstneigh; - // store all KC neighs of owned and ghost atoms - // scan full neighbor list of I - - ipage->reset(); - - for (ii = 0; ii < allnum; ii++) { + //calculate exp(-lambda*(r-z0))*[epsilon/2 + f(rho_ij)] + // loop over neighbors of owned atoms + for (ii = 0; ii < inum; ii++) { i = ilist[ii]; - - n = 0; - neighptr = ipage->vget(); - + if (KC_numneigh[i] == -1) { + continue; + } xtmp = x[i][0]; ytmp = x[i][1]; ztmp = x[i][2]; - itype = map[type[i]]; + itype = type[i]; jlist = firstneigh[i]; jnum = numneigh[i]; for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; - jtype = map[type[j]]; + if (KC_numneigh[j] == -1) { + continue; + } + jtype = type[j]; + delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; rsq = delx*delx + dely*dely + delz*delz; - if (rsq != 0 && rsq < cutKCsq[itype][jtype] && atom->molecule[i] == atom->molecule[j]) { - neighptr[n++] = j; - } - } - - KC_firstneigh[i] = neighptr; - KC_numneigh[i] = n; - if (n > 3) error->one(FLERR,"There are too many neighbors for some atoms, please check your configuration"); - ipage->vgot(n); - if (ipage->status()) - error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); - } -} - + // only include the interation between different layers + if (rsq < cutsq[itype][jtype] && atom->molecule[i] != atom->molecule[j]) { -/* ---------------------------------------------------------------------- - allocate all arrays -------------------------------------------------------------------------- */ + int iparam_ij = elem2param[map[itype]][map[jtype]]; + Param& p = params[iparam_ij]; -void PairKolmogorovCrespiFull::allocate() -{ - allocated = 1; - int n = atom->ntypes; + r = sqrt(rsq); + r2inv = 1.0/rsq; + r6inv = r2inv*r2inv*r2inv; + r8inv = r2inv*r6inv; + // turn on/off taper function + if (tap_flag) { + Tap = calc_Tap(r,sqrt(cutsq[itype][jtype])); + dTap = calc_dTap(r,sqrt(cutsq[itype][jtype])); + } else {Tap = 1.0; dTap = 0.0;} - memory->create(setflag,n+1,n+1,"pair:setflag"); - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; + // Calculate the transverse distance + prodnorm1 = normal[i][0]*delx + normal[i][1]*dely + normal[i][2]*delz; + rhosq1 = rsq - prodnorm1*prodnorm1; // rho_ij + rho_ij = rhosq1*p.delta2inv; // (rho_ij/delta)^2 - memory->create(cutsq,n+1,n+1,"pair:cutsq"); - memory->create(cut,n+1,n+1,"pair:cut"); - memory->create(offset,n+1,n+1,"pair:offset"); - map = new int[atom->ntypes+1]; -} + // store exponents + exp0 = exp(-p.lambda*(r-p.z0)); + exp1 = exp(-rho_ij); -/* ---------------------------------------------------------------------- - global settings -------------------------------------------------------------------------- */ + sumC1 = p.C0 + p.C2*rho_ij + p.C4*rho_ij*rho_ij; + sumC11 = (p.C2 + 2.0*p.C4*rho_ij)*p.delta2inv; + frho_ij = exp1*sumC1; + sumCff = 0.5*p.C + frho_ij; + Vkc = exp0*sumCff; -void PairKolmogorovCrespiFull::settings(int narg, char **arg) -{ - if (narg < 1 || narg > 2) error->all(FLERR,"Illegal pair_style command"); - if (strcmp(force->pair_style,"hybrid/overlay")!=0) - error->all(FLERR,"ERROR: requires hybrid/overlay pair_style"); + // derivatives + fpair = p.lambda*exp0/r*sumCff; + fpair1 = 2.0*exp0*exp1*(p.delta2inv*sumC1 - sumC11); + fsum = fpair + fpair1; + // derivatives of the product of rij and ni, the result is a vector + dprodnorm1[0] = dnormdri[0][0][i]*delx + dnormdri[1][0][i]*dely + dnormdri[2][0][i]*delz; + dprodnorm1[1] = dnormdri[0][1][i]*delx + dnormdri[1][1][i]*dely + dnormdri[2][1][i]*delz; + dprodnorm1[2] = dnormdri[0][2][i]*delx + dnormdri[1][2][i]*dely + dnormdri[2][2][i]*delz; + fp1[0] = prodnorm1*normal[i][0]*fpair1; + fp1[1] = prodnorm1*normal[i][1]*fpair1; + fp1[2] = prodnorm1*normal[i][2]*fpair1; + fprod1[0] = prodnorm1*dprodnorm1[0]*fpair1; + fprod1[1] = prodnorm1*dprodnorm1[1]*fpair1; + fprod1[2] = prodnorm1*dprodnorm1[2]*fpair1; + fkcx = (delx*fsum - fp1[0])*Tap - Vkc*dTap*delx/r; + fkcy = (dely*fsum - fp1[1])*Tap - Vkc*dTap*dely/r; + fkcz = (delz*fsum - fp1[2])*Tap - Vkc*dTap*delz/r; - cut_global = force->numeric(FLERR,arg[0]); - if (narg == 2) tap_flag = force->numeric(FLERR,arg[1]); + f[i][0] += fkcx - fprod1[0]*Tap; + f[i][1] += fkcy - fprod1[1]*Tap; + f[i][2] += fkcz - fprod1[2]*Tap; + f[j][0] -= fkcx; + f[j][1] -= fkcy; + f[j][2] -= fkcz; - // reset cutoffs that have been explicitly set + // calculate the forces acted on the neighbors of atom i from atom j + KC_neighs_i = KC_firstneigh[i]; + for (kk = 0; kk < KC_numneigh[i]; kk++) { + k = KC_neighs_i[kk]; + if (k == i) continue; + // derivatives of the product of rij and ni respect to rk, k=0,1,2, where atom k is the neighbors of atom i + dprodnorm1[0] = dnormal[0][0][kk][i]*delx + dnormal[1][0][kk][i]*dely + dnormal[2][0][kk][i]*delz; + dprodnorm1[1] = dnormal[0][1][kk][i]*delx + dnormal[1][1][kk][i]*dely + dnormal[2][1][kk][i]*delz; + dprodnorm1[2] = dnormal[0][2][kk][i]*delx + dnormal[1][2][kk][i]*dely + dnormal[2][2][kk][i]*delz; + fk[0] = (-prodnorm1*dprodnorm1[0]*fpair1)*Tap; + fk[1] = (-prodnorm1*dprodnorm1[1]*fpair1)*Tap; + fk[2] = (-prodnorm1*dprodnorm1[2]*fpair1)*Tap; + f[k][0] += fk[0]; + f[k][1] += fk[1]; + f[k][2] += fk[2]; + delkj[0] = x[k][0] - x[j][0]; + delkj[1] = x[k][1] - x[j][1]; + delkj[2] = x[k][2] - x[j][2]; + if (evflag) ev_tally_xyz(k,j,nlocal,newton_pair,0.0,0.0,fk[0],fk[1],fk[2],delkj[0],delkj[1],delkj[2]); + } - if (allocated) { - int i,j; - for (i = 1; i <= atom->ntypes; i++) - for (j = i; j <= atom->ntypes; j++) - if (setflag[i][j]) cut[i][j] = cut_global; - } + if (eflag) { + if (tap_flag) pvector[1] += evdwl = Tap*Vkc; + else pvector[1] += evdwl = Vkc - offset[itype][jtype]; + } + if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair,evdwl,0.0,fkcx,fkcy,fkcz,delx,dely,delz); + } + } // loop over jj + } // loop over ii } /* ---------------------------------------------------------------------- - set coeffs for one or more type pairs + create neighbor list from main neighbor list for calculating the normals ------------------------------------------------------------------------- */ -void PairKolmogorovCrespiFull::coeff(int narg, char **arg) +void PairKolmogorovCrespiFull::KC_neigh() { - int i,j,n; - - if (narg != 3 + atom->ntypes) - error->all(FLERR,"Incorrect args for pair coefficients"); - if (!allocated) allocate(); - - // insure I,J args are * * - - if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) - error->all(FLERR,"Incorrect args for pair coefficients"); + int i,j,ii,jj,n,allnum,inum,jnum,itype,jtype; + double xtmp,ytmp,ztmp,delx,dely,delz,rsq; + int *ilist,*jlist,*numneigh,**firstneigh; + int *neighptr; - // read args that map atom types to elements in potential file - // map[i] = which element the Ith atom type is, -1 if NULL - // nelements = # of unique elements - // elements = list of element names + double **x = atom->x; + int *type = atom->type; - if (elements) { - for (i = 0; i < nelements; i++) delete [] elements[i]; - delete [] elements; + if (atom->nmax > maxlocal) { + maxlocal = atom->nmax; + memory->destroy(KC_numneigh); + memory->sfree(KC_firstneigh); + memory->create(KC_numneigh,maxlocal,"KolmogorovCrespiFull:numneigh"); + KC_firstneigh = (int **) memory->smalloc(maxlocal*sizeof(int *), + "KolmogorovCrespiFull:firstneigh"); } - elements = new char*[atom->ntypes]; - for (i = 0; i < atom->ntypes; i++) elements[i] = NULL; - nelements = 0; - for (i = 3; i < narg; i++) { - if (strcmp(arg[i],"NULL") == 0) { - map[i-2] = -1; - continue; - } - for (j = 0; j < nelements; j++) - if (strcmp(arg[i],elements[j]) == 0) break; - map[i-2] = j; - if (j == nelements) { - n = strlen(arg[i]) + 1; - elements[j] = new char[n]; - strcpy(elements[j],arg[i]); - nelements++; - } - } + inum = list->inum; + allnum = list->inum + list->gnum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + // store all KC neighs of owned and ghost atoms + // scan full neighbor list of I - read_file(arg[2]); + ipage->reset(); - // clear setflag since coeff() called once with I,J = * * + for (ii = 0; ii < allnum; ii++) { + i = ilist[ii]; - n = atom->ntypes; - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; + n = 0; + neighptr = ipage->vget(); - // set setflag i,j for type pairs where both are mapped to elements + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + itype = map[type[i]]; + jlist = firstneigh[i]; + jnum = numneigh[i]; - int count = 0; - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - if (map[i] >= 0 && map[j] >= 0) { - setflag[i][j] = 1; - cut[i][j] = cut_global; - count++; + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + jtype = map[type[j]]; + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; + + if (rsq != 0 && rsq < cutKCsq[itype][jtype] && atom->molecule[i] == atom->molecule[j]) { + neighptr[n++] = j; } + } - if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); -} + KC_firstneigh[i] = neighptr; + if (n == 3) { + KC_numneigh[i] = n; + } + else if (n < 3) { + if (i < inum) { + KC_numneigh[i] = n; + } else { + KC_numneigh[i] = -1; + } + } + else if (n > 3) error->one(FLERR,"There are too many neighbors for some atoms, please check your configuration"); + ipage->vgot(n); + if (ipage->status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } +} /* ---------------------------------------------------------------------- - init for one type pair i,j and corresponding j,i + Calculate the normals for each atom ------------------------------------------------------------------------- */ - -double PairKolmogorovCrespiFull::init_one(int i, int j) +void PairKolmogorovCrespiFull::calc_normal() { - if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - if (!offset_flag) - error->all(FLERR,"Must use 'pair_modify shift yes' with this pair style"); + int i,j,ii,jj,inum,jnum; + int cont,id,ip,m; + double nn,xtp,ytp,ztp,delx,dely,delz,nn2; + int *ilist,*jlist; + double pv12[3],pv31[3],pv23[3],n1[3],dni[3],dnn[3][3],vet[3][3],dpvdri[3][3]; + double dn1[3][3][3],dpv12[3][3][3],dpv23[3][3][3],dpv31[3][3][3]; - if (offset_flag && (cut[i][j] > 0.0)) { - int iparam_ij = elem2param[map[i]][map[j]]; - Param& p = params[iparam_ij]; - offset[i][j] = -p.A*pow(p.z0/cut[i][j],6); - } else offset[i][j] = 0.0; - offset[j][i] = offset[i][j]; + double **x = atom->x; - return cut[i][j]; -} + // grow normal array if necessary -/* ---------------------------------------------------------------------- - read Kolmogorov-Crespi potential file -------------------------------------------------------------------------- */ + if (atom->nmax > nmax) { + memory->destroy(normal); + memory->destroy(dnormal); + memory->destroy(dnormdri); + nmax = atom->nmax; + memory->create(normal,nmax,3,"KolmogorovCrespiFull:normal"); + memory->create(dnormdri,3,3,nmax,"KolmogorovCrespiFull:dnormdri"); + memory->create(dnormal,3,3,3,nmax,"KolmogorovCrespiFull:dnormal"); + } -void PairKolmogorovCrespiFull::read_file(char *filename) -{ - int params_per_line = 12; - char **words = new char*[params_per_line+1]; - memory->sfree(params); - params = NULL; - nparams = maxparam = 0; + inum = list->inum; + ilist = list->ilist; + //Calculate normals + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; - // open file on proc 0 + // Initialize the arrays + for (id = 0; id < 3; id++){ + pv12[id] = 0.0; + pv31[id] = 0.0; + pv23[id] = 0.0; + n1[id] = 0.0; + dni[id] = 0.0; + normal[i][id] = 0.0; + for (ip = 0; ip < 3; ip++){ + vet[ip][id] = 0.0; + dnn[ip][id] = 0.0; + dpvdri[ip][id] = 0.0; + dnormdri[ip][id][i] = 0.0; + for (m = 0; m < 3; m++){ + dpv12[ip][id][m] = 0.0; + dpv31[ip][id][m] = 0.0; + dpv23[ip][id][m] = 0.0; + dn1[ip][id][m] = 0.0; + dnormal[ip][id][m][i] = 0.0; + } + } + } - FILE *fp; - if (comm->me == 0) { - fp = force->open_potential(filename); - if (fp == NULL) { - char str[128]; - snprintf(str,128,"Cannot open KC potential file %s",filename); - error->one(FLERR,str); + if (KC_numneigh[i] == -1) { + continue; } - } + xtp = x[i][0]; + ytp = x[i][1]; + ztp = x[i][2]; - // read each line out of file, skipping blank lines or leading '#' - // store line of params if all 3 element tags are in element list + cont = 0; + jlist = KC_firstneigh[i]; + jnum = KC_numneigh[i]; + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; - int i,j,n,m,nwords,ielement,jelement; - char line[MAXLINE],*ptr; - int eof = 0; + delx = x[j][0] - xtp; + dely = x[j][1] - ytp; + delz = x[j][2] - ztp; + vet[cont][0] = delx; + vet[cont][1] = dely; + vet[cont][2] = delz; + cont++; + } - while (1) { - if (comm->me == 0) { - ptr = fgets(line,MAXLINE,fp); - if (ptr == NULL) { - eof = 1; - fclose(fp); - } else n = strlen(line) + 1; + if (cont <= 1) { + normal[i][0] = 0.0; + normal[i][1] = 0.0; + normal[i][2] = 1.0; + // derivatives of normal vector is zero + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormdri[id][ip][i] = 0.0; + for (m = 0; m < 3; m++){ + dnormal[id][ip][m][i] = 0.0; + } + } + } } - MPI_Bcast(&eof,1,MPI_INT,0,world); - if (eof) break; - MPI_Bcast(&n,1,MPI_INT,0,world); - MPI_Bcast(line,n,MPI_CHAR,0,world); + else if (cont == 2) { + // for the atoms at the edge who has only two neighbor atoms + pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; + pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; + pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; + dpvdri[0][0] = 0.0; + dpvdri[0][1] = vet[0][2]-vet[1][2]; + dpvdri[0][2] = vet[1][1]-vet[0][1]; + dpvdri[1][0] = vet[1][2]-vet[0][2]; + dpvdri[1][1] = 0.0; + dpvdri[1][2] = vet[0][0]-vet[1][0]; + dpvdri[2][0] = vet[0][1]-vet[1][1]; + dpvdri[2][1] = vet[1][0]-vet[0][0]; + dpvdri[2][2] = 0.0; - // strip comment, skip line if blank + // derivatives respect to the first neighbor, atom k + dpv12[0][0][0] = 0.0; + dpv12[0][1][0] = vet[1][2]; + dpv12[0][2][0] = -vet[1][1]; + dpv12[1][0][0] = -vet[1][2]; + dpv12[1][1][0] = 0.0; + dpv12[1][2][0] = vet[1][0]; + dpv12[2][0][0] = vet[1][1]; + dpv12[2][1][0] = -vet[1][0]; + dpv12[2][2][0] = 0.0; - if ((ptr = strchr(line,'#'))) *ptr = '\0'; - nwords = atom->count_words(line); - if (nwords == 0) continue; + // derivatives respect to the second neighbor, atom l + dpv12[0][0][1] = 0.0; + dpv12[0][1][1] = -vet[0][2]; + dpv12[0][2][1] = vet[0][1]; + dpv12[1][0][1] = vet[0][2]; + dpv12[1][1][1] = 0.0; + dpv12[1][2][1] = -vet[0][0]; + dpv12[2][0][1] = -vet[0][1]; + dpv12[2][1][1] = vet[0][0]; + dpv12[2][2][1] = 0.0; - // concatenate additional lines until have params_per_line words + // derivatives respect to the third neighbor, atom n + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv12[id][ip][2] = 0.0; + } + } - while (nwords < params_per_line) { - n = strlen(line); - if (comm->me == 0) { - ptr = fgets(&line[n],MAXLINE-n,fp); - if (ptr == NULL) { - eof = 1; - fclose(fp); - } else n = strlen(line) + 1; + n1[0] = pv12[0]; + n1[1] = pv12[1]; + n1[2] = pv12[2]; + // the magnitude of the normal vector + nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; + nn = sqrt(nn2); + if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); + // the unit normal vector + normal[i][0] = n1[0]/nn; + normal[i][1] = n1[1]/nn; + normal[i][2] = n1[2]/nn; + // derivatives of nn, dnn:3x1 vector + dni[0] = (n1[0]*dpvdri[0][0] + n1[1]*dpvdri[1][0] + n1[2]*dpvdri[2][0])/nn; + dni[1] = (n1[0]*dpvdri[0][1] + n1[1]*dpvdri[1][1] + n1[2]*dpvdri[2][1])/nn; + dni[2] = (n1[0]*dpvdri[0][2] + n1[1]*dpvdri[1][2] + n1[2]*dpvdri[2][2])/nn; + // derivatives of unit vector ni respect to ri, the result is 3x3 matrix + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormdri[id][ip][i] = dpvdri[id][ip]/nn - n1[id]*dni[ip]/nn2; + } + } + + // derivatives of non-normalized normal vector, dn1:3x3x3 array + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + for (m = 0; m < 3; m++){ + dn1[id][ip][m] = dpv12[id][ip][m]; + } + } + } + // derivatives of nn, dnn:3x3 vector + // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 + // r[id][m]: the id's component of atom m + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; + } + } + // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 + // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; + } + } } - MPI_Bcast(&eof,1,MPI_INT,0,world); - if (eof) break; - MPI_Bcast(&n,1,MPI_INT,0,world); - MPI_Bcast(line,n,MPI_CHAR,0,world); - if ((ptr = strchr(line,'#'))) *ptr = '\0'; - nwords = atom->count_words(line); } +//############################################################################################## - if (nwords != params_per_line) - error->all(FLERR,"Insufficient format in KC potential file"); - - // words = ptrs to all words in line - - nwords = 0; - words[nwords++] = strtok(line," \t\n\r\f"); - while ((words[nwords++] = strtok(NULL," \t\n\r\f"))) continue; - - // ielement,jelement = 1st args - // if these 2 args are in element list, then parse this line - // else skip to next line (continue) + else if(cont == 3) { + // for the atoms at the edge who has only two neighbor atoms + pv12[0] = vet[0][1]*vet[1][2] - vet[1][1]*vet[0][2]; + pv12[1] = vet[0][2]*vet[1][0] - vet[1][2]*vet[0][0]; + pv12[2] = vet[0][0]*vet[1][1] - vet[1][0]*vet[0][1]; + // derivatives respect to the first neighbor, atom k + dpv12[0][0][0] = 0.0; + dpv12[0][1][0] = vet[1][2]; + dpv12[0][2][0] = -vet[1][1]; + dpv12[1][0][0] = -vet[1][2]; + dpv12[1][1][0] = 0.0; + dpv12[1][2][0] = vet[1][0]; + dpv12[2][0][0] = vet[1][1]; + dpv12[2][1][0] = -vet[1][0]; + dpv12[2][2][0] = 0.0; + // derivatives respect to the second neighbor, atom l + dpv12[0][0][1] = 0.0; + dpv12[0][1][1] = -vet[0][2]; + dpv12[0][2][1] = vet[0][1]; + dpv12[1][0][1] = vet[0][2]; + dpv12[1][1][1] = 0.0; + dpv12[1][2][1] = -vet[0][0]; + dpv12[2][0][1] = -vet[0][1]; + dpv12[2][1][1] = vet[0][0]; + dpv12[2][2][1] = 0.0; - for (ielement = 0; ielement < nelements; ielement++) - if (strcmp(words[0],elements[ielement]) == 0) break; - if (ielement == nelements) continue; - for (jelement = 0; jelement < nelements; jelement++) - if (strcmp(words[1],elements[jelement]) == 0) break; - if (jelement == nelements) continue; + // derivatives respect to the third neighbor, atom n + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv12[id][ip][2] = 0.0; + } + } - // load up parameter settings and error check their values + pv31[0] = vet[2][1]*vet[0][2] - vet[0][1]*vet[2][2]; + pv31[1] = vet[2][2]*vet[0][0] - vet[0][2]*vet[2][0]; + pv31[2] = vet[2][0]*vet[0][1] - vet[0][0]*vet[2][1]; + // derivatives respect to the first neighbor, atom k + dpv31[0][0][0] = 0.0; + dpv31[0][1][0] = -vet[2][2]; + dpv31[0][2][0] = vet[2][1]; + dpv31[1][0][0] = vet[2][2]; + dpv31[1][1][0] = 0.0; + dpv31[1][2][0] = -vet[2][0]; + dpv31[2][0][0] = -vet[2][1]; + dpv31[2][1][0] = vet[2][0]; + dpv31[2][2][0] = 0.0; + // derivatives respect to the third neighbor, atom n + dpv31[0][0][2] = 0.0; + dpv31[0][1][2] = vet[0][2]; + dpv31[0][2][2] = -vet[0][1]; + // derivatives of pv13[1] to rn + dpv31[1][0][2] = -vet[0][2]; + dpv31[1][1][2] = 0.0; + dpv31[1][2][2] = vet[0][0]; + // derivatives of pv13[2] to rn + dpv31[2][0][2] = vet[0][1]; + dpv31[2][1][2] = -vet[0][0]; + dpv31[2][2][2] = 0.0; - if (nparams == maxparam) { - maxparam += DELTA; - params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), - "pair:params"); - } + // derivatives respect to the second neighbor, atom l + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv31[id][ip][1] = 0.0; + } + } - params[nparams].ielement = ielement; - params[nparams].jelement = jelement; - params[nparams].z0 = atof(words[2]); - params[nparams].C0 = atof(words[3]); - params[nparams].C2 = atof(words[4]); - params[nparams].C4 = atof(words[5]); - params[nparams].C = atof(words[6]); - params[nparams].delta = atof(words[7]); - params[nparams].lambda = atof(words[8]); - params[nparams].A = atof(words[9]); - // S provides a convenient scaling of all energies - params[nparams].S = atof(words[10]); - params[nparams].rcut = atof(words[11]); + pv23[0] = vet[1][1]*vet[2][2] - vet[2][1]*vet[1][2]; + pv23[1] = vet[1][2]*vet[2][0] - vet[2][2]*vet[1][0]; + pv23[2] = vet[1][0]*vet[2][1] - vet[2][0]*vet[1][1]; + // derivatives respect to the second neighbor, atom k + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dpv23[id][ip][0] = 0.0; + } + } + // derivatives respect to the second neighbor, atom l + dpv23[0][0][1] = 0.0; + dpv23[0][1][1] = vet[2][2]; + dpv23[0][2][1] = -vet[2][1]; + dpv23[1][0][1] = -vet[2][2]; + dpv23[1][1][1] = 0.0; + dpv23[1][2][1] = vet[2][0]; + dpv23[2][0][1] = vet[2][1]; + dpv23[2][1][1] = -vet[2][0]; + dpv23[2][2][1] = 0.0; + // derivatives respect to the third neighbor, atom n + dpv23[0][0][2] = 0.0; + dpv23[0][1][2] = -vet[1][2]; + dpv23[0][2][2] = vet[1][1]; + dpv23[1][0][2] = vet[1][2]; + dpv23[1][1][2] = 0.0; + dpv23[1][2][2] = -vet[1][0]; + dpv23[2][0][2] = -vet[1][1]; + dpv23[2][1][2] = vet[1][0]; + dpv23[2][2][2] = 0.0; - // energies in meV further scaled by S - double meV = 1.0e-3*params[nparams].S; - params[nparams].C *= meV; - params[nparams].A *= meV; - params[nparams].C0 *= meV; - params[nparams].C2 *= meV; - params[nparams].C4 *= meV; +//############################################################################################ + // average the normal vectors by using the 3 neighboring planes + n1[0] = (pv12[0] + pv31[0] + pv23[0])/cont; + n1[1] = (pv12[1] + pv31[1] + pv23[1])/cont; + n1[2] = (pv12[2] + pv31[2] + pv23[2])/cont; + // the magnitude of the normal vector + nn2 = n1[0]*n1[0] + n1[1]*n1[1] + n1[2]*n1[2]; + nn = sqrt(nn2); + if (nn == 0) error->one(FLERR,"The magnitude of the normal vector is zero"); + // the unit normal vector + normal[i][0] = n1[0]/nn; + normal[i][1] = n1[1]/nn; + normal[i][2] = n1[2]/nn; - // precompute some quantities - params[nparams].delta2inv = pow(params[nparams].delta,-2); - params[nparams].z06 = pow(params[nparams].z0,6); + // for the central atoms, dnormdri is always zero + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormdri[id][ip][i] = 0.0; + } + } // end of derivatives of normals respect to atom i - nparams++; - //if(nparams >= pow(atom->ntypes,3)) break; - } - memory->destroy(elem2param); - memory->destroy(cutKCsq); - memory->create(elem2param,nelements,nelements,"pair:elem2param"); - memory->create(cutKCsq,nelements,nelements,"pair:cutKCsq"); - for (i = 0; i < nelements; i++) { - for (j = 0; j < nelements; j++) { - n = -1; - for (m = 0; m < nparams; m++) { - if (i == params[m].ielement && j == params[m].jelement) { - if (n >= 0) error->all(FLERR,"Potential file has duplicate entry"); - n = m; + // derivatives of non-normalized normal vector, dn1:3x3x3 array + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + for (m = 0; m < 3; m++){ + dn1[id][ip][m] = (dpv12[id][ip][m] + dpv23[id][ip][m] + dpv31[id][ip][m])/cont; + } } } - if (n < 0) error->all(FLERR,"Potential file is missing an entry"); - elem2param[i][j] = n; - cutKCsq[i][j] = params[n].rcut*params[n].rcut; + // derivatives of nn, dnn:3x3 vector + // dnn[id][m]: the derivative of nn respect to r[id][m], id,m=0,1,2 + // r[id][m]: the id's component of atom m + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + dnn[id][m] = (n1[0]*dn1[0][id][m] + n1[1]*dn1[1][id][m] + n1[2]*dn1[2][id][m])/nn; + } + } + // dnormal[id][ip][m][i]: the derivative of normal[id] respect to r[ip][m], id,ip=0,1,2 + // for atom m, which is a neighbor atom of atom i, m=0,jnum-1 + for (m = 0; m < 3; m++){ + for (id = 0; id < 3; id++){ + for (ip = 0; ip < 3; ip++){ + dnormal[id][ip][m][i] = dn1[id][ip][m]/nn - n1[id]*dnn[ip][m]/nn2; + } + } + } + } + else { + error->one(FLERR,"There are too many neighbors for calculating normals"); } + +//############################################################################################## } - delete [] words; } /* ---------------------------------------------------------------------- */ @@ -1066,69 +1137,3 @@ double PairKolmogorovCrespiFull::single(int /*i*/, int /*j*/, int itype, int jty else philj = Vkc - offset[itype][jtype]; return factor_lj*philj; } - -/* ---------------------------------------------------------------------- */ - -int PairKolmogorovCrespiFull::pack_forward_comm(int n, int *list, double *buf, - int /*pbc_flag*/, int * /*pbc*/) -{ - int i,j,m,l,ip,id; - - m = 0; - for (i = 0; i < n; i++) { - j = list[i]; - buf[m++] = normal[j][0]; - buf[m++] = normal[j][1]; - buf[m++] = normal[j][2]; - buf[m++] = dnormdri[0][0][j]; - buf[m++] = dnormdri[0][1][j]; - buf[m++] = dnormdri[0][2][j]; - buf[m++] = dnormdri[1][0][j]; - buf[m++] = dnormdri[1][1][j]; - buf[m++] = dnormdri[1][2][j]; - buf[m++] = dnormdri[2][0][j]; - buf[m++] = dnormdri[2][1][j]; - buf[m++] = dnormdri[2][2][j]; - for (l = 0; l < 3; l++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - buf[m++] = dnormal[id][ip][l][j]; - } - } - } - } - return m; -} - -/* ---------------------------------------------------------------------- */ - -void PairKolmogorovCrespiFull::unpack_forward_comm(int n, int first, double *buf) -{ - int i,m,last,l,ip,id; - - m = 0; - last = first + n; - for (i = first; i < last; i++) { - normal[i][0] = buf[m++]; - normal[i][1] = buf[m++]; - normal[i][2] = buf[m++]; - dnormdri[0][0][i] = buf[m++]; - dnormdri[0][1][i] = buf[m++]; - dnormdri[0][2][i] = buf[m++]; - dnormdri[1][0][i] = buf[m++]; - dnormdri[1][1][i] = buf[m++]; - dnormdri[1][2][i] = buf[m++]; - dnormdri[2][0][i] = buf[m++]; - dnormdri[2][1][i] = buf[m++]; - dnormdri[2][2][i] = buf[m++]; - for (l = 0; l < 3; l++){ - for (id = 0; id < 3; id++){ - for (ip = 0; ip < 3; ip++){ - dnormal[id][ip][l][i] = buf[m++]; - } - } - } - } -} - -/* ---------------------------------------------------------------------- */ diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.h b/src/USER-MISC/pair_kolmogorov_crespi_full.h index 68dede0dd5..81ab1984da 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.h +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.h @@ -21,6 +21,8 @@ PairStyle(kolmogorov/crespi/full,PairKolmogorovCrespiFull) #define LMP_PAIR_KolmogorovCrespi_FULL_H #include "pair.h" +#include "my_page.h" +#include namespace LAMMPS_NS { @@ -34,9 +36,10 @@ class PairKolmogorovCrespiFull : public Pair { void coeff(int, char **); double init_one(int, int); void init_style(); + void KC_neigh(); void calc_normal(); - int pack_forward_comm(int, int *, double *, int, int *); - void unpack_forward_comm(int, int, double *); + void calc_FRep(int, int); + void calc_FvdW(int, int); double single(int, int, int, int, double, double, double, double &); protected: @@ -75,7 +78,6 @@ class PairKolmogorovCrespiFull : public Pair { void read_file( char * ); void allocate(); - void KC_neigh(); /* ----Calculate the long-range cutoff term */ -- GitLab From 76bac4cedce4d8021781636d33425716b01d6dc8 Mon Sep 17 00:00:00 2001 From: oywg11 Date: Thu, 1 Aug 2019 16:39:42 +0300 Subject: [PATCH 400/469] Fix communication bug of ILP --- .../Bi_gr_AB_stack_2L_noH.data | 1372 +++++++++++++++++ .../USER/misc/kolmogorov_crespi_full/CH.KC | 1 + .../misc/kolmogorov_crespi_full/CH_taper.KC | 1 + .../in.bilayer-graphene | 52 +- .../log.5Jun19.bilayer-graphene.icc.1 | 129 ++ .../log.5Jun19.bilayer-graphene.icc.4 | 129 ++ 6 files changed, 1654 insertions(+), 30 deletions(-) create mode 100644 examples/USER/misc/kolmogorov_crespi_full/Bi_gr_AB_stack_2L_noH.data create mode 120000 examples/USER/misc/kolmogorov_crespi_full/CH.KC create mode 120000 examples/USER/misc/kolmogorov_crespi_full/CH_taper.KC create mode 100644 examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.1 create mode 100644 examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.4 diff --git a/examples/USER/misc/kolmogorov_crespi_full/Bi_gr_AB_stack_2L_noH.data b/examples/USER/misc/kolmogorov_crespi_full/Bi_gr_AB_stack_2L_noH.data new file mode 100644 index 0000000000..756123a6f1 --- /dev/null +++ b/examples/USER/misc/kolmogorov_crespi_full/Bi_gr_AB_stack_2L_noH.data @@ -0,0 +1,1372 @@ + Generate Bi-layer graphene + + 1360 atoms + + 2 atom types + + 0.000000000000000 42.599999999999994 xlo xhi + 0.000000000000000 41.811706494712695 ylo yhi + 0.000000000000000 100.000000000000000 zlo zhi + + Atoms + + 1 1 1 0.000000000000000 0.000000000000000 1.229756073373903 0.000000000000000 + 2 1 1 0.000000000000000 0.710000000000000 0.000000000000000 0.000000000000000 + 3 1 1 0.000000000000000 2.130000000000000 0.000000000000000 0.000000000000000 + 4 1 1 0.000000000000000 2.840000000000000 1.229756073373903 0.000000000000000 + 5 1 1 0.000000000000000 4.260000000000000 1.229756073373903 0.000000000000000 + 6 1 1 0.000000000000000 4.970000000000000 0.000000000000000 0.000000000000000 + 7 1 1 0.000000000000000 6.390000000000000 0.000000000000000 0.000000000000000 + 8 1 1 0.000000000000000 7.100000000000000 1.229756073373903 0.000000000000000 + 9 1 1 0.000000000000000 8.520000000000000 1.229756073373903 0.000000000000000 + 10 1 1 0.000000000000000 9.230000000000000 0.000000000000000 0.000000000000000 + 11 1 1 0.000000000000000 10.649999999999999 0.000000000000000 0.000000000000000 + 12 1 1 0.000000000000000 11.359999999999999 1.229756073373903 0.000000000000000 + 13 1 1 0.000000000000000 12.779999999999999 1.229756073373903 0.000000000000000 + 14 1 1 0.000000000000000 13.489999999999998 0.000000000000000 0.000000000000000 + 15 1 1 0.000000000000000 14.910000000000000 0.000000000000000 0.000000000000000 + 16 1 1 0.000000000000000 15.619999999999999 1.229756073373903 0.000000000000000 + 17 1 1 0.000000000000000 17.039999999999999 1.229756073373903 0.000000000000000 + 18 1 1 0.000000000000000 17.750000000000000 0.000000000000000 0.000000000000000 + 19 1 1 0.000000000000000 19.169999999999998 0.000000000000000 0.000000000000000 + 20 1 1 0.000000000000000 19.879999999999999 1.229756073373903 0.000000000000000 + 21 1 1 0.000000000000000 21.299999999999997 1.229756073373903 0.000000000000000 + 22 1 1 0.000000000000000 22.009999999999998 0.000000000000000 0.000000000000000 + 23 1 1 0.000000000000000 23.429999999999996 0.000000000000000 0.000000000000000 + 24 1 1 0.000000000000000 24.139999999999997 1.229756073373903 0.000000000000000 + 25 1 1 0.000000000000000 25.559999999999999 1.229756073373903 0.000000000000000 + 26 1 1 0.000000000000000 26.270000000000000 0.000000000000000 0.000000000000000 + 27 1 1 0.000000000000000 27.689999999999998 0.000000000000000 0.000000000000000 + 28 1 1 0.000000000000000 28.399999999999999 1.229756073373903 0.000000000000000 + 29 1 1 0.000000000000000 29.820000000000000 1.229756073373903 0.000000000000000 + 30 1 1 0.000000000000000 30.530000000000001 0.000000000000000 0.000000000000000 + 31 1 1 0.000000000000000 31.949999999999999 0.000000000000000 0.000000000000000 + 32 1 1 0.000000000000000 32.659999999999997 1.229756073373903 0.000000000000000 + 33 1 1 0.000000000000000 34.079999999999998 1.229756073373903 0.000000000000000 + 34 1 1 0.000000000000000 34.789999999999999 0.000000000000000 0.000000000000000 + 35 1 1 0.000000000000000 36.210000000000001 0.000000000000000 0.000000000000000 + 36 1 1 0.000000000000000 36.920000000000002 1.229756073373903 0.000000000000000 + 37 1 1 0.000000000000000 38.339999999999996 1.229756073373903 0.000000000000000 + 38 1 1 0.000000000000000 39.049999999999997 0.000000000000000 0.000000000000000 + 39 1 1 0.000000000000000 40.469999999999999 0.000000000000000 0.000000000000000 + 40 1 1 0.000000000000000 41.179999999999993 1.229756073373903 0.000000000000000 + 41 1 1 0.000000000000000 0.000000000000000 3.689268220121709 0.000000000000000 + 42 1 1 0.000000000000000 0.710000000000000 2.459512146747806 0.000000000000000 + 43 1 1 0.000000000000000 2.130000000000000 2.459512146747806 0.000000000000000 + 44 1 1 0.000000000000000 2.840000000000000 3.689268220121709 0.000000000000000 + 45 1 1 0.000000000000000 4.260000000000000 3.689268220121709 0.000000000000000 + 46 1 1 0.000000000000000 4.970000000000000 2.459512146747806 0.000000000000000 + 47 1 1 0.000000000000000 6.390000000000000 2.459512146747806 0.000000000000000 + 48 1 1 0.000000000000000 7.100000000000000 3.689268220121709 0.000000000000000 + 49 1 1 0.000000000000000 8.520000000000000 3.689268220121709 0.000000000000000 + 50 1 1 0.000000000000000 9.230000000000000 2.459512146747806 0.000000000000000 + 51 1 1 0.000000000000000 10.649999999999999 2.459512146747806 0.000000000000000 + 52 1 1 0.000000000000000 11.359999999999999 3.689268220121709 0.000000000000000 + 53 1 1 0.000000000000000 12.779999999999999 3.689268220121709 0.000000000000000 + 54 1 1 0.000000000000000 13.489999999999998 2.459512146747806 0.000000000000000 + 55 1 1 0.000000000000000 14.910000000000000 2.459512146747806 0.000000000000000 + 56 1 1 0.000000000000000 15.619999999999999 3.689268220121709 0.000000000000000 + 57 1 1 0.000000000000000 17.039999999999999 3.689268220121709 0.000000000000000 + 58 1 1 0.000000000000000 17.750000000000000 2.459512146747806 0.000000000000000 + 59 1 1 0.000000000000000 19.169999999999998 2.459512146747806 0.000000000000000 + 60 1 1 0.000000000000000 19.879999999999999 3.689268220121709 0.000000000000000 + 61 1 1 0.000000000000000 21.299999999999997 3.689268220121709 0.000000000000000 + 62 1 1 0.000000000000000 22.009999999999998 2.459512146747806 0.000000000000000 + 63 1 1 0.000000000000000 23.429999999999996 2.459512146747806 0.000000000000000 + 64 1 1 0.000000000000000 24.139999999999997 3.689268220121709 0.000000000000000 + 65 1 1 0.000000000000000 25.559999999999999 3.689268220121709 0.000000000000000 + 66 1 1 0.000000000000000 26.270000000000000 2.459512146747806 0.000000000000000 + 67 1 1 0.000000000000000 27.689999999999998 2.459512146747806 0.000000000000000 + 68 1 1 0.000000000000000 28.399999999999999 3.689268220121709 0.000000000000000 + 69 1 1 0.000000000000000 29.820000000000000 3.689268220121709 0.000000000000000 + 70 1 1 0.000000000000000 30.530000000000001 2.459512146747806 0.000000000000000 + 71 1 1 0.000000000000000 31.949999999999999 2.459512146747806 0.000000000000000 + 72 1 1 0.000000000000000 32.659999999999997 3.689268220121709 0.000000000000000 + 73 1 1 0.000000000000000 34.079999999999998 3.689268220121709 0.000000000000000 + 74 1 1 0.000000000000000 34.789999999999999 2.459512146747806 0.000000000000000 + 75 1 1 0.000000000000000 36.210000000000001 2.459512146747806 0.000000000000000 + 76 1 1 0.000000000000000 36.920000000000002 3.689268220121709 0.000000000000000 + 77 1 1 0.000000000000000 38.339999999999996 3.689268220121709 0.000000000000000 + 78 1 1 0.000000000000000 39.049999999999997 2.459512146747806 0.000000000000000 + 79 1 1 0.000000000000000 40.469999999999999 2.459512146747806 0.000000000000000 + 80 1 1 0.000000000000000 41.179999999999993 3.689268220121709 0.000000000000000 + 81 1 1 0.000000000000000 0.000000000000000 6.148780366869514 0.000000000000000 + 82 1 1 0.000000000000000 0.710000000000000 4.919024293495611 0.000000000000000 + 83 1 1 0.000000000000000 2.130000000000000 4.919024293495611 0.000000000000000 + 84 1 1 0.000000000000000 2.840000000000000 6.148780366869514 0.000000000000000 + 85 1 1 0.000000000000000 4.260000000000000 6.148780366869514 0.000000000000000 + 86 1 1 0.000000000000000 4.970000000000000 4.919024293495611 0.000000000000000 + 87 1 1 0.000000000000000 6.390000000000000 4.919024293495611 0.000000000000000 + 88 1 1 0.000000000000000 7.100000000000000 6.148780366869514 0.000000000000000 + 89 1 1 0.000000000000000 8.520000000000000 6.148780366869514 0.000000000000000 + 90 1 1 0.000000000000000 9.230000000000000 4.919024293495611 0.000000000000000 + 91 1 1 0.000000000000000 10.649999999999999 4.919024293495611 0.000000000000000 + 92 1 1 0.000000000000000 11.359999999999999 6.148780366869514 0.000000000000000 + 93 1 1 0.000000000000000 12.779999999999999 6.148780366869514 0.000000000000000 + 94 1 1 0.000000000000000 13.489999999999998 4.919024293495611 0.000000000000000 + 95 1 1 0.000000000000000 14.910000000000000 4.919024293495611 0.000000000000000 + 96 1 1 0.000000000000000 15.619999999999999 6.148780366869514 0.000000000000000 + 97 1 1 0.000000000000000 17.039999999999999 6.148780366869514 0.000000000000000 + 98 1 1 0.000000000000000 17.750000000000000 4.919024293495611 0.000000000000000 + 99 1 1 0.000000000000000 19.169999999999998 4.919024293495611 0.000000000000000 + 100 1 1 0.000000000000000 19.879999999999999 6.148780366869514 0.000000000000000 + 101 1 1 0.000000000000000 21.299999999999997 6.148780366869514 0.000000000000000 + 102 1 1 0.000000000000000 22.009999999999998 4.919024293495611 0.000000000000000 + 103 1 1 0.000000000000000 23.429999999999996 4.919024293495611 0.000000000000000 + 104 1 1 0.000000000000000 24.139999999999997 6.148780366869514 0.000000000000000 + 105 1 1 0.000000000000000 25.559999999999999 6.148780366869514 0.000000000000000 + 106 1 1 0.000000000000000 26.270000000000000 4.919024293495611 0.000000000000000 + 107 1 1 0.000000000000000 27.689999999999998 4.919024293495611 0.000000000000000 + 108 1 1 0.000000000000000 28.399999999999999 6.148780366869514 0.000000000000000 + 109 1 1 0.000000000000000 29.820000000000000 6.148780366869514 0.000000000000000 + 110 1 1 0.000000000000000 30.530000000000001 4.919024293495611 0.000000000000000 + 111 1 1 0.000000000000000 31.949999999999999 4.919024293495611 0.000000000000000 + 112 1 1 0.000000000000000 32.659999999999997 6.148780366869514 0.000000000000000 + 113 1 1 0.000000000000000 34.079999999999998 6.148780366869514 0.000000000000000 + 114 1 1 0.000000000000000 34.789999999999999 4.919024293495611 0.000000000000000 + 115 1 1 0.000000000000000 36.210000000000001 4.919024293495611 0.000000000000000 + 116 1 1 0.000000000000000 36.920000000000002 6.148780366869514 0.000000000000000 + 117 1 1 0.000000000000000 38.339999999999996 6.148780366869514 0.000000000000000 + 118 1 1 0.000000000000000 39.049999999999997 4.919024293495611 0.000000000000000 + 119 1 1 0.000000000000000 40.469999999999999 4.919024293495611 0.000000000000000 + 120 1 1 0.000000000000000 41.179999999999993 6.148780366869514 0.000000000000000 + 121 1 1 0.000000000000000 0.000000000000000 8.608292513617320 0.000000000000000 + 122 1 1 0.000000000000000 0.710000000000000 7.378536440243417 0.000000000000000 + 123 1 1 0.000000000000000 2.130000000000000 7.378536440243417 0.000000000000000 + 124 1 1 0.000000000000000 2.840000000000000 8.608292513617320 0.000000000000000 + 125 1 1 0.000000000000000 4.260000000000000 8.608292513617320 0.000000000000000 + 126 1 1 0.000000000000000 4.970000000000000 7.378536440243417 0.000000000000000 + 127 1 1 0.000000000000000 6.390000000000000 7.378536440243417 0.000000000000000 + 128 1 1 0.000000000000000 7.100000000000000 8.608292513617320 0.000000000000000 + 129 1 1 0.000000000000000 8.520000000000000 8.608292513617320 0.000000000000000 + 130 1 1 0.000000000000000 9.230000000000000 7.378536440243417 0.000000000000000 + 131 1 1 0.000000000000000 10.649999999999999 7.378536440243417 0.000000000000000 + 132 1 1 0.000000000000000 11.359999999999999 8.608292513617320 0.000000000000000 + 133 1 1 0.000000000000000 12.779999999999999 8.608292513617320 0.000000000000000 + 134 1 1 0.000000000000000 13.489999999999998 7.378536440243417 0.000000000000000 + 135 1 1 0.000000000000000 14.910000000000000 7.378536440243417 0.000000000000000 + 136 1 1 0.000000000000000 15.619999999999999 8.608292513617320 0.000000000000000 + 137 1 1 0.000000000000000 17.039999999999999 8.608292513617320 0.000000000000000 + 138 1 1 0.000000000000000 17.750000000000000 7.378536440243417 0.000000000000000 + 139 1 1 0.000000000000000 19.169999999999998 7.378536440243417 0.000000000000000 + 140 1 1 0.000000000000000 19.879999999999999 8.608292513617320 0.000000000000000 + 141 1 1 0.000000000000000 21.299999999999997 8.608292513617320 0.000000000000000 + 142 1 1 0.000000000000000 22.009999999999998 7.378536440243417 0.000000000000000 + 143 1 1 0.000000000000000 23.429999999999996 7.378536440243417 0.000000000000000 + 144 1 1 0.000000000000000 24.139999999999997 8.608292513617320 0.000000000000000 + 145 1 1 0.000000000000000 25.559999999999999 8.608292513617320 0.000000000000000 + 146 1 1 0.000000000000000 26.270000000000000 7.378536440243417 0.000000000000000 + 147 1 1 0.000000000000000 27.689999999999998 7.378536440243417 0.000000000000000 + 148 1 1 0.000000000000000 28.399999999999999 8.608292513617320 0.000000000000000 + 149 1 1 0.000000000000000 29.820000000000000 8.608292513617320 0.000000000000000 + 150 1 1 0.000000000000000 30.530000000000001 7.378536440243417 0.000000000000000 + 151 1 1 0.000000000000000 31.949999999999999 7.378536440243417 0.000000000000000 + 152 1 1 0.000000000000000 32.659999999999997 8.608292513617320 0.000000000000000 + 153 1 1 0.000000000000000 34.079999999999998 8.608292513617320 0.000000000000000 + 154 1 1 0.000000000000000 34.789999999999999 7.378536440243417 0.000000000000000 + 155 1 1 0.000000000000000 36.210000000000001 7.378536440243417 0.000000000000000 + 156 1 1 0.000000000000000 36.920000000000002 8.608292513617320 0.000000000000000 + 157 1 1 0.000000000000000 38.339999999999996 8.608292513617320 0.000000000000000 + 158 1 1 0.000000000000000 39.049999999999997 7.378536440243417 0.000000000000000 + 159 1 1 0.000000000000000 40.469999999999999 7.378536440243417 0.000000000000000 + 160 1 1 0.000000000000000 41.179999999999993 8.608292513617320 0.000000000000000 + 161 1 1 0.000000000000000 0.000000000000000 11.067804660365125 0.000000000000000 + 162 1 1 0.000000000000000 0.710000000000000 9.838048586991222 0.000000000000000 + 163 1 1 0.000000000000000 2.130000000000000 9.838048586991222 0.000000000000000 + 164 1 1 0.000000000000000 2.840000000000000 11.067804660365125 0.000000000000000 + 165 1 1 0.000000000000000 4.260000000000000 11.067804660365125 0.000000000000000 + 166 1 1 0.000000000000000 4.970000000000000 9.838048586991222 0.000000000000000 + 167 1 1 0.000000000000000 6.390000000000000 9.838048586991222 0.000000000000000 + 168 1 1 0.000000000000000 7.100000000000000 11.067804660365125 0.000000000000000 + 169 1 1 0.000000000000000 8.520000000000000 11.067804660365125 0.000000000000000 + 170 1 1 0.000000000000000 9.230000000000000 9.838048586991222 0.000000000000000 + 171 1 1 0.000000000000000 10.649999999999999 9.838048586991222 0.000000000000000 + 172 1 1 0.000000000000000 11.359999999999999 11.067804660365125 0.000000000000000 + 173 1 1 0.000000000000000 12.779999999999999 11.067804660365125 0.000000000000000 + 174 1 1 0.000000000000000 13.489999999999998 9.838048586991222 0.000000000000000 + 175 1 1 0.000000000000000 14.910000000000000 9.838048586991222 0.000000000000000 + 176 1 1 0.000000000000000 15.619999999999999 11.067804660365125 0.000000000000000 + 177 1 1 0.000000000000000 17.039999999999999 11.067804660365125 0.000000000000000 + 178 1 1 0.000000000000000 17.750000000000000 9.838048586991222 0.000000000000000 + 179 1 1 0.000000000000000 19.169999999999998 9.838048586991222 0.000000000000000 + 180 1 1 0.000000000000000 19.879999999999999 11.067804660365125 0.000000000000000 + 181 1 1 0.000000000000000 21.299999999999997 11.067804660365125 0.000000000000000 + 182 1 1 0.000000000000000 22.009999999999998 9.838048586991222 0.000000000000000 + 183 1 1 0.000000000000000 23.429999999999996 9.838048586991222 0.000000000000000 + 184 1 1 0.000000000000000 24.139999999999997 11.067804660365125 0.000000000000000 + 185 1 1 0.000000000000000 25.559999999999999 11.067804660365125 0.000000000000000 + 186 1 1 0.000000000000000 26.270000000000000 9.838048586991222 0.000000000000000 + 187 1 1 0.000000000000000 27.689999999999998 9.838048586991222 0.000000000000000 + 188 1 1 0.000000000000000 28.399999999999999 11.067804660365125 0.000000000000000 + 189 1 1 0.000000000000000 29.820000000000000 11.067804660365125 0.000000000000000 + 190 1 1 0.000000000000000 30.530000000000001 9.838048586991222 0.000000000000000 + 191 1 1 0.000000000000000 31.949999999999999 9.838048586991222 0.000000000000000 + 192 1 1 0.000000000000000 32.659999999999997 11.067804660365125 0.000000000000000 + 193 1 1 0.000000000000000 34.079999999999998 11.067804660365125 0.000000000000000 + 194 1 1 0.000000000000000 34.789999999999999 9.838048586991222 0.000000000000000 + 195 1 1 0.000000000000000 36.210000000000001 9.838048586991222 0.000000000000000 + 196 1 1 0.000000000000000 36.920000000000002 11.067804660365125 0.000000000000000 + 197 1 1 0.000000000000000 38.339999999999996 11.067804660365125 0.000000000000000 + 198 1 1 0.000000000000000 39.049999999999997 9.838048586991222 0.000000000000000 + 199 1 1 0.000000000000000 40.469999999999999 9.838048586991222 0.000000000000000 + 200 1 1 0.000000000000000 41.179999999999993 11.067804660365125 0.000000000000000 + 201 1 1 0.000000000000000 0.000000000000000 13.527316807112930 0.000000000000000 + 202 1 1 0.000000000000000 0.710000000000000 12.297560733739028 0.000000000000000 + 203 1 1 0.000000000000000 2.130000000000000 12.297560733739028 0.000000000000000 + 204 1 1 0.000000000000000 2.840000000000000 13.527316807112930 0.000000000000000 + 205 1 1 0.000000000000000 4.260000000000000 13.527316807112930 0.000000000000000 + 206 1 1 0.000000000000000 4.970000000000000 12.297560733739028 0.000000000000000 + 207 1 1 0.000000000000000 6.390000000000000 12.297560733739028 0.000000000000000 + 208 1 1 0.000000000000000 7.100000000000000 13.527316807112930 0.000000000000000 + 209 1 1 0.000000000000000 8.520000000000000 13.527316807112930 0.000000000000000 + 210 1 1 0.000000000000000 9.230000000000000 12.297560733739028 0.000000000000000 + 211 1 1 0.000000000000000 10.649999999999999 12.297560733739028 0.000000000000000 + 212 1 1 0.000000000000000 11.359999999999999 13.527316807112930 0.000000000000000 + 213 1 1 0.000000000000000 12.779999999999999 13.527316807112930 0.000000000000000 + 214 1 1 0.000000000000000 13.489999999999998 12.297560733739028 0.000000000000000 + 215 1 1 0.000000000000000 14.910000000000000 12.297560733739028 0.000000000000000 + 216 1 1 0.000000000000000 15.619999999999999 13.527316807112930 0.000000000000000 + 217 1 1 0.000000000000000 17.039999999999999 13.527316807112930 0.000000000000000 + 218 1 1 0.000000000000000 17.750000000000000 12.297560733739028 0.000000000000000 + 219 1 1 0.000000000000000 19.169999999999998 12.297560733739028 0.000000000000000 + 220 1 1 0.000000000000000 19.879999999999999 13.527316807112930 0.000000000000000 + 221 1 1 0.000000000000000 21.299999999999997 13.527316807112930 0.000000000000000 + 222 1 1 0.000000000000000 22.009999999999998 12.297560733739028 0.000000000000000 + 223 1 1 0.000000000000000 23.429999999999996 12.297560733739028 0.000000000000000 + 224 1 1 0.000000000000000 24.139999999999997 13.527316807112930 0.000000000000000 + 225 1 1 0.000000000000000 25.559999999999999 13.527316807112930 0.000000000000000 + 226 1 1 0.000000000000000 26.270000000000000 12.297560733739028 0.000000000000000 + 227 1 1 0.000000000000000 27.689999999999998 12.297560733739028 0.000000000000000 + 228 1 1 0.000000000000000 28.399999999999999 13.527316807112930 0.000000000000000 + 229 1 1 0.000000000000000 29.820000000000000 13.527316807112930 0.000000000000000 + 230 1 1 0.000000000000000 30.530000000000001 12.297560733739028 0.000000000000000 + 231 1 1 0.000000000000000 31.949999999999999 12.297560733739028 0.000000000000000 + 232 1 1 0.000000000000000 32.659999999999997 13.527316807112930 0.000000000000000 + 233 1 1 0.000000000000000 34.079999999999998 13.527316807112930 0.000000000000000 + 234 1 1 0.000000000000000 34.789999999999999 12.297560733739028 0.000000000000000 + 235 1 1 0.000000000000000 36.210000000000001 12.297560733739028 0.000000000000000 + 236 1 1 0.000000000000000 36.920000000000002 13.527316807112930 0.000000000000000 + 237 1 1 0.000000000000000 38.339999999999996 13.527316807112930 0.000000000000000 + 238 1 1 0.000000000000000 39.049999999999997 12.297560733739028 0.000000000000000 + 239 1 1 0.000000000000000 40.469999999999999 12.297560733739028 0.000000000000000 + 240 1 1 0.000000000000000 41.179999999999993 13.527316807112930 0.000000000000000 + 241 1 1 0.000000000000000 0.000000000000000 15.986828953860737 0.000000000000000 + 242 1 1 0.000000000000000 0.710000000000000 14.757072880486835 0.000000000000000 + 243 1 1 0.000000000000000 2.130000000000000 14.757072880486835 0.000000000000000 + 244 1 1 0.000000000000000 2.840000000000000 15.986828953860737 0.000000000000000 + 245 1 1 0.000000000000000 4.260000000000000 15.986828953860737 0.000000000000000 + 246 1 1 0.000000000000000 4.970000000000000 14.757072880486835 0.000000000000000 + 247 1 1 0.000000000000000 6.390000000000000 14.757072880486835 0.000000000000000 + 248 1 1 0.000000000000000 7.100000000000000 15.986828953860737 0.000000000000000 + 249 1 1 0.000000000000000 8.520000000000000 15.986828953860737 0.000000000000000 + 250 1 1 0.000000000000000 9.230000000000000 14.757072880486835 0.000000000000000 + 251 1 1 0.000000000000000 10.649999999999999 14.757072880486835 0.000000000000000 + 252 1 1 0.000000000000000 11.359999999999999 15.986828953860737 0.000000000000000 + 253 1 1 0.000000000000000 12.779999999999999 15.986828953860737 0.000000000000000 + 254 1 1 0.000000000000000 13.489999999999998 14.757072880486835 0.000000000000000 + 255 1 1 0.000000000000000 14.910000000000000 14.757072880486835 0.000000000000000 + 256 1 1 0.000000000000000 15.619999999999999 15.986828953860737 0.000000000000000 + 257 1 1 0.000000000000000 17.039999999999999 15.986828953860737 0.000000000000000 + 258 1 1 0.000000000000000 17.750000000000000 14.757072880486835 0.000000000000000 + 259 1 1 0.000000000000000 19.169999999999998 14.757072880486835 0.000000000000000 + 260 1 1 0.000000000000000 19.879999999999999 15.986828953860737 0.000000000000000 + 261 1 1 0.000000000000000 21.299999999999997 15.986828953860737 0.000000000000000 + 262 1 1 0.000000000000000 22.009999999999998 14.757072880486835 0.000000000000000 + 263 1 1 0.000000000000000 23.429999999999996 14.757072880486835 0.000000000000000 + 264 1 1 0.000000000000000 24.139999999999997 15.986828953860737 0.000000000000000 + 265 1 1 0.000000000000000 25.559999999999999 15.986828953860737 0.000000000000000 + 266 1 1 0.000000000000000 26.270000000000000 14.757072880486835 0.000000000000000 + 267 1 1 0.000000000000000 27.689999999999998 14.757072880486835 0.000000000000000 + 268 1 1 0.000000000000000 28.399999999999999 15.986828953860737 0.000000000000000 + 269 1 1 0.000000000000000 29.820000000000000 15.986828953860737 0.000000000000000 + 270 1 1 0.000000000000000 30.530000000000001 14.757072880486835 0.000000000000000 + 271 1 1 0.000000000000000 31.949999999999999 14.757072880486835 0.000000000000000 + 272 1 1 0.000000000000000 32.659999999999997 15.986828953860737 0.000000000000000 + 273 1 1 0.000000000000000 34.079999999999998 15.986828953860737 0.000000000000000 + 274 1 1 0.000000000000000 34.789999999999999 14.757072880486835 0.000000000000000 + 275 1 1 0.000000000000000 36.210000000000001 14.757072880486835 0.000000000000000 + 276 1 1 0.000000000000000 36.920000000000002 15.986828953860737 0.000000000000000 + 277 1 1 0.000000000000000 38.339999999999996 15.986828953860737 0.000000000000000 + 278 1 1 0.000000000000000 39.049999999999997 14.757072880486835 0.000000000000000 + 279 1 1 0.000000000000000 40.469999999999999 14.757072880486835 0.000000000000000 + 280 1 1 0.000000000000000 41.179999999999993 15.986828953860737 0.000000000000000 + 281 1 1 0.000000000000000 0.000000000000000 18.446341100608542 0.000000000000000 + 282 1 1 0.000000000000000 0.710000000000000 17.216585027234640 0.000000000000000 + 283 1 1 0.000000000000000 2.130000000000000 17.216585027234640 0.000000000000000 + 284 1 1 0.000000000000000 2.840000000000000 18.446341100608542 0.000000000000000 + 285 1 1 0.000000000000000 4.260000000000000 18.446341100608542 0.000000000000000 + 286 1 1 0.000000000000000 4.970000000000000 17.216585027234640 0.000000000000000 + 287 1 1 0.000000000000000 6.390000000000000 17.216585027234640 0.000000000000000 + 288 1 1 0.000000000000000 7.100000000000000 18.446341100608542 0.000000000000000 + 289 1 1 0.000000000000000 8.520000000000000 18.446341100608542 0.000000000000000 + 290 1 1 0.000000000000000 9.230000000000000 17.216585027234640 0.000000000000000 + 291 1 1 0.000000000000000 10.649999999999999 17.216585027234640 0.000000000000000 + 292 1 1 0.000000000000000 11.359999999999999 18.446341100608542 0.000000000000000 + 293 1 1 0.000000000000000 12.779999999999999 18.446341100608542 0.000000000000000 + 294 1 1 0.000000000000000 13.489999999999998 17.216585027234640 0.000000000000000 + 295 1 1 0.000000000000000 14.910000000000000 17.216585027234640 0.000000000000000 + 296 1 1 0.000000000000000 15.619999999999999 18.446341100608542 0.000000000000000 + 297 1 1 0.000000000000000 17.039999999999999 18.446341100608542 0.000000000000000 + 298 1 1 0.000000000000000 17.750000000000000 17.216585027234640 0.000000000000000 + 299 1 1 0.000000000000000 19.169999999999998 17.216585027234640 0.000000000000000 + 300 1 1 0.000000000000000 19.879999999999999 18.446341100608542 0.000000000000000 + 301 1 1 0.000000000000000 21.299999999999997 18.446341100608542 0.000000000000000 + 302 1 1 0.000000000000000 22.009999999999998 17.216585027234640 0.000000000000000 + 303 1 1 0.000000000000000 23.429999999999996 17.216585027234640 0.000000000000000 + 304 1 1 0.000000000000000 24.139999999999997 18.446341100608542 0.000000000000000 + 305 1 1 0.000000000000000 25.559999999999999 18.446341100608542 0.000000000000000 + 306 1 1 0.000000000000000 26.270000000000000 17.216585027234640 0.000000000000000 + 307 1 1 0.000000000000000 27.689999999999998 17.216585027234640 0.000000000000000 + 308 1 1 0.000000000000000 28.399999999999999 18.446341100608542 0.000000000000000 + 309 1 1 0.000000000000000 29.820000000000000 18.446341100608542 0.000000000000000 + 310 1 1 0.000000000000000 30.530000000000001 17.216585027234640 0.000000000000000 + 311 1 1 0.000000000000000 31.949999999999999 17.216585027234640 0.000000000000000 + 312 1 1 0.000000000000000 32.659999999999997 18.446341100608542 0.000000000000000 + 313 1 1 0.000000000000000 34.079999999999998 18.446341100608542 0.000000000000000 + 314 1 1 0.000000000000000 34.789999999999999 17.216585027234640 0.000000000000000 + 315 1 1 0.000000000000000 36.210000000000001 17.216585027234640 0.000000000000000 + 316 1 1 0.000000000000000 36.920000000000002 18.446341100608542 0.000000000000000 + 317 1 1 0.000000000000000 38.339999999999996 18.446341100608542 0.000000000000000 + 318 1 1 0.000000000000000 39.049999999999997 17.216585027234640 0.000000000000000 + 319 1 1 0.000000000000000 40.469999999999999 17.216585027234640 0.000000000000000 + 320 1 1 0.000000000000000 41.179999999999993 18.446341100608542 0.000000000000000 + 321 1 1 0.000000000000000 0.000000000000000 20.905853247356347 0.000000000000000 + 322 1 1 0.000000000000000 0.710000000000000 19.676097173982445 0.000000000000000 + 323 1 1 0.000000000000000 2.130000000000000 19.676097173982445 0.000000000000000 + 324 1 1 0.000000000000000 2.840000000000000 20.905853247356347 0.000000000000000 + 325 1 1 0.000000000000000 4.260000000000000 20.905853247356347 0.000000000000000 + 326 1 1 0.000000000000000 4.970000000000000 19.676097173982445 0.000000000000000 + 327 1 1 0.000000000000000 6.390000000000000 19.676097173982445 0.000000000000000 + 328 1 1 0.000000000000000 7.100000000000000 20.905853247356347 0.000000000000000 + 329 1 1 0.000000000000000 8.520000000000000 20.905853247356347 0.000000000000000 + 330 1 1 0.000000000000000 9.230000000000000 19.676097173982445 0.000000000000000 + 331 1 1 0.000000000000000 10.649999999999999 19.676097173982445 0.000000000000000 + 332 1 1 0.000000000000000 11.359999999999999 20.905853247356347 0.000000000000000 + 333 1 1 0.000000000000000 12.779999999999999 20.905853247356347 0.000000000000000 + 334 1 1 0.000000000000000 13.489999999999998 19.676097173982445 0.000000000000000 + 335 1 1 0.000000000000000 14.910000000000000 19.676097173982445 0.000000000000000 + 336 1 1 0.000000000000000 15.619999999999999 20.905853247356347 0.000000000000000 + 337 1 1 0.000000000000000 17.039999999999999 20.905853247356347 0.000000000000000 + 338 1 1 0.000000000000000 17.750000000000000 19.676097173982445 0.000000000000000 + 339 1 1 0.000000000000000 19.169999999999998 19.676097173982445 0.000000000000000 + 340 1 1 0.000000000000000 19.879999999999999 20.905853247356347 0.000000000000000 + 341 1 1 0.000000000000000 21.299999999999997 20.905853247356347 0.000000000000000 + 342 1 1 0.000000000000000 22.009999999999998 19.676097173982445 0.000000000000000 + 343 1 1 0.000000000000000 23.429999999999996 19.676097173982445 0.000000000000000 + 344 1 1 0.000000000000000 24.139999999999997 20.905853247356347 0.000000000000000 + 345 1 1 0.000000000000000 25.559999999999999 20.905853247356347 0.000000000000000 + 346 1 1 0.000000000000000 26.270000000000000 19.676097173982445 0.000000000000000 + 347 1 1 0.000000000000000 27.689999999999998 19.676097173982445 0.000000000000000 + 348 1 1 0.000000000000000 28.399999999999999 20.905853247356347 0.000000000000000 + 349 1 1 0.000000000000000 29.820000000000000 20.905853247356347 0.000000000000000 + 350 1 1 0.000000000000000 30.530000000000001 19.676097173982445 0.000000000000000 + 351 1 1 0.000000000000000 31.949999999999999 19.676097173982445 0.000000000000000 + 352 1 1 0.000000000000000 32.659999999999997 20.905853247356347 0.000000000000000 + 353 1 1 0.000000000000000 34.079999999999998 20.905853247356347 0.000000000000000 + 354 1 1 0.000000000000000 34.789999999999999 19.676097173982445 0.000000000000000 + 355 1 1 0.000000000000000 36.210000000000001 19.676097173982445 0.000000000000000 + 356 1 1 0.000000000000000 36.920000000000002 20.905853247356347 0.000000000000000 + 357 1 1 0.000000000000000 38.339999999999996 20.905853247356347 0.000000000000000 + 358 1 1 0.000000000000000 39.049999999999997 19.676097173982445 0.000000000000000 + 359 1 1 0.000000000000000 40.469999999999999 19.676097173982445 0.000000000000000 + 360 1 1 0.000000000000000 41.179999999999993 20.905853247356347 0.000000000000000 + 361 1 1 0.000000000000000 0.000000000000000 23.365365394104153 0.000000000000000 + 362 1 1 0.000000000000000 0.710000000000000 22.135609320730250 0.000000000000000 + 363 1 1 0.000000000000000 2.130000000000000 22.135609320730250 0.000000000000000 + 364 1 1 0.000000000000000 2.840000000000000 23.365365394104153 0.000000000000000 + 365 1 1 0.000000000000000 4.260000000000000 23.365365394104153 0.000000000000000 + 366 1 1 0.000000000000000 4.970000000000000 22.135609320730250 0.000000000000000 + 367 1 1 0.000000000000000 6.390000000000000 22.135609320730250 0.000000000000000 + 368 1 1 0.000000000000000 7.100000000000000 23.365365394104153 0.000000000000000 + 369 1 1 0.000000000000000 8.520000000000000 23.365365394104153 0.000000000000000 + 370 1 1 0.000000000000000 9.230000000000000 22.135609320730250 0.000000000000000 + 371 1 1 0.000000000000000 10.649999999999999 22.135609320730250 0.000000000000000 + 372 1 1 0.000000000000000 11.359999999999999 23.365365394104153 0.000000000000000 + 373 1 1 0.000000000000000 12.779999999999999 23.365365394104153 0.000000000000000 + 374 1 1 0.000000000000000 13.489999999999998 22.135609320730250 0.000000000000000 + 375 1 1 0.000000000000000 14.910000000000000 22.135609320730250 0.000000000000000 + 376 1 1 0.000000000000000 15.619999999999999 23.365365394104153 0.000000000000000 + 377 1 1 0.000000000000000 17.039999999999999 23.365365394104153 0.000000000000000 + 378 1 1 0.000000000000000 17.750000000000000 22.135609320730250 0.000000000000000 + 379 1 1 0.000000000000000 19.169999999999998 22.135609320730250 0.000000000000000 + 380 1 1 0.000000000000000 19.879999999999999 23.365365394104153 0.000000000000000 + 381 1 1 0.000000000000000 21.299999999999997 23.365365394104153 0.000000000000000 + 382 1 1 0.000000000000000 22.009999999999998 22.135609320730250 0.000000000000000 + 383 1 1 0.000000000000000 23.429999999999996 22.135609320730250 0.000000000000000 + 384 1 1 0.000000000000000 24.139999999999997 23.365365394104153 0.000000000000000 + 385 1 1 0.000000000000000 25.559999999999999 23.365365394104153 0.000000000000000 + 386 1 1 0.000000000000000 26.270000000000000 22.135609320730250 0.000000000000000 + 387 1 1 0.000000000000000 27.689999999999998 22.135609320730250 0.000000000000000 + 388 1 1 0.000000000000000 28.399999999999999 23.365365394104153 0.000000000000000 + 389 1 1 0.000000000000000 29.820000000000000 23.365365394104153 0.000000000000000 + 390 1 1 0.000000000000000 30.530000000000001 22.135609320730250 0.000000000000000 + 391 1 1 0.000000000000000 31.949999999999999 22.135609320730250 0.000000000000000 + 392 1 1 0.000000000000000 32.659999999999997 23.365365394104153 0.000000000000000 + 393 1 1 0.000000000000000 34.079999999999998 23.365365394104153 0.000000000000000 + 394 1 1 0.000000000000000 34.789999999999999 22.135609320730250 0.000000000000000 + 395 1 1 0.000000000000000 36.210000000000001 22.135609320730250 0.000000000000000 + 396 1 1 0.000000000000000 36.920000000000002 23.365365394104153 0.000000000000000 + 397 1 1 0.000000000000000 38.339999999999996 23.365365394104153 0.000000000000000 + 398 1 1 0.000000000000000 39.049999999999997 22.135609320730250 0.000000000000000 + 399 1 1 0.000000000000000 40.469999999999999 22.135609320730250 0.000000000000000 + 400 1 1 0.000000000000000 41.179999999999993 23.365365394104153 0.000000000000000 + 401 1 1 0.000000000000000 0.000000000000000 25.824877540851958 0.000000000000000 + 402 1 1 0.000000000000000 0.710000000000000 24.595121467478055 0.000000000000000 + 403 1 1 0.000000000000000 2.130000000000000 24.595121467478055 0.000000000000000 + 404 1 1 0.000000000000000 2.840000000000000 25.824877540851958 0.000000000000000 + 405 1 1 0.000000000000000 4.260000000000000 25.824877540851958 0.000000000000000 + 406 1 1 0.000000000000000 4.970000000000000 24.595121467478055 0.000000000000000 + 407 1 1 0.000000000000000 6.390000000000000 24.595121467478055 0.000000000000000 + 408 1 1 0.000000000000000 7.100000000000000 25.824877540851958 0.000000000000000 + 409 1 1 0.000000000000000 8.520000000000000 25.824877540851958 0.000000000000000 + 410 1 1 0.000000000000000 9.230000000000000 24.595121467478055 0.000000000000000 + 411 1 1 0.000000000000000 10.649999999999999 24.595121467478055 0.000000000000000 + 412 1 1 0.000000000000000 11.359999999999999 25.824877540851958 0.000000000000000 + 413 1 1 0.000000000000000 12.779999999999999 25.824877540851958 0.000000000000000 + 414 1 1 0.000000000000000 13.489999999999998 24.595121467478055 0.000000000000000 + 415 1 1 0.000000000000000 14.910000000000000 24.595121467478055 0.000000000000000 + 416 1 1 0.000000000000000 15.619999999999999 25.824877540851958 0.000000000000000 + 417 1 1 0.000000000000000 17.039999999999999 25.824877540851958 0.000000000000000 + 418 1 1 0.000000000000000 17.750000000000000 24.595121467478055 0.000000000000000 + 419 1 1 0.000000000000000 19.169999999999998 24.595121467478055 0.000000000000000 + 420 1 1 0.000000000000000 19.879999999999999 25.824877540851958 0.000000000000000 + 421 1 1 0.000000000000000 21.299999999999997 25.824877540851958 0.000000000000000 + 422 1 1 0.000000000000000 22.009999999999998 24.595121467478055 0.000000000000000 + 423 1 1 0.000000000000000 23.429999999999996 24.595121467478055 0.000000000000000 + 424 1 1 0.000000000000000 24.139999999999997 25.824877540851958 0.000000000000000 + 425 1 1 0.000000000000000 25.559999999999999 25.824877540851958 0.000000000000000 + 426 1 1 0.000000000000000 26.270000000000000 24.595121467478055 0.000000000000000 + 427 1 1 0.000000000000000 27.689999999999998 24.595121467478055 0.000000000000000 + 428 1 1 0.000000000000000 28.399999999999999 25.824877540851958 0.000000000000000 + 429 1 1 0.000000000000000 29.820000000000000 25.824877540851958 0.000000000000000 + 430 1 1 0.000000000000000 30.530000000000001 24.595121467478055 0.000000000000000 + 431 1 1 0.000000000000000 31.949999999999999 24.595121467478055 0.000000000000000 + 432 1 1 0.000000000000000 32.659999999999997 25.824877540851958 0.000000000000000 + 433 1 1 0.000000000000000 34.079999999999998 25.824877540851958 0.000000000000000 + 434 1 1 0.000000000000000 34.789999999999999 24.595121467478055 0.000000000000000 + 435 1 1 0.000000000000000 36.210000000000001 24.595121467478055 0.000000000000000 + 436 1 1 0.000000000000000 36.920000000000002 25.824877540851958 0.000000000000000 + 437 1 1 0.000000000000000 38.339999999999996 25.824877540851958 0.000000000000000 + 438 1 1 0.000000000000000 39.049999999999997 24.595121467478055 0.000000000000000 + 439 1 1 0.000000000000000 40.469999999999999 24.595121467478055 0.000000000000000 + 440 1 1 0.000000000000000 41.179999999999993 25.824877540851958 0.000000000000000 + 441 1 1 0.000000000000000 0.000000000000000 28.284389687599763 0.000000000000000 + 442 1 1 0.000000000000000 0.710000000000000 27.054633614225860 0.000000000000000 + 443 1 1 0.000000000000000 2.130000000000000 27.054633614225860 0.000000000000000 + 444 1 1 0.000000000000000 2.840000000000000 28.284389687599763 0.000000000000000 + 445 1 1 0.000000000000000 4.260000000000000 28.284389687599763 0.000000000000000 + 446 1 1 0.000000000000000 4.970000000000000 27.054633614225860 0.000000000000000 + 447 1 1 0.000000000000000 6.390000000000000 27.054633614225860 0.000000000000000 + 448 1 1 0.000000000000000 7.100000000000000 28.284389687599763 0.000000000000000 + 449 1 1 0.000000000000000 8.520000000000000 28.284389687599763 0.000000000000000 + 450 1 1 0.000000000000000 9.230000000000000 27.054633614225860 0.000000000000000 + 451 1 1 0.000000000000000 10.649999999999999 27.054633614225860 0.000000000000000 + 452 1 1 0.000000000000000 11.359999999999999 28.284389687599763 0.000000000000000 + 453 1 1 0.000000000000000 12.779999999999999 28.284389687599763 0.000000000000000 + 454 1 1 0.000000000000000 13.489999999999998 27.054633614225860 0.000000000000000 + 455 1 1 0.000000000000000 14.910000000000000 27.054633614225860 0.000000000000000 + 456 1 1 0.000000000000000 15.619999999999999 28.284389687599763 0.000000000000000 + 457 1 1 0.000000000000000 17.039999999999999 28.284389687599763 0.000000000000000 + 458 1 1 0.000000000000000 17.750000000000000 27.054633614225860 0.000000000000000 + 459 1 1 0.000000000000000 19.169999999999998 27.054633614225860 0.000000000000000 + 460 1 1 0.000000000000000 19.879999999999999 28.284389687599763 0.000000000000000 + 461 1 1 0.000000000000000 21.299999999999997 28.284389687599763 0.000000000000000 + 462 1 1 0.000000000000000 22.009999999999998 27.054633614225860 0.000000000000000 + 463 1 1 0.000000000000000 23.429999999999996 27.054633614225860 0.000000000000000 + 464 1 1 0.000000000000000 24.139999999999997 28.284389687599763 0.000000000000000 + 465 1 1 0.000000000000000 25.559999999999999 28.284389687599763 0.000000000000000 + 466 1 1 0.000000000000000 26.270000000000000 27.054633614225860 0.000000000000000 + 467 1 1 0.000000000000000 27.689999999999998 27.054633614225860 0.000000000000000 + 468 1 1 0.000000000000000 28.399999999999999 28.284389687599763 0.000000000000000 + 469 1 1 0.000000000000000 29.820000000000000 28.284389687599763 0.000000000000000 + 470 1 1 0.000000000000000 30.530000000000001 27.054633614225860 0.000000000000000 + 471 1 1 0.000000000000000 31.949999999999999 27.054633614225860 0.000000000000000 + 472 1 1 0.000000000000000 32.659999999999997 28.284389687599763 0.000000000000000 + 473 1 1 0.000000000000000 34.079999999999998 28.284389687599763 0.000000000000000 + 474 1 1 0.000000000000000 34.789999999999999 27.054633614225860 0.000000000000000 + 475 1 1 0.000000000000000 36.210000000000001 27.054633614225860 0.000000000000000 + 476 1 1 0.000000000000000 36.920000000000002 28.284389687599763 0.000000000000000 + 477 1 1 0.000000000000000 38.339999999999996 28.284389687599763 0.000000000000000 + 478 1 1 0.000000000000000 39.049999999999997 27.054633614225860 0.000000000000000 + 479 1 1 0.000000000000000 40.469999999999999 27.054633614225860 0.000000000000000 + 480 1 1 0.000000000000000 41.179999999999993 28.284389687599763 0.000000000000000 + 481 1 1 0.000000000000000 0.000000000000000 30.743901834347572 0.000000000000000 + 482 1 1 0.000000000000000 0.710000000000000 29.514145760973669 0.000000000000000 + 483 1 1 0.000000000000000 2.130000000000000 29.514145760973669 0.000000000000000 + 484 1 1 0.000000000000000 2.840000000000000 30.743901834347572 0.000000000000000 + 485 1 1 0.000000000000000 4.260000000000000 30.743901834347572 0.000000000000000 + 486 1 1 0.000000000000000 4.970000000000000 29.514145760973669 0.000000000000000 + 487 1 1 0.000000000000000 6.390000000000000 29.514145760973669 0.000000000000000 + 488 1 1 0.000000000000000 7.100000000000000 30.743901834347572 0.000000000000000 + 489 1 1 0.000000000000000 8.520000000000000 30.743901834347572 0.000000000000000 + 490 1 1 0.000000000000000 9.230000000000000 29.514145760973669 0.000000000000000 + 491 1 1 0.000000000000000 10.649999999999999 29.514145760973669 0.000000000000000 + 492 1 1 0.000000000000000 11.359999999999999 30.743901834347572 0.000000000000000 + 493 1 1 0.000000000000000 12.779999999999999 30.743901834347572 0.000000000000000 + 494 1 1 0.000000000000000 13.489999999999998 29.514145760973669 0.000000000000000 + 495 1 1 0.000000000000000 14.910000000000000 29.514145760973669 0.000000000000000 + 496 1 1 0.000000000000000 15.619999999999999 30.743901834347572 0.000000000000000 + 497 1 1 0.000000000000000 17.039999999999999 30.743901834347572 0.000000000000000 + 498 1 1 0.000000000000000 17.750000000000000 29.514145760973669 0.000000000000000 + 499 1 1 0.000000000000000 19.169999999999998 29.514145760973669 0.000000000000000 + 500 1 1 0.000000000000000 19.879999999999999 30.743901834347572 0.000000000000000 + 501 1 1 0.000000000000000 21.299999999999997 30.743901834347572 0.000000000000000 + 502 1 1 0.000000000000000 22.009999999999998 29.514145760973669 0.000000000000000 + 503 1 1 0.000000000000000 23.429999999999996 29.514145760973669 0.000000000000000 + 504 1 1 0.000000000000000 24.139999999999997 30.743901834347572 0.000000000000000 + 505 1 1 0.000000000000000 25.559999999999999 30.743901834347572 0.000000000000000 + 506 1 1 0.000000000000000 26.270000000000000 29.514145760973669 0.000000000000000 + 507 1 1 0.000000000000000 27.689999999999998 29.514145760973669 0.000000000000000 + 508 1 1 0.000000000000000 28.399999999999999 30.743901834347572 0.000000000000000 + 509 1 1 0.000000000000000 29.820000000000000 30.743901834347572 0.000000000000000 + 510 1 1 0.000000000000000 30.530000000000001 29.514145760973669 0.000000000000000 + 511 1 1 0.000000000000000 31.949999999999999 29.514145760973669 0.000000000000000 + 512 1 1 0.000000000000000 32.659999999999997 30.743901834347572 0.000000000000000 + 513 1 1 0.000000000000000 34.079999999999998 30.743901834347572 0.000000000000000 + 514 1 1 0.000000000000000 34.789999999999999 29.514145760973669 0.000000000000000 + 515 1 1 0.000000000000000 36.210000000000001 29.514145760973669 0.000000000000000 + 516 1 1 0.000000000000000 36.920000000000002 30.743901834347572 0.000000000000000 + 517 1 1 0.000000000000000 38.339999999999996 30.743901834347572 0.000000000000000 + 518 1 1 0.000000000000000 39.049999999999997 29.514145760973669 0.000000000000000 + 519 1 1 0.000000000000000 40.469999999999999 29.514145760973669 0.000000000000000 + 520 1 1 0.000000000000000 41.179999999999993 30.743901834347572 0.000000000000000 + 521 1 1 0.000000000000000 0.000000000000000 33.203413981095380 0.000000000000000 + 522 1 1 0.000000000000000 0.710000000000000 31.973657907721474 0.000000000000000 + 523 1 1 0.000000000000000 2.130000000000000 31.973657907721474 0.000000000000000 + 524 1 1 0.000000000000000 2.840000000000000 33.203413981095380 0.000000000000000 + 525 1 1 0.000000000000000 4.260000000000000 33.203413981095380 0.000000000000000 + 526 1 1 0.000000000000000 4.970000000000000 31.973657907721474 0.000000000000000 + 527 1 1 0.000000000000000 6.390000000000000 31.973657907721474 0.000000000000000 + 528 1 1 0.000000000000000 7.100000000000000 33.203413981095380 0.000000000000000 + 529 1 1 0.000000000000000 8.520000000000000 33.203413981095380 0.000000000000000 + 530 1 1 0.000000000000000 9.230000000000000 31.973657907721474 0.000000000000000 + 531 1 1 0.000000000000000 10.649999999999999 31.973657907721474 0.000000000000000 + 532 1 1 0.000000000000000 11.359999999999999 33.203413981095380 0.000000000000000 + 533 1 1 0.000000000000000 12.779999999999999 33.203413981095380 0.000000000000000 + 534 1 1 0.000000000000000 13.489999999999998 31.973657907721474 0.000000000000000 + 535 1 1 0.000000000000000 14.910000000000000 31.973657907721474 0.000000000000000 + 536 1 1 0.000000000000000 15.619999999999999 33.203413981095380 0.000000000000000 + 537 1 1 0.000000000000000 17.039999999999999 33.203413981095380 0.000000000000000 + 538 1 1 0.000000000000000 17.750000000000000 31.973657907721474 0.000000000000000 + 539 1 1 0.000000000000000 19.169999999999998 31.973657907721474 0.000000000000000 + 540 1 1 0.000000000000000 19.879999999999999 33.203413981095380 0.000000000000000 + 541 1 1 0.000000000000000 21.299999999999997 33.203413981095380 0.000000000000000 + 542 1 1 0.000000000000000 22.009999999999998 31.973657907721474 0.000000000000000 + 543 1 1 0.000000000000000 23.429999999999996 31.973657907721474 0.000000000000000 + 544 1 1 0.000000000000000 24.139999999999997 33.203413981095380 0.000000000000000 + 545 1 1 0.000000000000000 25.559999999999999 33.203413981095380 0.000000000000000 + 546 1 1 0.000000000000000 26.270000000000000 31.973657907721474 0.000000000000000 + 547 1 1 0.000000000000000 27.689999999999998 31.973657907721474 0.000000000000000 + 548 1 1 0.000000000000000 28.399999999999999 33.203413981095380 0.000000000000000 + 549 1 1 0.000000000000000 29.820000000000000 33.203413981095380 0.000000000000000 + 550 1 1 0.000000000000000 30.530000000000001 31.973657907721474 0.000000000000000 + 551 1 1 0.000000000000000 31.949999999999999 31.973657907721474 0.000000000000000 + 552 1 1 0.000000000000000 32.659999999999997 33.203413981095380 0.000000000000000 + 553 1 1 0.000000000000000 34.079999999999998 33.203413981095380 0.000000000000000 + 554 1 1 0.000000000000000 34.789999999999999 31.973657907721474 0.000000000000000 + 555 1 1 0.000000000000000 36.210000000000001 31.973657907721474 0.000000000000000 + 556 1 1 0.000000000000000 36.920000000000002 33.203413981095380 0.000000000000000 + 557 1 1 0.000000000000000 38.339999999999996 33.203413981095380 0.000000000000000 + 558 1 1 0.000000000000000 39.049999999999997 31.973657907721474 0.000000000000000 + 559 1 1 0.000000000000000 40.469999999999999 31.973657907721474 0.000000000000000 + 560 1 1 0.000000000000000 41.179999999999993 33.203413981095380 0.000000000000000 + 561 1 1 0.000000000000000 0.000000000000000 35.662926127843185 0.000000000000000 + 562 1 1 0.000000000000000 0.710000000000000 34.433170054469279 0.000000000000000 + 563 1 1 0.000000000000000 2.130000000000000 34.433170054469279 0.000000000000000 + 564 1 1 0.000000000000000 2.840000000000000 35.662926127843185 0.000000000000000 + 565 1 1 0.000000000000000 4.260000000000000 35.662926127843185 0.000000000000000 + 566 1 1 0.000000000000000 4.970000000000000 34.433170054469279 0.000000000000000 + 567 1 1 0.000000000000000 6.390000000000000 34.433170054469279 0.000000000000000 + 568 1 1 0.000000000000000 7.100000000000000 35.662926127843185 0.000000000000000 + 569 1 1 0.000000000000000 8.520000000000000 35.662926127843185 0.000000000000000 + 570 1 1 0.000000000000000 9.230000000000000 34.433170054469279 0.000000000000000 + 571 1 1 0.000000000000000 10.649999999999999 34.433170054469279 0.000000000000000 + 572 1 1 0.000000000000000 11.359999999999999 35.662926127843185 0.000000000000000 + 573 1 1 0.000000000000000 12.779999999999999 35.662926127843185 0.000000000000000 + 574 1 1 0.000000000000000 13.489999999999998 34.433170054469279 0.000000000000000 + 575 1 1 0.000000000000000 14.910000000000000 34.433170054469279 0.000000000000000 + 576 1 1 0.000000000000000 15.619999999999999 35.662926127843185 0.000000000000000 + 577 1 1 0.000000000000000 17.039999999999999 35.662926127843185 0.000000000000000 + 578 1 1 0.000000000000000 17.750000000000000 34.433170054469279 0.000000000000000 + 579 1 1 0.000000000000000 19.169999999999998 34.433170054469279 0.000000000000000 + 580 1 1 0.000000000000000 19.879999999999999 35.662926127843185 0.000000000000000 + 581 1 1 0.000000000000000 21.299999999999997 35.662926127843185 0.000000000000000 + 582 1 1 0.000000000000000 22.009999999999998 34.433170054469279 0.000000000000000 + 583 1 1 0.000000000000000 23.429999999999996 34.433170054469279 0.000000000000000 + 584 1 1 0.000000000000000 24.139999999999997 35.662926127843185 0.000000000000000 + 585 1 1 0.000000000000000 25.559999999999999 35.662926127843185 0.000000000000000 + 586 1 1 0.000000000000000 26.270000000000000 34.433170054469279 0.000000000000000 + 587 1 1 0.000000000000000 27.689999999999998 34.433170054469279 0.000000000000000 + 588 1 1 0.000000000000000 28.399999999999999 35.662926127843185 0.000000000000000 + 589 1 1 0.000000000000000 29.820000000000000 35.662926127843185 0.000000000000000 + 590 1 1 0.000000000000000 30.530000000000001 34.433170054469279 0.000000000000000 + 591 1 1 0.000000000000000 31.949999999999999 34.433170054469279 0.000000000000000 + 592 1 1 0.000000000000000 32.659999999999997 35.662926127843185 0.000000000000000 + 593 1 1 0.000000000000000 34.079999999999998 35.662926127843185 0.000000000000000 + 594 1 1 0.000000000000000 34.789999999999999 34.433170054469279 0.000000000000000 + 595 1 1 0.000000000000000 36.210000000000001 34.433170054469279 0.000000000000000 + 596 1 1 0.000000000000000 36.920000000000002 35.662926127843185 0.000000000000000 + 597 1 1 0.000000000000000 38.339999999999996 35.662926127843185 0.000000000000000 + 598 1 1 0.000000000000000 39.049999999999997 34.433170054469279 0.000000000000000 + 599 1 1 0.000000000000000 40.469999999999999 34.433170054469279 0.000000000000000 + 600 1 1 0.000000000000000 41.179999999999993 35.662926127843185 0.000000000000000 + 601 1 1 0.000000000000000 0.000000000000000 38.122438274590991 0.000000000000000 + 602 1 1 0.000000000000000 0.710000000000000 36.892682201217085 0.000000000000000 + 603 1 1 0.000000000000000 2.130000000000000 36.892682201217085 0.000000000000000 + 604 1 1 0.000000000000000 2.840000000000000 38.122438274590991 0.000000000000000 + 605 1 1 0.000000000000000 4.260000000000000 38.122438274590991 0.000000000000000 + 606 1 1 0.000000000000000 4.970000000000000 36.892682201217085 0.000000000000000 + 607 1 1 0.000000000000000 6.390000000000000 36.892682201217085 0.000000000000000 + 608 1 1 0.000000000000000 7.100000000000000 38.122438274590991 0.000000000000000 + 609 1 1 0.000000000000000 8.520000000000000 38.122438274590991 0.000000000000000 + 610 1 1 0.000000000000000 9.230000000000000 36.892682201217085 0.000000000000000 + 611 1 1 0.000000000000000 10.649999999999999 36.892682201217085 0.000000000000000 + 612 1 1 0.000000000000000 11.359999999999999 38.122438274590991 0.000000000000000 + 613 1 1 0.000000000000000 12.779999999999999 38.122438274590991 0.000000000000000 + 614 1 1 0.000000000000000 13.489999999999998 36.892682201217085 0.000000000000000 + 615 1 1 0.000000000000000 14.910000000000000 36.892682201217085 0.000000000000000 + 616 1 1 0.000000000000000 15.619999999999999 38.122438274590991 0.000000000000000 + 617 1 1 0.000000000000000 17.039999999999999 38.122438274590991 0.000000000000000 + 618 1 1 0.000000000000000 17.750000000000000 36.892682201217085 0.000000000000000 + 619 1 1 0.000000000000000 19.169999999999998 36.892682201217085 0.000000000000000 + 620 1 1 0.000000000000000 19.879999999999999 38.122438274590991 0.000000000000000 + 621 1 1 0.000000000000000 21.299999999999997 38.122438274590991 0.000000000000000 + 622 1 1 0.000000000000000 22.009999999999998 36.892682201217085 0.000000000000000 + 623 1 1 0.000000000000000 23.429999999999996 36.892682201217085 0.000000000000000 + 624 1 1 0.000000000000000 24.139999999999997 38.122438274590991 0.000000000000000 + 625 1 1 0.000000000000000 25.559999999999999 38.122438274590991 0.000000000000000 + 626 1 1 0.000000000000000 26.270000000000000 36.892682201217085 0.000000000000000 + 627 1 1 0.000000000000000 27.689999999999998 36.892682201217085 0.000000000000000 + 628 1 1 0.000000000000000 28.399999999999999 38.122438274590991 0.000000000000000 + 629 1 1 0.000000000000000 29.820000000000000 38.122438274590991 0.000000000000000 + 630 1 1 0.000000000000000 30.530000000000001 36.892682201217085 0.000000000000000 + 631 1 1 0.000000000000000 31.949999999999999 36.892682201217085 0.000000000000000 + 632 1 1 0.000000000000000 32.659999999999997 38.122438274590991 0.000000000000000 + 633 1 1 0.000000000000000 34.079999999999998 38.122438274590991 0.000000000000000 + 634 1 1 0.000000000000000 34.789999999999999 36.892682201217085 0.000000000000000 + 635 1 1 0.000000000000000 36.210000000000001 36.892682201217085 0.000000000000000 + 636 1 1 0.000000000000000 36.920000000000002 38.122438274590991 0.000000000000000 + 637 1 1 0.000000000000000 38.339999999999996 38.122438274590991 0.000000000000000 + 638 1 1 0.000000000000000 39.049999999999997 36.892682201217085 0.000000000000000 + 639 1 1 0.000000000000000 40.469999999999999 36.892682201217085 0.000000000000000 + 640 1 1 0.000000000000000 41.179999999999993 38.122438274590991 0.000000000000000 + 641 1 1 0.000000000000000 0.000000000000000 40.581950421338796 0.000000000000000 + 642 1 1 0.000000000000000 0.710000000000000 39.352194347964890 0.000000000000000 + 643 1 1 0.000000000000000 2.130000000000000 39.352194347964890 0.000000000000000 + 644 1 1 0.000000000000000 2.840000000000000 40.581950421338796 0.000000000000000 + 645 1 1 0.000000000000000 4.260000000000000 40.581950421338796 0.000000000000000 + 646 1 1 0.000000000000000 4.970000000000000 39.352194347964890 0.000000000000000 + 647 1 1 0.000000000000000 6.390000000000000 39.352194347964890 0.000000000000000 + 648 1 1 0.000000000000000 7.100000000000000 40.581950421338796 0.000000000000000 + 649 1 1 0.000000000000000 8.520000000000000 40.581950421338796 0.000000000000000 + 650 1 1 0.000000000000000 9.230000000000000 39.352194347964890 0.000000000000000 + 651 1 1 0.000000000000000 10.649999999999999 39.352194347964890 0.000000000000000 + 652 1 1 0.000000000000000 11.359999999999999 40.581950421338796 0.000000000000000 + 653 1 1 0.000000000000000 12.779999999999999 40.581950421338796 0.000000000000000 + 654 1 1 0.000000000000000 13.489999999999998 39.352194347964890 0.000000000000000 + 655 1 1 0.000000000000000 14.910000000000000 39.352194347964890 0.000000000000000 + 656 1 1 0.000000000000000 15.619999999999999 40.581950421338796 0.000000000000000 + 657 1 1 0.000000000000000 17.039999999999999 40.581950421338796 0.000000000000000 + 658 1 1 0.000000000000000 17.750000000000000 39.352194347964890 0.000000000000000 + 659 1 1 0.000000000000000 19.169999999999998 39.352194347964890 0.000000000000000 + 660 1 1 0.000000000000000 19.879999999999999 40.581950421338796 0.000000000000000 + 661 1 1 0.000000000000000 21.299999999999997 40.581950421338796 0.000000000000000 + 662 1 1 0.000000000000000 22.009999999999998 39.352194347964890 0.000000000000000 + 663 1 1 0.000000000000000 23.429999999999996 39.352194347964890 0.000000000000000 + 664 1 1 0.000000000000000 24.139999999999997 40.581950421338796 0.000000000000000 + 665 1 1 0.000000000000000 25.559999999999999 40.581950421338796 0.000000000000000 + 666 1 1 0.000000000000000 26.270000000000000 39.352194347964890 0.000000000000000 + 667 1 1 0.000000000000000 27.689999999999998 39.352194347964890 0.000000000000000 + 668 1 1 0.000000000000000 28.399999999999999 40.581950421338796 0.000000000000000 + 669 1 1 0.000000000000000 29.820000000000000 40.581950421338796 0.000000000000000 + 670 1 1 0.000000000000000 30.530000000000001 39.352194347964890 0.000000000000000 + 671 1 1 0.000000000000000 31.949999999999999 39.352194347964890 0.000000000000000 + 672 1 1 0.000000000000000 32.659999999999997 40.581950421338796 0.000000000000000 + 673 1 1 0.000000000000000 34.079999999999998 40.581950421338796 0.000000000000000 + 674 1 1 0.000000000000000 34.789999999999999 39.352194347964890 0.000000000000000 + 675 1 1 0.000000000000000 36.210000000000001 39.352194347964890 0.000000000000000 + 676 1 1 0.000000000000000 36.920000000000002 40.581950421338796 0.000000000000000 + 677 1 1 0.000000000000000 38.339999999999996 40.581950421338796 0.000000000000000 + 678 1 1 0.000000000000000 39.049999999999997 39.352194347964890 0.000000000000000 + 679 1 1 0.000000000000000 40.469999999999999 39.352194347964890 0.000000000000000 + 680 1 1 0.000000000000000 41.179999999999993 40.581950421338796 0.000000000000000 + 681 2 2 0.000000000000000 1.420000000000000 1.229756073373903 3.3000000000000000 + 682 2 2 0.000000000000000 2.130000000000000 0.000000000000000 3.3000000000000000 + 683 2 2 0.000000000000000 3.550000000000000 0.000000000000000 3.3000000000000000 + 684 2 2 0.000000000000000 4.260000000000000 1.229756073373903 3.3000000000000000 + 685 2 2 0.000000000000000 5.680000000000000 1.229756073373903 3.3000000000000000 + 686 2 2 0.000000000000000 6.390000000000000 0.000000000000000 3.3000000000000000 + 687 2 2 0.000000000000000 7.810000000000000 0.000000000000000 3.3000000000000000 + 688 2 2 0.000000000000000 8.520000000000000 1.229756073373903 3.3000000000000000 + 689 2 2 0.000000000000000 9.940000000000000 1.229756073373903 3.3000000000000000 + 690 2 2 0.000000000000000 10.650000000000000 0.000000000000000 3.3000000000000000 + 691 2 2 0.000000000000000 12.069999999999999 0.000000000000000 3.3000000000000000 + 692 2 2 0.000000000000000 12.779999999999999 1.229756073373903 3.3000000000000000 + 693 2 2 0.000000000000000 14.199999999999999 1.229756073373903 3.3000000000000000 + 694 2 2 0.000000000000000 14.909999999999998 0.000000000000000 3.3000000000000000 + 695 2 2 0.000000000000000 16.329999999999998 0.000000000000000 3.3000000000000000 + 696 2 2 0.000000000000000 17.039999999999999 1.229756073373903 3.3000000000000000 + 697 2 2 0.000000000000000 18.460000000000001 1.229756073373903 3.3000000000000000 + 698 2 2 0.000000000000000 19.170000000000002 0.000000000000000 3.3000000000000000 + 699 2 2 0.000000000000000 20.589999999999996 0.000000000000000 3.3000000000000000 + 700 2 2 0.000000000000000 21.299999999999997 1.229756073373903 3.3000000000000000 + 701 2 2 0.000000000000000 22.719999999999999 1.229756073373903 3.3000000000000000 + 702 2 2 0.000000000000000 23.430000000000000 0.000000000000000 3.3000000000000000 + 703 2 2 0.000000000000000 24.849999999999994 0.000000000000000 3.3000000000000000 + 704 2 2 0.000000000000000 25.559999999999995 1.229756073373903 3.3000000000000000 + 705 2 2 0.000000000000000 26.979999999999997 1.229756073373903 3.3000000000000000 + 706 2 2 0.000000000000000 27.689999999999998 0.000000000000000 3.3000000000000000 + 707 2 2 0.000000000000000 29.109999999999999 0.000000000000000 3.3000000000000000 + 708 2 2 0.000000000000000 29.820000000000000 1.229756073373903 3.3000000000000000 + 709 2 2 0.000000000000000 31.240000000000002 1.229756073373903 3.3000000000000000 + 710 2 2 0.000000000000000 31.950000000000003 0.000000000000000 3.3000000000000000 + 711 2 2 0.000000000000000 33.369999999999997 0.000000000000000 3.3000000000000000 + 712 2 2 0.000000000000000 34.079999999999998 1.229756073373903 3.3000000000000000 + 713 2 2 0.000000000000000 35.500000000000000 1.229756073373903 3.3000000000000000 + 714 2 2 0.000000000000000 36.210000000000001 0.000000000000000 3.3000000000000000 + 715 2 2 0.000000000000000 37.630000000000003 0.000000000000000 3.3000000000000000 + 716 2 2 0.000000000000000 38.340000000000003 1.229756073373903 3.3000000000000000 + 717 2 2 0.000000000000000 39.759999999999998 1.229756073373903 3.3000000000000000 + 718 2 2 0.000000000000000 40.469999999999999 0.000000000000000 3.3000000000000000 + 719 2 2 0.000000000000000 41.890000000000001 0.000000000000000 3.3000000000000000 + 720 2 2 0.000000000000000 42.599999999999994 1.229756073373903 3.3000000000000000 + 721 2 2 0.000000000000000 1.420000000000000 3.689268220121709 3.3000000000000000 + 722 2 2 0.000000000000000 2.130000000000000 2.459512146747806 3.3000000000000000 + 723 2 2 0.000000000000000 3.550000000000000 2.459512146747806 3.3000000000000000 + 724 2 2 0.000000000000000 4.260000000000000 3.689268220121709 3.3000000000000000 + 725 2 2 0.000000000000000 5.680000000000000 3.689268220121709 3.3000000000000000 + 726 2 2 0.000000000000000 6.390000000000000 2.459512146747806 3.3000000000000000 + 727 2 2 0.000000000000000 7.810000000000000 2.459512146747806 3.3000000000000000 + 728 2 2 0.000000000000000 8.520000000000000 3.689268220121709 3.3000000000000000 + 729 2 2 0.000000000000000 9.940000000000000 3.689268220121709 3.3000000000000000 + 730 2 2 0.000000000000000 10.650000000000000 2.459512146747806 3.3000000000000000 + 731 2 2 0.000000000000000 12.069999999999999 2.459512146747806 3.3000000000000000 + 732 2 2 0.000000000000000 12.779999999999999 3.689268220121709 3.3000000000000000 + 733 2 2 0.000000000000000 14.199999999999999 3.689268220121709 3.3000000000000000 + 734 2 2 0.000000000000000 14.909999999999998 2.459512146747806 3.3000000000000000 + 735 2 2 0.000000000000000 16.329999999999998 2.459512146747806 3.3000000000000000 + 736 2 2 0.000000000000000 17.039999999999999 3.689268220121709 3.3000000000000000 + 737 2 2 0.000000000000000 18.460000000000001 3.689268220121709 3.3000000000000000 + 738 2 2 0.000000000000000 19.170000000000002 2.459512146747806 3.3000000000000000 + 739 2 2 0.000000000000000 20.589999999999996 2.459512146747806 3.3000000000000000 + 740 2 2 0.000000000000000 21.299999999999997 3.689268220121709 3.3000000000000000 + 741 2 2 0.000000000000000 22.719999999999999 3.689268220121709 3.3000000000000000 + 742 2 2 0.000000000000000 23.430000000000000 2.459512146747806 3.3000000000000000 + 743 2 2 0.000000000000000 24.849999999999994 2.459512146747806 3.3000000000000000 + 744 2 2 0.000000000000000 25.559999999999995 3.689268220121709 3.3000000000000000 + 745 2 2 0.000000000000000 26.979999999999997 3.689268220121709 3.3000000000000000 + 746 2 2 0.000000000000000 27.689999999999998 2.459512146747806 3.3000000000000000 + 747 2 2 0.000000000000000 29.109999999999999 2.459512146747806 3.3000000000000000 + 748 2 2 0.000000000000000 29.820000000000000 3.689268220121709 3.3000000000000000 + 749 2 2 0.000000000000000 31.240000000000002 3.689268220121709 3.3000000000000000 + 750 2 2 0.000000000000000 31.950000000000003 2.459512146747806 3.3000000000000000 + 751 2 2 0.000000000000000 33.369999999999997 2.459512146747806 3.3000000000000000 + 752 2 2 0.000000000000000 34.079999999999998 3.689268220121709 3.3000000000000000 + 753 2 2 0.000000000000000 35.500000000000000 3.689268220121709 3.3000000000000000 + 754 2 2 0.000000000000000 36.210000000000001 2.459512146747806 3.3000000000000000 + 755 2 2 0.000000000000000 37.630000000000003 2.459512146747806 3.3000000000000000 + 756 2 2 0.000000000000000 38.340000000000003 3.689268220121709 3.3000000000000000 + 757 2 2 0.000000000000000 39.759999999999998 3.689268220121709 3.3000000000000000 + 758 2 2 0.000000000000000 40.469999999999999 2.459512146747806 3.3000000000000000 + 759 2 2 0.000000000000000 41.890000000000001 2.459512146747806 3.3000000000000000 + 760 2 2 0.000000000000000 42.599999999999994 3.689268220121709 3.3000000000000000 + 761 2 2 0.000000000000000 1.420000000000000 6.148780366869514 3.3000000000000000 + 762 2 2 0.000000000000000 2.130000000000000 4.919024293495611 3.3000000000000000 + 763 2 2 0.000000000000000 3.550000000000000 4.919024293495611 3.3000000000000000 + 764 2 2 0.000000000000000 4.260000000000000 6.148780366869514 3.3000000000000000 + 765 2 2 0.000000000000000 5.680000000000000 6.148780366869514 3.3000000000000000 + 766 2 2 0.000000000000000 6.390000000000000 4.919024293495611 3.3000000000000000 + 767 2 2 0.000000000000000 7.810000000000000 4.919024293495611 3.3000000000000000 + 768 2 2 0.000000000000000 8.520000000000000 6.148780366869514 3.3000000000000000 + 769 2 2 0.000000000000000 9.940000000000000 6.148780366869514 3.3000000000000000 + 770 2 2 0.000000000000000 10.650000000000000 4.919024293495611 3.3000000000000000 + 771 2 2 0.000000000000000 12.069999999999999 4.919024293495611 3.3000000000000000 + 772 2 2 0.000000000000000 12.779999999999999 6.148780366869514 3.3000000000000000 + 773 2 2 0.000000000000000 14.199999999999999 6.148780366869514 3.3000000000000000 + 774 2 2 0.000000000000000 14.909999999999998 4.919024293495611 3.3000000000000000 + 775 2 2 0.000000000000000 16.329999999999998 4.919024293495611 3.3000000000000000 + 776 2 2 0.000000000000000 17.039999999999999 6.148780366869514 3.3000000000000000 + 777 2 2 0.000000000000000 18.460000000000001 6.148780366869514 3.3000000000000000 + 778 2 2 0.000000000000000 19.170000000000002 4.919024293495611 3.3000000000000000 + 779 2 2 0.000000000000000 20.589999999999996 4.919024293495611 3.3000000000000000 + 780 2 2 0.000000000000000 21.299999999999997 6.148780366869514 3.3000000000000000 + 781 2 2 0.000000000000000 22.719999999999999 6.148780366869514 3.3000000000000000 + 782 2 2 0.000000000000000 23.430000000000000 4.919024293495611 3.3000000000000000 + 783 2 2 0.000000000000000 24.849999999999994 4.919024293495611 3.3000000000000000 + 784 2 2 0.000000000000000 25.559999999999995 6.148780366869514 3.3000000000000000 + 785 2 2 0.000000000000000 26.979999999999997 6.148780366869514 3.3000000000000000 + 786 2 2 0.000000000000000 27.689999999999998 4.919024293495611 3.3000000000000000 + 787 2 2 0.000000000000000 29.109999999999999 4.919024293495611 3.3000000000000000 + 788 2 2 0.000000000000000 29.820000000000000 6.148780366869514 3.3000000000000000 + 789 2 2 0.000000000000000 31.240000000000002 6.148780366869514 3.3000000000000000 + 790 2 2 0.000000000000000 31.950000000000003 4.919024293495611 3.3000000000000000 + 791 2 2 0.000000000000000 33.369999999999997 4.919024293495611 3.3000000000000000 + 792 2 2 0.000000000000000 34.079999999999998 6.148780366869514 3.3000000000000000 + 793 2 2 0.000000000000000 35.500000000000000 6.148780366869514 3.3000000000000000 + 794 2 2 0.000000000000000 36.210000000000001 4.919024293495611 3.3000000000000000 + 795 2 2 0.000000000000000 37.630000000000003 4.919024293495611 3.3000000000000000 + 796 2 2 0.000000000000000 38.340000000000003 6.148780366869514 3.3000000000000000 + 797 2 2 0.000000000000000 39.759999999999998 6.148780366869514 3.3000000000000000 + 798 2 2 0.000000000000000 40.469999999999999 4.919024293495611 3.3000000000000000 + 799 2 2 0.000000000000000 41.890000000000001 4.919024293495611 3.3000000000000000 + 800 2 2 0.000000000000000 42.599999999999994 6.148780366869514 3.3000000000000000 + 801 2 2 0.000000000000000 1.420000000000000 8.608292513617320 3.3000000000000000 + 802 2 2 0.000000000000000 2.130000000000000 7.378536440243417 3.3000000000000000 + 803 2 2 0.000000000000000 3.550000000000000 7.378536440243417 3.3000000000000000 + 804 2 2 0.000000000000000 4.260000000000000 8.608292513617320 3.3000000000000000 + 805 2 2 0.000000000000000 5.680000000000000 8.608292513617320 3.3000000000000000 + 806 2 2 0.000000000000000 6.390000000000000 7.378536440243417 3.3000000000000000 + 807 2 2 0.000000000000000 7.810000000000000 7.378536440243417 3.3000000000000000 + 808 2 2 0.000000000000000 8.520000000000000 8.608292513617320 3.3000000000000000 + 809 2 2 0.000000000000000 9.940000000000000 8.608292513617320 3.3000000000000000 + 810 2 2 0.000000000000000 10.650000000000000 7.378536440243417 3.3000000000000000 + 811 2 2 0.000000000000000 12.069999999999999 7.378536440243417 3.3000000000000000 + 812 2 2 0.000000000000000 12.779999999999999 8.608292513617320 3.3000000000000000 + 813 2 2 0.000000000000000 14.199999999999999 8.608292513617320 3.3000000000000000 + 814 2 2 0.000000000000000 14.909999999999998 7.378536440243417 3.3000000000000000 + 815 2 2 0.000000000000000 16.329999999999998 7.378536440243417 3.3000000000000000 + 816 2 2 0.000000000000000 17.039999999999999 8.608292513617320 3.3000000000000000 + 817 2 2 0.000000000000000 18.460000000000001 8.608292513617320 3.3000000000000000 + 818 2 2 0.000000000000000 19.170000000000002 7.378536440243417 3.3000000000000000 + 819 2 2 0.000000000000000 20.589999999999996 7.378536440243417 3.3000000000000000 + 820 2 2 0.000000000000000 21.299999999999997 8.608292513617320 3.3000000000000000 + 821 2 2 0.000000000000000 22.719999999999999 8.608292513617320 3.3000000000000000 + 822 2 2 0.000000000000000 23.430000000000000 7.378536440243417 3.3000000000000000 + 823 2 2 0.000000000000000 24.849999999999994 7.378536440243417 3.3000000000000000 + 824 2 2 0.000000000000000 25.559999999999995 8.608292513617320 3.3000000000000000 + 825 2 2 0.000000000000000 26.979999999999997 8.608292513617320 3.3000000000000000 + 826 2 2 0.000000000000000 27.689999999999998 7.378536440243417 3.3000000000000000 + 827 2 2 0.000000000000000 29.109999999999999 7.378536440243417 3.3000000000000000 + 828 2 2 0.000000000000000 29.820000000000000 8.608292513617320 3.3000000000000000 + 829 2 2 0.000000000000000 31.240000000000002 8.608292513617320 3.3000000000000000 + 830 2 2 0.000000000000000 31.950000000000003 7.378536440243417 3.3000000000000000 + 831 2 2 0.000000000000000 33.369999999999997 7.378536440243417 3.3000000000000000 + 832 2 2 0.000000000000000 34.079999999999998 8.608292513617320 3.3000000000000000 + 833 2 2 0.000000000000000 35.500000000000000 8.608292513617320 3.3000000000000000 + 834 2 2 0.000000000000000 36.210000000000001 7.378536440243417 3.3000000000000000 + 835 2 2 0.000000000000000 37.630000000000003 7.378536440243417 3.3000000000000000 + 836 2 2 0.000000000000000 38.340000000000003 8.608292513617320 3.3000000000000000 + 837 2 2 0.000000000000000 39.759999999999998 8.608292513617320 3.3000000000000000 + 838 2 2 0.000000000000000 40.469999999999999 7.378536440243417 3.3000000000000000 + 839 2 2 0.000000000000000 41.890000000000001 7.378536440243417 3.3000000000000000 + 840 2 2 0.000000000000000 42.599999999999994 8.608292513617320 3.3000000000000000 + 841 2 2 0.000000000000000 1.420000000000000 11.067804660365125 3.3000000000000000 + 842 2 2 0.000000000000000 2.130000000000000 9.838048586991222 3.3000000000000000 + 843 2 2 0.000000000000000 3.550000000000000 9.838048586991222 3.3000000000000000 + 844 2 2 0.000000000000000 4.260000000000000 11.067804660365125 3.3000000000000000 + 845 2 2 0.000000000000000 5.680000000000000 11.067804660365125 3.3000000000000000 + 846 2 2 0.000000000000000 6.390000000000000 9.838048586991222 3.3000000000000000 + 847 2 2 0.000000000000000 7.810000000000000 9.838048586991222 3.3000000000000000 + 848 2 2 0.000000000000000 8.520000000000000 11.067804660365125 3.3000000000000000 + 849 2 2 0.000000000000000 9.940000000000000 11.067804660365125 3.3000000000000000 + 850 2 2 0.000000000000000 10.650000000000000 9.838048586991222 3.3000000000000000 + 851 2 2 0.000000000000000 12.069999999999999 9.838048586991222 3.3000000000000000 + 852 2 2 0.000000000000000 12.779999999999999 11.067804660365125 3.3000000000000000 + 853 2 2 0.000000000000000 14.199999999999999 11.067804660365125 3.3000000000000000 + 854 2 2 0.000000000000000 14.909999999999998 9.838048586991222 3.3000000000000000 + 855 2 2 0.000000000000000 16.329999999999998 9.838048586991222 3.3000000000000000 + 856 2 2 0.000000000000000 17.039999999999999 11.067804660365125 3.3000000000000000 + 857 2 2 0.000000000000000 18.460000000000001 11.067804660365125 3.3000000000000000 + 858 2 2 0.000000000000000 19.170000000000002 9.838048586991222 3.3000000000000000 + 859 2 2 0.000000000000000 20.589999999999996 9.838048586991222 3.3000000000000000 + 860 2 2 0.000000000000000 21.299999999999997 11.067804660365125 3.3000000000000000 + 861 2 2 0.000000000000000 22.719999999999999 11.067804660365125 3.3000000000000000 + 862 2 2 0.000000000000000 23.430000000000000 9.838048586991222 3.3000000000000000 + 863 2 2 0.000000000000000 24.849999999999994 9.838048586991222 3.3000000000000000 + 864 2 2 0.000000000000000 25.559999999999995 11.067804660365125 3.3000000000000000 + 865 2 2 0.000000000000000 26.979999999999997 11.067804660365125 3.3000000000000000 + 866 2 2 0.000000000000000 27.689999999999998 9.838048586991222 3.3000000000000000 + 867 2 2 0.000000000000000 29.109999999999999 9.838048586991222 3.3000000000000000 + 868 2 2 0.000000000000000 29.820000000000000 11.067804660365125 3.3000000000000000 + 869 2 2 0.000000000000000 31.240000000000002 11.067804660365125 3.3000000000000000 + 870 2 2 0.000000000000000 31.950000000000003 9.838048586991222 3.3000000000000000 + 871 2 2 0.000000000000000 33.369999999999997 9.838048586991222 3.3000000000000000 + 872 2 2 0.000000000000000 34.079999999999998 11.067804660365125 3.3000000000000000 + 873 2 2 0.000000000000000 35.500000000000000 11.067804660365125 3.3000000000000000 + 874 2 2 0.000000000000000 36.210000000000001 9.838048586991222 3.3000000000000000 + 875 2 2 0.000000000000000 37.630000000000003 9.838048586991222 3.3000000000000000 + 876 2 2 0.000000000000000 38.340000000000003 11.067804660365125 3.3000000000000000 + 877 2 2 0.000000000000000 39.759999999999998 11.067804660365125 3.3000000000000000 + 878 2 2 0.000000000000000 40.469999999999999 9.838048586991222 3.3000000000000000 + 879 2 2 0.000000000000000 41.890000000000001 9.838048586991222 3.3000000000000000 + 880 2 2 0.000000000000000 42.599999999999994 11.067804660365125 3.3000000000000000 + 881 2 2 0.000000000000000 1.420000000000000 13.527316807112930 3.3000000000000000 + 882 2 2 0.000000000000000 2.130000000000000 12.297560733739028 3.3000000000000000 + 883 2 2 0.000000000000000 3.550000000000000 12.297560733739028 3.3000000000000000 + 884 2 2 0.000000000000000 4.260000000000000 13.527316807112930 3.3000000000000000 + 885 2 2 0.000000000000000 5.680000000000000 13.527316807112930 3.3000000000000000 + 886 2 2 0.000000000000000 6.390000000000000 12.297560733739028 3.3000000000000000 + 887 2 2 0.000000000000000 7.810000000000000 12.297560733739028 3.3000000000000000 + 888 2 2 0.000000000000000 8.520000000000000 13.527316807112930 3.3000000000000000 + 889 2 2 0.000000000000000 9.940000000000000 13.527316807112930 3.3000000000000000 + 890 2 2 0.000000000000000 10.650000000000000 12.297560733739028 3.3000000000000000 + 891 2 2 0.000000000000000 12.069999999999999 12.297560733739028 3.3000000000000000 + 892 2 2 0.000000000000000 12.779999999999999 13.527316807112930 3.3000000000000000 + 893 2 2 0.000000000000000 14.199999999999999 13.527316807112930 3.3000000000000000 + 894 2 2 0.000000000000000 14.909999999999998 12.297560733739028 3.3000000000000000 + 895 2 2 0.000000000000000 16.329999999999998 12.297560733739028 3.3000000000000000 + 896 2 2 0.000000000000000 17.039999999999999 13.527316807112930 3.3000000000000000 + 897 2 2 0.000000000000000 18.460000000000001 13.527316807112930 3.3000000000000000 + 898 2 2 0.000000000000000 19.170000000000002 12.297560733739028 3.3000000000000000 + 899 2 2 0.000000000000000 20.589999999999996 12.297560733739028 3.3000000000000000 + 900 2 2 0.000000000000000 21.299999999999997 13.527316807112930 3.3000000000000000 + 901 2 2 0.000000000000000 22.719999999999999 13.527316807112930 3.3000000000000000 + 902 2 2 0.000000000000000 23.430000000000000 12.297560733739028 3.3000000000000000 + 903 2 2 0.000000000000000 24.849999999999994 12.297560733739028 3.3000000000000000 + 904 2 2 0.000000000000000 25.559999999999995 13.527316807112930 3.3000000000000000 + 905 2 2 0.000000000000000 26.979999999999997 13.527316807112930 3.3000000000000000 + 906 2 2 0.000000000000000 27.689999999999998 12.297560733739028 3.3000000000000000 + 907 2 2 0.000000000000000 29.109999999999999 12.297560733739028 3.3000000000000000 + 908 2 2 0.000000000000000 29.820000000000000 13.527316807112930 3.3000000000000000 + 909 2 2 0.000000000000000 31.240000000000002 13.527316807112930 3.3000000000000000 + 910 2 2 0.000000000000000 31.950000000000003 12.297560733739028 3.3000000000000000 + 911 2 2 0.000000000000000 33.369999999999997 12.297560733739028 3.3000000000000000 + 912 2 2 0.000000000000000 34.079999999999998 13.527316807112930 3.3000000000000000 + 913 2 2 0.000000000000000 35.500000000000000 13.527316807112930 3.3000000000000000 + 914 2 2 0.000000000000000 36.210000000000001 12.297560733739028 3.3000000000000000 + 915 2 2 0.000000000000000 37.630000000000003 12.297560733739028 3.3000000000000000 + 916 2 2 0.000000000000000 38.340000000000003 13.527316807112930 3.3000000000000000 + 917 2 2 0.000000000000000 39.759999999999998 13.527316807112930 3.3000000000000000 + 918 2 2 0.000000000000000 40.469999999999999 12.297560733739028 3.3000000000000000 + 919 2 2 0.000000000000000 41.890000000000001 12.297560733739028 3.3000000000000000 + 920 2 2 0.000000000000000 42.599999999999994 13.527316807112930 3.3000000000000000 + 921 2 2 0.000000000000000 1.420000000000000 15.986828953860737 3.3000000000000000 + 922 2 2 0.000000000000000 2.130000000000000 14.757072880486835 3.3000000000000000 + 923 2 2 0.000000000000000 3.550000000000000 14.757072880486835 3.3000000000000000 + 924 2 2 0.000000000000000 4.260000000000000 15.986828953860737 3.3000000000000000 + 925 2 2 0.000000000000000 5.680000000000000 15.986828953860737 3.3000000000000000 + 926 2 2 0.000000000000000 6.390000000000000 14.757072880486835 3.3000000000000000 + 927 2 2 0.000000000000000 7.810000000000000 14.757072880486835 3.3000000000000000 + 928 2 2 0.000000000000000 8.520000000000000 15.986828953860737 3.3000000000000000 + 929 2 2 0.000000000000000 9.940000000000000 15.986828953860737 3.3000000000000000 + 930 2 2 0.000000000000000 10.650000000000000 14.757072880486835 3.3000000000000000 + 931 2 2 0.000000000000000 12.069999999999999 14.757072880486835 3.3000000000000000 + 932 2 2 0.000000000000000 12.779999999999999 15.986828953860737 3.3000000000000000 + 933 2 2 0.000000000000000 14.199999999999999 15.986828953860737 3.3000000000000000 + 934 2 2 0.000000000000000 14.909999999999998 14.757072880486835 3.3000000000000000 + 935 2 2 0.000000000000000 16.329999999999998 14.757072880486835 3.3000000000000000 + 936 2 2 0.000000000000000 17.039999999999999 15.986828953860737 3.3000000000000000 + 937 2 2 0.000000000000000 18.460000000000001 15.986828953860737 3.3000000000000000 + 938 2 2 0.000000000000000 19.170000000000002 14.757072880486835 3.3000000000000000 + 939 2 2 0.000000000000000 20.589999999999996 14.757072880486835 3.3000000000000000 + 940 2 2 0.000000000000000 21.299999999999997 15.986828953860737 3.3000000000000000 + 941 2 2 0.000000000000000 22.719999999999999 15.986828953860737 3.3000000000000000 + 942 2 2 0.000000000000000 23.430000000000000 14.757072880486835 3.3000000000000000 + 943 2 2 0.000000000000000 24.849999999999994 14.757072880486835 3.3000000000000000 + 944 2 2 0.000000000000000 25.559999999999995 15.986828953860737 3.3000000000000000 + 945 2 2 0.000000000000000 26.979999999999997 15.986828953860737 3.3000000000000000 + 946 2 2 0.000000000000000 27.689999999999998 14.757072880486835 3.3000000000000000 + 947 2 2 0.000000000000000 29.109999999999999 14.757072880486835 3.3000000000000000 + 948 2 2 0.000000000000000 29.820000000000000 15.986828953860737 3.3000000000000000 + 949 2 2 0.000000000000000 31.240000000000002 15.986828953860737 3.3000000000000000 + 950 2 2 0.000000000000000 31.950000000000003 14.757072880486835 3.3000000000000000 + 951 2 2 0.000000000000000 33.369999999999997 14.757072880486835 3.3000000000000000 + 952 2 2 0.000000000000000 34.079999999999998 15.986828953860737 3.3000000000000000 + 953 2 2 0.000000000000000 35.500000000000000 15.986828953860737 3.3000000000000000 + 954 2 2 0.000000000000000 36.210000000000001 14.757072880486835 3.3000000000000000 + 955 2 2 0.000000000000000 37.630000000000003 14.757072880486835 3.3000000000000000 + 956 2 2 0.000000000000000 38.340000000000003 15.986828953860737 3.3000000000000000 + 957 2 2 0.000000000000000 39.759999999999998 15.986828953860737 3.3000000000000000 + 958 2 2 0.000000000000000 40.469999999999999 14.757072880486835 3.3000000000000000 + 959 2 2 0.000000000000000 41.890000000000001 14.757072880486835 3.3000000000000000 + 960 2 2 0.000000000000000 42.599999999999994 15.986828953860737 3.3000000000000000 + 961 2 2 0.000000000000000 1.420000000000000 18.446341100608542 3.3000000000000000 + 962 2 2 0.000000000000000 2.130000000000000 17.216585027234640 3.3000000000000000 + 963 2 2 0.000000000000000 3.550000000000000 17.216585027234640 3.3000000000000000 + 964 2 2 0.000000000000000 4.260000000000000 18.446341100608542 3.3000000000000000 + 965 2 2 0.000000000000000 5.680000000000000 18.446341100608542 3.3000000000000000 + 966 2 2 0.000000000000000 6.390000000000000 17.216585027234640 3.3000000000000000 + 967 2 2 0.000000000000000 7.810000000000000 17.216585027234640 3.3000000000000000 + 968 2 2 0.000000000000000 8.520000000000000 18.446341100608542 3.3000000000000000 + 969 2 2 0.000000000000000 9.940000000000000 18.446341100608542 3.3000000000000000 + 970 2 2 0.000000000000000 10.650000000000000 17.216585027234640 3.3000000000000000 + 971 2 2 0.000000000000000 12.069999999999999 17.216585027234640 3.3000000000000000 + 972 2 2 0.000000000000000 12.779999999999999 18.446341100608542 3.3000000000000000 + 973 2 2 0.000000000000000 14.199999999999999 18.446341100608542 3.3000000000000000 + 974 2 2 0.000000000000000 14.909999999999998 17.216585027234640 3.3000000000000000 + 975 2 2 0.000000000000000 16.329999999999998 17.216585027234640 3.3000000000000000 + 976 2 2 0.000000000000000 17.039999999999999 18.446341100608542 3.3000000000000000 + 977 2 2 0.000000000000000 18.460000000000001 18.446341100608542 3.3000000000000000 + 978 2 2 0.000000000000000 19.170000000000002 17.216585027234640 3.3000000000000000 + 979 2 2 0.000000000000000 20.589999999999996 17.216585027234640 3.3000000000000000 + 980 2 2 0.000000000000000 21.299999999999997 18.446341100608542 3.3000000000000000 + 981 2 2 0.000000000000000 22.719999999999999 18.446341100608542 3.3000000000000000 + 982 2 2 0.000000000000000 23.430000000000000 17.216585027234640 3.3000000000000000 + 983 2 2 0.000000000000000 24.849999999999994 17.216585027234640 3.3000000000000000 + 984 2 2 0.000000000000000 25.559999999999995 18.446341100608542 3.3000000000000000 + 985 2 2 0.000000000000000 26.979999999999997 18.446341100608542 3.3000000000000000 + 986 2 2 0.000000000000000 27.689999999999998 17.216585027234640 3.3000000000000000 + 987 2 2 0.000000000000000 29.109999999999999 17.216585027234640 3.3000000000000000 + 988 2 2 0.000000000000000 29.820000000000000 18.446341100608542 3.3000000000000000 + 989 2 2 0.000000000000000 31.240000000000002 18.446341100608542 3.3000000000000000 + 990 2 2 0.000000000000000 31.950000000000003 17.216585027234640 3.3000000000000000 + 991 2 2 0.000000000000000 33.369999999999997 17.216585027234640 3.3000000000000000 + 992 2 2 0.000000000000000 34.079999999999998 18.446341100608542 3.3000000000000000 + 993 2 2 0.000000000000000 35.500000000000000 18.446341100608542 3.3000000000000000 + 994 2 2 0.000000000000000 36.210000000000001 17.216585027234640 3.3000000000000000 + 995 2 2 0.000000000000000 37.630000000000003 17.216585027234640 3.3000000000000000 + 996 2 2 0.000000000000000 38.340000000000003 18.446341100608542 3.3000000000000000 + 997 2 2 0.000000000000000 39.759999999999998 18.446341100608542 3.3000000000000000 + 998 2 2 0.000000000000000 40.469999999999999 17.216585027234640 3.3000000000000000 + 999 2 2 0.000000000000000 41.890000000000001 17.216585027234640 3.3000000000000000 + 1000 2 2 0.000000000000000 42.599999999999994 18.446341100608542 3.3000000000000000 + 1001 2 2 0.000000000000000 1.420000000000000 20.905853247356347 3.3000000000000000 + 1002 2 2 0.000000000000000 2.130000000000000 19.676097173982445 3.3000000000000000 + 1003 2 2 0.000000000000000 3.550000000000000 19.676097173982445 3.3000000000000000 + 1004 2 2 0.000000000000000 4.260000000000000 20.905853247356347 3.3000000000000000 + 1005 2 2 0.000000000000000 5.680000000000000 20.905853247356347 3.3000000000000000 + 1006 2 2 0.000000000000000 6.390000000000000 19.676097173982445 3.3000000000000000 + 1007 2 2 0.000000000000000 7.810000000000000 19.676097173982445 3.3000000000000000 + 1008 2 2 0.000000000000000 8.520000000000000 20.905853247356347 3.3000000000000000 + 1009 2 2 0.000000000000000 9.940000000000000 20.905853247356347 3.3000000000000000 + 1010 2 2 0.000000000000000 10.650000000000000 19.676097173982445 3.3000000000000000 + 1011 2 2 0.000000000000000 12.069999999999999 19.676097173982445 3.3000000000000000 + 1012 2 2 0.000000000000000 12.779999999999999 20.905853247356347 3.3000000000000000 + 1013 2 2 0.000000000000000 14.199999999999999 20.905853247356347 3.3000000000000000 + 1014 2 2 0.000000000000000 14.909999999999998 19.676097173982445 3.3000000000000000 + 1015 2 2 0.000000000000000 16.329999999999998 19.676097173982445 3.3000000000000000 + 1016 2 2 0.000000000000000 17.039999999999999 20.905853247356347 3.3000000000000000 + 1017 2 2 0.000000000000000 18.460000000000001 20.905853247356347 3.3000000000000000 + 1018 2 2 0.000000000000000 19.170000000000002 19.676097173982445 3.3000000000000000 + 1019 2 2 0.000000000000000 20.589999999999996 19.676097173982445 3.3000000000000000 + 1020 2 2 0.000000000000000 21.299999999999997 20.905853247356347 3.3000000000000000 + 1021 2 2 0.000000000000000 22.719999999999999 20.905853247356347 3.3000000000000000 + 1022 2 2 0.000000000000000 23.430000000000000 19.676097173982445 3.3000000000000000 + 1023 2 2 0.000000000000000 24.849999999999994 19.676097173982445 3.3000000000000000 + 1024 2 2 0.000000000000000 25.559999999999995 20.905853247356347 3.3000000000000000 + 1025 2 2 0.000000000000000 26.979999999999997 20.905853247356347 3.3000000000000000 + 1026 2 2 0.000000000000000 27.689999999999998 19.676097173982445 3.3000000000000000 + 1027 2 2 0.000000000000000 29.109999999999999 19.676097173982445 3.3000000000000000 + 1028 2 2 0.000000000000000 29.820000000000000 20.905853247356347 3.3000000000000000 + 1029 2 2 0.000000000000000 31.240000000000002 20.905853247356347 3.3000000000000000 + 1030 2 2 0.000000000000000 31.950000000000003 19.676097173982445 3.3000000000000000 + 1031 2 2 0.000000000000000 33.369999999999997 19.676097173982445 3.3000000000000000 + 1032 2 2 0.000000000000000 34.079999999999998 20.905853247356347 3.3000000000000000 + 1033 2 2 0.000000000000000 35.500000000000000 20.905853247356347 3.3000000000000000 + 1034 2 2 0.000000000000000 36.210000000000001 19.676097173982445 3.3000000000000000 + 1035 2 2 0.000000000000000 37.630000000000003 19.676097173982445 3.3000000000000000 + 1036 2 2 0.000000000000000 38.340000000000003 20.905853247356347 3.3000000000000000 + 1037 2 2 0.000000000000000 39.759999999999998 20.905853247356347 3.3000000000000000 + 1038 2 2 0.000000000000000 40.469999999999999 19.676097173982445 3.3000000000000000 + 1039 2 2 0.000000000000000 41.890000000000001 19.676097173982445 3.3000000000000000 + 1040 2 2 0.000000000000000 42.599999999999994 20.905853247356347 3.3000000000000000 + 1041 2 2 0.000000000000000 1.420000000000000 23.365365394104153 3.3000000000000000 + 1042 2 2 0.000000000000000 2.130000000000000 22.135609320730250 3.3000000000000000 + 1043 2 2 0.000000000000000 3.550000000000000 22.135609320730250 3.3000000000000000 + 1044 2 2 0.000000000000000 4.260000000000000 23.365365394104153 3.3000000000000000 + 1045 2 2 0.000000000000000 5.680000000000000 23.365365394104153 3.3000000000000000 + 1046 2 2 0.000000000000000 6.390000000000000 22.135609320730250 3.3000000000000000 + 1047 2 2 0.000000000000000 7.810000000000000 22.135609320730250 3.3000000000000000 + 1048 2 2 0.000000000000000 8.520000000000000 23.365365394104153 3.3000000000000000 + 1049 2 2 0.000000000000000 9.940000000000000 23.365365394104153 3.3000000000000000 + 1050 2 2 0.000000000000000 10.650000000000000 22.135609320730250 3.3000000000000000 + 1051 2 2 0.000000000000000 12.069999999999999 22.135609320730250 3.3000000000000000 + 1052 2 2 0.000000000000000 12.779999999999999 23.365365394104153 3.3000000000000000 + 1053 2 2 0.000000000000000 14.199999999999999 23.365365394104153 3.3000000000000000 + 1054 2 2 0.000000000000000 14.909999999999998 22.135609320730250 3.3000000000000000 + 1055 2 2 0.000000000000000 16.329999999999998 22.135609320730250 3.3000000000000000 + 1056 2 2 0.000000000000000 17.039999999999999 23.365365394104153 3.3000000000000000 + 1057 2 2 0.000000000000000 18.460000000000001 23.365365394104153 3.3000000000000000 + 1058 2 2 0.000000000000000 19.170000000000002 22.135609320730250 3.3000000000000000 + 1059 2 2 0.000000000000000 20.589999999999996 22.135609320730250 3.3000000000000000 + 1060 2 2 0.000000000000000 21.299999999999997 23.365365394104153 3.3000000000000000 + 1061 2 2 0.000000000000000 22.719999999999999 23.365365394104153 3.3000000000000000 + 1062 2 2 0.000000000000000 23.430000000000000 22.135609320730250 3.3000000000000000 + 1063 2 2 0.000000000000000 24.849999999999994 22.135609320730250 3.3000000000000000 + 1064 2 2 0.000000000000000 25.559999999999995 23.365365394104153 3.3000000000000000 + 1065 2 2 0.000000000000000 26.979999999999997 23.365365394104153 3.3000000000000000 + 1066 2 2 0.000000000000000 27.689999999999998 22.135609320730250 3.3000000000000000 + 1067 2 2 0.000000000000000 29.109999999999999 22.135609320730250 3.3000000000000000 + 1068 2 2 0.000000000000000 29.820000000000000 23.365365394104153 3.3000000000000000 + 1069 2 2 0.000000000000000 31.240000000000002 23.365365394104153 3.3000000000000000 + 1070 2 2 0.000000000000000 31.950000000000003 22.135609320730250 3.3000000000000000 + 1071 2 2 0.000000000000000 33.369999999999997 22.135609320730250 3.3000000000000000 + 1072 2 2 0.000000000000000 34.079999999999998 23.365365394104153 3.3000000000000000 + 1073 2 2 0.000000000000000 35.500000000000000 23.365365394104153 3.3000000000000000 + 1074 2 2 0.000000000000000 36.210000000000001 22.135609320730250 3.3000000000000000 + 1075 2 2 0.000000000000000 37.630000000000003 22.135609320730250 3.3000000000000000 + 1076 2 2 0.000000000000000 38.340000000000003 23.365365394104153 3.3000000000000000 + 1077 2 2 0.000000000000000 39.759999999999998 23.365365394104153 3.3000000000000000 + 1078 2 2 0.000000000000000 40.469999999999999 22.135609320730250 3.3000000000000000 + 1079 2 2 0.000000000000000 41.890000000000001 22.135609320730250 3.3000000000000000 + 1080 2 2 0.000000000000000 42.599999999999994 23.365365394104153 3.3000000000000000 + 1081 2 2 0.000000000000000 1.420000000000000 25.824877540851958 3.3000000000000000 + 1082 2 2 0.000000000000000 2.130000000000000 24.595121467478055 3.3000000000000000 + 1083 2 2 0.000000000000000 3.550000000000000 24.595121467478055 3.3000000000000000 + 1084 2 2 0.000000000000000 4.260000000000000 25.824877540851958 3.3000000000000000 + 1085 2 2 0.000000000000000 5.680000000000000 25.824877540851958 3.3000000000000000 + 1086 2 2 0.000000000000000 6.390000000000000 24.595121467478055 3.3000000000000000 + 1087 2 2 0.000000000000000 7.810000000000000 24.595121467478055 3.3000000000000000 + 1088 2 2 0.000000000000000 8.520000000000000 25.824877540851958 3.3000000000000000 + 1089 2 2 0.000000000000000 9.940000000000000 25.824877540851958 3.3000000000000000 + 1090 2 2 0.000000000000000 10.650000000000000 24.595121467478055 3.3000000000000000 + 1091 2 2 0.000000000000000 12.069999999999999 24.595121467478055 3.3000000000000000 + 1092 2 2 0.000000000000000 12.779999999999999 25.824877540851958 3.3000000000000000 + 1093 2 2 0.000000000000000 14.199999999999999 25.824877540851958 3.3000000000000000 + 1094 2 2 0.000000000000000 14.909999999999998 24.595121467478055 3.3000000000000000 + 1095 2 2 0.000000000000000 16.329999999999998 24.595121467478055 3.3000000000000000 + 1096 2 2 0.000000000000000 17.039999999999999 25.824877540851958 3.3000000000000000 + 1097 2 2 0.000000000000000 18.460000000000001 25.824877540851958 3.3000000000000000 + 1098 2 2 0.000000000000000 19.170000000000002 24.595121467478055 3.3000000000000000 + 1099 2 2 0.000000000000000 20.589999999999996 24.595121467478055 3.3000000000000000 + 1100 2 2 0.000000000000000 21.299999999999997 25.824877540851958 3.3000000000000000 + 1101 2 2 0.000000000000000 22.719999999999999 25.824877540851958 3.3000000000000000 + 1102 2 2 0.000000000000000 23.430000000000000 24.595121467478055 3.3000000000000000 + 1103 2 2 0.000000000000000 24.849999999999994 24.595121467478055 3.3000000000000000 + 1104 2 2 0.000000000000000 25.559999999999995 25.824877540851958 3.3000000000000000 + 1105 2 2 0.000000000000000 26.979999999999997 25.824877540851958 3.3000000000000000 + 1106 2 2 0.000000000000000 27.689999999999998 24.595121467478055 3.3000000000000000 + 1107 2 2 0.000000000000000 29.109999999999999 24.595121467478055 3.3000000000000000 + 1108 2 2 0.000000000000000 29.820000000000000 25.824877540851958 3.3000000000000000 + 1109 2 2 0.000000000000000 31.240000000000002 25.824877540851958 3.3000000000000000 + 1110 2 2 0.000000000000000 31.950000000000003 24.595121467478055 3.3000000000000000 + 1111 2 2 0.000000000000000 33.369999999999997 24.595121467478055 3.3000000000000000 + 1112 2 2 0.000000000000000 34.079999999999998 25.824877540851958 3.3000000000000000 + 1113 2 2 0.000000000000000 35.500000000000000 25.824877540851958 3.3000000000000000 + 1114 2 2 0.000000000000000 36.210000000000001 24.595121467478055 3.3000000000000000 + 1115 2 2 0.000000000000000 37.630000000000003 24.595121467478055 3.3000000000000000 + 1116 2 2 0.000000000000000 38.340000000000003 25.824877540851958 3.3000000000000000 + 1117 2 2 0.000000000000000 39.759999999999998 25.824877540851958 3.3000000000000000 + 1118 2 2 0.000000000000000 40.469999999999999 24.595121467478055 3.3000000000000000 + 1119 2 2 0.000000000000000 41.890000000000001 24.595121467478055 3.3000000000000000 + 1120 2 2 0.000000000000000 42.599999999999994 25.824877540851958 3.3000000000000000 + 1121 2 2 0.000000000000000 1.420000000000000 28.284389687599763 3.3000000000000000 + 1122 2 2 0.000000000000000 2.130000000000000 27.054633614225860 3.3000000000000000 + 1123 2 2 0.000000000000000 3.550000000000000 27.054633614225860 3.3000000000000000 + 1124 2 2 0.000000000000000 4.260000000000000 28.284389687599763 3.3000000000000000 + 1125 2 2 0.000000000000000 5.680000000000000 28.284389687599763 3.3000000000000000 + 1126 2 2 0.000000000000000 6.390000000000000 27.054633614225860 3.3000000000000000 + 1127 2 2 0.000000000000000 7.810000000000000 27.054633614225860 3.3000000000000000 + 1128 2 2 0.000000000000000 8.520000000000000 28.284389687599763 3.3000000000000000 + 1129 2 2 0.000000000000000 9.940000000000000 28.284389687599763 3.3000000000000000 + 1130 2 2 0.000000000000000 10.650000000000000 27.054633614225860 3.3000000000000000 + 1131 2 2 0.000000000000000 12.069999999999999 27.054633614225860 3.3000000000000000 + 1132 2 2 0.000000000000000 12.779999999999999 28.284389687599763 3.3000000000000000 + 1133 2 2 0.000000000000000 14.199999999999999 28.284389687599763 3.3000000000000000 + 1134 2 2 0.000000000000000 14.909999999999998 27.054633614225860 3.3000000000000000 + 1135 2 2 0.000000000000000 16.329999999999998 27.054633614225860 3.3000000000000000 + 1136 2 2 0.000000000000000 17.039999999999999 28.284389687599763 3.3000000000000000 + 1137 2 2 0.000000000000000 18.460000000000001 28.284389687599763 3.3000000000000000 + 1138 2 2 0.000000000000000 19.170000000000002 27.054633614225860 3.3000000000000000 + 1139 2 2 0.000000000000000 20.589999999999996 27.054633614225860 3.3000000000000000 + 1140 2 2 0.000000000000000 21.299999999999997 28.284389687599763 3.3000000000000000 + 1141 2 2 0.000000000000000 22.719999999999999 28.284389687599763 3.3000000000000000 + 1142 2 2 0.000000000000000 23.430000000000000 27.054633614225860 3.3000000000000000 + 1143 2 2 0.000000000000000 24.849999999999994 27.054633614225860 3.3000000000000000 + 1144 2 2 0.000000000000000 25.559999999999995 28.284389687599763 3.3000000000000000 + 1145 2 2 0.000000000000000 26.979999999999997 28.284389687599763 3.3000000000000000 + 1146 2 2 0.000000000000000 27.689999999999998 27.054633614225860 3.3000000000000000 + 1147 2 2 0.000000000000000 29.109999999999999 27.054633614225860 3.3000000000000000 + 1148 2 2 0.000000000000000 29.820000000000000 28.284389687599763 3.3000000000000000 + 1149 2 2 0.000000000000000 31.240000000000002 28.284389687599763 3.3000000000000000 + 1150 2 2 0.000000000000000 31.950000000000003 27.054633614225860 3.3000000000000000 + 1151 2 2 0.000000000000000 33.369999999999997 27.054633614225860 3.3000000000000000 + 1152 2 2 0.000000000000000 34.079999999999998 28.284389687599763 3.3000000000000000 + 1153 2 2 0.000000000000000 35.500000000000000 28.284389687599763 3.3000000000000000 + 1154 2 2 0.000000000000000 36.210000000000001 27.054633614225860 3.3000000000000000 + 1155 2 2 0.000000000000000 37.630000000000003 27.054633614225860 3.3000000000000000 + 1156 2 2 0.000000000000000 38.340000000000003 28.284389687599763 3.3000000000000000 + 1157 2 2 0.000000000000000 39.759999999999998 28.284389687599763 3.3000000000000000 + 1158 2 2 0.000000000000000 40.469999999999999 27.054633614225860 3.3000000000000000 + 1159 2 2 0.000000000000000 41.890000000000001 27.054633614225860 3.3000000000000000 + 1160 2 2 0.000000000000000 42.599999999999994 28.284389687599763 3.3000000000000000 + 1161 2 2 0.000000000000000 1.420000000000000 30.743901834347572 3.3000000000000000 + 1162 2 2 0.000000000000000 2.130000000000000 29.514145760973669 3.3000000000000000 + 1163 2 2 0.000000000000000 3.550000000000000 29.514145760973669 3.3000000000000000 + 1164 2 2 0.000000000000000 4.260000000000000 30.743901834347572 3.3000000000000000 + 1165 2 2 0.000000000000000 5.680000000000000 30.743901834347572 3.3000000000000000 + 1166 2 2 0.000000000000000 6.390000000000000 29.514145760973669 3.3000000000000000 + 1167 2 2 0.000000000000000 7.810000000000000 29.514145760973669 3.3000000000000000 + 1168 2 2 0.000000000000000 8.520000000000000 30.743901834347572 3.3000000000000000 + 1169 2 2 0.000000000000000 9.940000000000000 30.743901834347572 3.3000000000000000 + 1170 2 2 0.000000000000000 10.650000000000000 29.514145760973669 3.3000000000000000 + 1171 2 2 0.000000000000000 12.069999999999999 29.514145760973669 3.3000000000000000 + 1172 2 2 0.000000000000000 12.779999999999999 30.743901834347572 3.3000000000000000 + 1173 2 2 0.000000000000000 14.199999999999999 30.743901834347572 3.3000000000000000 + 1174 2 2 0.000000000000000 14.909999999999998 29.514145760973669 3.3000000000000000 + 1175 2 2 0.000000000000000 16.329999999999998 29.514145760973669 3.3000000000000000 + 1176 2 2 0.000000000000000 17.039999999999999 30.743901834347572 3.3000000000000000 + 1177 2 2 0.000000000000000 18.460000000000001 30.743901834347572 3.3000000000000000 + 1178 2 2 0.000000000000000 19.170000000000002 29.514145760973669 3.3000000000000000 + 1179 2 2 0.000000000000000 20.589999999999996 29.514145760973669 3.3000000000000000 + 1180 2 2 0.000000000000000 21.299999999999997 30.743901834347572 3.3000000000000000 + 1181 2 2 0.000000000000000 22.719999999999999 30.743901834347572 3.3000000000000000 + 1182 2 2 0.000000000000000 23.430000000000000 29.514145760973669 3.3000000000000000 + 1183 2 2 0.000000000000000 24.849999999999994 29.514145760973669 3.3000000000000000 + 1184 2 2 0.000000000000000 25.559999999999995 30.743901834347572 3.3000000000000000 + 1185 2 2 0.000000000000000 26.979999999999997 30.743901834347572 3.3000000000000000 + 1186 2 2 0.000000000000000 27.689999999999998 29.514145760973669 3.3000000000000000 + 1187 2 2 0.000000000000000 29.109999999999999 29.514145760973669 3.3000000000000000 + 1188 2 2 0.000000000000000 29.820000000000000 30.743901834347572 3.3000000000000000 + 1189 2 2 0.000000000000000 31.240000000000002 30.743901834347572 3.3000000000000000 + 1190 2 2 0.000000000000000 31.950000000000003 29.514145760973669 3.3000000000000000 + 1191 2 2 0.000000000000000 33.369999999999997 29.514145760973669 3.3000000000000000 + 1192 2 2 0.000000000000000 34.079999999999998 30.743901834347572 3.3000000000000000 + 1193 2 2 0.000000000000000 35.500000000000000 30.743901834347572 3.3000000000000000 + 1194 2 2 0.000000000000000 36.210000000000001 29.514145760973669 3.3000000000000000 + 1195 2 2 0.000000000000000 37.630000000000003 29.514145760973669 3.3000000000000000 + 1196 2 2 0.000000000000000 38.340000000000003 30.743901834347572 3.3000000000000000 + 1197 2 2 0.000000000000000 39.759999999999998 30.743901834347572 3.3000000000000000 + 1198 2 2 0.000000000000000 40.469999999999999 29.514145760973669 3.3000000000000000 + 1199 2 2 0.000000000000000 41.890000000000001 29.514145760973669 3.3000000000000000 + 1200 2 2 0.000000000000000 42.599999999999994 30.743901834347572 3.3000000000000000 + 1201 2 2 0.000000000000000 1.420000000000000 33.203413981095380 3.3000000000000000 + 1202 2 2 0.000000000000000 2.130000000000000 31.973657907721474 3.3000000000000000 + 1203 2 2 0.000000000000000 3.550000000000000 31.973657907721474 3.3000000000000000 + 1204 2 2 0.000000000000000 4.260000000000000 33.203413981095380 3.3000000000000000 + 1205 2 2 0.000000000000000 5.680000000000000 33.203413981095380 3.3000000000000000 + 1206 2 2 0.000000000000000 6.390000000000000 31.973657907721474 3.3000000000000000 + 1207 2 2 0.000000000000000 7.810000000000000 31.973657907721474 3.3000000000000000 + 1208 2 2 0.000000000000000 8.520000000000000 33.203413981095380 3.3000000000000000 + 1209 2 2 0.000000000000000 9.940000000000000 33.203413981095380 3.3000000000000000 + 1210 2 2 0.000000000000000 10.650000000000000 31.973657907721474 3.3000000000000000 + 1211 2 2 0.000000000000000 12.069999999999999 31.973657907721474 3.3000000000000000 + 1212 2 2 0.000000000000000 12.779999999999999 33.203413981095380 3.3000000000000000 + 1213 2 2 0.000000000000000 14.199999999999999 33.203413981095380 3.3000000000000000 + 1214 2 2 0.000000000000000 14.909999999999998 31.973657907721474 3.3000000000000000 + 1215 2 2 0.000000000000000 16.329999999999998 31.973657907721474 3.3000000000000000 + 1216 2 2 0.000000000000000 17.039999999999999 33.203413981095380 3.3000000000000000 + 1217 2 2 0.000000000000000 18.460000000000001 33.203413981095380 3.3000000000000000 + 1218 2 2 0.000000000000000 19.170000000000002 31.973657907721474 3.3000000000000000 + 1219 2 2 0.000000000000000 20.589999999999996 31.973657907721474 3.3000000000000000 + 1220 2 2 0.000000000000000 21.299999999999997 33.203413981095380 3.3000000000000000 + 1221 2 2 0.000000000000000 22.719999999999999 33.203413981095380 3.3000000000000000 + 1222 2 2 0.000000000000000 23.430000000000000 31.973657907721474 3.3000000000000000 + 1223 2 2 0.000000000000000 24.849999999999994 31.973657907721474 3.3000000000000000 + 1224 2 2 0.000000000000000 25.559999999999995 33.203413981095380 3.3000000000000000 + 1225 2 2 0.000000000000000 26.979999999999997 33.203413981095380 3.3000000000000000 + 1226 2 2 0.000000000000000 27.689999999999998 31.973657907721474 3.3000000000000000 + 1227 2 2 0.000000000000000 29.109999999999999 31.973657907721474 3.3000000000000000 + 1228 2 2 0.000000000000000 29.820000000000000 33.203413981095380 3.3000000000000000 + 1229 2 2 0.000000000000000 31.240000000000002 33.203413981095380 3.3000000000000000 + 1230 2 2 0.000000000000000 31.950000000000003 31.973657907721474 3.3000000000000000 + 1231 2 2 0.000000000000000 33.369999999999997 31.973657907721474 3.3000000000000000 + 1232 2 2 0.000000000000000 34.079999999999998 33.203413981095380 3.3000000000000000 + 1233 2 2 0.000000000000000 35.500000000000000 33.203413981095380 3.3000000000000000 + 1234 2 2 0.000000000000000 36.210000000000001 31.973657907721474 3.3000000000000000 + 1235 2 2 0.000000000000000 37.630000000000003 31.973657907721474 3.3000000000000000 + 1236 2 2 0.000000000000000 38.340000000000003 33.203413981095380 3.3000000000000000 + 1237 2 2 0.000000000000000 39.759999999999998 33.203413981095380 3.3000000000000000 + 1238 2 2 0.000000000000000 40.469999999999999 31.973657907721474 3.3000000000000000 + 1239 2 2 0.000000000000000 41.890000000000001 31.973657907721474 3.3000000000000000 + 1240 2 2 0.000000000000000 42.599999999999994 33.203413981095380 3.3000000000000000 + 1241 2 2 0.000000000000000 1.420000000000000 35.662926127843185 3.3000000000000000 + 1242 2 2 0.000000000000000 2.130000000000000 34.433170054469279 3.3000000000000000 + 1243 2 2 0.000000000000000 3.550000000000000 34.433170054469279 3.3000000000000000 + 1244 2 2 0.000000000000000 4.260000000000000 35.662926127843185 3.3000000000000000 + 1245 2 2 0.000000000000000 5.680000000000000 35.662926127843185 3.3000000000000000 + 1246 2 2 0.000000000000000 6.390000000000000 34.433170054469279 3.3000000000000000 + 1247 2 2 0.000000000000000 7.810000000000000 34.433170054469279 3.3000000000000000 + 1248 2 2 0.000000000000000 8.520000000000000 35.662926127843185 3.3000000000000000 + 1249 2 2 0.000000000000000 9.940000000000000 35.662926127843185 3.3000000000000000 + 1250 2 2 0.000000000000000 10.650000000000000 34.433170054469279 3.3000000000000000 + 1251 2 2 0.000000000000000 12.069999999999999 34.433170054469279 3.3000000000000000 + 1252 2 2 0.000000000000000 12.779999999999999 35.662926127843185 3.3000000000000000 + 1253 2 2 0.000000000000000 14.199999999999999 35.662926127843185 3.3000000000000000 + 1254 2 2 0.000000000000000 14.909999999999998 34.433170054469279 3.3000000000000000 + 1255 2 2 0.000000000000000 16.329999999999998 34.433170054469279 3.3000000000000000 + 1256 2 2 0.000000000000000 17.039999999999999 35.662926127843185 3.3000000000000000 + 1257 2 2 0.000000000000000 18.460000000000001 35.662926127843185 3.3000000000000000 + 1258 2 2 0.000000000000000 19.170000000000002 34.433170054469279 3.3000000000000000 + 1259 2 2 0.000000000000000 20.589999999999996 34.433170054469279 3.3000000000000000 + 1260 2 2 0.000000000000000 21.299999999999997 35.662926127843185 3.3000000000000000 + 1261 2 2 0.000000000000000 22.719999999999999 35.662926127843185 3.3000000000000000 + 1262 2 2 0.000000000000000 23.430000000000000 34.433170054469279 3.3000000000000000 + 1263 2 2 0.000000000000000 24.849999999999994 34.433170054469279 3.3000000000000000 + 1264 2 2 0.000000000000000 25.559999999999995 35.662926127843185 3.3000000000000000 + 1265 2 2 0.000000000000000 26.979999999999997 35.662926127843185 3.3000000000000000 + 1266 2 2 0.000000000000000 27.689999999999998 34.433170054469279 3.3000000000000000 + 1267 2 2 0.000000000000000 29.109999999999999 34.433170054469279 3.3000000000000000 + 1268 2 2 0.000000000000000 29.820000000000000 35.662926127843185 3.3000000000000000 + 1269 2 2 0.000000000000000 31.240000000000002 35.662926127843185 3.3000000000000000 + 1270 2 2 0.000000000000000 31.950000000000003 34.433170054469279 3.3000000000000000 + 1271 2 2 0.000000000000000 33.369999999999997 34.433170054469279 3.3000000000000000 + 1272 2 2 0.000000000000000 34.079999999999998 35.662926127843185 3.3000000000000000 + 1273 2 2 0.000000000000000 35.500000000000000 35.662926127843185 3.3000000000000000 + 1274 2 2 0.000000000000000 36.210000000000001 34.433170054469279 3.3000000000000000 + 1275 2 2 0.000000000000000 37.630000000000003 34.433170054469279 3.3000000000000000 + 1276 2 2 0.000000000000000 38.340000000000003 35.662926127843185 3.3000000000000000 + 1277 2 2 0.000000000000000 39.759999999999998 35.662926127843185 3.3000000000000000 + 1278 2 2 0.000000000000000 40.469999999999999 34.433170054469279 3.3000000000000000 + 1279 2 2 0.000000000000000 41.890000000000001 34.433170054469279 3.3000000000000000 + 1280 2 2 0.000000000000000 42.599999999999994 35.662926127843185 3.3000000000000000 + 1281 2 2 0.000000000000000 1.420000000000000 38.122438274590991 3.3000000000000000 + 1282 2 2 0.000000000000000 2.130000000000000 36.892682201217085 3.3000000000000000 + 1283 2 2 0.000000000000000 3.550000000000000 36.892682201217085 3.3000000000000000 + 1284 2 2 0.000000000000000 4.260000000000000 38.122438274590991 3.3000000000000000 + 1285 2 2 0.000000000000000 5.680000000000000 38.122438274590991 3.3000000000000000 + 1286 2 2 0.000000000000000 6.390000000000000 36.892682201217085 3.3000000000000000 + 1287 2 2 0.000000000000000 7.810000000000000 36.892682201217085 3.3000000000000000 + 1288 2 2 0.000000000000000 8.520000000000000 38.122438274590991 3.3000000000000000 + 1289 2 2 0.000000000000000 9.940000000000000 38.122438274590991 3.3000000000000000 + 1290 2 2 0.000000000000000 10.650000000000000 36.892682201217085 3.3000000000000000 + 1291 2 2 0.000000000000000 12.069999999999999 36.892682201217085 3.3000000000000000 + 1292 2 2 0.000000000000000 12.779999999999999 38.122438274590991 3.3000000000000000 + 1293 2 2 0.000000000000000 14.199999999999999 38.122438274590991 3.3000000000000000 + 1294 2 2 0.000000000000000 14.909999999999998 36.892682201217085 3.3000000000000000 + 1295 2 2 0.000000000000000 16.329999999999998 36.892682201217085 3.3000000000000000 + 1296 2 2 0.000000000000000 17.039999999999999 38.122438274590991 3.3000000000000000 + 1297 2 2 0.000000000000000 18.460000000000001 38.122438274590991 3.3000000000000000 + 1298 2 2 0.000000000000000 19.170000000000002 36.892682201217085 3.3000000000000000 + 1299 2 2 0.000000000000000 20.589999999999996 36.892682201217085 3.3000000000000000 + 1300 2 2 0.000000000000000 21.299999999999997 38.122438274590991 3.3000000000000000 + 1301 2 2 0.000000000000000 22.719999999999999 38.122438274590991 3.3000000000000000 + 1302 2 2 0.000000000000000 23.430000000000000 36.892682201217085 3.3000000000000000 + 1303 2 2 0.000000000000000 24.849999999999994 36.892682201217085 3.3000000000000000 + 1304 2 2 0.000000000000000 25.559999999999995 38.122438274590991 3.3000000000000000 + 1305 2 2 0.000000000000000 26.979999999999997 38.122438274590991 3.3000000000000000 + 1306 2 2 0.000000000000000 27.689999999999998 36.892682201217085 3.3000000000000000 + 1307 2 2 0.000000000000000 29.109999999999999 36.892682201217085 3.3000000000000000 + 1308 2 2 0.000000000000000 29.820000000000000 38.122438274590991 3.3000000000000000 + 1309 2 2 0.000000000000000 31.240000000000002 38.122438274590991 3.3000000000000000 + 1310 2 2 0.000000000000000 31.950000000000003 36.892682201217085 3.3000000000000000 + 1311 2 2 0.000000000000000 33.369999999999997 36.892682201217085 3.3000000000000000 + 1312 2 2 0.000000000000000 34.079999999999998 38.122438274590991 3.3000000000000000 + 1313 2 2 0.000000000000000 35.500000000000000 38.122438274590991 3.3000000000000000 + 1314 2 2 0.000000000000000 36.210000000000001 36.892682201217085 3.3000000000000000 + 1315 2 2 0.000000000000000 37.630000000000003 36.892682201217085 3.3000000000000000 + 1316 2 2 0.000000000000000 38.340000000000003 38.122438274590991 3.3000000000000000 + 1317 2 2 0.000000000000000 39.759999999999998 38.122438274590991 3.3000000000000000 + 1318 2 2 0.000000000000000 40.469999999999999 36.892682201217085 3.3000000000000000 + 1319 2 2 0.000000000000000 41.890000000000001 36.892682201217085 3.3000000000000000 + 1320 2 2 0.000000000000000 42.599999999999994 38.122438274590991 3.3000000000000000 + 1321 2 2 0.000000000000000 1.420000000000000 40.581950421338796 3.3000000000000000 + 1322 2 2 0.000000000000000 2.130000000000000 39.352194347964890 3.3000000000000000 + 1323 2 2 0.000000000000000 3.550000000000000 39.352194347964890 3.3000000000000000 + 1324 2 2 0.000000000000000 4.260000000000000 40.581950421338796 3.3000000000000000 + 1325 2 2 0.000000000000000 5.680000000000000 40.581950421338796 3.3000000000000000 + 1326 2 2 0.000000000000000 6.390000000000000 39.352194347964890 3.3000000000000000 + 1327 2 2 0.000000000000000 7.810000000000000 39.352194347964890 3.3000000000000000 + 1328 2 2 0.000000000000000 8.520000000000000 40.581950421338796 3.3000000000000000 + 1329 2 2 0.000000000000000 9.940000000000000 40.581950421338796 3.3000000000000000 + 1330 2 2 0.000000000000000 10.650000000000000 39.352194347964890 3.3000000000000000 + 1331 2 2 0.000000000000000 12.069999999999999 39.352194347964890 3.3000000000000000 + 1332 2 2 0.000000000000000 12.779999999999999 40.581950421338796 3.3000000000000000 + 1333 2 2 0.000000000000000 14.199999999999999 40.581950421338796 3.3000000000000000 + 1334 2 2 0.000000000000000 14.909999999999998 39.352194347964890 3.3000000000000000 + 1335 2 2 0.000000000000000 16.329999999999998 39.352194347964890 3.3000000000000000 + 1336 2 2 0.000000000000000 17.039999999999999 40.581950421338796 3.3000000000000000 + 1337 2 2 0.000000000000000 18.460000000000001 40.581950421338796 3.3000000000000000 + 1338 2 2 0.000000000000000 19.170000000000002 39.352194347964890 3.3000000000000000 + 1339 2 2 0.000000000000000 20.589999999999996 39.352194347964890 3.3000000000000000 + 1340 2 2 0.000000000000000 21.299999999999997 40.581950421338796 3.3000000000000000 + 1341 2 2 0.000000000000000 22.719999999999999 40.581950421338796 3.3000000000000000 + 1342 2 2 0.000000000000000 23.430000000000000 39.352194347964890 3.3000000000000000 + 1343 2 2 0.000000000000000 24.849999999999994 39.352194347964890 3.3000000000000000 + 1344 2 2 0.000000000000000 25.559999999999995 40.581950421338796 3.3000000000000000 + 1345 2 2 0.000000000000000 26.979999999999997 40.581950421338796 3.3000000000000000 + 1346 2 2 0.000000000000000 27.689999999999998 39.352194347964890 3.3000000000000000 + 1347 2 2 0.000000000000000 29.109999999999999 39.352194347964890 3.3000000000000000 + 1348 2 2 0.000000000000000 29.820000000000000 40.581950421338796 3.3000000000000000 + 1349 2 2 0.000000000000000 31.240000000000002 40.581950421338796 3.3000000000000000 + 1350 2 2 0.000000000000000 31.950000000000003 39.352194347964890 3.3000000000000000 + 1351 2 2 0.000000000000000 33.369999999999997 39.352194347964890 3.3000000000000000 + 1352 2 2 0.000000000000000 34.079999999999998 40.581950421338796 3.3000000000000000 + 1353 2 2 0.000000000000000 35.500000000000000 40.581950421338796 3.3000000000000000 + 1354 2 2 0.000000000000000 36.210000000000001 39.352194347964890 3.3000000000000000 + 1355 2 2 0.000000000000000 37.630000000000003 39.352194347964890 3.3000000000000000 + 1356 2 2 0.000000000000000 38.340000000000003 40.581950421338796 3.3000000000000000 + 1357 2 2 0.000000000000000 39.759999999999998 40.581950421338796 3.3000000000000000 + 1358 2 2 0.000000000000000 40.469999999999999 39.352194347964890 3.3000000000000000 + 1359 2 2 0.000000000000000 41.890000000000001 39.352194347964890 3.3000000000000000 + 1360 2 2 0.000000000000000 42.599999999999994 40.581950421338796 3.3000000000000000 diff --git a/examples/USER/misc/kolmogorov_crespi_full/CH.KC b/examples/USER/misc/kolmogorov_crespi_full/CH.KC new file mode 120000 index 0000000000..74f7f340e5 --- /dev/null +++ b/examples/USER/misc/kolmogorov_crespi_full/CH.KC @@ -0,0 +1 @@ +../../../../potentials/CH.KC \ No newline at end of file diff --git a/examples/USER/misc/kolmogorov_crespi_full/CH_taper.KC b/examples/USER/misc/kolmogorov_crespi_full/CH_taper.KC new file mode 120000 index 0000000000..2693646814 --- /dev/null +++ b/examples/USER/misc/kolmogorov_crespi_full/CH_taper.KC @@ -0,0 +1 @@ +../../../../potentials/CH_taper.KC \ No newline at end of file diff --git a/examples/USER/misc/kolmogorov_crespi_full/in.bilayer-graphene b/examples/USER/misc/kolmogorov_crespi_full/in.bilayer-graphene index c3e59337de..259604d953 100644 --- a/examples/USER/misc/kolmogorov_crespi_full/in.bilayer-graphene +++ b/examples/USER/misc/kolmogorov_crespi_full/in.bilayer-graphene @@ -5,21 +5,22 @@ atom_style full processors * * 1 # domain decomposition over x and y # System and atom definition -# we use 2 atom types so that inter- and intra-layer +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer # interactions can be specified separately -# read lammps data file -read_data Bi_gr_AB_stack_2L_noH_300K.data + +read_data Bi_gr_AB_stack_2L_noH.data mass 1 12.0107 # carbon mass (g/mole) | membrane mass 2 12.0107 # carbon mass (g/mole) | adsorbate # Separate atom groups -group membrane type 1 -group adsorbate type 2 +group layer1 molecule 1 +group layer2 molecule 2 ######################## Potential defition ######################## -pair_style hybrid/overlay rebo kolmogorov/crespi/full 16.0 +pair_style hybrid/overlay rebo kolmogorov/crespi/full 16.0 1 #################################################################### -pair_coeff * * rebo CH.rebo NULL C # chemical -pair_coeff * * kolmogorov/crespi/full CC.KC-full C C # long range +pair_coeff * * rebo CH.rebo C C # chemical +pair_coeff * * kolmogorov/crespi/full CH_taper.KC C C # long range #################################################################### # Neighbor update settings neighbor 2.0 bin @@ -27,34 +28,25 @@ neigh_modify every 1 neigh_modify delay 0 neigh_modify check yes -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - #### Simulation settings #### -timestep 0.001 -fix subf membrane setforce 0.0 0.0 0.0 -fix thermostat all nve +timestep 0.001 +velocity all create 300.0 12345 -compute 0 all pair rebo -compute 1 all pair kolmogorov/crespi/full -variable REBO equal c_0 -variable KC equal c_1 +compute 0 all pair rebo +compute 1 all pair kolmogorov/crespi/full +variable REBO equal c_0 # REBO energy +variable KC equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy ############################ # Output thermo 100 -thermo_style custom step etotal pe ke v_REBO v_KC temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost warn #ignore - -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes +thermo_style custom step cpu etotal pe ke v_REBO v_KC v_Erep v_Evdw temp +thermo_modify line one format float %.16f +thermo_modify flush yes norm no lost warn ###### Run molecular dynamics ###### -run 1000 +fix thermostat all nve +run 1000 diff --git a/examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.1 b/examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.1 new file mode 100644 index 0000000000..f400df565c --- /dev/null +++ b/examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.1 @@ -0,0 +1,129 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer +# interactions can be specified separately + +read_data Bi_gr_AB_stack_2L_noH.data + orthogonal box = (0 0 0) to (42.6 41.8117 100) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000143357 secs + read_data CPU = 0.00128686 secs +mass 1 12.0107 # carbon mass (g/mole) | membrane +mass 2 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo kolmogorov/crespi/full 16.0 1 +#################################################################### +pair_coeff * * rebo CH.rebo C C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * kolmogorov/crespi/full CH_taper.KC C C # long range +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 + +compute 0 all pair rebo +compute 1 all pair kolmogorov/crespi/full +variable REBO equal c_0 # REBO energy +variable KC equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy + +############################ + +# Output +thermo 100 +thermo_style custom step cpu etotal pe ke v_REBO v_KC v_Erep v_Evdw temp +thermo_modify line one format float %.16f +thermo_modify flush yes norm no lost warn + +###### Run molecular dynamics ###### +fix thermostat all nve +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair rebo, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (2) pair kolmogorov/crespi/full, perpetual, copy from (1) + attributes: full, newton on, ghost + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 17.21 | 17.21 | 17.21 Mbytes +Step CPU TotEng PotEng KinEng v_REBO v_KC v_Erep v_Evdw Temp + 0 0.0000000000000000 -10037.7640583248121402 -10090.4634194413119985 52.6993611164999436 -10057.1894932863488066 -33.2739261549639664 35.9559834316876348 -69.2299095866357561 299.9999999999996589 + 100 5.3877589240437374 -10037.5122858156355505 -10065.4637593850693520 27.9514735694345475 -10032.2132655062632693 -33.2504938788055995 25.2100699045900747 -58.4605637833913789 159.1184768311149185 + 200 10.7755050340201706 -10037.4414086674350983 -10061.6271012692632212 24.1856926018286202 -10028.9093252939674130 -32.7177759752951403 18.5366534598604176 -51.2544294351563394 137.6811336385792970 + 300 16.1665089030284435 -10037.4824653300311184 -10064.2845326005663082 26.8020672705344225 -10030.9195389405322203 -33.3649936600345924 26.3639208740001152 -59.7289145340284122 152.5752876469470891 + 400 21.5454839280573651 -10037.5105626329259394 -10064.8769084956420556 27.3663458627154164 -10031.8478821022799821 -33.0290263933626349 36.6142885774199272 -69.6433149707719963 155.7875386888538571 + 500 26.9370588400634006 -10037.5010433785082569 -10064.8363209936451312 27.3352776151367571 -10031.4417172103931080 -33.3946037832518243 26.2980262321670750 -59.6926300154142595 155.6106774503846850 + 600 32.4204196080099791 -10037.4817772372425679 -10064.1925798287738871 26.7108025915316247 -10031.4376178099264507 -32.7549620188478201 18.5745873777024606 -51.3295493965519327 152.0557480714992380 + 700 37.8001567909959704 -10037.4834430268438155 -10064.1291975032218033 26.6457544763788299 -10030.8722888097800023 -33.2569086934421492 25.2322818106646771 -58.4891905041015008 151.6854507067418467 + 800 43.1622281169984490 -10037.5047888097760733 -10064.8671187128948077 27.3623299031188978 -10031.9815058608437539 -32.8856128520517217 36.5236695083771536 -69.4092823604148350 155.7646771616279011 + 900 48.5261204120470211 -10037.5068323940176924 -10065.3998155271074211 27.8929831330889542 -10032.1734374829957233 -33.2263780441125931 27.7314849391008309 -60.9578629832065317 158.7855101588076820 + 1000 53.8888844919856638 -10037.4811494880468672 -10064.0099109142265661 26.5287614261789670 -10031.3325267421259923 -32.6773841721003464 18.9005970229871600 -51.5779811950879434 151.0194480396057202 +Loop time of 53.8889 on 1 procs for 1000 steps with 1360 atoms + +Performance: 1.603 ns/day, 14.969 hours/ns, 18.557 timesteps/s +100.0% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 53.836 | 53.836 | 53.836 | 0.0 | 99.90 +Bond | 0.00043479 | 0.00043479 | 0.00043479 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.032452 | 0.032452 | 0.032452 | 0.0 | 0.06 +Output | 0.00058326 | 0.00058326 | 0.00058326 | 0.0 | 0.00 +Modify | 0.0094135 | 0.0094135 | 0.0094135 | 0.0 | 0.02 +Other | | 0.009815 | | | 0.02 + +Nlocal: 1360 ave 1360 max 1360 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7964 ave 7964 max 7964 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 1.037e+06 ave 1.037e+06 max 1.037e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1037000 +Ave neighs/atom = 762.5 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:54 diff --git a/examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.4 b/examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.4 new file mode 100644 index 0000000000..ebb2c8c3fa --- /dev/null +++ b/examples/USER/misc/kolmogorov_crespi_full/log.5Jun19.bilayer-graphene.icc.4 @@ -0,0 +1,129 @@ +LAMMPS (5 Jun 2019) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer +# interactions can be specified separately + +read_data Bi_gr_AB_stack_2L_noH.data + orthogonal box = (0 0 0) to (42.6 41.8117 100) + 2 by 2 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000245051 secs + read_data CPU = 0.00257704 secs +mass 1 12.0107 # carbon mass (g/mole) | membrane +mass 2 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo kolmogorov/crespi/full 16.0 1 +#################################################################### +pair_coeff * * rebo CH.rebo C C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * kolmogorov/crespi/full CH_taper.KC C C # long range +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 + +compute 0 all pair rebo +compute 1 all pair kolmogorov/crespi/full +variable REBO equal c_0 # REBO energy +variable KC equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy + +############################ + +# Output +thermo 100 +thermo_style custom step cpu etotal pe ke v_REBO v_KC v_Erep v_Evdw temp +thermo_modify line one format float %.16f +thermo_modify flush yes norm no lost warn + +###### Run molecular dynamics ###### +fix thermostat all nve +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair rebo, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (2) pair kolmogorov/crespi/full, perpetual, copy from (1) + attributes: full, newton on, ghost + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 9.878 | 9.878 | 9.878 Mbytes +Step CPU TotEng PotEng KinEng v_REBO v_KC v_Erep v_Evdw Temp + 0 0.0000000000000000 -10037.7640583250176860 -10090.4634194415175443 52.6993611164999933 -10057.1894932866325689 -33.2739261548851388 35.9559834317043467 -69.2299095866038954 299.9999999999999432 + 100 1.5180600649910048 -10037.5122858156355505 -10065.4637593850711710 27.9514735694348637 -10032.2132655062741833 -33.2504938787968172 25.2100699046001573 -58.4605637833912795 159.1184768311167090 + 200 3.0089348420733586 -10037.4414086674296414 -10061.6271012692577642 24.1856926018279914 -10028.9093252939601371 -32.7177759752976272 18.5366534598677504 -51.2544294351567515 137.6811336385757158 + 300 4.5315427089808509 -10037.4824653300020145 -10064.2845326005372044 26.8020672705348311 -10030.9195389405158494 -33.3649936600211205 26.3639208740115549 -59.7289145340278722 152.5752876469494197 + 400 6.0353655620710924 -10037.5105626329095685 -10064.8769084956238657 27.3663458627148124 -10031.8478821022818011 -33.0290263933414394 36.6142885774347562 -69.6433149707726074 155.7875386888504181 + 500 7.5396006110822782 -10037.5010433784900670 -10064.8363209936269413 27.3352776151361780 -10031.4417172103858320 -33.3946037832416351 26.2980262321774489 -59.6926300154146787 155.6106774503813881 + 600 9.2617433650884777 -10037.4817772372534819 -10064.1925798287848011 26.7108025915320830 -10031.4376178099319077 -32.7549620188514226 18.5745873777100208 -51.3295493965524017 152.0557480715018528 + 700 10.7484918619738892 -10037.4834430268347205 -10064.1291975032127084 26.6457544763787268 -10030.8722888097836403 -33.2569086934306739 25.2322818106757047 -58.4891905041008613 151.6854507067412499 + 800 12.2509897360578179 -10037.5047888097869873 -10064.8671187129039026 27.3623299031166667 -10031.9815058608728577 -32.8856128520297801 36.5236695083899718 -69.4092823604150908 155.7646771616151966 + 900 13.7584852169966325 -10037.5068323939758557 -10065.3998155270637653 27.8929831330881477 -10032.1734374829648004 -33.2263780440982259 27.7314849391120788 -60.9578629832060841 158.7855101588031062 + 1000 15.2755981830414385 -10037.4811494880432292 -10064.0099109142211091 26.5287614261777058 -10031.3325267421205353 -32.6773841721017888 18.9005970229946634 -51.5779811950868776 151.0194480395985295 +Loop time of 15.2757 on 4 procs for 1000 steps with 1360 atoms + +Performance: 5.656 ns/day, 4.243 hours/ns, 65.464 timesteps/s +99.9% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 13.985 | 14.446 | 14.823 | 7.9 | 94.57 +Bond | 0.00040979 | 0.00042456 | 0.00046059 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.43692 | 0.81428 | 1.2749 | 33.2 | 5.33 +Output | 0.00028016 | 0.00037143 | 0.00063561 | 0.0 | 0.00 +Modify | 0.0045586 | 0.0046468 | 0.0047903 | 0.1 | 0.03 +Other | | 0.01041 | | | 0.07 + +Nlocal: 340 ave 340 max 340 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 4628 ave 4628 max 4628 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 259250 ave 259250 max 259250 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1037000 +Ave neighs/atom = 762.5 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:15 -- GitLab From 5fe457667e31f52b772609f58e981ffff5adb93b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 11:19:39 -0400 Subject: [PATCH 401/469] restore showing references to potential files without pathnames --- doc/src/pair_ilp_graphene_hbn.txt | 8 ++++---- doc/src/pair_kolmogorov_crespi_full.txt | 6 +++--- 2 files changed, 7 insertions(+), 7 deletions(-) diff --git a/doc/src/pair_ilp_graphene_hbn.txt b/doc/src/pair_ilp_graphene_hbn.txt index 0e8ac5e9c5..6d922e20f9 100644 --- a/doc/src/pair_ilp_graphene_hbn.txt +++ b/doc/src/pair_ilp_graphene_hbn.txt @@ -18,12 +18,12 @@ tap_flag = 0/1 to turn off/on the taper function :ul [Examples:] pair_style hybrid/overlay ilp/graphene/hbn 16.0 1 -pair_coeff * * ilp/graphene/hbn ../potentials/BNCH.ILP B N C :pre +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N C :pre pair_style hybrid/overlay rebo tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 -pair_coeff * * rebo ../potentials/CH.rebo NULL NULL C -pair_coeff * * tersoff ../potentials/BNC.tersoff B N NULL -pair_coeff * * ilp/graphene/hbn ../potentials/BNCH.ILP B N C +pair_coeff * * rebo CH.rebo NULL NULL C +pair_coeff * * tersoff BNC.tersoff B N NULL +pair_coeff * * ilp/graphene/hbn BNCH.ILP B N C pair_coeff 1 1 coul/shield 0.70 pair_coeff 1 2 coul/shield 0.695 pair_coeff 2 2 coul/shield 0.69 :pre diff --git a/doc/src/pair_kolmogorov_crespi_full.txt b/doc/src/pair_kolmogorov_crespi_full.txt index bfadc33e30..5a2623ed89 100644 --- a/doc/src/pair_kolmogorov_crespi_full.txt +++ b/doc/src/pair_kolmogorov_crespi_full.txt @@ -19,11 +19,11 @@ tap_flag = 0/1 to turn off/on the taper function :ul pair_style hybrid/overlay kolmogorov/crespi/full 20.0 0 pair_coeff * * none -pair_coeff * * kolmogorov/crespi/full ../potentials/CH.KC C C :pre +pair_coeff * * kolmogorov/crespi/full CH.KC C C :pre pair_style hybrid/overlay rebo kolmogorov/crespi/full 16.0 1 -pair_coeff * * rebo ../potentials/CH.rebo C H -pair_coeff * * kolmogorov/crespi/full ../potentials/CH_taper.KC C H :pre +pair_coeff * * rebo CH.rebo C H +pair_coeff * * kolmogorov/crespi/full CH_taper.KC C H :pre [Description:] -- GitLab From 2fe4a6490c771ca44c1973854241591236f976cc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 11:20:06 -0400 Subject: [PATCH 402/469] restore include file cleanup changes --- src/USER-MISC/pair_ilp_graphene_hbn.cpp | 3 +-- src/USER-MISC/pair_ilp_graphene_hbn.h | 2 -- src/USER-MISC/pair_kolmogorov_crespi_full.cpp | 3 +-- src/USER-MISC/pair_kolmogorov_crespi_full.h | 2 -- 4 files changed, 2 insertions(+), 8 deletions(-) diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.cpp b/src/USER-MISC/pair_ilp_graphene_hbn.cpp index a050f1f613..4741263603 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.cpp +++ b/src/USER-MISC/pair_ilp_graphene_hbn.cpp @@ -20,12 +20,11 @@ [Kolmogorov & Crespi, Phys. Rev. B 71, 235415 (2005)] ------------------------------------------------------------------------- */ +#include "pair_ilp_graphene_hbn.h" #include #include -#include #include #include -#include "pair_ilp_graphene_hbn.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.h b/src/USER-MISC/pair_ilp_graphene_hbn.h index 32bee4a10f..ec6146fa33 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.h +++ b/src/USER-MISC/pair_ilp_graphene_hbn.h @@ -21,8 +21,6 @@ PairStyle(ilp/graphene/hbn,PairILPGrapheneHBN) #define LMP_PAIR_ILP_GRAPHENE_HBN_H #include "pair.h" -#include "my_page.h" -#include namespace LAMMPS_NS { diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp index bfebb0c553..7bfbedfa1c 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp @@ -20,12 +20,11 @@ [Kolmogorov & Crespi, Phys. Rev. B 71, 235415 (2005)] ------------------------------------------------------------------------- */ +#include "pair_kolmogorov_crespi_full.h" #include -#include #include #include #include -#include "pair_kolmogorov_crespi_full.h" #include "atom.h" #include "comm.h" #include "force.h" diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.h b/src/USER-MISC/pair_kolmogorov_crespi_full.h index 81ab1984da..d2971e3fbc 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.h +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.h @@ -21,8 +21,6 @@ PairStyle(kolmogorov/crespi/full,PairKolmogorovCrespiFull) #define LMP_PAIR_KolmogorovCrespi_FULL_H #include "pair.h" -#include "my_page.h" -#include namespace LAMMPS_NS { -- GitLab From 73d2b824bdb4826f000527d133ebf204d8fde30a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 13:31:13 -0400 Subject: [PATCH 403/469] fix compilation issue of library.cpp with exceptions enabled --- src/library.cpp | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/library.cpp b/src/library.cpp index eabe5fd179..c8c2c24146 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -38,6 +38,10 @@ #include "force.h" #include "info.h" +#if defined(LAMMPS_EXCEPTIONS) +#include "exceptions.h" +#endif + using namespace LAMMPS_NS; // ---------------------------------------------------------------------- -- GitLab From fa6a990536b8d3098f9699059ca5935ab66042bd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 13:31:52 -0400 Subject: [PATCH 404/469] reduce output precision to default and don't output per-step cpu time --- .../ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene index 949de4b74c..0ef2787744 100644 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene +++ b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene @@ -43,9 +43,8 @@ variable Erep equal c_1[2] # repulsive energy # Output thermo 100 -thermo_style custom step cpu etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp -thermo_modify line one format float %.16f -thermo_modify flush yes norm no lost warn +thermo_style custom step etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp +thermo_modify lost warn ###### Run molecular dynamics ###### fix thermostat all nve -- GitLab From 083841ab2a8b4acc5610e7b43202512ca3e0633f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 13:34:05 -0400 Subject: [PATCH 405/469] another compilation fix --- src/library.cpp | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/src/library.cpp b/src/library.cpp index c8c2c24146..6e7a104270 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -810,7 +810,9 @@ void lammps_gather_atoms(void *ptr, char * /*name */, LAMMPS *lmp = (LAMMPS *) ptr; BEGIN_CAPTURE - lmp->error->all(FLERR,"Library function lammps_gather_atoms() not compatible with -DLAMMPS_BIGBIG"); + { + lmp->error->all(FLERR,"Library function lammps_gather_atoms() not compatible with -DLAMMPS_BIGBIG"); + } END_CAPTURE } #else -- GitLab From 64b682b9f9f39a5c50aced907a5e8ff3880b8397 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 13:40:50 -0400 Subject: [PATCH 406/469] library compilation fix for clang with exceptions and -DLAMMPS_BIGBIG --- src/library.cpp | 23 ++++++++++++++++++----- 1 file changed, 18 insertions(+), 5 deletions(-) diff --git a/src/library.cpp b/src/library.cpp index 6e7a104270..30b7c7c7ce 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -811,7 +811,8 @@ void lammps_gather_atoms(void *ptr, char * /*name */, BEGIN_CAPTURE { - lmp->error->all(FLERR,"Library function lammps_gather_atoms() not compatible with -DLAMMPS_BIGBIG"); + lmp->error->all(FLERR,"Library function lammps_gather_atoms() " + "is not compatible with -DLAMMPS_BIGBIG"); } END_CAPTURE } @@ -950,7 +951,10 @@ void lammps_gather_atoms_concat(void *ptr, char * /*name */, LAMMPS *lmp = (LAMMPS *) ptr; BEGIN_CAPTURE - lmp->error->all(FLERR,"Library function lammps_gather_atoms_concat() not compatible with -DLAMMPS_BIGBIG"); + { + lmp->error->all(FLERR,"Library function lammps_gather_atoms_concat() " + "is not compatible with -DLAMMPS_BIGBIG"); + } END_CAPTURE } #else @@ -1107,7 +1111,10 @@ void lammps_gather_atoms_subset(void *ptr, char * /*name */, LAMMPS *lmp = (LAMMPS *) ptr; BEGIN_CAPTURE - lmp->error->all(FLERR,"Library function lammps_gather_atoms_subset() not compatible with -DLAMMPS_BIGBIG"); + { + lmp->error->all(FLERR,"Library function lammps_gather_atoms_subset() " + "is not compatible with -DLAMMPS_BIGBIG"); + } END_CAPTURE } #else @@ -1253,7 +1260,10 @@ void lammps_scatter_atoms(void *ptr, char * /*name */, LAMMPS *lmp = (LAMMPS *) ptr; BEGIN_CAPTURE - lmp->error->all(FLERR,"Library function lammps_scatter_atoms() not compatible with -DLAMMPS_BIGBIG"); + { + lmp->error->all(FLERR,"Library function lammps_scatter_atoms() " + "is not compatible with -DLAMMPS_BIGBIG"); + } END_CAPTURE } #else @@ -1379,7 +1389,10 @@ void lammps_scatter_atoms_subset(void *ptr, char * /*name */, LAMMPS *lmp = (LAMMPS *) ptr; BEGIN_CAPTURE - lmp->error->all(FLERR,"Library function lammps_scatter_atoms_subset() not compatible with -DLAMMPS_BIGBIG"); + { + lmp->error->all(FLERR,"Library function lammps_scatter_atoms_subset() " + "is not compatible with -DLAMMPS_BIGBIG"); + } END_CAPTURE } #else -- GitLab From 5fd323fe32b7c3a108879bd971818a48e366c49b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 14:24:47 -0400 Subject: [PATCH 407/469] simplify example folder for ilp/graphene/hbn potential - flatten directory structure - remove CPU time and reduce excess precision from output - delete redundant and unused files - regenerate reference outputs --- .../Bi_gr_AB_stack_2L_noH.data | 0 .../bilayer-graphene/BNCH-old.ILP | 1 - .../bilayer-graphene/BNCH.ILP | 1 - .../Bi_gr_AB_stack_2L_noH_300K.data | 2739 ----------------- .../bilayer-graphene/CH.airebo | 1 - .../ilp_graphene_hbn/bilayer-graphene/CH.rebo | 1 - .../log.16Mar18.bilayer-graphene.g++.1 | 137 - .../log.16Mar18.bilayer-graphene.g++.4 | 137 - .../log.5Jun19.bilayer-graphene.icc.1 | 128 - .../log.5Jun19.bilayer-graphene.icc.4 | 128 - .../ilp_graphene_hbn/bilayer-hBN/BNC.tersoff | 1 - .../ilp_graphene_hbn/bilayer-hBN/BNCH.ILP | 1 - .../misc/ilp_graphene_hbn/gr-hBN/BNC.tersoff | 1 - .../misc/ilp_graphene_hbn/gr-hBN/BNCH-old.ILP | 1 - .../misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP | 1 - .../misc/ilp_graphene_hbn/gr-hBN/CH.airebo | 1 - .../USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo | 1 - .../gr-hBN/log.16Mar18.grhBN.g++.1 | 171 - .../gr-hBN/log.16Mar18.grhBN.g++.4 | 171 - .../{gr-hBN => }/gr_hBN_Cstack_2L_noH.data | 0 .../hBN_AA_prime_stack_2L_noH.data | 0 .../in.bilayer-graphene | 0 .../{bilayer-hBN => }/in.bilayer-hBN | 5 +- .../ilp_graphene_hbn/{gr-hBN => }/in.grhBN | 3 +- .../misc/ilp_graphene_hbn/in.ilp_graphene_hbn | 21 +- .../log.16Mar18.ilp_gr_hBN.g++.1 | 168 - .../log.16Mar18.ilp_gr_hBN.g++.4 | 168 - .../log.31Jul19.bilayer-graphene.g++.1 | 127 + .../log.31Jul19.bilayer-graphene.g++.4 | 127 + ...BN.icc.1 => log.31Jul19.bilayer-hBN.g++.1} | 58 +- ...BN.icc.4 => log.31Jul19.bilayer-hBN.g++.4} | 58 +- ...19.grhBN.icc.1 => log.31Jul19.grhBN.g++.1} | 52 +- ...19.grhBN.icc.4 => log.31Jul19.grhBN.g++.4} | 52 +- .../log.31Jul19.ilp_graphene_hbn.g++.1 | 154 + .../log.31Jul19.ilp_graphene_hbn.g++.4 | 154 + 35 files changed, 676 insertions(+), 4093 deletions(-) rename examples/USER/misc/ilp_graphene_hbn/{bilayer-graphene => }/Bi_gr_AB_stack_2L_noH.data (100%) delete mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH-old.ILP delete mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP delete mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH_300K.data delete mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.airebo delete mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo delete mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.1 delete mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.4 delete mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 delete mode 100644 examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 delete mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff delete mode 120000 examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP delete mode 120000 examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNC.tersoff delete mode 120000 examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH-old.ILP delete mode 120000 examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP delete mode 120000 examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.airebo delete mode 120000 examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo delete mode 100644 examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.1 delete mode 100644 examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.4 rename examples/USER/misc/ilp_graphene_hbn/{gr-hBN => }/gr_hBN_Cstack_2L_noH.data (100%) rename examples/USER/misc/ilp_graphene_hbn/{bilayer-hBN => }/hBN_AA_prime_stack_2L_noH.data (100%) rename examples/USER/misc/ilp_graphene_hbn/{bilayer-graphene => }/in.bilayer-graphene (100%) rename examples/USER/misc/ilp_graphene_hbn/{bilayer-hBN => }/in.bilayer-hBN (91%) rename examples/USER/misc/ilp_graphene_hbn/{gr-hBN => }/in.grhBN (96%) delete mode 100644 examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.1 delete mode 100644 examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.4 create mode 100644 examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.1 create mode 100644 examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.4 rename examples/USER/misc/ilp_graphene_hbn/{bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 => log.31Jul19.bilayer-hBN.g++.1} (56%) rename examples/USER/misc/ilp_graphene_hbn/{bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 => log.31Jul19.bilayer-hBN.g++.4} (56%) rename examples/USER/misc/ilp_graphene_hbn/{gr-hBN/log.5Jun19.grhBN.icc.1 => log.31Jul19.grhBN.g++.1} (60%) rename examples/USER/misc/ilp_graphene_hbn/{gr-hBN/log.5Jun19.grhBN.icc.4 => log.31Jul19.grhBN.g++.4} (60%) create mode 100644 examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.1 create mode 100644 examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.4 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH.data b/examples/USER/misc/ilp_graphene_hbn/Bi_gr_AB_stack_2L_noH.data similarity index 100% rename from examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH.data rename to examples/USER/misc/ilp_graphene_hbn/Bi_gr_AB_stack_2L_noH.data diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH-old.ILP b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH-old.ILP deleted file mode 120000 index 9a3bc96225..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH-old.ILP +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/BNCH-old.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP deleted file mode 120000 index b970e23f95..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/BNCH.ILP +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/BNCH.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH_300K.data b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH_300K.data deleted file mode 100644 index be91806549..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/Bi_gr_AB_stack_2L_noH_300K.data +++ /dev/null @@ -1,2739 +0,0 @@ -LAMMPS data file via write_data, version 23 Oct 2017, timestep = 1000000 - -1360 atoms -2 atom types - -0.0000000000000000e+00 4.2599999999999994e+01 xlo xhi -0.0000000000000000e+00 4.1811706494712695e+01 ylo yhi -0.0000000000000000e+00 1.0000000000000000e+02 zlo zhi - -Masses - -1 12.0107 -2 12.0107 - -Atoms # full - -1 1 1 0.0000000000000000e+00 0.0000000000000000e+00 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -2 1 1 0.0000000000000000e+00 7.0999999999999996e-01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -3 1 1 0.0000000000000000e+00 2.1299999999999999e+00 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -4 1 1 0.0000000000000000e+00 2.8399999999999999e+00 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -5 1 1 0.0000000000000000e+00 4.2599999999999998e+00 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -6 1 1 0.0000000000000000e+00 4.9699999999999998e+00 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -7 1 1 0.0000000000000000e+00 6.3899999999999997e+00 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -8 1 1 0.0000000000000000e+00 7.0999999999999996e+00 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -9 1 1 0.0000000000000000e+00 8.5199999999999996e+00 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -10 1 1 0.0000000000000000e+00 9.2300000000000004e+00 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -41 1 1 0.0000000000000000e+00 0.0000000000000000e+00 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -42 1 1 0.0000000000000000e+00 7.0999999999999996e-01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -43 1 1 0.0000000000000000e+00 2.1299999999999999e+00 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -44 1 1 0.0000000000000000e+00 2.8399999999999999e+00 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -45 1 1 0.0000000000000000e+00 4.2599999999999998e+00 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -46 1 1 0.0000000000000000e+00 4.9699999999999998e+00 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -47 1 1 0.0000000000000000e+00 6.3899999999999997e+00 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -48 1 1 0.0000000000000000e+00 7.0999999999999996e+00 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -49 1 1 0.0000000000000000e+00 8.5199999999999996e+00 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -50 1 1 0.0000000000000000e+00 9.2300000000000004e+00 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -81 1 1 0.0000000000000000e+00 0.0000000000000000e+00 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -82 1 1 0.0000000000000000e+00 7.0999999999999996e-01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -83 1 1 0.0000000000000000e+00 2.1299999999999999e+00 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -84 1 1 0.0000000000000000e+00 2.8399999999999999e+00 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -85 1 1 0.0000000000000000e+00 4.2599999999999998e+00 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -86 1 1 0.0000000000000000e+00 4.9699999999999998e+00 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -87 1 1 0.0000000000000000e+00 6.3899999999999997e+00 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -88 1 1 0.0000000000000000e+00 7.0999999999999996e+00 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -89 1 1 0.0000000000000000e+00 8.5199999999999996e+00 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -90 1 1 0.0000000000000000e+00 9.2300000000000004e+00 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -121 1 1 0.0000000000000000e+00 0.0000000000000000e+00 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -122 1 1 0.0000000000000000e+00 7.0999999999999996e-01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -123 1 1 0.0000000000000000e+00 2.1299999999999999e+00 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -124 1 1 0.0000000000000000e+00 2.8399999999999999e+00 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -125 1 1 0.0000000000000000e+00 4.2599999999999998e+00 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -126 1 1 0.0000000000000000e+00 4.9699999999999998e+00 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -127 1 1 0.0000000000000000e+00 6.3899999999999997e+00 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -128 1 1 0.0000000000000000e+00 7.0999999999999996e+00 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -129 1 1 0.0000000000000000e+00 8.5199999999999996e+00 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -130 1 1 0.0000000000000000e+00 9.2300000000000004e+00 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -162 1 1 0.0000000000000000e+00 7.0999999999999996e-01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -163 1 1 0.0000000000000000e+00 2.1299999999999999e+00 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -166 1 1 0.0000000000000000e+00 4.9699999999999998e+00 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -167 1 1 0.0000000000000000e+00 6.3899999999999997e+00 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -170 1 1 0.0000000000000000e+00 9.2300000000000004e+00 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -681 2 2 0.0000000000000000e+00 1.4360484521254813e+00 1.2156353210077178e+00 3.4724433536386705e+00 0 0 0 -980 2 2 0.0000000000000000e+00 2.1268042142700910e+01 1.8467576713172189e+01 3.4356534011004438e+00 0 0 0 -940 2 2 0.0000000000000000e+00 2.1289174529666763e+01 1.5986034351614693e+01 3.4054625743998899e+00 0 0 0 -684 2 2 0.0000000000000000e+00 4.2896146949144462e+00 1.1851031295477696e+00 3.6265428873627212e+00 0 0 0 -685 2 2 0.0000000000000000e+00 5.7298166858273341e+00 1.1813583697974139e+00 3.5908613830504392e+00 0 0 0 -1011 2 2 0.0000000000000000e+00 1.2052329368811529e+01 1.9673253188648559e+01 3.3966889020487923e+00 0 0 0 -1010 2 2 0.0000000000000000e+00 1.0629391760286564e+01 1.9654556437930548e+01 3.4778277606023713e+00 0 0 0 -688 2 2 0.0000000000000000e+00 8.5357332099213092e+00 1.1885082267356111e+00 3.3996796836973764e+00 0 0 0 -689 2 2 0.0000000000000000e+00 9.9652996594827776e+00 1.1729412896240941e+00 3.3974337062564164e+00 0 0 0 -720 2 2 0.0000000000000000e+00 1.0847000573896454e-02 1.2090367574314298e+00 3.4224191240537776e+00 1 0 0 -721 2 2 0.0000000000000000e+00 1.4534403397636206e+00 3.6659606669512601e+00 3.4945537773449695e+00 0 0 0 -722 2 2 0.0000000000000000e+00 2.1564102656635735e+00 2.4453271957582028e+00 3.3864647851790566e+00 0 0 0 -723 2 2 0.0000000000000000e+00 3.5795989042263527e+00 2.4081818479173180e+00 3.4796635056799734e+00 0 0 0 -724 2 2 0.0000000000000000e+00 4.2475856989071055e+00 3.6512372631426557e+00 3.4612841395073213e+00 0 0 0 -725 2 2 0.0000000000000000e+00 5.6743310128811464e+00 3.6303699124186259e+00 3.4709986002061965e+00 0 0 0 -726 2 2 0.0000000000000000e+00 6.4171830153768186e+00 2.4212379145431617e+00 3.4121226133410718e+00 0 0 0 -727 2 2 0.0000000000000000e+00 7.8674041585921088e+00 2.4368869075918291e+00 3.4657079379037103e+00 0 0 0 -728 2 2 0.0000000000000000e+00 8.5338429185895208e+00 3.6773390903281284e+00 3.4224687074866034e+00 0 0 0 -729 2 2 0.0000000000000000e+00 9.9729752888653938e+00 3.6601799099613115e+00 3.4567178575792976e+00 0 0 0 -760 2 2 0.0000000000000000e+00 2.0304101599425150e-02 3.6466920200595960e+00 3.4733764516769181e+00 1 0 0 -761 2 2 0.0000000000000000e+00 1.4312944905075375e+00 6.0883706671660143e+00 3.3712070229911908e+00 0 0 0 -762 2 2 0.0000000000000000e+00 2.1293352307252733e+00 4.8930218945150230e+00 3.3525193302101326e+00 0 0 0 -763 2 2 0.0000000000000000e+00 3.5447883976182819e+00 4.8933626244938164e+00 3.4367504344356021e+00 0 0 0 -764 2 2 0.0000000000000000e+00 4.2835962719753615e+00 6.1017181321696805e+00 3.5096130816794817e+00 0 0 0 -765 2 2 0.0000000000000000e+00 5.7311003237625595e+00 6.0872923252467706e+00 3.4020030478108585e+00 0 0 0 -766 2 2 0.0000000000000000e+00 6.3907622223592622e+00 4.8664252462271396e+00 3.4658076618506368e+00 0 0 0 -767 2 2 0.0000000000000000e+00 7.7969567218941140e+00 4.8673421050445711e+00 3.4969805227646935e+00 0 0 0 -768 2 2 0.0000000000000000e+00 8.5536831663877901e+00 6.1125473087399458e+00 3.4214286435830727e+00 0 0 0 -769 2 2 0.0000000000000000e+00 9.9574226059788469e+00 6.1691046148246498e+00 3.3923430535834216e+00 0 0 0 -1019 2 2 0.0000000000000000e+00 2.0614771476408642e+01 1.9678440988349823e+01 3.3733982220118390e+00 0 0 0 -801 2 2 0.0000000000000000e+00 1.4082844924527798e+00 8.5501468082804237e+00 3.3554870365752718e+00 0 0 0 -802 2 2 0.0000000000000000e+00 2.1420557118870098e+00 7.3029520175272591e+00 3.3668960432977491e+00 0 0 0 -803 2 2 0.0000000000000000e+00 3.5662735110243005e+00 7.3403282406814432e+00 3.4418106025731037e+00 0 0 0 -804 2 2 0.0000000000000000e+00 4.2639462423618966e+00 8.5676444873786259e+00 3.4574041190169322e+00 0 0 0 -805 2 2 0.0000000000000000e+00 5.6981212013879405e+00 8.5376151298269676e+00 3.3761550313944033e+00 0 0 0 -806 2 2 0.0000000000000000e+00 6.4343181980914093e+00 7.3227825545295024e+00 3.3833252158028917e+00 0 0 0 -807 2 2 0.0000000000000000e+00 7.8410483907927269e+00 7.3736709341791942e+00 3.3222078383320546e+00 0 0 0 -808 2 2 0.0000000000000000e+00 8.5673391019276135e+00 8.5851160128338062e+00 3.3594398465372004e+00 0 0 0 -809 2 2 0.0000000000000000e+00 9.9910601148345499e+00 8.6271113270301445e+00 3.3611024326251133e+00 0 0 0 -1018 2 2 0.0000000000000000e+00 1.9176084875249657e+01 1.9672377108796226e+01 3.4109631418328026e+00 0 0 0 -842 2 2 0.0000000000000000e+00 2.1034287387281823e+00 9.7806422683935725e+00 3.4315194130144744e+00 0 0 0 -843 2 2 0.0000000000000000e+00 3.5482339166755552e+00 9.7872360491643082e+00 3.4299282972111413e+00 0 0 0 -846 2 2 0.0000000000000000e+00 6.3990527640381183e+00 9.7402337992089958e+00 3.4373102719438005e+00 0 0 0 -847 2 2 0.0000000000000000e+00 7.8147230850337825e+00 9.7709400342814590e+00 3.3623014949209669e+00 0 0 0 -11 1 1 0.0000000000000000e+00 1.0649999999999999e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -12 1 1 0.0000000000000000e+00 1.1359999999999999e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -13 1 1 0.0000000000000000e+00 1.2779999999999999e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -14 1 1 0.0000000000000000e+00 1.3489999999999998e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -15 1 1 0.0000000000000000e+00 1.4910000000000000e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -16 1 1 0.0000000000000000e+00 1.5619999999999999e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -17 1 1 0.0000000000000000e+00 1.7039999999999999e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -18 1 1 0.0000000000000000e+00 1.7750000000000000e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -19 1 1 0.0000000000000000e+00 1.9169999999999998e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -20 1 1 0.0000000000000000e+00 1.9879999999999999e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -51 1 1 0.0000000000000000e+00 1.0649999999999999e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -52 1 1 0.0000000000000000e+00 1.1359999999999999e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -53 1 1 0.0000000000000000e+00 1.2779999999999999e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -54 1 1 0.0000000000000000e+00 1.3489999999999998e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -55 1 1 0.0000000000000000e+00 1.4910000000000000e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -56 1 1 0.0000000000000000e+00 1.5619999999999999e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -57 1 1 0.0000000000000000e+00 1.7039999999999999e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -58 1 1 0.0000000000000000e+00 1.7750000000000000e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -59 1 1 0.0000000000000000e+00 1.9169999999999998e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -60 1 1 0.0000000000000000e+00 1.9879999999999999e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -91 1 1 0.0000000000000000e+00 1.0649999999999999e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -92 1 1 0.0000000000000000e+00 1.1359999999999999e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -93 1 1 0.0000000000000000e+00 1.2779999999999999e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -94 1 1 0.0000000000000000e+00 1.3489999999999998e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -95 1 1 0.0000000000000000e+00 1.4910000000000000e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -96 1 1 0.0000000000000000e+00 1.5619999999999999e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -97 1 1 0.0000000000000000e+00 1.7039999999999999e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -98 1 1 0.0000000000000000e+00 1.7750000000000000e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -99 1 1 0.0000000000000000e+00 1.9169999999999998e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -100 1 1 0.0000000000000000e+00 1.9879999999999999e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -131 1 1 0.0000000000000000e+00 1.0649999999999999e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -132 1 1 0.0000000000000000e+00 1.1359999999999999e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -133 1 1 0.0000000000000000e+00 1.2779999999999999e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -134 1 1 0.0000000000000000e+00 1.3489999999999998e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -135 1 1 0.0000000000000000e+00 1.4910000000000000e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -136 1 1 0.0000000000000000e+00 1.5619999999999999e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -137 1 1 0.0000000000000000e+00 1.7039999999999999e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -138 1 1 0.0000000000000000e+00 1.7750000000000000e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -139 1 1 0.0000000000000000e+00 1.9169999999999998e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -140 1 1 0.0000000000000000e+00 1.9879999999999999e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -171 1 1 0.0000000000000000e+00 1.0649999999999999e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -174 1 1 0.0000000000000000e+00 1.3489999999999998e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -175 1 1 0.0000000000000000e+00 1.4910000000000000e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -178 1 1 0.0000000000000000e+00 1.7750000000000000e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -179 1 1 0.0000000000000000e+00 1.9169999999999998e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -979 2 2 0.0000000000000000e+00 2.0606737643177919e+01 1.7231579013557369e+01 3.4581144058711217e+00 0 0 0 -978 2 2 0.0000000000000000e+00 1.9183796034130779e+01 1.7226343637626957e+01 3.4656806819105332e+00 0 0 0 -692 2 2 0.0000000000000000e+00 1.2825128244825484e+01 1.1979632984636728e+00 3.4079564159728073e+00 0 0 0 -693 2 2 0.0000000000000000e+00 1.4227380214058627e+01 1.1627789274510960e+00 3.3830589382081762e+00 0 0 0 -977 2 2 0.0000000000000000e+00 1.8468951996504330e+01 1.8453885253904165e+01 3.3649146348301322e+00 0 0 0 -976 2 2 0.0000000000000000e+00 1.7027934867551267e+01 1.8466578588131657e+01 3.4043750346451400e+00 0 0 0 -696 2 2 0.0000000000000000e+00 1.7106429535489159e+01 1.1982511240932916e+00 3.4430092923956082e+00 0 0 0 -697 2 2 0.0000000000000000e+00 1.8506054246123242e+01 1.2385732755228496e+00 3.5222084479556495e+00 0 0 0 -975 2 2 0.0000000000000000e+00 1.6349315608535591e+01 1.7231685621911094e+01 3.3871155590454713e+00 0 0 0 -974 2 2 0.0000000000000000e+00 1.4934702297462803e+01 1.7209805739151580e+01 3.4038111563979210e+00 0 0 0 -730 2 2 0.0000000000000000e+00 1.0689351078724647e+01 2.4376988089851008e+00 3.3792073560566509e+00 0 0 0 -731 2 2 0.0000000000000000e+00 1.2086353481209592e+01 2.3848555355380587e+00 3.4089597083220835e+00 0 0 0 -732 2 2 0.0000000000000000e+00 1.2809032592257868e+01 3.6101708128449688e+00 3.4542764180813812e+00 0 0 0 -733 2 2 0.0000000000000000e+00 1.4218446421457086e+01 3.6524187755908746e+00 3.3390287611412690e+00 0 0 0 -734 2 2 0.0000000000000000e+00 1.4931744333718854e+01 2.4198100191517944e+00 3.3766638948248571e+00 0 0 0 -735 2 2 0.0000000000000000e+00 1.6343983696427454e+01 2.4191132915075593e+00 3.4591714286696100e+00 0 0 0 -736 2 2 0.0000000000000000e+00 1.7040031761751560e+01 3.6575456506254396e+00 3.5069171273052913e+00 0 0 0 -737 2 2 0.0000000000000000e+00 1.8455759767878213e+01 3.6832045322718576e+00 3.5093967707528884e+00 0 0 0 -738 2 2 0.0000000000000000e+00 1.9206205830953451e+01 2.4895555779060277e+00 3.5830176476542737e+00 0 0 0 -739 2 2 0.0000000000000000e+00 2.0623028178576643e+01 2.4047005967545361e+00 3.4402287255084882e+00 0 0 0 -770 2 2 0.0000000000000000e+00 1.0673737043046222e+01 4.9324598046151440e+00 3.4167361776960283e+00 0 0 0 -771 2 2 0.0000000000000000e+00 1.2087682090398591e+01 4.8893171778121092e+00 3.3434009911120848e+00 0 0 0 -772 2 2 0.0000000000000000e+00 1.2795193034949950e+01 6.1061900003989074e+00 3.3646904915331146e+00 0 0 0 -773 2 2 0.0000000000000000e+00 1.4197269922105637e+01 6.0887128665133678e+00 3.4048366949167415e+00 0 0 0 -774 2 2 0.0000000000000000e+00 1.4892676168000389e+01 4.8673341373930468e+00 3.4571139814114580e+00 0 0 0 -775 2 2 0.0000000000000000e+00 1.6346095804400832e+01 4.8887367885979325e+00 3.4209328059029946e+00 0 0 0 -776 2 2 0.0000000000000000e+00 1.7075110752377341e+01 6.1048331669597546e+00 3.3652639742616985e+00 0 0 0 -777 2 2 0.0000000000000000e+00 1.8472529679788501e+01 6.1218585737431921e+00 3.4269749207294313e+00 0 0 0 -778 2 2 0.0000000000000000e+00 1.9160174369448239e+01 4.9084345633770639e+00 3.5119242025769459e+00 0 0 0 -779 2 2 0.0000000000000000e+00 2.0616499243567613e+01 4.8668881960391408e+00 3.4935603899234393e+00 0 0 0 -810 2 2 0.0000000000000000e+00 1.0666205042902956e+01 7.3918460081565849e+00 3.3791778429325938e+00 0 0 0 -811 2 2 0.0000000000000000e+00 1.2093764161129547e+01 7.3270224586299868e+00 3.3779132991047036e+00 0 0 0 -812 2 2 0.0000000000000000e+00 1.2831536987971612e+01 8.5933721339755653e+00 3.3287657886666726e+00 0 0 0 -813 2 2 0.0000000000000000e+00 1.4237146486015172e+01 8.5396517450210787e+00 3.3690151373134087e+00 0 0 0 -814 2 2 0.0000000000000000e+00 1.4916784641639698e+01 7.3298262510481944e+00 3.3708334850934247e+00 0 0 0 -815 2 2 0.0000000000000000e+00 1.6333032343455091e+01 7.3547980922515377e+00 3.4495530819174247e+00 0 0 0 -816 2 2 0.0000000000000000e+00 1.7032844540545764e+01 8.6107424416555425e+00 3.4717978051673861e+00 0 0 0 -817 2 2 0.0000000000000000e+00 1.8454185286597301e+01 8.5898962174403106e+00 3.4912090889111895e+00 0 0 0 -818 2 2 0.0000000000000000e+00 1.9192648551915237e+01 7.3593922210835014e+00 3.4580338474249821e+00 0 0 0 -819 2 2 0.0000000000000000e+00 2.0615275400363281e+01 7.3364578785532366e+00 3.5140812390640588e+00 0 0 0 -850 2 2 0.0000000000000000e+00 1.0726339999387164e+01 9.8165856704039953e+00 3.4173846855908088e+00 0 0 0 -851 2 2 0.0000000000000000e+00 1.2123051093822083e+01 9.8214717745968994e+00 3.3793237076364790e+00 0 0 0 -854 2 2 0.0000000000000000e+00 1.4944091287809160e+01 9.7623350471511241e+00 3.4500986896665009e+00 0 0 0 -855 2 2 0.0000000000000000e+00 1.6336562616007591e+01 9.8279271160742514e+00 3.4161668733871080e+00 0 0 0 -858 2 2 0.0000000000000000e+00 1.9189199084655232e+01 9.7736399659349082e+00 3.5181980138178610e+00 0 0 0 -859 2 2 0.0000000000000000e+00 2.0587840592191768e+01 9.8006578760977980e+00 3.5608097170649526e+00 0 0 0 -161 1 1 0.0000000000000000e+00 0.0000000000000000e+00 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -164 1 1 0.0000000000000000e+00 2.8399999999999999e+00 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -165 1 1 0.0000000000000000e+00 4.2599999999999998e+00 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -168 1 1 0.0000000000000000e+00 7.0999999999999996e+00 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -169 1 1 0.0000000000000000e+00 8.5199999999999996e+00 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -201 1 1 0.0000000000000000e+00 0.0000000000000000e+00 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -202 1 1 0.0000000000000000e+00 7.0999999999999996e-01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -203 1 1 0.0000000000000000e+00 2.1299999999999999e+00 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -204 1 1 0.0000000000000000e+00 2.8399999999999999e+00 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -205 1 1 0.0000000000000000e+00 4.2599999999999998e+00 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -206 1 1 0.0000000000000000e+00 4.9699999999999998e+00 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -207 1 1 0.0000000000000000e+00 6.3899999999999997e+00 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -208 1 1 0.0000000000000000e+00 7.0999999999999996e+00 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -209 1 1 0.0000000000000000e+00 8.5199999999999996e+00 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -210 1 1 0.0000000000000000e+00 9.2300000000000004e+00 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -241 1 1 0.0000000000000000e+00 0.0000000000000000e+00 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -242 1 1 0.0000000000000000e+00 7.0999999999999996e-01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -243 1 1 0.0000000000000000e+00 2.1299999999999999e+00 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -244 1 1 0.0000000000000000e+00 2.8399999999999999e+00 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -245 1 1 0.0000000000000000e+00 4.2599999999999998e+00 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -246 1 1 0.0000000000000000e+00 4.9699999999999998e+00 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -247 1 1 0.0000000000000000e+00 6.3899999999999997e+00 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -248 1 1 0.0000000000000000e+00 7.0999999999999996e+00 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -249 1 1 0.0000000000000000e+00 8.5199999999999996e+00 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -250 1 1 0.0000000000000000e+00 9.2300000000000004e+00 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -281 1 1 0.0000000000000000e+00 0.0000000000000000e+00 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -282 1 1 0.0000000000000000e+00 7.0999999999999996e-01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -283 1 1 0.0000000000000000e+00 2.1299999999999999e+00 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -284 1 1 0.0000000000000000e+00 2.8399999999999999e+00 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -285 1 1 0.0000000000000000e+00 4.2599999999999998e+00 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -286 1 1 0.0000000000000000e+00 4.9699999999999998e+00 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -287 1 1 0.0000000000000000e+00 6.3899999999999997e+00 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -288 1 1 0.0000000000000000e+00 7.0999999999999996e+00 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -289 1 1 0.0000000000000000e+00 8.5199999999999996e+00 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -290 1 1 0.0000000000000000e+00 9.2300000000000004e+00 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -322 1 1 0.0000000000000000e+00 7.0999999999999996e-01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -323 1 1 0.0000000000000000e+00 2.1299999999999999e+00 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -326 1 1 0.0000000000000000e+00 4.9699999999999998e+00 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -327 1 1 0.0000000000000000e+00 6.3899999999999997e+00 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -330 1 1 0.0000000000000000e+00 9.2300000000000004e+00 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -841 2 2 0.0000000000000000e+00 1.3845033314640982e+00 1.1025820332784152e+01 3.4732649197728280e+00 0 0 0 -844 2 2 0.0000000000000000e+00 4.2431846472887260e+00 1.0970856623452475e+01 3.4989839603568287e+00 0 0 0 -845 2 2 0.0000000000000000e+00 5.6605939270182510e+00 1.0972209049006597e+01 3.4909511778951354e+00 0 0 0 -848 2 2 0.0000000000000000e+00 8.5443893186779860e+00 1.1000240528319337e+01 3.4615227406407985e+00 0 0 0 -849 2 2 0.0000000000000000e+00 1.0016917715256740e+01 1.1036765907570992e+01 3.4199021031123160e+00 0 0 0 -1015 2 2 0.0000000000000000e+00 1.6301922810025108e+01 1.9673930998555768e+01 3.3774967878389197e+00 0 0 0 -881 2 2 0.0000000000000000e+00 1.4419002259800158e+00 1.3522623862351168e+01 3.4111228650911198e+00 0 0 0 -882 2 2 0.0000000000000000e+00 2.1542633018245163e+00 1.2243047155457207e+01 3.4452774003722171e+00 0 0 0 -883 2 2 0.0000000000000000e+00 3.5825588257789160e+00 1.2255520669787545e+01 3.4999173183685830e+00 0 0 0 -884 2 2 0.0000000000000000e+00 4.2786317804235861e+00 1.3496383489099639e+01 3.5499863768378721e+00 0 0 0 -885 2 2 0.0000000000000000e+00 5.7113061526675191e+00 1.3464732134241254e+01 3.4867747613266373e+00 0 0 0 -886 2 2 0.0000000000000000e+00 6.4092649411175815e+00 1.2229082302385914e+01 3.5359795634094051e+00 0 0 0 -887 2 2 0.0000000000000000e+00 7.8319317926474499e+00 1.2233151820283377e+01 3.5206949896303410e+00 0 0 0 -888 2 2 0.0000000000000000e+00 8.5157508753001760e+00 1.3473662847128443e+01 3.4788318870721788e+00 0 0 0 -889 2 2 0.0000000000000000e+00 9.9362553235649091e+00 1.3527976223694766e+01 3.4668260637429222e+00 0 0 0 -920 2 2 0.0000000000000000e+00 1.2237911507440830e-02 1.3558563050609528e+01 3.4597343820427775e+00 1 0 0 -921 2 2 0.0000000000000000e+00 1.4288163878560016e+00 1.5991719725377481e+01 3.5694377673805500e+00 0 0 0 -922 2 2 0.0000000000000000e+00 2.1340531037076809e+00 1.4767795385881259e+01 3.4862412006438377e+00 0 0 0 -923 2 2 0.0000000000000000e+00 3.5664961557381578e+00 1.4726178587098349e+01 3.5569234373617298e+00 0 0 0 -924 2 2 0.0000000000000000e+00 4.2867015396418600e+00 1.5980222286419201e+01 3.6024358364576559e+00 0 0 0 -925 2 2 0.0000000000000000e+00 5.7045560702958191e+00 1.5971949050340868e+01 3.4459017887927517e+00 0 0 0 -926 2 2 0.0000000000000000e+00 6.4193880840071849e+00 1.4745584703409234e+01 3.4832167958450508e+00 0 0 0 -927 2 2 0.0000000000000000e+00 7.8117420196204037e+00 1.4710926309362412e+01 3.4034915877755676e+00 0 0 0 -928 2 2 0.0000000000000000e+00 8.5511355717083912e+00 1.5987164960941989e+01 3.3594802888021782e+00 0 0 0 -929 2 2 0.0000000000000000e+00 9.9548307542097803e+00 1.5974464044361795e+01 3.4465376488521855e+00 0 0 0 -960 2 2 0.0000000000000000e+00 2.5145153759279174e-02 1.5991665304247524e+01 3.6410417525546284e+00 1 0 0 -961 2 2 0.0000000000000000e+00 1.4132040097965335e+00 1.8418746864558816e+01 3.6558728508235196e+00 0 0 0 -962 2 2 0.0000000000000000e+00 2.1415603846975291e+00 1.7211824175388099e+01 3.6747879425702621e+00 0 0 0 -963 2 2 0.0000000000000000e+00 3.5614325036635015e+00 1.7216381474760848e+01 3.6674527177374863e+00 0 0 0 -964 2 2 0.0000000000000000e+00 4.2907941588889189e+00 1.8425671079174560e+01 3.5527400546607484e+00 0 0 0 -965 2 2 0.0000000000000000e+00 5.6721950818403162e+00 1.8409502940394528e+01 3.5232724582923693e+00 0 0 0 -966 2 2 0.0000000000000000e+00 6.4134278200777564e+00 1.7199270644096480e+01 3.4626064425024099e+00 0 0 0 -967 2 2 0.0000000000000000e+00 7.8221292206522008e+00 1.7190814824287045e+01 3.3875191111278280e+00 0 0 0 -968 2 2 0.0000000000000000e+00 8.4964262329471687e+00 1.8411094183223547e+01 3.5509225764725421e+00 0 0 0 -969 2 2 0.0000000000000000e+00 9.9405030376584218e+00 1.8424225613104916e+01 3.5251254566538375e+00 0 0 0 -1014 2 2 0.0000000000000000e+00 1.4882788005117588e+01 1.9670515777815794e+01 3.3107588700567030e+00 0 0 0 -1002 2 2 0.0000000000000000e+00 2.1044747906191081e+00 1.9641310707109959e+01 3.6244539666391975e+00 0 0 0 -1003 2 2 0.0000000000000000e+00 3.5309372121571090e+00 1.9652193069765705e+01 3.6706916577373980e+00 0 0 0 -1006 2 2 0.0000000000000000e+00 6.3560421371391129e+00 1.9627391264522903e+01 3.4342450206733259e+00 0 0 0 -1007 2 2 0.0000000000000000e+00 7.7798921066268232e+00 1.9647796026002545e+01 3.5348795423060988e+00 0 0 0 -172 1 1 0.0000000000000000e+00 1.1359999999999999e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -173 1 1 0.0000000000000000e+00 1.2779999999999999e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -176 1 1 0.0000000000000000e+00 1.5619999999999999e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -177 1 1 0.0000000000000000e+00 1.7039999999999999e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -180 1 1 0.0000000000000000e+00 1.9879999999999999e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -211 1 1 0.0000000000000000e+00 1.0649999999999999e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -212 1 1 0.0000000000000000e+00 1.1359999999999999e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -213 1 1 0.0000000000000000e+00 1.2779999999999999e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -214 1 1 0.0000000000000000e+00 1.3489999999999998e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -215 1 1 0.0000000000000000e+00 1.4910000000000000e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -216 1 1 0.0000000000000000e+00 1.5619999999999999e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -217 1 1 0.0000000000000000e+00 1.7039999999999999e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -218 1 1 0.0000000000000000e+00 1.7750000000000000e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -219 1 1 0.0000000000000000e+00 1.9169999999999998e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -220 1 1 0.0000000000000000e+00 1.9879999999999999e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -251 1 1 0.0000000000000000e+00 1.0649999999999999e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -252 1 1 0.0000000000000000e+00 1.1359999999999999e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -253 1 1 0.0000000000000000e+00 1.2779999999999999e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -254 1 1 0.0000000000000000e+00 1.3489999999999998e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -255 1 1 0.0000000000000000e+00 1.4910000000000000e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -256 1 1 0.0000000000000000e+00 1.5619999999999999e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -257 1 1 0.0000000000000000e+00 1.7039999999999999e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -258 1 1 0.0000000000000000e+00 1.7750000000000000e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -259 1 1 0.0000000000000000e+00 1.9169999999999998e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -260 1 1 0.0000000000000000e+00 1.9879999999999999e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -291 1 1 0.0000000000000000e+00 1.0649999999999999e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -292 1 1 0.0000000000000000e+00 1.1359999999999999e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -293 1 1 0.0000000000000000e+00 1.2779999999999999e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -294 1 1 0.0000000000000000e+00 1.3489999999999998e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -295 1 1 0.0000000000000000e+00 1.4910000000000000e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -296 1 1 0.0000000000000000e+00 1.5619999999999999e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -297 1 1 0.0000000000000000e+00 1.7039999999999999e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -298 1 1 0.0000000000000000e+00 1.7750000000000000e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -299 1 1 0.0000000000000000e+00 1.9169999999999998e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -300 1 1 0.0000000000000000e+00 1.9879999999999999e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -331 1 1 0.0000000000000000e+00 1.0649999999999999e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -334 1 1 0.0000000000000000e+00 1.3489999999999998e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -335 1 1 0.0000000000000000e+00 1.4910000000000000e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -338 1 1 0.0000000000000000e+00 1.7750000000000000e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -339 1 1 0.0000000000000000e+00 1.9169999999999998e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -852 2 2 0.0000000000000000e+00 1.2809017194812190e+01 1.1054908368409119e+01 3.4140368207077327e+00 0 0 0 -853 2 2 0.0000000000000000e+00 1.4220119053389061e+01 1.1021866224341498e+01 3.5051170217195891e+00 0 0 0 -856 2 2 0.0000000000000000e+00 1.7068510597153498e+01 1.1017379682662652e+01 3.4589149585650794e+00 0 0 0 -857 2 2 0.0000000000000000e+00 1.8487958999004263e+01 1.1033773745004572e+01 3.4973760222025922e+00 0 0 0 -890 2 2 0.0000000000000000e+00 1.0642030019504498e+01 1.2327944203768883e+01 3.4100475359485882e+00 0 0 0 -891 2 2 0.0000000000000000e+00 1.2095607423923544e+01 1.2338428460582239e+01 3.3830163997230196e+00 0 0 0 -892 2 2 0.0000000000000000e+00 1.2825149497328001e+01 1.3543424234696577e+01 3.4838066689284819e+00 0 0 0 -893 2 2 0.0000000000000000e+00 1.4193309922307440e+01 1.3536751636629463e+01 3.4704608525512533e+00 0 0 0 -894 2 2 0.0000000000000000e+00 1.4912374703073102e+01 1.2274229306424274e+01 3.4943219446978149e+00 0 0 0 -895 2 2 0.0000000000000000e+00 1.6330895644261162e+01 1.2283658643741294e+01 3.5010063982024957e+00 0 0 0 -896 2 2 0.0000000000000000e+00 1.7047925783817053e+01 1.3521680123657807e+01 3.4648973496868400e+00 0 0 0 -897 2 2 0.0000000000000000e+00 1.8480852548067695e+01 1.3490825058354366e+01 3.5436289913914272e+00 0 0 0 -898 2 2 0.0000000000000000e+00 1.9201022075635265e+01 1.2275125495062451e+01 3.4176383172146818e+00 0 0 0 -899 2 2 0.0000000000000000e+00 2.0614022796645791e+01 1.2272974964598314e+01 3.4602052019728533e+00 0 0 0 -930 2 2 0.0000000000000000e+00 1.0660566194056177e+01 1.4751797944843798e+01 3.4535619832562703e+00 0 0 0 -931 2 2 0.0000000000000000e+00 1.2095923137943998e+01 1.4766333684411775e+01 3.4659416921093409e+00 0 0 0 -932 2 2 0.0000000000000000e+00 1.2803545032531481e+01 1.5955891074864809e+01 3.4574937926123348e+00 0 0 0 -933 2 2 0.0000000000000000e+00 1.4201490844033389e+01 1.5995210853556596e+01 3.4632722762405894e+00 0 0 0 -934 2 2 0.0000000000000000e+00 1.4923752454064399e+01 1.4781044979149993e+01 3.5030261559452232e+00 0 0 0 -935 2 2 0.0000000000000000e+00 1.6377578663106320e+01 1.4756878254961800e+01 3.4901088433397134e+00 0 0 0 -936 2 2 0.0000000000000000e+00 1.7069079805989603e+01 1.6010104161884410e+01 3.4448022587170404e+00 0 0 0 -937 2 2 0.0000000000000000e+00 1.8482410741258963e+01 1.5968065835958278e+01 3.4939630036982585e+00 0 0 0 -938 2 2 0.0000000000000000e+00 1.9183566751248033e+01 1.4747759395549711e+01 3.4837969537438851e+00 0 0 0 -939 2 2 0.0000000000000000e+00 2.0628540228971641e+01 1.4756551539421114e+01 3.4373584121442087e+00 0 0 0 -970 2 2 0.0000000000000000e+00 1.0656695701951254e+01 1.7191848422929361e+01 3.4021841298374143e+00 0 0 0 -971 2 2 0.0000000000000000e+00 1.2076991428963657e+01 1.7175092773926462e+01 3.3681008877519130e+00 0 0 0 -972 2 2 0.0000000000000000e+00 1.2747371434726579e+01 1.8440678336901374e+01 3.3851535423681551e+00 0 0 0 -973 2 2 0.0000000000000000e+00 1.4191521101363950e+01 1.8406057770607369e+01 3.3705459556379731e+00 0 0 0 -1001 2 2 0.0000000000000000e+00 1.3944702514182281e+00 2.0876571774539645e+01 3.6734033355752049e+00 0 0 0 -1004 2 2 0.0000000000000000e+00 4.2133227831755056e+00 2.0857539728539006e+01 3.6570243592921097e+00 0 0 0 -1005 2 2 0.0000000000000000e+00 5.6407080351174947e+00 2.0882830061369120e+01 3.5220200510131288e+00 0 0 0 -1008 2 2 0.0000000000000000e+00 8.5155710749285785e+00 2.0876498333744973e+01 3.4949010821280067e+00 0 0 0 -1009 2 2 0.0000000000000000e+00 9.9589226647397879e+00 2.0860027193138283e+01 3.4568005760009899e+00 0 0 0 -1012 2 2 0.0000000000000000e+00 1.2809561430009833e+01 2.0889219250211490e+01 3.3896137810024607e+00 0 0 0 -321 1 1 0.0000000000000000e+00 0.0000000000000000e+00 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -324 1 1 0.0000000000000000e+00 2.8399999999999999e+00 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -325 1 1 0.0000000000000000e+00 4.2599999999999998e+00 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -328 1 1 0.0000000000000000e+00 7.0999999999999996e+00 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -329 1 1 0.0000000000000000e+00 8.5199999999999996e+00 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -361 1 1 0.0000000000000000e+00 0.0000000000000000e+00 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -362 1 1 0.0000000000000000e+00 7.0999999999999996e-01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -363 1 1 0.0000000000000000e+00 2.1299999999999999e+00 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -364 1 1 0.0000000000000000e+00 2.8399999999999999e+00 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -365 1 1 0.0000000000000000e+00 4.2599999999999998e+00 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -366 1 1 0.0000000000000000e+00 4.9699999999999998e+00 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -367 1 1 0.0000000000000000e+00 6.3899999999999997e+00 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -368 1 1 0.0000000000000000e+00 7.0999999999999996e+00 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -369 1 1 0.0000000000000000e+00 8.5199999999999996e+00 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -370 1 1 0.0000000000000000e+00 9.2300000000000004e+00 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -401 1 1 0.0000000000000000e+00 0.0000000000000000e+00 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -402 1 1 0.0000000000000000e+00 7.0999999999999996e-01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -403 1 1 0.0000000000000000e+00 2.1299999999999999e+00 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -404 1 1 0.0000000000000000e+00 2.8399999999999999e+00 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -405 1 1 0.0000000000000000e+00 4.2599999999999998e+00 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -406 1 1 0.0000000000000000e+00 4.9699999999999998e+00 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -407 1 1 0.0000000000000000e+00 6.3899999999999997e+00 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -408 1 1 0.0000000000000000e+00 7.0999999999999996e+00 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -409 1 1 0.0000000000000000e+00 8.5199999999999996e+00 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -410 1 1 0.0000000000000000e+00 9.2300000000000004e+00 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -441 1 1 0.0000000000000000e+00 0.0000000000000000e+00 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -442 1 1 0.0000000000000000e+00 7.0999999999999996e-01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -443 1 1 0.0000000000000000e+00 2.1299999999999999e+00 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -444 1 1 0.0000000000000000e+00 2.8399999999999999e+00 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -445 1 1 0.0000000000000000e+00 4.2599999999999998e+00 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -446 1 1 0.0000000000000000e+00 4.9699999999999998e+00 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -447 1 1 0.0000000000000000e+00 6.3899999999999997e+00 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -448 1 1 0.0000000000000000e+00 7.0999999999999996e+00 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -449 1 1 0.0000000000000000e+00 8.5199999999999996e+00 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -450 1 1 0.0000000000000000e+00 9.2300000000000004e+00 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -481 1 1 0.0000000000000000e+00 0.0000000000000000e+00 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -482 1 1 0.0000000000000000e+00 7.0999999999999996e-01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -483 1 1 0.0000000000000000e+00 2.1299999999999999e+00 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -484 1 1 0.0000000000000000e+00 2.8399999999999999e+00 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -485 1 1 0.0000000000000000e+00 4.2599999999999998e+00 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -486 1 1 0.0000000000000000e+00 4.9699999999999998e+00 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -487 1 1 0.0000000000000000e+00 6.3899999999999997e+00 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -488 1 1 0.0000000000000000e+00 7.0999999999999996e+00 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -489 1 1 0.0000000000000000e+00 8.5199999999999996e+00 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -490 1 1 0.0000000000000000e+00 9.2300000000000004e+00 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -1300 2 2 0.0000000000000000e+00 2.1290217018244302e+01 3.8120100777889519e+01 3.3992177489109405e+00 0 0 0 -1260 2 2 0.0000000000000000e+00 2.1281315573224937e+01 3.5665981024812247e+01 3.4577993882823708e+00 0 0 0 -1220 2 2 0.0000000000000000e+00 2.1282438513519399e+01 3.3175938309889325e+01 3.4479437195943636e+00 0 0 0 -1180 2 2 0.0000000000000000e+00 2.1263002450799327e+01 3.0714296827862654e+01 3.4249846469684595e+00 0 0 0 -1100 2 2 0.0000000000000000e+00 2.1284653578025491e+01 2.5866037449962249e+01 3.4778825432769178e+00 0 0 0 -1339 2 2 0.0000000000000000e+00 2.0591391009599889e+01 3.9342644327422072e+01 3.5111645715913160e+00 0 0 0 -1041 2 2 0.0000000000000000e+00 1.3566665277776921e+00 2.3339485619154399e+01 3.7596159527714632e+00 0 0 0 -1042 2 2 0.0000000000000000e+00 2.1127439989221193e+00 2.2108408231306292e+01 3.6754699387724794e+00 0 0 0 -1043 2 2 0.0000000000000000e+00 3.5392088416080099e+00 2.2116666099490455e+01 3.6109253042452352e+00 0 0 0 -1044 2 2 0.0000000000000000e+00 4.2332979503436414e+00 2.3318860979576979e+01 3.5145861010279282e+00 0 0 0 -1045 2 2 0.0000000000000000e+00 5.6753096655991211e+00 2.3350455297071434e+01 3.5960082062005245e+00 0 0 0 -1046 2 2 0.0000000000000000e+00 6.3777276878137679e+00 2.2130905185549540e+01 3.5191875034080047e+00 0 0 0 -1047 2 2 0.0000000000000000e+00 7.8054314619881699e+00 2.2131729131375014e+01 3.4838979276011828e+00 0 0 0 -1048 2 2 0.0000000000000000e+00 8.5130574728951149e+00 2.3378133496114348e+01 3.4934290095732221e+00 0 0 0 -1049 2 2 0.0000000000000000e+00 9.9354448174137353e+00 2.3348081833734433e+01 3.4318860700962115e+00 0 0 0 -1338 2 2 0.0000000000000000e+00 1.9180686142560379e+01 3.9344309035191031e+01 3.4687019053733614e+00 0 0 0 -1081 2 2 0.0000000000000000e+00 1.4168505099554372e+00 2.5791521439124185e+01 3.5460293913718495e+00 0 0 0 -1082 2 2 0.0000000000000000e+00 2.0549337770017346e+00 2.4558933974177538e+01 3.6078734803132413e+00 0 0 0 -1083 2 2 0.0000000000000000e+00 3.4981068294982904e+00 2.4549473906668620e+01 3.5402664300674314e+00 0 0 0 -1084 2 2 0.0000000000000000e+00 4.2128214637178774e+00 2.5766186079659420e+01 3.4299576896437762e+00 0 0 0 -1085 2 2 0.0000000000000000e+00 5.6288417909137474e+00 2.5784794044346597e+01 3.5286025010456910e+00 0 0 0 -1086 2 2 0.0000000000000000e+00 6.3492933235430984e+00 2.4544296109774063e+01 3.5187536347437822e+00 0 0 0 -1087 2 2 0.0000000000000000e+00 7.7803042440530783e+00 2.4592798666152234e+01 3.5287809815132825e+00 0 0 0 -1088 2 2 0.0000000000000000e+00 8.4649377958009282e+00 2.5825770947694515e+01 3.4443693225624719e+00 0 0 0 -1089 2 2 0.0000000000000000e+00 9.8832879462219783e+00 2.5815910851728539e+01 3.4394399979173396e+00 0 0 0 -1120 2 2 0.0000000000000000e+00 1.9576467297775213e-04 2.5835433633771725e+01 3.5096924468474864e+00 1 0 0 -1121 2 2 0.0000000000000000e+00 1.3851914655192019e+00 2.8225762874520719e+01 3.4782669199401961e+00 0 0 0 -1122 2 2 0.0000000000000000e+00 2.1506567488724242e+00 2.7021260018493393e+01 3.4649216424206042e+00 0 0 0 -1123 2 2 0.0000000000000000e+00 3.5511220273189026e+00 2.7007941439876365e+01 3.4081787513269548e+00 0 0 0 -1124 2 2 0.0000000000000000e+00 4.2623566900492822e+00 2.8235576865866911e+01 3.5230248477676209e+00 0 0 0 -1125 2 2 0.0000000000000000e+00 5.6506949377980646e+00 2.8254516994754130e+01 3.5024216780227455e+00 0 0 0 -1126 2 2 0.0000000000000000e+00 6.3376378145645385e+00 2.7023465610506587e+01 3.4247968416247700e+00 0 0 0 -1127 2 2 0.0000000000000000e+00 7.7636073541602801e+00 2.7018642249146229e+01 3.4048275316716992e+00 0 0 0 -1128 2 2 0.0000000000000000e+00 8.4778781985460991e+00 2.8241350947808687e+01 3.4303692864983542e+00 0 0 0 -1129 2 2 0.0000000000000000e+00 9.8863648316694324e+00 2.8263374609029409e+01 3.4854419440184037e+00 0 0 0 -1337 2 2 0.0000000000000000e+00 1.8460269637906269e+01 4.0547968469054297e+01 3.5537265054822726e+00 0 0 0 -1161 2 2 0.0000000000000000e+00 1.3624490706129815e+00 3.0691510311774728e+01 3.5483868780075465e+00 0 0 0 -1162 2 2 0.0000000000000000e+00 2.0726016673496850e+00 2.9453409527746015e+01 3.4517653450200769e+00 0 0 0 -1163 2 2 0.0000000000000000e+00 3.5089186709904343e+00 2.9462210713562371e+01 3.5700649667876299e+00 0 0 0 -1164 2 2 0.0000000000000000e+00 4.2308311502705100e+00 3.0703978297055695e+01 3.5725600607520622e+00 0 0 0 -1165 2 2 0.0000000000000000e+00 5.6100205184731786e+00 3.0649758849512146e+01 3.3728030832721099e+00 0 0 0 -1166 2 2 0.0000000000000000e+00 6.3707308600571997e+00 2.9455523984828112e+01 3.4766277403350885e+00 0 0 0 -1167 2 2 0.0000000000000000e+00 7.8003869187372681e+00 2.9471601432884526e+01 3.4696621180570584e+00 0 0 0 -1168 2 2 0.0000000000000000e+00 8.4972417379400795e+00 3.0683370084456605e+01 3.3295631341905558e+00 0 0 0 -1169 2 2 0.0000000000000000e+00 9.9045678699548372e+00 3.0712140564473227e+01 3.4503569941167780e+00 0 0 0 -1336 2 2 0.0000000000000000e+00 1.7069191183079397e+01 4.0566486196113651e+01 3.4389503776105133e+00 0 0 0 -332 1 1 0.0000000000000000e+00 1.1359999999999999e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -333 1 1 0.0000000000000000e+00 1.2779999999999999e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -336 1 1 0.0000000000000000e+00 1.5619999999999999e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -337 1 1 0.0000000000000000e+00 1.7039999999999999e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -340 1 1 0.0000000000000000e+00 1.9879999999999999e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -371 1 1 0.0000000000000000e+00 1.0649999999999999e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -372 1 1 0.0000000000000000e+00 1.1359999999999999e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -373 1 1 0.0000000000000000e+00 1.2779999999999999e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -374 1 1 0.0000000000000000e+00 1.3489999999999998e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -375 1 1 0.0000000000000000e+00 1.4910000000000000e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -376 1 1 0.0000000000000000e+00 1.5619999999999999e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -377 1 1 0.0000000000000000e+00 1.7039999999999999e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -378 1 1 0.0000000000000000e+00 1.7750000000000000e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -379 1 1 0.0000000000000000e+00 1.9169999999999998e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -380 1 1 0.0000000000000000e+00 1.9879999999999999e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -411 1 1 0.0000000000000000e+00 1.0649999999999999e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -412 1 1 0.0000000000000000e+00 1.1359999999999999e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -413 1 1 0.0000000000000000e+00 1.2779999999999999e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -414 1 1 0.0000000000000000e+00 1.3489999999999998e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -415 1 1 0.0000000000000000e+00 1.4910000000000000e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -416 1 1 0.0000000000000000e+00 1.5619999999999999e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -417 1 1 0.0000000000000000e+00 1.7039999999999999e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -418 1 1 0.0000000000000000e+00 1.7750000000000000e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -419 1 1 0.0000000000000000e+00 1.9169999999999998e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -420 1 1 0.0000000000000000e+00 1.9879999999999999e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -451 1 1 0.0000000000000000e+00 1.0649999999999999e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -452 1 1 0.0000000000000000e+00 1.1359999999999999e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -453 1 1 0.0000000000000000e+00 1.2779999999999999e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -454 1 1 0.0000000000000000e+00 1.3489999999999998e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -455 1 1 0.0000000000000000e+00 1.4910000000000000e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -456 1 1 0.0000000000000000e+00 1.5619999999999999e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -457 1 1 0.0000000000000000e+00 1.7039999999999999e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -458 1 1 0.0000000000000000e+00 1.7750000000000000e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -459 1 1 0.0000000000000000e+00 1.9169999999999998e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -460 1 1 0.0000000000000000e+00 1.9879999999999999e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -491 1 1 0.0000000000000000e+00 1.0649999999999999e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -492 1 1 0.0000000000000000e+00 1.1359999999999999e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -493 1 1 0.0000000000000000e+00 1.2779999999999999e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -494 1 1 0.0000000000000000e+00 1.3489999999999998e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -495 1 1 0.0000000000000000e+00 1.4910000000000000e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -496 1 1 0.0000000000000000e+00 1.5619999999999999e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -497 1 1 0.0000000000000000e+00 1.7039999999999999e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -498 1 1 0.0000000000000000e+00 1.7750000000000000e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -499 1 1 0.0000000000000000e+00 1.9169999999999998e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -500 1 1 0.0000000000000000e+00 1.9879999999999999e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -1332 2 2 0.0000000000000000e+00 1.2808040109676485e+01 4.0559075384695490e+01 3.3430659147513437e+00 0 0 0 -1013 2 2 0.0000000000000000e+00 1.4218361797260489e+01 2.0913522510818783e+01 3.4024945316268549e+00 0 0 0 -1016 2 2 0.0000000000000000e+00 1.7009092398363297e+01 2.0934000480097669e+01 3.4249520391650905e+00 0 0 0 -1017 2 2 0.0000000000000000e+00 1.8447476890214691e+01 2.0934190272577418e+01 3.4151791830943412e+00 0 0 0 -1050 2 2 0.0000000000000000e+00 1.0645938297059661e+01 2.2114669784025672e+01 3.3548458685108349e+00 0 0 0 -1051 2 2 0.0000000000000000e+00 1.2074757357015869e+01 2.2123411539908108e+01 3.2915620593103876e+00 0 0 0 -1052 2 2 0.0000000000000000e+00 1.2752427492179706e+01 2.3367595438655808e+01 3.4335685334226418e+00 0 0 0 -1053 2 2 0.0000000000000000e+00 1.4208104383952691e+01 2.3388651439650527e+01 3.4675795406418399e+00 0 0 0 -1054 2 2 0.0000000000000000e+00 1.4873911022597305e+01 2.2164144770260418e+01 3.3989399491426777e+00 0 0 0 -1055 2 2 0.0000000000000000e+00 1.6289561409230259e+01 2.2177226649566808e+01 3.3937086707283064e+00 0 0 0 -1056 2 2 0.0000000000000000e+00 1.7022925122077293e+01 2.3406339077938092e+01 3.4471895786422215e+00 0 0 0 -1057 2 2 0.0000000000000000e+00 1.8446625833603793e+01 2.3386381042057568e+01 3.4637078993075252e+00 0 0 0 -1058 2 2 0.0000000000000000e+00 1.9184871531059674e+01 2.2157696610338068e+01 3.4411998542136786e+00 0 0 0 -1059 2 2 0.0000000000000000e+00 2.0593970958544503e+01 2.2199375120910503e+01 3.4577963475657705e+00 0 0 0 -1090 2 2 0.0000000000000000e+00 1.0631654022188506e+01 2.4608570260515084e+01 3.4140062366318511e+00 0 0 0 -1091 2 2 0.0000000000000000e+00 1.2061940485010808e+01 2.4609109908303783e+01 3.4338190996899947e+00 0 0 0 -1092 2 2 0.0000000000000000e+00 1.2743683713953823e+01 2.5853329244639134e+01 3.4877564488660271e+00 0 0 0 -1093 2 2 0.0000000000000000e+00 1.4187699109078382e+01 2.5857288955112491e+01 3.4555525180075697e+00 0 0 0 -1094 2 2 0.0000000000000000e+00 1.4925671702631240e+01 2.4632104110190991e+01 3.5218492076485073e+00 0 0 0 -1095 2 2 0.0000000000000000e+00 1.6319667234252424e+01 2.4605443788845761e+01 3.5705401380492257e+00 0 0 0 -1096 2 2 0.0000000000000000e+00 1.7069645050729132e+01 2.5822404413138521e+01 3.6254154798625562e+00 0 0 0 -1097 2 2 0.0000000000000000e+00 1.8503517708749921e+01 2.5817240835544869e+01 3.6038938066962594e+00 0 0 0 -1098 2 2 0.0000000000000000e+00 1.9197502882812827e+01 2.4556975365535187e+01 3.5439119871023732e+00 0 0 0 -1099 2 2 0.0000000000000000e+00 2.0618364895566412e+01 2.4617523976653214e+01 3.5376634974207137e+00 0 0 0 -1130 2 2 0.0000000000000000e+00 1.0602570522909321e+01 2.7037482875152126e+01 3.4664373266834154e+00 0 0 0 -1131 2 2 0.0000000000000000e+00 1.2025206922001814e+01 2.7062796223552855e+01 3.5484796338648970e+00 0 0 0 -1132 2 2 0.0000000000000000e+00 1.2738448628826367e+01 2.8271451828944436e+01 3.5088952301790934e+00 0 0 0 -1133 2 2 0.0000000000000000e+00 1.4165858629508776e+01 2.8286196794671998e+01 3.5254954452765079e+00 0 0 0 -1134 2 2 0.0000000000000000e+00 1.4881437222780846e+01 2.7056816179318801e+01 3.5544124092749061e+00 0 0 0 -1135 2 2 0.0000000000000000e+00 1.6330220695176124e+01 2.7042528230881643e+01 3.4974683547783969e+00 0 0 0 -1136 2 2 0.0000000000000000e+00 1.6992416195748522e+01 2.8284742054689310e+01 3.5060040255093572e+00 0 0 0 -1137 2 2 0.0000000000000000e+00 1.8416017518245400e+01 2.8241009941955866e+01 3.4955889212124056e+00 0 0 0 -1138 2 2 0.0000000000000000e+00 1.9186641878510464e+01 2.7057529684265287e+01 3.5392735344521440e+00 0 0 0 -1139 2 2 0.0000000000000000e+00 2.0581624767295501e+01 2.7056718194252838e+01 3.4327091672481442e+00 0 0 0 -1170 2 2 0.0000000000000000e+00 1.0627894823322695e+01 2.9510323624575136e+01 3.4905752662406311e+00 0 0 0 -1171 2 2 0.0000000000000000e+00 1.2031341919296660e+01 2.9525703111816128e+01 3.5033259773506491e+00 0 0 0 -1172 2 2 0.0000000000000000e+00 1.2778294818619804e+01 3.0738780030940347e+01 3.5536883580264274e+00 0 0 0 -1173 2 2 0.0000000000000000e+00 1.4212906820810890e+01 3.0727007226470874e+01 3.4940205276161103e+00 0 0 0 -1174 2 2 0.0000000000000000e+00 1.4921058940096996e+01 2.9484934345115871e+01 3.6273983265075196e+00 0 0 0 -1175 2 2 0.0000000000000000e+00 1.6325345990957562e+01 2.9495896390850582e+01 3.5659204189407143e+00 0 0 0 -1176 2 2 0.0000000000000000e+00 1.7044235999585112e+01 3.0747360578611612e+01 3.5272302763963221e+00 0 0 0 -1177 2 2 0.0000000000000000e+00 1.8471178081119763e+01 3.0726408907415621e+01 3.5989130270960112e+00 0 0 0 -1178 2 2 0.0000000000000000e+00 1.9135238375890399e+01 2.9477413197557990e+01 3.5565544706272045e+00 0 0 0 -1179 2 2 0.0000000000000000e+00 2.0536815445031731e+01 2.9496734045325336e+01 3.4581954463835709e+00 0 0 0 -521 1 1 0.0000000000000000e+00 0.0000000000000000e+00 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -522 1 1 0.0000000000000000e+00 7.0999999999999996e-01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -523 1 1 0.0000000000000000e+00 2.1299999999999999e+00 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -524 1 1 0.0000000000000000e+00 2.8399999999999999e+00 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -525 1 1 0.0000000000000000e+00 4.2599999999999998e+00 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -526 1 1 0.0000000000000000e+00 4.9699999999999998e+00 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -527 1 1 0.0000000000000000e+00 6.3899999999999997e+00 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -528 1 1 0.0000000000000000e+00 7.0999999999999996e+00 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -529 1 1 0.0000000000000000e+00 8.5199999999999996e+00 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -530 1 1 0.0000000000000000e+00 9.2300000000000004e+00 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -561 1 1 0.0000000000000000e+00 0.0000000000000000e+00 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -562 1 1 0.0000000000000000e+00 7.0999999999999996e-01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -563 1 1 0.0000000000000000e+00 2.1299999999999999e+00 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -564 1 1 0.0000000000000000e+00 2.8399999999999999e+00 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -565 1 1 0.0000000000000000e+00 4.2599999999999998e+00 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -566 1 1 0.0000000000000000e+00 4.9699999999999998e+00 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -567 1 1 0.0000000000000000e+00 6.3899999999999997e+00 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -568 1 1 0.0000000000000000e+00 7.0999999999999996e+00 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -569 1 1 0.0000000000000000e+00 8.5199999999999996e+00 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -570 1 1 0.0000000000000000e+00 9.2300000000000004e+00 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -601 1 1 0.0000000000000000e+00 0.0000000000000000e+00 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -602 1 1 0.0000000000000000e+00 7.0999999999999996e-01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -603 1 1 0.0000000000000000e+00 2.1299999999999999e+00 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -604 1 1 0.0000000000000000e+00 2.8399999999999999e+00 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -605 1 1 0.0000000000000000e+00 4.2599999999999998e+00 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -606 1 1 0.0000000000000000e+00 4.9699999999999998e+00 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -607 1 1 0.0000000000000000e+00 6.3899999999999997e+00 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -608 1 1 0.0000000000000000e+00 7.0999999999999996e+00 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -609 1 1 0.0000000000000000e+00 8.5199999999999996e+00 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -610 1 1 0.0000000000000000e+00 9.2300000000000004e+00 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -641 1 1 0.0000000000000000e+00 0.0000000000000000e+00 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -642 1 1 0.0000000000000000e+00 7.0999999999999996e-01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -643 1 1 0.0000000000000000e+00 2.1299999999999999e+00 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -644 1 1 0.0000000000000000e+00 2.8399999999999999e+00 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -645 1 1 0.0000000000000000e+00 4.2599999999999998e+00 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -646 1 1 0.0000000000000000e+00 4.9699999999999998e+00 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -647 1 1 0.0000000000000000e+00 6.3899999999999997e+00 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -648 1 1 0.0000000000000000e+00 7.0999999999999996e+00 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -649 1 1 0.0000000000000000e+00 8.5199999999999996e+00 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -650 1 1 0.0000000000000000e+00 9.2300000000000004e+00 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -1201 2 2 0.0000000000000000e+00 1.3949894431810268e+00 3.3162101043536303e+01 3.5347793230388200e+00 0 0 0 -1202 2 2 0.0000000000000000e+00 2.0711587590994358e+00 3.1940945107725103e+01 3.6194971848094375e+00 0 0 0 -1203 2 2 0.0000000000000000e+00 3.5244936746730717e+00 3.1927631995321057e+01 3.5492764044219767e+00 0 0 0 -1204 2 2 0.0000000000000000e+00 4.2389794902689832e+00 3.3152635851554102e+01 3.5192025255370054e+00 0 0 0 -1205 2 2 0.0000000000000000e+00 5.6331694639944789e+00 3.3156995316710670e+01 3.4869287491504988e+00 0 0 0 -1206 2 2 0.0000000000000000e+00 6.3511932464514977e+00 3.1950065126472204e+01 3.3492881730753123e+00 0 0 0 -1207 2 2 0.0000000000000000e+00 7.7947430669698381e+00 3.1933136475564972e+01 3.3993078130946084e+00 0 0 0 -1208 2 2 0.0000000000000000e+00 8.5221558920617646e+00 3.3162541978507676e+01 3.4733097232507419e+00 0 0 0 -1209 2 2 0.0000000000000000e+00 9.9430244570211865e+00 3.3217273054724345e+01 3.5052158804254039e+00 0 0 0 -1335 2 2 0.0000000000000000e+00 1.6338749485646613e+01 3.9344155693943343e+01 3.3638811136850655e+00 0 0 0 -1241 2 2 0.0000000000000000e+00 1.4145783845915840e+00 3.5606971137820260e+01 3.4031965663090888e+00 0 0 0 -1242 2 2 0.0000000000000000e+00 2.1318657514314636e+00 3.4367659935217873e+01 3.3961400908880499e+00 0 0 0 -1243 2 2 0.0000000000000000e+00 3.5523598117004416e+00 3.4390220992623490e+01 3.3755304006888447e+00 0 0 0 -1244 2 2 0.0000000000000000e+00 4.2446038643294637e+00 3.5644267015048356e+01 3.4329512959170634e+00 0 0 0 -1245 2 2 0.0000000000000000e+00 5.6526265793045116e+00 3.5627054591825512e+01 3.4504223915959642e+00 0 0 0 -1246 2 2 0.0000000000000000e+00 6.3867893649091600e+00 3.4397989442084075e+01 3.5256963847472877e+00 0 0 0 -1247 2 2 0.0000000000000000e+00 7.8116237749634596e+00 3.4459780578942336e+01 3.4786543394850780e+00 0 0 0 -1248 2 2 0.0000000000000000e+00 8.5304800110672083e+00 3.5665759112701771e+01 3.4867766741035702e+00 0 0 0 -1249 2 2 0.0000000000000000e+00 9.9382753292189996e+00 3.5670511843731049e+01 3.4398999258718486e+00 0 0 0 -1334 2 2 0.0000000000000000e+00 1.4920528118634161e+01 3.9314213384263063e+01 3.3990381887338823e+00 0 0 0 -1281 2 2 0.0000000000000000e+00 1.3856631115099827e+00 3.8074115731046511e+01 3.4104809652107546e+00 0 0 0 -1282 2 2 0.0000000000000000e+00 2.1401937795125656e+00 3.6829563337161687e+01 3.3879328365312977e+00 0 0 0 -1283 2 2 0.0000000000000000e+00 3.5338225473495344e+00 3.6857120746448800e+01 3.4760412039472639e+00 0 0 0 -1284 2 2 0.0000000000000000e+00 4.2514524563613358e+00 3.8062992631845034e+01 3.4002408002942595e+00 0 0 0 -1285 2 2 0.0000000000000000e+00 5.6981585477939403e+00 3.8089079544365958e+01 3.4620698705156392e+00 0 0 0 -1286 2 2 0.0000000000000000e+00 6.3653409519056572e+00 3.6864735843242386e+01 3.4195841228557815e+00 0 0 0 -1287 2 2 0.0000000000000000e+00 7.8160757396043916e+00 3.6877457613580482e+01 3.3904569225965520e+00 0 0 0 -1288 2 2 0.0000000000000000e+00 8.5327282129976929e+00 3.8112091504929403e+01 3.4076481554797069e+00 0 0 0 -1289 2 2 0.0000000000000000e+00 9.9519006000900898e+00 3.8146276173811081e+01 3.3346327890100325e+00 0 0 0 -1333 2 2 0.0000000000000000e+00 1.4226353901477488e+01 4.0526975837036076e+01 3.2724771318922730e+00 0 0 0 -1321 2 2 0.0000000000000000e+00 1.4182504486281522e+00 4.0530767811428682e+01 3.4946750081631017e+00 0 0 0 -1322 2 2 0.0000000000000000e+00 2.1256308167675759e+00 3.9305919958663722e+01 3.5055451800768322e+00 0 0 0 -1323 2 2 0.0000000000000000e+00 3.5425022591956301e+00 3.9298016886958457e+01 3.4962468459117737e+00 0 0 0 -1324 2 2 0.0000000000000000e+00 4.2899333247763138e+00 4.0538828445633904e+01 3.5961562303798758e+00 0 0 0 -1325 2 2 0.0000000000000000e+00 5.6978931841683158e+00 4.0526667949638515e+01 3.4466273366370035e+00 0 0 0 -1326 2 2 0.0000000000000000e+00 6.4025580557976474e+00 3.9314630219298657e+01 3.3936940668875755e+00 0 0 0 -1327 2 2 0.0000000000000000e+00 7.8277389189594215e+00 3.9324855702930556e+01 3.4354311391621448e+00 0 0 0 -1328 2 2 0.0000000000000000e+00 8.5423666234919473e+00 4.0554311564806248e+01 3.3237088784631617e+00 0 0 0 -1329 2 2 0.0000000000000000e+00 9.9608738729325559e+00 4.0573963200078417e+01 3.3292206457177365e+00 0 0 0 -1360 2 2 0.0000000000000000e+00 2.2580587274387769e-02 4.0545528876313547e+01 3.3995858229480893e+00 1 0 0 -531 1 1 0.0000000000000000e+00 1.0649999999999999e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -532 1 1 0.0000000000000000e+00 1.1359999999999999e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -533 1 1 0.0000000000000000e+00 1.2779999999999999e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -534 1 1 0.0000000000000000e+00 1.3489999999999998e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -535 1 1 0.0000000000000000e+00 1.4910000000000000e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -536 1 1 0.0000000000000000e+00 1.5619999999999999e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -537 1 1 0.0000000000000000e+00 1.7039999999999999e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -538 1 1 0.0000000000000000e+00 1.7750000000000000e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -539 1 1 0.0000000000000000e+00 1.9169999999999998e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -540 1 1 0.0000000000000000e+00 1.9879999999999999e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -571 1 1 0.0000000000000000e+00 1.0649999999999999e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -572 1 1 0.0000000000000000e+00 1.1359999999999999e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -573 1 1 0.0000000000000000e+00 1.2779999999999999e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -574 1 1 0.0000000000000000e+00 1.3489999999999998e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -575 1 1 0.0000000000000000e+00 1.4910000000000000e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -576 1 1 0.0000000000000000e+00 1.5619999999999999e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -577 1 1 0.0000000000000000e+00 1.7039999999999999e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -578 1 1 0.0000000000000000e+00 1.7750000000000000e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -579 1 1 0.0000000000000000e+00 1.9169999999999998e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -580 1 1 0.0000000000000000e+00 1.9879999999999999e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -611 1 1 0.0000000000000000e+00 1.0649999999999999e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -612 1 1 0.0000000000000000e+00 1.1359999999999999e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -613 1 1 0.0000000000000000e+00 1.2779999999999999e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -614 1 1 0.0000000000000000e+00 1.3489999999999998e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -615 1 1 0.0000000000000000e+00 1.4910000000000000e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -616 1 1 0.0000000000000000e+00 1.5619999999999999e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -617 1 1 0.0000000000000000e+00 1.7039999999999999e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -618 1 1 0.0000000000000000e+00 1.7750000000000000e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -619 1 1 0.0000000000000000e+00 1.9169999999999998e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -620 1 1 0.0000000000000000e+00 1.9879999999999999e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -651 1 1 0.0000000000000000e+00 1.0649999999999999e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -652 1 1 0.0000000000000000e+00 1.1359999999999999e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -653 1 1 0.0000000000000000e+00 1.2779999999999999e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -654 1 1 0.0000000000000000e+00 1.3489999999999998e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -655 1 1 0.0000000000000000e+00 1.4910000000000000e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -656 1 1 0.0000000000000000e+00 1.5619999999999999e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -657 1 1 0.0000000000000000e+00 1.7039999999999999e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -658 1 1 0.0000000000000000e+00 1.7750000000000000e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -659 1 1 0.0000000000000000e+00 1.9169999999999998e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -660 1 1 0.0000000000000000e+00 1.9879999999999999e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -1210 2 2 0.0000000000000000e+00 1.0623279923460000e+01 3.1966683488301395e+01 3.4901980536513006e+00 0 0 0 -1211 2 2 0.0000000000000000e+00 1.2057538483856446e+01 3.1973607772496276e+01 3.5402064362623897e+00 0 0 0 -1212 2 2 0.0000000000000000e+00 1.2741262270195799e+01 3.3209853511256213e+01 3.4828337705608639e+00 0 0 0 -1213 2 2 0.0000000000000000e+00 1.4156427215896759e+01 3.3173636780542942e+01 3.5873309968220215e+00 0 0 0 -1214 2 2 0.0000000000000000e+00 1.4912092482968982e+01 3.1987184881263122e+01 3.5184954952897050e+00 0 0 0 -1215 2 2 0.0000000000000000e+00 1.6310480204748465e+01 3.1985035572334876e+01 3.4680173128192835e+00 0 0 0 -1216 2 2 0.0000000000000000e+00 1.7043245278656013e+01 3.3197007604898182e+01 3.4794673885970084e+00 0 0 0 -1217 2 2 0.0000000000000000e+00 1.8446509663534705e+01 3.3209352262319022e+01 3.5732382484276508e+00 0 0 0 -1218 2 2 0.0000000000000000e+00 1.9158074886031887e+01 3.1962115094240026e+01 3.5293481723074498e+00 0 0 0 -1219 2 2 0.0000000000000000e+00 2.0563963178961860e+01 3.1943640252519774e+01 3.5136460956176987e+00 0 0 0 -1250 2 2 0.0000000000000000e+00 1.0653210729211464e+01 3.4439828372111940e+01 3.5111422188841162e+00 0 0 0 -1251 2 2 0.0000000000000000e+00 1.2027796517255862e+01 3.4416866155902056e+01 3.4810223548060137e+00 0 0 0 -1252 2 2 0.0000000000000000e+00 1.2745236026785406e+01 3.5664952092564242e+01 3.4292405249163838e+00 0 0 0 -1253 2 2 0.0000000000000000e+00 1.4168433803716209e+01 3.5633337428700365e+01 3.4679555170230678e+00 0 0 0 -1254 2 2 0.0000000000000000e+00 1.4881060147219854e+01 3.4412442505279216e+01 3.5300698734391776e+00 0 0 0 -1255 2 2 0.0000000000000000e+00 1.6302953404581320e+01 3.4422627858257954e+01 3.5160022301305589e+00 0 0 0 -1256 2 2 0.0000000000000000e+00 1.7016587543535874e+01 3.5621303699166994e+01 3.2966009728715457e+00 0 0 0 -1257 2 2 0.0000000000000000e+00 1.8425103859483048e+01 3.5644189694299662e+01 3.3790892960397887e+00 0 0 0 -1258 2 2 0.0000000000000000e+00 1.9144854394314716e+01 3.4411739132347080e+01 3.6230614236931014e+00 0 0 0 -1259 2 2 0.0000000000000000e+00 2.0563636796370737e+01 3.4432297037435461e+01 3.5519261997978355e+00 0 0 0 -1290 2 2 0.0000000000000000e+00 1.0640932588694060e+01 3.6892589985334659e+01 3.3748885622214293e+00 0 0 0 -1291 2 2 0.0000000000000000e+00 1.2037392947222694e+01 3.6892388512725695e+01 3.3910596995989626e+00 0 0 0 -1292 2 2 0.0000000000000000e+00 1.2776025378640918e+01 3.8104067345618539e+01 3.2415962788395243e+00 0 0 0 -1293 2 2 0.0000000000000000e+00 1.4185353108812251e+01 3.8082961008668136e+01 3.3852188104069683e+00 0 0 0 -1294 2 2 0.0000000000000000e+00 1.4910999804533393e+01 3.6856623363816965e+01 3.3949457302183332e+00 0 0 0 -1295 2 2 0.0000000000000000e+00 1.6323502663099053e+01 3.6867813549827950e+01 3.3792220817405618e+00 0 0 0 -1296 2 2 0.0000000000000000e+00 1.7053741118820746e+01 3.8093044709705261e+01 3.3359702792921095e+00 0 0 0 -1297 2 2 0.0000000000000000e+00 1.8469466275800535e+01 3.8111581986443269e+01 3.3102901770876869e+00 0 0 0 -1298 2 2 0.0000000000000000e+00 1.9161138067610356e+01 3.6876131663083562e+01 3.3495977811607829e+00 0 0 0 -1299 2 2 0.0000000000000000e+00 2.0595809716577296e+01 3.6895310056287862e+01 3.4280877879670864e+00 0 0 0 -1330 2 2 0.0000000000000000e+00 1.0660014396129187e+01 3.9355588722655618e+01 3.3123212219033720e+00 0 0 0 -1331 2 2 0.0000000000000000e+00 1.2069114297287237e+01 3.9351243554597993e+01 3.2913957087677033e+00 0 0 0 -682 2 2 0.0000000000000000e+00 2.1664937295106519e+00 4.1798785661516384e+01 3.6248109780436883e+00 0 -1 0 -683 2 2 0.0000000000000000e+00 3.5807760352234146e+00 4.1738112011846063e+01 3.6236485346371121e+00 0 -1 0 -686 2 2 0.0000000000000000e+00 6.4126796504083625e+00 4.1748900103183928e+01 3.4779366475729652e+00 0 -1 0 -687 2 2 0.0000000000000000e+00 7.8374124881143858e+00 4.1763886675353469e+01 3.4115110104207975e+00 0 -1 0 -690 2 2 0.0000000000000000e+00 1.0670447552994155e+01 4.1777065075275338e+01 3.5186220048562498e+00 0 -1 0 -691 2 2 0.0000000000000000e+00 1.2090196475131766e+01 4.1782206153223143e+01 3.4286764519929402e+00 0 -1 0 -694 2 2 0.0000000000000000e+00 1.4942482447588546e+01 4.1773651646778845e+01 3.3615200661092057e+00 0 -1 0 -695 2 2 0.0000000000000000e+00 1.6388579688720434e+01 4.1778840867794791e+01 3.4648969761507895e+00 0 -1 0 -698 2 2 0.0000000000000000e+00 1.9199156670987669e+01 4.1769128340505489e+01 3.5552071701970109e+00 0 -1 0 -699 2 2 0.0000000000000000e+00 2.0607044113338837e+01 4.1754026983475569e+01 3.5754979322711393e+00 0 -1 0 -21 1 1 0.0000000000000000e+00 2.1299999999999997e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -22 1 1 0.0000000000000000e+00 2.2009999999999998e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -23 1 1 0.0000000000000000e+00 2.3429999999999996e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -24 1 1 0.0000000000000000e+00 2.4139999999999997e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -25 1 1 0.0000000000000000e+00 2.5559999999999999e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -26 1 1 0.0000000000000000e+00 2.6270000000000000e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -27 1 1 0.0000000000000000e+00 2.7689999999999998e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -28 1 1 0.0000000000000000e+00 2.8399999999999999e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -29 1 1 0.0000000000000000e+00 2.9820000000000000e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -30 1 1 0.0000000000000000e+00 3.0530000000000001e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -61 1 1 0.0000000000000000e+00 2.1299999999999997e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -62 1 1 0.0000000000000000e+00 2.2009999999999998e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -63 1 1 0.0000000000000000e+00 2.3429999999999996e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -64 1 1 0.0000000000000000e+00 2.4139999999999997e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -65 1 1 0.0000000000000000e+00 2.5559999999999999e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -66 1 1 0.0000000000000000e+00 2.6270000000000000e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -67 1 1 0.0000000000000000e+00 2.7689999999999998e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -68 1 1 0.0000000000000000e+00 2.8399999999999999e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -69 1 1 0.0000000000000000e+00 2.9820000000000000e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -70 1 1 0.0000000000000000e+00 3.0530000000000001e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -101 1 1 0.0000000000000000e+00 2.1299999999999997e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -102 1 1 0.0000000000000000e+00 2.2009999999999998e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -103 1 1 0.0000000000000000e+00 2.3429999999999996e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -104 1 1 0.0000000000000000e+00 2.4139999999999997e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -105 1 1 0.0000000000000000e+00 2.5559999999999999e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -106 1 1 0.0000000000000000e+00 2.6270000000000000e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -107 1 1 0.0000000000000000e+00 2.7689999999999998e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -108 1 1 0.0000000000000000e+00 2.8399999999999999e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -109 1 1 0.0000000000000000e+00 2.9820000000000000e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -110 1 1 0.0000000000000000e+00 3.0530000000000001e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -141 1 1 0.0000000000000000e+00 2.1299999999999997e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -142 1 1 0.0000000000000000e+00 2.2009999999999998e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -143 1 1 0.0000000000000000e+00 2.3429999999999996e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -144 1 1 0.0000000000000000e+00 2.4139999999999997e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -145 1 1 0.0000000000000000e+00 2.5559999999999999e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -146 1 1 0.0000000000000000e+00 2.6270000000000000e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -147 1 1 0.0000000000000000e+00 2.7689999999999998e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -148 1 1 0.0000000000000000e+00 2.8399999999999999e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -149 1 1 0.0000000000000000e+00 2.9820000000000000e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -150 1 1 0.0000000000000000e+00 3.0530000000000001e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -182 1 1 0.0000000000000000e+00 2.2009999999999998e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -183 1 1 0.0000000000000000e+00 2.3429999999999996e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -186 1 1 0.0000000000000000e+00 2.6270000000000000e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -187 1 1 0.0000000000000000e+00 2.7689999999999998e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -190 1 1 0.0000000000000000e+00 3.0530000000000001e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -700 2 2 0.0000000000000000e+00 2.1334301960850492e+01 1.1651381930475284e+00 3.4840446952319106e+00 0 0 0 -701 2 2 0.0000000000000000e+00 2.2744465376493217e+01 1.2107438273007436e+00 3.4816996478444704e+00 0 0 0 -1000 2 2 0.0000000000000000e+00 4.2571666813096414e+01 1.8417883314000015e+01 3.6894100284195446e+00 0 0 0 -880 2 2 0.0000000000000000e+00 4.2599992636422478e+01 1.1043310699134517e+01 3.4960838193979997e+00 0 0 0 -704 2 2 0.0000000000000000e+00 2.5554831261693653e+01 1.2307510087228970e+00 3.5102538236327088e+00 0 0 0 -705 2 2 0.0000000000000000e+00 2.6964547626354097e+01 1.2536843286608332e+00 3.6246776093539288e+00 0 0 0 -706 2 2 0.0000000000000000e+00 2.7675521860178570e+01 3.0679110631658100e-02 3.5898604958873723e+00 0 0 0 -840 2 2 0.0000000000000000e+00 4.2575754591987781e+01 8.5609686501356350e+00 3.4426188801139750e+00 0 0 0 -708 2 2 0.0000000000000000e+00 2.9834714816268175e+01 1.2191238633937307e+00 3.6329472191036616e+00 0 0 0 -709 2 2 0.0000000000000000e+00 3.1233596861916254e+01 1.2093945929124188e+00 3.4860107877322588e+00 0 0 0 -740 2 2 0.0000000000000000e+00 2.1318299118516212e+01 3.6714745858791065e+00 3.4619559578909302e+00 0 0 0 -741 2 2 0.0000000000000000e+00 2.2737245917407385e+01 3.6750113676605891e+00 3.4675456612836375e+00 0 0 0 -742 2 2 0.0000000000000000e+00 2.3446697045313556e+01 2.4406509644089995e+00 3.5825923522281862e+00 0 0 0 -743 2 2 0.0000000000000000e+00 2.4849524551984985e+01 2.4425758729500737e+00 3.4514515708936564e+00 0 0 0 -744 2 2 0.0000000000000000e+00 2.5577987797496984e+01 3.6848457108532049e+00 3.4876012523019950e+00 0 0 0 -745 2 2 0.0000000000000000e+00 2.6976086843552309e+01 3.6859261871142830e+00 3.4958618577999450e+00 0 0 0 -746 2 2 0.0000000000000000e+00 2.7718001763177739e+01 2.4714076730041916e+00 3.5920815613848696e+00 0 0 0 -747 2 2 0.0000000000000000e+00 2.9151143906029265e+01 2.4595321699553554e+00 3.5828934152737717e+00 0 0 0 -748 2 2 0.0000000000000000e+00 2.9801487556892113e+01 3.6889287826222139e+00 3.4918973450903978e+00 0 0 0 -749 2 2 0.0000000000000000e+00 3.1207417026403665e+01 3.7012378674086803e+00 3.4119114481333130e+00 0 0 0 -780 2 2 0.0000000000000000e+00 2.1342802485659664e+01 6.1255311155791343e+00 3.5444831043256388e+00 0 0 0 -781 2 2 0.0000000000000000e+00 2.2730418932936857e+01 6.0858193205295379e+00 3.4417476075032871e+00 0 0 0 -782 2 2 0.0000000000000000e+00 2.3427559854501798e+01 4.9077840849868872e+00 3.3345727975160329e+00 0 0 0 -783 2 2 0.0000000000000000e+00 2.4876873904914373e+01 4.9165769163759832e+00 3.3671808830650365e+00 0 0 0 -784 2 2 0.0000000000000000e+00 2.5546569896796839e+01 6.1368506872683284e+00 3.4065045385602182e+00 0 0 0 -785 2 2 0.0000000000000000e+00 2.6981670198673623e+01 6.1128430085320122e+00 3.4576872393277407e+00 0 0 0 -786 2 2 0.0000000000000000e+00 2.7703437441528902e+01 4.9034811000372773e+00 3.4965785583410902e+00 0 0 0 -787 2 2 0.0000000000000000e+00 2.9116128154294881e+01 4.9113054796492408e+00 3.4677457151036921e+00 0 0 0 -788 2 2 0.0000000000000000e+00 2.9783032528804060e+01 6.1502027853227315e+00 3.4467643916654844e+00 0 0 0 -789 2 2 0.0000000000000000e+00 3.1184472706796285e+01 6.1311380213039914e+00 3.5210321045141515e+00 0 0 0 -820 2 2 0.0000000000000000e+00 2.1313692874384980e+01 8.5800924284011799e+00 3.5549472063647487e+00 0 0 0 -821 2 2 0.0000000000000000e+00 2.2744278841033932e+01 8.5944821480483355e+00 3.5350993689358976e+00 0 0 0 -822 2 2 0.0000000000000000e+00 2.3470659678242747e+01 7.3649242935906667e+00 3.4225245038131811e+00 0 0 0 -823 2 2 0.0000000000000000e+00 2.4864786545102046e+01 7.3682502493361026e+00 3.3730639156788036e+00 0 0 0 -824 2 2 0.0000000000000000e+00 2.5581102273155153e+01 8.5977728461565768e+00 3.3896901652760847e+00 0 0 0 -825 2 2 0.0000000000000000e+00 2.7005292794421447e+01 8.6265302428183297e+00 3.4390322600769583e+00 0 0 0 -826 2 2 0.0000000000000000e+00 2.7665392656919050e+01 7.3626157122768872e+00 3.5060730478003306e+00 0 0 0 -827 2 2 0.0000000000000000e+00 2.9084452582747748e+01 7.3758115072854284e+00 3.4257634037985381e+00 0 0 0 -828 2 2 0.0000000000000000e+00 2.9809009416875885e+01 8.5979458237890700e+00 3.4970952363992720e+00 0 0 0 -829 2 2 0.0000000000000000e+00 3.1282731655031107e+01 8.5948865148159559e+00 3.5038071586225730e+00 0 0 0 -862 2 2 0.0000000000000000e+00 2.3475174840209917e+01 9.8135158215028913e+00 3.5675472065136185e+00 0 0 0 -863 2 2 0.0000000000000000e+00 2.4886667122486735e+01 9.8522219040822012e+00 3.4778927387325940e+00 0 0 0 -866 2 2 0.0000000000000000e+00 2.7722970687333849e+01 9.8694072637400012e+00 3.3399930060315937e+00 0 0 0 -867 2 2 0.0000000000000000e+00 2.9141152589937143e+01 9.8466133020056343e+00 3.4244753388249678e+00 0 0 0 -31 1 1 0.0000000000000000e+00 3.1949999999999999e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -32 1 1 0.0000000000000000e+00 3.2659999999999997e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -33 1 1 0.0000000000000000e+00 3.4079999999999998e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -34 1 1 0.0000000000000000e+00 3.4789999999999999e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -35 1 1 0.0000000000000000e+00 3.6210000000000001e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -36 1 1 0.0000000000000000e+00 3.6920000000000002e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -37 1 1 0.0000000000000000e+00 3.8339999999999996e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -38 1 1 0.0000000000000000e+00 3.9049999999999997e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -39 1 1 0.0000000000000000e+00 4.0469999999999999e+01 0.0000000000000000e+00 0.0000000000000000e+00 0 0 0 -40 1 1 0.0000000000000000e+00 4.1179999999999993e+01 1.2297560733739030e+00 0.0000000000000000e+00 0 0 0 -71 1 1 0.0000000000000000e+00 3.1949999999999999e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -72 1 1 0.0000000000000000e+00 3.2659999999999997e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -73 1 1 0.0000000000000000e+00 3.4079999999999998e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -74 1 1 0.0000000000000000e+00 3.4789999999999999e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -75 1 1 0.0000000000000000e+00 3.6210000000000001e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -76 1 1 0.0000000000000000e+00 3.6920000000000002e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -77 1 1 0.0000000000000000e+00 3.8339999999999996e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -78 1 1 0.0000000000000000e+00 3.9049999999999997e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -79 1 1 0.0000000000000000e+00 4.0469999999999999e+01 2.4595121467478060e+00 0.0000000000000000e+00 0 0 0 -80 1 1 0.0000000000000000e+00 4.1179999999999993e+01 3.6892682201217091e+00 0.0000000000000000e+00 0 0 0 -111 1 1 0.0000000000000000e+00 3.1949999999999999e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -112 1 1 0.0000000000000000e+00 3.2659999999999997e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -113 1 1 0.0000000000000000e+00 3.4079999999999998e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -114 1 1 0.0000000000000000e+00 3.4789999999999999e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -115 1 1 0.0000000000000000e+00 3.6210000000000001e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -116 1 1 0.0000000000000000e+00 3.6920000000000002e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -117 1 1 0.0000000000000000e+00 3.8339999999999996e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -118 1 1 0.0000000000000000e+00 3.9049999999999997e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -119 1 1 0.0000000000000000e+00 4.0469999999999999e+01 4.9190242934956112e+00 0.0000000000000000e+00 0 0 0 -120 1 1 0.0000000000000000e+00 4.1179999999999993e+01 6.1487803668695138e+00 0.0000000000000000e+00 0 0 0 -151 1 1 0.0000000000000000e+00 3.1949999999999999e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -152 1 1 0.0000000000000000e+00 3.2659999999999997e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -153 1 1 0.0000000000000000e+00 3.4079999999999998e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -154 1 1 0.0000000000000000e+00 3.4789999999999999e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -155 1 1 0.0000000000000000e+00 3.6210000000000001e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -156 1 1 0.0000000000000000e+00 3.6920000000000002e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -157 1 1 0.0000000000000000e+00 3.8339999999999996e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -158 1 1 0.0000000000000000e+00 3.9049999999999997e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -159 1 1 0.0000000000000000e+00 4.0469999999999999e+01 7.3785364402434173e+00 0.0000000000000000e+00 0 0 0 -160 1 1 0.0000000000000000e+00 4.1179999999999993e+01 8.6082925136173198e+00 0.0000000000000000e+00 0 0 0 -191 1 1 0.0000000000000000e+00 3.1949999999999999e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -194 1 1 0.0000000000000000e+00 3.4789999999999999e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -195 1 1 0.0000000000000000e+00 3.6210000000000001e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -198 1 1 0.0000000000000000e+00 3.9049999999999997e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -199 1 1 0.0000000000000000e+00 4.0469999999999999e+01 9.8380485869912224e+00 0.0000000000000000e+00 0 0 0 -710 2 2 0.0000000000000000e+00 3.1927155362145239e+01 5.6951791693690031e-03 3.3816934629052842e+00 0 0 0 -711 2 2 0.0000000000000000e+00 3.3341640869765264e+01 3.6084618812221511e-02 3.4057261326595083e+00 0 0 0 -712 2 2 0.0000000000000000e+00 3.4054207340663154e+01 1.2216744224617555e+00 3.4447077786018445e+00 0 0 0 -713 2 2 0.0000000000000000e+00 3.5455046682053293e+01 1.2242481580162874e+00 3.3963238042569057e+00 0 0 0 -714 2 2 0.0000000000000000e+00 3.6188869249181174e+01 2.5088252030732696e-02 3.5186627948261329e+00 0 0 0 -715 2 2 0.0000000000000000e+00 3.7651203396442341e+01 5.4837965490283401e-03 3.4879670040465975e+00 0 0 0 -716 2 2 0.0000000000000000e+00 3.8351683190725389e+01 1.2165811826076021e+00 3.4990473285053199e+00 0 0 0 -717 2 2 0.0000000000000000e+00 3.9762563817836799e+01 1.2206191756440727e+00 3.4509282184991141e+00 0 0 0 -800 2 2 0.0000000000000000e+00 4.2592608289509009e+01 6.0649233466695520e+00 3.4530172179438527e+00 0 0 0 -1035 2 2 0.0000000000000000e+00 3.7613855375528352e+01 1.9679950680241255e+01 3.4802030864123661e+00 0 0 0 -750 2 2 0.0000000000000000e+00 3.1912494591136888e+01 2.4656589861402467e+00 3.4418443928369005e+00 0 0 0 -751 2 2 0.0000000000000000e+00 3.3362356629009319e+01 2.4463371997378318e+00 3.4645269162984222e+00 0 0 0 -752 2 2 0.0000000000000000e+00 3.4100773180993663e+01 3.6782116652070607e+00 3.4164002861074345e+00 0 0 0 -753 2 2 0.0000000000000000e+00 3.5538460957601835e+01 3.6798897844026679e+00 3.4120223574023174e+00 0 0 0 -754 2 2 0.0000000000000000e+00 3.6218195939592306e+01 2.4633067232175740e+00 3.3939114488846003e+00 0 0 0 -755 2 2 0.0000000000000000e+00 3.7619720584089215e+01 2.4460135715326574e+00 3.4521220212487900e+00 0 0 0 -756 2 2 0.0000000000000000e+00 3.8341188850927722e+01 3.6753273078964854e+00 3.4553302527304792e+00 0 0 0 -757 2 2 0.0000000000000000e+00 3.9757493548868695e+01 3.6692835375883814e+00 3.5059526792879332e+00 0 0 0 -758 2 2 0.0000000000000000e+00 4.0487768538905705e+01 2.4406036121219916e+00 3.4572919679316607e+00 0 0 0 -759 2 2 0.0000000000000000e+00 4.1943416640455212e+01 2.4272549345057488e+00 3.4390981820584234e+00 0 0 0 -790 2 2 0.0000000000000000e+00 3.1920314216720502e+01 4.9314292932798587e+00 3.5470056138977033e+00 0 0 0 -791 2 2 0.0000000000000000e+00 3.3375371335194842e+01 4.9267371024613116e+00 3.5205237076993647e+00 0 0 0 -792 2 2 0.0000000000000000e+00 3.4123634231159713e+01 6.1690956864434261e+00 3.4925501284358047e+00 0 0 0 -793 2 2 0.0000000000000000e+00 3.5560537840042528e+01 6.1561627849006761e+00 3.4116455132913455e+00 0 0 0 -794 2 2 0.0000000000000000e+00 3.6253435253227757e+01 4.9289673508534717e+00 3.3729540828249194e+00 0 0 0 -795 2 2 0.0000000000000000e+00 3.7659815774627766e+01 4.9151015832543798e+00 3.4314903058336101e+00 0 0 0 -796 2 2 0.0000000000000000e+00 3.8376709879608434e+01 6.1463508300799514e+00 3.4738734807795413e+00 0 0 0 -797 2 2 0.0000000000000000e+00 3.9764786337174201e+01 6.0952131764338651e+00 3.4825875355174882e+00 0 0 0 -798 2 2 0.0000000000000000e+00 4.0460484663906080e+01 4.8777743694810916e+00 3.5265290990162965e+00 0 0 0 -799 2 2 0.0000000000000000e+00 4.1907861751867145e+01 4.8457260396733481e+00 3.5089647280896652e+00 0 0 0 -830 2 2 0.0000000000000000e+00 3.1978696560379365e+01 7.3542233101470513e+00 3.4777729903480470e+00 0 0 0 -831 2 2 0.0000000000000000e+00 3.3415548663131908e+01 7.3948562615141649e+00 3.4924730701829989e+00 0 0 0 -832 2 2 0.0000000000000000e+00 3.4112343661509996e+01 8.6107609665244738e+00 3.5560120985109358e+00 0 0 0 -833 2 2 0.0000000000000000e+00 3.5551302757264928e+01 8.5993192903737690e+00 3.4577247093456975e+00 0 0 0 -834 2 2 0.0000000000000000e+00 3.6255770194152603e+01 7.4013785552563993e+00 3.4677803366100632e+00 0 0 0 -835 2 2 0.0000000000000000e+00 3.7657699098527495e+01 7.3695244132776478e+00 3.4499941512767305e+00 0 0 0 -836 2 2 0.0000000000000000e+00 3.8381784145124435e+01 8.5615658283124034e+00 3.5385197511687205e+00 0 0 0 -837 2 2 0.0000000000000000e+00 3.9822269513004166e+01 8.5548698810076012e+00 3.4135233969444911e+00 0 0 0 -838 2 2 0.0000000000000000e+00 4.0527178143422219e+01 7.3076427558169366e+00 3.4664993741295733e+00 0 0 0 -839 2 2 0.0000000000000000e+00 4.1927820832328607e+01 7.3289958396831043e+00 3.3986998316951298e+00 0 0 0 -870 2 2 0.0000000000000000e+00 3.2000040257493396e+01 9.8600258483404950e+00 3.4920129114220280e+00 0 0 0 -871 2 2 0.0000000000000000e+00 3.3400532905532948e+01 9.8393799490844138e+00 3.4676281067688723e+00 0 0 0 -874 2 2 0.0000000000000000e+00 3.6263787274272140e+01 9.8158909674246679e+00 3.5109859098799432e+00 0 0 0 -875 2 2 0.0000000000000000e+00 3.7666144241737470e+01 9.8365534625667408e+00 3.5531980986543252e+00 0 0 0 -878 2 2 0.0000000000000000e+00 4.0501338529999749e+01 9.8289411709455479e+00 3.4593188390162584e+00 0 0 0 -879 2 2 0.0000000000000000e+00 4.1892774977181219e+01 9.8278011051584482e+00 3.4091117675680689e+00 0 0 0 -181 1 1 0.0000000000000000e+00 2.1299999999999997e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -184 1 1 0.0000000000000000e+00 2.4139999999999997e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -185 1 1 0.0000000000000000e+00 2.5559999999999999e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -188 1 1 0.0000000000000000e+00 2.8399999999999999e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -189 1 1 0.0000000000000000e+00 2.9820000000000000e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -221 1 1 0.0000000000000000e+00 2.1299999999999997e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -222 1 1 0.0000000000000000e+00 2.2009999999999998e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -223 1 1 0.0000000000000000e+00 2.3429999999999996e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -224 1 1 0.0000000000000000e+00 2.4139999999999997e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -225 1 1 0.0000000000000000e+00 2.5559999999999999e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -226 1 1 0.0000000000000000e+00 2.6270000000000000e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -227 1 1 0.0000000000000000e+00 2.7689999999999998e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -228 1 1 0.0000000000000000e+00 2.8399999999999999e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -229 1 1 0.0000000000000000e+00 2.9820000000000000e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -230 1 1 0.0000000000000000e+00 3.0530000000000001e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -261 1 1 0.0000000000000000e+00 2.1299999999999997e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -262 1 1 0.0000000000000000e+00 2.2009999999999998e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -263 1 1 0.0000000000000000e+00 2.3429999999999996e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -264 1 1 0.0000000000000000e+00 2.4139999999999997e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -265 1 1 0.0000000000000000e+00 2.5559999999999999e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -266 1 1 0.0000000000000000e+00 2.6270000000000000e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -267 1 1 0.0000000000000000e+00 2.7689999999999998e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -268 1 1 0.0000000000000000e+00 2.8399999999999999e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -269 1 1 0.0000000000000000e+00 2.9820000000000000e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -270 1 1 0.0000000000000000e+00 3.0530000000000001e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -301 1 1 0.0000000000000000e+00 2.1299999999999997e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -302 1 1 0.0000000000000000e+00 2.2009999999999998e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -303 1 1 0.0000000000000000e+00 2.3429999999999996e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -304 1 1 0.0000000000000000e+00 2.4139999999999997e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -305 1 1 0.0000000000000000e+00 2.5559999999999999e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -306 1 1 0.0000000000000000e+00 2.6270000000000000e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -307 1 1 0.0000000000000000e+00 2.7689999999999998e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -308 1 1 0.0000000000000000e+00 2.8399999999999999e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -309 1 1 0.0000000000000000e+00 2.9820000000000000e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -310 1 1 0.0000000000000000e+00 3.0530000000000001e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -342 1 1 0.0000000000000000e+00 2.2009999999999998e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -343 1 1 0.0000000000000000e+00 2.3429999999999996e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -346 1 1 0.0000000000000000e+00 2.6270000000000000e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -347 1 1 0.0000000000000000e+00 2.7689999999999998e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -350 1 1 0.0000000000000000e+00 3.0530000000000001e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -860 2 2 0.0000000000000000e+00 2.1322776788571808e+01 1.1029728800857407e+01 3.5962834690334136e+00 0 0 0 -861 2 2 0.0000000000000000e+00 2.2736640402610433e+01 1.1048660356559719e+01 3.5076115297064026e+00 0 0 0 -864 2 2 0.0000000000000000e+00 2.5591927473665994e+01 1.1041524580601575e+01 3.3764461882851355e+00 0 0 0 -865 2 2 0.0000000000000000e+00 2.6997761894249074e+01 1.1085229144754088e+01 3.3945868870374443e+00 0 0 0 -868 2 2 0.0000000000000000e+00 2.9830965686025166e+01 1.1084230099033787e+01 3.3827920322100256e+00 0 0 0 -869 2 2 0.0000000000000000e+00 3.1266130064318574e+01 1.1062617715566814e+01 3.4164257339937558e+00 0 0 0 -900 2 2 0.0000000000000000e+00 2.1333212083640852e+01 1.3517385045345488e+01 3.4501007929122123e+00 0 0 0 -901 2 2 0.0000000000000000e+00 2.2774094874477978e+01 1.3501347995892930e+01 3.3943924361777245e+00 0 0 0 -902 2 2 0.0000000000000000e+00 2.3481089250381590e+01 1.2272598146128882e+01 3.4466995269826928e+00 0 0 0 -903 2 2 0.0000000000000000e+00 2.4906644212433022e+01 1.2272229213262657e+01 3.2780253106322319e+00 0 0 0 -904 2 2 0.0000000000000000e+00 2.5582820364910543e+01 1.3539368687584071e+01 3.2823490258251988e+00 0 0 0 -905 2 2 0.0000000000000000e+00 2.7006135949395507e+01 1.3524924463766940e+01 3.3659291118089310e+00 0 0 0 -906 2 2 0.0000000000000000e+00 2.7702012476851237e+01 1.2317312976939068e+01 3.3764577861248548e+00 0 0 0 -907 2 2 0.0000000000000000e+00 2.9133662945233812e+01 1.2311100581657795e+01 3.3675147985690153e+00 0 0 0 -908 2 2 0.0000000000000000e+00 2.9824106820968314e+01 1.3530741970872274e+01 3.3755001530770126e+00 0 0 0 -909 2 2 0.0000000000000000e+00 3.1236196568138006e+01 1.3531325402513376e+01 3.4536308343321607e+00 0 0 0 -1039 2 2 0.0000000000000000e+00 4.1875475409200256e+01 1.9640284090184938e+01 3.6951644581452872e+00 0 0 0 -941 2 2 0.0000000000000000e+00 2.2727719568150068e+01 1.5966388939883862e+01 3.4062683979364903e+00 0 0 0 -942 2 2 0.0000000000000000e+00 2.3468232219122676e+01 1.4745515139686599e+01 3.3434196597533314e+00 0 0 0 -943 2 2 0.0000000000000000e+00 2.4903447864990977e+01 1.4790579141669673e+01 3.3169781697528080e+00 0 0 0 -944 2 2 0.0000000000000000e+00 2.5579553508740521e+01 1.6005795025739399e+01 3.4634507089415121e+00 0 0 0 -945 2 2 0.0000000000000000e+00 2.7014390057524466e+01 1.5991867291406040e+01 3.4832898475932912e+00 0 0 0 -946 2 2 0.0000000000000000e+00 2.7736881820670362e+01 1.4749756050236353e+01 3.4286986184673207e+00 0 0 0 -947 2 2 0.0000000000000000e+00 2.9150463258316336e+01 1.4782875680522487e+01 3.5185707965031798e+00 0 0 0 -948 2 2 0.0000000000000000e+00 2.9847858899387433e+01 1.6028050376950972e+01 3.5927128819950074e+00 0 0 0 -949 2 2 0.0000000000000000e+00 3.1262488388930695e+01 1.6016000140136768e+01 3.6068012739123061e+00 0 0 0 -1038 2 2 0.0000000000000000e+00 4.0469382373428573e+01 1.9667435418200746e+01 3.6638060102594054e+00 0 0 0 -981 2 2 0.0000000000000000e+00 2.2688780160616570e+01 1.8445701841356342e+01 3.5118482993698854e+00 0 0 0 -982 2 2 0.0000000000000000e+00 2.3461427203726050e+01 1.7204567980208218e+01 3.4068387941000751e+00 0 0 0 -983 2 2 0.0000000000000000e+00 2.4874740423597171e+01 1.7250304648730342e+01 3.5372955968491389e+00 0 0 0 -984 2 2 0.0000000000000000e+00 2.5591021367732687e+01 1.8465253317574863e+01 3.6291755903328480e+00 0 0 0 -985 2 2 0.0000000000000000e+00 2.7001996796250296e+01 1.8464742133934116e+01 3.5516214534961543e+00 0 0 0 -986 2 2 0.0000000000000000e+00 2.7681626530754393e+01 1.7225218627692083e+01 3.4852169231697445e+00 0 0 0 -987 2 2 0.0000000000000000e+00 2.9108812575681913e+01 1.7244816740502632e+01 3.5185225590340607e+00 0 0 0 -988 2 2 0.0000000000000000e+00 2.9833885952372306e+01 1.8450613836804621e+01 3.4800174043675116e+00 0 0 0 -989 2 2 0.0000000000000000e+00 3.1231053333497865e+01 1.8467009156816491e+01 3.5504262710818284e+00 0 0 0 -1022 2 2 0.0000000000000000e+00 2.3438607398506182e+01 1.9677037683959750e+01 3.5655254813241335e+00 0 0 0 -1023 2 2 0.0000000000000000e+00 2.4849870393924721e+01 1.9681681549472426e+01 3.5877344088992786e+00 0 0 0 -1026 2 2 0.0000000000000000e+00 2.7692326315685413e+01 1.9679792659067289e+01 3.5215646864061618e+00 0 0 0 -1027 2 2 0.0000000000000000e+00 2.9098153350720700e+01 1.9653418404610129e+01 3.4834969916277023e+00 0 0 0 -192 1 1 0.0000000000000000e+00 3.2659999999999997e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -193 1 1 0.0000000000000000e+00 3.4079999999999998e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -196 1 1 0.0000000000000000e+00 3.6920000000000002e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -197 1 1 0.0000000000000000e+00 3.8339999999999996e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -200 1 1 0.0000000000000000e+00 4.1179999999999993e+01 1.1067804660365125e+01 0.0000000000000000e+00 0 0 0 -231 1 1 0.0000000000000000e+00 3.1949999999999999e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -232 1 1 0.0000000000000000e+00 3.2659999999999997e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -233 1 1 0.0000000000000000e+00 3.4079999999999998e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -234 1 1 0.0000000000000000e+00 3.4789999999999999e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -235 1 1 0.0000000000000000e+00 3.6210000000000001e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -236 1 1 0.0000000000000000e+00 3.6920000000000002e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -237 1 1 0.0000000000000000e+00 3.8339999999999996e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -238 1 1 0.0000000000000000e+00 3.9049999999999997e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -239 1 1 0.0000000000000000e+00 4.0469999999999999e+01 1.2297560733739028e+01 0.0000000000000000e+00 0 0 0 -240 1 1 0.0000000000000000e+00 4.1179999999999993e+01 1.3527316807112930e+01 0.0000000000000000e+00 0 0 0 -271 1 1 0.0000000000000000e+00 3.1949999999999999e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -272 1 1 0.0000000000000000e+00 3.2659999999999997e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -273 1 1 0.0000000000000000e+00 3.4079999999999998e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -274 1 1 0.0000000000000000e+00 3.4789999999999999e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -275 1 1 0.0000000000000000e+00 3.6210000000000001e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -276 1 1 0.0000000000000000e+00 3.6920000000000002e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -277 1 1 0.0000000000000000e+00 3.8339999999999996e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -278 1 1 0.0000000000000000e+00 3.9049999999999997e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -279 1 1 0.0000000000000000e+00 4.0469999999999999e+01 1.4757072880486835e+01 0.0000000000000000e+00 0 0 0 -280 1 1 0.0000000000000000e+00 4.1179999999999993e+01 1.5986828953860737e+01 0.0000000000000000e+00 0 0 0 -311 1 1 0.0000000000000000e+00 3.1949999999999999e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -312 1 1 0.0000000000000000e+00 3.2659999999999997e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -313 1 1 0.0000000000000000e+00 3.4079999999999998e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -314 1 1 0.0000000000000000e+00 3.4789999999999999e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -315 1 1 0.0000000000000000e+00 3.6210000000000001e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -316 1 1 0.0000000000000000e+00 3.6920000000000002e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -317 1 1 0.0000000000000000e+00 3.8339999999999996e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -318 1 1 0.0000000000000000e+00 3.9049999999999997e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -319 1 1 0.0000000000000000e+00 4.0469999999999999e+01 1.7216585027234640e+01 0.0000000000000000e+00 0 0 0 -320 1 1 0.0000000000000000e+00 4.1179999999999993e+01 1.8446341100608542e+01 0.0000000000000000e+00 0 0 0 -351 1 1 0.0000000000000000e+00 3.1949999999999999e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -354 1 1 0.0000000000000000e+00 3.4789999999999999e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -355 1 1 0.0000000000000000e+00 3.6210000000000001e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -358 1 1 0.0000000000000000e+00 3.9049999999999997e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -359 1 1 0.0000000000000000e+00 4.0469999999999999e+01 1.9676097173982445e+01 0.0000000000000000e+00 0 0 0 -872 2 2 0.0000000000000000e+00 3.4124753232818371e+01 1.1060408278251183e+01 3.4536641967878512e+00 0 0 0 -873 2 2 0.0000000000000000e+00 3.5554936460625463e+01 1.1056204853382539e+01 3.4529685626392248e+00 0 0 0 -876 2 2 0.0000000000000000e+00 3.8374748026319168e+01 1.1067816693772194e+01 3.5255307756130554e+00 0 0 0 -877 2 2 0.0000000000000000e+00 3.9759652085470350e+01 1.1038597641090009e+01 3.5166198725081572e+00 0 0 0 -910 2 2 0.0000000000000000e+00 3.1977328820757769e+01 1.2321518364377779e+01 3.3643381287175140e+00 0 0 0 -911 2 2 0.0000000000000000e+00 3.3413854372731556e+01 1.2324416627993781e+01 3.5036535111723257e+00 0 0 0 -912 2 2 0.0000000000000000e+00 3.4135798307115799e+01 1.3549709896290478e+01 3.4511041115837311e+00 0 0 0 -913 2 2 0.0000000000000000e+00 3.5545111348578743e+01 1.3530248375087876e+01 3.5085285680401106e+00 0 0 0 -914 2 2 0.0000000000000000e+00 3.6259827380768449e+01 1.2306171362371115e+01 3.4962603583264786e+00 0 0 0 -915 2 2 0.0000000000000000e+00 3.7672001089382448e+01 1.2286757866232193e+01 3.4516132636511658e+00 0 0 0 -916 2 2 0.0000000000000000e+00 3.8348538863589162e+01 1.3520834964184758e+01 3.4815604583602919e+00 0 0 0 -917 2 2 0.0000000000000000e+00 3.9775062496418762e+01 1.3500714339738682e+01 3.4798687319203307e+00 0 0 0 -918 2 2 0.0000000000000000e+00 4.0497439689661128e+01 1.2266695167367864e+01 3.5094541095603318e+00 0 0 0 -919 2 2 0.0000000000000000e+00 4.1917369325956258e+01 1.2286064074469639e+01 3.4443517672239667e+00 0 0 0 -950 2 2 0.0000000000000000e+00 3.1948006781068017e+01 1.4778329621757761e+01 3.4900102788116394e+00 0 0 0 -951 2 2 0.0000000000000000e+00 3.3374918118556117e+01 1.4771292072762705e+01 3.5488806318302295e+00 0 0 0 -952 2 2 0.0000000000000000e+00 3.4069706822064255e+01 1.5984926773036790e+01 3.6167002791294847e+00 0 0 0 -953 2 2 0.0000000000000000e+00 3.5516210823193028e+01 1.5968902831519419e+01 3.5894170052565437e+00 0 0 0 -954 2 2 0.0000000000000000e+00 3.6236843430344763e+01 1.4748159256518138e+01 3.5762509607038124e+00 0 0 0 -955 2 2 0.0000000000000000e+00 3.7636656326881862e+01 1.4746411985223970e+01 3.5109998954148649e+00 0 0 0 -956 2 2 0.0000000000000000e+00 3.8369106063300244e+01 1.5975825667180301e+01 3.5219342745605466e+00 0 0 0 -957 2 2 0.0000000000000000e+00 3.9784356270969681e+01 1.5949672411665540e+01 3.5802819403972652e+00 0 0 0 -958 2 2 0.0000000000000000e+00 4.0492005222102065e+01 1.4735608574259441e+01 3.5774084688183345e+00 0 0 0 -959 2 2 0.0000000000000000e+00 4.1888910437418517e+01 1.4759217725603484e+01 3.4751308894490123e+00 0 0 0 -990 2 2 0.0000000000000000e+00 3.1967518728619535e+01 1.7237497558202168e+01 3.5462394167790525e+00 0 0 0 -991 2 2 0.0000000000000000e+00 3.3393034982329560e+01 1.7203133234966955e+01 3.5590442970885796e+00 0 0 0 -992 2 2 0.0000000000000000e+00 3.4042447808381922e+01 1.8419428356609306e+01 3.6054880278952499e+00 0 0 0 -993 2 2 0.0000000000000000e+00 3.5490129286998851e+01 1.8467266993575933e+01 3.6566065181451832e+00 0 0 0 -994 2 2 0.0000000000000000e+00 3.6194936255856412e+01 1.7203478347096567e+01 3.6289412648357326e+00 0 0 0 -995 2 2 0.0000000000000000e+00 3.7625669724518040e+01 1.7204342807784901e+01 3.5429545307897778e+00 0 0 0 -996 2 2 0.0000000000000000e+00 3.8333344047578080e+01 1.8430886245076390e+01 3.4861603387610276e+00 0 0 0 -997 2 2 0.0000000000000000e+00 3.9740747631889541e+01 1.8435422870112141e+01 3.5671762489828316e+00 0 0 0 -998 2 2 0.0000000000000000e+00 4.0454398920866701e+01 1.7206544779686137e+01 3.6211894228205987e+00 0 0 0 -999 2 2 0.0000000000000000e+00 4.1853144873024412e+01 1.7205319072220785e+01 3.7037110467825385e+00 0 0 0 -1030 2 2 0.0000000000000000e+00 3.1959255054305011e+01 1.9643060232895543e+01 3.5110419564334561e+00 0 0 0 -1031 2 2 0.0000000000000000e+00 3.3370819319362887e+01 1.9664406028398957e+01 3.5791930735379522e+00 0 0 0 -1034 2 2 0.0000000000000000e+00 3.6206562958434567e+01 1.9685110033196803e+01 3.5224678448631757e+00 0 0 0 -1024 2 2 0.0000000000000000e+00 2.5541572520385799e+01 2.0903205410170845e+01 3.4899330777576747e+00 0 0 0 -1025 2 2 0.0000000000000000e+00 2.6956312776256283e+01 2.0886387290782086e+01 3.5439129329279417e+00 0 0 0 -1028 2 2 0.0000000000000000e+00 2.9821126829445781e+01 2.0857212770586727e+01 3.4057863620944677e+00 0 0 0 -1029 2 2 0.0000000000000000e+00 3.1258705113362044e+01 2.0875069723645343e+01 3.3575962532672712e+00 0 0 0 -1032 2 2 0.0000000000000000e+00 3.4068705650794357e+01 2.0885984392813302e+01 3.4285468770606866e+00 0 0 0 -1036 2 2 0.0000000000000000e+00 3.8324191815956581e+01 2.0904645378134859e+01 3.4594401288378038e+00 0 0 0 -1040 2 2 0.0000000000000000e+00 4.2599600380698909e+01 2.0876168066562389e+01 3.7283973040531868e+00 0 0 0 -341 1 1 0.0000000000000000e+00 2.1299999999999997e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -344 1 1 0.0000000000000000e+00 2.4139999999999997e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -345 1 1 0.0000000000000000e+00 2.5559999999999999e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -348 1 1 0.0000000000000000e+00 2.8399999999999999e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -349 1 1 0.0000000000000000e+00 2.9820000000000000e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -381 1 1 0.0000000000000000e+00 2.1299999999999997e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -382 1 1 0.0000000000000000e+00 2.2009999999999998e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -383 1 1 0.0000000000000000e+00 2.3429999999999996e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -384 1 1 0.0000000000000000e+00 2.4139999999999997e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -385 1 1 0.0000000000000000e+00 2.5559999999999999e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -386 1 1 0.0000000000000000e+00 2.6270000000000000e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -387 1 1 0.0000000000000000e+00 2.7689999999999998e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -388 1 1 0.0000000000000000e+00 2.8399999999999999e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -389 1 1 0.0000000000000000e+00 2.9820000000000000e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -390 1 1 0.0000000000000000e+00 3.0530000000000001e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -421 1 1 0.0000000000000000e+00 2.1299999999999997e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -422 1 1 0.0000000000000000e+00 2.2009999999999998e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -423 1 1 0.0000000000000000e+00 2.3429999999999996e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -424 1 1 0.0000000000000000e+00 2.4139999999999997e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -425 1 1 0.0000000000000000e+00 2.5559999999999999e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -426 1 1 0.0000000000000000e+00 2.6270000000000000e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -427 1 1 0.0000000000000000e+00 2.7689999999999998e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -428 1 1 0.0000000000000000e+00 2.8399999999999999e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -429 1 1 0.0000000000000000e+00 2.9820000000000000e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -430 1 1 0.0000000000000000e+00 3.0530000000000001e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -461 1 1 0.0000000000000000e+00 2.1299999999999997e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -462 1 1 0.0000000000000000e+00 2.2009999999999998e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -463 1 1 0.0000000000000000e+00 2.3429999999999996e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -464 1 1 0.0000000000000000e+00 2.4139999999999997e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -465 1 1 0.0000000000000000e+00 2.5559999999999999e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -466 1 1 0.0000000000000000e+00 2.6270000000000000e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -467 1 1 0.0000000000000000e+00 2.7689999999999998e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -468 1 1 0.0000000000000000e+00 2.8399999999999999e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -469 1 1 0.0000000000000000e+00 2.9820000000000000e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -470 1 1 0.0000000000000000e+00 3.0530000000000001e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -501 1 1 0.0000000000000000e+00 2.1299999999999997e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -502 1 1 0.0000000000000000e+00 2.2009999999999998e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -503 1 1 0.0000000000000000e+00 2.3429999999999996e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -504 1 1 0.0000000000000000e+00 2.4139999999999997e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -505 1 1 0.0000000000000000e+00 2.5559999999999999e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -506 1 1 0.0000000000000000e+00 2.6270000000000000e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -507 1 1 0.0000000000000000e+00 2.7689999999999998e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -508 1 1 0.0000000000000000e+00 2.8399999999999999e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -509 1 1 0.0000000000000000e+00 2.9820000000000000e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -510 1 1 0.0000000000000000e+00 3.0530000000000001e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -1020 2 2 0.0000000000000000e+00 2.1300558990151906e+01 2.0946700713237909e+01 3.4810308659226239e+00 0 0 0 -1021 2 2 0.0000000000000000e+00 2.2722663984039411e+01 2.0940339862463215e+01 3.5655325317245099e+00 0 0 0 -1320 2 2 0.0000000000000000e+00 4.2579606574987544e+01 3.8103857330220350e+01 3.3529350064105494e+00 0 0 0 -1280 2 2 0.0000000000000000e+00 4.2594058312360318e+01 3.5659827239661631e+01 3.4183514504619992e+00 0 0 0 -1240 2 2 0.0000000000000000e+00 4.2597272917865467e+01 3.3192908306076447e+01 3.4227369622955681e+00 0 0 0 -1200 2 2 0.0000000000000000e+00 4.2535064845884619e+01 3.0744199759454759e+01 3.4578433017277073e+00 0 0 0 -1060 2 2 0.0000000000000000e+00 2.1341975904939407e+01 2.3395315107806191e+01 3.5308109785353703e+00 0 0 0 -1061 2 2 0.0000000000000000e+00 2.2745372228563337e+01 2.3429031010056544e+01 3.5166799415213963e+00 0 0 0 -1062 2 2 0.0000000000000000e+00 2.3417466486300576e+01 2.2158201435239448e+01 3.5616687679366601e+00 0 0 0 -1063 2 2 0.0000000000000000e+00 2.4858681773914284e+01 2.2121795316605134e+01 3.4839978236550504e+00 0 0 0 -1064 2 2 0.0000000000000000e+00 2.5563931758899066e+01 2.3374816092417138e+01 3.4222661717807248e+00 0 0 0 -1065 2 2 0.0000000000000000e+00 2.6981407401344367e+01 2.3425879975608080e+01 3.4608018705717498e+00 0 0 0 -1066 2 2 0.0000000000000000e+00 2.7677152996855966e+01 2.2151067497206689e+01 3.5116091379836321e+00 0 0 0 -1067 2 2 0.0000000000000000e+00 2.9119919422196652e+01 2.2122514187235904e+01 3.3533224846432725e+00 0 0 0 -1068 2 2 0.0000000000000000e+00 2.9842386065540587e+01 2.3349764555927337e+01 3.4395411443133392e+00 0 0 0 -1069 2 2 0.0000000000000000e+00 3.1268389506555049e+01 2.3334485629681481e+01 3.3781974017894210e+00 0 0 0 -1359 2 2 0.0000000000000000e+00 4.1908239008242063e+01 3.9336405168122894e+01 3.3542176813679854e+00 0 0 0 -1101 2 2 0.0000000000000000e+00 2.2698762931413174e+01 2.5906858435913147e+01 3.4676731624016361e+00 0 0 0 -1102 2 2 0.0000000000000000e+00 2.3416576212633853e+01 2.4645325020809192e+01 3.5274775165987315e+00 0 0 0 -1103 2 2 0.0000000000000000e+00 2.4834055498349777e+01 2.4640362751637703e+01 3.4637802302306779e+00 0 0 0 -1104 2 2 0.0000000000000000e+00 2.5575812494857665e+01 2.5852162050240025e+01 3.4554561982613792e+00 0 0 0 -1105 2 2 0.0000000000000000e+00 2.7012194337535998e+01 2.5856276829147209e+01 3.3922529050697303e+00 0 0 0 -1106 2 2 0.0000000000000000e+00 2.7690314317605523e+01 2.4607142583933523e+01 3.4074207221998583e+00 0 0 0 -1107 2 2 0.0000000000000000e+00 2.9124056577148938e+01 2.4591723783083605e+01 3.4214464051469267e+00 0 0 0 -1108 2 2 0.0000000000000000e+00 2.9841842447612134e+01 2.5881094846214154e+01 3.4432505213335474e+00 0 0 0 -1109 2 2 0.0000000000000000e+00 3.1242139515475721e+01 2.5843522013332954e+01 3.4546264729715479e+00 0 0 0 -1140 2 2 0.0000000000000000e+00 2.1302036392471344e+01 2.8278376043708963e+01 3.4245217402652410e+00 0 0 0 -1141 2 2 0.0000000000000000e+00 2.2740020370597680e+01 2.8309804920734713e+01 3.4076820804019397e+00 0 0 0 -1142 2 2 0.0000000000000000e+00 2.3433151909015383e+01 2.7116554065483015e+01 3.4587959553790650e+00 0 0 0 -1143 2 2 0.0000000000000000e+00 2.4850325675546422e+01 2.7095825124281586e+01 3.3609051109699362e+00 0 0 0 -1144 2 2 0.0000000000000000e+00 2.5591788824244809e+01 2.8322713157550098e+01 3.3914716713961384e+00 0 0 0 -1145 2 2 0.0000000000000000e+00 2.7008965364506587e+01 2.8307970992949659e+01 3.2811766462460814e+00 0 0 0 -1146 2 2 0.0000000000000000e+00 2.7721843448591613e+01 2.7098291652266195e+01 3.3571686220099464e+00 0 0 0 -1147 2 2 0.0000000000000000e+00 2.9127996608109658e+01 2.7096170053110544e+01 3.4194353338242069e+00 0 0 0 -1148 2 2 0.0000000000000000e+00 2.9864771444380025e+01 2.8329762899063784e+01 3.3724409854227737e+00 0 0 0 -1149 2 2 0.0000000000000000e+00 3.1256690289976671e+01 2.8276289067450399e+01 3.4930635839175399e+00 0 0 0 -1358 2 2 0.0000000000000000e+00 4.0522007216285957e+01 3.9366212497265280e+01 3.3731657736433074e+00 0 0 0 -1181 2 2 0.0000000000000000e+00 2.2710667989101271e+01 3.0790329828001600e+01 3.4020814683398628e+00 0 0 0 -1182 2 2 0.0000000000000000e+00 2.3445301668757697e+01 2.9563065521210813e+01 3.4202082028772569e+00 0 0 0 -1183 2 2 0.0000000000000000e+00 2.4843716642582233e+01 2.9550036753270216e+01 3.3980280212153096e+00 0 0 0 -1184 2 2 0.0000000000000000e+00 2.5582813227471867e+01 3.0765585864062540e+01 3.4207944194278603e+00 0 0 0 -1185 2 2 0.0000000000000000e+00 2.6997559481401609e+01 3.0766862918190210e+01 3.3050108014947037e+00 0 0 0 -1186 2 2 0.0000000000000000e+00 2.7744133768550707e+01 2.9560587174875611e+01 3.2823902399329827e+00 0 0 0 -1187 2 2 0.0000000000000000e+00 2.9151368767920641e+01 2.9538643946538485e+01 3.2703684404340194e+00 0 0 0 -1188 2 2 0.0000000000000000e+00 2.9823957535855914e+01 3.0775240322584789e+01 3.3062174842127665e+00 0 0 0 -1189 2 2 0.0000000000000000e+00 3.1275102454951632e+01 3.0760493296479293e+01 3.3847959095420159e+00 0 0 0 -352 1 1 0.0000000000000000e+00 3.2659999999999997e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -353 1 1 0.0000000000000000e+00 3.4079999999999998e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -356 1 1 0.0000000000000000e+00 3.6920000000000002e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -357 1 1 0.0000000000000000e+00 3.8339999999999996e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -360 1 1 0.0000000000000000e+00 4.1179999999999993e+01 2.0905853247356347e+01 0.0000000000000000e+00 0 0 0 -391 1 1 0.0000000000000000e+00 3.1949999999999999e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -392 1 1 0.0000000000000000e+00 3.2659999999999997e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -393 1 1 0.0000000000000000e+00 3.4079999999999998e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -394 1 1 0.0000000000000000e+00 3.4789999999999999e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -395 1 1 0.0000000000000000e+00 3.6210000000000001e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -396 1 1 0.0000000000000000e+00 3.6920000000000002e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -397 1 1 0.0000000000000000e+00 3.8339999999999996e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -398 1 1 0.0000000000000000e+00 3.9049999999999997e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -399 1 1 0.0000000000000000e+00 4.0469999999999999e+01 2.2135609320730250e+01 0.0000000000000000e+00 0 0 0 -400 1 1 0.0000000000000000e+00 4.1179999999999993e+01 2.3365365394104153e+01 0.0000000000000000e+00 0 0 0 -431 1 1 0.0000000000000000e+00 3.1949999999999999e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -432 1 1 0.0000000000000000e+00 3.2659999999999997e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -433 1 1 0.0000000000000000e+00 3.4079999999999998e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -434 1 1 0.0000000000000000e+00 3.4789999999999999e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -435 1 1 0.0000000000000000e+00 3.6210000000000001e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -436 1 1 0.0000000000000000e+00 3.6920000000000002e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -437 1 1 0.0000000000000000e+00 3.8339999999999996e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -438 1 1 0.0000000000000000e+00 3.9049999999999997e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -439 1 1 0.0000000000000000e+00 4.0469999999999999e+01 2.4595121467478055e+01 0.0000000000000000e+00 0 0 0 -440 1 1 0.0000000000000000e+00 4.1179999999999993e+01 2.5824877540851958e+01 0.0000000000000000e+00 0 0 0 -471 1 1 0.0000000000000000e+00 3.1949999999999999e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -472 1 1 0.0000000000000000e+00 3.2659999999999997e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -473 1 1 0.0000000000000000e+00 3.4079999999999998e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -474 1 1 0.0000000000000000e+00 3.4789999999999999e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -475 1 1 0.0000000000000000e+00 3.6210000000000001e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -476 1 1 0.0000000000000000e+00 3.6920000000000002e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -477 1 1 0.0000000000000000e+00 3.8339999999999996e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -478 1 1 0.0000000000000000e+00 3.9049999999999997e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -479 1 1 0.0000000000000000e+00 4.0469999999999999e+01 2.7054633614225860e+01 0.0000000000000000e+00 0 0 0 -480 1 1 0.0000000000000000e+00 4.1179999999999993e+01 2.8284389687599763e+01 0.0000000000000000e+00 0 0 0 -511 1 1 0.0000000000000000e+00 3.1949999999999999e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -512 1 1 0.0000000000000000e+00 3.2659999999999997e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -513 1 1 0.0000000000000000e+00 3.4079999999999998e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -514 1 1 0.0000000000000000e+00 3.4789999999999999e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -515 1 1 0.0000000000000000e+00 3.6210000000000001e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -516 1 1 0.0000000000000000e+00 3.6920000000000002e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -517 1 1 0.0000000000000000e+00 3.8339999999999996e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -518 1 1 0.0000000000000000e+00 3.9049999999999997e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -519 1 1 0.0000000000000000e+00 4.0469999999999999e+01 2.9514145760973669e+01 0.0000000000000000e+00 0 0 0 -520 1 1 0.0000000000000000e+00 4.1179999999999993e+01 3.0743901834347572e+01 0.0000000000000000e+00 0 0 0 -1160 2 2 0.0000000000000000e+00 4.2563568750200815e+01 2.8264579802330253e+01 3.3780680396676979e+00 0 0 0 -1033 2 2 0.0000000000000000e+00 3.5471081999170451e+01 2.0914012650445617e+01 3.4060953542460952e+00 0 0 0 -1080 2 2 0.0000000000000000e+00 4.2577469019284209e+01 2.3375918901166106e+01 3.6668947125718829e+00 0 0 0 -1037 2 2 0.0000000000000000e+00 3.9748745901476227e+01 2.0911941451705221e+01 3.5479519125433758e+00 0 0 0 -1070 2 2 0.0000000000000000e+00 3.1966330282827741e+01 2.2108724762114431e+01 3.4034272826668852e+00 0 0 0 -1071 2 2 0.0000000000000000e+00 3.3394979803425244e+01 2.2116241308977500e+01 3.4332814756420413e+00 0 0 0 -1072 2 2 0.0000000000000000e+00 3.4117156353566905e+01 2.3329135096221876e+01 3.4096173709926578e+00 0 0 0 -1073 2 2 0.0000000000000000e+00 3.5508111844195952e+01 2.3355158034626978e+01 3.3944531552219304e+00 0 0 0 -1074 2 2 0.0000000000000000e+00 3.6220529430465938e+01 2.2125224956385782e+01 3.3989370060495498e+00 0 0 0 -1075 2 2 0.0000000000000000e+00 3.7621311913697220e+01 2.2144646759701018e+01 3.3699749118146936e+00 0 0 0 -1076 2 2 0.0000000000000000e+00 3.8311485907113401e+01 2.3387570357561863e+01 3.3479819447228469e+00 0 0 0 -1077 2 2 0.0000000000000000e+00 3.9760993503425730e+01 2.3396815755460111e+01 3.4277436920134732e+00 0 0 0 -1078 2 2 0.0000000000000000e+00 4.0454559237569349e+01 2.2150959920734408e+01 3.5468869999937733e+00 0 0 0 -1079 2 2 0.0000000000000000e+00 4.1873062271322404e+01 2.2133777660330047e+01 3.6857259188027358e+00 0 0 0 -1110 2 2 0.0000000000000000e+00 3.1924982147207956e+01 2.4559007545872749e+01 3.4244342497958056e+00 0 0 0 -1111 2 2 0.0000000000000000e+00 3.3380898499571330e+01 2.4590591394688392e+01 3.3950147074026176e+00 0 0 0 -1112 2 2 0.0000000000000000e+00 3.4116835005949170e+01 2.5826007423148205e+01 3.3935079082626118e+00 0 0 0 -1113 2 2 0.0000000000000000e+00 3.5533288074579907e+01 2.5838587065397874e+01 3.4233630141004432e+00 0 0 0 -1114 2 2 0.0000000000000000e+00 3.6215048695935970e+01 2.4623451328422753e+01 3.5337823409749789e+00 0 0 0 -1115 2 2 0.0000000000000000e+00 3.7660375982786988e+01 2.4611556190291008e+01 3.4461255794355115e+00 0 0 0 -1116 2 2 0.0000000000000000e+00 3.8353997298904837e+01 2.5844061169278454e+01 3.4511745448472313e+00 0 0 0 -1117 2 2 0.0000000000000000e+00 3.9753932734432162e+01 2.5876967726484040e+01 3.3781912252982327e+00 0 0 0 -1118 2 2 0.0000000000000000e+00 4.0425473132195066e+01 2.4632251406076811e+01 3.4210587912831651e+00 0 0 0 -1119 2 2 0.0000000000000000e+00 4.1807386301343612e+01 2.4601866240646594e+01 3.4920085038954927e+00 0 0 0 -1150 2 2 0.0000000000000000e+00 3.1990062501611551e+01 2.7063272894047817e+01 3.4383705320408371e+00 0 0 0 -1151 2 2 0.0000000000000000e+00 3.3401585371581000e+01 2.7046819743293650e+01 3.3937315307092408e+00 0 0 0 -1152 2 2 0.0000000000000000e+00 3.4130955116243548e+01 2.8248720099702307e+01 3.4702033130666954e+00 0 0 0 -1153 2 2 0.0000000000000000e+00 3.5559662377462956e+01 2.8303139847897405e+01 3.4430247611853200e+00 0 0 0 -1154 2 2 0.0000000000000000e+00 3.6245381469466132e+01 2.7065141542299699e+01 3.4322750396072146e+00 0 0 0 -1155 2 2 0.0000000000000000e+00 3.7657934878841360e+01 2.7066888169786125e+01 3.5399824094997032e+00 0 0 0 -1156 2 2 0.0000000000000000e+00 3.8341718714998748e+01 2.8328208808368185e+01 3.3485167763393404e+00 0 0 0 -1157 2 2 0.0000000000000000e+00 3.9737847979173416e+01 2.8275978782769133e+01 3.3487858128143948e+00 0 0 0 -1158 2 2 0.0000000000000000e+00 4.0456299577064918e+01 2.7073439625662363e+01 3.4536892635198226e+00 0 0 0 -1159 2 2 0.0000000000000000e+00 4.1875469355885201e+01 2.7051789472231498e+01 3.4920815043843016e+00 0 0 0 -1190 2 2 0.0000000000000000e+00 3.1995497773973145e+01 2.9488861886961136e+01 3.4380749114491889e+00 0 0 0 -1191 2 2 0.0000000000000000e+00 3.3391530346448306e+01 2.9454582409751094e+01 3.4914448916121938e+00 0 0 0 -1192 2 2 0.0000000000000000e+00 3.4067698307302386e+01 3.0704328973368412e+01 3.3914209585710262e+00 0 0 0 -1193 2 2 0.0000000000000000e+00 3.5471015290002377e+01 3.0745368870935568e+01 3.4162087809655746e+00 0 0 0 -1194 2 2 0.0000000000000000e+00 3.6199224242684060e+01 2.9523060917006681e+01 3.4493009167249973e+00 0 0 0 -1195 2 2 0.0000000000000000e+00 3.7638842291404039e+01 2.9521630516133378e+01 3.3847550825697663e+00 0 0 0 -1196 2 2 0.0000000000000000e+00 3.8325042795859417e+01 3.0786008761741190e+01 3.3000421225385259e+00 0 0 0 -1197 2 2 0.0000000000000000e+00 3.9754586445370386e+01 3.0765173719457547e+01 3.3188748567886188e+00 0 0 0 -1198 2 2 0.0000000000000000e+00 4.0485669695671874e+01 2.9498589817221969e+01 3.2978716105202737e+00 0 0 0 -1199 2 2 0.0000000000000000e+00 4.1876720354040572e+01 2.9483930859332780e+01 3.3349039044871449e+00 0 0 0 -541 1 1 0.0000000000000000e+00 2.1299999999999997e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -542 1 1 0.0000000000000000e+00 2.2009999999999998e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -543 1 1 0.0000000000000000e+00 2.3429999999999996e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -544 1 1 0.0000000000000000e+00 2.4139999999999997e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -545 1 1 0.0000000000000000e+00 2.5559999999999999e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -546 1 1 0.0000000000000000e+00 2.6270000000000000e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -547 1 1 0.0000000000000000e+00 2.7689999999999998e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -548 1 1 0.0000000000000000e+00 2.8399999999999999e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -549 1 1 0.0000000000000000e+00 2.9820000000000000e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -550 1 1 0.0000000000000000e+00 3.0530000000000001e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -581 1 1 0.0000000000000000e+00 2.1299999999999997e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -582 1 1 0.0000000000000000e+00 2.2009999999999998e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -583 1 1 0.0000000000000000e+00 2.3429999999999996e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -584 1 1 0.0000000000000000e+00 2.4139999999999997e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -585 1 1 0.0000000000000000e+00 2.5559999999999999e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -586 1 1 0.0000000000000000e+00 2.6270000000000000e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -587 1 1 0.0000000000000000e+00 2.7689999999999998e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -588 1 1 0.0000000000000000e+00 2.8399999999999999e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -589 1 1 0.0000000000000000e+00 2.9820000000000000e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -590 1 1 0.0000000000000000e+00 3.0530000000000001e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -621 1 1 0.0000000000000000e+00 2.1299999999999997e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -622 1 1 0.0000000000000000e+00 2.2009999999999998e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -623 1 1 0.0000000000000000e+00 2.3429999999999996e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -624 1 1 0.0000000000000000e+00 2.4139999999999997e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -625 1 1 0.0000000000000000e+00 2.5559999999999999e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -626 1 1 0.0000000000000000e+00 2.6270000000000000e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -627 1 1 0.0000000000000000e+00 2.7689999999999998e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -628 1 1 0.0000000000000000e+00 2.8399999999999999e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -629 1 1 0.0000000000000000e+00 2.9820000000000000e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -630 1 1 0.0000000000000000e+00 3.0530000000000001e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -661 1 1 0.0000000000000000e+00 2.1299999999999997e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -662 1 1 0.0000000000000000e+00 2.2009999999999998e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -663 1 1 0.0000000000000000e+00 2.3429999999999996e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -664 1 1 0.0000000000000000e+00 2.4139999999999997e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -665 1 1 0.0000000000000000e+00 2.5559999999999999e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -666 1 1 0.0000000000000000e+00 2.6270000000000000e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -667 1 1 0.0000000000000000e+00 2.7689999999999998e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -668 1 1 0.0000000000000000e+00 2.8399999999999999e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -669 1 1 0.0000000000000000e+00 2.9820000000000000e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -670 1 1 0.0000000000000000e+00 3.0530000000000001e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -1357 2 2 0.0000000000000000e+00 3.9770131272893146e+01 4.0580591120931842e+01 3.3811761388540051e+00 0 0 0 -1221 2 2 0.0000000000000000e+00 2.2708342795292712e+01 3.3221736150438296e+01 3.3451382093491389e+00 0 0 0 -1222 2 2 0.0000000000000000e+00 2.3396487107318492e+01 3.2042295196340525e+01 3.4145513916976573e+00 0 0 0 -1223 2 2 0.0000000000000000e+00 2.4817670649919656e+01 3.2034530155048230e+01 3.4304589568028843e+00 0 0 0 -1224 2 2 0.0000000000000000e+00 2.5571857207588916e+01 3.3245967884896203e+01 3.5315248273562414e+00 0 0 0 -1225 2 2 0.0000000000000000e+00 2.6990634993293764e+01 3.3236192789314657e+01 3.5046078481041278e+00 0 0 0 -1226 2 2 0.0000000000000000e+00 2.7709288223369445e+01 3.2016919698946744e+01 3.3653429857923562e+00 0 0 0 -1227 2 2 0.0000000000000000e+00 2.9120571247026906e+01 3.2010737646615482e+01 3.3151932876975621e+00 0 0 0 -1228 2 2 0.0000000000000000e+00 2.9838321541991451e+01 3.3245102073277884e+01 3.3746363697091670e+00 0 0 0 -1229 2 2 0.0000000000000000e+00 3.1252501351674507e+01 3.3222425793351832e+01 3.4029917754450976e+00 0 0 0 -1356 2 2 0.0000000000000000e+00 3.8384775990302415e+01 4.0602554459820929e+01 3.3762591319141868e+00 0 0 0 -1261 2 2 0.0000000000000000e+00 2.2712625569670447e+01 3.5707400935557935e+01 3.4252196207475665e+00 0 0 0 -1262 2 2 0.0000000000000000e+00 2.3434475751590707e+01 3.4486776424327985e+01 3.3667972684042997e+00 0 0 0 -1263 2 2 0.0000000000000000e+00 2.4878904258454984e+01 3.4470589958679206e+01 3.4336010249501219e+00 0 0 0 -1264 2 2 0.0000000000000000e+00 2.5535340431333200e+01 3.5685263196182127e+01 3.4805719627145870e+00 0 0 0 -1265 2 2 0.0000000000000000e+00 2.6933913262063935e+01 3.5660850044272742e+01 3.4921276282318963e+00 0 0 0 -1266 2 2 0.0000000000000000e+00 2.7719137482986209e+01 3.4443567105791040e+01 3.4685493427550314e+00 0 0 0 -1267 2 2 0.0000000000000000e+00 2.9126814361492244e+01 3.4456658145754304e+01 3.3916720610961493e+00 0 0 0 -1268 2 2 0.0000000000000000e+00 2.9834443599295501e+01 3.5686448532444103e+01 3.4156027062399326e+00 0 0 0 -1269 2 2 0.0000000000000000e+00 3.1247531943860235e+01 3.5694919452204843e+01 3.3595935086342550e+00 0 0 0 -1355 2 2 0.0000000000000000e+00 3.7660963433901934e+01 3.9405291206286215e+01 3.4021847404833574e+00 0 0 0 -1301 2 2 0.0000000000000000e+00 2.2693727564543853e+01 3.8155105255902342e+01 3.4434175902753283e+00 0 0 0 -1302 2 2 0.0000000000000000e+00 2.3412800285367112e+01 3.6933426490585667e+01 3.4548237872403154e+00 0 0 0 -1303 2 2 0.0000000000000000e+00 2.4820676863329883e+01 3.6899219903936107e+01 3.4022804711937087e+00 0 0 0 -1304 2 2 0.0000000000000000e+00 2.5559365234764812e+01 3.8125075868326228e+01 3.4382445233246268e+00 0 0 0 -1305 2 2 0.0000000000000000e+00 2.6958824744486357e+01 3.8122557286232805e+01 3.4498274763198546e+00 0 0 0 -1306 2 2 0.0000000000000000e+00 2.7681149510395333e+01 3.6914941032773754e+01 3.5213618111514315e+00 0 0 0 -1307 2 2 0.0000000000000000e+00 2.9106023869247093e+01 3.6909413690978042e+01 3.4523201143157762e+00 0 0 0 -1308 2 2 0.0000000000000000e+00 2.9832830100812142e+01 3.8134359886507411e+01 3.5205998286959312e+00 0 0 0 -1309 2 2 0.0000000000000000e+00 3.1246582039487343e+01 3.8152425799119733e+01 3.4043638366633036e+00 0 0 0 -1340 2 2 0.0000000000000000e+00 2.1312428153705216e+01 4.0540820530250208e+01 3.5961796364012395e+00 0 0 0 -1341 2 2 0.0000000000000000e+00 2.2733190905826582e+01 4.0586956606456241e+01 3.5383373472500583e+00 0 0 0 -1342 2 2 0.0000000000000000e+00 2.3439055848092561e+01 3.9343946447086267e+01 3.4343730120530220e+00 0 0 0 -1343 2 2 0.0000000000000000e+00 2.4842086919650185e+01 3.9373670268067286e+01 3.4809384697642791e+00 0 0 0 -1344 2 2 0.0000000000000000e+00 2.5578674835634711e+01 4.0588471112727561e+01 3.4607251703572195e+00 0 0 0 -1345 2 2 0.0000000000000000e+00 2.6985039004746881e+01 4.0603869720765893e+01 3.6242457266109969e+00 0 0 0 -1346 2 2 0.0000000000000000e+00 2.7659004485898830e+01 3.9378022133684439e+01 3.5337673784176897e+00 0 0 0 -1347 2 2 0.0000000000000000e+00 2.9100865858265152e+01 3.9338198746794724e+01 3.5887561802250647e+00 0 0 0 -1348 2 2 0.0000000000000000e+00 2.9866611181511725e+01 4.0569443835239035e+01 3.6897866158670904e+00 0 0 0 -1349 2 2 0.0000000000000000e+00 3.1276722533825453e+01 4.0567605066119064e+01 3.4650876486485096e+00 0 0 0 -551 1 1 0.0000000000000000e+00 3.1949999999999999e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -552 1 1 0.0000000000000000e+00 3.2659999999999997e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -553 1 1 0.0000000000000000e+00 3.4079999999999998e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -554 1 1 0.0000000000000000e+00 3.4789999999999999e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -555 1 1 0.0000000000000000e+00 3.6210000000000001e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -556 1 1 0.0000000000000000e+00 3.6920000000000002e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -557 1 1 0.0000000000000000e+00 3.8339999999999996e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -558 1 1 0.0000000000000000e+00 3.9049999999999997e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -559 1 1 0.0000000000000000e+00 4.0469999999999999e+01 3.1973657907721474e+01 0.0000000000000000e+00 0 0 0 -560 1 1 0.0000000000000000e+00 4.1179999999999993e+01 3.3203413981095380e+01 0.0000000000000000e+00 0 0 0 -591 1 1 0.0000000000000000e+00 3.1949999999999999e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -592 1 1 0.0000000000000000e+00 3.2659999999999997e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -593 1 1 0.0000000000000000e+00 3.4079999999999998e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -594 1 1 0.0000000000000000e+00 3.4789999999999999e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -595 1 1 0.0000000000000000e+00 3.6210000000000001e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -596 1 1 0.0000000000000000e+00 3.6920000000000002e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -597 1 1 0.0000000000000000e+00 3.8339999999999996e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -598 1 1 0.0000000000000000e+00 3.9049999999999997e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -599 1 1 0.0000000000000000e+00 4.0469999999999999e+01 3.4433170054469279e+01 0.0000000000000000e+00 0 0 0 -600 1 1 0.0000000000000000e+00 4.1179999999999993e+01 3.5662926127843185e+01 0.0000000000000000e+00 0 0 0 -631 1 1 0.0000000000000000e+00 3.1949999999999999e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -632 1 1 0.0000000000000000e+00 3.2659999999999997e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -633 1 1 0.0000000000000000e+00 3.4079999999999998e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -634 1 1 0.0000000000000000e+00 3.4789999999999999e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -635 1 1 0.0000000000000000e+00 3.6210000000000001e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -636 1 1 0.0000000000000000e+00 3.6920000000000002e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -637 1 1 0.0000000000000000e+00 3.8339999999999996e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -638 1 1 0.0000000000000000e+00 3.9049999999999997e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -639 1 1 0.0000000000000000e+00 4.0469999999999999e+01 3.6892682201217085e+01 0.0000000000000000e+00 0 0 0 -640 1 1 0.0000000000000000e+00 4.1179999999999993e+01 3.8122438274590991e+01 0.0000000000000000e+00 0 0 0 -671 1 1 0.0000000000000000e+00 3.1949999999999999e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -672 1 1 0.0000000000000000e+00 3.2659999999999997e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -673 1 1 0.0000000000000000e+00 3.4079999999999998e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -674 1 1 0.0000000000000000e+00 3.4789999999999999e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -675 1 1 0.0000000000000000e+00 3.6210000000000001e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -676 1 1 0.0000000000000000e+00 3.6920000000000002e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -677 1 1 0.0000000000000000e+00 3.8339999999999996e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -678 1 1 0.0000000000000000e+00 3.9049999999999997e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -679 1 1 0.0000000000000000e+00 4.0469999999999999e+01 3.9352194347964890e+01 0.0000000000000000e+00 0 0 0 -680 1 1 0.0000000000000000e+00 4.1179999999999993e+01 4.0581950421338796e+01 0.0000000000000000e+00 0 0 0 -1230 2 2 0.0000000000000000e+00 3.1981155822083064e+01 3.1981210986853860e+01 3.3898236776194257e+00 0 0 0 -1231 2 2 0.0000000000000000e+00 3.3380888762363170e+01 3.1961996918059349e+01 3.4755844640537239e+00 0 0 0 -1232 2 2 0.0000000000000000e+00 3.4085786307563332e+01 3.3183012713700968e+01 3.5324546759518047e+00 0 0 0 -1233 2 2 0.0000000000000000e+00 3.5506977742747381e+01 3.3197027662992433e+01 3.4899944788601260e+00 0 0 0 -1234 2 2 0.0000000000000000e+00 3.6236456386981104e+01 3.1969071940928742e+01 3.3522961391945501e+00 0 0 0 -1235 2 2 0.0000000000000000e+00 3.7634765388836300e+01 3.1996087142445379e+01 3.2853448757253152e+00 0 0 0 -1236 2 2 0.0000000000000000e+00 3.8354365984089192e+01 3.3230003767601055e+01 3.3176321072920332e+00 0 0 0 -1237 2 2 0.0000000000000000e+00 3.9765107672744108e+01 3.3191227402859276e+01 3.4199209220714790e+00 0 0 0 -1238 2 2 0.0000000000000000e+00 4.0439454986054969e+01 3.1980408730467371e+01 3.4520731528186985e+00 0 0 0 -1239 2 2 0.0000000000000000e+00 4.1881551561025034e+01 3.1975086990164659e+01 3.4768925856162980e+00 0 0 0 -1270 2 2 0.0000000000000000e+00 3.1991387610486882e+01 3.4436668193135986e+01 3.3726036128432204e+00 0 0 0 -1271 2 2 0.0000000000000000e+00 3.3401661608082605e+01 3.4423057111931229e+01 3.4571855217226677e+00 0 0 0 -1272 2 2 0.0000000000000000e+00 3.4071503276565160e+01 3.5658161664952388e+01 3.5016400000853234e+00 0 0 0 -1273 2 2 0.0000000000000000e+00 3.5502752121048545e+01 3.5715560901385601e+01 3.5110392785003124e+00 0 0 0 -1274 2 2 0.0000000000000000e+00 3.6185791249513905e+01 3.4462226653750072e+01 3.4326465540830045e+00 0 0 0 -1275 2 2 0.0000000000000000e+00 3.7634951910596115e+01 3.4434580928755906e+01 3.3667148080286373e+00 0 0 0 -1276 2 2 0.0000000000000000e+00 3.8347560246516785e+01 3.5680205016498689e+01 3.3821358029345401e+00 0 0 0 -1277 2 2 0.0000000000000000e+00 3.9767568342752966e+01 3.5672741455182702e+01 3.4538491687478712e+00 0 0 0 -1278 2 2 0.0000000000000000e+00 4.0502929925813724e+01 3.4361670502852483e+01 3.4902725767775182e+00 0 0 0 -1279 2 2 0.0000000000000000e+00 4.1905549560517272e+01 3.4393678197707423e+01 3.4463992495902116e+00 0 0 0 -1310 2 2 0.0000000000000000e+00 3.1953081112184517e+01 3.6925181041964741e+01 3.3875894505844508e+00 0 0 0 -1311 2 2 0.0000000000000000e+00 3.3357802552799050e+01 3.6915543955455263e+01 3.4157880345603764e+00 0 0 0 -1312 2 2 0.0000000000000000e+00 3.4098134272166455e+01 3.8127490360084302e+01 3.4069701426380403e+00 0 0 0 -1313 2 2 0.0000000000000000e+00 3.5520447549100460e+01 3.8173949525187325e+01 3.4619407165885776e+00 0 0 0 -1314 2 2 0.0000000000000000e+00 3.6223856485294682e+01 3.6919744184134956e+01 3.4792425959973921e+00 0 0 0 -1315 2 2 0.0000000000000000e+00 3.7652069020893919e+01 3.6915864502319387e+01 3.4691962168060173e+00 0 0 0 -1316 2 2 0.0000000000000000e+00 3.8388171312473062e+01 3.8183556080019407e+01 3.4733237483479407e+00 0 0 0 -1317 2 2 0.0000000000000000e+00 3.9805237379467385e+01 3.8135073348973123e+01 3.4822460697958189e+00 0 0 0 -1318 2 2 0.0000000000000000e+00 4.0451164257139283e+01 3.6914258614216152e+01 3.4491376461819718e+00 0 0 0 -1319 2 2 0.0000000000000000e+00 4.1872894484434745e+01 3.6877837475638344e+01 3.3898613741036661e+00 0 0 0 -1350 2 2 0.0000000000000000e+00 3.1968753150668913e+01 3.9349446152426076e+01 3.4252710592829096e+00 0 0 0 -1351 2 2 0.0000000000000000e+00 3.3388196728171557e+01 3.9353558550630140e+01 3.4253614226471578e+00 0 0 0 -1352 2 2 0.0000000000000000e+00 3.4075521679422330e+01 4.0609252997778007e+01 3.4283597228905442e+00 0 0 0 -1353 2 2 0.0000000000000000e+00 3.5492174142302531e+01 4.0619103681185308e+01 3.4964156543164049e+00 0 0 0 -1354 2 2 0.0000000000000000e+00 3.6212867910165670e+01 3.9405943929044476e+01 3.4458717571272075e+00 0 0 0 -702 2 2 0.0000000000000000e+00 2.3459374716015247e+01 4.1797558487683609e+01 3.5281538445815994e+00 0 -1 0 -703 2 2 0.0000000000000000e+00 2.4875504104630480e+01 4.1805481503394326e+01 3.4318018950701159e+00 0 -1 0 -707 2 2 0.0000000000000000e+00 2.9139986282698125e+01 4.1809050997344393e+01 3.6678514330791265e+00 0 -1 0 -718 2 2 0.0000000000000000e+00 4.0483832209098175e+01 4.1791104657469177e+01 3.4274065398253004e+00 0 -1 0 -719 2 2 0.0000000000000000e+00 4.1923017580789121e+01 4.1762634972745587e+01 3.4057923253719480e+00 0 -1 0 - -Velocities - -1 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -2 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -3 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -4 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -5 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -6 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -7 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -8 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -9 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -10 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -41 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -42 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -43 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -44 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -45 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -46 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -47 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -48 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -49 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -50 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -81 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -82 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -83 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -84 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -85 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -86 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -87 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -88 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -89 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -90 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -121 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -122 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -123 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -124 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -125 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -126 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -127 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -128 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -129 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -130 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -162 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -163 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -166 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -167 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -170 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -681 2.7121467171028604e+00 -5.7802903969089270e+00 2.3731182228866987e+00 -980 1.5120764187685223e+00 6.4575664529614993e+00 1.3161289056694985e+00 -940 3.3925856593004364e+00 -1.5711749564473014e+00 2.3437635327109146e-01 -684 5.5670722994728843e+00 3.3450119350076264e+00 7.2179095224004142e-01 -685 -4.7492291928930488e+00 3.2086399446994553e+00 -1.8707354719563732e-01 -1011 1.7963290924663460e+00 1.9099589859584460e+00 5.3637634621223951e+00 -1010 -5.6799501921878299e+00 2.8696488463871228e-01 -7.7368227120583599e-01 -688 6.1238036837807908e+00 -1.1908566916994829e+00 -6.7840611612051038e+00 -689 5.0126164767013428e+00 -6.4782044920256954e-01 -8.5798996246826764e-01 -720 3.2702707093925745e+00 4.4813004367723375e-01 -1.3465073365423517e+00 -721 -1.6095252508185061e+00 5.0823048725637987e-01 5.1637411601889327e-01 -722 1.5582206750893826e+00 -4.0063578099552446e+00 -2.1525090760241616e-01 -723 6.0959569237262254e+00 4.4019564803117088e+00 2.3973161445407714e+00 -724 -7.4078621751903606e-02 -1.4421067559133767e+00 -1.3320793968223330e+00 -725 -2.2638207054745201e+00 1.8002395897645160e+00 -1.2270423318886114e+00 -726 -9.2517003619090765e-01 -7.9954394849526507e+00 -1.7899340597010103e+00 -727 7.1086757698455347e+00 -1.0092752361867667e+00 -5.9836662531284945e+00 -728 -1.0242454286416991e+00 -5.6098441618248618e-03 1.0798169880975328e+00 -729 -3.8255919720020595e+00 -1.6745039721877033e+00 6.9479193832568797e-01 -760 -4.5500294763446680e+00 -2.1349666999280542e-01 -3.8148094310224638e+00 -761 -5.5490995933734810e-01 -5.8801221609765175e+00 7.6210980762793907e+00 -762 -3.7292972461625591e+00 4.0898508449919042e+00 -4.3072139028843432e+00 -763 3.8936243367132537e+00 -2.9724953967442844e+00 5.1213701284499598e+00 -764 1.2327152601792943e+00 1.8618154375580755e+00 2.4251062695876286e+00 -765 -8.5989240833672582e+00 1.7514446383699382e+00 4.5432662229177623e-01 -766 7.1518575383087706e+00 1.3406562824612306e-01 5.4855295488545308e-01 -767 3.4225215493826884e+00 -2.6003501634039159e+00 2.0597346232656524e-01 -768 6.8807144013774701e+00 2.1285225877840679e+00 1.2896759568073700e-02 -769 -5.9926741912136867e+00 2.1273660752978341e+00 -2.7769727669454070e+00 -1019 2.2842493918540825e+00 -4.6709781322555139e+00 1.8980078891663681e+00 -801 -2.2744730582457584e+00 5.6483426900493079e+00 -3.8369992670553477e+00 -802 -3.1004984626138339e+00 5.7761603832491177e+00 3.5137633412868730e+00 -803 -1.0760795837320780e+00 -4.6488537989112890e+00 -2.2809938718284042e+00 -804 4.4722648395463471e+00 -3.3808554236968948e+00 -4.2470580326793765e+00 -805 2.9021217889823028e+00 -1.4855325298952593e+00 1.4948707422907899e+00 -806 1.5776467773857067e-01 3.3462202060372097e+00 3.1534907682733180e+00 -807 2.0785153633181563e-02 -4.4212022171283234e+00 -2.0672360790918956e+00 -808 3.6790900968677933e+00 2.6837215415216149e+00 -6.3322330690634843e-01 -809 -6.2502121735723586e+00 1.4225352297802716e+00 -1.0771356717306113e+00 -1018 8.3887963664739051e-01 1.0829536276760932e+00 -2.6491753129242488e+00 -842 -2.4685053224419780e+00 7.3550514468628303e-01 -3.3773188100691858e+00 -843 -5.0639346924551294e+00 2.0361818903555826e+00 4.5915654106941597e+00 -846 8.3686610047729004e-01 -1.5182959992007541e+00 1.9792560854958108e+00 -847 -2.9253183770817452e+00 5.8163165903815006e+00 -5.3763565221558913e+00 -11 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -12 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -13 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -14 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -15 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -16 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -17 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -18 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -19 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -20 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -51 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -52 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -53 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -54 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -55 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -56 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -57 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -58 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -59 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -60 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -91 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -92 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -93 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -94 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -95 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -96 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -97 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -98 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -99 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -100 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -131 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -132 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -133 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -134 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -135 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -136 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -137 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -138 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -139 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -140 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -171 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -174 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -175 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -178 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -179 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -979 -4.0021296586073496e-01 -4.6551107164323744e+00 -4.1571166428880751e-01 -978 2.1028760921058027e+00 2.5441698338796499e+00 8.1465934109244609e-01 -692 -1.3475628443346443e+00 -3.4705727600162426e+00 -3.3909389478520975e+00 -693 -1.5569993933709747e-01 1.3543417786405332e-01 3.5634761898185388e+00 -977 2.9379615134828159e+00 2.1317349811663857e+00 4.1737615918828315e+00 -976 1.1402979299057363e+00 1.5993318965936687e+00 -1.5299482858519349e+00 -696 -5.4623094791000444e+00 2.3125861261982799e+00 5.9575018875865871e+00 -697 5.2832365066179126e+00 1.6620914692958451e+00 -1.6574266239876996e+00 -975 -9.1950905467765867e-02 1.9854874340583417e+00 -2.5331015746979793e+00 -974 5.7619835096228744e-01 -4.3388316380894993e+00 1.4192342239212280e-01 -730 9.6727178572714656e-01 5.2631436851473339e+00 -1.2111395094446353e+00 -731 -5.0108651595036080e-01 1.9983803343560527e+00 7.0663025630622156e-02 -732 6.4647256925267342e+00 -1.9245339397571417e+00 4.9982000717999560e+00 -733 -1.6900119898831507e+00 -1.3935110694656094e+00 -4.1483999124032049e+00 -734 3.0953029859804717e+00 -6.4620115533795031e-01 -5.7010518447236507e+00 -735 -1.8630539709318772e-01 2.6468139984018304e+00 -2.1245156261084164e-01 -736 -8.0155099932684948e-01 -1.5903117544333296e+00 1.2412088404828925e+00 -737 5.9836047147602012e-01 -4.4117857147328499e-01 9.5647564176289468e-01 -738 4.6812651857276064e+00 5.2190570002848986e+00 1.4062364769587306e+00 -739 4.3286517040237422e+00 1.5284364134899544e+00 3.0446726446666275e+00 -770 -5.3654093930857627e+00 1.8119479036353647e+00 -3.5703872099295362e+00 -771 -1.8767225037750748e+00 2.8957922731931496e-01 -6.9624842016239397e-01 -772 -5.6842173004470531e-01 -1.2339999342845764e+00 5.1160760307968429e+00 -773 3.6433661714136987e+00 1.0866142735401052e+00 -3.2142094845052340e+00 -774 -4.7711002837453638e+00 5.9595849691172651e+00 -7.0174618239301711e-01 -775 -4.0587331098344270e+00 8.5114122776272594e-01 -2.3671479749401509e+00 -776 3.5237718389373951e-01 8.0417701124460672e-01 1.1918948521234261e+00 -777 -1.2669230391651465e+00 -7.7118318739096301e+00 -1.7955462388950405e+00 -778 1.2273850751715738e+00 2.2278074563497001e+00 1.6875278210388189e+00 -779 -8.2465049039799982e+00 8.9575208004220896e-01 4.6398149516345990e+00 -810 4.7097021775709319e-01 6.0392028475082702e+00 4.8300381555559193e+00 -811 4.7923171448605784e+00 4.3048956379478671e+00 6.1458949262376139e-01 -812 -2.9710783803918197e+00 6.4690486884977672e-01 1.7039233712842878e+00 -813 -6.4292908216643312e+00 -1.1082159066766530e+00 -3.2883300404076476e+00 -814 -2.2092966377078755e+00 3.1856235411285514e+00 1.9757005386859674e+00 -815 1.7094065837100991e-02 -2.1813940312399200e+00 -2.1043992788103836e+00 -816 -2.3074208780688492e+00 3.3870123898614435e+00 -3.0328363338128135e+00 -817 5.1547617919447859e+00 -9.4814203719207168e-01 3.6214375263555447e+00 -818 -3.8142197533942546e-02 9.0864952131770096e+00 -1.5549579750641014e+00 -819 3.0053173539348013e+00 1.6772330982648089e+00 -5.1147865916159079e+00 -850 -4.0414025007924304e-01 2.5476159272380063e+00 1.4633468107647367e+00 -851 -1.2046089620054448e+00 -1.4129869461876248e+00 -1.4128085297289839e+00 -854 -3.0024504577531608e-01 1.1563349615451752e+00 1.0767525169355392e+00 -855 4.0143202100256072e+00 -8.0464320875522510e+00 -1.2427981535173509e+00 -858 -1.5673567766828361e-01 6.7534550778574509e-01 -2.9071879208868721e+00 -859 -2.8544029022579567e+00 1.7236105847866928e-01 -4.6171532049634090e+00 -161 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -164 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -165 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -168 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -169 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -201 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -202 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -203 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -204 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -205 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -206 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -207 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -208 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -209 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -210 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -241 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -242 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -243 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -244 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -245 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -246 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -247 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -248 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -249 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -250 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -281 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -282 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -283 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -284 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -285 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -286 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -287 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -288 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -289 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -290 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -322 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -323 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -326 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -327 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -330 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -841 -7.8608706753249868e-01 3.2745998202713946e+00 -8.0730115336120933e-01 -844 3.8855606716382396e+00 3.9316203483264873e+00 -4.7050906928865199e+00 -845 2.0685189891262468e+00 -1.1239404534812034e+00 -7.6429783747536650e-01 -848 -8.7775560717191459e-01 -7.7095073473273956e+00 5.3643864102486312e+00 -849 -9.6852766400861512e-01 -2.4193797984861165e+00 -4.1860648293450406e+00 -1015 2.7153047525354563e+00 -2.4460385954702106e+00 -1.6043101040311105e+00 -881 6.5282058135329635e+00 -4.9504641313324314e+00 6.1123211772793207e+00 -882 -2.0406888164968850e+00 -2.9463799983456198e+00 -1.6629191042004785e+00 -883 2.9125294607035186e+00 7.0851520531048151e-01 1.3652001533856339e+00 -884 -4.9004197778236419e-02 -1.7165438905293615e-01 1.5502047085524544e+00 -885 -4.4230815936240768e+00 -3.8478133226220192e+00 -6.8580864569011366e+00 -886 1.6353276862550832e+00 5.0742201647157605e+00 1.0053580024934425e+00 -887 -2.9106894643997250e-01 -6.0816085848534251e-01 3.0185858175082050e+00 -888 -2.8502766686273855e+00 6.0442552481069933e+00 -3.1146206886555623e+00 -889 3.0086883248528493e+00 -5.3069746161302467e+00 6.3809027314870272e+00 -920 1.6908672858546205e+00 -1.2496412665302605e+00 -5.5437697403567976e-01 -921 -8.6261679165016092e-01 2.0598089322923110e-01 3.1596152595431528e+00 -922 -8.4090091489958319e-01 -1.3644368981429713e+00 3.4566163298037300e-01 -923 2.3067090327985835e+00 4.1113938537095054e+00 -2.2629458645959000e+00 -924 2.6343296993681147e+00 3.0009006071154465e+00 3.2862413049275045e+00 -925 1.8546500435735018e+00 -4.5642550440964874e-01 1.1084222460882456e+00 -926 -2.8395954382564192e-01 5.9866239442823321e+00 -4.1200960115219827e+00 -927 2.0662899577094418e+00 -1.1880878317486467e+00 8.0505385895261850e-02 -928 -5.8316151383667947e+00 1.4359054857212672e+00 -1.2622417832514629e-01 -929 2.2496618398687915e+00 -3.4566857227053341e-02 -4.0106322697247689e+00 -960 3.8955366646974547e+00 8.0678755121431567e-01 -1.0916914391655477e+00 -961 -1.0878642323402912e+00 -2.3831349572299381e+00 -1.0801248210895116e+00 -962 2.4116693730084218e+00 5.2604387478623531e+00 2.7873752369719709e+00 -963 1.4524875121483123e+00 -7.6131763116014706e-01 1.9074712566835150e+00 -964 -4.3656130626388001e-01 -4.1821077253789891e+00 -6.7315083912656046e+00 -965 -3.5227215781757444e+00 3.2818172292484142e+00 7.3904817976061006e+00 -966 -2.8043067080929196e-01 -8.6098953673465406e-01 7.1282270656459024e-01 -967 -2.5102585349107143e-01 -3.8500553824635695e+00 9.6273261260599929e-01 -968 -4.8397992593613797e+00 6.3315845084227829e-01 4.1482532481612706e+00 -969 5.5994291460365819e-01 -1.7769226158682355e-01 -2.8641210413438491e+00 -1014 -1.5174482817269783e-01 -1.1899978642464673e-01 -9.2317902379731931e-01 -1002 -2.7081201005183919e+00 7.8568765388316351e+00 -4.4196717031027264e+00 -1003 3.7722369634280688e+00 -6.3062097663286449e+00 3.5562994528354550e+00 -1006 4.5199525750536971e+00 -5.3862228612024028e+00 5.1804764676280870e+00 -1007 2.5677872202657681e-01 -5.5448845945299094e+00 1.8932299464703710e+00 -172 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -173 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -176 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -177 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -180 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -211 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -212 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -213 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -214 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -215 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -216 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -217 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -218 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -219 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -220 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -251 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -252 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -253 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -254 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -255 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -256 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -257 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -258 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -259 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -260 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -291 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -292 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -293 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -294 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -295 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -296 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -297 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -298 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -299 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -300 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -331 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -334 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -335 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -338 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -339 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -852 -2.0282092377397967e+00 -1.6096395110490027e+00 5.8711409106092172e-01 -853 4.0883951670525773e+00 -2.8887189269748097e+00 -3.8457645145146269e+00 -856 -3.8841910177275958e+00 -2.7613192650418781e+00 2.5592676064342843e+00 -857 -1.6473918307184277e+00 -4.1702257926360113e+00 3.9692735487216511e+00 -890 5.6128215438773434e+00 -3.8507044954884111e+00 3.6330908687757385e-01 -891 -1.1916172322955663e+00 2.0546358022989186e+00 -4.1041572495369252e+00 -892 2.7794837704538198e+00 -2.4867513452745986e+00 -7.4238766278935033e+00 -893 -9.7255167459011371e-01 7.0229829929991778e+00 -4.6482978469354225e-01 -894 5.1350477940873229e-01 -2.2456196527133439e+00 -1.8833016749270115e+00 -895 2.4218872437182233e+00 -1.0654434385033502e+00 2.2418500783694104e+00 -896 8.4055565118072320e+00 -3.8438509195756621e-01 4.7923731380427836e-01 -897 -8.0245236825346233e-01 -1.7300091009756227e+00 -1.9553113796646540e+00 -898 6.4000560869959973e+00 2.0409908129557064e-01 2.5729869230322890e+00 -899 2.3208808636151010e+00 1.3297936562838191e+00 5.3717977718211678e+00 -930 -3.4045753838907737e+00 -3.9317853191923708e+00 5.4833486829425144e+00 -931 6.6409400439401498e+00 2.5845302237460510e+00 1.3283589463628014e+00 -932 1.5702128649476281e+00 2.4635881749491793e+00 -1.8322991618100839e+00 -933 1.3750313416583140e+00 2.0989077157957050e+00 7.7791584006073589e-01 -934 -4.9748284396938391e+00 -1.1797792851824001e+00 4.6121114737438607e+00 -935 -2.3442163449884861e+00 -3.3535609366228210e+00 -7.1673153625477704e-01 -936 3.5437796856500583e+00 3.0753574203323408e+00 -2.1764665422999516e+00 -937 -1.7043495990662025e+00 1.2362801542137110e+00 -5.6431677163542443e-03 -938 4.0681949193285947e+00 5.6127469297621735e+00 -6.6886693974365379e+00 -939 7.6671587981289999e+00 4.5642101522276080e-01 -5.9402850789034733e+00 -970 -7.5152665859500818e+00 -4.6246403597051797e+00 8.0317543252316537e-01 -971 3.1442159720468119e+00 -2.7390581862322710e-01 5.4513687446138253e+00 -972 -7.8710437000388123e-01 3.9800938174372313e+00 -3.8103922151255594e+00 -973 4.7863249854674728e-01 -3.3414701428477489e+00 -1.6453227952788860e+00 -1001 2.5392705299321083e-02 -5.1323035614109003e+00 1.8418821399378726e+00 -1004 2.4209089011460350e+00 3.1575773358918979e-01 -1.5287221028911948e+00 -1005 2.9605984030402128e+00 2.0294748012022730e+00 1.3208367272886984e-01 -1008 -3.3069909828565476e+00 1.1868730962663760e+00 -8.5309222923673833e-01 -1009 -5.0118399069958297e+00 -1.7141113935238921e+00 -4.6481721565286040e+00 -1012 6.2754787286214764e-01 -1.9112308584684294e+00 -6.7008668403276031e-02 -321 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -324 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -325 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -328 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -329 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -361 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -362 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -363 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -364 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -365 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -366 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -367 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -368 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -369 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -370 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -401 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -402 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -403 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -404 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -405 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -406 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -407 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -408 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -409 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -410 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -441 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -442 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -443 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -444 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -445 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -446 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -447 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -448 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -449 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -450 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -481 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -482 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -483 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -484 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -485 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -486 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -487 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -488 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -489 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -490 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1300 -2.9699034318278899e+00 -3.1798672981763625e+00 5.3779681015568883e+00 -1260 5.0658610146843550e+00 3.4707758350429879e-01 3.1245050300338049e+00 -1220 2.5423272257585969e+00 3.3267229088859818e+00 -1.4682039014480428e+00 -1180 3.4272020875664837e+00 -1.5790194895520364e+00 1.8274297910739412e+00 -1100 4.3217338067401556e+00 -7.6873510795398738e+00 2.9390881793764061e+00 -1339 -3.2142447398387790e+00 -6.3553329385735440e+00 2.4059299480228362e+00 -1041 -1.9896635739553732e+00 3.1410558606142427e+00 -5.3673762288539562e-01 -1042 2.0954332939445108e+00 -6.0507650276253608e+00 -6.3287862859538441e-02 -1043 4.5478005091666784e-01 -6.2482957022433112e+00 -2.7174397367886312e+00 -1044 -5.2743489342554648e+00 -2.8217839293388458e+00 6.8968820448433341e+00 -1045 3.0811408913429226e+00 -3.5808745422631700e+00 -6.4066416370929415e+00 -1046 -1.9965613046301489e+00 -2.9866904753916259e+00 -5.7168714799086728e-01 -1047 -9.2909221958592558e-01 -3.4194285770116615e+00 2.7222166895452844e+00 -1048 6.2792556938603017e+00 3.8182730908541549e+00 4.0840664195387681e+00 -1049 -5.6469779792702237e+00 -1.0484107490094079e+00 -5.2439294759629433e+00 -1338 -3.5819705508309778e+00 -1.5026811652361576e+00 4.7432507728111233e+00 -1081 6.5896978789941931e+00 -5.2740626174371412e+00 1.8705454826124206e+00 -1082 6.7328108009122811e-02 -2.1561523710663595e+00 -8.5652678806389426e-01 -1083 -1.3893663406374139e+00 -1.1160492573934833e+00 2.5954796601263569e-01 -1084 3.2161929373426181e+00 2.8129579376269733e+00 1.9697968832515129e+00 -1085 -2.8007278551635961e+00 5.2761885071640959e+00 3.8729090333957319e+00 -1086 6.0807977513069122e+00 -7.8011550295865817e-01 5.6834680794586303e+00 -1087 -3.3475382217405318e+00 4.3855362593698253e+00 2.7856774956447938e+00 -1088 3.9602584597000203e+00 -5.9354075891487312e+00 1.0717047358627891e+00 -1089 -1.7020366944294563e+00 2.1878196815990867e+00 -1.0238097779175788e+00 -1120 -4.7226812537971863e-01 2.7053624031692385e+00 -3.2651958208577181e+00 -1121 -4.0759298099510737e+00 -5.9746845627961713e+00 8.2404451571583914e-01 -1122 2.6390656635987941e+00 -4.2142761970680764e+00 -6.2778876822175267e+00 -1123 2.8108259495086423e+00 -4.2432508340818016e+00 2.4765833186643818e-01 -1124 -2.3291634444044034e+00 -2.5628645722162444e+00 9.3652288107952075e-01 -1125 -3.1517308553070456e-01 3.4688741695665831e-01 2.3208945550843745e+00 -1126 -1.3720046335180638e+00 -4.2279327731173062e+00 -1.0136609360317481e+00 -1127 3.2987027521150130e+00 -6.9668843395607620e+00 -7.2514767121107537e-01 -1128 1.3584386406742779e+00 -2.4424878111243333e+00 -1.7963679953804115e+00 -1129 -4.7938526147072436e+00 3.3254901282405567e+00 6.0862234882928208e+00 -1337 -2.9843229779378473e+00 -1.0813422593923658e+00 -2.2179172829037173e+00 -1161 9.8867132328517215e-01 -1.2782597539885403e+00 3.9096827685907476e+00 -1162 4.7576868096423972e+00 3.4444110292567798e+00 -3.5527939934250528e+00 -1163 -1.1206143914892113e+00 -4.2452866628288138e-01 3.4278948857352272e+00 -1164 -2.9374450220191179e+00 -1.0160217715424982e+00 -6.0507515745563021e+00 -1165 2.8315135565822414e-01 -5.8105740435259152e+00 1.8077219800705460e+00 -1166 3.4623926089160317e+00 1.7292688226928363e+00 6.3858854927896658e-01 -1167 -2.8678589316804741e+00 9.3123970793054678e-01 3.8044921129337406e-01 -1168 4.5090603172549981e+00 -3.0441418538816269e+00 -2.1327918094165271e-01 -1169 -7.6145540712755588e-01 1.7777439483440707e+00 2.4670064581119098e+00 -1336 1.5884368684847665e+00 -2.5121431584763791e+00 -2.6476184338629376e+00 -332 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -333 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -336 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -337 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -340 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -371 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -372 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -373 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -374 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -375 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -376 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -377 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -378 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -379 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -380 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -411 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -412 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -413 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -414 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -415 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -416 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -417 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -418 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -419 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -420 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -451 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -452 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -453 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -454 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -455 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -456 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -457 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -458 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -459 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -460 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -491 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -492 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -493 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -494 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -495 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -496 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -497 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -498 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -499 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -500 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1332 -6.1148531002633055e-01 1.4052458562886434e+00 4.2206177558836400e+00 -1013 -2.7721225176186257e+00 -1.6478365492982845e+00 8.1771949609146457e+00 -1016 -2.4976062485179251e-01 6.8940017565174188e+00 -1.8577089682772470e+00 -1017 -1.1401600108522987e+00 4.1166187963477148e+00 6.0894714873971034e-01 -1050 7.2215934158853989e-01 -2.1255349280856581e-02 -4.3037485504751851e+00 -1051 -2.6081316883093617e+00 -9.7666675013980839e-02 6.2816748286186872e+00 -1052 3.7806592255478124e+00 3.4599704562907019e-01 7.9574668356452039e+00 -1053 -3.9834167981745896e+00 -2.6411786808675384e+00 3.7895165227270247e+00 -1054 -1.6888461017108201e+00 -1.7258039388722946e-01 -2.4442722217638728e+00 -1055 -3.2834642503028162e+00 5.5750954119112883e+00 -1.8909763518063074e+00 -1056 -3.9599811655447265e-01 -4.9090975837388209e+00 3.7986553142754258e+00 -1057 -4.2656028542137037e+00 1.1194695419936220e+00 2.2815126681531139e+00 -1058 3.0538419658264142e+00 -1.8090069692916519e+00 7.4345777304115435e-01 -1059 -9.8841185374043916e-01 -1.3488134454090606e+00 -5.2330848433536978e+00 -1090 4.6491578264810114e+00 1.2134401714245033e+00 1.8251353983102703e+00 -1091 3.2361412374507459e-02 3.6048205683773471e+00 1.4124372487355146e+00 -1092 -4.1791763141407676e+00 -1.7590962406662365e+00 -3.1490444243840696e+00 -1093 -4.4747615238569498e+00 2.3829381275160766e-01 6.2828193682056932e-01 -1094 1.0340246018956791e+00 2.5054905075009928e+00 3.9358271631243187e+00 -1095 5.3729180687085387e-01 -1.2223839090645769e+00 3.5610473384100789e+00 -1096 2.0533557255465191e+00 4.6339875464056011e+00 3.0027724681423953e+00 -1097 -1.1296900441345568e+00 -2.3574093544803500e+00 4.1111658303447411e+00 -1098 1.6264450535683606e+00 2.0589540847162882e+00 -1.5073727081291242e+00 -1099 -3.3650523033493500e+00 7.3831464907365003e+00 -2.0024506550590626e+00 -1130 -5.2186620311721366e-01 8.2455015687613309e-01 -3.7921022238245476e+00 -1131 -1.0812747632299140e+00 -3.0247152145057776e+00 -2.4321308211958201e+00 -1132 2.7964553932558883e-01 1.9125297335898537e+00 4.0492552949695026e+00 -1133 -7.1625350889463011e+00 4.0847656935608612e+00 4.5243943148108654e+00 -1134 7.5502722402044009e+00 -4.0509738697016312e-01 7.0583595196099658e-01 -1135 -1.8484974859666896e+00 -5.7175712753033130e+00 3.3661498050592078e+00 -1136 -3.8548845864300203e+00 -6.4951936237146919e+00 -3.5750682542039764e+00 -1137 -2.4176159193600530e+00 1.3781952204557644e+00 -3.6216028909610150e+00 -1138 1.9386408981010348e+00 -4.7190448620390431e+00 -3.4684388426477413e+00 -1139 -1.4442329168205786e-01 -3.5527993100143829e+00 -2.9843796955263430e-01 -1170 1.6637186807120546e-01 5.0682001819196101e+00 -5.0295789000840312e+00 -1171 1.4275902259643662e+00 -3.4822593355412956e-01 2.5300519453354888e+00 -1172 2.6425149932787568e+00 7.3125057197472532e-01 2.6842346031930022e+00 -1173 6.6216183707528513e+00 1.5316391673740437e-01 -7.9087221107788885e-01 -1174 -4.9273210939836547e+00 -4.9863484963601246e-01 6.4473435878794696e+00 -1175 2.0938771136811987e+00 1.6697348059452390e+00 2.4844022035472206e+00 -1176 -1.9759321620349055e+00 1.1382758946778719e+00 -2.0791124927139841e+00 -1177 1.6313810009937770e+00 4.3177809280144510e+00 -3.2852182095627334e+00 -1178 -3.8340300498593742e+00 4.8903885690634230e-01 4.7964050466875294e+00 -1179 3.0699161380229221e+00 5.0339411196281567e+00 2.7118873343518675e+00 -521 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -522 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -523 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -524 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -525 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -526 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -527 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -528 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -529 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -530 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -561 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -562 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -563 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -564 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -565 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -566 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -567 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -568 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -569 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -570 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -601 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -602 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -603 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -604 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -605 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -606 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -607 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -608 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -609 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -610 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -641 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -642 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -643 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -644 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -645 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -646 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -647 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -648 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -649 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -650 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1201 5.4257773789591486e+00 9.2679931057399678e-01 -2.5619853641735029e+00 -1202 1.5966772738604438e+00 8.4394748881107517e+00 -3.3044919133293362e+00 -1203 6.5412872225918428e-01 -8.3961069713845013e+00 5.0505340921486497e-01 -1204 -2.7949477740642754e+00 -5.1663608041643405e+00 -2.5887943809764566e+00 -1205 7.6478432294171483e-01 -3.6586578369894700e+00 2.6115079832583654e-01 -1206 -1.0210470008733896e+00 1.6860150250565886e+00 -1.4345211747259980e+00 -1207 -4.7088199873753958e+00 2.1378099397841757e-01 1.4533219848456320e+00 -1208 -1.4089478394798758e+00 4.9144321578661163e+00 2.7325824887775008e-01 -1209 4.4838676107321280e+00 -2.8941685239416710e+00 6.1643314856835740e+00 -1335 1.2879600184300350e+00 6.3859435903277451e-01 4.3544687584387303e+00 -1241 -2.8149107563889348e+00 2.4238466761460962e+00 4.3911999076183399e+00 -1242 6.9484868588996340e-01 -2.6362000015517397e+00 2.5876046893831486e+00 -1243 -3.2855194775168239e-02 1.3152326173757782e+00 3.2016790143770613e+00 -1244 8.7506194802867245e+00 4.0974422968761610e+00 -3.9590716992116750e+00 -1245 1.3295159110046071e+00 -1.9874070771874512e+00 -1.5163806465952985e+00 -1246 1.8445218050460255e+00 2.3636621302624277e+00 -2.4687494146998308e+00 -1247 -2.9098358980079125e-01 -9.6711346942462395e-01 -4.0740621738834477e+00 -1248 -8.2987298680467330e+00 -2.0225816001928711e+00 -2.1349791731948833e+00 -1249 1.1815262604524268e+00 -6.1865929783563067e-01 3.3509303683908933e+00 -1334 -4.2880099112366676e-01 4.9481132012766587e+00 6.2184334488200932e-01 -1281 -1.6174094338294265e+00 5.7429466726317386e+00 4.0078353247151952e+00 -1282 4.5788428155399430e+00 -4.8004448396038777e+00 3.6819871164076118e-01 -1283 -5.9050391155278048e-01 6.9172884991845129e-01 1.8646595041521632e+00 -1284 9.8263468810856147e-01 5.3345155217036284e+00 3.2275764320448070e+00 -1285 -1.9230396324850827e+00 -1.1173716673375953e+00 -1.6406967314214427e+00 -1286 -2.5575624996387258e+00 -3.3466980980542177e-01 2.2351700845762246e-01 -1287 5.4268065524959370e+00 -8.6259594011650242e-01 4.4344219420132642e+00 -1288 -2.5844056624458045e-01 1.6458103725196196e+00 -2.4851155192626577e+00 -1289 4.0726726122476071e+00 -4.9507865548839247e-01 3.5835558587945231e+00 -1333 -2.1030986045209024e+00 1.0519945096063406e+00 -5.7012168202252980e+00 -1321 3.6791905156802982e+00 5.1174465157418272e+00 3.6108007199044518e+00 -1322 5.2650748477131204e-01 2.9934116398925104e-01 -5.2990033987359542e-01 -1323 1.6282415056587198e+00 8.8973352362029079e+00 2.1494811302056509e+00 -1324 3.7696038520411537e+00 2.1483785521837286e+00 1.6341883528954142e+00 -1325 2.0478251130789671e-01 5.4276663121628834e+00 -6.1298486269134171e+00 -1326 -6.9801074168905075e-01 -7.8066598601932036e-01 -4.6857072664957400e+00 -1327 -2.3593772209715249e+00 8.7146434552816321e-01 -2.9866680455500441e+00 -1328 2.7864629710344885e-01 4.3621638240313843e+00 2.1339271072925112e+00 -1329 9.6002480223063613e-01 -3.5693724517830558e+00 3.6483762089100478e+00 -1360 4.8353886275887259e+00 -5.5307431259967252e+00 1.4204533135284829e+00 -531 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -532 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -533 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -534 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -535 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -536 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -537 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -538 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -539 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -540 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -571 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -572 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -573 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -574 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -575 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -576 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -577 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -578 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -579 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -580 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -611 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -612 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -613 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -614 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -615 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -616 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -617 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -618 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -619 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -620 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -651 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -652 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -653 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -654 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -655 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -656 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -657 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -658 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -659 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -660 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1210 1.8987503170374838e+00 5.0292169131580877e+00 4.6968212653299818e-01 -1211 1.4417759711004952e+00 -1.4121916102787677e+00 -2.5132738414602707e+00 -1212 -3.0147552314135613e+00 6.3259294717303827e-01 2.9884306870363115e+00 -1213 2.7084385583425798e+00 2.1713619646036082e+00 5.5705433210843882e+00 -1214 -2.5833549677167320e+00 2.9897722198052881e+00 5.6401265526957003e+00 -1215 4.6229330398651394e+00 -3.9305735116218123e+00 5.1861953195794035e+00 -1216 -1.5915808938258698e+00 -9.2047205426974177e-01 5.0684464479910858e+00 -1217 1.3048215730329518e-01 -2.1401392313219616e+00 -6.3411363743279781e-01 -1218 -1.8387079257136758e+00 -2.2761594358456483e+00 1.1890016138098460e+00 -1219 -5.6833680595006939e+00 4.3725675142380585e+00 7.3897010230185822e-01 -1250 1.5087627892791355e+00 -8.8922949078414415e-01 1.9685462383729715e+00 -1251 -5.6816765119124590e-01 5.5497659719881764e-01 4.4894484225743083e+00 -1252 -3.0938005343920474e+00 -3.6496904996795814e+00 -3.9848928757647419e+00 -1253 -1.2618444163265548e+00 3.9959024117987191e-01 8.2982576113551687e-01 -1254 8.7097045053508804e-01 -3.6225788385451456e+00 2.6663009797917976e+00 -1255 -1.7612896177502289e+00 3.3339265544066210e+00 -6.0596441414820945e-01 -1256 3.8044731467355568e+00 2.6685189146587978e+00 -7.2964775284503762e+00 -1257 -5.9697120541360409e+00 9.2337036792439409e-01 2.6812911865502489e+00 -1258 -1.4433660232960825e+00 6.5837760654381867e+00 -3.3069373694917925e-01 -1259 2.5388434403706253e+00 4.8672314150629310e+00 -1.3586147351388833e+00 -1290 4.6851617066406162e+00 3.7789694042163937e+00 2.9384898428914177e+00 -1291 -1.6648979729555902e+00 3.9708757003798163e+00 4.4542164331501937e+00 -1292 -2.9104836143183155e-01 1.9291107695399523e+00 -1.3089993039925458e+00 -1293 1.1630730205950914e+00 -3.2829254097533878e+00 -1.7378657989705371e+00 -1294 2.2201044422463356e+00 2.0152982468201479e+00 1.5964996294789016e-01 -1295 6.3661066901726404e-01 1.0394172057796469e-01 -4.8872364644475486e+00 -1296 1.8113326551810651e+00 2.2304196991817427e+00 -5.1713065686775010e+00 -1297 4.2487601013228717e+00 2.3262924632282989e-01 3.2519651618114374e+00 -1298 -1.3180125426468698e+00 2.3439136555130404e+00 -1.1949945698585487e+00 -1299 2.1741982789385927e+00 -5.2866379748191754e+00 -5.2730545203706018e+00 -1330 4.4065596931204984e+00 -3.2658335840382411e+00 -4.5796116892116912e+00 -1331 -3.2890641442705468e+00 8.7106490330165762e+00 -1.1927779206178901e+00 -682 3.6073620698284707e+00 -8.8590182565642905e-01 1.9348130817641751e-01 -683 -3.3666944069595690e+00 -1.2964826704242787e+00 4.7788678201277932e+00 -686 -4.0053885490762493e+00 -5.6225780318733403e+00 -2.2886199726524112e+00 -687 3.9265900198019090e+00 -5.1701765685337806e+00 1.5869765994502039e+00 -690 -8.8542542256296275e-01 8.4469486036138459e+00 -6.5569346687301087e+00 -691 -5.9453981103718103e+00 7.1516097467619026e+00 -2.5248670560152342e+00 -694 7.1792849008515813e-01 2.8870083237315449e+00 3.0829389885639880e+00 -695 -3.2513621493482145e+00 -7.0507951854334505e-02 9.7568949773447811e-01 -698 7.9537775649273117e+00 -4.2134023491106121e-02 3.3440956114486138e+00 -699 -4.2771524166146389e+00 5.9122113750714442e+00 5.4005866269182945e-01 -21 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -22 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -23 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -24 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -25 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -26 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -27 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -28 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -29 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -30 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -61 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -62 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -63 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -64 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -65 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -66 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -67 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -68 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -69 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -70 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -101 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -102 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -103 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -104 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -105 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -106 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -107 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -108 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -109 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -110 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -141 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -142 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -143 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -144 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -145 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -146 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -147 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -148 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -149 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -150 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -182 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -183 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -186 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -187 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -190 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -700 4.4116855754045226e+00 -1.5020715527350470e+00 -2.5843612588943626e-01 -701 -5.1030967222217374e+00 -7.5932746972068230e+00 5.3968657496113988e+00 -1000 2.1671511893913324e+00 -3.5052907030225683e-01 1.2600995766061061e+00 -880 -2.1691265187029096e-01 -3.0731907566214325e+00 -4.4627597243684987e+00 -704 -2.3011572399138847e+00 -2.3606658847746407e+00 -6.1277948018585011e+00 -705 -1.8326073784852734e+00 -4.1046723260575728e+00 4.1517454744698867e-02 -706 -2.5160004030843672e+00 -1.9025130210506040e+00 4.9421282420720605e+00 -840 2.1934408157221759e+00 4.0854372498911502e+00 -4.6917231905244821e+00 -708 3.3116872685269176e+00 4.9658613527386164e+00 1.7719103855188825e+00 -709 -7.2207505426062717e+00 3.6629937830716219e+00 2.0565748452061485e+00 -740 -1.1406665371146434e+00 1.3373319232168233e+00 -6.6898526195690868e+00 -741 -2.8665534170025566e+00 8.5921151533989999e+00 4.1594226615631706e+00 -742 -5.1588021441993712e+00 2.2226411623428342e+00 1.4382376014986082e+00 -743 2.7503805410768112e+00 7.4094878241955069e+00 5.7558509804395230e-01 -744 4.9794961900839114e+00 2.4229916036362356e-01 8.2840090428698543e-01 -745 -5.2687113384114754e+00 7.7078809163461202e+00 -3.1458696436466647e+00 -746 -3.9188008717810621e+00 3.3699335074217900e+00 4.9031243050817892e+00 -747 2.2100528663828745e+00 3.6179174009749175e+00 -8.9265613587604886e-01 -748 1.5123408620258041e+00 -1.2622974116423016e+00 3.6275161804441387e+00 -749 -5.2232940688367488e+00 -1.9783024887437266e+00 4.0172651674048829e+00 -780 -4.2251992950642130e+00 2.5572919340817508e+00 5.6867501635344393e+00 -781 -7.9862916926293552e+00 2.3698578817160461e+00 9.8732063646323109e-01 -782 5.6807577813565224e-01 3.1656110668074278e+00 2.0829934838336922e-02 -783 1.2782561061253110e+00 2.6066773999436849e-01 4.8618045511877037e+00 -784 4.1879949888093568e+00 4.1233248927671005e+00 -6.6018391712010462e+00 -785 -3.7930696819380261e+00 -2.2630152177515770e+00 -5.5882635320411982e+00 -786 2.1575139149878906e+00 -1.4924536876936569e+00 -1.1498553710722359e+00 -787 -2.6327213967915362e+00 -2.8885356717947843e+00 -3.0506296985647330e+00 -788 3.8874291526791507e+00 3.7977804595860096e+00 -2.5010501417314908e+00 -789 1.6399885595549586e+00 -4.7463318035059299e+00 1.2998360390846568e+00 -820 3.0585720179875970e+00 -3.5531518187068789e+00 -2.2789170800490073e+00 -821 -1.5391050131707182e+00 2.7990478385347108e+00 1.3613563499393417e+00 -822 -2.0394973177135984e+00 1.8279038798855847e+00 -2.6379470970515313e+00 -823 4.9650383618498370e+00 2.3366855364644984e-01 8.3150981919701361e-01 -824 -3.2719678376469807e-01 4.1517148664366923e+00 -6.5200104066478843e+00 -825 6.2209131545344496e+00 -1.2844269443577570e+00 -1.3990259470779276e-01 -826 -2.1969307536332083e+00 -1.1425270045515337e+00 1.2315087148524642e+00 -827 7.3623852644165400e-01 -5.9599637798502663e+00 3.7473532539795635e+00 -828 -4.9220501517478361e+00 1.6238437958744101e+00 -3.9458944199327073e+00 -829 -5.7492282167143518e+00 6.1261082172830650e-01 -1.0284641202897224e+00 -862 -1.6147685780294230e+00 -4.9728689876224513e-01 2.8402707546379484e+00 -863 2.9310778275429739e-01 1.8376333474646014e+00 4.4400515320227241e+00 -866 3.4374535944899627e+00 3.9631414538612081e-01 3.8330968309961024e+00 -867 5.2054700843883079e+00 2.4077525293273170e+00 1.5476848163965500e+00 -31 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -32 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -33 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -34 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -35 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -36 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -37 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -38 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -39 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -40 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -71 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -72 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -73 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -74 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -75 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -76 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -77 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -78 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -79 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -80 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -111 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -112 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -113 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -114 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -115 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -116 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -117 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -118 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -119 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -120 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -151 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -152 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -153 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -154 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -155 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -156 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -157 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -158 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -159 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -160 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -191 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -194 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -195 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -198 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -199 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -710 -5.9503701618688929e+00 2.4367905862788617e+00 -3.3474931653480580e+00 -711 -2.7502082157113801e+00 4.6648222087066422e+00 2.2361365039788486e+00 -712 9.3664875358307265e-01 4.9867542270623080e+00 1.4065911441586865e+00 -713 4.6674495538142349e+00 3.7672649215719671e+00 1.7801139381592170e+00 -714 3.9318875468072472e+00 -3.1767795810729114e+00 -3.5327531578816935e+00 -715 4.9909255771427818e-01 -7.9691542634337453e-01 3.1289216785501810e+00 -716 -5.2752318170013366e+00 7.2972958537707990e+00 7.3618902933209274e-01 -717 -6.1864745832978878e+00 -2.4434892748021220e+00 -3.2783675087577331e+00 -800 3.1821290720747557e+00 1.2275969183969007e+00 6.7344074724049818e+00 -1035 1.4183457389459320e+00 3.2774659101940564e+00 1.0138194457766858e+01 -750 4.2411765846475085e+00 1.1281263281278311e+00 -4.1501533414609471e+00 -751 5.8438949290870235e-02 -8.8299802552270314e+00 -4.7286056932485893e-01 -752 -2.9427657540804542e+00 -1.9798330500295269e+00 -4.2567472382597753e+00 -753 3.7743812612262290e-01 3.5497001846684845e-01 -2.6899668934118282e+00 -754 -1.3571506526275130e+00 8.6235735161312750e+00 1.2347095811812439e+00 -755 2.0593238671937959e+00 7.8796856322861624e+00 1.0756198027006551e-01 -756 1.2656659987224486e+00 -3.8625339088471575e+00 3.7182021753136874e+00 -757 2.0490485075005687e+00 1.5735231769276674e+00 2.1728325901801644e+00 -758 7.4219334459477135e+00 2.3937190918298827e+00 2.7334774437566495e-01 -759 -2.2208596535813565e+00 -2.1317911759354158e+00 1.3836112202442326e+01 -790 -1.7033430722900058e+00 2.6579097552843440e+00 3.3669740213263091e+00 -791 -3.4809467488049695e+00 8.6210660546501194e-01 -2.5838649364510942e+00 -792 -2.7943364414455165e+00 -1.4346375845371933e+00 -4.9037075824864766e+00 -793 -3.8193739682923189e-01 5.9179944692631758e-01 1.5850300051616593e+00 -794 5.6792437281184753e+00 1.6633897075601550e-01 1.9626318404973651e+00 -795 3.2314902889340630e-01 1.7658142175269270e-01 5.2564859745081322e-02 -796 -9.3232953582846845e-01 1.7685932474264270e+00 2.5414420208825725e+00 -797 -1.2922883277349788e+00 -2.9358020986839652e+00 2.4820182795993708e+00 -798 -2.7304597296377180e+00 1.6192932862788312e-01 1.0842033129247908e+00 -799 3.5362836221860410e+00 4.6512637109479158e+00 2.8723733252930335e+00 -830 5.5050470356848524e-01 -4.0752344692941360e+00 -3.8656831575198658e+00 -831 7.9284024170181766e-01 1.5839595303962395e+00 -7.4643853177416242e+00 -832 -3.6360033257191033e+00 -2.3082140951842587e+00 -1.2642869853101599e+00 -833 -2.4221437670694574e+00 -3.0076847746614268e+00 2.1409378749643144e+00 -834 -3.4725426354194791e+00 -9.8079789186491761e-01 -5.0806330448204884e-01 -835 3.5214012039156284e+00 1.0417582029661843e+00 -2.7809426177253229e+00 -836 6.0200258331738681e+00 1.1502198364824605e+00 -4.4990447709213068e+00 -837 -1.3034083674520602e+00 3.6637833247300189e+00 -3.4389096222056876e+00 -838 2.3630141293916682e+00 3.5611088075200601e+00 1.6441872336438670e+00 -839 4.5891247315852296e-01 -3.5500818326434600e+00 -2.5552898383606322e+00 -870 1.2496503346507208e+00 -1.8360772785988186e+00 -2.8554164712735436e-01 -871 -2.4985771273515165e+00 3.3993850522297091e+00 1.2103531243809216e+00 -874 -1.1123136315417741e+00 -2.0862441748033196e+00 1.7246832649167076e+00 -875 -4.5869976638215570e+00 3.1823714591840604e+00 -4.7965034093126464e+00 -878 2.1917195271834982e+00 -5.4775873581685390e+00 3.1134264964872247e+00 -879 2.7413801370208130e-01 -5.1718706305789475e+00 4.5989713761425088e-01 -181 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -184 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -185 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -188 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -189 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -221 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -222 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -223 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -224 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -225 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -226 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -227 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -228 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -229 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -230 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -261 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -262 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -263 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -264 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -265 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -266 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -267 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -268 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -269 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -270 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -301 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -302 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -303 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -304 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -305 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -306 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -307 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -308 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -309 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -310 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -342 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -343 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -346 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -347 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -350 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -860 -4.2125386158237266e-01 -2.9854371925557004e+00 -4.5283640194322166e+00 -861 -1.2167104818769618e+00 6.7728343666777646e-01 -2.3077538812768941e+00 -864 -6.2239726204879426e+00 2.5129088347554172e+00 5.1637184810036620e+00 -865 -4.4120270584115548e+00 2.9032777145620146e+00 2.7359690850355158e+00 -868 -3.0577548750502381e+00 -2.6900966656451458e-01 3.7211455326895546e+00 -869 -4.4645305250044132e+00 1.1581434553120729e+00 3.4258302019223827e+00 -900 1.5048611343277232e+00 5.9315376945218041e+00 3.8280317039605314e+00 -901 -3.9205958674613486e+00 6.5858316361285363e-01 1.9964131575567980e+00 -902 -3.8435553854418201e+00 1.0448547847895950e+00 4.8217195268497415e+00 -903 2.5136085512781965e+00 -3.9723881775582006e+00 -5.3424960002962907e-01 -904 4.4905151508088892e+00 3.0981900797362920e+00 -8.4023965234196127e-02 -905 6.8421504568270231e-01 -2.6238737279163571e+00 -4.3211128158401220e+00 -906 3.1778066950336248e-01 2.8371198050548180e-01 -1.2139791027134639e-01 -907 6.3518721165024266e+00 6.9706243351821540e-01 3.5516495004845932e+00 -908 6.6998608062643683e-01 -3.7888917782097864e+00 3.6283940084444399e-01 -909 -1.3428409156484251e+00 3.1481480717937638e+00 -2.4264525778167028e+00 -1039 -3.9063788729290227e-01 -6.3766135574067639e-01 -7.1980180988430229e+00 -941 -6.5380713708401050e-01 -1.9526093188467164e-01 3.7752796903245693e+00 -942 1.9008610210266106e+00 2.1285377518475332e+00 1.8295056683675541e+00 -943 -1.7546984190896429e+00 -1.6685588914504317e+00 2.3181234637932975e+00 -944 -2.4458967235905960e-02 -4.5587894571033016e-01 -4.6765692065706386e+00 -945 -2.1860344986817126e+00 -2.2559809074084916e+00 -5.5060223050658337e+00 -946 1.2006005113384624e+00 -3.2196620293450824e+00 1.2745192700286068e+00 -947 -7.4856756465875629e-01 -2.4224488951883880e+00 7.1247023994293790e-01 -948 -3.1471071019973273e-01 -1.2172457924637956e+00 7.7346415308119565e-01 -949 -3.0775033253585145e+00 5.7745945975580684e+00 4.3959122327570483e+00 -1038 7.6104547715012449e-01 -4.2754603357482610e+00 1.9946209391429757e+00 -981 5.9367112467315080e+00 -3.8644675401203252e+00 -3.3523918573378957e+00 -982 -7.8703116572757048e-01 1.8594047850049442e+00 2.3420540629661102e-01 -983 -5.1923492564489315e+00 1.7444957266364418e+00 -5.1473346767297068e-01 -984 3.9095708175028405e+00 1.0669273158869592e-01 3.2864137981159751e+00 -985 -3.7544621527232908e-01 2.3518314557217659e+00 -4.7662034898273351e+00 -986 -4.1843878404787045e+00 -3.3923485127620934e+00 3.9888536265013532e+00 -987 1.6213056965731054e+00 2.2771720872152521e+00 6.6921479115869731e-01 -988 3.1789382428488739e+00 -3.7608013930613451e+00 -3.5775195766457673e+00 -989 -3.3296422583902534e+00 2.1376880291258935e+00 2.7921719224479156e+00 -1022 -1.1135020605544121e+00 1.4726427971549774e+00 5.7800817288722861e+00 -1023 1.2120094461836788e+00 1.2736446079046337e+00 3.3202193787952519e+00 -1026 9.5697925267228157e-01 -3.3827961397857451e+00 2.5399454167703222e+00 -1027 -3.4195948360036876e+00 3.8560877008128014e-01 -6.2147357689657867e-01 -192 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -193 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -196 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -197 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -200 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -231 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -232 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -233 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -234 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -235 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -236 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -237 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -238 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -239 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -240 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -271 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -272 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -273 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -274 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -275 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -276 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -277 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -278 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -279 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -280 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -311 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -312 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -313 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -314 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -315 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -316 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -317 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -318 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -319 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -320 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -351 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -354 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -355 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -358 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -359 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -872 9.4616760147151364e+00 -2.9653714448680706e+00 3.0886828810645944e-01 -873 1.5172690419406698e+00 -2.7844818180480484e+00 2.6418386121597748e+00 -876 2.2525544489939309e+00 -2.6160057536487198e+00 2.5775867526309164e+00 -877 -5.8108147541053219e+00 1.5959386379484293e+00 9.8470718815630159e-02 -910 -3.1292208264046741e+00 -2.4298746076630269e+00 -1.0795828115286543e+00 -911 3.2317860833624721e+00 -8.0281459531791810e-01 -3.0892450281781150e+00 -912 -1.7392902182851977e+00 9.6940224904331296e-01 3.2250564508175485e+00 -913 -8.0393743994089173e-01 -2.7057565308862026e+00 1.8121129133121516e-01 -914 9.8910165612661316e-01 -8.0418229627759601e+00 -2.6247420594480667e-02 -915 -2.4022065545066607e+00 -3.0386200686206339e+00 -7.1337146261013307e-01 -916 3.5997000281725500e+00 1.3212236698126787e+00 -1.0928163872919878e+00 -917 -1.3619682141854772e+00 2.5694495191256577e+00 7.9389905200097166e-01 -918 2.2254174056179541e+00 -4.0195736784604685e+00 3.4017999212085317e+00 -919 4.8232905929115821e+00 2.2978402706526833e+00 1.7130745110229493e+00 -950 8.1427993277871682e+00 2.5002996399387105e+00 -7.2038863542231379e-01 -951 -5.3105495551682957e-01 -1.4145300927163190e-01 1.2145657677165225e+00 -952 2.3844707462536219e-01 -1.2904673074498121e-01 1.6637452605636671e+00 -953 3.1411183945733927e+00 1.3940937156328310e+00 -2.7091140066898522e+00 -954 -4.0626779833362212e+00 -3.6655041792514242e+00 2.5554307348836286e-01 -955 1.6537677869672973e+00 -2.5822562174650896e+00 1.3188772709483676e+00 -956 6.6705531105819036e+00 -1.7944917318850573e+00 -3.8208021247162023e+00 -957 -4.0127841257777774e+00 7.1871084482012115e-01 3.0711168092789563e+00 -958 -2.5175151000339979e+00 1.9013644180828806e+00 -4.4942251051692503e+00 -959 4.2473016198097433e+00 -1.8646444107943123e+00 -3.1614484583601943e+00 -990 2.9206331511846071e+00 -5.6453223171094402e+00 -4.2835017353626199e+00 -991 -1.0122519048439758e+01 -1.5590208399234697e+00 4.8338510661857914e-01 -992 2.7921447045552004e+00 -4.6669872566781203e+00 -3.1246871999667873e+00 -993 1.7635091600767755e-01 1.3903498283181714e-01 8.1432599503299419e-01 -994 1.0802456615603602e+00 2.3816641398524929e+00 1.1119759949533521e+00 -995 -2.9512472033645558e+00 -6.1096441733759494e+00 -6.9972859315147371e+00 -996 3.3427575405151737e+00 -7.7108161305979062e+00 2.8987891790218705e+00 -997 1.4635776666237241e+00 1.1467371526209913e+00 -1.6957288926634373e+00 -998 -5.4015555409206384e-01 -5.1274797446424347e-01 1.6703318351127749e+00 -999 1.4063225937521517e+00 8.1589445137411509e-01 5.5250311406071893e+00 -1030 1.1201122117228328e+00 3.4128145470613780e-01 2.6229004415943242e+00 -1031 3.5477460534771192e+00 -2.1220027498336167e+00 -3.1528239171648376e+00 -1034 5.1588867500566948e-01 3.9524935591441119e+00 3.1619947484527269e+00 -1024 -9.3664967280765747e+00 2.5835637250023011e+00 4.3449676594399023e+00 -1025 -9.1018746366492864e-01 4.8942329453916322e-01 -1.6471100590186922e+00 -1028 -8.2959761007397992e-01 3.8460515491467082e+00 6.1004842025346429e-01 -1029 -2.3667556821707370e-01 -4.2389585522247923e+00 1.6300686699931113e+00 -1032 -8.2559999434545848e+00 -4.4382665829424299e+00 3.0845886665251898e+00 -1036 -1.6285197542178786e+00 4.9389423971176365e+00 -6.6066216296475631e+00 -1040 -2.2870652865680166e+00 -2.5080271005335928e+00 7.9409961715442368e-01 -341 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -344 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -345 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -348 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -349 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -381 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -382 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -383 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -384 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -385 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -386 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -387 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -388 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -389 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -390 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -421 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -422 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -423 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -424 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -425 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -426 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -427 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -428 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -429 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -430 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -461 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -462 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -463 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -464 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -465 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -466 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -467 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -468 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -469 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -470 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -501 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -502 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -503 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -504 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -505 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -506 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -507 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -508 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -509 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -510 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1020 -6.9690480610152261e-01 -1.1634829060490954e+00 -6.9703477443166655e+00 -1021 -1.6875389430797667e+00 -2.6513910040166735e+00 -3.5318568128586323e+00 -1320 2.9541296326467905e+00 -5.1215142338683215e+00 -2.7101661921986246e+00 -1280 1.1417792463664176e+00 4.4718034368487924e-01 -2.7172024088052771e+00 -1240 4.0396329868371907e+00 1.5204128955735232e+00 -2.0674862042108373e+00 -1200 -4.4435365999933314e+00 1.4760975654886912e+00 1.5130573645615231e+00 -1060 -5.1385665667799452e-01 8.9536765217458258e-01 -1.5171770027339480e+00 -1061 1.0344617878927886e+01 4.5633455393320927e+00 1.0200351088351470e+01 -1062 -4.2638704632331894e+00 5.0163281053663935e+00 -4.7910176569849181e+00 -1063 -7.7606326620193844e-02 1.4699560673943668e+00 3.2075625766403539e+00 -1064 1.1052725719042762e+00 -1.6528103532206813e+00 4.9785723870540357e+00 -1065 -5.1915474462744653e+00 -2.0234239867144730e+00 2.3188800309329176e+00 -1066 -4.9105966361118893e+00 -6.1469805802649171e+00 -2.5938652950656365e+00 -1067 -1.0112549976913572e+00 1.8414349259350424e-01 -3.6496707570213716e-01 -1068 1.3047663813675996e+00 2.8282823030985860e+00 -4.8096352576634009e+00 -1069 -4.0494461107580593e-02 -2.8557633336336687e+00 3.5477799381549153e+00 -1359 -1.1082386655535679e+00 2.9662457440658647e+00 6.7295840835726377e+00 -1101 1.7549470283013293e+00 -5.0254051471910897e+00 6.3521977051743868e+00 -1102 -2.8944557075666091e+00 -7.2109003791223458e-01 4.4426341252026230e-01 -1103 -3.7022092262126445e+00 -1.3157152281094560e+00 3.0587169839203177e+00 -1104 -3.5558866034990122e+00 -4.3558570031781016e+00 3.5413891552522023e+00 -1105 1.1368872347546601e+00 -2.2666996444362599e+00 1.4425758372430180e+00 -1106 3.4756879540641910e+00 -4.7847078906270308e+00 1.4983663347602183e+00 -1107 -1.6302682893599307e+00 -2.9694041135616436e+00 2.5617292858256717e+00 -1108 2.3976281021066024e+00 5.8298196733624437e+00 -3.3709839941924096e+00 -1109 -7.3186562409323197e-01 -1.1718208578788882e+00 2.7579859401693594e+00 -1140 -6.2941333630311014e-01 -6.6011663997911429e-01 4.0270140043560270e+00 -1141 -3.2152773025238126e+00 -3.4079987566313608e+00 3.7093108583555279e+00 -1142 7.1075066470436701e+00 1.9388478940734073e+00 3.6179701471947672e+00 -1143 -3.2422752586222399e+00 -9.1169715899558967e-01 -3.0786709323708035e+00 -1144 -1.9701809213785432e-01 -4.1367065930989275e+00 -3.7555732433300189e+00 -1145 -1.1331173324591572e+00 2.4814560473897154e+00 1.5295795601598443e+00 -1146 -3.3505955994622236e+00 -1.8561637371540429e-01 2.7283122801358881e+00 -1147 3.1535537228050550e+00 -9.6451917470264581e-01 2.6288285274125212e+00 -1148 -1.7289594650201652e+00 -9.1845693581998955e-01 2.7569162778728951e-01 -1149 -4.2975167771557032e+00 -1.7222983294575116e+00 -8.6162457103632697e+00 -1358 -1.1682171762362075e+00 -3.1203619941035061e+00 2.4552317273732784e+00 -1181 5.1758281397851773e+00 1.3792421510187292e+00 -1.0993763698159866e+00 -1182 1.8940840188237604e+00 1.3293009400114246e+00 1.4576521650167853e+00 -1183 4.1525426118038391e+00 -2.2702407862130780e+00 -3.1804731845326244e+00 -1184 1.3184763949802303e+00 -2.9412700094246578e+00 3.9529517010810844e+00 -1185 1.6731394150760444e+00 4.2733199490910421e+00 -6.4798258010382472e+00 -1186 -6.4742131244187435e+00 5.2209599500742065e+00 6.0362606808307628e+00 -1187 -6.1615621620637773e-01 -1.5790101930707197e+00 3.1014622826289289e+00 -1188 -1.1027221370533364e+00 2.9836630574239105e+00 1.9026143743382837e+00 -1189 5.2813793048206192e-01 3.8136677269293902e+00 6.9049049976427854e+00 -352 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -353 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -356 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -357 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -360 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -391 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -392 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -393 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -394 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -395 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -396 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -397 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -398 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -399 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -400 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -431 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -432 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -433 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -434 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -435 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -436 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -437 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -438 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -439 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -440 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -471 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -472 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -473 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -474 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -475 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -476 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -477 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -478 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -479 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -480 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -511 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -512 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -513 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -514 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -515 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -516 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -517 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -518 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -519 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -520 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1160 3.8147825926283558e+00 9.7410604885840435e-01 4.7579384555779587e+00 -1033 4.2972547589860168e+00 1.0033396581115848e+00 -6.1212193102261825e-01 -1080 -1.8519150063815464e+00 3.4671724979552550e+00 1.7089389270597914e+00 -1037 3.0130861955074932e+00 -4.1261238215154439e+00 5.4889538002763860e+00 -1070 -4.3450530704320327e+00 5.8208519025563703e+00 -5.0103290221423027e+00 -1071 2.2650310974069288e+00 1.4258009116599291e+00 -5.6977261853692376e+00 -1072 4.8387338279326975e-01 1.6659012181656516e+00 4.6392298402862098e+00 -1073 6.1617778074213545e+00 -2.7598644916811832e-01 2.4665993672274338e+00 -1074 2.6570899024360775e+00 9.8503534658575482e+00 3.8085454234491561e-01 -1075 5.3866992259056579e+00 2.0540703265020119e+00 -7.0438926835130677e-01 -1076 1.9188831742843329e+00 1.3664968522554688e+00 -7.9304048801645086e+00 -1077 3.4139660139045875e+00 -7.3466827713198022e+00 8.3465962811620695e+00 -1078 -6.3603636952017018e-01 -3.0640781054410686e+00 -3.1326890677520556e+00 -1079 1.8793083536402120e+00 3.3391453871734158e+00 1.5977564316801143e+00 -1110 1.0594078452359383e+01 2.1809830267521004e+00 4.8998535698612500e+00 -1111 -2.8535363862583729e+00 4.2929559545567626e+00 6.4414602828805756e-01 -1112 2.1619311588180761e+00 -2.0643428188312050e+00 1.3635361666450139e+00 -1113 -1.8940272492699411e-01 -3.7943603312797167e+00 -2.9593219138536314e-01 -1114 -1.6726951317465750e+00 3.1673623167475444e+00 -1.8880559267366714e+00 -1115 1.1104632227712519e+00 8.8327343138169123e-01 1.5763194005353016e+00 -1116 -1.3521064619611249e+00 -4.0273055196177809e+00 1.2109659230360099e+00 -1117 3.2862268227025138e+00 2.5250139126941509e+00 3.9818358668734721e-01 -1118 -1.4150439166542692e+00 -1.6779039298474545e+00 3.7541365334350387e+00 -1119 -3.8941085610001869e-02 -5.3094343339859507e-01 4.4068745315679342e-01 -1150 3.0989940770647837e+00 -1.3752374561353125e+00 -2.5205699071863683e+00 -1151 -1.9593222586166688e+00 -1.3127723270279450e+00 4.2341949619991066e+00 -1152 3.3997107375596941e-01 6.8998731056065177e+00 -3.2402887627763897e+00 -1153 -1.4313461786107400e+00 -1.0776550459052991e+00 5.7713982548430387e-01 -1154 1.1248362707237509e+00 5.5290001509797779e+00 -6.0757285217749919e+00 -1155 -8.0284790672859901e-02 -5.3544777054097619e+00 7.0139973021713931e-01 -1156 1.5130438537716075e+00 -3.8924268844532639e+00 -4.1258258797350686e+00 -1157 7.7998531791676229e-01 -3.4664833097211716e+00 1.5909251198245145e+00 -1158 -4.1479118928422913e+00 2.6833649205417598e-01 -8.2678766725503046e+00 -1159 -1.9935561342384589e+00 -3.3696580877516897e+00 2.7258099882611311e+00 -1190 -3.2000058156960924e+00 3.4124133416811504e+00 1.1795499708579211e+00 -1191 3.2991181182537415e+00 2.5110261931170874e+00 -4.5924314349219548e+00 -1192 1.4116537413942434e+00 -2.4542337083596005e-01 1.8200639390649029e+00 -1193 3.5871023660648826e-01 1.5130508768143267e+00 -1.9014216144580622e+00 -1194 -2.3024803306270225e-01 9.3254628914393389e-01 -4.1926861876090638e-01 -1195 9.2957008826156329e-01 2.3071598131459994e+00 4.0316572481536079e+00 -1196 -4.9402840947606963e+00 -2.6953092051339156e+00 5.3105816754157917e+00 -1197 -4.0916480731181559e-01 4.9439180676235841e+00 -2.4578508388929903e+00 -1198 4.9430249278559906e+00 -4.4556523408024840e-01 -3.1796626781985373e+00 -1199 3.4296725005548794e+00 9.2044973180518808e-01 9.2309381421396690e+00 -541 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -542 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -543 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -544 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -545 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -546 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -547 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -548 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -549 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -550 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -581 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -582 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -583 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -584 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -585 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -586 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -587 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -588 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -589 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -590 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -621 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -622 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -623 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -624 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -625 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -626 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -627 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -628 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -629 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -630 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -661 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -662 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -663 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -664 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -665 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -666 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -667 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -668 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -669 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -670 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1357 2.4557074739147278e+00 -2.5370070485041545e+00 2.3516263087932612e+00 -1221 5.2106139657064761e+00 -2.5319290012543103e+00 8.4555147406528501e+00 -1222 -6.6548653097248884e+00 -2.8980274305818332e+00 6.3026959488304934e-01 -1223 -3.0682192481720563e+00 2.9391367794171369e-01 -5.3289778025719174e+00 -1224 -4.9012173031638815e+00 4.1948391104854652e+00 1.7431431071967634e+00 -1225 -2.7733905446113694e+00 1.2937907763280709e+00 2.2623978885694554e-01 -1226 2.6391962643005713e+00 1.8962199864008804e+00 -1.4364538159388007e+00 -1227 -9.0767152560392206e-01 1.3228710888890864e+00 1.7457134020121559e+00 -1228 -2.2462284397061012e+00 1.8969346246093317e+00 3.2401198354788550e+00 -1229 -2.1790700572438930e+00 -9.1615146223189359e-01 1.6595159317394315e-01 -1356 9.2099960124372049e-02 -6.1528780525009807e-01 1.6955080083386529e+00 -1261 -5.3635073410725509e-01 -6.8120912239761444e-01 1.0246566152582151e+00 -1262 -6.8221844412631141e-02 2.4977391880883562e+00 1.9287455797819737e+00 -1263 -8.1179407604388079e+00 2.3955677467274978e+00 -3.7779716175496589e+00 -1264 3.1255755524624433e+00 -4.5705157180873650e+00 1.4430838805377260e+00 -1265 5.0505518621802796e+00 3.6702143965382712e+00 2.0915336158783528e+00 -1266 -6.1224354499754128e+00 -1.0848973956029371e+00 -2.9188361563302561e+00 -1267 2.4045636361999896e+00 -1.9385136424049740e+00 3.2744920542222138e+00 -1268 -1.4718867038063703e+00 -6.8361229541103645e+00 -1.3441887891501949e+00 -1269 -2.2317411178841593e+00 -7.8301776552788072e-01 2.2718091642530469e+00 -1355 4.2484456840161284e+00 -4.8066915798509608e+00 -3.0627859317881589e+00 -1301 -6.8276768427586632e+00 3.4445319833407306e+00 -4.5964017611593047e+00 -1302 2.6344211829249939e+00 6.2854310634003074e-01 -2.2646532558800594e+00 -1303 -1.3343395097351842e+00 -4.9881670627067214e+00 -1.1500975985637396e+00 -1304 -1.8687328130589270e-01 -7.4586502669405084e+00 -9.3257133952259375e-01 -1305 -4.9887517672964776e+00 -3.5312108978990171e+00 -1.1920448681072928e+00 -1306 -2.1969171593812720e-01 5.3789366153830427e+00 -1.3203685396346954e+00 -1307 -1.1030725626022862e+01 -4.9988696581343722e-02 1.8043058603087099e+00 -1308 1.7053245844179594e+00 -1.1063146701446700e+00 7.8741672685205044e+00 -1309 -5.4673436337662373e-01 4.8957291518445105e+00 1.2777702893237057e+00 -1340 1.6130671069209754e+00 6.7848942377909314e+00 -2.3927054188065435e+00 -1341 5.1924551193396695e-01 3.3358607000572342e+00 -3.3122566413653458e+00 -1342 -6.6786332791932992e+00 1.1150183229858013e+00 1.4144892469865940e+00 -1343 3.1798829476001114e+00 5.3017670016789573e+00 -3.1453585081319928e+00 -1344 -1.3267060053266675e+00 8.0915680557477820e-01 -3.9123514738225604e+00 -1345 1.7844821307971401e+00 -3.9443214625799095e+00 2.1482585943486772e+00 -1346 4.3003929962059306e-01 -6.4263064017195115e-01 -3.9430487734695341e-01 -1347 7.5971649147790687e-01 -2.5780193956084192e+00 2.5883981585510363e-01 -1348 1.5669615674219641e+00 -7.2734990810175866e+00 1.3008049118306981e+00 -1349 7.1676144078125392e-01 -2.7271334258534137e+00 4.8426672670114206e+00 -551 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -552 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -553 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -554 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -555 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -556 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -557 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -558 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -559 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -560 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -591 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -592 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -593 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -594 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -595 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -596 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -597 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -598 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -599 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -600 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -631 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -632 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -633 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -634 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -635 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -636 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -637 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -638 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -639 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -640 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -671 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -672 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -673 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -674 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -675 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -676 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -677 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -678 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -679 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -680 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 -1230 -2.9801365704864219e-01 -2.4024686775229083e+00 -2.0708282749005685e-01 -1231 -9.8695100267522928e-01 -3.9742667728572032e+00 -3.5906796248798925e+00 -1232 1.7853813903342868e+00 3.0089219068168003e+00 1.1957862040559939e+00 -1233 9.2592469772552057e+00 -2.3665864622399608e+00 -3.4549367626527294e-01 -1234 -5.5993867816648599e+00 -2.4366777111690006e+00 -6.1646341415745898e+00 -1235 -2.8502593267797964e+00 -3.6777510457761325e-01 1.2913238763503510e-01 -1236 -9.0617808402181748e+00 2.7296028575602533e+00 2.2126950363229856e+00 -1237 -1.4239693008055792e+00 -7.1225275033874880e-01 2.4112141543926693e-01 -1238 -3.4545321861678291e+00 1.8043668158708783e+00 -7.7148799520861635e+00 -1239 -5.9737188361738953e+00 -3.5529742237304696e+00 2.4995073865520108e+00 -1270 2.4537520073415857e+00 -4.1586446491623770e+00 -5.9462260302411201e+00 -1271 -2.2125963240633020e+00 1.4498605407537390e+00 1.8069391931067085e+00 -1272 2.0978743011077019e+00 -9.8794551058557312e-01 -3.2369623913641696e+00 -1273 5.9415979517875090e+00 -5.3553568339332769e-01 -5.8102268727574309e+00 -1274 -2.8459901680325719e+00 -2.0071011672846564e+00 -2.0553207770717333e-01 -1275 -1.2208801260623969e+00 1.5840263011301139e+00 -9.8489236082374598e-01 -1276 6.1339649286605171e+00 4.2956174626901191e+00 1.8429763288898429e-01 -1277 4.3564872036412865e+00 -6.3635999733177218e-01 3.9633618458895921e+00 -1278 -2.5314549046919219e+00 -7.8151252611879940e-01 1.4207941320458068e+00 -1279 -4.9749278415889373e+00 -2.6250289025125411e+00 3.9726498331296534e-01 -1310 -1.0613283925851399e-01 5.8329113204158443e+00 -1.6450991120936314e+00 -1311 -1.9907433640059573e+00 -3.0896495810995572e-02 -6.4288833611355694e+00 -1312 -1.2071748932660413e+00 1.5725096125180416e+00 5.3898276344755773e+00 -1313 -3.0955102763080951e+00 -8.3171981498895176e-01 4.0917865199497538e-01 -1314 -8.6895579798253619e-01 2.4320740243933034e+00 2.3492802417528131e+00 -1315 1.5186344317264668e+00 1.1139781359036012e+00 2.3145541793486188e+00 -1316 2.1759911433270878e+00 4.1041824116410943e+00 -3.4186664223320213e+00 -1317 -6.5350587951885752e-01 2.1728602362628364e+00 -9.3506091911896871e-01 -1318 2.2131446244985673e+00 3.4846267357002616e+00 -6.4099133208856796e-01 -1319 1.8624189621389606e-02 -3.1875630884833392e+00 -2.7924893382984890e+00 -1350 5.1066724601917080e-01 -4.0200837602680686e+00 -2.0822270907901546e+00 -1351 -3.8081985974687202e+00 -2.7821955752842173e+00 -4.9182226597878331e-01 -1352 2.0857113844710571e+00 4.0813756953869941e-02 3.5906572080150190e-01 -1353 -5.3587868971993551e+00 -3.5755757963624495e+00 1.5057299259293710e+00 -1354 -3.2945098909860357e+00 2.6921177397335487e+00 -1.7732742579875274e+00 -702 -9.5554272786823313e-01 -1.8050141704560814e+00 2.9407033173692434e+00 -703 3.7341478842454454e+00 2.5992645288123040e+00 -1.3108189187533481e+00 -707 -2.4750406135105125e+00 -1.0408436907294416e+00 1.9567288819932589e-02 -718 -1.6028707723827402e+00 1.3138068249639852e+00 -7.6381995716134812e+00 -719 -5.0993630474754168e+00 -3.1670782848510890e+00 3.7929821457460677e-01 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.airebo b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.airebo deleted file mode 120000 index 5d070dd3a4..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.airebo +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/CH.airebo \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo deleted file mode 120000 index b98001a7fd..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/CH.rebo +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/CH.rebo \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.1 b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.1 deleted file mode 100644 index b93108646e..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.1 +++ /dev/null @@ -1,137 +0,0 @@ -LAMMPS (8 Mar 2018) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 atom types so that inter- and intra-layer -# interactions can be specified separately -# read lammps data file -read_data Bi_gr_AB_stack_2L_noH_300K.data - orthogonal box = (0 0 0) to (42.6 41.8117 100) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 1360 atoms - reading velocities ... - 1360 velocities - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -mass 1 12.0107 # carbon mass (g/mole) | membrane -mass 2 12.0107 # carbon mass (g/mole) | adsorbate -# Separate atom groups -group membrane type 1 -680 atoms in group membrane -group adsorbate type 2 -680 atoms in group adsorbate - -######################## Potential defition ######################## -pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 -#################################################################### -pair_coeff * * rebo CH.airebo NULL C # chemical -Reading potential file CH.airebo with DATE: 2011-10-25 -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP C C # long range -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - -#### Simulation settings #### -timestep 0.001 -#velocity adsorbate create 300.0 12345 -fix subf membrane setforce 0.0 0.0 0.0 -fix thermostat all nve - -compute 0 all pair rebo -compute 1 all pair ilp/graphene/hbn -variable REBO equal c_0 -variable ILP equal c_1 - -############################ - -# Output -thermo 100 -thermo_style custom step etotal pe ke v_REBO v_ILP temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost warn - -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - -###### Run molecular dynamics ###### -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair rebo, perpetual, skip from (2) - attributes: full, newton on, ghost - pair build: skip/ghost - stencil: none - bin: none - (2) pair ilp/graphene/hbn, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 16.96 | 16.96 | 16.96 Mbytes -Step TotEng PotEng KinEng v_REBO v_ILP Temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom - 0 -5029.3801131277 -5044.0700799791 14.6899668514 -5011.2636297759 -32.8064502032 83.6251135127 22.0155657205 20.2812150219 3.4623630945 0.0282287195 0.0535565745 0.2193320108 - 100 -5029.3895815657 -5045.3201249690 15.9305434033 -5012.4897058028 -32.8304191662 90.6873047362 22.0181751545 20.2867946176 3.4502536831 0.0239131349 0.0576557373 -0.4387830564 - 200 -5029.3874064119 -5045.8119502228 16.4245438109 -5012.7276250747 -33.0843251481 93.4994853617 22.0202931358 20.2926890775 3.3883512918 0.0180268639 0.0596894423 -0.6964675465 - 300 -5029.3851410393 -5044.9928147367 15.6076736974 -5012.1131531405 -32.8796615962 88.8493144891 22.0216852689 20.2985091183 3.3368274018 0.0093519893 0.0546775051 -0.2110676539 - 400 -5029.3900102082 -5045.6706717598 16.2806615516 -5012.7330095297 -32.9376622301 92.6804113372 22.0220931529 20.3035219616 3.3560233852 -0.0015365116 0.0454268927 0.5478139709 - 500 -5029.3985510533 -5046.0433160610 16.6447650078 -5013.0924334585 -32.9508826025 94.7531316612 22.0214795944 20.3074656871 3.4232399722 -0.0107212024 0.0332249366 0.6595923534 - 600 -5029.3929936746 -5045.4367231195 16.0437294449 -5012.7046931021 -32.7320300174 91.3316353653 22.0200027176 20.3101652565 3.4651727438 -0.0178110391 0.0210056002 0.1144372537 - 700 -5029.3934435811 -5045.6074608403 16.2140172592 -5012.7886962164 -32.8187646239 92.3010274644 22.0178838793 20.3116257077 3.4432436715 -0.0242636237 0.0078323424 -0.5162836955 - 800 -5029.3892931255 -5046.2270462380 16.8377531124 -5013.2383770824 -32.9886691555 95.8517489911 22.0151485191 20.3116305041 3.3780520461 -0.0302821178 -0.0083184719 -0.6710801515 - 900 -5029.3930414672 -5046.0272003818 16.6341589146 -5013.2317798384 -32.7954205434 94.6927546874 22.0119224940 20.3099187654 3.3350551183 -0.0341747588 -0.0256858066 -0.0799872839 - 1000 -5029.3908907831 -5045.6437703691 16.2528795861 -5012.6800867885 -32.9636835807 92.5222578135 22.0084902521 20.3065746721 3.3658243730 -0.0336536245 -0.0406018547 0.6191660974 -Loop time of 137.46 on 1 procs for 1000 steps with 1360 atoms - -Performance: 0.629 ns/day, 38.183 hours/ns, 7.275 timesteps/s -95.1% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 137.33 | 137.33 | 137.33 | 0.0 | 99.90 -Bond | 0.00071788 | 0.00071788 | 0.00071788 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.067907 | 0.067907 | 0.067907 | 0.0 | 0.05 -Output | 0.0016029 | 0.0016029 | 0.0016029 | 0.0 | 0.00 -Modify | 0.036542 | 0.036542 | 0.036542 | 0.0 | 0.03 -Other | | 0.02574 | | | 0.02 - -Nlocal: 1360 ave 1360 max 1360 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 7964 ave 7964 max 7964 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 265206 ave 265206 max 265206 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 265206 -Ave neighs/atom = 195.004 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:02:17 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.4 b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.4 deleted file mode 100644 index 6e28672714..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.16Mar18.bilayer-graphene.g++.4 +++ /dev/null @@ -1,137 +0,0 @@ -LAMMPS (8 Mar 2018) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 atom types so that inter- and intra-layer -# interactions can be specified separately -# read lammps data file -read_data Bi_gr_AB_stack_2L_noH_300K.data - orthogonal box = (0 0 0) to (42.6 41.8117 100) - 2 by 2 by 1 MPI processor grid - reading atoms ... - 1360 atoms - reading velocities ... - 1360 velocities - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -mass 1 12.0107 # carbon mass (g/mole) | membrane -mass 2 12.0107 # carbon mass (g/mole) | adsorbate -# Separate atom groups -group membrane type 1 -680 atoms in group membrane -group adsorbate type 2 -680 atoms in group adsorbate - -######################## Potential defition ######################## -pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 -#################################################################### -pair_coeff * * rebo CH.airebo NULL C # chemical -Reading potential file CH.airebo with DATE: 2011-10-25 -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP C C # long range -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - -#### Simulation settings #### -timestep 0.001 -#velocity adsorbate create 300.0 12345 -fix subf membrane setforce 0.0 0.0 0.0 -fix thermostat all nve - -compute 0 all pair rebo -compute 1 all pair ilp/graphene/hbn -variable REBO equal c_0 -variable ILP equal c_1 - -############################ - -# Output -thermo 100 -thermo_style custom step etotal pe ke v_REBO v_ILP temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost warn - -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - -###### Run molecular dynamics ###### -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair rebo, perpetual, skip from (2) - attributes: full, newton on, ghost - pair build: skip/ghost - stencil: none - bin: none - (2) pair ilp/graphene/hbn, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 11.13 | 11.13 | 11.13 Mbytes -Step TotEng PotEng KinEng v_REBO v_ILP Temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom - 0 -5029.3801131277 -5044.0700799791 14.6899668514 -5011.2636297759 -32.8064502032 83.6251135127 22.0155657205 20.2812150219 3.4623630945 0.0282287195 0.0535565745 0.2193320108 - 100 -5029.3895815657 -5045.3201249690 15.9305434033 -5012.4897058028 -32.8304191662 90.6873047362 22.0181751545 20.2867946176 3.4502536831 0.0239131349 0.0576557373 -0.4387830564 - 200 -5029.3874064119 -5045.8119502228 16.4245438109 -5012.7276250747 -33.0843251481 93.4994853617 22.0202931358 20.2926890775 3.3883512918 0.0180268639 0.0596894423 -0.6964675465 - 300 -5029.3851410393 -5044.9928147367 15.6076736974 -5012.1131531405 -32.8796615962 88.8493144891 22.0216852689 20.2985091183 3.3368274018 0.0093519893 0.0546775051 -0.2110676539 - 400 -5029.3900102082 -5045.6706717598 16.2806615516 -5012.7330095297 -32.9376622301 92.6804113371 22.0220931529 20.3035219616 3.3560233852 -0.0015365116 0.0454268927 0.5478139709 - 500 -5029.3985510533 -5046.0433160611 16.6447650078 -5013.0924334585 -32.9508826025 94.7531316612 22.0214795944 20.3074656871 3.4232399722 -0.0107212024 0.0332249366 0.6595923534 - 600 -5029.3929936746 -5045.4367231195 16.0437294449 -5012.7046931021 -32.7320300174 91.3316353653 22.0200027176 20.3101652565 3.4651727438 -0.0178110391 0.0210056002 0.1144372537 - 700 -5029.3934435811 -5045.6074608403 16.2140172592 -5012.7886962164 -32.8187646239 92.3010274643 22.0178838793 20.3116257077 3.4432436715 -0.0242636237 0.0078323424 -0.5162836955 - 800 -5029.3892931255 -5046.2270462380 16.8377531124 -5013.2383770824 -32.9886691555 95.8517489911 22.0151485191 20.3116305041 3.3780520461 -0.0302821178 -0.0083184719 -0.6710801515 - 900 -5029.3930414671 -5046.0272003818 16.6341589146 -5013.2317798384 -32.7954205434 94.6927546874 22.0119224940 20.3099187654 3.3350551183 -0.0341747588 -0.0256858066 -0.0799872839 - 1000 -5029.3908907831 -5045.6437703692 16.2528795861 -5012.6800867885 -32.9636835807 92.5222578135 22.0084902521 20.3065746721 3.3658243730 -0.0336536245 -0.0406018547 0.6191660974 -Loop time of 36.0917 on 4 procs for 1000 steps with 1360 atoms - -Performance: 2.394 ns/day, 10.025 hours/ns, 27.707 timesteps/s -97.6% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 33.204 | 34.289 | 35.893 | 17.3 | 95.01 -Bond | 0.00038719 | 0.00065947 | 0.00097609 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.1539 | 1.7595 | 2.8464 | 76.7 | 4.88 -Output | 0.0013447 | 0.0014529 | 0.0016887 | 0.4 | 0.00 -Modify | 0.010811 | 0.012037 | 0.013764 | 1.0 | 0.03 -Other | | 0.0287 | | | 0.08 - -Nlocal: 340 ave 344 max 334 min -Histogram: 1 0 0 0 0 0 1 0 1 1 -Nghost: 4628 ave 4634 max 4624 min -Histogram: 1 0 1 0 1 0 0 0 0 1 -Neighs: 0 ave 0 max 0 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -FullNghs: 66301.5 ave 67860 max 63963 min -Histogram: 1 0 0 0 0 0 1 0 1 1 - -Total # of neighbors = 265206 -Ave neighs/atom = 195.004 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:36 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 deleted file mode 100644 index bb36f22d81..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.1 +++ /dev/null @@ -1,128 +0,0 @@ -LAMMPS (5 Jun 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 molecule ids so that inter- and intra-layer -# interactions can be specified separately -# read lammps data file -read_data Bi_gr_AB_stack_2L_noH.data - orthogonal box = (0 0 0) to (42.6 41.8117 100) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 1360 atoms - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors - special bonds CPU = 0.00018123 secs - read_data CPU = 0.00179349 secs -mass 1 12.0107 # carbon mass (g/mole) | membrane -mass 2 12.0107 # carbon mass (g/mole) | adsorbate -# Separate atom groups -group layer1 molecule 1 -680 atoms in group layer1 -group layer2 molecule 2 -680 atoms in group layer2 - -######################## Potential defition ######################## -pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 -#################################################################### -pair_coeff * * rebo CH.rebo C C # chemical -Reading potential file CH.rebo with DATE: 2018-7-3 -pair_coeff * * ilp/graphene/hbn BNCH.ILP C C # long range -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -#### Simulation settings #### -timestep 0.001 -velocity all create 300.0 12345 - -compute 0 all pair rebo -compute 1 all pair ilp/graphene/hbn -variable REBO equal c_0 # REBO energy -variable ILP equal c_1 # total interlayer energy -variable Evdw equal c_1[1] # attractive energy -variable Erep equal c_1[2] # repulsive energy - -############################ - -# Output -thermo 100 -thermo_style custom step cpu etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp -thermo_modify line one format float %.16f -thermo_modify flush yes norm no lost warn - -###### Run molecular dynamics ###### -fix thermostat all nve -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair rebo, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard - (2) pair ilp/graphene/hbn, perpetual, copy from (1) - attributes: full, newton on, ghost - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 20.52 | 20.52 | 20.52 Mbytes -Step CPU TotEng PotEng KinEng v_REBO v_ILP v_Erep v_Evdw Temp - 0 0.0000000000000000 -10037.2853168513975106 -10089.9846779678973689 52.6993611164999436 -10057.1894932863488066 -32.7951846815484842 43.6401037466550932 -76.4352884281863538 299.9999999999996589 - 100 5.4714687280356884 -10037.0338552868142870 -10064.7651651140276954 27.7313098272134866 -10032.1809546658514591 -32.5842104481769326 34.7308676709731401 -67.3150781191208409 157.8651576016785896 - 200 10.9391297820257023 -10036.9626863095945737 -10061.1437965401473775 24.1811102305520329 -10028.8556641958457476 -32.2881323443021699 28.1799358234288526 -60.4680681676962450 137.6550477173489071 - 300 16.5882020250428468 -10037.0034097789539373 -10063.5001355365984637 26.4967257576440751 -10030.8230306457862753 -32.6771048908121244 34.9238490632189666 -67.6009539540019659 150.8370795942042264 - 400 22.1194989730138332 -10037.0320901258455706 -10064.3886163746337843 27.3565262487876240 -10031.8532011416427849 -32.5354152329904451 44.2423469839209460 -76.7777622168925546 155.7316388806602561 - 500 27.6722563949879259 -10037.0233394483148004 -10064.1136184894730832 27.0902790411580163 -10031.4312007416901906 -32.6824177477829565 37.2292320482101289 -69.9116497959676906 154.2159817531989177 - 600 33.2032995349727571 -10037.0033561502987141 -10063.6570740290953836 26.6537178787960869 -10031.3274097829344100 -32.3296642461602843 28.5090732059975061 -60.8387374521216842 151.7307837178934449 - 700 38.6685221369843930 -10037.0041655805853225 -10063.3498627390818001 26.3456971584966979 -10030.8006321783104795 -32.5492305607709014 32.5646861904578486 -65.1139167511948074 149.9773238251721921 - 800 44.2185375869739801 -10037.0245724491269357 -10064.2193369538654224 27.1947645047377584 -10031.7656842933574808 -32.4536526605085243 43.3815569718683705 -75.8352096323569498 154.8107828743098082 - 900 49.6989215560024604 -10037.0283918584391358 -10064.6675188165245345 27.6391269580851500 -10032.1673975747289660 -32.5001212417962648 39.9934500237055133 -72.4935712654787778 157.3403910741040761 - 1000 55.1455117090372369 -10037.0033475406326033 -10063.6621727186211501 26.6588251779885006 -10031.3371200905367004 -32.3250526280852100 29.5735783776502288 -61.8986310057011480 151.7598578798047697 -Loop time of 55.1456 on 1 procs for 1000 steps with 1360 atoms - -Performance: 1.567 ns/day, 15.318 hours/ns, 18.134 timesteps/s -100.0% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 55.092 | 55.092 | 55.092 | 0.0 | 99.90 -Bond | 0.00050265 | 0.00050265 | 0.00050265 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.032649 | 0.032649 | 0.032649 | 0.0 | 0.06 -Output | 0.00060948 | 0.00060948 | 0.00060948 | 0.0 | 0.00 -Modify | 0.0093351 | 0.0093351 | 0.0093351 | 0.0 | 0.02 -Other | | 0.01008 | | | 0.02 - -Nlocal: 1360 ave 1360 max 1360 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 7964 ave 7964 max 7964 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 1.037e+06 ave 1.037e+06 max 1.037e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 1037000 -Ave neighs/atom = 762.5 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:55 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 b/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 deleted file mode 100644 index 95c495b677..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/log.5Jun19.bilayer-graphene.icc.4 +++ /dev/null @@ -1,128 +0,0 @@ -LAMMPS (5 Jun 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 molecule ids so that inter- and intra-layer -# interactions can be specified separately -# read lammps data file -read_data Bi_gr_AB_stack_2L_noH.data - orthogonal box = (0 0 0) to (42.6 41.8117 100) - 2 by 2 by 1 MPI processor grid - reading atoms ... - 1360 atoms - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors - special bonds CPU = 0.000147377 secs - read_data CPU = 0.0025185 secs -mass 1 12.0107 # carbon mass (g/mole) | membrane -mass 2 12.0107 # carbon mass (g/mole) | adsorbate -# Separate atom groups -group layer1 molecule 1 -680 atoms in group layer1 -group layer2 molecule 2 -680 atoms in group layer2 - -######################## Potential defition ######################## -pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 -#################################################################### -pair_coeff * * rebo CH.rebo C C # chemical -Reading potential file CH.rebo with DATE: 2018-7-3 -pair_coeff * * ilp/graphene/hbn BNCH.ILP C C # long range -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -#### Simulation settings #### -timestep 0.001 -velocity all create 300.0 12345 - -compute 0 all pair rebo -compute 1 all pair ilp/graphene/hbn -variable REBO equal c_0 # REBO energy -variable ILP equal c_1 # total interlayer energy -variable Evdw equal c_1[1] # attractive energy -variable Erep equal c_1[2] # repulsive energy - -############################ - -# Output -thermo 100 -thermo_style custom step cpu etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp -thermo_modify line one format float %.16f -thermo_modify flush yes norm no lost warn - -###### Run molecular dynamics ###### -fix thermostat all nve -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair rebo, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard - (2) pair ilp/graphene/hbn, perpetual, copy from (1) - attributes: full, newton on, ghost - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 11.64 | 11.64 | 11.64 Mbytes -Step CPU TotEng PotEng KinEng v_REBO v_ILP v_Erep v_Evdw Temp - 0 0.0000000000000000 -10037.2853168516194273 -10089.9846779681192857 52.6993611164999933 -10057.1894932866325689 -32.7951846814872354 43.6401037466782640 -76.4352884281594527 299.9999999999999432 - 100 1.5180878639221191 -10037.0338552867851831 -10064.7651651139967726 27.7313098272123320 -10032.1809546658569161 -32.5842104481406381 34.7308676709827395 -67.3150781191209546 157.8651576016720242 - 200 3.0293023219564930 -10036.9626863095381850 -10061.1437965400909889 24.1811102305529495 -10028.8556641958311957 -32.2881323442601911 28.1799358234373614 -60.4680681676959750 137.6550477173541367 - 300 4.5289151089964435 -10037.0034097789121006 -10063.5001355365566269 26.4967257576439188 -10030.8230306457808183 -32.6771048907772084 34.9238490632284311 -67.6009539540031454 150.8370795942033453 - 400 6.0309539699228480 -10037.0320901258182857 -10064.3886163746046805 27.3565262487870413 -10031.8532011416427849 -32.5354152329611424 44.2423469839354624 -76.7777622168941747 155.7316388806569307 - 500 7.5873900629812852 -10037.0233394482729636 -10064.1136184894312464 27.0902790411581904 -10031.4312007416810957 -32.6824177477510176 37.2292320482201404 -69.9116497959683159 154.2159817531999124 - 600 9.1088078819448128 -10037.0033561502586963 -10063.6570740290553658 26.6537178787959803 -10031.3274097829398670 -32.3296642461160033 28.5090732060055281 -60.8387374521202773 151.7307837178928480 - 700 10.6168858460150659 -10037.0041655805125629 -10063.3498627390090405 26.3456971584962574 -10030.8006321782777377 -32.5492305607314165 32.5646861904650535 -65.1139167511946653 149.9773238251696910 - 800 12.1294107990106568 -10037.0245724491123838 -10064.2193369538508705 27.1947645047383304 -10031.7656842933720327 -32.4536526604775162 43.3815569718824179 -75.8352096323571629 154.8107828743130767 - 900 13.6509861790109426 -10037.0283918584264029 -10064.6675188165099826 27.6391269580827625 -10032.1673975747471559 -32.5001212417642336 39.9934500237184380 -72.4935712654798436 157.3403910740904905 - 1000 15.1634582940023392 -10037.0033475405834906 -10063.6621727185720374 26.6588251779879926 -10031.3371200905276055 -32.3250526280445740 29.5735783776581442 -61.8986310057012972 151.7598578798018707 -Loop time of 15.1635 on 4 procs for 1000 steps with 1360 atoms - -Performance: 5.698 ns/day, 4.212 hours/ns, 65.948 timesteps/s -99.9% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 13.997 | 14.363 | 14.741 | 9.0 | 94.72 -Bond | 0.00036359 | 0.00040186 | 0.00044586 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.40664 | 0.78485 | 1.1509 | 38.6 | 5.18 -Output | 0.00027687 | 0.00036825 | 0.00063194 | 0.0 | 0.00 -Modify | 0.0043962 | 0.0045847 | 0.0047857 | 0.2 | 0.03 -Other | | 0.01055 | | | 0.07 - -Nlocal: 340 ave 340 max 340 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -Nghost: 4628 ave 4628 max 4628 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -FullNghs: 259250 ave 259250 max 259250 min -Histogram: 4 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 1037000 -Ave neighs/atom = 762.5 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:15 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff deleted file mode 120000 index 0c35f80da1..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNC.tersoff +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/BNC.tersoff \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP b/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP deleted file mode 120000 index b970e23f95..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/BNCH.ILP +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/BNCH.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNC.tersoff b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNC.tersoff deleted file mode 120000 index 0c35f80da1..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNC.tersoff +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/BNC.tersoff \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH-old.ILP b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH-old.ILP deleted file mode 120000 index 9a3bc96225..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH-old.ILP +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/BNCH-old.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP deleted file mode 120000 index b970e23f95..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/BNCH.ILP +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/BNCH.ILP \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.airebo b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.airebo deleted file mode 120000 index 5d070dd3a4..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.airebo +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/CH.airebo \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo deleted file mode 120000 index b98001a7fd..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/CH.rebo +++ /dev/null @@ -1 +0,0 @@ -../../../../../potentials/CH.rebo \ No newline at end of file diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.1 b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.1 deleted file mode 100644 index e5bce94ef4..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.1 +++ /dev/null @@ -1,171 +0,0 @@ -LAMMPS (8 Mar 2018) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 atom types so that inter- and intra-layer -# interactions can be specified separately -read_data gr_hBN_Cstack_2L_noH.data - orthogonal box = (0 0 0) to (44.583 42.9 100) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 1440 atoms - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -mass 1 10.8110 # boron mass (g/mole) | membrane -mass 2 14.0067 # nitrogen mass (g/mole) | membrane -mass 3 12.0107 # carbon mass (g/mole) | adsorbate -# Separate atom groups -group membrane type 1 2 -720 atoms in group membrane -group adsorbate type 3 -720 atoms in group adsorbate - -######################## Potential defition ######################## -pair_style hybrid/overlay rebo tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 -#################################################################### -pair_coeff * * rebo CH.airebo NULL NULL C # chemical -Reading potential file CH.airebo with DATE: 2011-10-25 -pair_coeff * * tersoff BNC.tersoff B N NULL # chemical -Reading potential file BNC.tersoff with DATE: 2013-03-21 -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP B N C # long range -pair_coeff 1 1 coul/shield 0.70 -pair_coeff 1 2 coul/shield 0.69498201415576216335 -pair_coeff 2 2 coul/shield 0.69 -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - -#### Simulation settings #### -timestep 0.001 -velocity all create 300.0 12345 -fix thermostat all nve - -compute 0 all pair rebo -compute 1 all pair tersoff -compute 2 all pair ilp/graphene/hbn -compute 3 all pair coul/shield -variable REBO equal c_0 -variable Tersoff equal c_1 -variable EILP equal c_2 -variable Ecoul equal c_3 - -# Calculate the pair potential between the substrate and slider -compute sldsub adsorbate group/group membrane -variable Evdw equal c_sldsub - -############################ - -# Output -thermo 100 -thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Ecoul temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom -thermo_modify line one format float %.10f - -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - -###### Run molecular dynamics ###### -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 7 neighbor lists, perpetual/occasional/extra = 6 1 0 - (1) pair rebo, perpetual, skip from (3) - attributes: full, newton on, ghost - pair build: skip/ghost - stencil: none - bin: none - (2) pair tersoff, perpetual, skip from (6) - attributes: full, newton on - pair build: skip - stencil: none - bin: none - (3) pair ilp/graphene/hbn, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard - (4) pair coul/shield, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton/skip - stencil: none - bin: none - (5) compute group/group, occasional, copy from (7) - attributes: half, newton on - pair build: copy - stencil: none - bin: none - (6) neighbor class addition, perpetual, copy from (3) - attributes: full, newton on - pair build: copy - stencil: none - bin: none - (7) neighbor class addition, perpetual, half/full from (6) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 25.93 | 25.93 | 25.93 Mbytes -Step TotEng PotEng KinEng v_Evdw v_Tersoff v_REBO v_EILP v_Ecoul Temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom - 0 -10708.4531746010 -10764.2547791975 55.8016045965 -66.8250335416 -5401.7347845703 -5322.2780762734 -40.2419183538 0.0000000000 300.0000000000 21.6722857297 22.1650000000 3.3300000000 0.1682661410 -0.0842226772 0.1056563755 - 100 -10708.2491256387 -10738.4532793285 30.2041536898 -68.8603937785 -5389.4304136167 -5309.6361134033 -39.3867523085 0.0000000000 162.3832535368 21.6879886706 22.1574778199 3.3223279482 0.1346509596 -0.0580689194 -0.1274433614 - 200 -10708.1985754490 -10736.7142682477 28.5156927987 -70.0276479251 -5388.8677096501 -5308.3263464524 -39.5202121452 0.0000000000 153.3057678444 21.6968427596 22.1541506320 3.3143666142 0.0334706445 -0.0081639882 -0.0055006321 - 300 -10708.1878214116 -10736.9033486636 28.7155272520 -68.2422175765 -5388.5952548022 -5308.9505338445 -39.3575600169 0.0000000000 154.3801157314 21.6939171741 22.1551483321 3.3251666346 -0.0896064591 0.0248921781 0.1717740196 - 400 -10708.2036103906 -10738.2295882994 30.0259779088 -67.4993928655 -5389.4510311345 -5309.1985887571 -39.5799684078 0.0000000000 161.4253467759 21.6806789605 22.1589742804 3.3300374170 -0.1615300496 0.0532638209 -0.1185426799 - 500 -10708.1853082161 -10736.0245173060 27.8392090900 -69.9737746636 -5387.9379921501 -5308.5551693329 -39.5313558230 0.0000000000 149.6688632411 21.6641276776 22.1655659011 3.3143210751 -0.1579504334 0.0766822604 -0.1154029266 - 600 -10708.1781001285 -10736.4254568396 28.2473567110 -69.9368770273 -5388.3515507737 -5308.6700567475 -39.4038493184 0.0000000000 151.8631421907 21.6516789999 22.1733266592 3.3149997184 -0.0805825343 0.0684349609 0.1419617624 - 700 -10708.1867253590 -10736.6143955088 28.4276701498 -67.1597096579 -5387.8570063253 -5309.0676141640 -39.6897750195 0.0000000000 152.8325414049 21.6489884054 22.1774523945 3.3315351816 0.0259900263 0.0094570835 0.0707953688 - 800 -10708.1733385055 -10736.0277775931 27.8544390876 -68.6354557276 -5388.1933954711 -5308.5094712719 -39.3249108500 0.0000000000 149.7507425941 21.6565725156 22.1751617515 3.3227650180 0.1222442823 -0.0531420670 -0.1677749693 - 900 -10708.1827888042 -10737.2646739167 29.0818851126 -70.2218493216 -5387.9824857335 -5309.6527953488 -39.6293928345 0.0000000000 156.3497250098 21.6716950833 22.1680989334 3.3131455846 0.1650154385 -0.0820901425 0.0072049300 - 1000 -10708.1804322657 -10736.1966428009 28.0162105352 -68.3753745517 -5388.2611029662 -5308.4521913187 -39.4833485160 0.0000000000 150.6204565501 21.6865468141 22.1602434319 3.3246621699 0.1213363701 -0.0688593023 0.1701174943 -Loop time of 149.449 on 1 procs for 1000 steps with 1440 atoms - -Performance: 0.578 ns/day, 41.514 hours/ns, 6.691 timesteps/s -96.7% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 149.06 | 149.06 | 149.06 | 0.0 | 99.74 -Bond | 0.00082946 | 0.00082946 | 0.00082946 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.068351 | 0.068351 | 0.068351 | 0.0 | 0.05 -Output | 0.25935 | 0.25935 | 0.25935 | 0.0 | 0.17 -Modify | 0.030915 | 0.030915 | 0.030915 | 0.0 | 0.02 -Other | | 0.02702 | | | 0.02 - -Nlocal: 1440 ave 1440 max 1440 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 8180 ave 8180 max 8180 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 140400 ave 140400 max 140400 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 280800 ave 280800 max 280800 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 280800 -Ave neighs/atom = 195 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:02:29 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.4 b/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.4 deleted file mode 100644 index 86e93369ff..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.16Mar18.grhBN.g++.4 +++ /dev/null @@ -1,171 +0,0 @@ -LAMMPS (8 Mar 2018) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 atom types so that inter- and intra-layer -# interactions can be specified separately -read_data gr_hBN_Cstack_2L_noH.data - orthogonal box = (0 0 0) to (44.583 42.9 100) - 2 by 2 by 1 MPI processor grid - reading atoms ... - 1440 atoms - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -mass 1 10.8110 # boron mass (g/mole) | membrane -mass 2 14.0067 # nitrogen mass (g/mole) | membrane -mass 3 12.0107 # carbon mass (g/mole) | adsorbate -# Separate atom groups -group membrane type 1 2 -720 atoms in group membrane -group adsorbate type 3 -720 atoms in group adsorbate - -######################## Potential defition ######################## -pair_style hybrid/overlay rebo tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 -#################################################################### -pair_coeff * * rebo CH.airebo NULL NULL C # chemical -Reading potential file CH.airebo with DATE: 2011-10-25 -pair_coeff * * tersoff BNC.tersoff B N NULL # chemical -Reading potential file BNC.tersoff with DATE: 2013-03-21 -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP B N C # long range -pair_coeff 1 1 coul/shield 0.70 -pair_coeff 1 2 coul/shield 0.69498201415576216335 -pair_coeff 2 2 coul/shield 0.69 -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - -#### Simulation settings #### -timestep 0.001 -velocity all create 300.0 12345 -fix thermostat all nve - -compute 0 all pair rebo -compute 1 all pair tersoff -compute 2 all pair ilp/graphene/hbn -compute 3 all pair coul/shield -variable REBO equal c_0 -variable Tersoff equal c_1 -variable EILP equal c_2 -variable Ecoul equal c_3 - -# Calculate the pair potential between the substrate and slider -compute sldsub adsorbate group/group membrane -variable Evdw equal c_sldsub - -############################ - -# Output -thermo 100 -thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Ecoul temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom -thermo_modify line one format float %.10f - -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - -###### Run molecular dynamics ###### -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 7 neighbor lists, perpetual/occasional/extra = 6 1 0 - (1) pair rebo, perpetual, skip from (3) - attributes: full, newton on, ghost - pair build: skip/ghost - stencil: none - bin: none - (2) pair tersoff, perpetual, skip from (6) - attributes: full, newton on - pair build: skip - stencil: none - bin: none - (3) pair ilp/graphene/hbn, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard - (4) pair coul/shield, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton/skip - stencil: none - bin: none - (5) compute group/group, occasional, copy from (7) - attributes: half, newton on - pair build: copy - stencil: none - bin: none - (6) neighbor class addition, perpetual, copy from (3) - attributes: full, newton on - pair build: copy - stencil: none - bin: none - (7) neighbor class addition, perpetual, half/full from (6) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 14.25 | 14.25 | 14.25 Mbytes -Step TotEng PotEng KinEng v_Evdw v_Tersoff v_REBO v_EILP v_Ecoul Temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom - 0 -10708.4531746011 -10764.2547791976 55.8016045965 -66.8250335415 -5401.7347845703 -5322.2780762735 -40.2419183538 0.0000000000 300.0000000000 21.6722857297 22.1650000000 3.3300000000 0.1682661410 -0.0842226772 0.1056563755 - 100 -10708.2491256387 -10738.4532793285 30.2041536898 -68.8603937785 -5389.4304136167 -5309.6361134033 -39.3867523085 0.0000000000 162.3832535368 21.6879886706 22.1574778199 3.3223279482 0.1346509596 -0.0580689194 -0.1274433614 - 200 -10708.1985754490 -10736.7142682477 28.5156927987 -70.0276479251 -5388.8677096501 -5308.3263464524 -39.5202121452 0.0000000000 153.3057678444 21.6968427596 22.1541506320 3.3143666142 0.0334706445 -0.0081639882 -0.0055006321 - 300 -10708.1878214116 -10736.9033486636 28.7155272520 -68.2422175765 -5388.5952548022 -5308.9505338445 -39.3575600169 0.0000000000 154.3801157314 21.6939171741 22.1551483321 3.3251666346 -0.0896064591 0.0248921781 0.1717740196 - 400 -10708.2036103906 -10738.2295882994 30.0259779088 -67.4993928655 -5389.4510311345 -5309.1985887571 -39.5799684078 0.0000000000 161.4253467759 21.6806789605 22.1589742804 3.3300374170 -0.1615300496 0.0532638209 -0.1185426799 - 500 -10708.1853082161 -10736.0245173060 27.8392090900 -69.9737746636 -5387.9379921501 -5308.5551693329 -39.5313558230 0.0000000000 149.6688632411 21.6641276776 22.1655659011 3.3143210751 -0.1579504334 0.0766822604 -0.1154029266 - 600 -10708.1781001285 -10736.4254568396 28.2473567110 -69.9368770273 -5388.3515507736 -5308.6700567475 -39.4038493184 0.0000000000 151.8631421907 21.6516789999 22.1733266592 3.3149997184 -0.0805825343 0.0684349609 0.1419617624 - 700 -10708.1867253590 -10736.6143955089 28.4276701498 -67.1597096579 -5387.8570063253 -5309.0676141640 -39.6897750195 0.0000000000 152.8325414049 21.6489884054 22.1774523945 3.3315351816 0.0259900263 0.0094570835 0.0707953688 - 800 -10708.1733385055 -10736.0277775930 27.8544390876 -68.6354557276 -5388.1933954711 -5308.5094712719 -39.3249108500 0.0000000000 149.7507425941 21.6565725156 22.1751617515 3.3227650180 0.1222442823 -0.0531420670 -0.1677749693 - 900 -10708.1827888042 -10737.2646739167 29.0818851126 -70.2218493216 -5387.9824857335 -5309.6527953488 -39.6293928345 0.0000000000 156.3497250098 21.6716950833 22.1680989334 3.3131455846 0.1650154385 -0.0820901425 0.0072049300 - 1000 -10708.1804322657 -10736.1966428009 28.0162105352 -68.3753745517 -5388.2611029662 -5308.4521913187 -39.4833485160 0.0000000000 150.6204565501 21.6865468141 22.1602434319 3.3246621699 0.1213363701 -0.0688593023 0.1701174943 -Loop time of 39.6206 on 4 procs for 1000 steps with 1440 atoms - -Performance: 2.181 ns/day, 11.006 hours/ns, 25.239 timesteps/s -98.9% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 34.948 | 37.122 | 39.309 | 31.6 | 93.69 -Bond | 0.00046444 | 0.0005914 | 0.00089121 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.20131 | 2.3895 | 4.565 | 124.7 | 6.03 -Output | 0.069107 | 0.069157 | 0.069264 | 0.0 | 0.17 -Modify | 0.010056 | 0.010403 | 0.010688 | 0.3 | 0.03 -Other | | 0.02875 | | | 0.07 - -Nlocal: 360 ave 380 max 340 min -Histogram: 2 0 0 0 0 0 0 0 0 2 -Nghost: 4716 ave 4736 max 4696 min -Histogram: 2 0 0 0 0 0 0 0 0 2 -Neighs: 35100 ave 37050 max 33150 min -Histogram: 2 0 0 0 0 0 0 0 0 2 -FullNghs: 70200 ave 74100 max 66300 min -Histogram: 2 0 0 0 0 0 0 0 0 2 - -Total # of neighbors = 280800 -Ave neighs/atom = 195 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:39 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/gr_hBN_Cstack_2L_noH.data b/examples/USER/misc/ilp_graphene_hbn/gr_hBN_Cstack_2L_noH.data similarity index 100% rename from examples/USER/misc/ilp_graphene_hbn/gr-hBN/gr_hBN_Cstack_2L_noH.data rename to examples/USER/misc/ilp_graphene_hbn/gr_hBN_Cstack_2L_noH.data diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/hBN_AA_prime_stack_2L_noH.data b/examples/USER/misc/ilp_graphene_hbn/hBN_AA_prime_stack_2L_noH.data similarity index 100% rename from examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/hBN_AA_prime_stack_2L_noH.data rename to examples/USER/misc/ilp_graphene_hbn/hBN_AA_prime_stack_2L_noH.data diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene b/examples/USER/misc/ilp_graphene_hbn/in.bilayer-graphene similarity index 100% rename from examples/USER/misc/ilp_graphene_hbn/bilayer-graphene/in.bilayer-graphene rename to examples/USER/misc/ilp_graphene_hbn/in.bilayer-graphene diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/in.bilayer-hBN b/examples/USER/misc/ilp_graphene_hbn/in.bilayer-hBN similarity index 91% rename from examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/in.bilayer-hBN rename to examples/USER/misc/ilp_graphene_hbn/in.bilayer-hBN index 0e02104d59..1cf982d8dc 100644 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/in.bilayer-hBN +++ b/examples/USER/misc/ilp_graphene_hbn/in.bilayer-hBN @@ -49,9 +49,8 @@ variable Erep equal c_2[2] # repulsive energy ############# Output ############### thermo 100 -thermo_style custom step cpu etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost error +thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify lost warn ###### Run molecular dynamics ###### run 1000 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/in.grhBN b/examples/USER/misc/ilp_graphene_hbn/in.grhBN similarity index 96% rename from examples/USER/misc/ilp_graphene_hbn/gr-hBN/in.grhBN rename to examples/USER/misc/ilp_graphene_hbn/in.grhBN index 1ae1704dec..46c42e0d6d 100644 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/in.grhBN +++ b/examples/USER/misc/ilp_graphene_hbn/in.grhBN @@ -50,8 +50,7 @@ variable Ecoul equal c_3 ############# Output ############## thermo 100 -thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul temp -thermo_modify line one format float %.10f +thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul temp ###### Run molecular dynamics ###### run 1000 diff --git a/examples/USER/misc/ilp_graphene_hbn/in.ilp_graphene_hbn b/examples/USER/misc/ilp_graphene_hbn/in.ilp_graphene_hbn index da813b3d10..9b122e194e 100644 --- a/examples/USER/misc/ilp_graphene_hbn/in.ilp_graphene_hbn +++ b/examples/USER/misc/ilp_graphene_hbn/in.ilp_graphene_hbn @@ -32,14 +32,6 @@ neigh_modify every 1 neigh_modify delay 0 neigh_modify check yes -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - #### Simulation settings #### timestep 0.001 #velocity adsorbate create 300.0 12345 @@ -51,19 +43,16 @@ compute 1 all pair coul/shield ecoul compute 2 all pair ilp/graphene/hbn variable Tersoff equal c_0 variable Ecoul equal c_1 -variable EILP equal c_2 - -# Calculate the pair potential between the substrate and slider -compute sldsub adsorbate group/group membrane -variable Evdw equal c_sldsub +variable ILP equal c_2 +variable Evdw equal c_2[1] +variable Erep equal c_2[2] ############################ # Output thermo 100 -thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_EILP v_Ecoul temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom f_subf[1] f_subf[2] f_subf[3] -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost warn #ignore +thermo_style custom step etotal pe ke v_Tersoff v_ILP v_Ecoul v_Erep v_Evdw temp +thermo_modify lost warn #ignore #dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu #dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes diff --git a/examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.1 b/examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.1 deleted file mode 100644 index fc10948f9a..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.1 +++ /dev/null @@ -1,168 +0,0 @@ -LAMMPS (8 Mar 2018) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 atom types so that inter- and intra-layer -# interactions can be specified separately -read_data hBN_AB_stack_2L_noH_equi_300K.data - orthogonal box = (0 0 0) to (43.38 42.5773 100) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 1360 atoms - reading velocities ... - 1360 velocities - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -mass 1 10.8110 # boron mass (g/mole) | membrane -mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate -mass 3 10.8110 # boron mass (g/mole) | membrane -mass 4 14.0067 # nitrogen mass (g/mole) | adsorbate -# Separate atom groups -group membrane type 1 2 -680 atoms in group membrane -group adsorbate type 3 4 -680 atoms in group adsorbate - -######################## Potential defition ######################## -pair_style hybrid/overlay tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 1 -#################################################################### -pair_coeff * * tersoff BNC.tersoff NULL NULL B N # chemical -Reading potential file BNC.tersoff with DATE: 2013-03-21 -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP B N B N # long range -pair_coeff 1 3 coul/shield 0.70 -pair_coeff 1 4 coul/shield 0.69498201415576216335 -pair_coeff 2 3 coul/shield 0.69498201415576216335 -pair_coeff 2 4 coul/shield 0.69 -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - -#### Simulation settings #### -timestep 0.001 -#velocity adsorbate create 300.0 12345 -fix subf membrane setforce 0.0 0.0 0.0 -fix thermostat all nve - -compute 0 all pair tersoff -compute 1 all pair coul/shield ecoul -compute 2 all pair ilp/graphene/hbn -variable Tersoff equal c_0 -variable Ecoul equal c_1 -variable EILP equal c_2 - -# Calculate the pair potential between the substrate and slider -compute sldsub adsorbate group/group membrane -variable Evdw equal c_sldsub - -############################ - -# Output -thermo 100 -thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_EILP v_Ecoul temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom f_subf[1] f_subf[2] f_subf[3] -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost warn #ignore - -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - -###### Run molecular dynamics ###### -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 6 neighbor lists, perpetual/occasional/extra = 5 1 0 - (1) pair tersoff, perpetual, skip from (5) - attributes: full, newton on - pair build: skip - stencil: none - bin: none - (2) pair ilp/graphene/hbn, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard - (3) pair coul/shield, perpetual, skip from (6) - attributes: half, newton on - pair build: skip - stencil: none - bin: none - (4) compute group/group, occasional, copy from (6) - attributes: half, newton on - pair build: copy - stencil: none - bin: none - (5) neighbor class addition, perpetual, copy from (2) - attributes: full, newton on - pair build: copy - stencil: none - bin: none - (6) neighbor class addition, perpetual, half/full from (5) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 57.85 | 57.85 | 57.85 Mbytes -Step TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Ecoul Temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom f_subf[1] f_subf[2] f_subf[3] - 0 -5114.6628078598 -5127.8586355055 13.1958276458 -75.3652234209 -5091.4120857465 -36.0831137829 -0.3634359761 75.1194741238 20.9113202537 20.6582215878 3.2895976612 -0.0495147937 -0.0552233516 -0.0166592619 -0.1742790202 -0.0884665936 -0.8010816801 - 100 -5114.6620580583 -5127.6958349342 13.0337768758 -75.2249487778 -5091.2407919311 -36.0927601416 -0.3622828614 74.1969727889 20.9076129631 20.6534162972 3.2908118318 -0.0234802196 -0.0397832410 0.0332404745 -0.2430042439 -0.1598109185 -0.5351246275 - 200 -5114.6630637865 -5127.5945140906 12.9314503041 -74.6445167393 -5091.1507571912 -36.0866688941 -0.3570880053 73.6144615235 20.9067696105 20.6505240051 3.2976575241 0.0078967872 -0.0170385302 0.0850447973 -0.2934041648 -0.2405295165 0.2309200807 - 300 -5114.6693830121 -5128.3286231421 13.6592401300 -74.2223518942 -5091.8645555419 -36.1107860098 -0.3532815904 77.7575278367 20.9090146500 20.6502445717 3.3024525026 0.0352437329 0.0112279015 -0.0021399216 -0.2166516175 -0.2410661267 0.9007458614 - 400 -5114.6614035404 -5127.6423784754 12.9809749350 -74.6548295432 -5091.2348011465 -36.0496340516 -0.3579432773 73.8963888364 20.9136276183 20.6526810045 3.2977225951 0.0556629502 0.0358324354 -0.0738287296 -0.1431221016 -0.1626739623 0.0673046122 - 500 -5114.6599876234 -5127.4097813122 12.7497936887 -75.2268687829 -5090.9284608504 -36.1195707042 -0.3617497575 72.5803506074 20.9197050770 20.6571510311 3.2909058903 0.0631939085 0.0530269602 -0.0516940297 -0.0112976844 -0.1217009147 -0.4713422319 - 600 -5114.6672773464 -5128.0912983829 13.4240210364 -75.3848112535 -5091.6338883189 -36.0938401510 -0.3635699131 76.4185034811 20.9258252862 20.6628322031 3.2892805234 0.0573396226 0.0579085440 0.0291853982 0.1059950758 0.0102266125 -0.7683214794 - 700 -5114.6609647250 -5127.7466720637 13.0857073388 -74.7981789470 -5091.2811095008 -36.1066385732 -0.3589239897 74.4925957063 20.9307092134 20.6683554324 3.2957959411 0.0396744013 0.0503347378 0.0818267711 0.1737903706 0.1258761156 0.1307185989 - 800 -5114.6622627667 -5128.0130406264 13.3507778597 -74.2952448854 -5091.5693975625 -36.0897180314 -0.3539250325 76.0015543464 20.9334441079 20.6725125240 3.3019570181 0.0142277646 0.0313116646 0.0291673132 0.2457478793 0.1912082770 0.7239823553 - 900 -5114.6675469561 -5128.1496933801 13.4821464240 -74.3644898573 -5091.6703861750 -36.1246785145 -0.3546286905 76.7493920516 20.9334403558 20.6744181494 3.3005582394 -0.0141399355 0.0063543986 -0.0561206619 0.2370151923 0.2115707560 0.7822017606 - 1000 -5114.6683146144 -5128.3364609113 13.6681462969 -75.1091579020 -5091.9370210069 -36.0375964349 -0.3618434694 77.8082276935 20.9306643096 20.6737238853 3.2922181699 -0.0411219854 -0.0200694204 -0.0788193565 0.2225175431 0.2377413412 -0.5875288557 -Loop time of 202.063 on 1 procs for 1000 steps with 1360 atoms - -Performance: 0.428 ns/day, 56.129 hours/ns, 4.949 timesteps/s -91.0% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 201.4 | 201.4 | 201.4 | 0.0 | 99.67 -Bond | 0.00092697 | 0.00092697 | 0.00092697 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.086005 | 0.086005 | 0.086005 | 0.0 | 0.04 -Output | 0.50438 | 0.50438 | 0.50438 | 0.0 | 0.25 -Modify | 0.038846 | 0.038846 | 0.038846 | 0.0 | 0.02 -Other | | 0.03093 | | | 0.02 - -Nlocal: 1360 ave 1360 max 1360 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 7840 ave 7840 max 7840 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 249628 ave 249628 max 249628 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 253390 ave 253390 max 253390 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 253390 -Ave neighs/atom = 186.316 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:03:22 diff --git a/examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.4 b/examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.4 deleted file mode 100644 index 5cd3518918..0000000000 --- a/examples/USER/misc/ilp_graphene_hbn/log.16Mar18.ilp_gr_hBN.g++.4 +++ /dev/null @@ -1,168 +0,0 @@ -LAMMPS (8 Mar 2018) - using 1 OpenMP thread(s) per MPI task -# Initialization -units metal -boundary p p p -atom_style full -processors * * 1 # domain decomposition over x and y - -# System and atom definition -# we use 2 atom types so that inter- and intra-layer -# interactions can be specified separately -read_data hBN_AB_stack_2L_noH_equi_300K.data - orthogonal box = (0 0 0) to (43.38 42.5773 100) - 2 by 2 by 1 MPI processor grid - reading atoms ... - 1360 atoms - reading velocities ... - 1360 velocities - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -mass 1 10.8110 # boron mass (g/mole) | membrane -mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate -mass 3 10.8110 # boron mass (g/mole) | membrane -mass 4 14.0067 # nitrogen mass (g/mole) | adsorbate -# Separate atom groups -group membrane type 1 2 -680 atoms in group membrane -group adsorbate type 3 4 -680 atoms in group adsorbate - -######################## Potential defition ######################## -pair_style hybrid/overlay tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 1 -#################################################################### -pair_coeff * * tersoff BNC.tersoff NULL NULL B N # chemical -Reading potential file BNC.tersoff with DATE: 2013-03-21 -pair_coeff * * ilp/graphene/hbn BNCH-old.ILP B N B N # long range -pair_coeff 1 3 coul/shield 0.70 -pair_coeff 1 4 coul/shield 0.69498201415576216335 -pair_coeff 2 3 coul/shield 0.69498201415576216335 -pair_coeff 2 4 coul/shield 0.69 -#################################################################### -# Neighbor update settings -neighbor 2.0 bin -neigh_modify every 1 -neigh_modify delay 0 -neigh_modify check yes - -# calculate the COM -variable adsxcom equal xcm(adsorbate,x) -variable adsycom equal xcm(adsorbate,y) -variable adszcom equal xcm(adsorbate,z) -variable adsvxcom equal vcm(adsorbate,x) -variable adsvycom equal vcm(adsorbate,y) -variable adsvzcom equal vcm(adsorbate,z) - -#### Simulation settings #### -timestep 0.001 -#velocity adsorbate create 300.0 12345 -fix subf membrane setforce 0.0 0.0 0.0 -fix thermostat all nve - -compute 0 all pair tersoff -compute 1 all pair coul/shield ecoul -compute 2 all pair ilp/graphene/hbn -variable Tersoff equal c_0 -variable Ecoul equal c_1 -variable EILP equal c_2 - -# Calculate the pair potential between the substrate and slider -compute sldsub adsorbate group/group membrane -variable Evdw equal c_sldsub - -############################ - -# Output -thermo 100 -thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_EILP v_Ecoul temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom f_subf[1] f_subf[2] f_subf[3] -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost warn #ignore - -#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu -#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes - -###### Run molecular dynamics ###### -run 1000 -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 18 - ghost atom cutoff = 18 - binsize = 9, bins = 5 5 12 - 6 neighbor lists, perpetual/occasional/extra = 5 1 0 - (1) pair tersoff, perpetual, skip from (5) - attributes: full, newton on - pair build: skip - stencil: none - bin: none - (2) pair ilp/graphene/hbn, perpetual - attributes: full, newton on, ghost - pair build: full/bin/ghost - stencil: full/ghost/bin/3d - bin: standard - (3) pair coul/shield, perpetual, skip from (6) - attributes: half, newton on - pair build: skip - stencil: none - bin: none - (4) compute group/group, occasional, copy from (6) - attributes: half, newton on - pair build: copy - stencil: none - bin: none - (5) neighbor class addition, perpetual, copy from (2) - attributes: full, newton on - pair build: copy - stencil: none - bin: none - (6) neighbor class addition, perpetual, half/full from (5) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 30.63 | 30.63 | 30.64 Mbytes -Step TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Ecoul Temp v_adsxcom v_adsycom v_adszcom v_adsvxcom v_adsvycom v_adsvzcom f_subf[1] f_subf[2] f_subf[3] - 0 -5114.6628078598 -5127.8586355055 13.1958276458 -75.3652234209 -5091.4120857465 -36.0831137829 -0.3634359761 75.1194741238 20.9113202537 20.6582215878 3.2895976612 -0.0495147937 -0.0552233516 -0.0166592619 -0.1742790202 -0.0884665936 -0.8010816801 - 100 -5114.6620580583 -5127.6958349342 13.0337768758 -75.2249487778 -5091.2407919311 -36.0927601416 -0.3622828614 74.1969727889 20.9076129631 20.6534162972 3.2908118318 -0.0234802196 -0.0397832410 0.0332404745 -0.2430042439 -0.1598109185 -0.5351246275 - 200 -5114.6630637865 -5127.5945140906 12.9314503041 -74.6445167393 -5091.1507571912 -36.0866688941 -0.3570880053 73.6144615235 20.9067696105 20.6505240051 3.2976575241 0.0078967872 -0.0170385302 0.0850447973 -0.2934041648 -0.2405295165 0.2309200807 - 300 -5114.6693830121 -5128.3286231421 13.6592401300 -74.2223518942 -5091.8645555419 -36.1107860098 -0.3532815904 77.7575278367 20.9090146500 20.6502445717 3.3024525026 0.0352437329 0.0112279015 -0.0021399216 -0.2166516175 -0.2410661267 0.9007458614 - 400 -5114.6614035404 -5127.6423784754 12.9809749350 -74.6548295432 -5091.2348011465 -36.0496340516 -0.3579432773 73.8963888364 20.9136276183 20.6526810045 3.2977225951 0.0556629502 0.0358324354 -0.0738287296 -0.1431221016 -0.1626739623 0.0673046122 - 500 -5114.6599876234 -5127.4097813122 12.7497936887 -75.2268687829 -5090.9284608504 -36.1195707042 -0.3617497575 72.5803506074 20.9197050770 20.6571510311 3.2909058903 0.0631939085 0.0530269602 -0.0516940297 -0.0112976844 -0.1217009147 -0.4713422319 - 600 -5114.6672773464 -5128.0912983829 13.4240210364 -75.3848112535 -5091.6338883189 -36.0938401510 -0.3635699131 76.4185034811 20.9258252862 20.6628322031 3.2892805234 0.0573396226 0.0579085440 0.0291853982 0.1059950758 0.0102266125 -0.7683214794 - 700 -5114.6609647250 -5127.7466720637 13.0857073388 -74.7981789470 -5091.2811095008 -36.1066385732 -0.3589239897 74.4925957063 20.9307092134 20.6683554324 3.2957959411 0.0396744013 0.0503347378 0.0818267711 0.1737903706 0.1258761156 0.1307185989 - 800 -5114.6622627667 -5128.0130406264 13.3507778597 -74.2952448854 -5091.5693975625 -36.0897180314 -0.3539250325 76.0015543464 20.9334441079 20.6725125240 3.3019570181 0.0142277646 0.0313116646 0.0291673132 0.2457478793 0.1912082770 0.7239823553 - 900 -5114.6675469561 -5128.1496933801 13.4821464240 -74.3644898573 -5091.6703861750 -36.1246785145 -0.3546286905 76.7493920516 20.9334403558 20.6744181494 3.3005582394 -0.0141399355 0.0063543986 -0.0561206619 0.2370151923 0.2115707560 0.7822017606 - 1000 -5114.6683146144 -5128.3364609113 13.6681462969 -75.1091579020 -5091.9370210069 -36.0375964349 -0.3618434694 77.8082276935 20.9306643096 20.6737238853 3.2922181699 -0.0411219854 -0.0200694204 -0.0788193565 0.2225175431 0.2377413412 -0.5875288557 -Loop time of 53.3155 on 4 procs for 1000 steps with 1360 atoms - -Performance: 1.621 ns/day, 14.810 hours/ns, 18.756 timesteps/s -97.6% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 49.475 | 50.978 | 52.988 | 18.0 | 95.62 -Bond | 0.00045061 | 0.00066602 | 0.00086665 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.16491 | 2.1759 | 3.679 | 87.0 | 4.08 -Output | 0.11871 | 0.11882 | 0.11911 | 0.0 | 0.22 -Modify | 0.012956 | 0.013504 | 0.01387 | 0.3 | 0.03 -Other | | 0.02828 | | | 0.05 - -Nlocal: 340 ave 346 max 336 min -Histogram: 1 0 1 0 1 0 0 0 0 1 -Nghost: 4537.5 ave 4540 max 4534 min -Histogram: 1 0 0 0 0 0 2 0 0 1 -Neighs: 62407 ave 62413 max 62402 min -Histogram: 1 0 0 1 1 0 0 0 0 1 -FullNghs: 63347.5 ave 65585 max 61866 min -Histogram: 1 1 0 1 0 0 0 0 0 1 - -Total # of neighbors = 253926 -Ave neighs/atom = 186.71 -Ave special neighs/atom = 0 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:53 diff --git a/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.1 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.1 new file mode 100644 index 0000000000..df3a7b70ab --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.1 @@ -0,0 +1,127 @@ +LAMMPS (31 Jul 2019) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer +# interactions can be specified separately + +read_data Bi_gr_AB_stack_2L_noH.data + orthogonal box = (0 0 0) to (42.6 41.8117 100) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000290871 secs + read_data CPU = 0.00159073 secs +mass 1 12.0107 # carbon mass (g/mole) | membrane +mass 2 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 +#################################################################### +pair_coeff * * rebo CH.rebo C C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * ilp/graphene/hbn BNCH.ILP C C # long range +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 + +compute 0 all pair rebo +compute 1 all pair ilp/graphene/hbn +variable REBO equal c_0 # REBO energy +variable ILP equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy + +############################ + +# Output +thermo 100 +thermo_style custom step etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp +thermo_modify lost warn + +###### Run molecular dynamics ###### +fix thermostat all nve +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair rebo, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (2) pair ilp/graphene/hbn, perpetual, copy from (1) + attributes: full, newton on, ghost + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 17.21 | 17.21 | 17.21 Mbytes +Step TotEng PotEng KinEng v_REBO v_ILP v_Erep v_Evdw Temp + 0 -10037.285 -10089.985 52.699361 -10057.189 -32.795185 43.640104 -76.435288 300 + 100 -10037.034 -10064.765 27.73131 -10032.181 -32.58421 34.730868 -67.315078 157.86516 + 200 -10036.963 -10061.144 24.18111 -10028.856 -32.288132 28.179936 -60.468068 137.65505 + 300 -10037.003 -10063.5 26.496726 -10030.823 -32.677105 34.923849 -67.600954 150.83708 + 400 -10037.032 -10064.389 27.356526 -10031.853 -32.535415 44.242347 -76.777762 155.73164 + 500 -10037.023 -10064.114 27.090279 -10031.431 -32.682418 37.229232 -69.91165 154.21598 + 600 -10037.003 -10063.657 26.653718 -10031.327 -32.329664 28.509073 -60.838737 151.73078 + 700 -10037.004 -10063.35 26.345697 -10030.801 -32.549231 32.564686 -65.113917 149.97732 + 800 -10037.025 -10064.219 27.194765 -10031.766 -32.453653 43.381557 -75.83521 154.81078 + 900 -10037.028 -10064.668 27.639127 -10032.167 -32.500121 39.99345 -72.493571 157.34039 + 1000 -10037.003 -10063.662 26.658825 -10031.337 -32.325053 29.573578 -61.898631 151.75986 +Loop time of 149.887 on 1 procs for 1000 steps with 1360 atoms + +Performance: 0.576 ns/day, 41.635 hours/ns, 6.672 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 149.75 | 149.75 | 149.75 | 0.0 | 99.91 +Bond | 0.00024772 | 0.00024772 | 0.00024772 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.086328 | 0.086328 | 0.086328 | 0.0 | 0.06 +Output | 0.00036383 | 0.00036383 | 0.00036383 | 0.0 | 0.00 +Modify | 0.028636 | 0.028636 | 0.028636 | 0.0 | 0.02 +Other | | 0.01708 | | | 0.01 + +Nlocal: 1360 ave 1360 max 1360 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7964 ave 7964 max 7964 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 1.037e+06 ave 1.037e+06 max 1.037e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1037000 +Ave neighs/atom = 762.5 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:02:30 diff --git a/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.4 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.4 new file mode 100644 index 0000000000..9ecc05ce6d --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-graphene.g++.4 @@ -0,0 +1,127 @@ +LAMMPS (31 Jul 2019) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use different molecule ids for each layer of hBN +# so that inter- and intra-layer +# interactions can be specified separately + +read_data Bi_gr_AB_stack_2L_noH.data + orthogonal box = (0 0 0) to (42.6 41.8117 100) + 2 by 2 by 1 MPI processor grid + reading atoms ... + 1360 atoms + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000157118 secs + read_data CPU = 0.00145698 secs +mass 1 12.0107 # carbon mass (g/mole) | membrane +mass 2 12.0107 # carbon mass (g/mole) | adsorbate +# Separate atom groups +group layer1 molecule 1 +680 atoms in group layer1 +group layer2 molecule 2 +680 atoms in group layer2 + +######################## Potential defition ######################## +pair_style hybrid/overlay rebo ilp/graphene/hbn 16.0 +#################################################################### +pair_coeff * * rebo CH.rebo C C # chemical +Reading potential file CH.rebo with DATE: 2018-7-3 +pair_coeff * * ilp/graphene/hbn BNCH.ILP C C # long range +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +velocity all create 300.0 12345 + +compute 0 all pair rebo +compute 1 all pair ilp/graphene/hbn +variable REBO equal c_0 # REBO energy +variable ILP equal c_1 # total interlayer energy +variable Evdw equal c_1[1] # attractive energy +variable Erep equal c_1[2] # repulsive energy + +############################ + +# Output +thermo 100 +thermo_style custom step etotal pe ke v_REBO v_ILP v_Erep v_Evdw temp +thermo_modify lost warn + +###### Run molecular dynamics ###### +fix thermostat all nve +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair rebo, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (2) pair ilp/graphene/hbn, perpetual, copy from (1) + attributes: full, newton on, ghost + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 9.879 | 9.879 | 9.879 Mbytes +Step TotEng PotEng KinEng v_REBO v_ILP v_Erep v_Evdw Temp + 0 -10037.285 -10089.985 52.699361 -10057.189 -32.795185 43.640104 -76.435288 300 + 100 -10037.034 -10064.765 27.73131 -10032.181 -32.58421 34.730868 -67.315078 157.86516 + 200 -10036.963 -10061.144 24.18111 -10028.856 -32.288132 28.179936 -60.468068 137.65505 + 300 -10037.003 -10063.5 26.496726 -10030.823 -32.677105 34.923849 -67.600954 150.83708 + 400 -10037.032 -10064.389 27.356526 -10031.853 -32.535415 44.242347 -76.777762 155.73164 + 500 -10037.023 -10064.114 27.090279 -10031.431 -32.682418 37.229232 -69.91165 154.21598 + 600 -10037.003 -10063.657 26.653718 -10031.327 -32.329664 28.509073 -60.838737 151.73078 + 700 -10037.004 -10063.35 26.345697 -10030.801 -32.549231 32.564686 -65.113917 149.97732 + 800 -10037.025 -10064.219 27.194765 -10031.766 -32.453653 43.381557 -75.83521 154.81078 + 900 -10037.028 -10064.668 27.639127 -10032.167 -32.500121 39.99345 -72.493571 157.34039 + 1000 -10037.003 -10063.662 26.658825 -10031.337 -32.325053 29.573578 -61.898631 151.75986 +Loop time of 44.6551 on 4 procs for 1000 steps with 1360 atoms + +Performance: 1.935 ns/day, 12.404 hours/ns, 22.394 timesteps/s +93.9% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 40.304 | 41.221 | 41.998 | 9.5 | 92.31 +Bond | 0.00027633 | 0.00029379 | 0.00031424 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 2.5678 | 3.3334 | 4.2403 | 32.9 | 7.46 +Output | 0.0051446 | 0.0054518 | 0.0059683 | 0.4 | 0.01 +Modify | 0.0088317 | 0.009002 | 0.0090654 | 0.1 | 0.02 +Other | | 0.08586 | | | 0.19 + +Nlocal: 340 ave 340 max 340 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 4628 ave 4628 max 4628 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 259250 ave 259250 max 259250 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1037000 +Ave neighs/atom = 762.5 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:44 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-hBN.g++.1 similarity index 56% rename from examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 rename to examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-hBN.g++.1 index abebb8df27..c5c6e94f15 100644 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.1 +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-hBN.g++.1 @@ -1,5 +1,4 @@ -LAMMPS (5 Jun 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) +LAMMPS (31 Jul 2019) using 1 OpenMP thread(s) per MPI task # Initialization units metal @@ -20,8 +19,8 @@ read_data hBN_AA_prime_stack_2L_noH.data 0 = max # of 1-3 neighbors 0 = max # of 1-4 neighbors 1 = max # of special neighbors - special bonds CPU = 0.000162885 secs - read_data CPU = 0.00152144 secs + special bonds CPU = 0.000375509 secs + read_data CPU = 0.00181293 secs mass 1 10.8110 # boron mass (g/mole) | membrane mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate mass 3 10.8110 # boron mass (g/mole) | membrane @@ -65,9 +64,8 @@ variable Erep equal c_2[2] # repulsive energy ############# Output ############### thermo 100 -thermo_style custom step cpu etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost error +thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify lost warn ###### Run molecular dynamics ###### run 1000 @@ -98,34 +96,34 @@ Neighbor list info ... pair build: halffull/newton stencil: none bin: none -Per MPI rank memory allocation (min/avg/max) = 39.16 | 39.16 | 39.16 Mbytes -Step CPU TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul Temp - 0 0.0000000000 -10193.1380848266 -10245.8374459431 52.6993611165 -77.5570687695 -10208.7302118650 -36.7764829084 40.7805858612 -77.5570687695 -0.3307511697 300.0000000000 - 100 6.7965245070 -10192.8138221665 -10215.1933919318 22.3795697653 -80.9976194405 -10177.8775571602 -36.9677356248 44.0298838157 -80.9976194405 -0.3480991468 127.3994748197 - 200 13.6121753111 -10192.9217984546 -10221.8066529747 28.8848545200 -86.3703194681 -10184.2512197444 -37.1689855905 49.2013338776 -86.3703194681 -0.3864476398 164.4319052911 - 300 20.4697002331 -10192.8780091121 -10219.0294731325 26.1514640204 -83.0639240055 -10182.3487520151 -36.3041195435 46.7598044620 -83.0639240055 -0.3766015739 148.8716189324 - 400 27.2477328760 -10192.8915023008 -10218.8337311224 25.9422288216 -78.3942416895 -10181.3978178066 -37.1109676261 41.2832740634 -78.3942416895 -0.3249456897 147.6805122794 - 500 34.0398510781 -10192.9091924320 -10221.3314056924 28.4222132604 -81.7685306349 -10184.0302799036 -36.9462261394 44.8223044955 -81.7685306349 -0.3548996493 161.7982419039 - 600 40.8147194131 -10192.8859685989 -10219.3709182378 26.4849496389 -86.2783346104 -10182.6694059460 -36.2951497597 49.9831848507 -86.2783346104 -0.4063625321 150.7700420526 - 700 47.6096971680 -10192.9015812429 -10220.9496893393 28.0481080963 -82.2887300963 -10183.2081700333 -37.3937397296 44.8949903667 -82.2887300963 -0.3477795764 159.6685851711 - 800 54.4165411390 -10192.8798040842 -10218.5099898620 25.6301857778 -78.0110194568 -10181.4267315419 -36.7542088970 41.2568105599 -78.0110194568 -0.3290494232 145.9041546318 - 900 61.2580328170 -10192.8940657565 -10220.5595028458 27.6654370893 -82.4743793723 -10183.8013123118 -36.3811572492 46.0932221231 -82.4743793723 -0.3770332848 157.4901659330 - 1000 68.0452993071 -10192.8973362869 -10219.0104657947 26.1131295079 -87.1256831340 -10181.2524878789 -37.3618984004 49.7637847337 -87.1256831340 -0.3960795154 148.6533932553 -Loop time of 68.0453 on 1 procs for 1000 steps with 1360 atoms +Per MPI rank memory allocation (min/avg/max) = 35.9 | 35.9 | 35.9 Mbytes +Step TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul Temp + 0 -10193.138 -10245.837 52.699361 -77.557069 -10208.73 -36.776483 40.780586 -77.557069 -0.33075117 300 + 100 -10192.814 -10215.193 22.37957 -80.997619 -10177.878 -36.967736 44.029884 -80.997619 -0.34809915 127.39947 + 200 -10192.922 -10221.807 28.884855 -86.370319 -10184.251 -37.168986 49.201334 -86.370319 -0.38644764 164.43191 + 300 -10192.878 -10219.029 26.151464 -83.063924 -10182.349 -36.30412 46.759804 -83.063924 -0.37660157 148.87162 + 400 -10192.892 -10218.834 25.942229 -78.394242 -10181.398 -37.110968 41.283274 -78.394242 -0.32494569 147.68051 + 500 -10192.909 -10221.331 28.422213 -81.768531 -10184.03 -36.946226 44.822304 -81.768531 -0.35489965 161.79824 + 600 -10192.886 -10219.371 26.48495 -86.278335 -10182.669 -36.29515 49.983185 -86.278335 -0.40636253 150.77004 + 700 -10192.902 -10220.95 28.048108 -82.28873 -10183.208 -37.39374 44.89499 -82.28873 -0.34777958 159.66859 + 800 -10192.88 -10218.51 25.630186 -78.011019 -10181.427 -36.754209 41.256811 -78.011019 -0.32904942 145.90415 + 900 -10192.894 -10220.56 27.665437 -82.474379 -10183.801 -36.381157 46.093222 -82.474379 -0.37703328 157.49017 + 1000 -10192.897 -10219.01 26.11313 -87.125683 -10181.252 -37.361898 49.763785 -87.125683 -0.39607952 148.65339 +Loop time of 211.527 on 1 procs for 1000 steps with 1360 atoms -Performance: 1.270 ns/day, 18.901 hours/ns, 14.696 timesteps/s -100.0% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 0.408 ns/day, 58.757 hours/ns, 4.728 timesteps/s +99.9% CPU use with 1 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 67.995 | 67.995 | 67.995 | 0.0 | 99.93 -Bond | 0.00047219 | 0.00047219 | 0.00047219 | 0.0 | 0.00 +Pair | 211.4 | 211.4 | 211.4 | 0.0 | 99.94 +Bond | 0.00018859 | 0.00018859 | 0.00018859 | 0.0 | 0.00 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.030427 | 0.030427 | 0.030427 | 0.0 | 0.04 -Output | 0.000568 | 0.000568 | 0.000568 | 0.0 | 0.00 -Modify | 0.0089312 | 0.0089312 | 0.0089312 | 0.0 | 0.01 -Other | | 0.01005 | | | 0.01 +Comm | 0.082034 | 0.082034 | 0.082034 | 0.0 | 0.04 +Output | 0.00037289 | 0.00037289 | 0.00037289 | 0.0 | 0.00 +Modify | 0.027928 | 0.027928 | 0.027928 | 0.0 | 0.01 +Other | | 0.0159 | | | 0.01 Nlocal: 1360 ave 1360 max 1360 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -141,4 +139,4 @@ Ave neighs/atom = 739 Ave special neighs/atom = 0 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:01:08 +Total wall time: 0:03:31 diff --git a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-hBN.g++.4 similarity index 56% rename from examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 rename to examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-hBN.g++.4 index 8ad5875282..7a0b7a269b 100644 --- a/examples/USER/misc/ilp_graphene_hbn/bilayer-hBN/log.5Jun19.bilayer_hBN.icc.4 +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.bilayer-hBN.g++.4 @@ -1,5 +1,4 @@ -LAMMPS (5 Jun 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) +LAMMPS (31 Jul 2019) using 1 OpenMP thread(s) per MPI task # Initialization units metal @@ -20,8 +19,8 @@ read_data hBN_AA_prime_stack_2L_noH.data 0 = max # of 1-3 neighbors 0 = max # of 1-4 neighbors 1 = max # of special neighbors - special bonds CPU = 0.00013403 secs - read_data CPU = 0.00236647 secs + special bonds CPU = 0.000224352 secs + read_data CPU = 0.00160909 secs mass 1 10.8110 # boron mass (g/mole) | membrane mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate mass 3 10.8110 # boron mass (g/mole) | membrane @@ -65,9 +64,8 @@ variable Erep equal c_2[2] # repulsive energy ############# Output ############### thermo 100 -thermo_style custom step cpu etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp -thermo_modify line one format float %.10f -thermo_modify flush yes norm no lost error +thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul temp +thermo_modify lost warn ###### Run molecular dynamics ###### run 1000 @@ -98,34 +96,34 @@ Neighbor list info ... pair build: halffull/newton stencil: none bin: none -Per MPI rank memory allocation (min/avg/max) = 20.72 | 20.72 | 20.72 Mbytes -Step CPU TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul Temp - 0 0.0000000000 -10193.1380848270 -10245.8374459435 52.6993611165 -77.5570687695 -10208.7302118654 -36.7764829083 40.7805858612 -77.5570687695 -0.3307511697 300.0000000000 - 100 2.1550989150 -10192.8138221665 -10215.1933919317 22.3795697653 -80.9976194405 -10177.8775571601 -36.9677356248 44.0298838158 -80.9976194405 -0.3480991468 127.3994748197 - 200 4.3479236889 -10192.9217984546 -10221.8066529746 28.8848545200 -86.3703194681 -10184.2512197444 -37.1689855904 49.2013338777 -86.3703194681 -0.3864476398 164.4319052911 - 300 6.5410459590 -10192.8780091121 -10219.0294731324 26.1514640204 -83.0639240055 -10182.3487520151 -36.3041195435 46.7598044620 -83.0639240055 -0.3766015739 148.8716189324 - 400 8.7036962360 -10192.8915023008 -10218.8337311224 25.9422288216 -78.3942416895 -10181.3978178066 -37.1109676261 41.2832740634 -78.3942416895 -0.3249456897 147.6805122794 - 500 10.8535934120 -10192.9091924320 -10221.3314056923 28.4222132604 -81.7685306349 -10184.0302799036 -36.9462261394 44.8223044955 -81.7685306349 -0.3548996493 161.7982419039 - 600 12.9922130840 -10192.8859685988 -10219.3709182377 26.4849496389 -86.2783346104 -10182.6694059459 -36.2951497597 49.9831848507 -86.2783346104 -0.4063625321 150.7700420526 - 700 15.1486390879 -10192.9015812430 -10220.9496893393 28.0481080963 -82.2887300963 -10183.2081700333 -37.3937397295 44.8949903668 -82.2887300963 -0.3477795764 159.6685851711 - 800 17.3069961029 -10192.8798040842 -10218.5099898620 25.6301857778 -78.0110194568 -10181.4267315419 -36.7542088969 41.2568105599 -78.0110194568 -0.3290494232 145.9041546318 - 900 19.4832645269 -10192.8940657564 -10220.5595028457 27.6654370893 -82.4743793723 -10183.8013123118 -36.3811572492 46.0932221231 -82.4743793723 -0.3770332848 157.4901659330 - 1000 21.6507079899 -10192.8973362868 -10219.0104657947 26.1131295079 -87.1256831340 -10181.2524878789 -37.3618984003 49.7637847337 -87.1256831340 -0.3960795154 148.6533932553 -Loop time of 21.6507 on 4 procs for 1000 steps with 1360 atoms +Per MPI rank memory allocation (min/avg/max) = 18.99 | 18.99 | 18.99 Mbytes +Step TotEng PotEng KinEng v_Evdw v_Tersoff v_EILP v_Erep v_Evdw v_Ecoul Temp + 0 -10193.138 -10245.837 52.699361 -77.557069 -10208.73 -36.776483 40.780586 -77.557069 -0.33075117 300 + 100 -10192.814 -10215.193 22.37957 -80.997619 -10177.878 -36.967736 44.029884 -80.997619 -0.34809915 127.39947 + 200 -10192.922 -10221.807 28.884855 -86.370319 -10184.251 -37.168986 49.201334 -86.370319 -0.38644764 164.43191 + 300 -10192.878 -10219.029 26.151464 -83.063924 -10182.349 -36.30412 46.759804 -83.063924 -0.37660157 148.87162 + 400 -10192.892 -10218.834 25.942229 -78.394242 -10181.398 -37.110968 41.283274 -78.394242 -0.32494569 147.68051 + 500 -10192.909 -10221.331 28.422213 -81.768531 -10184.03 -36.946226 44.822304 -81.768531 -0.35489965 161.79824 + 600 -10192.886 -10219.371 26.48495 -86.278335 -10182.669 -36.29515 49.983185 -86.278335 -0.40636253 150.77004 + 700 -10192.902 -10220.95 28.048108 -82.28873 -10183.208 -37.39374 44.89499 -82.28873 -0.34777958 159.66859 + 800 -10192.88 -10218.51 25.630186 -78.011019 -10181.427 -36.754209 41.256811 -78.011019 -0.32904942 145.90415 + 900 -10192.894 -10220.56 27.665437 -82.474379 -10183.801 -36.381157 46.093222 -82.474379 -0.37703328 157.49017 + 1000 -10192.897 -10219.01 26.11313 -87.125683 -10181.252 -37.361898 49.763785 -87.125683 -0.39607952 148.65339 +Loop time of 68.3631 on 4 procs for 1000 steps with 1360 atoms -Performance: 3.991 ns/day, 6.014 hours/ns, 46.188 timesteps/s -99.8% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 1.264 ns/day, 18.990 hours/ns, 14.628 timesteps/s +98.5% CPU use with 4 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 20.152 | 20.681 | 21.202 | 8.2 | 95.52 -Bond | 0.00039643 | 0.00043971 | 0.00048381 | 0.0 | 0.00 +Pair | 64.58 | 66.38 | 67.402 | 13.2 | 97.10 +Bond | 0.0001719 | 0.00021869 | 0.00024033 | 0.0 | 0.00 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.43171 | 0.9526 | 1.482 | 38.2 | 4.40 -Output | 0.00028839 | 0.00037988 | 0.00064771 | 0.0 | 0.00 -Modify | 0.0046368 | 0.0047831 | 0.0050183 | 0.2 | 0.02 -Other | | 0.01106 | | | 0.05 +Comm | 0.93767 | 1.9601 | 3.76 | 77.0 | 2.87 +Output | 0.00033593 | 0.00061601 | 0.0014501 | 0.0 | 0.00 +Modify | 0.0085733 | 0.0089303 | 0.0093236 | 0.4 | 0.01 +Other | | 0.01285 | | | 0.02 Nlocal: 340 ave 340 max 340 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -141,4 +139,4 @@ Ave neighs/atom = 739 Ave special neighs/atom = 0 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:21 +Total wall time: 0:01:08 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.1 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.grhBN.g++.1 similarity index 60% rename from examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.1 rename to examples/USER/misc/ilp_graphene_hbn/log.31Jul19.grhBN.g++.1 index 65e32502f0..f9f1dedff6 100644 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.1 +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.grhBN.g++.1 @@ -1,5 +1,4 @@ -LAMMPS (5 Jun 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) +LAMMPS (31 Jul 2019) using 1 OpenMP thread(s) per MPI task # Initialization units metal @@ -20,8 +19,8 @@ read_data gr_hBN_Cstack_2L_noH.data 0 = max # of 1-3 neighbors 0 = max # of 1-4 neighbors 1 = max # of special neighbors - special bonds CPU = 0.000152684 secs - read_data CPU = 0.00139584 secs + special bonds CPU = 0.000282049 secs + read_data CPU = 0.00159025 secs mass 1 10.8110 # boron mass (g/mole) | membrane mass 2 14.0067 # nitrogen mass (g/mole) | membrane mass 3 12.0107 # carbon mass (g/mole) | adsorbate @@ -68,7 +67,6 @@ variable Ecoul equal c_3 ############# Output ############## thermo 100 thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul temp -thermo_modify line one format float %.10f ###### Run molecular dynamics ###### run 1000 @@ -109,34 +107,34 @@ Neighbor list info ... pair build: halffull/newton stencil: none bin: none -Per MPI rank memory allocation (min/avg/max) = 25.93 | 25.93 | 25.93 Mbytes +Per MPI rank memory allocation (min/avg/max) = 22.52 | 22.52 | 22.52 Mbytes Step TotEng PotEng KinEng v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul Temp - 0 -10707.2836653377 -10763.0852699342 55.8016045965 -75.2477261362 -5401.7347845703 -5322.2780768034 -39.0724085605 36.1753175757 -75.2477261362 0.0000000000 300.0000000000 - 100 -10707.0738132278 -10737.1273434298 30.0535302020 -73.2173218622 -5389.9568321958 -5309.2004092412 -37.9701019928 35.2472198694 -73.2173218622 0.0000000000 161.5734731251 - 200 -10707.0160305531 -10734.9317906949 27.9157601418 -71.6030968581 -5389.1293717071 -5307.7455440517 -38.0568749361 33.5462219220 -71.6030968581 0.0000000000 150.0804162013 - 300 -10707.0133459577 -10734.9870508108 27.9737048532 -75.0821335395 -5388.9196081501 -5308.1164952096 -37.9509474511 37.1311860884 -75.0821335395 0.0000000000 150.3919379493 - 400 -10707.0118845924 -10735.4980560195 28.4861714271 -76.3398711857 -5389.1656629670 -5308.1529507210 -38.1794423315 38.1604288542 -76.3398711857 0.0000000000 153.1470553564 - 500 -10707.0073064907 -10734.6814074933 27.6741010026 -73.3123544614 -5388.7261058688 -5307.7383573628 -38.2169442617 35.0954101998 -73.3123544614 0.0000000000 148.7812108775 - 600 -10707.0179599067 -10735.8330915547 28.8151316481 -71.9277634955 -5389.0797599186 -5308.5959984739 -38.1573331622 33.7704303333 -71.9277634955 0.0000000000 154.9156078382 - 700 -10707.0202991119 -10735.6556762202 28.6353771083 -74.6793707186 -5389.2970704981 -5308.1866033124 -38.1720024097 36.5073683089 -74.6793707186 0.0000000000 153.9492133711 - 800 -10707.0042706783 -10734.3516957279 27.3474250495 -76.3712879764 -5388.5923210533 -5307.7206382682 -38.0387364064 38.3325515700 -76.3712879764 0.0000000000 147.0249390530 - 900 -10707.0144790011 -10735.8318835748 28.8174045738 -73.6993318112 -5388.9674133804 -5308.7963924816 -38.0680777128 35.6312540984 -73.6993318112 0.0000000000 154.9278275177 - 1000 -10706.9953891527 -10733.5615396283 26.5661504756 -71.4398677888 -5388.0186485439 -5307.4414386685 -38.1014524159 33.3384153730 -71.4398677888 0.0000000000 142.8246589021 -Loop time of 55.1175 on 1 procs for 1000 steps with 1440 atoms + 0 -10707.284 -10763.085 55.801605 -75.247726 -5401.7348 -5322.2781 -39.072409 36.175318 -75.247726 0 300 + 100 -10707.074 -10737.127 30.05353 -73.217322 -5389.9568 -5309.2004 -37.970102 35.24722 -73.217322 0 161.57347 + 200 -10707.016 -10734.932 27.91576 -71.603097 -5389.1294 -5307.7455 -38.056875 33.546222 -71.603097 0 150.08042 + 300 -10707.013 -10734.987 27.973705 -75.082134 -5388.9196 -5308.1165 -37.950947 37.131186 -75.082134 0 150.39194 + 400 -10707.012 -10735.498 28.486171 -76.339871 -5389.1657 -5308.153 -38.179442 38.160429 -76.339871 0 153.14706 + 500 -10707.007 -10734.681 27.674101 -73.312354 -5388.7261 -5307.7384 -38.216944 35.09541 -73.312354 0 148.78121 + 600 -10707.018 -10735.833 28.815132 -71.927763 -5389.0798 -5308.596 -38.157333 33.77043 -71.927763 0 154.91561 + 700 -10707.02 -10735.656 28.635377 -74.679371 -5389.2971 -5308.1866 -38.172002 36.507368 -74.679371 0 153.94921 + 800 -10707.004 -10734.352 27.347425 -76.371288 -5388.5923 -5307.7206 -38.038736 38.332552 -76.371288 0 147.02494 + 900 -10707.014 -10735.832 28.817405 -73.699332 -5388.9674 -5308.7964 -38.068078 35.631254 -73.699332 0 154.92783 + 1000 -10706.995 -10733.562 26.56615 -71.439868 -5388.0186 -5307.4414 -38.101452 33.338415 -71.439868 0 142.82466 +Loop time of 152.66 on 1 procs for 1000 steps with 1440 atoms -Performance: 1.568 ns/day, 15.310 hours/ns, 18.143 timesteps/s -100.0% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 0.566 ns/day, 42.406 hours/ns, 6.550 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 55.062 | 55.062 | 55.062 | 0.0 | 99.90 -Bond | 0.00046717 | 0.00046717 | 0.00046717 | 0.0 | 0.00 +Pair | 152.52 | 152.52 | 152.52 | 0.0 | 99.91 +Bond | 0.00023174 | 0.00023174 | 0.00023174 | 0.0 | 0.00 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.034313 | 0.034313 | 0.034313 | 0.0 | 0.06 -Output | 0.00034028 | 0.00034028 | 0.00034028 | 0.0 | 0.00 -Modify | 0.010012 | 0.010012 | 0.010012 | 0.0 | 0.02 -Other | | 0.01061 | | | 0.02 +Comm | 0.087147 | 0.087147 | 0.087147 | 0.0 | 0.06 +Output | 0.0004189 | 0.0004189 | 0.0004189 | 0.0 | 0.00 +Modify | 0.029972 | 0.029972 | 0.029972 | 0.0 | 0.02 +Other | | 0.02057 | | | 0.01 Nlocal: 1440 ave 1440 max 1440 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -152,4 +150,4 @@ Ave neighs/atom = 195 Ave special neighs/atom = 0 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:55 +Total wall time: 0:02:32 diff --git a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.4 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.grhBN.g++.4 similarity index 60% rename from examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.4 rename to examples/USER/misc/ilp_graphene_hbn/log.31Jul19.grhBN.g++.4 index 9ea23fb6e3..a7b97a81b7 100644 --- a/examples/USER/misc/ilp_graphene_hbn/gr-hBN/log.5Jun19.grhBN.icc.4 +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.grhBN.g++.4 @@ -1,5 +1,4 @@ -LAMMPS (5 Jun 2019) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (../comm.cpp:88) +LAMMPS (31 Jul 2019) using 1 OpenMP thread(s) per MPI task # Initialization units metal @@ -20,8 +19,8 @@ read_data gr_hBN_Cstack_2L_noH.data 0 = max # of 1-3 neighbors 0 = max # of 1-4 neighbors 1 = max # of special neighbors - special bonds CPU = 0.000148868 secs - read_data CPU = 0.00332732 secs + special bonds CPU = 0.00012207 secs + read_data CPU = 0.00357461 secs mass 1 10.8110 # boron mass (g/mole) | membrane mass 2 14.0067 # nitrogen mass (g/mole) | membrane mass 3 12.0107 # carbon mass (g/mole) | adsorbate @@ -68,7 +67,6 @@ variable Ecoul equal c_3 ############# Output ############## thermo 100 thermo_style custom step etotal pe ke v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul temp -thermo_modify line one format float %.10f ###### Run molecular dynamics ###### run 1000 @@ -109,34 +107,34 @@ Neighbor list info ... pair build: halffull/newton stencil: none bin: none -Per MPI rank memory allocation (min/avg/max) = 14.25 | 14.25 | 14.25 Mbytes +Per MPI rank memory allocation (min/avg/max) = 12.45 | 12.45 | 12.45 Mbytes Step TotEng PotEng KinEng v_Evdw v_Tersoff v_REBO v_EILP v_Erep v_Evdw v_Ecoul Temp - 0 -10707.2836653376 -10763.0852699341 55.8016045965 -75.2477261361 -5401.7347845703 -5322.2780768034 -39.0724085604 36.1753175757 -75.2477261361 0.0000000000 300.0000000000 - 100 -10707.0738132277 -10737.1273434298 30.0535302020 -73.2173218622 -5389.9568321958 -5309.2004092412 -37.9701019928 35.2472198694 -73.2173218622 0.0000000000 161.5734731251 - 200 -10707.0160305531 -10734.9317906949 27.9157601418 -71.6030968581 -5389.1293717071 -5307.7455440517 -38.0568749361 33.5462219220 -71.6030968581 0.0000000000 150.0804162013 - 300 -10707.0133459576 -10734.9870508108 27.9737048532 -75.0821335395 -5388.9196081501 -5308.1164952096 -37.9509474511 37.1311860885 -75.0821335395 0.0000000000 150.3919379493 - 400 -10707.0118845923 -10735.4980560194 28.4861714271 -76.3398711857 -5389.1656629669 -5308.1529507210 -38.1794423315 38.1604288542 -76.3398711857 0.0000000000 153.1470553564 - 500 -10707.0073064907 -10734.6814074932 27.6741010026 -73.3123544614 -5388.7261058688 -5307.7383573628 -38.2169442616 35.0954101998 -73.3123544614 0.0000000000 148.7812108775 - 600 -10707.0179599066 -10735.8330915547 28.8151316481 -71.9277634955 -5389.0797599186 -5308.5959984739 -38.1573331622 33.7704303333 -71.9277634955 0.0000000000 154.9156078382 - 700 -10707.0202991119 -10735.6556762202 28.6353771083 -74.6793707186 -5389.2970704981 -5308.1866033124 -38.1720024097 36.5073683089 -74.6793707186 0.0000000000 153.9492133711 - 800 -10707.0042706783 -10734.3516957278 27.3474250495 -76.3712879764 -5388.5923210533 -5307.7206382682 -38.0387364063 38.3325515701 -76.3712879764 0.0000000000 147.0249390530 - 900 -10707.0144790010 -10735.8318835748 28.8174045738 -73.6993318112 -5388.9674133804 -5308.7963924816 -38.0680777128 35.6312540984 -73.6993318112 0.0000000000 154.9278275177 - 1000 -10706.9953891527 -10733.5615396283 26.5661504756 -71.4398677888 -5388.0186485439 -5307.4414386685 -38.1014524158 33.3384153730 -71.4398677888 0.0000000000 142.8246589021 -Loop time of 15.7325 on 4 procs for 1000 steps with 1440 atoms + 0 -10707.284 -10763.085 55.801605 -75.247726 -5401.7348 -5322.2781 -39.072409 36.175318 -75.247726 0 300 + 100 -10707.074 -10737.127 30.05353 -73.217322 -5389.9568 -5309.2004 -37.970102 35.24722 -73.217322 0 161.57347 + 200 -10707.016 -10734.932 27.91576 -71.603097 -5389.1294 -5307.7455 -38.056875 33.546222 -71.603097 0 150.08042 + 300 -10707.013 -10734.987 27.973705 -75.082134 -5388.9196 -5308.1165 -37.950947 37.131186 -75.082134 0 150.39194 + 400 -10707.012 -10735.498 28.486171 -76.339871 -5389.1657 -5308.153 -38.179442 38.160429 -76.339871 0 153.14706 + 500 -10707.007 -10734.681 27.674101 -73.312354 -5388.7261 -5307.7384 -38.216944 35.09541 -73.312354 0 148.78121 + 600 -10707.018 -10735.833 28.815132 -71.927763 -5389.0798 -5308.596 -38.157333 33.77043 -71.927763 0 154.91561 + 700 -10707.02 -10735.656 28.635377 -74.679371 -5389.2971 -5308.1866 -38.172002 36.507368 -74.679371 0 153.94921 + 800 -10707.004 -10734.352 27.347425 -76.371288 -5388.5923 -5307.7206 -38.038736 38.332552 -76.371288 0 147.02494 + 900 -10707.014 -10735.832 28.817405 -73.699332 -5388.9674 -5308.7964 -38.068078 35.631254 -73.699332 0 154.92783 + 1000 -10706.995 -10733.562 26.56615 -71.439868 -5388.0186 -5307.4414 -38.101452 33.338415 -71.439868 0 142.82466 +Loop time of 54.095 on 4 procs for 1000 steps with 1440 atoms -Performance: 5.492 ns/day, 4.370 hours/ns, 63.563 timesteps/s -99.8% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 1.597 ns/day, 15.026 hours/ns, 18.486 timesteps/s +84.8% CPU use with 4 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 13.905 | 14.645 | 15.391 | 14.5 | 93.08 -Bond | 0.00029796 | 0.00040495 | 0.00046212 | 0.0 | 0.00 +Pair | 42.138 | 45.531 | 49.106 | 42.0 | 84.17 +Bond | 0.0003159 | 0.00037384 | 0.000489 | 0.0 | 0.00 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.3261 | 1.0722 | 1.8116 | 53.4 | 6.82 -Output | 0.00028242 | 0.00030932 | 0.00037515 | 0.0 | 0.00 -Modify | 0.0046079 | 0.0047365 | 0.0048651 | 0.2 | 0.03 -Other | | 0.01031 | | | 0.07 +Comm | 4.71 | 8.2803 | 11.682 | 98.3 | 15.31 +Output | 0.0021999 | 0.0055975 | 0.013382 | 6.0 | 0.01 +Modify | 0.0092845 | 0.010981 | 0.012538 | 1.3 | 0.02 +Other | | 0.2673 | | | 0.49 Nlocal: 360 ave 380 max 340 min Histogram: 2 0 0 0 0 0 0 0 0 2 @@ -152,4 +150,4 @@ Ave neighs/atom = 195 Ave special neighs/atom = 0 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:15 +Total wall time: 0:00:54 diff --git a/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.1 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.1 new file mode 100644 index 0000000000..1845c2e54d --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.1 @@ -0,0 +1,154 @@ +LAMMPS (31 Jul 2019) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use 2 atom types so that inter- and intra-layer +# interactions can be specified separately +read_data hBN_AB_stack_2L_noH_equi_300K.data + orthogonal box = (0 0 0) to (43.38 42.5773 100) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1360 atoms + reading velocities ... + 1360 velocities + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000251532 secs + read_data CPU = 0.00451231 secs +mass 1 10.8110 # boron mass (g/mole) | membrane +mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate +mass 3 10.8110 # boron mass (g/mole) | membrane +mass 4 14.0067 # nitrogen mass (g/mole) | adsorbate +# Separate atom groups +group membrane type 1 2 +680 atoms in group membrane +group adsorbate type 3 4 +680 atoms in group adsorbate + +######################## Potential defition ######################## +pair_style hybrid/overlay tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 1 +#################################################################### +pair_coeff * * tersoff BNC.tersoff NULL NULL B N # chemical +Reading potential file BNC.tersoff with DATE: 2013-03-21 +pair_coeff * * ilp/graphene/hbn BNCH-old.ILP B N B N # long range +pair_coeff 1 3 coul/shield 0.70 +pair_coeff 1 4 coul/shield 0.69498201415576216335 +pair_coeff 2 3 coul/shield 0.69498201415576216335 +pair_coeff 2 4 coul/shield 0.69 +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +#velocity adsorbate create 300.0 12345 +fix subf membrane setforce 0.0 0.0 0.0 +fix thermostat all nve + +compute 0 all pair tersoff +compute 1 all pair coul/shield ecoul +compute 2 all pair ilp/graphene/hbn +variable Tersoff equal c_0 +variable Ecoul equal c_1 +variable ILP equal c_2 +variable Evdw equal c_2[1] +variable Erep equal c_2[2] + +############################ + +# Output +thermo 100 +thermo_style custom step etotal pe ke v_Tersoff v_ILP v_Ecoul v_Erep v_Evdw temp +thermo_modify lost warn #ignore + +#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu +#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes + +###### Run molecular dynamics ###### +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 5 neighbor lists, perpetual/occasional/extra = 5 0 0 + (1) pair tersoff, perpetual, skip from (4) + attributes: full, newton on + pair build: skip + stencil: none + bin: none + (2) pair ilp/graphene/hbn, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (3) pair coul/shield, perpetual, skip from (5) + attributes: half, newton on + pair build: skip + stencil: none + bin: none + (4) neighbor class addition, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (5) neighbor class addition, perpetual, half/full from (4) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 54.59 | 54.59 | 54.59 Mbytes +Step TotEng PotEng KinEng v_Tersoff v_ILP v_Ecoul v_Erep v_Evdw Temp + 0 -5114.6628 -5127.8586 13.195828 -5091.4121 -36.083114 -0.36343598 38.918674 -75.001787 75.119474 + 100 -5114.6621 -5127.6958 13.033777 -5091.2408 -36.09276 -0.36228286 38.769906 -74.862666 74.196973 + 200 -5114.6631 -5127.5945 12.93145 -5091.1508 -36.086669 -0.35708801 38.20076 -74.287429 73.614462 + 300 -5114.6694 -5128.3286 13.65924 -5091.8646 -36.110786 -0.35328159 37.758284 -73.86907 77.757528 + 400 -5114.6614 -5127.6424 12.980975 -5091.2348 -36.049634 -0.35794328 38.247252 -74.296886 73.896389 + 500 -5114.66 -5127.4098 12.749794 -5090.9285 -36.119571 -0.36174976 38.745548 -74.865119 72.580351 + 600 -5114.6673 -5128.0913 13.424021 -5091.6339 -36.09384 -0.36356991 38.927401 -75.021241 76.418503 + 700 -5114.661 -5127.7467 13.085707 -5091.2811 -36.106639 -0.35892399 38.332616 -74.439255 74.492596 + 800 -5114.6623 -5128.013 13.350778 -5091.5694 -36.089718 -0.35392503 37.851602 -73.94132 76.001554 + 900 -5114.6675 -5128.1497 13.482146 -5091.6704 -36.124679 -0.35462869 37.885183 -74.009861 76.749392 + 1000 -5114.6683 -5128.3365 13.668146 -5091.937 -36.037596 -0.36184347 38.709718 -74.747314 77.808228 +Loop time of 207.028 on 1 procs for 1000 steps with 1360 atoms + +Performance: 0.417 ns/day, 57.508 hours/ns, 4.830 timesteps/s +99.9% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 206.9 | 206.9 | 206.9 | 0.0 | 99.94 +Bond | 0.00019169 | 0.00019169 | 0.00019169 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.081397 | 0.081397 | 0.081397 | 0.0 | 0.04 +Output | 0.00036597 | 0.00036597 | 0.00036597 | 0.0 | 0.00 +Modify | 0.033408 | 0.033408 | 0.033408 | 0.0 | 0.02 +Other | | 0.01615 | | | 0.01 + +Nlocal: 1360 ave 1360 max 1360 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7840 ave 7840 max 7840 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 249628 ave 249628 max 249628 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 253390 ave 253390 max 253390 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 253390 +Ave neighs/atom = 186.316 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:03:27 diff --git a/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.4 b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.4 new file mode 100644 index 0000000000..ec2a8443a4 --- /dev/null +++ b/examples/USER/misc/ilp_graphene_hbn/log.31Jul19.ilp_graphene_hbn.g++.4 @@ -0,0 +1,154 @@ +LAMMPS (31 Jul 2019) + using 1 OpenMP thread(s) per MPI task +# Initialization +units metal +boundary p p p +atom_style full +processors * * 1 # domain decomposition over x and y + +# System and atom definition +# we use 2 atom types so that inter- and intra-layer +# interactions can be specified separately +read_data hBN_AB_stack_2L_noH_equi_300K.data + orthogonal box = (0 0 0) to (43.38 42.5773 100) + 2 by 2 by 1 MPI processor grid + reading atoms ... + 1360 atoms + reading velocities ... + 1360 velocities + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors + special bonds CPU = 0.000332117 secs + read_data CPU = 0.00270581 secs +mass 1 10.8110 # boron mass (g/mole) | membrane +mass 2 14.0067 # nitrogen mass (g/mole) | adsorbate +mass 3 10.8110 # boron mass (g/mole) | membrane +mass 4 14.0067 # nitrogen mass (g/mole) | adsorbate +# Separate atom groups +group membrane type 1 2 +680 atoms in group membrane +group adsorbate type 3 4 +680 atoms in group adsorbate + +######################## Potential defition ######################## +pair_style hybrid/overlay tersoff ilp/graphene/hbn 16.0 coul/shield 16.0 1 +#################################################################### +pair_coeff * * tersoff BNC.tersoff NULL NULL B N # chemical +Reading potential file BNC.tersoff with DATE: 2013-03-21 +pair_coeff * * ilp/graphene/hbn BNCH-old.ILP B N B N # long range +pair_coeff 1 3 coul/shield 0.70 +pair_coeff 1 4 coul/shield 0.69498201415576216335 +pair_coeff 2 3 coul/shield 0.69498201415576216335 +pair_coeff 2 4 coul/shield 0.69 +#################################################################### +# Neighbor update settings +neighbor 2.0 bin +neigh_modify every 1 +neigh_modify delay 0 +neigh_modify check yes + +#### Simulation settings #### +timestep 0.001 +#velocity adsorbate create 300.0 12345 +fix subf membrane setforce 0.0 0.0 0.0 +fix thermostat all nve + +compute 0 all pair tersoff +compute 1 all pair coul/shield ecoul +compute 2 all pair ilp/graphene/hbn +variable Tersoff equal c_0 +variable Ecoul equal c_1 +variable ILP equal c_2 +variable Evdw equal c_2[1] +variable Erep equal c_2[2] + +############################ + +# Output +thermo 100 +thermo_style custom step etotal pe ke v_Tersoff v_ILP v_Ecoul v_Erep v_Evdw temp +thermo_modify lost warn #ignore + +#dump 1 all custom 1000 traj.lammpstrj id mol type xu yu zu +#dump_modify 1 format line "%7d %3d %3d %15.10g %15.10g %15.10g" flush yes + +###### Run molecular dynamics ###### +run 1000 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 18 + ghost atom cutoff = 18 + binsize = 9, bins = 5 5 12 + 5 neighbor lists, perpetual/occasional/extra = 5 0 0 + (1) pair tersoff, perpetual, skip from (4) + attributes: full, newton on + pair build: skip + stencil: none + bin: none + (2) pair ilp/graphene/hbn, perpetual + attributes: full, newton on, ghost + pair build: full/bin/ghost + stencil: full/ghost/bin/3d + bin: standard + (3) pair coul/shield, perpetual, skip from (5) + attributes: half, newton on + pair build: skip + stencil: none + bin: none + (4) neighbor class addition, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (5) neighbor class addition, perpetual, half/full from (4) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 28.9 | 28.9 | 28.9 Mbytes +Step TotEng PotEng KinEng v_Tersoff v_ILP v_Ecoul v_Erep v_Evdw Temp + 0 -5114.6628 -5127.8586 13.195828 -5091.4121 -36.083114 -0.36343598 38.918674 -75.001787 75.119474 + 100 -5114.6621 -5127.6958 13.033777 -5091.2408 -36.09276 -0.36228286 38.769906 -74.862666 74.196973 + 200 -5114.6631 -5127.5945 12.93145 -5091.1508 -36.086669 -0.35708801 38.20076 -74.287429 73.614462 + 300 -5114.6694 -5128.3286 13.65924 -5091.8646 -36.110786 -0.35328159 37.758284 -73.86907 77.757528 + 400 -5114.6614 -5127.6424 12.980975 -5091.2348 -36.049634 -0.35794328 38.247252 -74.296886 73.896389 + 500 -5114.66 -5127.4098 12.749794 -5090.9285 -36.119571 -0.36174976 38.745548 -74.865119 72.580351 + 600 -5114.6673 -5128.0913 13.424021 -5091.6339 -36.09384 -0.36356991 38.927401 -75.021241 76.418503 + 700 -5114.661 -5127.7467 13.085707 -5091.2811 -36.106639 -0.35892399 38.332616 -74.439255 74.492596 + 800 -5114.6623 -5128.013 13.350778 -5091.5694 -36.089718 -0.35392503 37.851602 -73.94132 76.001554 + 900 -5114.6675 -5128.1497 13.482146 -5091.6704 -36.124679 -0.35462869 37.885183 -74.009861 76.749392 + 1000 -5114.6683 -5128.3365 13.668146 -5091.937 -36.037596 -0.36184347 38.709718 -74.747314 77.808228 +Loop time of 65.9005 on 4 procs for 1000 steps with 1360 atoms + +Performance: 1.311 ns/day, 18.306 hours/ns, 15.174 timesteps/s +98.9% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 63.244 | 64.208 | 65.281 | 10.1 | 97.43 +Bond | 0.00013971 | 0.00017679 | 0.00022101 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.58237 | 1.6612 | 2.6292 | 63.1 | 2.52 +Output | 0.0003171 | 0.00062358 | 0.0015192 | 0.0 | 0.00 +Modify | 0.010251 | 0.010509 | 0.01075 | 0.2 | 0.02 +Other | | 0.02025 | | | 0.03 + +Nlocal: 340 ave 346 max 336 min +Histogram: 1 0 1 0 1 0 0 0 0 1 +Nghost: 4537.5 ave 4540 max 4534 min +Histogram: 1 0 0 0 0 0 2 0 0 1 +Neighs: 62407 ave 62413 max 62402 min +Histogram: 1 0 0 1 1 0 0 0 0 1 +FullNghs: 63347.5 ave 65585 max 61866 min +Histogram: 1 1 0 1 0 0 0 0 0 1 + +Total # of neighbors = 253926 +Ave neighs/atom = 186.71 +Ave special neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:01:06 -- GitLab From 52e2db44a1c3f1c30cdc99580078251d61b80962 Mon Sep 17 00:00:00 2001 From: Giacomo Fiorin Date: Thu, 1 Aug 2019 15:12:42 -0400 Subject: [PATCH 408/469] Update Colvars to version 2019-08-01 One new feature (geometric path variables) and bugfixes. Minimize occurrence of file-read errors in multiple-walker metadynamics https://github.com/Colvars/colvars/pull/276 Better error messages for RMSD https://github.com/Colvars/colvars/pull/272 Ensemble-biased metadynamics documentation https://github.com/Colvars/colvars/pull/261 Fix bug on multiple walkers metadynamics, pmf included twice https://github.com/Colvars/colvars/pull/259 Implementation of the geometric path collective variables (C++11-only feature) https://github.com/Colvars/colvars/pull/249 --- doc/src/PDF/colvars-refman-lammps.pdf | Bin 628031 -> 665730 bytes lib/colvars/Makefile.common | 1 + lib/colvars/colvar.cpp | 20 +- lib/colvars/colvar.h | 8 + lib/colvars/colvar_geometricpath.h | 270 ++++++ lib/colvars/colvarbias_meta.cpp | 208 ++-- lib/colvars/colvarbias_meta.h | 8 +- lib/colvars/colvarbias_restraint.cpp | 3 +- lib/colvars/colvarcomp.cpp | 2 + lib/colvars/colvarcomp.h | 226 ++++- lib/colvars/colvarcomp_distances.cpp | 8 +- lib/colvars/colvarcomp_gpath.cpp | 910 ++++++++++++++++++ lib/colvars/colvarcomp_protein.cpp | 2 + lib/colvars/colvargrid.cpp | 4 +- lib/colvars/colvargrid.h | 6 +- lib/colvars/colvarparse.cpp | 38 +- lib/colvars/colvarparse.h | 10 + lib/colvars/colvarproxy.cpp | 75 +- lib/colvars/colvarproxy.h | 24 +- lib/colvars/colvars_version.h | 2 +- src/USER-COLVARS/colvarproxy_lammps_version.h | 2 +- 21 files changed, 1689 insertions(+), 138 deletions(-) create mode 100644 lib/colvars/colvar_geometricpath.h create mode 100644 lib/colvars/colvarcomp_gpath.cpp diff --git a/doc/src/PDF/colvars-refman-lammps.pdf b/doc/src/PDF/colvars-refman-lammps.pdf index 6194424212c1386e5f57a0a5e917fcbd74536a18..14deceeb879fca0cc6846406c720f17733e2ac6b 100644 GIT binary patch delta 370839 zcmdnLO0DUl#smv)BQAZP)V%bP3$isA&bwnKPHSsjO59?W-{5HMqsfMH_PiUdWL&JZCs6@QIMK@(4SFtJWBdMfx} zQKv>%kWYO;3$M{qi;kNKGOXPm0W#cONnOS!T_Ry_k}Ic74?HA1X_APqOJ>i(mPT4a)Ix~B%`Mj zoOgOOiZhA?B+4vcjXT4~pnp#3RKxMUv;)B%oX!g$6+Wm}BZZXSA9WJN1ltxzdJS3#TvzpPh%LIBs^Tv`p%rP&$E$EmCUb z4rW=UgHBAAL5#;a<}Ps2h}QHY?{GrkGJHw7E|n$BNvQ}N-QA)0wYR$;l1 z(hBj&=_(HAgqE?^pJG!iS1OsoprI;h+7f2;M#DLcLsG{nfP4Bzi6&3Y8Mf!d+}cu% zl2VT7D~ky&HcH#(Fs&yt=!9D6ft{QwqJ~=?!d6B!8bj^(2z3ItHZ|4WsUtQf^ ze*Z?do1Y)|^H*_me4|Szf6tMru-sg_c=gxVvc9sOW1kYwPrA0ODewH9XE*(>oAwHC zF*-ZdP}DTMZ`-}CzkmIdsVVIFpXgcr{@*+C3AYt?oIIrJHdnnT`%mq*&paoRnd|>; ztzR`2W13e!y_K_0;L(y>(~5)gt$xokUvR0QIC=kvV`un%?>)JBZ|burvnQA< zzSLS?mpWh2H?j7f|2ZSGr!k2|Q+BI5PL`UyLi4y;y}8D0{?4Qmx)sa*?mlE9b-eXA z^BUKgx5ba$Hq}`xn>BrHN%FJA85>?U*tdSo>-wm-yz}#>Y~Olw;g-wC)${Mi z%&D#Ml73(IC@*Z1{jE`(t zYo4vT@Id8l%yH`pZJq9qS09%8?v`JuxMgQ#-_jiOKAT$(MIr~<*?i)HFce#7 zc7N|d^~ugI`H9O;@BKYDBzc{6{=+K@j}G?VuKc^fXyvgpb`CbXd>&f)FH*Qc(fRW)AyyngRVH>wuevc}kRc{O7X!@c3-ikI z6USei=CIqN87?B6>EL*5#p^f1-bVzwHJ{B{{6mLrjakxjuNV7Wr|b!1IcxP!+I{8& zmy`d~a{QB**emn>4%;2#sOooSf%UXQ`d@Z?95^KV>e%XIZ|eG-4m#iO8xLf(u*zM-ms{Y$M%f{X<;AM7D#l^;7?Vr;pDka}+cmBGz zAiDaab3^T4=Dv+zJ3%3b7KRp<(<|>WDmUNa*nW$HQK3n~#8|;V0TjG8Hi(MY!qj+r zp(l%GeYAJ^BQuG+=hr82a@$lzztfw%#qw?DtvNn^^2Tou8FKAl7MuDu5~s0e~3_<>9MKg%lD`L`3v5$vSnGV(9^5;d;RVJw*y1>y95KbBafH7 z;&D&rV37D%W!#jY5%Tf7n%MTIXU{nEd^sVf8nR#0dLpkg@3CcxhAa#BWc9r=tP3v` zQ@?ysBG7-p8*=?l5Um4vl&@5?CjG%McjF^)beX~b`AB;mY9 z(2%)G^bt&p?IY#A-kUxYSF6l_9L{ED_~89nhINt_b5Cp68-Kl{#`O18 zMup>&3A3ief6keiE~+T3_$Idpf6Hn|4MY|GDgg zQT?v1A*GLZ1!u(BACFyQspK#D$Lz#OzY~_kQ@J@LA;?AB*+%_^+p(>u2m#{*zqvxaEVBgyUWPvs=F? zP43n^VRyivOk2$r|;?@yQ_b#(f8$D|er6es` zEpaj{aZ}_PHSO5l^-8Wk7mA#CuleT2+23c6ELpK-w_bWlklA3 zvU&ONU3Gfq2`BZ#u?OPHUOLFl{`I3sEks5#NJ;amir*ohl0trt zI=chE6?3;gym3@=+J?F3lb(Oz``;~IX|}ngoPUj_g1*X}pLycUS{B#pKP&INKlS7x zjn@&9PVu&9gg2$Ej}{ac4nFo$|L38-d8tghBaf;7eB|{dR%&4#=f}urO|iE+yRAKs z{`pnGeWhnw)HUf>MV=wC_m16aT_f)OCQgOpN8=GGMs`_7xwIYJ^O_}R?wx$AI@jpd zj@DZ_F74&Qs>|7CYiG{6{p`gSea-rr@;23qzZ+yeaIF(#-E#3$l{VMKU5^5RI`=NQ_jBBvVRYWT?)1V7Md7?JZ_D}S zb=6PM>+;>o^CZ(k^sdxa*6fa2euaI)Z%ni0P96xo2v{aBXhnkGpcIUg+!H)xW5 ze-&0pKJbrw;<A95| zx@OaM{mz}!_0>5&^L}y7zsKtyU%Qy|FWSMQp`9tMj%(MgH@{Dt|7X6Lv6y>$+$2U@ zUSp&h)?oTXMK;a)wGp@TZd(Y{UJpN${5!#0rBt_xX{SkUW0|xGV zpKkK*`g_UFvd0Q*=N$dEaEa!*hi5FE`6MMhxIEYlS4#Lg1$qUsOli$v;XG*XEEL#g zrZh20tlzU!EV=X5Z>5#|!ZQiGbV)>TJ_C(_e--KkHg$7!W zG(Jd#s5mwVDyS=#H_TB{kdW#W;nED#Og$C3%;Xv0>nWeq71AeJJDgM4&=jKNo#gMR zEyL>e?y;AtNirGicN-4>ygvCr)e%EC3)4qDCocG_&B@^qI>aE!bxOst z{j!#8p2oTMc`PnW`zu&Z%zVT*!T8DQrltiFbEgQKpRzf+kyWxFXj%W~X@A8$lBO>6 zkxw^L^ZuuwtRykva9E+2Vp8~=i>vDAAMbO#Y;dBbyujg~<)!6QFfPp#|2gN`wwRlzLUKPB9SP!@R(~Vw(wWkQuLEz#eqPCJaqZ|H z?ULEy*RR|P6W_As>z$r;`s|%UoqIT8U1?@i@Ox*E9g0tMXX|}FWU_w6n=Z5Yw-;$^ zXPvD*eP_xp+0SZH6ZEqFnzQBZRlB`)b>0;{xi|OjY+n{NgSGa;^{wmH7032Qsx?1# z|5hF>}rF_qw zNtc^1Z#MG|o}HDqO!-@u@|ugeoh50Huco~}mlLjQa%A4^tcl+4u{hXVe_(<)fLWP zj`ptf-W?IX%cZCCs?-w|e@Vmg5P7{XtIodX$+fY3dO0=6{!oqfmy4QTel9ji`_ zEy;X+Zt1^*YdRb9SF>%a;k$lp!b+doy~~!Zp8hL*Pi}bd?&rssL_X%wc$vxj;x>2l zh5dVF`kivSk6u4~K4rtfLXIZOCt20Wa#mK47AQYnoVoS%3R{ai^Uk<`sPj9!E9>iD zyR=XHHN^5F?%bU6VEvi;KWgvG6=UY)uc|*b#p4{OaR1rgcXr%m{JC7Si?ij3C-a0) zGZjAOWzML%est~1`Mi&{&U`$)>cOdherf$F4css19$OgXcvk9W$m^PZZ|^^!Ka@ZJ z?teSH#YO(cMhi)+eSB}_?>yf1L14Rfy6KDSS6&o_{xRAYyW_0tv$k$?@mY2Izy6L5 zf6L+g(Z7Dt?uTJ*x^0ijtf#d7WGi|7lq2p_N8yY3o=f|-`jxM%te&0P?^mCG{`Z0U z;`6GT_2;WwTz#&aVtw8_{Q0p}K_3+6%Fml-zN0*1%CaKp-{qYy8_x(E^^O~JPAJ^|o?q)4}C(Ctxa`_|g zx>YP+X8yUnXK&J!X6EzzBi8f$O#gMO;@?Kszt5CTtuH$B<w$3 zqS}=AFDJ1l?O8d=C$6$#MWpf6qknDK{}ftPZ z3!9f8mK>hU=Wm6|2qoJ&<&#yF!d*z~FWB#x!aA}0mSIhm>CxfgkaEr8@#b zf8+}>T@QF6bo^zA+r|976QuS3u?C)~G@9U_^@OVXF$ExI-5?VQr;fF6eR+m5PSoL2YifRYkHG5Ny zK3(|mnPY+CTDku*HVzd|?}D`4>hJ#xs-Jbx{rL9>1vW(!UfW%imT;|&+y2#5S)6C@ zf{!a?yBgb%xpK%n=ojqC`j8y3C&2aO{hmqu-Me2+eR?@<5s%B)J#Hqo`7#xamG}IW zkJqznWz9KjA-bqbz%$bBa{2bfRtxKQuA6?@^K15`*Uvqt%@o<85)(9W!ks6Kk0-0B z2OW>E-8AEt3)6b;-38*-?Ci;JlBMTuXWx@Q_kpjFqNm*J_2y4?exG||z+ihx|5fjW z`@IIfMP5HtPrvK(pTA*GZ`u{N&%D0kQ?jM@hi{)`TF+?qBdpzM&oy=(`GnwF?dPw} zw}!AE(mVNlxAjTJd}i6G$<4p#?R+(RJ418b&vn@esdcvB?wC%wJz4w6hw4*l_V*lD z7>V4R+4ar#ruB!qH!uGgQ!QnXtpP$eIds&s~8%?>HHF{Ga50suQ>Gx%OqMd>PaB4}O_@d_q5(vj!M> zUW!Uh+I_o0!NzOX?#RP)AKklG!?6C;*X`2Fx}QWn5!Z=*dg}C~D@DnR>NAhOvp3x% zU^|;H&)hXy`%l;Xr$HXcGRscetdoe`Cnvw$Pd?5%;Je2GEg}1Gy|rS!lKwtc!hS|t zn%lWoyq^1D{lmv~%{&afMe*0qbVn=+c@bw2z09aHa@UzH<1W3U$Xl#zt*4kT$+(fc4bfZbdyzlnbbeAgyrybUfGg% zxv&fR9)DKmeCM2R(fT|%?t`AE@Xk$qB5uoV;+5ZDY;hC)#2;iRwkk_X*so~PI+sgH zTk8K#ej%?WwSJwz9T{mWhUwDA$D5NoN;(1zMT6UaIGkP^VY?(W_dr;V0@tZc>yGzr z__S?pd#;bREXUoV1@}C7LuRZgk}HoZms#|SC(YxY)tuXMdl@UdI!nDu-kM*yaXGN! zIM;>wuUTe@`MPbkepcdTc{Y04;SU^(3ON4kFs_TQf4n}%P}OMh&YYxplVi)vb7uN? z7@jjct?qeq$!%^Sewm|oQf_k>I`MvO`?N`X^>!t;mG?ShHibm%*s^z>U2)Fif~?>% zsoCvmb9A@b3!mIRt#@PlJn{W|PqAD}eWawA6svNkWv$+`r}>goi_^TfinmxuDV3k! zlxTM}Eu%2jB(MJYl=PfUr#$yA_WQJoH(a*o<{LBq_j66SB>w%L@3%uw@VW4&4eMuT zrW^_V*q*d3_dWl|lLsR=GSsStXem6+e6Vu6?fxA`TYuh9J(L-CZk=@1)z?+(JqLN5PMW?lwqTFufi=%po#icHto+>|Ayd5WUEACDoYHF}f6w}wf3528HFFu|B{C%kt$ISW^7b#BDW6|ecGOyhH_Qs+YD@=@E%-p(cZl$~G z#lGwN93(6B6LZRb%;B$&xx3IQX!)PkN$htUIzshMhQHQOun^t&`-S`5ZizLvw@vK6v_i(vzuhNf6 zfqBnT6L^Y}Z|C)?S+Ie)|XL;hcQ{zEH$@dBsYF+qFw z+5YCYne=%!Xlz#J|7X_7xFl3uG#oUE%<=O#Sr5O_ZxJSJ+&GZ%?c1SX5G=I8OUL*rTHhX=B`;@ zvqAsG_#^ciCZVQo_sR}RUvJ_2d$QiwnyY3sVk;yies1 z?NmpcL4~iw1Jbjg$+LS%}@a31~>}4&|_VqKR7Z>iWcp86OYsVt> zOGmS3uWY%qOK;0k^REk+xBg?fXVYXg)A_9GOYa{CqU|25@g$0d$5xu}T)Sbv=F?v3 zKV~U;w@$A9+PSJ=>An6-HpYg>dEPtSHq?~%t$KKSYvk@zt;acIRUY1zD&*R3Yge;` z!}#M(9j)|&<6+Kkwn@!c8sNOXai@Y)n)2U;mph_kY|ReZ^xQDtzDzUMeCAcreJ@J#j_5}t%ued)cde42Kz)t=zE-_z2x}7II=5t))C0letN>0u1isa@AD)mL( z)~1GzZmPa#q$Wot6&`l=ULzVD;Gc8XZ>mk9_??H7Zb&an@N%ly!Zc~aQCUx+1nui8 zQHJ8#lNjgfdiK9Rq1(wWCpY6q$j!&O2Lw7eW|%Gu?6s~)Y*e53rcr(0r0+Wxduq-T z@IJ-6eW@z%j8Lm9%l?KOoxCj|ZLO#EKlYFHJ6 ziVLYR1+T7tNc>Z(U9>7JIDetl;iT_!TnDnIN0hxdaq`h3_4Ml(d_OHzS<{}~T=(HQ zZ+Cp6`@Q;)bF(HtxwkNV!4fAK`JkAM$7Z*!-k8$h>Ux~nU|Evf_XOXi&fQxN&*@_S z!dI=tWpSXbd&6PAZl#FloY^g_6F18iPhj;}BNn*6Q2)(U=fAc*(+;s%JxgFa!L_+n z@Hm&nvj>R`eU>{8>aR-XdnbDT@Z(7KZCo!67`m2QE;q9;|NOcB|7*3m^7roDyF35f`FsBh?Bo9b zJp0z(|9SrVd;cmve{*g8JZ<`O`+5IM>b^7`>%RQ+_w4K6U%D=iIh5O4e6Z-?XCs5i zsdx4~4CcSw%>MF^&fNXGtLy8gpX*nwK`K+b>zkSEOO$Rc1s>IgF zil61#J9COp??3ad@AfrJlU`P6EPd9O`aH?fY3{_-=e6>)y92cr6%5w0DWZV>y2`fH@^KO${&;RjGy+G2A z1KBD8fnl4nxmHT^gh}obp6I7r-jXtP+TB~F8thU!i*oqP0(-=+yxK5X!C+m)nt!f3 z^AB1EnaeXO9yyfi@G-V{iI^9w*C$s8X%m)fjn7#Or^Phgmsx$HyCQ{IZpYN-!IuW|mL_#pud>-$f zqbr_UBrQ;6J7&klvGt4Ty-Tvk4s%%g9_o-vGGR67w^Jv7ej5N zAMtZeO88O9qTtjkrRuh_yTa^BH>Xzson)3-`BM)!)0jxBmC9XLoOWk>CEW==0;*;rH*=dN?;; z+?gqN?bDa5(KfRe^_tq5m;C43?6z8cgUj;t9;5_NQA@t}okT_H?V}df&?2Q(&QAQ?4)HWB2r{X8n5q%Gy(}gX89Z z0*Tqo|5S78v*vmIPjPZma#5U3lPA7#yUcrW;WpNHZ;w|mt_+BN^URRTv?5(_%FpaO zx651DvoCOl@oL*ONGh>top5!K-f^Ahj+&U7v6&Ok%~MJ5?w1#=*W9726`A76RBXm9 zzFzMJ+q2?^Ne*fj^uY8wI-+@>xypyk?rhYq##A)e4R1L_-C!(kl(!Pqi=h9gEPO zxu|Asg#3i{-#l)YI9f_a?eutS9U)V(sDIUh4lV7shj`cC(OU6pamBPXg+`9`4>#5} zF3)hD5xC?_p@^$Pz?I`4B|^Sr7xr%}3HA)UsJxKP@#sax)QYh98~>L+PM+tsouN~E z`aEu?-k=im8phLY+k`7NRli|eSR~y_mp$UHviiwp)u9WXT zny|m{4*NmBM-PIVgMTvVPL!`RT9lM|tp4Hh10|OF)AnDnoNLjy{pP8{It{+pPYZ4M z4wu?p;_Zt$cqxXHt@}e;*QTbW-7iWtjxtaZoRO;>KPb?k7p(wwNhVqw58sp~n- z2f0?%2Lv*HSRpNXLB)H2Uy6HluY<+JKi($`GeU1n{J2i#|F-86{UXxVjR);i&rCD8 z7-W3epVSKR7chP zXp?&`ad49OrY}qXO?_*bct9gT*Q)yR`Wc!^7nByr+Da9aJK74kJ$~F$8c|_ong{?Vt3tFJw467qMkGDc+|p0x$iy( z%e*)yq$nN|pS)JLJ%mH%-~#`JFP1aTe-iXsX&&!G_G~eBM}g)?;-T|auWz#4SC+By zq~qfa>c!p#`s=Ii=DfN7)^>aRmhT#-xsTr*$G?BI3HQBzeEo9%VWxrUS z{^*_4&%4UvKd0O7TMK@%q&n9pZd+#YZSBIT+G|(N_rA1gqpm3XjE753=dNtn{P=q0 zX5FK&rkmZIy6wvOj29nxd6+FFg8%TSn`RsJ#d`jK_3x-U|1bXf=U-Dmoffn{i=pxK zz+KG3+xr$W&gL+iq|@-Pu2+TH#q+j#5m??2=a zZ*w3@`Q#+~ce-~~+Ow;#my|cM?Rau9IXmsn*W*{@x0nB~^$h%WYx6$u326B!Z+@!mUoh=c$b(OJxR)e#3T^rI_~rqgd6$BMb}wxx*eW9EZ9U_L=)&ri zn=bY8q^WQDU%5c;+?qL0wk^)LFG-Ovns0nOQsPN&kMNxBp{bu1x`f&-bWuO@GORwW z{nVH34#FGjH8$71OYwD_qkegY-s(9`kqv$ht6fiQ@jCfRZ}r)P6DvFK%YBq?4r=4b zjz8dWS1dVIqQaWzZ#i?})VvRqzV6lRFxwKoC__!~_`SFJkK{M~(KPTC{31Si`isUn zY@fERJ1C;QE93JR;KFXtUAS0 z8?#?e-Q#_oZ&}WYVvX5{k`As5;p5PiJ^pWZTgrNd4jYDRQWNFem}Ek}ZPwzB$S_); zA$>&J!?Hn7$aF`{Dt#7P*Mm%UrQKHbvrf)!{LHz$a)G7T35R+$1?R;YzZJ8KoDZ`b z+elxI`N(sPRd?f-_Wule)ix$JWrc1Zdp9(_)4zBvgGt;wk-@&-W~z-7lOM6dyZR-CDT$!uE8-lSjUKwj6EU>as&) z+m$`7VdbvTZ)JJrY+jc)yWZ$NPic2;t3g9sU8t*lQkA#mGa=84xgI8$V|)*;FqmJj zb8(^6rkQUyE&H)&sW8h=|44Ty<-HJ*Js`%#ZltsRoN#c z8Kk>cO-Xz`yW8q$n2~?1b=(noljd2%-ez0Awr{j^@Y{8M)?{P1lMb(Se=^nEtY5IE zV6*>ht?r1%byd#kKbODA+5SWKlydI-rZv0f7;`U>m&^b6T0zZbB}=!XpeU!BLr~oP znm<#kS$PiGZ8Y%RlYTm?dg0xuccJ$VpWPqxbxV+=*4Z5%4q_LAJZEw68m3)VJDId% z^Rzss@+ATPW7JzSdvs!wUVkzDaJ*qwOMS&O_7CTs#APS_yS>3~TWsFDTWkky1y(=l z$zRecbGpNG4%0M;#Mk%%qHGau$@`eaN=%Z^Zg8)3FTUhKfX zL<4bko_`;1e|nsiA9lMe_K~0G{dW_R_n1qj#$bP- zXc?MXUw=$%wzqg)W6e~%2B)jc=Z<-VSS+0+TCjM+%Aaq1e*g6P%A%BIQs`*(rg3Au z_Kd*tnG>eg%gnAhwfy0ndAiF|XEoTbyO7$;srY*cdcT4uO0GVJN(=kpw+ zKTi_6Ij#Sp&xaJVMA`k&bhU^ultmRf@Q6s zQHA5(&Lj4kFf^Z#(B^U9XgUasJ&#+f|)!Cp)@}oKW39!{^1Mm}|+Vv6dV9 zEuVjtjnJR(>XdhwbL)!*y9G}FRqvTl|1F_@VZzOu-qjqYHP4@kv8^-u*4MFj)66G- zuDxZN@#Xbxt2wSu_ghbzka+36m-eab7rUlOm1xd?X`t~p1x|#oL{>#?Ale=f(ewodt zGWhj-b7|H4m*k%(?$~ql{p&T7o4XuC)^FaEo?Cv)zu!zO=XcE;s~2w^C+jsV;{Nn9 zLM*MGB_$!=y0*GZ?p4;-x6=OQ-n>!l#noqzKfZAOe0z}o%+gdRkTACL`|Hnt`SPOLg-O{hT#O$zj=l0Zs1&><^036D>;D-NM00jwsq9S* zAT5K;jf_(`xUc{Ge0O&|!y~o+fax~7m^GM8jUc03Yb9^5yKVN#Ha;;yK8xAVJLvlp z%}l))c^7z_Cbzo=FR(Jo&DQo_r!jYO@RP^oZN|GSOD5(1PU(_4*IWGkyZQTjtF9ij zo3#3{*Sfg={pa)LYX56-g?n}Rq-B+Ej!&I=!E=LGidqVX_3o?ZUyC0T%dLEOYFXW; zpHH97FHoO%zq8(XVKaw;)eHIWv)A%ntxC7^Sed=Ky667EUDi@DFTUP&bAP?(74Jb) zp8K-i-VFP5r^L+e?YhSQeMinM*+zkesQI_q{NJCNd-LMdIsR)5d2XAQ97?&m>+I{; z;zeh7+25Tt?Hm6xv)p~I2g9PpQdctxwn}ndF@3AnbuDQ#Z^KOKq65eX?t6_-3gDTSpqMW_vnYeO?2%pUoXG5uFPR!z{X|?AJ&WmuBy{!-*!+^ z(eTk0JU(m2&jqDh8k9FqJ+a86-defX?AV&}ZKth;1O?8z@B|5_D&M%cyw#&6(Zb=5 zjBj<8fb^@L)TzG~^OrL{o7;O!Tk`uM;cZ^*Ojq`pw8_uf)tvt6m*b2MhBAql`!AfS z^?$_kZdzl6Yu)gUtlV_7;a_ zdSQ>w`GnjmI4CS`-|%(k241lj>*magjsN(t_NJ`6TsZ2x=T@}3Mcy+%m7PBD@}K#*`&Id0*A^T-oqp&l&E3 ziD8O1w^ZdWRD@n@>-+8-YP#ZOwYU3}{dYKv{AUX!GUwZ!Jiu~%PJ-OKxuWesYv0El z`ufvZ?NY)X<__mG*P|XQZ}FK`*|E-o(;?wNp+IVSX8OFRqEhvIk2gJ=)BGasxR_L` z68DwX)*?IB?G8cCM!ME~f#2qcr=2;z$1*dI=fCa@js132*A7ok{TB2t; z=f~Mpf0x(y+b*+~SF1}sg*{P#i<9-prcYM0Ha%5e?sIr&vu}3A?P{KoZm#B1k{h3))v zZXeWVkF{yFi2L|1m)nm$8pd+pqZ5R^w_-ial;M>t= zdBLeQd1vVlwJZJ#Qm-;j1fSexIeV6|kCRY+-AuJD?vvSLr>gylnH8LGDQ(88F?Hqj zFQ?xud2?`wtK`9#2m2zYnAtq!$Wd%i-^J1R&P@4Ohv&Ry3j3E9ZqPW}rF`VcqT+Xx z+EOO}=$<)yn)4T5iAVy-Ri~OU^ynZCTjm z@nNU-_l~msn7Pk1*G^cxU*eD7;-=;wQBu4~Vv>#uBBgl=^#V&Y*&8DGj(1t--kDW? ztD;FYV`t#&S%N}SY-cYz(h+x|tnsY0Q3LNCGp-F8880*D8L#_Xt^4EctVQ;Xa_w@v z=WP8uUtGOkpYNjk0*$8MIZr0;xp%=o^qoP%L!FH3@T8<|vya5^F@8E_#@uZE!noo7 z{tvsJ&b!NB|43WraAkIV-FxqI_ZX&MewTYWq|L@MPNch_Y-^m?LBZuoUk~2!_x-yv zdws~Z3;R|ZiX3+SZIHEadESORJJa8Pm)pKL8S_&1`9aw^%|A+iu^Q?<3(9=*X46aS zX?vFWR!PsZU=480d~r|wTT5)h&7WLtDX~Sh8;q;3J3E_gXL;!sSMX_dcu@U;^^adf zm#VWLct0=6bLENP30#Hq=PzhV=-cyU!TJ+wv5kD^YQOW`j^12-bxZ5?tZg$gYu&&2 z{S0U*IC^NY&e>r5w~yj)^Zw$Q$}#HoD@&OsSEXT$BZkYY>oc$ug_|olDyWWV!!GgOToj1 zOh*)SCK|MaiO%&~$kJ%A>0v(m!LkRFR*OZ1>al%3o@#1zM@#qe?5@58j)F%eS}$?x=bd7azra6u&Y@~0n(=Z|>S+OZuvGV`u@eflY@P^Xta&Yzod)2e2M zY95IgsmAM;K9-rDBZ$?+dl=# zrR*}M2}_rM>QDSNo2NeTk>K75(ZXIC@^=-|-(0=3eGc+?op0sI z*eiT%`5K#9zx&VYqMzZazWxWDK5zS7qi427czc@6$=*+TO8ch;biVXilIb;N^3k8C zXS@GrUU%|NCR$68Eh&r3)YJmhR211Bah~xLhrHSCPk#@eeLwMZKqQ)CkXp0pfgf0f zx7XZYyvr&dDf_do{Ij|2I%++(a~G@Jh89-}X#S-abP#_ewRnI>Ejw=lpm z5M^o(X_3wi_b$F|Ca~{!_=m8fV{RW5et7u%MWtVQ>0{NG=gGf?#oI?Sh;^aGsrB#m z#Fn_sJhfQ8shjmf;`iI^aXRn*3til`|ItOOM;B**{GC*Z;ReXu|~eGTDm{{+$i|QvcBHm6G4zFB^&lX1Toh zaeCd#SKIs@f{xABn`l+%^=HfL7rTw*EvK(txWCKp^tzutyQVIk8oGN?=dG_M6$Z1l zCffXqDL3=1tl@psbNt%;U48{GR~gn`cqf-R|CXu}U&gPwk=H7|O)8Q5zIK1s)t3L~ z@*;~CPw5l)JouPTU-E9pnR@A$ZW_xjPwFWtYX2i*GjGcDjkiPkmT6^sguE>iTTo&h z9j601 z=O63Z&dzq8^wQ$Z@42(tm@_x|fBSQ+X3s{U!>m95uvYFd&AYtz*8=BbVhPJj)3dkV zY~y@y{Nr7ZEBAy;&aq$9T!m}*-Zd9JWOu)w>&d#fs|VWTPFT(mI^Q4|p#P%TIc-n9 zQ+3dHk&Nte=PJYAkTJ;a7 z>+Aa4w|B)}Ue#rHy!+yR;fPkZ242n><$dR8DDs?Sejt^5XL3fz)2pU`CkLBcTA8U~ zcC7gBv03#7x6j5jZMeDMBa2_rvRX^kMvVtivohyh+S-tNeo;vC#JpzDuHeZXlU6Qb zFx|hUe2Ui&K8|N=Rv4*$%86(y7s`s>V5gM)P?`Cj$BHq_x;=7*WceKd&T7Y)B4srSy37GB**ND|E4zI zn5z2Z!_2o|chna6d3oy%QtWST_>Qm{rLMgS&~S!;mOt=>{Az~rtJw$(>d?vVHQ~FQ<3rW=>%`@WyYm^ zDG77j6Z<+(%CTJz?R&9eOM=aL^^!YGSr^!11Dm+#-u$Y+QBdL#$5LkL0-O31a^EBN z{}Jes_@wyk0GpTW$%#7ub{ihAtx;XDxMq^&yZ48?nJb$`iaC1?3^EpTcRUm7yXLd9 z=G>{znaeGfEuVkZI(V0J=_xO^-G2=Zrbf1Kv>x;qjxk)>W!$8n^YtbBO@G%=#>94HDO#QC92c(y|q(S8LVbG?fTe3ySZke8qisrcV3eIj*ll=Py`L zb|UQ7FQMPYCpRUl@H?pg44W#jDz)lbaQm-yn-qHwJeaYXVUM5cUiN~vjP}KqNu0c@ zU8ny?pOUFan-*AC5p*(W=CR+~R{nR?o?ZMy#KuCUdEv!{W>@oC{HDKbO7M78CtjmJ z;b8reHg^w8-GDL=x6LbUO^o?(MDSfrifpxesVLG?YcJBHw&BEf+r$m8tI9WTzAF?L zdi-4WiYDjw6Hc5@?RwPLp0(c4yfn&QOgC^|iMPSVwR|QkX6;*C+3)u$`OuO1?aaP@ za-Kyw6F=@U>gJ99{UxN$g0=N_csXO!QrQI8tyT>6wXag`Z#LH%r0MNTe$;bv^BaNq z_)GI@Ez{ook!(@#`f%?@@e;v(rZ4y$s#F&9+a(-nbWxt0vTBc#D0_?>uLjStK89lp z7dA|Na^K|3kNAU|6UF_V=5WL^|CABUe3*Iv!Nq%*s=4G`tE;j*4{qOoX0NzGQoG#D zIlduBzE}TU)9fZ6y>RYV-e1#iD)*uT!dNO&#R7(-Q(uD#J1uune6`ffBV1qzh zlmC>u_?W-!DIY36V5xkj2Yg@^Wi~Q4o<4CQqsI3BUCh^*>yz?7pLA*8nWPaQ)qDNt zR&TGk{VL4X6P`25_np4P`z)8UtjT_r5nHSS@7W$xS(ArsU6BSeI79wy*|2`5_1m*7 zzTV1598P};y{#0uM?RlHBrs%xb;OI3PkRe?zj(Ha$>_lJRqS6J$|q{*^z&_HS|Ph} z%i;5zUwp`9X{`MhAue05nV#hLBGi(>KD4a5VsgT?PZgWnQ=g@LHO+1?Fg*S3E#nR; z@tG$}+9s^yHx6^>UY6D_JWag+R%~0HRea7@?r*0aJz?Eb#n@2Za#u>rGjh^Tqb0LU zVve3az377G=B-j8lP#haetG>-q&D29aofsy;}n(AS-yWYY#P)=Np zFE=o|P$>LYrv-k}@Dcos>ogdO) zx7P=2vmYs+y!Z8AX-@92oX>}>SFU!Pxvo5%GvmS~$!4AdpPHigKW{Z)?AMN1@UZ69 zmE|XcLYGc+*R@`I?P6ESwO4KDrrq5Uvn!nUbXke|zOQmCJ2$<3y>g?xp-ZoU=>g$m zE3)+hzwyqK7C(P!Y4_}(ELOIwK40+LQWkeAae`FA_HA~%SPk3#c5mcf zaUv~##>XS}s~wX1KAqXO*)ebF^lhqts#iqsOMbKUfWhN$C!dR-+0{Ck)BVQ<7uU-i zTfKF1nhyAP2XX7z#nqp>n47s?c&bLLV3XK$@54Kv=kK;xy8E`Qcv?5>o*gmU7V|Rr z%=?wa8ssS!$eFp+Ncw-vv8yU2r7uHMuO7TM^VWO~*6+8c2(LT2owwUy+Qk65SFXZm z4u0IVYG&4LmD^P@EyekJ&gl9HozDIHr2UN7uWiv~g5RaI?q8h$%wIA;yxvo1g=Ku) zwATkztv8FuF;4H=f1|T#nzPxQY?hMFEqmE`O_5vfiF7E|oZC!)7IBjYT`(X2nV;ZajXV|MhdD zHTJ!lVQJ2ut1?+WH>>(d$#W*{M>Zs!%` ztJ4>npM0<9$kvIfdl{d;TdNj5waFk?-TmVWj)3>x{5Skxvn@@i4ZLu0&6584(_Jqa zvmaDf*I?rzS;TKU4F$xF>PD$LG*n_deEkPdmL$++gSS+&w23-{F^*`DY4mAYm&&8Yt6D5bvS(8EB!7s9iJLLGK_eEb_MqI3T3ZMFFF zczfGBf90+APnm~VBAOYSOlP{qBD6i{Fta7Ag7@std9@$;rPp#k##C!+U^!jjKeGm} zA=0u)lj(xpjGFaFqjK|wcZ&U+7ymGy`_j?JkEbU~hkCH)?esXE=US~=CMfS@wdLmQ zv>lUK8n@X0vrB&@HfxJ##`3)#r{tdZ{QdD`Pj!>$sTB!LpE6EpeG*$6Xy&pdZl{iJ zU0I;z)5SKie=O`Lj9g@ts$^D#3 z{pro5v^@`!izGTvsZZkTQ(=9X&^cu?m*C`CJrgxzjui;(&`XZkrs2aA7?+@U%-JYS zpv5rqoY0w+O_w^m4hH@4>)L&Na_F0<1|PborzQo-99Yd@XWZuSNTfX4Kd$guy}<ufz;%q{uA0~q!xArzp`jwn|L_EYGH4kK!Zl) z33cgaK8qe_zirB2wJawXsc2QM5h`fXEOl^oD&)vnb4tzo_{tnb+nhb8^nNlvHYnO) zbV$qCTYc3WhZ7g3&RM&M^`;41PijtYPrd5Pi5|5RnBy#n2@K{R<&pn{WUR~Y% zYH5|c!S2BP(68_M?GGvzD7|W7o}s5UnZG&xyw$Gyy1DzUX7NA&dM~c@&$kH|dfK{H ziU01J_wfD#tBhsETemM?#VjZt|I9|9v03M2bAar&voBW6Tm5~NRZZoBRgZtYj)`4Y z^yh7HeXo4m@~;c38h^feS;O|U?9;CWRng~XxmvGEpS!QzIsetv>Vm?>25&nlSP30kLgz$E0MpR=BVCr*UjqDlFctg!VlNoaTMAo z|8G@G^goUc26Sk44_HUtLe`^0sak z2>QUWEWTQuPb)*aT`DqK+WgQ5+d~|2#=GAeBwdQ@`Kcz+-T&!7Q_r?pznEQ~m;^qb zVA|4qMC*rM&_$Wcy%k&%5tHO9o#WJB*#EfT*|Aw{!UIRyH*V^;%;hhhtvARsnozPc zPbK%k`89@7f3#{AOv_-;^IERL6jgR9cgZdB*-HMu@1D9E`1Sqv^-telyjk<_XJ+VJ z{^i{dUFL5)`?J90vTt?NT$9B|EvFRS*lQTIWzoW`NnzXl{lp(n-u265-W7j4)3-kh z>@KH&{(SQBYO(7x@9Ml0-Nh?b-uf=8yZ-iM!M}OT;cFlBKKr_D*`?X0!7nfQEiQH}1ML%lqh; zJ(n-m->Sa8UR&#H^QOB|ODlYr?%BW9>!@Am3H57%n|gT4H6mwqT6tY#2}|F7wb1c? zMQDVc#2(*>br(EcCT?Al5dHGOFWyi0b4$eL%_vi7o@aFCl9`oPnDmm;|N6JhtBa?oCrJ z&?(it78JT6X`|vyzICk0(ur#%I|Ry&1;Sq_%sIig{h~+N6yDsWpDkPt&HNVfV@G7; zdX2w#x6Zt7%lUtfdcEf5~TzoWSuVnwNv~Rg)>(8hE4_Lok znYZil$C@V1WoNh4)l6lao^G_F&c0^xi{r*mWo6IymrQb<9L?1r;#9T1rv7c*`x^m| zD!%_dzTf42%F^r4AANoo7Uuohuy#+WkNkAc{*a34xrJ;SEt(^e{(;abrH$7QxW1C# zr~N~ZS-fN3xu6sGMRweAR#Z~H`e4O`C)t|ThmBw8uqO5Fo*{oKTu|v>%Z6UXYsU(Y z^F9~2rYPHdD|XOBO8^8Vr{!Bs}`+demM`}cm)yuN*3J1;Ozo}sY%X_B(#jtdPh zj%9m)5f_T9(=sZCz;#dIzy#(MMbBo#ES}# z=#76k)W1Y6bDN}l{j}uHZR#ppXUOib@w_odeu{bhwGC=JFX%<=D%#p>-?-G>`SDSI zuP9N~{f)mjL@iLQ5PU2@MR!tM(DXDbmAWg5Ckpua-YMQKIKM;7Xk++9&P@glKkm4m zxpr{wY>tK{g74z%Ki;%lvERM><{nG?2p{VN+b%wZNS2S&C%7C{mA=dH@>S*6O66&) zrqi^)uh9)T=~17yhU4BPmHpL!)ZeMRpK;;IhUl54t?RTmZ@TaGd_m)}4`EhLJ=#Z? ztSu3Ujhp*^pLcrry2*-;dhMV-txt}>~-}c8k~jI6HW$H zWlXs~^Q~UMzc=#SO&ojy`i2)K6}c5g?cttLUjL<^EtARf8E42OJp+rDni_GF^~>Xb zwL1$)X_r}K{j~9Ss_;(~p7XH&OUb4EM;wluI%erF5#O~o_}uKDMPc)|9QOPlp~O?R z&t}nt2@UriEY@3Clc)Ce-`@f@$Bm8)_U(!6{4`hT&gHMIP0RnT&ugBhudKgCeaDK} zg4r_|!+35#-dtt(M!wf^%k%xWcPQL1*s(+O?8BQo%5^4f(XpQyn=~=u#?4;0yekRy zpYDr2|C`J?LGb4$!N9^dcDtH;a`>#$zdpI#U48g5(HY}VqggF*w*vHs-!+x2Bn`!cUz9@MVrKor?9gb39 z)UhwHv^8$2Y;C{(`TNROub%O&jC*^kOa7Bl?S@^ucD-Bm^WDGY@;~31?CUC99=qjt zqU8O%`+vQ2p7W;S$R~~GyMI5{I~}1nIacbaPSA$p8-Hc)%>QaPC5ZL%((B5;yOn!W zuh)NxU48rHo6`w$UmN#@==QcUuc^P?ZK1&yRp0d}L#O-JT5IcVcUk6J=<-!vIy{fv z_o|hUjPBnHU#n)U(sjJNbB5jSK-Yt^Imb3+@c)i~_kSCAWs;m!(aEH#mz{qz2~0D- z5EB1wVaMVJA7iGb&$0_S8nIP9N@1&oSZ-kav8*Mb^^2Dmmv89al=0RvH}Utrbzd4E z{yk7udb&*B^uLk5pr=fTyOcer;(uQIQ+fR+Os5MLHSLm8udPVdk2pD%``{y&#v8ov z_DA)w@*dx*yL?r4W^0mK%WP?ZI2Xpkt*g4*qb`3d`t-(6L9^WAY}2WExn118a&K1d zlRlnx(6H1*?o0i04WYGnTMw(~&D>mZcK#uwT?-bzf8~AKG&JyX)f`9r2VJM^c$Ste z34C8E^M_9)?&-~}?z1nJUaNSm&G)9O>~N<0wduxZM}*6ynC3|ny77aa(!c?E`9Li0{16-H|U$s?`cRd%c^(g59+zJCi~Vm zPKh!x!R9A&8*CF z%S|OWZm{Bh@Z^5M@fWLiTnyiDP=8S1=~~588fhCl<|qki+i9;`(cFHj zlR3+uuaU1l*lLrk6!mWQ?|-e|TaElB&xPl#U&A)JZ{f{GCW);Mt^2ED3bxLFz0&y; zkdSMA-XMK4aY&HI>nROWn3D5C|-ibF>n7uA)fY}2k?z^%P>Ud1n4+ReL?RtVNc{CFR;r+)M}8nNP6y{4^l%$_O{(`@VOck0;EYq2TQ7PE!wsn!1e=eq2P&iv2Ue_o5d zf28W%CkwHRh=yp-Wl6JRHPyZ;_Ak=-A=jbZ(_$;hG^a~>S;ek7Npl`t+FCEDBf8S~ zd$a4y!yGOu^$Yfh35movd3YsAEr~JWJ@ih(>}bZ}M@=V|nOt6c?VP9u_rar_mrN%d zzSDnZdRt2-Q=HE`C&ucSxX<2Av3p$#5-thrdp?Rj5wXETPw(9eXEEk=tWAc`oDX-J zahH6$IDd0YD&M1p?@q-Zj4#;8(l~Ki>)qHHZL6i5kEwnTh~cZ>D0uyt$JrwvFDDpD zvYhi{F8X@zy9MXXs#!WEk{<7rl|KgBSDRcH5`Q9Q{()uem@>SiYb#`vg&ntT! zi>uBR{BwQL>GwUlzxH?>yQEV+@2OF;jd1-W{+l06g?*mg{Ppqv>y0v6i}UVXuUG5x z{3*(mE?wIC#jtZSym;MKv-@ag28kfej|MHjOoi=m(i}WHU9s9=l zQNEJtM&-)?H~;>4x7WYS^Vqs`e=Ap4$6vXjJ!8)IN{QW7W!fiH&Q%rc+?35~5*lq< zEF9)rc8rwy{pP&dUEGX?rZ%rkN#eqz9d4YkauFT@! zw!?htF_U_J4;#G|=MH~*G>hTTDh+Rr3n6B=lTujshL!}M-*TgU@uvkxr_YMASsXVd zYL>gfVV6CIYwb6e++I9y+UuGuUe3q9PSqFh{W)myVkv)F`cFmkdlI%T8ka;`(ogZs zn90Y`b9LogwqWN2O;w@>3#T7`(&qncg7=jC#8c-C_+yS|T&%ybu`x?f+pT@yp%j@t zD>L1zRvxTl`8*}(`;jvi+ih)f3Il_Uj~gG~xh+2WSJZ_|Wu6%q&z)_a==dnfTdrrX z-pZrX7OYF&dxH7$3*p8zb&-{4a`gG<%r?}^YS^_;#3!#}%9<|DoJiBT``KRa?s{c; zF4y|>lbbt^>|0alZjj$qRR2P%z&N4x*ST#Aa>T_ae^|6MO|8N1hH`Rzco{eU>`Ckn z>#udid->{aI+~}QWvI)mZQ+=y(r}@5p1V%&WPKMV_5!Qj0`YHsv$=TFFV|MeSY1CP z^JT}6Q|z%~3Qv8b9z3{U9c#EN?E8%X*IwJXuTO7W&8&YvO;{v!zv9dWrx*3g8MkW9 zMZdE5oVu67^(<&by7MQdkNmMcpC8O<+3{U(e|b%*?v2@dI(O@TecEfkTv+G))9H&h zcqm@H!?t0%`@=&S8=luPd2I_>^XIDg=S$94n?LQZ<%$)u?e>ZdoclGALGD*~^NgcL zfA6P$_}{;i@yg_h5r3B}O_STbVO{tWvx54E>iG}6RAT1Vr{3XeopOy|;>eQM2Bo|D z_U2dDJEs*cnELuGcUCRu^-bF9kM||??&XP~&PY8%4(GFxi>qU)dknoVWl6!wo<5Oh6&#X$OdLfB0fmjC=KU!GNV4DR%KaPLz8 z@-A1c+Iq+K)XO}LJnH2KB{qJaR_)QZ_m9^Dp&5yO8(Hl3*M3i&Kl8snZ&Ty3r~6eK z4%DmV-Zv8oJaj1}cd_5bk{7eO0?=th(KS^Fy z6Jfnkdu7hGr*ng^Sq2EXJ&ICV?vZu;@p^xAIhBKrZnNB%mK8H`m^HZV-`yy`&b~fr zvv0Ly`fSO$wQp{hUl+Hp2{_pkIO+17v+MHHBHfB6o(Y;Itd*Ez`@6Jm@73wt)0Tg} zufKDa`0nPPXP))G7Yp|HOD+Ash3^WpJMnq{~%}b$sEI9-<5q*^WSLs2Iij1N}j$y^VMG2W!qk6 zUC)zc+P!FJ%FUX^x7QuttUKMh{LrRXCBY?M_r=_7EWKIgy7dyD=&8;{G7|({PTol> z4lj$gI9~7cqjtmQTi4c>HJ|&wgEM_bGkNs7ph z4}1D=!*=Q5xN=InLd%h9iJXF- z`yZ>7HS`py*&ZnhU%&5BXZ_Kdwfh53Y2Uqd{!nk<3blqa(~e9(Bk0pm^Dh52m&#|} zy3;@JZi~siyZ+EYox5Mcvdx2b#D0^i%BjofDSO;8IYuBvtCN9?MaX)A@{*R)-PW6z zOvt)-SJ6BBclzZk?YFP}EAWsuZHzCyYPsOhS(iBGZ%T}uS#R`LPqVlgVX?TR-s1bQ zvl4F~xs|o4N&mhoH-YW4?TM#OPY-dQ4v`dON~p|x*(SS0dfPnH?BA6cyjwS{KDcbb z%AO5V@y!}G3a=xk~G!93$_bfVW(Q8fvM z$Bz$W-xk{zDgW(vwfUum%MWd#luxQu#j$uS>pA+9Y?QZbF0E zHgCST&f@)Ul3x>i3@o0g2vqQYbFP2AE=eqES;EFioA=x}RDX~y`~Qxpm$%m$GU(ohbg| zH19&UiektL@fSyD*0}HI{$eZ{zd)5S!29jo%021Ab49;i>aycx zX{DvJB&IJ~#lfWYgfldR)06k>zx5##{~Oj`@h!YjI=R@re{PXd=6?6qg_Swd>}Gva z&IeRX{r2tW^V^DX-fXSmeu0w%ZsfS!ndPG^`)5hj75^eV&qe31#4k_()A29qlD)&u zKL&+A7Zz>hkum&ewZ-o9#{b;r8Nq_H)#|yptbIfeJYT71xbV`Gu<(tC8JUBwonD?S z6s&k_!j{U8?H!E9jpZR*0{&Iye>B~etgz63QQ8jCii9J@4NOiKGv+uST=?Ao_Qa!Q zEE{wl+`lfdv*~lasO6Ga)8=VK+E&Z1C{dC&Vivm)d zUwFUx2U_hffBQYT{?mdtp{=uTIY#Wfe0O4xoWzmM%a81SRI#VqBgjd%%DG?A%IRx` zMorl#?kEe7sb|wS%jkF~cP;vPV%wH)(+%y|mXs(jUbKCtVV8w*u=?>d8Goe<3pgf6 zSf1>VuvySIt>8Dyv7F2ag*W>2qMgntMeDXanQ;8WhBI<|qm*WfEYGbEJ$7|-(~-;x z{;blsSKWWLY14G;f7>Q=zs%xVD{JZ__;;!A8zo-tgy!7$*`|{#6q-LQzAo~`Z{yMi z=jNAkrxrd8vbi9Wbob8I<8^N?y8YOFx%0r{gB3TwE$$uuFMg@6$(H@}*a` zoG;H!Ki&N&o_(FtApz;~4I-Z`Ond9C-DdS}zk2)EhUnY>F3r5Rd)XVSw|4_xD^GUw zPoDhm*zau_U4Fk)-&JqeJ3n`k(i?|sdsj#EztY!Cu+!Oob#2~qxm&-YUeCW;{O5DQ ze0lTfk^;NM|NeV)B680L7K!~HRSDldin-d|sq6Zr{GQ7uHfpcZ@^$MEd_4Ycz1t!= zv1X(CNy~0t@po_4*5Lf=^L>+ro_149V%V=H4X$bbmcIE?dRKHezsIK46-CT{8GnaA zo@Ui`Y_ZSjW}BDi514G>N;n!UmUU(8*FQGgYfR4HbyokrenW5l$(Fw#y_dNN9_^id zI#kEXSNY<~$RpS96zpGgE5rJgVN`ZO*Y8U)UmkBa)W1{D&e5@{x*(E`zxzx`M6 zTw;y5ASV$0J%ZC+>$cdo%+r4p!+$iznw94-T~NMy_NKVU-nxH^+Vx6bZzy}(`O(_+ zk5pyGXW`7Z1t0p|l(Hiu zY1Y=Uxx3cZt2XwREK(H>x$`IRr60pd1>xe%7EX*1Vje)p1mHZQ5a61z$_u>a7y=P7AA%h}6ZbDyQ;9@+Bn zOF_=Atq=7U`Z`sl=gwanc5>aO&(~(Wyl8Y!E$xLf@3A=@H=jq}J=0y9d0%HM+rcJ* zCY79eM~NS8M%CuVfu_+Ysh0nI(IWHGF}< zcDcR1m+Q}%tEy@!1)49-Z|3+Fw!mXu&E_2|UiB6((e(H}EeZ?-^8wcFjSy4ekz%Pi(WidtWRb>q+yVk^5a=U;;j=4S>5gkOITHqoT@eG$7_dPn=^NUKac8efRn1 z+pkMXbMNPKxka5zDKN<5a;rKKZ*a+fSJT7>AImQyJsS1P)w$e+jM@q&@f(Y5id%Ro z`cC3n={&9i-bZ_@Wy|+|VLq{|X4Sk-znPp@QWuv>u(eP9`S`!%jq}Ukpwe1<+r`a7H?bn3?8dRwoBRvdzv>(8 z2@uwKFVmyx`6uLd{cqzOr&0-d5u^X#HMbo+UOl;}F{AvgZH?aboyT6hefjHzxm%^i z1vjUC9n+=y=QsHA+?$mD>6y0g)P4=mC3~8GDo%SXw8bL$weeQF;MeOt*B&j&`s*BZ zr#b39<2rZMn_omurcIOzO?B90$;DYMG3jjIq@2!087DSsmRgvtwck;HZSh>kh3ULr zD^G88ypwo4WLwVcZ+7QjediHxZcDxW;m+x8x~JK=Ue@Sdm>(PQ`7cLL^_(nshXqGd zmg)8z<+fIM$hTyjW`1SSn^o-F1A1uYFr%U)E%~yMOMgf18{BC3ctY z^4)Z4lc{dn9|!w4KO5h_33e5ju2(O+RZ8GtTHT(lCyn2VFOgrVbo?l*(wfk+yImd~ zw|CfT$cU}IygcgFWLxbUjl!aK_=g)+=s2Z92ba`j)(H z@$n9B`^Of6n0m%(yE*tcx=3Ya>z`j=Y`#dmol&Z=vPoq6)zx<||NXlA`^QgDxrK6POZIIO?5lgV{=R;C z|NM_CN)o9S$`^}-J*7P7D9$->*=pB3^$w+t6`TJ&{b+phSWAzRr|Jg7l-G+gKi3y6 zt<$?7l{A0#0ojLFmC{(w^K0pg8$R9fe`)Qmz_)XQ-UU~0XSj6AF6T9?=ku#CZ`^pE zmAt+(T2|@_pXg)f$7i}Ef-Br-*w*h1?z?umEyY9a(HgU+>RSaz*dO_J$h&hsmt}R* zIMT*(#O0D;uCvyXj!klpXV-4sb=B+hk}>Ss(_wXuKa-ki{tuWI7|EWP&4wcY4@ zz_a8jKP6HV0?Rpy+YPpJ+>U;9Z^}D{Umo7FM_USxOcKeHaF`rf`95Uh-K}9_Hv6@2 z&D|T!edzi7zR;DYuI*FglY4W}S;MQc|9m;${1UEW|G+kZFFb{!j~M&T^iD5OX(`}K z;NYBFlvvZS;6jGxg8Uj(gOoAm+jKA-1LUaG}F< zp4s`#Ia?I=KEDt*Vd6c>q#h<^H(~z7m)0xQ8q76cZK&)OmT{8usF;-z?-257;)~78 zPv4wxEc8;wK}k!~%Y)0&MWEvUD}&v2&5KQIeybkRNL1QYZ#<>FBj`fg!MAo*roZp1 zYM(E$UEi{x#cIbq_6rj@l69qod@2_F`Xe-DiNG=DtCn$R9zT6B)u_p!;Z5dVRn~b4 zr_ZQfx~}t(v0afNN`!gW%H}m35z;-L?;@?g-cdZbM)`+wihJIlMlOXnEKKEg$?i-y zc~hE1im&zX7^OMs8`Ud2o1CsO{?)nRxvAOX+!cKl7x(ZnFgkMWkyM&fT5ycT=#2b9 zo4gu(xxo8v3xqkQT)8*n6r+`xg^U36%jB#V$0ZLuPv6_Kcn$ZS{Hlk?_8e&uPpOe9 zaBuXuHv8YfkdLt!D&1HPs(1+n^ky$-uPMBC@~~m6{gG)520TpC$9RvvVF z#isR%@^72UYgbM>FB6NZ_{gtwSMYw@YF*FF@|1_addil|<%Hz4@~DU~9aTNZe7>M{ zlFe(4l2qOgjeKnamYfCic@G?HYd*CuQ%XwhQHpM?4 z)*J8S%ADyCa>;I2HE%3)rpud!+}Sp{xvI@3(|@@8yMA>^h`aVKW^4Fnaym`1xZDEU$R=aaPG$&Lv5|5;PTpy;s=# z?=0-(k81W4nfGGhV#V3l!uO{Mtc*5)b-hPkOT+yAt<@83g*zq0#n+i7xxX!}-xRen zdG`G`u`GM8w$^LhpC2O3BeP-ai-(qBzJ_|or(ZceA!gc2^=tiEljnbX>#}TtN7W`N zH!eY&gBN}JGQvs|yJ9D-Z_u=UefQPzi*m}U>#lpfEOA|6ANs9oyLQ-a&eFhjx^YK; zrM%Lud9&u3#q+J3%(LE4SW>kyahmXfhi;A!%S3)QCAF8#&F?PiuFq+Htzv%bQ{qe( z##P35jxESMXuALUAI6vpm6>n7A8g$qewpXs*DEW|X6C=oeeSUPt4E#1ySx3puRbW+ z%YA?EDEFJCHahzG1D3w)zV{?@A6!d`{PFPf{dvdOr{mE13?*7R?euK!^Fd9T4l89~K~EnS{GG3$0J<#{bw*5B)Xf1b^z zIj{EIk$P&f+Ba7AO?FOv2G5tp8+Y!z`8-X2M`-V4zC+72eGa@l@4R{4{4ei3(`65@ ze7xaSXs_1Ye_qn!{)?V2vzq#PPhI}u)X=Hh7H7N7eL11hP=#s6ACHw*I%^_zizN5cQ12W zTA$RnQ?8blq1TVydivnPyUB(fSGQb$W3^(>&F@xRYd))A4P2_Pa#V4hN%NLzcjMp9 zORh>gB6{Jd;req~f9A8r{3|{1*XluC8S}ccjq|&?+k!oc&B3dgpdDr zU#zkC+uT*O-t*@nr&dQVHOarbJbq3R(^R?o|KOF+mKUqJUj7SIve~r!^v(Oz%|1TD zYz3H^P7gf7s4ie(X~w1R1G(1K$k-G-siIjQ6`g2`b6BUKmxqOiAOD7!B-;Z^ zrW7{ppRhOXBD1L8xedh;`kNDj1R{BU#}o)G+`|ydAn0Asw}Yuv?P~hRw#`hs2MZVj zH0E~Og`9AkV<&P&-!GT3v?DupvEZflrem#1bB;14zF%N|$Ir%n@`ud^A#&X7RP@~B zU5oTEK6IV<>)BrHcvIy#4&&EL9Ue>PIdYnUlezqqnquZ zj?!e8)Gzw0cpheH)oUGA6J=%le`;Mq>I}$V2j9T0o!zQ6QD^hHBIhd&1Na=)g zO;EYBM5HlEG3v@kgZ??(I~uFhbq+>I=)LinA1%{&Wrya0$Fe%D%Jn<;bpLXBbwh9K z{#QLrGh22G@hy~ynD&8#Yx#@3M&?z;f(NH<-n{wdpI3)-lb`vAul|~6wtvs>%Iov~ zSML0EJ?CG}-pboKan?CO-_!mb|2hBJ`S{>!quKj&)|EdiJ$Y^Q^J6L9c^gt5aunQ7 z5;k5kZ`NjG z-pWH~+kwOf#bL6R9-HnxpEyI$>~*~#JLmVUN86c~Iow;tDlZ(oT`_(p{G6{MD^?GJ$uMU5FcX-*> zi}hb3Tyi`VS|{jsyDd&Rc&IjF+Um5;(R$0;h4!2kdVlp$&f*@2PgzA8UM7*vwI$b- z-vl+buK1Ezx%uu7<`gJqU&VTGzF->=q&ic!trnkS|eYWf7wv(yVFZIvfe){ORa|+9Lm{NM+QQ)Gcs|WRXbT6)y zjns(H?KnC4sl)+$!A#B7plbES(7lQJw8)Tll0U9d@JisQCt0q^-v z?PU5cHSMvGj@K;5jZZcl|GZ(&bF;Mva@7h=Kt>#d~TVXHlcLA({*QUlrtXk+l zwdGQ!lWuDN94~Ge0U<5!v#MSPEhYMEq?RuKx@u?4yIJ+CzvdMdud|wMFtH$V@dZY? z#X+ji;wqSb1+CJ^laaQc@OjqtTMQ!2MUN&nOii@xH#&FJ(b6$?-P*H?me&lvs=oTS zRYvH!;P$I}zUK~~7VLRaWa(Aby4F5OwpP};UUp|+5IFI~9N#5(_3Mgt?xnV?UI)hZzp4t2zGZs9zjW`a9U-OD zR&{Mn+$aCKYTvr&PbC;xT9=82RK+rM_VAW|VrZJ=IBDP006wP|7fNg=@7ucR(tWwt zD?VO5Uavn*cw5{ag=H_h*YXANt@x9qzvTSO3;vO(QnXn^oyDRV>W>H?VpnF?h`QBt z<>IoRsZOGWZmZ6H?+Ex{S^M*9^NST)ukLs(y4A&(r{WneIpw0(r^~x9G6t0{w)0qi zQE;+qz!gXLrUS<-=k$rapMG2U#fs)DFITW%Dl8589I2>sdBNXV7r468!Y?gW-y*w4 zZ}Hp1rIUK5h1zp0k9E_2;KTW`-u+~Tbw#Y(ZT9yoe!WV{YiPFK`QA;o~t~ zZ}qq@-t37vc6jy|=N1OB{)ujq@9(D7mRoOhRy_DdK{3%?&|&X{zSj??atNG_I=;?D zAnIIAjna#RQkM(uuT@+gcxMz(>Emb;p8c2KnMHO_AIGl;b6YsJY~!o(X9-#0URAH6 zq;PWD9b3Twooy!;3pui{RBp2KP*-GHbfIjyw%~+)v%LEKS!CDrar`Qn+rrV6eOt0! zY&!ReH+2$nD_-!)u9GV{EUQ;5YPsz2*MM`|OaD*s(K)*5iKC_8$xk12Ehk;AJG&qz zT9>2tpED;*p23I*PHvUALi%UxBsu|{Js4b z-aG7H`*-TAa?xL%ck0%>T@i3QaN)MaPPy)_xB4Ez(Jr~`Uw>G<)o2g2mw0z8Fu|F@c*Us^*J$Un<wQcwK75+LJXhu2_F4TW>VoZZO#dbc*L=2!KKr_Q zx&&Xeul>z0BKs0o|CKLz8&qssF`qg6F?0JP4;}9%)0P;0+wcF_RZu2liSL^bRa5n*gw+@Gzp%eJ`u6;L zk8LmW3$~ps_*Pa^S6%)2QSSrEgBr&zPv*Thb~SD-Zn506cJp`cK8Z!A`M2NSU$OYc zlnH@LRxp`O%ZZi075jD7%{TR0?lQ$wEd=((tdls{eJE(%iUZxdvnp1sI<}XG-}}d{ zUDJKHt5jW-j;nWe?ENlp+njrMZMwaCoQkDr=2UCeFp*~*#h32pHUF5n zPQ^Xsmcg%GXuYdh2 zyeBjG>$|NPhlHQ}J=Rm4?=eH?cACbkW0U!AYw_$l#jpF=ZYkSRslrw6lGYncJUO$J zQtrE2T3R?JG(J~ZLM&hOieGw$Z} zc%~RkwwUR;tF$UP?v%nJ-dr!UY07;sMb+w=UERBXe*L4A_hZ9aEB&K0cno5{zl#*x z{b`4GTUKv^()I3o{&&vdyvNsl4AC<=GNZ@ftG3vVygL=Kx(^?-mApxuWx*|YRPegV zwhPX@nc_wjuZ1_~wXOP{>)H7K+)Ix|0@p=8DZKb$m&w|q$tiN<#A9KcqKMj=mnJ!%yKr&x;`%nl+@65NFE2@*|Lh`Z z{_%LGk!a~W{mHYWoHnlaDmi&fWa5;Gz3V5ndMPhe+Z|^w;v1>DRw(qtrn~aDmSwd~ z@DzR?z{%)t!o#s-+P}m17KT?WZ^+0re|z!$3g>D!&!V7DT%VoK1*lB@aan7_{;gaS zW~P1({{8Oubx+d+XJhI=)|&|Sht~%ME?lPc|7=jJqwlt@H?3asiy9^T^|lS!{x;yv zJ&DPxwXSC(YF+bfg&un@f4Xen$Ni@=e`PJ-xY@6I%i5xXjxZKBsc#B(PU3H*N;a;& z7Mr1*bZm~|$tOHd98 zQQU)iIeiDQCpm56GdeyrRqEbh*4d%bo#68OAT!6ZEzANw6F3_-*c##qz*Y zbstC81drk})~t#>?{!ja-}Pb=pD3^w zv2Fir>of0Hb;ZWNduw-nXn%O){^5#y_v>$;+&Fdmqb)C%hRri%{kSgeY>mvqz~{WD z9;O`b`H^|r!1iC4QBHMT#hjNvE!!qd{cj(;f9s6%F&{M9U6?xzKfQci_Wa9Rov=gQ zwY%-2lpp>op%KVD4s;hq;|9z7+sI)}}? zcEzq;vGvzeZEND1nss&rcbgyU7ZYW$RaqQ+OEK!r6(PUX>vpl<$l%(gTXApk@l)G_ zlsCOtRrf++E&Kn(IqZebvaAcQxrVpjpXMsem9r%{?4QB2cblu_s+TWbd&=$I`NWd} zYi2+Gx9(NahS0p*yVgvq;Qe3RIID&&>%7BT$rZJ#qCbqU)z=)G6`t(-x5xB9W5ne6 zW3$@J!b>j5@VRzveQ+V`%*ADYPbx35jC!}Bb=_K?+4VP_goDhNRr?(Fc{}Nu*No2M zD!)%Rw~Dw0z1q)|k)`rQCL?I=qHayub%6A4U5rK5-ov>JiA-`mEaF zzK}~uQUBic3ny!NPwJK#_ZNRRoiKm7b0@#}%&Oo!dRrX>`1Wx&|4;ju{l5OpN)`ca zQPv4vOecI$b?z9=dt0Wi<_ipu>>@GCV?vnkKJ1JY^I82UfbIZ%xe1CAH_qfNypO%H3 z$2?A-7UZpPd%Z$KA>1ZD@?RC>#8cw)>$_AV-|(AFN%XCr%X!}U`YeloYvZC%&(@FA z3JxsGJh)`1v#jcBJJGiM|4ln=U&U`X|Nr@#qU7>rX)k+L$Yd_tTvY%0AM?3u9|RRl zl6Ibx(|Ku^Y-e14Q{Vjm*ZKt=e~%};Z>&nH@SNuFRh$$%QTglAYf~p^elETHk%=i= zwMMDlA;3oJ#IaW=&p(T4X;ON%vRLrOIlkk&V`JHP>N9>t#LPm$%s2q*r?G6L~I{ z4M|#Ef8OVCCpv5Q-d_+cd-wm{C55y89aef{a=G5|r(UYmMdiP*|NoH)w$FK8WUV}_ zWW(QWw(qWe+<5QHeAPfR0kyZj$GT=mJ*&=Jq@<)#x1agj^c*aE-pws66$})F@{_W- zY;548FUE!j(*?U3wd$o$7TrGab=~?0f~%yqRUch+MMkFjjZfAjADO#3@(LR?lYE$X z7^0@_w_7jHa5tg($%#`TzEky;E>u+f{kC?Y`1bd8s@=c8ap}JkulQK@&f>>P2Uf(z|O;X}wSB zextW>_i3X}!S0_)o{7B%n{U2#i;Czko201dGUHoB#g^q7ip)=}T6`4v{zP%K1aR;g zZi!s*Ti~ze37dC{@3xhG#LD5ljv?`; z-~;{*hYGi>lm2`{$#;=c*xW7MUvI5>`)S+P@FLg$Ni&yr7zkJ}azC7zx^^Z1@7Jm) zH?*lqc79rSZ);kn>g`3E@1LBq*;#FJx~h8bf}4DrI&7Mk9r@W(9Xd=LMb2yqXPdzN zqQ3qe&o{TS_GO!vJPG~3`suQH^#_=yhx)%X6+F;8MOR0d`9nb2Y`KI5J41wi*Z8`! zG+k2>^#3|#iH4j;z5FJ=HiMWeR&9qsLZ;I1i1llof=#4q;cF6Y5Ba2O4wi!+vHs~?)OWiE< z<=e95SzQGCrnkGx>mBZB<$Gm1a-|mkYGi#8Tb(*x{_OjOrh5*RePFxrSjly( z4!`re#k)0F>&@(4Ix0nyB4NeXR|;yi&EKte{Uc*FKfZe_YQwtuI{)uK8F30)QB0SAuUn&CeAk_+)Ye(= zpv2OTKRc!_)bZWBqu-~kX647_6Z>4^Ki!S{Es+zk?OFN#E3Ym-FIswZ-MolNQzCPp z#wZ+Bj=c0BH(p?ohJO&lUVr=9uYWw>1Z?C zT}Kha#PZ!g&R^Z18~ISXUvL83#T^n4q=fSm;wLVAvh!Q7;sM|9rW08kw=i)DI%vqT zEa5E;F^Ujfe!$~V^i>s=M;Y}yZcl67nfGL0-syFDIWb%z9+MlsaJP7TUUyHf&VJ<% zje2?CikvVzb?C9DOIQeEGVovz+T_R;bqR_oodX^IBQn z`=PIwyo!@?xtqz>)F7e2_7ymI}?o)>$n{{D|XIcdtTsW~0RN(`djdqTcOiFe%ElIOG{Im4ap>;5vW z_1y4A_(iAsGFXMxfmg-v!L zt!gS)#2MljSNxilamt3}*u|S39!-W`EY^83f6gk*?C5F1pjN zDC6}!sfpRbD_~l}agAvYx^&C}9GeavSE#iN*v0n7T;`(WEXh+k5vKh)mQKAVYW~@9 z{*iEcdh^S6&EEJ$CLe9Q7N<|GKXzWz*Jk~t6^pmTazys5m=So3Gjp|Fo8gCu7oARP zj22AXpf34Bh5Hb9=jqk&I5N^Ui~5G{Jlf^VzL0fQP>22nv%^B>0k!OTFVC(H?TB)c zoM2s|b}&j(qrKpAxSVmtg0e@>yKc5#IPi4Fgimf#M!xqquh-6;m9y$uNM*X*s<`^7 z<95>;WLC)k3Q@_;ie0g3#TEU-N4J>?vzUE(QBbLF{?oKoXthadqab_Cg%xkTlCWwMyE0|_rH=RS>OHM+d+N8hib~SE-egtZcw6$H?fSC$!SyNry))-u z$e2I9xAyQ9%^aPq2$L;Flb3n#2;I7_+ha#~T76^Z`4s_Xfg1j{b4)BEK5EKRPHwsR-?X0ea|)?UaGLZpG5u17iu)#F!$QcX!Gz>+pKf$ocd;+#mAo+&;0WG zNQ3RUKZkBgPp#wZcwtd9-PpR3w_;_M#LrKWyPTzuX?zQQoWJnz3cbC|0Trk2%7@2) zRA2JyRYk}V76bO1u76ieyqFSlB(c3NWJ=R(POF)sKLuC2AJeRtxI6#Ut2Lr3>1*_2 zEdtIbl%8}An?7gbuIJhUle@W&JW*P$+%!)k@`?*bQHzxOguugR4q8fn=J41ca7A&A zW8&A^GtX6)K3LG+yyMvCeT~ky%cnn{u_*3*fsJmoP-@m63;A73{0=orzi$i9j9gG` zw5+40<;|ABe`}Ol)3R4g`BneQMng0|De#JQunRb!t?6Hjs<*{{;FNMhE7`~=7C4zCkTo~&ADVeT$xo$z9LT^Re`o$DUt z>M!NlbbZ?L!~=%|xGK31oxR~S%UCRwSxD%0!&Uq0mprV01gB~(I?uD*^Gs>wpZX&& zzpM;=D7^gg$2TQW^IN8@T5S~T_x`Hu&e#6umoF~=yUYDR_Re$sxAQht7kp+p6=*Yq z+5KS4_ALSXvjxsBXpl?EsIr-~F>%B4b#oOJPiFi-%1~0npBkR?MRGlxw2#N#nUjO9 z_T+?}z0P%}CTGDfyV4y?#NJ%^z}7NRNcLEBb3OZlG9BYEMQ`r~FAKb+jvY2;%(!u6 z@-oxQJ5Q!WeQvgmO`aSqW_jPH~#$S?|vkN|J%=l`2=yGm9`TalxG=N2x> z&UB{dw$*t~S_RLfaxR=ST5)3X%dn4c!nW}5YJ52V*CE%`2qU@1bx)$yqo-CMUZl`6 ze~$R-$l$8FxHFe8e@;3PdarYmnf-z*eR&^yWLE`-msxQix_546J-e_Y(@eWeE7A{& zbGSMed-yea6`ec$$WZkSUv2iidif8l^{0AB-97#Ab>kkc+^NUb?G7)tJF(YaZ|<>P zj&-Sj&&Kl4wzL#~{NZ2C{mJ^x90iTxL!?~~O$ zmfW1b=yzaj$^?}uMeC)0GM!T}=#zW<{`$?&?jPQrIhud_5?|HywR3!?`m-E-=Ca{sXwsf zW%iPHQ{HU9tD~lHvEo;5`ORIQ?SA)5l;xJc;QM(k#ZWq@KehYqLR%x%SYsA@tJWR9 z9vNE2ug-kXFi~2>cHX3!%l_^D=I;r0yY~K)@9!|x=o3H%a z(pm2i)6w^<$}FAbxc6Vjz|`Ep@XeN@7VG+UyVh-Z?0WCs)1B25w|-r>@$l|Ncg5}| zSKpLLb2<98u>a1jlNE0(R|y1~%nGh>o00mkY_@e&ez=P3t24`l9-iz{=&F8InqilJ zn`7Yx6BS3DMA?gKTUc2|mMo5#^7Rw{jfzP}R{xPbR=?%c)(oM{BaHs)MXlm{V;<%P zzv(ivo-+SUZglh{F_uUB?!A4jwf@$Hx)n(tkCr5-zI1-~@r%v2ku? z<>kh!hGI!)=68SG`0hYT3R}|CkJ{$TdpL3gm$yw*)Uy20E>U`@?)Z)u=E{Luh1-X<^ag`0$-5ks((_($;C!wXv z_dQ-75!ROdInB#mKGf>pj7y!Tr}V|HDB<~`6#IvREzD^v^Am@&5|Rqf?k*9CXsve; zxnr*E@hQclLV?-qv3=Tvs;5?2b-OM*cRa8PND@syow_gIw}f@q(d7wEE-Ffs=AQg* z6DQpHWI@W!gC8f{WS#wZ(aGrFE8=cv?_N8*FY8FZ)lvTC3HtM=_X~LRY>JIzQ%}=u zSf=N}tMDq>Zrj$}x)Zxu*qJz6q$WSGm|dn>A03$MB*lL1d^?MY_UQ#o4f8tYnJQa& z6#qJsIYoQ+lXFilecQEW^|A=YdhNA3`b|u!LV_la-Prj@=78#g}Q(D~-U_V{&+wzoAYCkd_im-B4i`qz3}W7l%cPwr=#dr;P9aj}@JSd06MF2>rTiX$m+H~%Ow z{uB0NMfb-<@rTO6vYxs&uZkbMJQN@y?~!-q`sR6s95%iE%h%kOw$rRh&B~phYai?K zznkIJ=Fap6KZYyUQtM9CuS%73(YSbA{O8x0nEk&Zdk$P&Ub2G_C4+>w89%16ofDWCZIr)$YFfG|TPS(URio z6Sp5PEP8KL9Vxn7#xJ!r^jUB9<5OQ{UN06%*4cMk?DX2%N~_IwE{>Kj*?GJE%+~wz zuYM;@-}=iUTQ0G7q8r;Unap{jq1?xqpC3-jys6GvF#pH$`JxQVczyH_h3v7OwKOp# zZQ1!v7q6CCm>=vkUj0V8_}dlc$qi>#bX?yimV4sW1<&akjW+_m?B)#VUuqdS`&Cy> z1<(8`H7X8Tiv-t(Jq$2pYwKCve$;TGpIH6zeO$#B858A-4^G;juHvkCa(!;)+vf0x zLfryvr=Y(?R&3bhHPit>--%Y*W*`)5)Q+2^~Q3A)A?8v)2Z?EC}K2hRFiP_7p zyDVM(21zL)i}*|vo*5WUy%=-d_h+)w5~entMH-$zZ_eUuHS{^98B{Rq!?ytP?*3uaVQl45wKh0jd>*mIi-oj}O7d4(*p6&m&dW}t1-cDVg zrud$jTX%UZ=`a*dy0q`OLrkBOAmg%Ui_7ij=>7M4yiR}RO|K&^39Ik?(XDs>Y<6#Y zWnB_~=V{R&CuiwDWHBrYJp29Rj-XhNV3mLVpMdBKv`rH5vvYSdKd z-N{{5I_I^*n)P#cM`dRFrvCX}ceyr=r~dYuJ6q59Zoaf~)1i(Po`+s7Kg}@xa7+i| z?PK@83p(FVs5Xo||G@7-XQ{ctix>f(wU>6x{&nM(UDw`?`&ihV&7SNllbjO#{^OA+ zcP>>eub4DB+N~sG^UobGpG_&f{P*+GXOH6KGiJ?UU8Gm{uDarQ+Wn9}0=hyfZIj=A zbMZS{-BmyPV*O3IZ!fAY{NAtIx`}C)l8u!h`)0#QLcxbVO{j@=uGpWy-uYQhOviO3)AGUQ57_S>s?HeapdhRXp{&vZ4N`V76*3)v>I7BeqW2z%_< z%;2>hiuqW-G`Pr8_QELkAsGJX1lpmqEn z8{NNretWf^vDGkA3CpCmDdhN8KBQai4K0j7M>A;FN8Rp|HW#YB9{!>5v(v_|?Mem) z54_c+6{LA=K5y9FCO@UnTH=k%+p8Yj>L-rBUnv&d_at!pBM)WiZ6~L79X)(FDfY&x z#vWtK4GRS>R2^1b#H+^g*Jf74rjrvdmaA1xX64=G#3^5`9C$mWt9bGh-;05Qx<`y8 zi`G24<@u{sLaBav6}Oevti_7*3z+_Ea4nq7n|kf1g3e7}BezY;3%pZi2t80Wd&7B{ zvBO#G1ceX=Ug#E%J!i^f%f7KQ(UX-9*zagXD=fhkbiEj#8 z+*e!=9Wr)PJu^j7{79nis^t#u(-Ia5&(zp-qUWoZ(M9HDy>mxSq^K-rb>wt8mUo_O z=8QdM60#>=vCsU%+~1ccwB_j}^r8v>%(qFCq>-wYvBRT~w}TL(Wp zx>zVEEBY&vJ-=}-s{CMEt#K`q+w;P+=H%ale9q29idTP(fK=qp3 zW&i(N-)|~*p#E{h!OU6f-@U*8ZfbM(k(IKOJ(otXQq$-?Vp=&KRvzTp#8eixI;ge&3VQAsD@)Uy95{0@%mqinF)*jF&cKp z>bEgC{gtqI%JDuX^zhW=b-xxw9;*s+E#8`uzg{|G+03}TyG$<6e)jm%p1Wq>R^L2- zHszPlj@dsyF*+`o?dtn$VeG>So07n7zhB6o-M#x}_qW9_`5NEJEmC^(D{I?DPbVlY1T$ z+_?78%Owo69Zn=Ct)3vf$W`;V|F>rm!txiHgEmbx4R46c5j(7^Tpj#v?cUV=jQjajp^+w5B~HmXuoRRq!{D>h$CV`?n!m`hN>%8lhz*<{PLm7-2i0h z(*)DojvF@XtcacaG)k0rX64Z)q0c|`I-NGwvv|Lc6;j=#_wVH$7vqOA{HratJ^2`)D~~Pno<^WE__3Mr{UwPzs$*{Yz>WgsdlWhy_ ze{qIx;;FA#6fE~w=4S6s^*Vm^f3 z*XlWysV8xI!<>7kmDr>hT;@n#ed+o6gOS$ph|Sgw*=`SC$#Gw{E)r3GwRF95$=f?i zbMJ0Sb-d6y|Nhd43m?q>5}q`F#~$h5Uyh!ce$=kkeM!U@(Tj%qyMi{j>Z={O`Q}S5 zOEkaqm)6`H!hy5?uS>hCSTA$2K0DRr1{eSS*bOJ=ExH=sGH+tVQF~UFZ!6wktJWU=zSLc3$N9b))AenWwj5I`mHpLLa@Q;Oy7#1AQY(F4oW58Z-LKJpt3IqY z=4;{Ad;^Q_Wa#_v17EQHnC(_J0gIzw! zK6zt$~^ z=?s@TPb4xp2K3DOe)#sLJaHRumwWMT`mW{mCoI)8e3y5aFR;mSFXeY$;OE+ZW5ND; znwha;2dg^2q#K(3Xg-l?SLbk9r%&>gve%{!2cPVWaC>CR@ao8uhAB5vx64{O3UP7S zO_>{hcF*6ZEN?;rY^|MF___3l`-ca-c+l~Z{|F0b$G0FFjN@(f>KmYuhDuYxo_l)@HNGU7G)Lt?lMEk*f~re9@vo@29gH*t(tl z&zM>KUIIKACV_1Wq_Kg8;q-+~teW-Fo|A8ziS7Ho{=%Ils|1@`89bI36(m(_t?Zdx zcq=qG_4k2kH?qQ10-q&qe}4UZb%aL~ujk#qx1PtQtGU|bI-eqHKj-(v6q zQ-2?y`~3TKcm6z2)8r{BCdr#mzm9ZEpOx04_95H0+O+=c&X_$r|Ezq^EPJHKaFS>J zNniFuTN}ijWADh#6ZxI>onyC8`?Ogbt^}L8Zj31MeE#~8>C&3`ZK+$g$FIsZR%8yc zT5WFp`_mzRTb>oH3vFhevyIK&(B>kz@R#1w*&8*(o}8GoIlN6tku&k&iFFT6r(Vf5 zi?f$Nq>Q`*Lopg1Y#bN6|kJ;{u=Ekm@bt6rq$2C#sYQO89Wu*sv4|YDg^?uPk z)7LjL=1eTPu))2)dufB~74B*0R=Np&ZL%npBqc#?j_uBIlq3})mPtV zST#;kS-I;pgDNvyhEwa8kn4eaRXX2%oi89H-Nx#+sWVrZ)it0wOtM~BPilAPwfD=m z<+Ph0FRL)lF@KvBC!XBr{J7=u2i6S-Y>I#1xDr}EW6PGS=Y0R{%gO(9;w)o`U^riy z6RT%~ZsWl%qAS`%EDY?jrYxSia6;9+Ev4JDcJET?Ui#?epPNl5D?@J|Q;NTPBhL5Y zE%6v0yWY9efA7(qwW5Y)f$IEI>h+dd^KZ}lIxA(?HDCYLZ{! z<}j6QnJb&)wv7{67$WyCVw@_%yZrH@;~VmmrJcJrOM5rfB2v6Cb;B+&gbNk<4ekVUx=1lDR&{H2~d1`S{PgLE41@-J({ad$Ito|SUIxy>h z{q4%l5+a7H7}G0Qt~wv_VfYhqsxh3Q>5Ahst^4bCtu-`hsC+i<0E0MR?#^g~f~;@l zv0Ha`>MGeJI|-^*_kY~<{Dgv9!F-488P#SG6G^XlVg7I551 zSKbtIE<85&b_VypXTQHL`N?uUxBpf@b2G!z*ZD%`)_#%woKoWT4UR&SmfrHPV7|Sj zt1$QQQ{TYErVoh=Rd!6C@xn%IRgsGZbY{@9ujRW5>uEdW-!l zaayT5EU#a&S>cTAqD_ZlvfsqNFidzH&z;mBn73hL{`tPb{AV>= zl)686t+7)))Wvb2t%vVV`&s|VDl_Y!uM%BYq4;A#f~MrfLy;344|Ok}E}kFT+v&Jz z9Y=twWQs}6wp+1#s+`laGk#^dJ?x&d*Sy7Af<5d+!Kb%xws+SbT~!vt+||Hd?-Rtf z&s_Rx>t##RhZjr_s&B}&(tfdczNm!ejg)gHb1wHTWq7(tp_TIqL*#ZL&7x*i#;Mm% zRO_V9+$45U&H4C@OGc3@MrvVRBBxBgMv3q*{h9FozH14OQ5U05q)&&CM$m~H2SbeY zOQ%V^St!wR%CY>ai5j{~L7uikvdu;o7Yj4yi| zUUsL$@ zOO@{HwEW!hWxdEZCztsu$su-2<^HS}vVYm}obk+Mr!R+0lC54UDs8ssuzM&r)j(C^ zR7yb7^!s`&()C?8oD8BH4WEh^?)oz+Q8Q-F>U}j`kGeMHbM`IUzHL|Y*BYBehs~lZ8vCz@@}3Gcv;JKho3Qtz z?6v3JxuqXsYquB1%G>QPa<7o!zA7y)GBbGJ&KYywoxPt>7<@>pKJV1kUhfo9^E^rI ziC2D4;C*6jnX$*f^L2s-a=Tp%deghpI=csU;`)7xS0)yVo|jFBhEGJ>|qfiTpkT+m~Bk7QQ}za z&J}h`wOWaIx202-ZrEiaa*3Z|@zLDh8dVy6iqk@#=dtR@MjE_%e07z@mY-L*eW?Gg z@FD8RHtkt2d?a1`OsvnF?^!mXZszB58^L0c$I;9Wugz>(*uwYy-;#{5(o7NUs#F)p z9P^e`f4BDEw|*wpe02XfEAn&Wa{I3L_JPlB4$oWWm40v5>{Ykdz5P8kTegW|jaruB z|D)}bZ**m6zP)fY@ugN{+1`gA?V@-uXy*EEsW)ET5ML=gnd`=+psFW=bzi4jEaLHU zw41nV-Ha=xR~1}@*~ImKWvHlKdho4lHxr}wyO}KS-?lq*^4zN1U_bx=CXW|?gz7a; zJ1jZQELQXJ;pCSU!B%AwsfyEzV+;=Pl^Y-W`D6L^49ULQYxj3_tyzEe+T884_D#6` zt4rT%)ura^^;-Eg0bBHDhh8_?*Y#RIE^&Xy^9NoIRTob`{`f1F&!@O{x0-wM-5b(w zhVEQ-t=|HQ8(!oDKWBgLy6bK8rF*cD|@p!*Lr)e$-6DPR|(wbmHT`tVsgT* z%8K88ukV)Tva=m|mht4r#shbrm2G`HtH`4?XELW?@{Q()2~t;2rav|7v#VNjRIIk3 zi>)%@-kpo(72#a_qNkQb=+s*%a7n~3V136D$dSq{TeH!R;l9m-!>@dfO}*9Zne$5O zKEGN%*Y~KMbyweA*y?&eFP!yIMp2+x*xtfCtX+YXwQAtFt>xAOa4fd$?QGK#iwyu=%8-c zX0hFD)vD*}iu|PFkAKgZ&SlJERNu&9w(jQSj4q~os;~ZCe8YL-?f0@2trG!~kC%U( z{+Xq&!`}AazM6lJ_aB$O_k6dK+_u?q{M?4ZPV6(bC2%yoKRBV-l*w86T|p%e=foct zLP=-i?^ti@mihefgG8|7j;#6{3GMCIReyZh#j-{D#!U-t<`AB{t=vtUbGqt#tp6;o zzw%ICsPfNZJ%z({a{ps?=k`977m{c`(ye%@Nxshb0edae2V-5q9o-F!SnXdmw%hUi z*>I}n)};PN@ot@A!hfW74?mWd{m_5!p#29<+kY43{%17QZ#iy%=8U^UdSk$$u4N~$ zaz0?Ty-?2hepCPI_S2Kry}DfX)lNt2*6yc`pQP=)Lz8f0IfBm|*a*t#?XK?Vn zu)|NCo@M>4a7cOexb}8($REzI>`6*#jt>t1VbtaSulVTY)1&o_-rJ3Jz|H^ZjA3jd zEJl{bkc0iFpEY4&ub;R6LSSs_!HAtVo*vdI)C!)wYRdBBuIC4)Ef7-|TB)eH`}h0j zwl)n+nk#nO3NJqE>)ZVH-A8Nx%f{c)|M95(*7M%hwQZlf z_viDs_v7}T58bmqKvlbor?2#OS$myx!sW-RbC$cWD6O{G)|<=rEOE0$nX1v*Et9&Z zwsT%bt`81Ud_$0O5i!XO1+`??e*B&bX%9w>-RV||7o%RCVED* zQ0W<@JBQit6(3 zK2;y_U2f;sm9Gn|EhHlv_h|4KxHGDsE=akZ`>KsE@Pp^oNU1Hy7utpV{;RyV?nw+E zbCHv#K&J5)llL<^oA+7$2u$BD)))Kxdbcvi#gmE4?cT_IbB&wBW^K)Kvh>OaP09Ir zOX?%TeosziIDYigG?z6Txl-4h^S?*izk9ipnf1oximRXAO`PZaV~5l&=H7R^zm+UW ztp2XQTTbTu>8HrrcEvpcI*7h z`FOp)X7SHU>#s4_R;>8bS3Yf?!i~3?{*NEBZRu*u4p^{`_p>#>k5!oY_boR!W?$d- z-nL6j(k3DyQKjB_NuIUH6s9X4!AsaKAH6$EDszEqiSv#}j%Qr_6YVYqFYwBA-Nn%` zFC%DU)`t%!7q7luS^quVUM|<(c6H|Lshh87`E&a4x(^A<$UYdv+j>wZaDJmYWnCbM(99CxsMohUso$e#1v$}3eN_PhV? ze4G8tU}4+LL@AX=3+Hm5nqC%Rd?S7VpOQM`WA>1BRX3_zUZ=IKHn*Np&z08xrhtXO&_3QiS2~85Zweqlw$AS3y!X>5^%O;l0u$=sEiQyTSvM;mBX9i6;u$XJAD-vPqc0q#^7Ouco|fiz z-@EnU<<;sIqDftojQCQwIIWAEr`k1H;bNI+=NVUq){lGR-gDIDx7TeeFLe0^~?GtqG&YB*V1-rhdyUJab?ReG1{W{pb{=&`YiyP8AD?~-IKlptw=Dlrh zocVw0-QO!-F64XrY|D22iM#x~Y|lx!$bGRaKeO6!rl9K?CHBjgii7h7Mbk5weO);j z>nuEDGONYA?sj~#lL&g%rMzj?qaN0m?0rsJ{XzSdaZj0VcanSlyBX;=(=}|*7aF{> z+&9OWb6;cVez$s0>mN7bAF^o9WnS!l;=rFL0@LO`Tx9>iC?)oUpcB)zcjYIqgmI{C zHnLcs`}W9>X6_%?i@FVkE1lPQrFRvska-+3!DPRL@!CVGV!UTdJLWZg*()EOk(k$R z@U)k2!6O?%v1MO*d@L3-@92tSp5LGm-0!g2*83{$ zsXa@#2}%afa?b=;`Ky_uc(vvgXQzAI~!-IK_QmDQ&ZgO-MPgJ@Ha`V9lp*?}M-MeEsmE{6)GokATcK zyR*`!pMAR?DJ82-Z%|=3J-?SvaDhQ__NBn4Q}w~mmdp&v%A4}*l^H+hN~!sqc13vl z_$_3XW3%yQ5mkK}JaN&7zm?8e>PJ7_IWqIR>7gfQd>c0JeU^JK?zVHiVKKu^%VM6> zTX!z7nmvO}KQ-iy`ZleIg`d4Qsc(vKOwkt&dA{IFl2Xr1@m8s*MLWCB_(YVfbPD!c zza{K+dFSNR`eR0MdJq1bNfFLIQ*5Kx?&=~Cq_u8N>O%bmy;IFJqbwS@RF-m_SuLD1 z(Wfgg{+?>YY{S4lExk)YBB^~Vx?|esrA3`D^*XOVh0VhHV(~lwv*`_N4lOB8FBmi@ zizOaVGDz%osQ2vTwg~O=?w&7Xz41r8{=(0f=6!vicK(-Tb-kOg);R|o&*+nj^@%-lJH%*8dXImM)%imY11>w(Dsz9h z$nd0_VR}WP>CxWZGlMPbO?y99K7GW}r}1_3ceP6mn|JN0t)BX&KA^03!G4w7g%jpK zOPciL>B1u|2Y23Q(SL3wbD!_(g{%DQgQTA6xnDJZ;6KT8z0l(6$N7@F>{R?~wbe|7 zD>$zS&lZSHKjyT&Y+ZP(;Z}VwwSeP~ul&2WjorHB-?pov#a;9D?GF3u#m=rb`?sm2 z?6Qf%fF4j;6auUehX7m%hPwe)KDq>sy4cpTkCH#Xc?oy*C<^0FxBLUw}DhZVnLzDxWG zS$SS(_Lqyc)&73R6KlR%Mv5IhzH(x5LQ6$h?c^(G|5r~)JaFzrVcWjDf9&}y6d&x` zVDTzvtK|DwM#p+am$yqi-IMN`-LTwkU#b_SCcStw->drjuj^)%>C_jWJ%0TBkBr^E zpI+^Hknl;%?B~5UyXX7zV|UB;_UrHZ&B|-HoMW-8Ij$^lXw%*lsxKQotLY&nw)&sJW^v5&9(a-;HVc|0y5lcnjA| zOmn<2HLd8A%tcMM?YPCH*H?)6xtdVTDQSxh;9RR8bs`a4(0;=YGUP-a-l z(Jx%jPNxX{FILi=#pLAo^Q(&S|L4a-8B+yPxIVgbuB@0i;f!}n%l2!on*YTQch3B> z@7`_mm)7NZ78I?`#vTyT1Ox^kFFf4|=Q+}*wT z`TCG~hF&^bb$0JKrE}I~Ym3*9t>^1*{5i4H>i^3}vp-7za7gJ9TrKilzFuG*>zRsI z+n?rTSiArK6T0r%YcJ0!eJS}9l6G!Z3R>my@vmiaPV?&Aor`A2R`1B1y-D)dl~-

Saxv1=C4fuKAhyYu(+fjUVm?1)_c3APmBSzeRAiP zy*X$-Z&T-!r+fVPZB=LLZ(lz%{65dp^4blWRSVlLMgLpoIOEL4Ga>4i_nB{teY9HN z$z5W{zocC&Q`~bFXfVX7uSn6Gk;U@l?w|TbHqGlET}?lhnNPRcZaQ5ybyHE+EOw<6 zjfzQ`tP?Y`7*%*&noe?T5~z1zue)(!^U9SgmS6g~WLn?vBSIfNnfpxDzNc^ax#H}x zoO8m5kBVH~tE*SDibcQUS!|=iw{=oyWshCnzV2HM%e8Rc*6=y}?_#^1cU5sUo2LCL z)thiYv;M5fbEb8Bu0DU#B(J8kVgpmh%QYeoXV~g5J+ffOxuYfwjZ(997qI@16f^6; zdev@0QO65|fWUOV3e%2~^b_yYmi^#0@80vhYt^Kq6DNDkvn~qyXPh$YMpM>~&6zCg zm_NwItV_5VF4pkiRO*YJ)0t0p^qe!B!eN^K`Tqm^w$3J%`tEI0Z*RKV)cdF8YSzkm z9d%J}#6tW{%04z|{Jm0BD4<$pdVl>rjik$`n!0{x{og6dbb8~e*=Zez-yReAogp^o z+PbgL`cAK7|CEvtR?Krd-oD8ya)MhGZ)x2$qgzrxb}c;H`AoISFK)^6C+A;Bu6_3V zs(t*Pnd{BpJt%DJS~n-Fe)qQxIxn*iyo-rSTAa3SUyRB@g7S*mpIWSbX2HGv^?vb$1i#wXZ0<7-?)}G=$5guN%(S%Z z)3P&W1PR=U`Bb;2>y^{d>HhyNeVAw;+N|+)?{$`>kcD*%1#8xAeyPLE63bhEXOZ`2 z2bbAvPQRTp<+s|+eb#+{vf2CmuIs(HBlS*?`^QGVWGg-)U3>k0*MKQ2LVb_)W}jy< z;uTWdCw1xEq&J%v-g8WQ8Qj5<5M1TzGM}lIed-E@J7%A^PnA#8ZBqS~@X)mNy!>Z1 z{c{RV@41|{|2+84CD?LN=ilD@_cni+xU7DYdgAB9!uBWE`29Mfd|;u2z-*Hf5B^^l zv~0Ed?<#0{^;hf4_rZ#i{PtfSPnfgnYJIBFRThE7IsaD8dLy6uV%LU?|K)g6oRx|t zg*4K`-b|EINI$&()}*``{cB&A>CWh?@zy=S{^_k$n^6>-p+;uvgq+^>F>K#<35pc` zdsQC%vA(hBqYURW&xG^;LJqe7SIJ1NboKn!*`&|wqBVbga>=hrU82@6Kp9eu-N^4c zcg3P7aSQXr`<1W%KfYw{Zu<$J`mZjI(N)wqX%Vel`&ZQ?K6N7h%iD=Lc4;4t8Y=%= zTx{I6jGZIBP$TBBzz&{n=4bcL?&#_K;qz7MZ0VDFf%?Q9S-J9}oOjBL%RL_3H~nxv zy-#XpRY85iBp2<)=h;7~&t|w<^J4v*%($zU6*@bXuKQjS$KjIl+3J4vp^j~Z&saNT zrMm>|&cm!jrGGH=FD69n8&aTeQA!$;uXO zS(V7^#vR8tHU%2ocD~#zx%)r&x=_Y>lji^WQ6o>g#WKq>T9&S~&bjdV ze$&Cp|G5{|TlaxiF)F7Ge;aIU}RISfF^g5p3nf?ONy1!iD<-?RZJ2z@O=S62nLvfvE^nv5@j9d6VKCiL zSYl;w{qaplZfO)8afpa<=dCk!7y=AAAU(sMRtu3&k~Xh|D9IqTl_a9 zr=eFXC+7yIXfE@n#|ph(eV)?sM^_{~a??=oveQa&Y5c&lvL%;&&4Miw;zuqecy-QD zX0Mk1Xy#qrEn2iuRDn}`oA2zT?96=5ER~~bNre+9*LU{u9*;2One5VeOzpz9lrw!3 z4Fe~yZSvX{CM3RfZNpzDuj+1H&&wGCGg>FDRk+D{{TTaguPuAMS}$%2)U-I6D{io8 zN=nU1oygnKrJb{$Zb)fzQtaAs|;_l;`Mw#f0z@qIafwX?^!#~ThZIbbxrOp z+`SCRVp(+|S{ggH9lFyx`xIAW)8|9y7i+JaDeV|)GP};JVCfc)hWfMKqSB2IR-0Mh zd^7c7w#4k1-fhu2cS1RH_wjIu*_;L5m=I_p&5x-+?{`>j){R!`v zC7qv9Sz258@#BlDtB?Ok;+4yiNjd$9RZ8a35AB*f_EcV&*07DgK=$PJ{0Glg z-DS3sU6;&n_WAbduRnhuJvMje&D-Y7^S&j1OnscE`uoHE`(hP_|4R!^tQ&c{uRc3< zDg5@8i*N2e%Broc+_&Ra+U{?+{kzYf{`vj2{<||Nfjh$1{So9ot8aKK)FZ8?Tr11+ zOTC{vi~gB?2M+Asbtf_9v|rqV8TxC_%=@?HY5Q#UrdeBOA8^w2_}(DF^>X34>SdO9 z7)tvYKWQ*4yuR$rJtdL5W@=LPtKI8w>`VUk<$uRC{xG4X?Ouz1lzPqD8@Kk_jJG+_ zi+tzJO_e@;@y*|_%YCc={Vw{te(}xkuTP)vK5bU{!=nCo;kWHKPfBiOpZr|Ldg3J8 zF8x!L-!$CAq-(rS2H6&~+<(37^!L1PhkqTubuggbDl-0$-Tpnl-d*qhy8P!+`O{aQ zADw>r>Cs2$mo54IO+`{N@QS~`MvdKqC|;v1)%dc{H|*RT4_&@1arg9$#perGMaaFZ zFV`#IFx~L&$4ylg8b$RInY-i`JF2$6bo)^FA?z@_WMEw4PH{tz^>VgZbK{o1U3#H9 z^LxSWsqJOSwl>xURdHnuX*=i327MJ}FnN@(v+eF1(*E17g@yTiTz8d-McgD z+TRw)j(8ya z`+&M~h`T}U<6pJ*PU`y4HmRRIR#ma%*ju@%{g#QL=b!M(YA;-|*x!k*HT1%UpH8Xy zSK?ypcO5$MwCd^N<-Zkw+c-*O+TDs|_$B_@@8Y&`Pb{v-IEle)QlW5liLzw~h-lb-1qnI8f-CClemzp5gwaPeV2^zeB`o z(dXYLnzK?DUHgBm=ifEH$r3Nb-ibE~D_@@Qdi8Y9SovJVSI_3^OxiQosCSyH`jn#= zY>KY0)zRAb&RDNpn3oN%h`=MsrWC+ZLP7%DM2%cPmeIJWM~t-tr4L0#jR zs-4cURzCe>w?vcQc5N&>8nHWRO|0RybrR3PDE(c>4Z*u-cFwjeH-4V?EJiKY^5M0z zb@Pm(&gQT=xiuYqvt*B!?Y-iCGvoj5b2uD1PxwP^q=e=1l36CdF1=gU<)5-i@l&V# z^ry#<)@SX!m0LGo)7#~wpZTVc-QN=wUa!@e^J;;P$g;_;MW4zxPrM}dC?GMv+)Q)f zHhb06-Zwa&E<14ASFE#dJ6O0)hvkcFCWrrmqGg)a z>)&i$Ai3^?xb@o!97hkNtyuocW#_K7p*9P37(!O&@UsioZ{nTcx7)CjDfwmHQJsIq zw(nP|`M=!7k(lD{z;&L%s%1;k@sAe|b${tpUiuI$7kBE`+|sq!b9@imq8U|fF2D9f{7q)A6u2X- zCe^t0P0`IGnu4Y~OF8Q^Bj!wg`txVi=18YGCaJa#`z163DOP%|`(uXUrnD=VGzoUHhP4VxvBRb7N4O`Z{Jw5Sw>rVMc z9~t%ZY=p$WOEe})Muxk6I9OHqp7%(tn_JhajV4d88Emo9HWzjg@i5udTz{u*)xNix zZywKLeAn@g`K?>?fi?O?t8Ovx>Yumj+q&7m-Pe3iEY7(f|6Zu25M(V^}5L0{1mlTV)(do4RRBjek(9Sh_gu1}Xb7b2m=^!ZxMe$BRt(vlW8 zZ|;f}QGPkQ=tFholawb%-!SjK@@=n_g0hRoBUV2BeSFC)x6IDSd{eG(>lWC= z86B$wcll1Q6__H}^Y)AxpYgFNduo-+PyeW2xbV_-(2%yMIP^|5E*l$oQ^?rB+<3a- zFJ|rf&9}D+)_q@pA$sLZxi*H1uRhC!x0fE9>G`VgT=XUOjwTf|k(EMAa-Uu=7vKHh ztj#uczgu>kEYlCXOVYou_vPy2+1HcGx1C>fw^ID=zP}H?AAP)eeVp1$KbJ&7(WLJc zx1M^=SXDCJ)m7rCLGhixA}SC6&F{b88-Gy!=O5vP4<_@}$5}qAFZsLlZnuWT_TF`? z|Lv=v5XAbHv;OgdoY#9f?!Dsk)H(a|nTJd2?Hh9UR2tXKy7y>Z_CJ?tZJBS(tNHGW zMkf5TeX%b~`uMVj=@-{ozt8ya>~{L@`FCC^#dRFqyfiQ4bF*Tej!tTQpHk+G)m@yw z%1;!Z4!Qa@OuFjfv#)pS|4GV!UXT>%do|w2UB$P%`n}wYzw8$xg~U}@Jb8t7^9l>T z*ta)Iu55?9kfLy*$ez324;IvQYkj)XXZxe|Y(_!W?n&+8i{De+LR&NUCW zZ{N14Qc&aGy935_^Eh%|HH=*x23vva(zCTazA#} zC#U$WzO~D99Zi=hyP6!kbo<|>t%rXeVzE6xjm4YtSEc#t!P|2a5A85p z{_mmFJwBCfR#H+smD!rke@I?%??dtoR(n0)v#)tqu!Np?penb(IDUrNj}LK+A1_+{ zEFn*#r#|ae%`uyglP#-T&0|Z~&3Jx1eErpIsY%xtyP50!yLD}uOjcQ3m!ZLiUnz4M z5B@NyDvRWI|MaY5uO-(X@tg|=R^=II@+@xfpSXGI>YY=mS_fXVn14=Atq!>~&G|^? zic1%}PkpP(mQMF_kv^X(Kc(yNniFOGo-)TQ=hsSg1-z55cM)+tn7w?KU$ddKyn$c! zNp(j4`+F*O9%a=CJTy6Ai%O8~2@~$VXKAw*FKyqp@c!)@<_fz~zhHwV8RlE>weL){ znepuYqn3ACwJUh*pPVuAO=R!+!7Ci3(Ry%aF}wZktH-&vFHAJ*5SXy_(}SAt^Is;X z&YEX_aKW}j94plFfWi|*-QY%nO%yXFB zr&`Zfa>jbk%aY;Y4g>1nkE`-d$IsJuUVq|X@??Wg_0K|r|&a-Kfhha zab>`=#j_;VyWI0!-Kp-ietw}}!n%n*&!p?W%t_&ik~~>EVe2v;`$@AJl>RCh8$PoN zxpm2M*NwU_%(3@#j|vL)eYzyKcJuk8M*K>BPKqioqMT;<)pxHm40~}dZ=WBzxR8wRKNJS|NF03u+{PYscAgs?;QL8#Q`>Pqs&bKf;kKU(>nEMKNmVSS@54h z4F9s(&G{|DTmEoyP1ybGd35;CEw4ApPP&s<8v5$!L7{_3*9d)?lsVIh;k4Vj)wvZ7 z*JgF6=KR!d@cz87e&1B}M>-)2JKI0BUw*d9$CUr~{V7Z9cYd95uJiSFzVa*0H@AIe z;<_rxdp9b2twK|9())l%GZXHz`&KKU=ruWH3_QTEw9DMj;=Q$=#$9Sm9Rn{zYN z+-Bq1sfxV5|Gw=wztXQ)G@|)Ss`5cb&aD~D4!c*ab`IwaS2E_CH(F zDu3yQQ(=KzPsOJvPOD?o-Wsk^&*3R0MP=)q zjSe2Tv2PdCo8|s`v$nHmoOKFp^uD@l^3|2R-?+CsJXn2sn!8A1oQ-6?dziZZ;gG&_ zkGBYN+dOWM_r0#?pm@gmym=3|y6utR>kMt8$*$3_W@WHCE}pT7JILBv|M#`so*OxY zISr=vNw#(iZ|td0G&|YBSiO1|yK}(e{eKMdrnb6@ebf@%#l?~tZ?fn9Egt2Ud2UaX z|FNIq`J9r&E#ve5+>ADszKB0<^R%q|LDLM@`S2XxUzl zONG;Fy_})DRK_~Ovo(46YQonX;;p-LVEd1>MZ_Ty;6SwN~QR92@$Nrrb zVpwf+=F<7CS2G&lE$*B+(^fa4AwYD}{{2a3L;p@<+P0~Ng=s>@wyaGS`x*lpR$o)E zm)bhpj@?Z9znbNgem<`?PZGkL;=i~`6*@NSb?v`Y`Eb&Vxh6}>PIH?$b1XS0B>Jl; zyK?(VWctnI8oeU*pnBNzV3x?J}b`=9I2j;!Bl(zWcb{w#K-N z7R&9gV^UN*IoWNuP*j`KshM3z#SVEN(mAKTC?lBHHA3XES5u!|jA90BY2ut!`i>XE z|NdKg+AF%oX~$fF^UEK8{{E}BRQ5*J`d>V$XA4Z^9rwQx^Uu+j@i=YA*Rr(Bd1`9C zih!K=_xrN-obtY$7R$F?-s^b#!|K`Voz+6jyjRrAB-n+CsoK;DnX1p{pS4`>+T){- z=Y2CPz3cNhry+6bvtzUO8KxSaPj+~q!`);m9j+rG;vO8G-?nR!<*Qi=Ki=qM@$VMf z@z(BP%F1g$&v{PdHcOHyXgWDFcE&?7rJgihmsgIBe0$Z3?$_@)X3F!I@0!Dmg@s4o zdu)=?_D%K;Hd-kxQx|xHaTWUp!{qrtK7IXuX0@zM`mMZ!PrKg*a2|@^b=CCluFeOt z4x-NMGa@A#4o;c-a&>&|O6?y?MSe#_CpEwNb!PIv7#6e33pNzYIm~?d?#q=~C6P&! z&lm_VmHUzN+}g+MpKw-XaQ%j4*W>*6x9=0YbE$BCtT?}#LY3BS{-^o|9XIuUg z^sRP&P`KcM%MpS}|93nzc-S+^z`arJ?AAkT7h5~*n%fxuQkMb-~ z(R_Wd=a_AFWPaI!@N3H-_{i6a$jw?6&-UVDnlV=m_wxE#RTrlo&+E*e|LgSR`op!G zh3Bm>IDPC$S&!^6J!Hj{1anq9i*IRzSux)F-r1mO(pP8>-PPw^de|$IRglxM-cICU@ zEL#5CQZn4;LUXZ6>}BSACcEeL>NI6%SI^3g3b`{^?$6ODhaGo!`#xoQ`(|CA{q?%@ zQax)5Z6&_{+~e=tIWZ!(!~Nxn=~)Ilw%SU}dMqse_xI|BbIeQIit>ye9?zJ!gI{Hy zweQ1N9k=>(PQB&Lm527~m2b=r|J}#ub@_>&ftA%?d5zj9!9TZk%@p>D_+GSInVwZL3FzK5_qqP8OmW>4Y^kp5r-G)>p0MTf#=9ri3h}djxch6q!k(Gk z&rkionsN4S$;-VbvM+7jEV6-5=a9{L&pj10ul)P>k4}Rt?o_k$`rP*}6!sBz$@5&m&(SDrH4p zF5Q(s+iHGEuZDEjGO@dD`**!Np4YA)etegOY3$Ldc5815DO>E`+jaHZVTH@z{;ZW2 zOkh2Gj(>Z<)&0MJANt?8eJ|KgLS;`K569jMN2N~rFPUCu%PrUa@X*pMo%Thhw@tc4 z#n!)GSe|j<cFK32yV-*Dr0K^_?ThJ@LO$MwQK4KJBRP!22mP^V+{;tp9TP+~KfO zf#2iT%VsZ{b7J%7Exz$QtdXbGts*5G*UVj&es}Gp+X}*+le=57}x%#^KyG`^Tgx+D?t+A>^;O>@lI}_&4%bvbS zUh2#09sH5smv|aa+WkItXZPa&Kc0X8cIyXs{k`V}9lMUNyBs8AtGjul&r5}8eo4Cj zHfp!kJNh$s%oh3E@16c=?c#!Yl4sAbum5)WGiTcztu zy_YaVXPv$Nr{j$FhWc%fF7U36oFdPBO>Od_jK(#NeqY5b|2}!3a>Fb+{Y&wN%_}yp z?oTj3`dq(hZo=uW-0GHr7yXtW>YZ=6VXA6H;EN;WJEqFF_$`@M`0qM0%_A4<9bUodRCoXBR&6J$U(6F!Mag5i`;#O1THOs@=bnYEbdLP~s{EjDZO0_{< zuJZET7PT=6GPghfI6F&K;d#g6>2nheWwI9ixV_uia?9bZ)|E^XHmTv!p`DDCdqeon|4%SgIqCfJ zim7P1`@b`bwq=0@%1gS8|SktF)FOtQgh2yQFdxq z{hzn9H!VLtG-TUJxL+j!*wz^JE@h*ZEqN;4KcZQjj%}qPKqj$&Mh|6+~EjfI31q+H- zJ&6*w+|zRCU8YXt!3oSKZaJmT>RzBL^|^FSLVmsW%sg(+puos)2ff)AJzp@e7oo>!ZW27C*f_C>~c@j~s{lVr9etO>8%@bTT)Y6oXR|3Z{A|8 zHL2iK!p?^r(@zC2QaR<5nco{N`S%6q@&i}DTAU16`F8tR1Kw;IPOhT|gdS(Dn60hq zxcudgnU!mEj@HYV&QRPu?}$0Gb9blZe7|s`UC&gu=EVn1#lGE0V zH)iucqsnbnmgnm({hfY#3%_59sclRalX`GWO+VmwrAb8=TBl=u#PW8@6kuGFaxfql9#Hn$<*b0;Ss0DS? znrCb7?L2u?b8+s~FU~(zjBXgJe@nZtEV|eDi(R7d?y@(xmd)Rk@{DQ9=a^X=rx+Cr z71`K6efsm$OQDDs!`w-Ay#M3>h!*BBe){EFKV#v1;d`+&W(NFSpSI<{OnTCDfxDHj zJ~O;5eDrscf9=EnYUdXCuQ=rTFXxB&XI<4j+6fa3eR<6#CImM6_H-_~x#s8xdv2a3 z+6Nqpk~nTzN*{ZEQ$@1qp+tb6?*7d(hrbB*J&cy}%5IrIM?d@c*6Fdjevcv#RWR=e zPMGeaB*s_Yzy439&ymEUbx)Gj_glZ6oMe;!dWxLN$8Wto6F;%vJ~UU@K_*H2^n=^Z zQKw}}icY^=Z{f-8wa@YIjcW~?%omi1m}y=xO5fqcx-P|B`uD<>Ee{TT;QcXullO{P zLAj}7JbR~IDY47St(RGF=%!L1gW#za=@ULuNw=2$k7+yCrcl4U;oq}qVc92hjOJYV ztP{NHZA0PIOZMxw&CNTzStry-C-8H)czK$8#?1d07MXF%Z;$1<-V!pa`KP2r<>5z* zzf3#5>2qt|S<9PzyW@`eU&`}a?b!O9>!_H9fuy+7=_Rv2J^3%Wa><{E>O709?xs|1 z_B43DYf8WlkCPXQ+Vnpe&rI+RtZ&*VE%)9k(8%_>(nj6?PW>Uf{%1~Kbh_{5QTlDTk|KZttyDFNF7KXe`_-`0nzxSgy6Km}6L)Z1?rPQysUer}u@xDsNsrd+} zP9XoH)=Tf@eqPA~YV?UP8bdd<8W>K$sK}yOzc$;?~7ZvDJ{eT!Q;nr+S;eN?sG{MaW$$X zamSzZ{QkYMYg6lG^z2&~>XdH(RrA+;hLWVepx!m1do7D3*YVG?`}ukG^(#9JUES9v z-_H5n`^@~c`@312a>9(_?#-&Qk9^O$S2Wd=H~8}ASKirXzBj{tHdLuTda8fT|3+AA zZQE|y8Sx!FW?D@XEdQ#c+DJ0gq$cnCduR{6vsEKKN`$rtxufwyYS#X-EGA| zlU`QrN?*NI=wZ?2?Q7RnUf#8tt?aB(X4!M6EYs~JYj00IG3~c?)p6Cc24|NW@O@u< z^H8wO&hV`B%Qr=;2TnL~gHuEN;(M)yzL&3;`MG$ptvqwirNm%vZo}a$t!e94^eqin zNmzMBdiC}*`N8u~^0{T}Yj3uFUT@3WZ18*khPpLnn|CQT`8-MQF)yt&&)EFjd;Ruh zmrB!T?Mj$@L*(f)eQxe0c^3Ib>;lppPxr6nmr#wA)<4v}xB7S0)Yj7s<~+Xy*@BJ= zGgmRYFLc`Z#$?vJ@R)$@JG51-9v^3uvY#istvf8)S$Dfs_?p6ekNYO3(M%iW964RD zuF)vbe}0R}qB8al-NVH*cU@ll)%Zr+yf+Cimaad0-gdo*%&yEMo0O$aT{Tpnq!7+& z6Dn~0vGUR02IZ1>+NUq}z4)TGN?^I;uZUQQE!G-&Wsl<01>GHGjvl^o)oPNZMc9+r zXA91?FVo+?W%;g+E_*J1xzjW)Ae_6}aBEo>i)_8?-lfN$eJNeZt+t5eW8}+4Z2COg zj{0oh#k~EZZE~P%;(|{-DWXr$d|t5XcAM#hxf2tM_hwgR)vP>u@$&7r3pb=Q&*{4m zvZ2?0N9ghAkFVD}PV?K_yZi;qzDHMFz2D#6c%$HY<0F4Aqf4e+`&_emZ}Hr8?=rjm zq5Xl^g&8k+@4l?Rv$ENgC5R`TWn%X2JLitMPi0k-|H6ECQ~bnv+u1i;R$K~`H~llg z*uR#i)pzD8X-ip_IiU*{WoS)t-Z)8dwo=V>m3fa1+@uXtJerOFzFcEh^uu6od5`aY`v;7ydyc>0 zdF~>x@X?o+DN1f$?*rcWreAkgU&f}u$JJrGb8%)t(cIkMy|M;=hFzz`^J?AWeQU}r ze!N+iU%uiV{{chGO~NyG9(_<)FX_}^!KLVN!c*x&;T2scO|CUwo1QteAJ>YmdisDV z-mi)KOV0+*JwGeE@0oqr+1TnWS0T3f!;M3o?rPtsdL8%Fns)ryp*_bwGK7>ra&Y_a zDsp3IF@rvNudRkx0 zXy^RFyyoGV32*C<_(xWp;yB~P-Wa+6;-O7m#}g;axov+l_sl_tdAdK#muz?zvS8Vp zgp+p!8K?Bhu1wwgwRh2;*Jn6)EAzbe(+Fn&-C$A^|J~wvg4Jg^>2J%5IR3@`{a_m9 zwMgmBf#-7DavsJk5_sBDn7>9cZ}N|+tpOGUfl z|Ek)rpQkcp?GWHr+@#QXRHei&5NIkolzul9! zpDbchT-|f0KE`uWrGNHT<3*7PigzE~(_9?jAXKpB+{#&NCok~f^iSlsWKi3c(VG%o z65nLW*rCC{>5C)d3XVT%i}rOhC@`>T&N;uGi{Wf@>Vp`DBFiATm&r<(=0+;4d~b3* zLG`f%<8I-v4lfoTnxUxKDKKT~5{~z*rTcReX1|v2+LqJNAXfji>@V{}W|cWkcC{H< zi~O(3a?JTRLzqY1>ab$)ohh@HCHOp<{<^O!`NGqQ^50Ha$D8dDIsVPq|IE!0l~^-Z zU4gD_&LR`RbcP!RJGka8uQmRAfVWTX!&{ZA9Y0^{oY;6^+NG!3?{2-4Wjn&ur2gx& zMp2!JRm`Cq_tpw}Hr}zFQQx&>y|cq1 z&2@b4o@E$y>xx3`hc#1#ANG{n+?VNgKTs$2bkc$c3OT!$+}XRRz;8hwQ`P2rjR4O_ zYo8~?M5+Zo=sf$+VD{za#S%EnX1L}1)4Tb`FddA zj~{o$H$~waq*nLxx0D)w9Y+S?i*^Y(fqOIz?8O> zTSc=j-??#Uj=1!`oqf#<&b|ENcHTOi$1T17UYgypmcj|mTeVIECLNI7uX(IRL3!q` zogu5_9w%*_HL*9D=lX&>ipl~1nqsOVe}yFJD0AEp{c*dL^X2Q!jv|#4)Qt|RUXz@r z^H|ev&SVyb^%j%3RZ|7LzD`h3U_AMW+i}jcmJ;nSfxR2Tl=Y8n@KY?UGi>QQEqv18 zRr>v8<$5J?hCi2H`jsuaqMs=)e|^COO_g{0S<@fy`Sa%Gw3lJw$Az~lX+_ok$Zr(0 zDv|xcoc==G##OVTIiiMt-Xas;DW{g(OboWnEpc~~ZY+9yqf>HELk`CtJDz!gCoBcr zLtmBjh<<$A@?Z4&oDHroolDv#|M{`4SWx4vTWQX#ehrEGLp#_)b}xOlkwIkb!P-)r zN?-qmcLv+#?uTk76PIL7k-6U;mT!{Zd3d+>Zi#9MopS|y^F;zW z9X>34^L0zdoxgYZO=n4eIGA!KMq$>wxa-*tKQ7D6yW!@3+d3a? zi4RzEwC((-g)eK&Y*yAUQS{sSwpg$9j^JOO2o)Bc1&fWg9`tx=Wx|@yfxts%w<}!QVIK;})%x`ctA#B~EBg&TppR1%QEqK7?AiGte zYSyGcUE6n^2k&qycx*px)0X}+;T<3E0d?LNPBWahKmE03wIs`@e{b9O|EN#7dao!k zPlP$=;O`B^+hv?5S@p2%#Lv^ZKG|Q!Z}zo6p0}?lwf=Feo7{Hmc;<=&yH|2eS-YWj z^?9yeOP2q$N-p^++FpD2)hD6CIqOW^ZZgI;@OJ+YQnv8@@bb#9-_MO1PZ$WyOyR7V z-CNc_so_k*<_QTF?^r5|j#-GcKDbwVxc*}sZ+)KZtYrs`471q38AKdNbL_wPS76_w zxjS}Bb-z0BdAGLv^|uVtTvxwt@qPMZ>4axyZ4l(E;C-~ z>#`|qCP&JOb6wBgzI1u+#i^-s$@!$ljh~@-PNZ+nf8p)2`g1yXv2Xn8(dt-ta$s->NE1 zx}EhZpRH$mZ|t|J{dLzzU;84?+re{`AF1=5W7L(}D9Kds@Ss~UVB+%7V7n9Fx68hL z7g%##tL%EH*2HyQKUU{S^K3Y0xN`HL20qPeI3TduGB6Q4Qj^!|@?l1rzuS8Sip9(m05ipE?X zM#ewv(O%JS!A<_@7Y?zBFdG}2LmK>BrA`(-KK9iv{-AP5>bB~GS?VjL^e1P=-g#qQ^!dE| z{`+_K{rco9l0QXc=9w$c%C?_;qBe2n1jRF_&hCC-zIO5K`}y@V_BHaKdBeO=nAw`; z@AlgI`O{0U_I)||efxU5JwY4P&9fFeS%fYv*~Mpm^yAgt_n$6n*(+}rG(+d^9pNX1 z$!|K(KD!?Nf1Aa*bs-bQq}q&K%1eX)I?w5|-c#i%dT*{~`_pjq=*1}kCC4vUt~oV( zZC}cU*Q>kSL!-Z%Yw>>Lw~;^h_Z{1V&x>XiCT$M&;+$NcC9%Xw>aTdA&bcWUjQ$2k zw55B_{HbGoyh*x#Y=h z(v`1mo|O9@l`cJ@%-z*iFZo>+HTybUpYUW|J!0&{XTXfrcd_-%C~)xZk?ud zXhZ#tX;)Wfc|Xze{7}E{9J`$Cod@eyMaex?ci5%H7`s(KpS!Cy`=8cBx0xNKf1Y!Q zpW`Zh#JyeWnD|ZSj7JO!uao`Q5~pyg-N|%2)E585p6Ael6SE)Pd19`$A-?5Wi@+&! z#W}y#T)0=r?A~X+Yvz?)+gp2uQr0d`V0X`u%vrl*sTh|?x!Su`x~m>a)*t+v8n*J` z7lU8LEX#!_wr$kkvFXG znr_Ow;gc7kf9HcwJByZ=)EzmU7q{ov)u+zb_PYP{?pKZBc1lM>8UHnw2fSRh?1?X% z(Fw)flWtF)vz)cSY|1x*W87Q&S4=Bjt5X&5blHWg*s>-+e^ z$_sCO>$RHOCm&VrYto-_@8U->p5tdkc*G8w_Pw%nKfP{K&vJzW9}2wgT|0a*edDe> zTNS=pJ!ikvAYpRA^E*S{o-FojhYW;X`mnxVrNn-5)9g)pI-g4AuFw7d*te`gZp(Xq zXK%Sai(`sK9S_wv^gKIw=)lV(7EW^;=UnF2{B!US=aVaa^`-Y19``!xZkQl2<>w#H z)1tA=tA4)|Uc~!n)55baH!M;9uzk1m=UZ*NZyj^_azK2)cjY;eebcL=zg&%|pO?bK zzU#(G```PP{dk$VTqsf`^NRTa3lpWDoOxp0wai@FsUQ9>7i=!sDJ$2u(dtv+`qO_* zu4O!z|Jd*PR+{61a9aL^`sK2jPJyuSGKRnQNQBOIjl(3guul%n3s(p_hE~%Qc|Hq7o zrQNaL4y{hT8}9cvX|=;WL)Ys$*Qcy#>`&`j72NM};`Y7=7RBuwAKQGgdnxv({+aIo zP2Y^;E0@05wQo)ICXG3hk2RV*u5IRaoPF-_5GhL~P<%-e#SdLp~4N6>d zn{CeA-<)~)MdPHJ1%(ghF6UJj(TdtE(>P^E4MXhng-u!w$ER>8sGqRlly1NF;(>py zX~8t6$@Nlu5=vV%e_PMKW{_BX|915I;IgBV_62#@ci!5>wEgy(>%X`@MV*q#_;qel z^UT!!+cnjMSAUsw<^IY2c_BJR!siQru1kvVa|%7cbw%Tk>Y~B}dMxg;xq&}hgX4`0 z{QfQ9Hb4F%?^M->Ln-b0;e5h=nq}pW3YxB85!+hxu$^Om{jSUk7Rk$fpRA9_9sRl0 z_<~19sue(&0^IX&=E#Xw|*GEL}=db;#eWq=)PTj3|$3l5O zHRpe_etNq;uPnSiLAl@P^@+^#Ns{wtob#XZKy|D2C*#8oaW4+49C~ra@lUO2x$2^d zPmAYYVYy&;JF7EaWj%{{%!eGW zmDlouxwQ7aQH}7IsW~sOaZa+Xe6c~?B~eR`zecC7hV}#r9=qtY?4y%Rg2eR8OJc%3 z1>-cb*S%;9T>Xh*wf_?JP~}Y(Zub^Nh$eESRW=Hl+4d_(FNkM4Q-5Gpebw#yWdGi2 zS!})=4|7?G2avxpV@xw=Fz`9bC=tE3DUnXcem=K8QC{h zsovi$^Sfl_#{)A(gFDS8o91+fFg2HGD9to7$`3m-p+n=UG|MI#HMupJdmnOLWd16m zyE|*c*(DkOmadTBJb6jv?klJ2>y{s?U)ES8W_&$?^^3~`?p7Y>+ZT4f3)&`k<9F%n zNvqrD#hQLe<6Su=%DDfm*4*;`O>Z*$xy4(bZ45nnk?XyF%T?iX#kVhKglV0dR^iSt z^@z`2#?Xt0JT_0c-g|DHYm;%chQH}|#-B(s#+M8Gs za@xhb0-d_56jB3pVo(d3GIPII7FON>P0W9QIN|?dpR?$P-G>ecXEn8)dwlqifm7OkdH%BMi3$=qD^IHYxR!Xb zN<2B;D%xm?b@J@D*8)rkp@ugs}Dtksbt^K&JC+Sd%}^;)c@ z6HlI6EE8ocl`x~B>&lHE4*Kp-``YT2)~|Q3^31CA6Yc+2E&Q2Foy%3m|JjAP$1hjL zY@Ho)BIOk0k#vKDWq%!gI*<4tU0UY2W}8On^b+A{?j5Or^>d=$_u5H&pUf4J$~s`J z<-y6Q7r%a)qK{ABr$;NpFWhOL9>rrb+;}5)pxV%{={8z>n2uYzEfR&cJJEo zXZ5%3=3kF)vJ8K-Z8F=gr$;tbAN@4HQA`&>C1OaEsycNtsu1bH88K zr><+mjSYv*y^dUbB)RkT>)N}Qev9q)6nG=dChPoks*66qOZ?-V0+X$aX6#E^xZ63z zx%T6w|F5&Md=E|&KU&zHBYOS4&WhsYrGdfX65oH-zd9_bC91#gLJ_n3%?J}$7D%?AxLvv4r?2IzIdQjhf z??Y8Btzg@&%XI742djSy`5Aj(`=j!uU;HoYW_>*DpEcj=p-?t=)xW$}Ycc+}a>*0< z{u_!tn^0h--q{dtw8docpYKQ88hZ;RnZ6fw-)b+u*Z1|ugGt7^OCn1ib?+(tfAQe{ zZ}P&+{@shU+uNQf(z7IdasBW6*Ynel)}#k7oEjchcYM;snfErfY^v9f%s#%xoVD!8 z(Vz8Fo=;v0_lNyj6r8D38r#>QvT;h9_=rkP8IE4zEX(OD`~d#hlwe|2D2_Cedll9 zBe`p9xvk&BCEwjLZm?wt8Vlv9%D=yG`AXhgW0#*Rl%}jJI_y@pyLOK)_vFLZJs3RN z8SiY-6liL+3{rh|hHWDQ>!CS}-}l!0O5WLql@=6?F1zy8y+S*ow^?ybLX`f}Te)#vsv zeS7-#{P=qA$!eE9XKrXI-g&FQdrC;%HGSKqVcO1X7WM@Q^S+;?A=R-$Jt@mdM*Y@0 zGvQU`As27#nN*TJzui5HUIuPjfo59Tf0{tC}jDj z6>cB<*Z9Tdb18ytMsos={p~R~jEqQX=<}S^@ImIL*|B|$6HnIlrnahRAM04gWNEzj zz|I%q_K(vJKhS?s>2&MJk#(L)PhH;3Utnu_`QFa@6^_Tk>^!eI3A3&*PCRe%C`>r( zOw6s@uX`UA{@bC(bAo4L=a(b(eXEZ}UDJPTzp+td;hlM>y;paCx^?_Yvq()qUQW-w zdor$u2G&(8=CgcR;}{Zr_66(Vp3bW+S&#J6v!9rVf9a(&_F ziC%NNKb-me)*&Q;%_HIj!w2=%r@vp1S$p|e)TOW8H>#$n`slBDtz*`8@%{N{C)Ur5 zs(+JOPlt*x3re^zR!4U)#6u43Lf?QdQ?w8?Y?OB zt}E|7yU*Xp+wwNu`8?%n=KG1+#-8_D|D`b=dzU6Xg8-MlXS*|WNX`Tw4VuRpY0DYr9R zu6>Tyq?C1g2d3uc#B3QyxT+amFvr{b$f=H%T9W(t-ZOGA_!9{K4WMx@Sql} zo9Jqh?;AyXyZRLJ=co#8a?F`D_i2CYTQAF&j`f#~tfw-F$wzW$yeu^Md0oPNPSK&B z`p9L@9*G4> z3s!!bvi)L9GV6k62QTNp+I8l#mR0zIIcp!}|IDq@+I`gLA}gcB#FBtJwhiBJs5E97 zdd@aIDk!VFi-ot&Xx5R}dy5kiuYWcCp|+%H;o72lM#+CmU+lFj5>FKnH*q%Njol;e z7<~Wx4D$yv?9a>dH2lravd^wx^5Dz$U8+@-zhuJE6jm8LUy|2Xzr`i=yU78PUv=DU;AxhdcJzx=Md@}K|s`d9bQzUQ6$%>BKy(#3=eM@^%*|69t> z6!5~z{n)mPCsj5p#wJxq%QVGr-FG-PaN57ibGPf}_|$f9=ef_4P`}!{`_#@U&lS3k zw?0!i`Q)W#y>P>HgBB*SS#3WB_6bZed3o-r%Ir1LAMUVOy!?~h&;IZ|=ON)`R@qI5 zougSh?Yn$^nCeWgSbtqA|dU$}O~rcYbmipPa8K6@Z{?$Z4`O|4;!``dFb9@uPa`J^>v=6$b2j51M&&TIVK@^TO70c$k|6^?7I%skgv zg)YP~<<6+#vAU6Nplffd*K;mh~Mh>s5TW4g{u(Ytx3J6ya_S@wkB%oR+E!L=cs^P06?<1bmEgo4jirW`iJzaR! z`fw5FV~-h{bJ-qd$_Rg`x_o8j_J|6`v+LQn)dtJj?X+AN9VUOkqxinWF%Cnyec!Cx z7QWAY@!Chg?*E6ot3R;HYE?}AFOqR!x}OC1hkALn9~TO(f>L@TW6f_bYU@q5S4 z^dB(`O`dfnOHNoF$A5HNz3=U9=ep(z-_7sWxSJixo45FR-r{=ai}i-ZkEgBLaNgq% zbGBd5GJlQBD+Pi|Ar+tm)DuGfyGHM}_Su(z`_jCJzs!&~IHaOB*) z9{pd`DCYJ5rT-qL+`f~)t^TKAx8C%wh37Z2WtOqd(hl0oyRY^3>$7@qHvi{1_oM9W zkvq2c*VTWk-Bl~ac6;H+WvL%G&X<0?@$o{Z=KcJ=-;dw9oNRM&n&zPnl@^A*2C=;n z$1NoiBm#D>c)ivVx7=*O-Ysug1w^OJI@PHzV9fAb)O|Z&#Zevp zgDYP}{eO4J;ydU4+HXItbB>2aO0Yh;BO>oKJ?+}kv%7x=+)kRGKfBJ!_RMulumbWdg(LYY~dgIxZbS7IzQvPYW}s-xwmFE50*BarS1}N{)$MpV_xR(fv_m z^zQZU$A?bJy{fTsy|JV7SK@~|A1z!36DQp)Jk|P`cjlSCV7vV#dz9y!OV>Zjk!Jh( zM%8Xc{e^#mPg{%+ZHe79$>zkV@63m}R`k5!^LyV=Ks4mB888ob2~5YHRQe4m>$2`dD9Nrv*+IG$%)wR zTB@(s{XS_iN79);Hd9-j3pJk>beLN6Eot$5?AI}MUhkT#F8u+^oXjuui*7Ei-LSh* zhtIk3iCRc~r&Qn8q>Wt30W;d7_OE8Ld*fYod;Y=w!a=Ub>TfydcO7kFP5Hv|jaBq? zHmBe>_EjIR{)XB&(s)fMT*rNejoVg_hANSKtpT- z1E=9$VX?rwMa!nO@2uxuF28nC?2Uk{e4h-(Hf+~t>~H*EnQ=j-u`$x=i-1(hmkaV5 z1{!BIG<((ca({eDI^}%P%|^dW{A0FNS|$4f;YUGF{!~>yJ#ga2Tbb&QyAG(5+1+~{3CF+*zh`CdcD;Msg9&#ynq;hGqCflp*z+p6|;^+z+9^$v+& zPkQ#XH!x3JbbaN+V!;Z%SeFdtHPRe9QmKo6JpIx7uiwi^CDGfrZzI#S_cqBrqONDI zF6c;J!N3u4tzwt`QHP5=7uVJ$e!ib&yE`>WdAm=G%HL(@oTvMIFq5g}x?G2Cc zzV#Jv)IYVU)m~_IM^=|Avw&h;&?}M;bp-G zdv_LG^zzG>wA?nQ@^OyvzYkvy$<|vRn|0xp4(ERv>HWJK%Q&ySO;Odb5N~?6at+fo z&DYEH7bkE=guV6iwfNp0>R=Eu>4@HrzkW~8KTX_bc(G~m>L=!kf>ni!)Wcu-M^D^m zaq%(dcj0R~^Gh`tKOd@d+`~36=FIMpt>>@p++nK7z?xCN)y7lEU+HZR+l2G=jKaQ+ zkj@kIas?J+BMa!UEl)v<(aePQ{SJR2w(^?O2ep^0Y%R|FnyvIw4gRQjve7wFB}^m8 zJ7`;a{ogWX1xXx7H7XYXqHda8ZVS}3_tD5`9A{I&Qww>RC(-)7@`{qMmY^-ke(=R@yJ_x&p) zwMnI-=>FGdFHWT$zWVEH+vU>Wz4r{Zn$4A8eo#H%tY_Wlvg^8R>wWLdT30?bIr4B! z-GOI$7r%y|Yu$PH;5(m-)AQ`+aL9RFe|qK1vUjKVNVWfX`|S4BX_>pP>I%D@Jd^u1 zUcierOBN=m z%Gx=4ZdY5sCt=~!nD;)>cdef`RB60OXz2);KI!pHg_-BtO6v+%spYMf!Ydm^w-Aeub zW7GNe6=co6{b$>nQ}_0#g>wJTx4yiuj7wr)fXUbT^;16m-MLjj^!82xo|Y*(-}t1& zPFY_pYMo{IW?t8gciV#w&)m#%PEE1v*XHfZR7LgvUD>jOCtD&&`NvIlw(WnvJ!$hv z3p%e7XcN6uMK(Y}ZTVxV^hM_rYHw$p|7o;vhEZB$Pb`1R8_vmBuFp`}?{!8i`qWI_ zZCb&M)5N~XdXs|!*U8| ziSuMu&eFdy>%v3cUnYN^hhDF!-IVn{M0bO5#tZ&yuNL^flgfJhXWiPGx$}3g+wy?N zR^UE=s_BDji_3ZGWpy*`ByQ{u{Lo*a(@}kDZDnE|14q!sujUzBZq{#zS->OQUcmpR z=EA*swag3JvrqozPJjKf@XaC?jkRWHm^f`#NpUlIxG>nyvtBs!&M!-em04WbwI6C8 z2_Kx|8YjMN)9#k2;&*o+->%;6Y2{wJz0svQeWpgc`^gPkQ`Byy2<5hKa;@Xu>)u_wxa7{S*Bk*&?dLqaj{ebM-r)1RIJGJEdC%9Y=OX^=CNagGP7iY0 zz15AcEkq<^%CW6X$MyOv^VjmoMO~fw!9`zFzJzlsuN6;zMQStObj^8eE2jKfys*B4 zzr#>x-)X~;LbhjSW#%W+96S#kGTP$&eai=_A4*wXJkA_9SV~x{Ce#@)o_Witw5R0C z2Y-e|OZQ~(&JkR9h25atewY7-w+BpKo(Dr@V=}=307>ck7;2 zF$-DUpFYm2Sp3cSozCn#+tXgy`&6*|?taFhrI%@>`{v55*vKzw<(5)rx!G6kKVF!? z6KE%5Q}SaLbMo`$!mn@mPpzG@?)^E_cVdpWOl>4qWklV$bbwjt`N7@XpT%Z)Y?$WB#-1Z}r!z`A${YxZHz9*!V6}E#qAupNB zFN(=If73Z41X8wHH=8Vzd!lc$`Gx$Y6~XtOCAg*Cc{Qif$Vq)ceQD!I?|Hro;(`)0 zE=Vw!3T9?5nsmjpJ6>7$Z^sssi4Jy5nZ5I>_Nh%1G>!bHSHG=NB8%(7Z;Qx)tdgnw z6Z+FdR^?nx`ozs`U-y?s&hYL0opU6%{9)tq4SukC!IlLRnLg~@Z$EXK16K*-@?cie zE7$ot(+&l^|9Em=X4$*eZ#}>C_jGS@mN|Dk`g+Kdx*O5=*_oZzh_^3$*=Cl#!b0Sn z$aif8jf0bSUfkDp)OiI*{iBl=9{aYRSSdI4Wrf>2U5)s1_XfQSRnadUSG3zmO54aFR3s+F$}8?lIPTm&XUX4hO#WAMM87!cG8WV|OHS0tYW%+B z)7)oGO0Oy}@NT@}bxTV?#K2_J%@9Y&;C=}W*J~3TU(9^fx;yq({sBAtn;P{Tk#~5E zS+*BXcehBtytm^VOM=tS`>a+M;#+4hCw=U8`OYr4=JUO|g^LWnu`Nk-Q>tQC``;_x_|1nm z%w(~1=h=))ofmo^yZlITdKlsER4Fc9$Y#_s;f8^O%aJ9izjxFw752O1l<|M}?du;1Q1VgF>)HE? z*Sdemsh0@9yZhDqit~v-Z|>duDdWymcCLGjhm6x|g?6ZgGhF}j!Gz)ZCcz04*em%= zeyv+N$Hgn+)M1JC<;kDqr-e?vyCK0_Z{q_OX6@(?fi-N8CYRLB-CSMw_LJ!{x8ub} zb53XnzvKVA*gBviTWc4y|4GAl5f`q#OX(6if7B>(7M}-4ef}=V+@DjJohs`@d&OCH zY}Wbf{3lEM$BeoiPHHiNhC3y+Cly_nmz&D*A$r%Gi}IT9vI2fQJ-57O%GBn$$HXe9 zG-USdy%8)Rn||^0ZJ7hR zT7~VaZq+RNzjXduW7eGp_g{(MPCl8Lt9)$pc2x_B@_6_5Ze5)xS8JcYW71^$yYObI z^8;(%&8d@w+6wL1<4@l6ye7AO(WADGHufVA{KdbU&d|*L_;_N4QsYpF!-!Y3e51EbP)+R!-!@~T$c zj9q%BTW9IN*?SF_GWS2b&Uw)KpVdMCOS`}Sb=a|Blfh%|iMxwu_hjugZ2SIyhR?^! zdL1*nwU-nczQyhTq`BS5dsmP0oo9CwZa4>LNOiABd>!z*c4A(~O*sZx9`B=HJ-%}- z&K959D)7u)wkGgF;rpNU8xHQV-hOx+`+q~0u!kO}6|}ZxtYe+nS;MrpLF!>Tb%1NF!;6ziu~(xeUSMW$(3~V)#NWpE*C3?9IzT$9Lc=Y&;vA#jvX;Nq zOCu}4mCQ3O6IBbbs(Es4*11{B?#{e_Na7EB(?+XTc}E&JjCP%1wm4e5@n*f3VT$>T zFI~M$-%Szcd$u4+^#qGdN&cRXa?dO!TW1kr1YB*MEeBZ_J z`P>ERS7qlvy#KDajC+4ZklTs}hx_*bvDx}}m9~ZdZ%r1x>l@c+I_tShL>pCD_#XMh zv)r}S+?r{+T+FSQh$)w>_T19cHD-2Yu74h|MKRx&tJ~`Ojf;Uf7Q&rf9(SH zZ~u2szhD3Vu>ZdF_x}nX7_C3`pKrU=g|>g3@7W@^{i{4IA$?wmZJ+61>Es&sXUA9l zbxDe9-JQc;uJklUYb|4Zxrylq){yr;?BCOZ&XlshDi`~A>eSUctV(A#82`6yzP$cj ztgQL%oO!cOePqb^kgmSeSvbLzFJQsLjnw@@sJ#+W%sr+Uio1v^S9ef*s<@Ae(*o2vljEq66^R((Cy(d53!MpGL`VYEgSEHPR z-k;T+{N~KFtutqpWbqqYUJ%M%9VWJSiOJr%@%tGZUp)*ve$%taBUDdJo`JLJ0DD8- z-wzLM@6UOoz0ETB#NAov+mm(s%UQoAC#L58<>EcjeRs0a>Yxik+=_L}`-(Dt zOLKwu~ zq@%*M=)|rtQ{Jyq=NZ^lSBk$dvg}wwd>}#Sf;*LDwaRgU$&g% z$G0Uc83#3Ac3hYyduqbQ%=sTr^?upq^z7N9Z!6edU3(>*yeQaAXYC!v8$n-In+PqD z^Ig8D-tc=($;n&6BE?-gUI_<+zpUOaGquL#0h{aD(`$bj7BMsn=Op_{XVp}E&-#2( z@Iw)!!-1|}+TCxrpMCk}3zN(Ik7{#Y2grwXdHuX|rHf7Pmc?Sm&+Aq(mOMS4%b&Hm zHu&T<{u8IS=I**2zPt9&&#-SMZ*uz%p7MQK`Eb=7*%YPvM|)zlHeZ#sTKHM(c1+u~ z`+VO%maWOp>W`Ny3*B3u>^c8?eckKy)aak0i%P$olI3}S*(7O=0_P@;z9V`4dAt6e zz7Ws;{&5D^+D+NwENqGkjweSw{Joi}v(j@%(mE;E7k(xsM!vZ#H3PTa2#{@x^quRk zle*Q)%B7H@xtYCmTD>)+!{rQS7MU$NGZfxF+GD-x_QmyoGiL4MPm-DU;&)D@DdWP* zsOEJ$SW2HL9}3y^SEu*yf(O5R>xI`(v%1NC?daF44#7gVaEa$7Y%&V0>vws`i9VGu zHi3mQ`8g8~UPxdyy!hgp{!0h0<WGTC)(^A@|zLhH))_N%4&?X&vpMdwRfpV;>E`01NG#|jG7XLla7c%<@w{>e1H zsO?^5|G&<0E&so=N0oWyvW6EEitbMQSrXnH`d%h$-J0o31Xb=eUi!($ByB0N%}Gmy zp*(ealY5W7b=I~s`!-5u)Jguj#~OLgvH#I&2Qx+!@5!PQdZ*pnr~baR#@6enc;z2{ zuh{zOeEI)n`{i>V^skU>)tt`#aG_DGD=9%!hYrIOIL@X^tf`lyqy{m#5{%?Q6_&KIZEaR2dz zDly;tn!dBbUGA-3kybF%WA$3D#+olL#6L}bDt*+$Hk2{`;(>>mr~WQoXwqA7NSr+^ z(ev74+cPiUM$WDatM^uyqG9a*HPw>y#l#-5 zb!YeQl68?XoL9OdZhwaLsl11CPG9PfVJ*=0&zCuR-FwlAJ)agZibV$3zmD9f(p9oG zLM!-6PIAXubLa5ZQ$oMaJ=<6qWygE4BXiB7)L6T|BnL$wwU<8pZc_|zE!eJ_aC-lD z?}KHHnbLT=M^=07(8y#jKNT@S{Xn_R-F@v75>$3_`2?(KIdA$-B;bnaQm$S4spS_Pqb9(pXfL$F8`?nuA)(Uy@@L!7h z?d5eo-@ETvUbIP;n(E1W$l&si1zgHY+HR;Cc)4ruwF2ugR z$zMP3^z}*eK5Up}-^CMK+>@Q2`O5z8qJx`blzSiPL^d7hI{rLZtnc){x7S|J*VS%F z?RhI$CI7RG$tcad^3~yW1*N5DChJ=2{CmOnSiS#a>N>eQpM}miD{M4*(A#lh# zR5SY^PkrrVeTme1M(x^w%Ct+Koa-jtsa5t$_j^Q{@nRFA`pfGwQdT5Me^Jm{Uc2=7i-Xgu)-F?!dJ#Iq;oP#_4@Cxv8(5s+@_uF$CsQDcj&#bA&t*<%APrw*8I6`q|KYhmDBfAa7l8+ zoQ-$#y}guZvwYF z4ZC#`D%4LLJm;vqaXIIUix&?+z8SwiR3|7a(`06$jLwGcy<0R^{m{4;9v`}K|L%Vu z;@;%_7OyGa{djlz<Xl8~R)1c0;dgV0jl{8ICfk3_h(3!jDGWO#JKpLMXAIc~wtd%FRnwzOSu{RzC_9f4BGY-w0mYdS~81RY4=s)Fqdq zYwvK&JyCFI|0sF<+0_-*Rp+hCy^gMYTl&~<&C>K-so>f5mYsDvety%gG+mo38595b zSV->sW!tnK3%MGWRc;j5+HwE5)&}XhYxW3hMmQR3s^U3y^~k2s$2W< zZSw1`fK4tbby1JS;uL-=Z0b0g>Gmv0>EJ=!fyY7n7>aJ6QD<9H>{;)P0ow`m%?-2D67zp3q&HHOuAh{1dZ!nWum0!8bYA zgZ{H8NnI{rU2)ob@$7}m!-H5<-hG%5UG?&7z2$qIu1uCkQ>EbD#A_g%8H zjo!bL->71;_s3~pk&PC8YC#tB=g$a;P2%gXO!ng7HJbIIIQ>-OWGAPClPo?aiD^%q z(0Fd5?#9siEuyl4+rv-PwX1YDn=EBq&u5CfC1v&74BG9On)uo0ItCTYH%a=9#(4LMZbRi`mB$^OC);wra}+G`sZW>u!Xj;D{`_&Az&G^= z4<74quQOxhRG+gk<84p;IR@T#<;A~!Cp}@<)A{nF#Q|P@Tepq_CRgs7&9Zv)^6=!o zun*iF30wlFDvF{WI+=7me|+KE0^J)6b}i3O(YdoMUT1xjx7DF&zF%IC9h`T^YTR^` zOWar{xv4$a?nl6WmiJ2aCGr{~@+uoX%X8nKyU+0KVn!RkgKCdXGT0?PYhEUkBfIZz z;;j$0pFI7RH+tk&wOe+17q)4BTg<8$koU%`NTJQ*@81u4!VJaRiq8K(UhZ(?<4K0~ z^Th8bA8nbV_OF#kdie}~{z~_a;`jSwqm#8ahqdwLr)Er=YWUW#MvZ@ONB#8u3iqn3 zj%RR*U5tJ2u32Y%x#{iZjZ)HP0bfp7JJL6 zUj548#V;RDu}MpH3*>g)yv(}j5kHs9l5;B^LW&t8R_|Oov-dK$;erbv^6qWWTc~{N zhJoRA$)Zbl!qenszkZr~qx8i78$TFA{u&CLoV3TDZU4Ss#@dE=K5o7JK`eLK9M{A@ zHAeOI{+U}Bzdil9;!N3UEuO{hQ*0bBH_QxB`=4#H_8+s(-#bP+eTuAeM0OnFQEoO7 z({!IcY^{$-K{#JUfCEQ%{qJmAniEV6QhAC?~SN(y{{=14dE#I?HY}ru(AFrz2 zAw3WMjE~z`%;$HFcH>DsRbkY8^oea{ie1m#dq#dzh9|{;YUlcxmly?9H1w;#p7L?~ z#Rkb4t5>?p$e8Lf>N|9aWxng)t8M(wt$Wgy8Cf0^{+zt9yFMx5Z>EdVk<*I~+jk2e z2si)oaa;CrV^P@Y@`tgiMdGm1M;6;QiKze8lWr8>o_#POW*N&# z_Q!{=RDR7lSJQOPXT-=rSK~)^LvFiJIcAP@Y!4+yX@MPRX(|G z)BnBNv1)_K?kjA^W5eEheR<@wj0vo`tO`e-ESJgdn_*f?n>OKG&!86TaB z1=SS?q+Tj*;nK*fFj{=&R7dKL^v*dG{)JCsP}*rC>wV>kP5$<4oso0agh$3c+3@q1 z*yKpP=GAQ_Opk85+kMPi7F~Ja-KBb~idzfMXCz+P@WD*rSPIXgJo_6eInKNd60`GX z%3oFf7i()Y?c~c@E$coVTlGbTr>%SOQbtE>9;u2(7Dgw=eOwwDu{%QkO|xPSo@LwS zWidyi>tVq!##eFDWx}Tp2Uf|(Ty1-=x0SC^Jz27T@vRFz&nrUvzvZ(=+;uyjQ~0%` ze%Bp~)QeHyG7bsw<<)Ysc{;b}39!%i-6yFg>b+@w*QBPUpM5v+o}A>g>BOW5>x>UK zm>2Wz-T(i1{}!7YOQgK-25Jc z=3kMlvRHkOVbG)1XLrV^?woTt?0`tckE+eWSN_*;+bYV@`0BQ-SL)vz3dl{$<%f0e}tepapMv`omAdi~+wG%@LE zzgBAbw(g$l@pBUIOMkYzKVl!(vwE~-TJdk#sc@!X*3qs!ogUSTSN^(N=<9rVf6(ds z-x9uWGj|IdiBy%+KlCP8k~{YJ%v*nrcX?e?5nuNte8SGlJzjb#bvx=l=G)G`vm4xY zVm2}~0-w;wY-(sU-SGsYM*Y*M$oxANLUrHQzt|qiY}nquLOFl)mHP(1-V|TI;~)D5U%#7|uBx`{tLa>Sy?4{+vfR+E*?Nnk z@7}qw?3=-hZG|=4U)e6*6Ue=K#&)#Cwz9MV5yBd9Lwh zMZf522R~1h-nDbyTTVa7abtRfp<9ur9(do)_zuO#FGmYxmJ6W_LH0^OLTsHc##=w*Inwo8*<{4|mR1 z^h-aYDOhyp;GvW4f9`&0_}ibllFxbL$J@WM&t`;#xL>u85Ax9SIP|A!_O`VmbDm#{ zDq9fgb?aii{*`qMyyvDx-U&bD>2v&WPWkSms&`f-SnG$xm)*MYcF`YCAB(fL&#zlg zaC?$4b=USOrj_2W>pZuqH23;$GWA{^ajCzO?M;%|ttF}d=6S7}z1B+O$7P-mCv)02 zYpb8rSTJ*%Yi*!4+uvCG6}K*>K6JUa5dRfI=uS@b7cH6$zHerW;$KxJQoEnmHK$fd-G1? z+shyBTN|~R<&0nh|JjRm+jiG4ojiS#f#JM8*2}N!PvcQwyK~OnUUAxM|J+!4=^2lG zcxLt7Jox_FBEKT%xhd?VR!Qv?M(hIv7KBg>jt8CUaVwh^< zpBDY+@dnnldtY5SzBudD(O#o-p0iTwlsZaZbk>*NpZ>V1Onq0_X4|Q`sc-ic|9-_D zaXzc{IgiBoHHYR-WGr~A|I?4Zxv1Q#>6TI&*QD+%-kq-x%?jtb_PWjZceAua!u%>m zmFj2AoKLU2ESzVZe6C38ljJVP7YZ_;bqaze9TlD+-+s6-LTFxkOP`dQU&W>q1|NR0 zIhJ2^R3@GSC!M2 zoRMGk@q@^@)s7t76CXa=eCKAj;#pT#1{oz42Vvz#Tv=w8yvUa7pPSz@)5mkO|?#pmx?;al&x_}GGjYh$n9U9K_x zDDRYztL@vgtzz$5wmf1;UwDgYy|G9AeD4bkH~yWEIk@V3;JOA!f1L+rmn$xF@nx*A z;$FD-uil+}$+*WiwnP?7$(C1au)ex>smtrhP03}g)0O)q^92sC4(7LTy&a;)B_KF! z`nxl+%<(Uj+BjSscAtvfQQtPVG*Ruio|?dfouOGDY`X3)kePnypAQ?Se16=HR$m6r zmfirDlrwjY3uoRvlDzuwGsO>4Rx=_Wr24+Oep2Vq8tt};Mh4xQKX$jARx!S*s6I(G zev<6D0F^UWgc7Wu%01tF=>AoM;{B6fZ2r8n^!f20)t8SKdhc9x!gJEI^di@e`Ys`Z zhwoLxTLO6XCm64MwD_{cjXxsa_QdgAZ#<(WAHR;{3`?7263gtTU-)-+z3F^8zeBkE z3)6&q&u28eW-w~b)_udjB%p?pzKvp?;x{v*H6YTEJp zz5oAzeEqt9Zr&dil?oOqn-EK{ck5+rweD1=6cjPt5Z7O?Zx?3}zW70*PtwHoET=tB zg{9Vhd{@sLo4b&Ik^Tv{O;^`SMy_u$-kb!*DTTg{m#UNH|2-P z9R5mQkNr!6r#W-|{o-{qDC z{rdj9@7FBZ8kwCoJV+M&DXOt$#_RLmC#HPR++o}Ax_^t^hI-=-R?oQYUNUTY;r4~^ zl*xrh!HWb=h&_2UVV=iHxi;;IT$7K_Ra5?dIHNS9`tQ%B%N^tX>T6T*S+3d ze_79E&P%9k=CYU(KWPr%@${ zug6-v9Fk=c+ivQ}drtqYQ2+9?je>9P)uTQWqLw5XrbRig*DWaJIvo&k_jT^#NIA}6 z@vTodXWXb%`+0a4OHJ%=&UXiW6Gg@MXNM-tOf6sY=DTM`%8&Pdnr`X7HShVd>5}U# z1~rxRGp|0s(&WFS|G~gxcaYdL&$FL7Sve10{&nvXTi8l{Gv~t*CM;Don;D|&cXRID zm+8|JEp|5HQ(TQk!AljFdCOk8JUz1E`qt|7E%({4ItE0F`*!M!&pGRI1$=81U7QoX-d5-xAcV34@Fg>Ows?TaXv z-N7t27q{+CN?$(x#EXRvf4kS6c)QVVPiyW=rng~xb3)3CzkA&mwmCf|;Mn*Mm+=-+n9Jw7&5K7BS( z3z_5jGr68|-JH|!pYqi{dHo^${*>I$zVYqLcYmD!`)QZKc?Qm-!Fk7dlu{?!)L1{7 z@aN?DQ*z>uEovOOFUd}Hj5s?l>YnYD-KvTfDb|v+8;N|gV? zr&4sS&3xh{yQImB>^>!Rtvw(@st(U*q4cm^7Ec+Idb1huD{O(*^%K zui|fxOZ_AGH-4#2l&h~|j>hjEL5ZrVG4384oVK#39~LRqX-hrw^2iZMzD2hVw#gLl z73WD`^<61yhNSDBs8>hoS?-EnRCIYSnlbT2$78MaYnM#pIOt*8!+(!MT-NkK<_cq; z9F=uXg{CcwvPs#}#3$G#sB@}8LDBU~=$Ux0P`wV$zS2!IVim51Cw3`ZWr(;e@H#j{ zHt3RhlF`C|x2n=>`m_YN8y=KyooqaDsh;Hl#hu$u99iN0PI&f=CMn6-qxCU=q@*&} zGJf&icSu8Z@{OxuW}Zvzbk$myOlx|iS^1XL!b3Cc?Z>=h(o zW?vNC`Af@(!}+Dvqh6n-_nf^W+8fd=Q|6{{s;RH?SB~;z*FO2A=c#hWq~fE6Co@82 z#Eo{osNt~CSr;X_S3HPYpk{f&6vq0fds7xjD6EK0Vo+JAK4o>%#VIVkoO`D(;SzT7 z{agSsD+023>BZ+@0dV8u`jOEXK*naISJZIae7j zUp;&F_`%iT)~uSAudPlT?9FK^-^%j;U+K?xIhIj<{(f!G%Tm$!tUQLlkdV7|I4h8HD8o}eDH&Ah^+r~ z?p~eH^9Mg1t}u)~yZ%^r>5^67{~7L^*K_a8zFFL&^Wb|#{s59|;)B5F? zC98Hvv`+$e6@`KKHbW63wI=tJ5~}ad_I@e8BW1?s}`0@!|5#pJy_1{WJP^ zK5NUIGt11P&ew<5SASd7mE^ZLgy&w?p9N>kn6DddTKZ?vEQYI6*P8!bdwbArfxgG4 ziZ3hF!Z*+U-}mhPexG&I=U0Us>Ad>Z%WF&IcBNC(1Wz@cHv6==OXpa4eYAG5rKE0E zh^k1p!r%JPq)l=Q?yWynRakYUiDQGy43DIZ%|R;Clk+Mrs=4cDPhhI|Z=8RB)VzJm^VqDez+o<}$3my+rYj>+6*GC-c@$+rIkg&m7BLmU9!EYLBf+ zXif{ec{9Q!C?Wo^{9=i=0xv;@Fx`t zA{^00)A*Ve@b~b%t%%vaB7V9>k;xR-Z3}g-@Sci0B{pSeV%nTpZh2C?r|}QE@x)^{7e$vcv~&KP zpqErz(Pea^KZ=L1kfB24n?gWTw88`7Hlh5v)iE=*f6V+_x`!cd!s4ZJQ#%i4h500K z&GHXEbuDvJYbf_po9#w#Q<;n+x>c1HXwK3-e0cHo`c)lYXYwg8`;sosDQFTc{E%nK zmAi5oZb4@gcK$is9rAcm!SMo(w=QM|pXRzN-*t9W@tJsv(b0)dc*_RnX*vmK*>_(( z+c?ojPRzyVP~f~~$2WfaqYW#>^|J#fEM8n((Xxcq($1<~Z9Cr;lOLIiJ9v|hd8O-G zTCF}RsMFgTw4+|{#PaWn6(%z$7GFu8!C33RVAiS9D_c(*Pgu2omh5{@2pFZDk zx#FGoOGA#s(B(> zDP{Yb6__MeykT^lZUsbe}YkuPq@uvkhTOO=Q zSrx}@*Di7_Qv7mWe&yyU9kqggcBgfO1g~5x(R|71>6f6h<~X1A&O2_WHsyVb$QHb? zeZt|rb_YdQKXj)==W_-VF74Xgv@juGL-CKM=;7+vcUo=iC6((YDIU*QeB}2m#pc%M zQ~pnxmAKeD*u-Xm_j|RAIV%`cJ(z5+uQ7bRFwNoEw@qw;-E{N&Av6B6HKh{T~K}fa)QjIrR9?|N}cTs5}ssw+Osx9J&^D?pY!o) zl#cCgxxgpZvG>BIgC% zKf{}^_q{i+d&Y}!Z-2H0>l)PBZFn`EQy8pH9c;dTDS5-i;DW!ul-Rwc+BfPad#D|JodCr$WV zyKG5S&xBY1__qYEN&oBl(xanl(N=X;*|Y1z!|TImO?~#S%#PKO!MjB{qW$X!kqL&c zze}EA65hMTs_B8l*KD0*`U*?;t-9Z0=pcKkfA!)6>enwCo-8dm)9w_rX{v}7N7@Xl zV|s_}PS3ob$9{L`_id}fY-K7ZFVD^Y`Yt11^?LSBj}6{j0pbqRz8JeQ@+SX{;`;9B zSHAfDVUGIe{9OAsu0PyK+VyWEy(izqq$DhZqTfeVz@)PZYkq5aq?z*?WtLdcATBA4vxx**& zz6M{J^ZWA7`2R(J%^!pn=he?No+qks`s2pQdDW}6%dFnnmRmjd6BbiHdEjr--ieiR zcja>`9fDkzuABJa;AoGdYjvywpA@Tm>hh2UuNbq`ycwJm%WSL z9qTPOxB7O)&a?Bb-YLe~`o9tIGm(0zYOcKadn(@{Rxg{zzv2&-Kzh z&!z92I1`yaS*7Rm96OJhNiVCEEuLRo{jB2B-n+L>eOpm~NICX>hlOeEe#@=d6Wx6? zcb&UtuBcoT!FsPn>E-nu$x}~e+z$!eJk7JDU;fa9u35r)dl&y)T({)n+W!ykOiYzc zkG17Xijumdo<4JC%fAKHvvy}@u())pROJ+K*IV4Pwr+2e{GgU+O%#oV#^qVN3O=-dpZuRoVR<2m*H4fn@-J@4XIU$=dd-W$zbaP3vj zuIY-O4}^Lik1Z+q?)E-b&$Xs|YTWF-cHw`I8XXKZI+H(_I+_ny2F(x1r9s8yJG(Sc-wmX;E4x?Jb96m+~oPL$tu^RR-b=p`Fh!M&b_-g zb8P>2q_D9q;KJ%X7RC(x30=kw_pb%p*3=Ym@ag;7p3yIDp7_!1Kr~kd>+cWp7xNll zWNi1ix%l`*apwN7MPC}q|JC1JXzp?6<~sKG*0dvEvitW9@J{ot9lz>_!rN}SVM_vvW`@xQJn#(Sw zOZDKlw#M z)PiMm6y|WBkhmiEamuwc?-lL6%ii_<<2$h5^x2oWYgg&D?A7d;d*R9H75^7*-D^JK zyuzHROYus(?S_;Z1RY*zYzQ^&;HCQ}(} zer$JP{aO-|@$L5msd=xHCh9LRwFtIi>*Qyz4{pB}KBrKTU9aKT_O*9Q6)O`iFOhh< z^NRn{tQ`+mN*!jnw2L=xolUx@m0WUg`!&U)X_>2?6cQFaxUn|JR)u|oL*X{LpE=%&%mos2+;x=}uPgm}YHBP zmgd1T!Lz=kxr}ASNtb8Nszx$jb$2m8nKx1X;DR=PkA>E+=LqjF`*m332>)Z&T^m}H z^$Ke*Ed5`wE?Q{s)$|FAUn?9-`olYi%OP|YFI)cEYuEg(9Gfnf%PHjOx2`Ddb!|1@ zasF7aqdifiJ8#3EzMdl3@x~i@40<(WxbcxA92SkecWnY6#;ML zE}lz#Ub?#8bg8iXC({jl)4G@=CSEn$7!>d}Hs)1u_P1rOe|8+Ha(a8e@r(cJ>c+JJ zn@@4F?dSSxYP;%L+RQ)BQ;xf&F#S*1A!yS!^|SthU8fT2kNyw*Yv29qW(i|#*z}{! z9L%Oo1{bz*zhVoII1=Akf6&l>#lPN*&2B79UGE6j?l8}L%Ho~8KHPwZW9BBE@cEWM zPTQ(y-7!|16sPQSV0o*IVaUk|jjByYEB77v7o!B%{P--QoEI!HDnG5xXgXE=fI27j4~6)-Ykhbzx+>H z792_aVvv+|;!x~kHnxi!<&N!Q_22W=Nm^#_Vppy=U-`R|Ureswm_NPeb2-QHU9Cs< zzxQz3%pb~N|Lxe8bMf70w!d#I;M`Njw#)FZ!Qa2xZb#Zndm7yL>Q$I;RlMh3Wq<3I z+}r$pseQ_Cce=T5WPUQM?5OK$?t3f6JNDFNAKp})8OLUttDr2O@HHvi`Lx{HQ^^w| zUY=ZKP>`iyd~m<@7pv>?_v?2T?=F8ClerddZBTnZnS^N7aT@&>eLAN$BP zXSUzM#f{0Et;5&3v#CBv{BpF_Y2MZ8r|19kZutD=Wp$*P?%eOL`E1;N?p0qER)4*F zf3D;IRc~!(#<0jt^lsZ2?#VV)W$jP@B$1Os-jzzr+QJX*-I64^Z;6!iOJ@(B`jpz0 zvpNMAEEl;rzlniiqud6S*(Sp47W{hs_3Cl$E3A(WdWlVPTsTQvt#Y4Mf4KeML*dpl zn1VM+6dkKRUJ=8a5VW>#&#(6XjWgs>Uf%{SIe_nv+v~cl$!~{CHb0j%Jojy6ohiz4G>v1 zXXO?793g$q9S5fTXOj4E+6UY?lQ1&2P%u!)Ps&2M8QItjv=U9T{;JgJqQ_>R-mSk7 zxNeicqoc={6nT`XugnSEwy9Hlx(fTOMLF*RmiPoczF70OZ1HUV6BCY4J$WrnUx?GB zp>F>H{k-~Lf$QG=UY$|8zbov%@BjOE;%Yyx?F}~)ikx!t>f5}jD?)`*m5e@Yi~YOn zU%K^_>(WzKeEl$i|HqPtD_>>i)JMNvH#PSCsddX&#$JDy`AYHqx7=V+le+6>(NgDM zIvze;dp27B!GyFGpJr`eE5)RF%l3_9^6qWgUQ+*byFw!Ke@oZ+UiaruHGg7CiR2;9KO(r*S~hg-L5s|dHSub z{@$)l_Sc-R-uXPM?O*Y)>|1G<`5n^l?TVAz}-!o_vdQ zb?o;^;dVSv0YP89dhjKwp-JE`3)*&jar ze2FnLd1BVyTQ5931hzVV6K|SwZMvbrJ`o3x32qu|=bbJL)6g!N#FXu_M!0Dbi>UiQ zJ2lpsX9MEn@>Mu~^8WMu)qQNgzVi$X&M$M4C++Jv$*;IcI5D7JI!$BR{zQTvVXm2Hgmz>~YR_46JemLDor!{{c*^*$ zrY03O1nk#Wyw?84nlW?MkKl)Mp00@N*joRfxMW+D!(D?ZcFmj4FMeSx+wC?%>3Ku> z@grBB_AQP)_y6jJ{=lN?%_c9N*2c-7)(nfgFxkWRUR=;RR_+77bJ-uQPgI_(CmdA~ z%@$r!nz`8TTJ1^ZWKfiUB=_mpm3~v6 z8GoI3zjZ&pJz;B0fWp$Wu-o>BvV6{eUdLY~eI?5Em4EtnTkGGhebV25Tz^=>#Hsb* zv*f9}a_xr;D{fD@`&aYCw~(%xkL>5aKK(g9rIzPttk!>{HQ@r!bLZ6dZL%-D8gQ@f z|6~69Y?Ayevu8fAzrVNs%<=sv%4h2o{=5I#b`jGD^Pq$v3)P1zCmc#d{l zR8}RHyQA0aNZxd3qw9^W&OZ}hE&s7sRpU>t%sIyM+tLE;t#!LT89XUB-TZ0q>l&wD z)fZzPdAjoF^0PI~ymiH-WLa=X^@?OCi3>&ijr*%RzgJXExZ>i-Gsn9~koA1Rip|cy z7Om#XIGe~X)9vCbd3zk)8>$$Vq*62jPI!krXwE!#4)|uMH zVJS9?Kjb`JGm~kWf%%Mkt;PAa%Rj7}cGx#Ish7W)vx&tgws@AyYEAk00#go`yS=UJ z3uo!AbKH97*EcKH;>TVbNweg(R!m`!ulh61n%}g;Li9 zGq-u2dZ#aL&XZ*MzS6BYJtaYVr*@ms=4Wc9N7ZIbR5_N#87Eu#L7(&9#0d+nE~&B> zWKC%_T(iq!|M`^}kHQ}u{A6QNaI9s0Lf2B&>yH%|b12l8ecdAWxI@@b_}Tpqh04q~ zd2w^L6qo;HR<8ZJ(M6{5{QXCQewQ@k3>O>{f66O-TKa>mpiOU{T!MI>oSGZMs+onp z-U%x9+dXf-o%`v)=|lh7qf(`s)_Y!her;>cwA344BTY{4|o-AAU`l|EqE@w!# z>fPEqU*Jwl=+PywrrtIFyXu{!bK}BH$^LT;9uNIyJo1}SbSRB)%NPEAqKCc(RMlM6 zW18fXxW)bntNIk<*?qrvuUqrF=CbwQjCVWtt~em%aMX62edyU~QP$@wc%Nq-`4!T? zj5}`G`~GUaeI^gB$_x%GRF&}@E9RM1FWVfsc-!KG=Vx2%>3rAdlg)hK(8&4hM5}Is zOx4#+l{4kPcdtu%Zt`2a==eeozAlS!wi0e`?fd=rB<8*RaUqpE~{k;(xy?@t&w(f0N2R>h%yGAVX&GvKCS8?Td9{4;rKCj|rr?1KzqkBP5 z`)1TnJo8J_-cYff@9?*2aq~{_>P9-fRuDa4amY5LN9FH~stBJ$HhX99diLljSB~@5 z)6chT^*UqmE8tzeMyzN~3u*m&Cu)UH9*2hvw7D(!fuhRR_CL^y;~8PP(eX@%@nF-c_r2ud{l0 za^{&8AJ*ob>NAn8)wA(=w3qX~@o^`$`X_PkBm0YYeeOH1!Ri@tM3XV$^$A7qknBD2 zhj{e7(wd|T{ym9Xo}ZGyt|@fjeDaFvrBZ*M9pLm$7nyiwM(TkBTb3tw9*SV^VOeGo zawh12ZJX7B7rAx1_1E=Q8gN%$){b45@@_Y)@%82B`HCwq2~A$~)2*ot947ez>CkUryDM3w`%9 zd>y8H96gt%vRCJaVN#U*Q{L&45y7)JulXLRIOF1L_u5WztJr(JhWd|Ecr(9kvo^AR zaCf6}TG%O6=9V)l4?k zC!KW7+qg1T=5@`#pxj&6_}zom9b1@vSUy^OTl`9Qnb%dt7co->i};%3gKu(*s-EE4 z`j(k5L+`hd-;D?NcN?)YoT}WIq_?xk)}iXvik8UZD|^-m{`)0d5WMd6U*1yZ6{pPV zgXM1&9++z-elj+$e~0h8j_H$G8EocRF6|5G>d**n?C03pIajG+k@L)JA5ScbXU_Nj zCBUb7;Nwr_Q$k03oWI9b+kDycw(mgg{LIZPLOe|`ZrjR7JgI%@!Jxi5*M3^>cK1DZ zn$6Ev^6PE;^W?_wFvYeb9xJQ20jp=XYCJe)E~Q+;lt^T=*pTaoVmw_s>nA%fYa5y|>%EUneD#&6PwS zw-?&ZcP;&0IpIdw-$lEwre8nx@y}PO*a?3hNeG^@oZ=Dks`Pt|{O^bl<&`heJ}+xv zvUuqD$EEFU#LP59!t`susCwNtn4x?%V8>)eMtnuYwb*12(? zwp^K@l-_21KW2;myZS$lZ_ZuboKk*Ib@%?=_w(P+-&-+vsrAGop+TK@|7M1th@BWx zIO)*k!tcdXj%Vt;`=;bM>BZXu^+_+B>u=A0|INsI(MP{26X!kKnD@J~s&ad{f$iC- z%SR@L#kTpGdx!Ubsi=AL+WWRo`Tt%2*=6SC^ZS=obNV}7y!oA9>RzCc6>qHhos&Ah zJkpsncbt2B!T-mCMYsGe-?6!n|2g1$`n^Xs*N(GZv;8D=E6TO^UAnE`o|h+QPrc}D z8`rk4J~!iS$EJIoCpx^BJT|hLmi24qEpCtO9o>N*Q@mDKcxz93wVeI#WUUtx5^H=8 zINL_8N}Rv-2G8F+-%fAvQE-~)dcM-|uf)>ZOY`F|=HIT)mI_#u_e@Om>qEa3LHW;& zoL_HTYwy#%yfv@lhEcGuZQokkgorfdnVT2S)p+HxZvv-|y?tPE$ zh{m3sRDO&oE_Y_sB9uMqL{54%=;$FKZ@fAvo zy^nRKNxJX2F~N#e!F%5HvdwAPx&KzK?3sMz<)h@=rCWYB^6%t%Vf)0%y3J=bBpX><O<=fB(Ic zvA18(nwc5cV?EQQ`qD%%#?(_+u3s#zSKwVJm*ToZU3B+8pM!I5Z=Bnikt3e*UM7j@ zT)_#DJZbT?)8EtsZytNjy8ARyl|$u)8Apm%Z>8C;=i6SN!N6nQ6zeZ z)mY+kpVqFbT@xe4!Wo?B<@p`1FicYG5}Dlaa?69Vs%tKDdn796Ob873H;zj4;9l@c z$G^V*czH z&Ry2WUzL0LeWKM?3lSb+ z^OiSFttGqW@ns+5ln~1T z-Z9~lp?u{d>3A{jr)Qq%E5@C+(4BKRF=y3rPNp|2ZQILq&Ro#@pY5S0la|N1P-DZs z)-xMz3@6EbmEjo$0t{&&R;#kD-1aB19jos#mY!{(61OuIG`D zKY!Rg;|(7t|2I}Gt&S*ZoyNv@zCxl-E@v`|(x*%iYmQQUAJwz^)nos|KkPEX7j<+W zsuZ2`B}u}W-N8v=(wDUV+6$WO_Q@S{Yd32b&~#Ka?|gP#Y{`=<27_-0{hwTON(tSv zS}|zyz5|c?a=)p4zaOl}|4_Mp-Kqb!f4?ht&QAz83Y+@l*B|+BRyUXqoO91Ye|o&`5wBD%m!Q~{ zJC44MC)on)JU6AR&3fo5AiH3}d;zBwZO490Nz;2ezv3eE`%AZ1`&n-HmdyCzv+q;A zi1+vZI=V^|9r@EP2Cr>wy>ouzM5P}(Gj2_r@L|WZ8y^}jNo;Ns_d8~u$?IWo{qLDa zPmKby^ZIXyas7D19;C29nSG&>_M;-!Uk;wNljmr9+zZd(JapcUmElzWq}*FK51cR8 ziLoeadbpxSSR-WJqI|#2JJ;MvW2)S#x$fo7aL0N^zfH%yqY5vmJvnrzBO>jTL*$9l z(`V04d6xFz*}5}LyXPF*FT=S#Ado%xEtiETeznGx!>({)@ItTvWu?lvt zsm;2?R+?L$dg*gX^O0JHLpjOMH?Q2{weU#Mj;gDC&$6EU$+_|0=hHNit5xB4`&M%$ z)oK3cZ&`lgD|@|JMO{;s-~D5H>;5*sm95vjb9{fPF~8c=2dhgYr^&Nw6==__Q{w%bGDaDN+$2J2e!S26S==Ni$oMxPL{mioVw>&!ouIr4Cm~2tk(-#m7Ck&{^hU_ z^O`3cwN-=Oc`^1Xt$!IN-8PqFo7Vx8ds+9gQiXFuHX3G34d137THw!BXW!&}#w}@v zTeZ8AVL(K6JJ)m{InSI=X>WD~{#aLgT-%~}#zHUY<#UcTzKVKp!=BDwb+2K|6nCYV zZ!@~f-&Dm2^p_gnw|L2)A75X*%ZzWj{?nC-{qvf7KO}74vvT*blhT`FB(!^YZkv7o z&b(-XP=Mu^FWL5;4jBYQG)BkxLWw z1laia&oT-at*Fm9QH#+$QFJFIA&vn=tSG zC%(7M|C*-N1rfJPO4GLY9=z{myZ7Ab&lje}Nk7uI>aAQ8#%8hiQt{!+n_mocWPk5w z%sP4Zk9zz~y;6U9&d)krhZ}TO?P&Tax9ZKJHP`x=eEMFa()y(D#g(_ts<-p*U#}Ar zz0KrOQ2$YRjWy@{+e>$R^jLU9G-1)ZWsPp^yVqXscrb6{hpJ;vMdyF0nt8NDANsjQ zVfUPh>R*yod+oQ0-}O(p_`r*?I40(Ma7fWrcH7(o?DIb={CS!-`Q(9#qKjuOUthg9 zGH_zZ!dl-|{mjyQ0ld!~elsm)v-*+xeO}V@wcg38n>hV{)bDYNKX7hVr*Z9lEfx3D zlf7Bak_+A}4prOH-LbJV=0?KeO{xML8D8YO8XGV8dos_y{>nEUou-n_6>}RKa->BU z)j#DlKe1`j<=079B`3>Q6g;Zo`d+6Z6mi*R8@tXMF+R=6gA7|LFaJLf@u{h4A6Mot znUi}{e{8K?TXa~*@>5*Brs&={w;K{QNmtH03*FnK`Bd0UT`73?tQ_gObpn^(uzN0= zb9|cnle9^5x$j3lV^l6b{NMG!TRvlpWwqZAgz!mO{PD?;6HSfroPMzB``N>i3#=n- zJ1wHQ*EmOS)==A$wfV2{8o^0-EACx<;J)T>&{T)JPsLd)V}6Q0IxonY98$lkA+q!{ z@2Rcr!6(G;+6#P$>s_lb)p(02^MqYi8!L=gQ)0qn)?Z6EK%9a-mbE){{N%fyG?F;2u@uzW%lpG%S2|!OquBMVC~I6 z+iJy+zdZZ?dwqFzLh~&T$*GxA^|N^c=V(V5UMM!Td-3!6>6h1cR$UOz`}0lDdoOdB zM{4Wc0u_PzZ6;omt~fDl+AEh|R;ab@aN|7TMDxdo4Q_d^J-)4;Lsn~QN0-fJi)cI3 z$ir`vrn*E1=9LAxW(EnpSiNxm*Z9xg_ZD8Wo@5iW(z$BQvC9{>mkO9SSFPB;I=i-h z-s;-rosIVSOKybSb@kVG4$=&r;#nPG|7CaF{Szg>3nu5S-nq9k*kwYVWF&XW?9>Ud z9SVn@UHsf^7cxC>pOV^%N;&t=g6(=u>IOZQN?X-^zTTMkyzE7@PFkc&O6J9V2XE_n z9e%z4tHqr|*^xQww*FfTB{>DEF6z#*{zbRI>2+m;a}Qumg=N6ZY)!?qUBfrb2R@Ul>fX@?ctrWCyA!_ zPB7(VEcR3Ubma7_EA#Z`Mn3%hxZtIf+j)b>t>PCWTP)72 zzR3D!c&@g7(`IX%bN4v~+n=!9Gm2aDbgqZ%gbs~h`SK-p*OclTC(oVzr|nD_Q<)^| z+rVRyQx4wI(^S@+`9!Bln&l>k;1n(6CivQ}df#4#|D5?jg7(%OFYHqW?m z;%vu69`^lzelTTBT`K+{;aUCn6Z0ps7KpoN&aABr*yHTD=aWi>=;8-07W(shd(Jt; zM~ZKl_K5u{@1#cV+Wb4eZupc%TSwNPKd0^yHIp&(e2c&6>J>WP=O6y>cRT;tV5`4# z+Tz#WLQ3b$>CNX%<2=Gv{=~jdsyRUCp~M&Ay?H&}=YPCPSh%leaoM${HT;uY>RU_9 z>nm1y|GT-fYswkjAHTP~e!-D!Ea2wH{K@x>`Iavs_63u^FuQfvNwAzvRq;=3FmXL> z(W^Z3$i5k3|9Lh#9OXR1G_{HAT_@D{iqh}5AT;ezhio@dY+$>*vL4=(ju%> zRyfEoQzcqN;a}eppExO}d(N|_rc>}+LEaCao|%{#n*qL0#M53!BUrQUgN zJ(ZF@zka%>yq;`tul(_?b#m>`l5VtzPo8kF_)0eKwqhAWom=zfiQ1lf{DDDXa{jjs z1*?9^r7%k|n@>_PTo&tCxWZ$~(dR5LOoTo@GMTC45x+K|%i~!1N#RdxUD{l zJ}H0JQh1N6bJF~NZZq*CvK2h%=6>za6xL$hx5(hb%`Fe=w=^*Ae7bjvnz5S?Z!Bx+ z(S1FOW0uWd$eTK4>eA)BJYf}SGu(_y#g?v?%2$*4t+3Z)8q3M7X<9Xmo1z+*sPP_4 znj?MZARO;%W3Y!J-9{B!EF)Nki3Zts@4BEk2@qGwjP=_&!W&pmgS zKCeiL$dDgCp{8Pzy{KAAt( z8s{Hh@snWenJ*qOHORJQ={ui<1$MsfaqokKciY}}f?-&o><*2ke@ysyB)X_|_=zKks>SWF76Pp^83UJ^RTL2 zxY$%YJA*HPdEZRQ7H-#;o5r&h>d&0km_2dA(dpsuo_c(Y*6*@<6s!E-@>X%{3FG~% zC)DdlY1HVl9GEKR$Koi*HSOD;)QhcmURvs82QN(2i)@xWf5cMTTkk}W@tazcw;blK zn;$dGduvv6b;GxUJzDBgKKXvR`Dar?cZ7ba_+wxb#juQU4$7`fPc1eAvXDD_%?}I&+F`=wGETc3A_GP zp0oLQ!Q2LawH2l<(+t*RKMt3ZIPGx0OYUodWqIC3?VIaVxn5c>`Qf)DHe!i4AD57? z$c~+>R2S|%Y?*7qUUYy%E@E0>&oOy)N{{elW7k2S^7NaU%?c6%g|Y~3jWSKU@yvb*yjG41^YNTx!Sy~ z7ju8;xUOWbwMll@E9Ufv&*!pcUG4fh!)H;%(d$ZoEsBkvES_(`e$lF8!9#z$@G4&b^?8AO5Xyua{NwUmEyx<|l!N&Xb+iuH4N#m#t1$cfZHN_0GkN zeO0VSbDXTcHhP5|i7$J7U2XPMx#?eAS8Q3UQ^22l|6J}>L&rNmq9>*|_{`q$sO`k3 z!VYUicBZ5$=K_yCy(IfsD)JeZj@kZolYbUpaJNljyZSTe2>Vi=NRLM*<#$gl{xZY9 z-nWtcT1@c4+lexM7LyjJtzMt}ahjLXiQI)Rj11+T#n^Yh?wL`{c;oK3gXiY8NPC<* z|9gs3@^r76PYzGAn!7s6{LX{Z#vW?xSWe1{`p#b(W6kj{NiA|sMVA?M2Crk`p-!G>wx#yj<+Pm3TnDdTJYr4IG z=K-E=`nP7TRFdAA6Hdlgf~*`tN3Y{Tw6yPv&yMa8cI!%0yOYa=!b>^R+?Sf3G7$`yLx$@Q$u z1)Gja8Cbc-FaK228?SEvqcE~dCCK~nU+?;fj&DK^H@B}kb}a1So0?!pS?4v|a*XwV zy!3Z%Yvl`LA(zzIJ!?q;IbZ zPL;SL8~V&f=0@Q4=gj6NM$;iz&_zzZeN3?Ke*8iAOZMShU?)`@(bd~um(N*!RzLhc-~9vZNk=6-r#^aC z&wMDEF`uV&s%&1@8{d7`kFLD*Fx9%rvTcR6t4;(Ohbb68!MOqrJyk$qY;*4+Ac z_V=4|vp2o7w%(c@Wqsm%WNq}d?T1U=*`1rc>-FYc{2Py|s(NYe&wlx1Qt+&`0-Of> zZy7mG@zH(ydfB_L$Nx?J?cifS!BDWkr2g6(Ta(h6_3YEjmTX@7f7Z~ezQq>-P~pUiZ}ZCQ){oCdT(Ox-+5KHKKge___u1Ai>33o zN>5w!@afaGm8P%0)Nj4~tov+OK!mTfv%{^uWzsL={dbw&@}Db{uuY>e^se>eke5?@ z6_plM*l-w@h)D3IeM&q$^(seDlbE9#&pz`_fzy`VPxlipPYtbHc>8|v^6u8JVo&+R z@4gJX{?6Ls+1hs}R&-zdxy{Dx-S*H2CMKJ#4@sIuyJ@mMwvqAw`+&PX%;*GXRM6#p z^P@e)KFKSW-~E~!R&{>n>1HP34@Zu;><-zrcLl@l&+@Z>%Jil7^2?oB`0%>5<^+Df zthki5W%Ct--6E#3@s(!ndUbDKt-C0%rGmdiV3LFS2Bi%P-ut(kyDeIHSw(2U`OEWP zIV~=|wyQyQ#@*F#bcL5%AKv(K*QfepO|lLyOFEodefBQS-^2aPH(IA8@U`8NDU0(Q zwb=9J&A)e_7mNDjRA+klm8iFa^&AbcTCQ2<%jM3nC%h=J2#s9dot>iJFwaLrsp3;j z$o{<3a{QAF$``e)-&`pFJ55QTB6m&6lJsEC1Fu)kR18gC&i?AUZ|dHyrTb1Xe0)5k zUf<+u+W$+H_qX`nS@E|(CRnpm=x4>A0+avzA0I8t)S7$M|KZ+G1^Z9?h3>zhR-_4kuXy~Zb!)O5^Rbhvj~3kYR(tN( zD!e$@aYNMmTh9`nx9cmIIkvDKU)7ucP-NG=7PmFKFRjV6Fz%jp;@Q4!#t$CsEn9z4 z^5f>j{*|*IetwZA;kS(4vi(iMq{Z)wKjeORtsU`o(^kj-b}QH}$jUmtC@``NI+J75 z$Jjl)>UaKKvyS?2EG@F#U%%c{ao^Y;w_x5px%s{-4e{dB3|4Et=@HfMGy0x6|7)Ip z^)vAw0yDSjY8kpNvY5yHkmDQEg|7>9{M4Rs&RUd|I6rW^h50M7`8_)?q{LpUEY-5{ zjl3OMEM!=7ssh{zgOm6J>q7WAwNO7FGx=2)8RAx_hTP9L|kw;-ew=WUQu7`&F=U6HchS! zd%D=}0qdFWZFII^kZMS<|h@XO+?_Jh(cN%CN}TCj zvuP&`tUu&68CWXp%WhiY5}Gep?Tx*8(0@YAUehOn6F<*6UEd%! ztL?!`?ZmX*Z>8RQuqB+ee!Y{A$zq1bq4a%5Yq>rd&QmwusCDQ@!m1P1nVYT&2sDMN zCvW6#^iF5nG>7;2wZ{zqa(2C2&a``3&xec?k*l7a3zqigd84bSDdgPKI^p}KkFT#U zDX*KFa8`a5N*3*Q?4UHSf7>b~vH?B6flYA%lB zu>QD+F+i?ws@;o){0~>Hs119&?f1-lIq8m$+L@vCoO34^Iy$IFb22KFX8+IOoH^^Z zZAR&;X923(%Z+|WM5!r#e37tj52McS)k}My-;-!oJr>~iu;;JR$BucEjx=AIUgsxq zz{>jjQ32li3u24zfBQIt`(7^jYIX*Wxs zBPVmuS$^^S`h}~R;tr{~FsYZfePMX%n)PRK)ZU#x3Nt46O7nR;)^sQxm*lTfWi(1m z$?dq;{zO_(Pcm&aUzf5w8H{^z`V?5i8p)C zi#biI&PtzBGk9g}LN1=DH|99FK+qy^Pr$`V`6om_v_u?hEaf-KGx(%@_R*QOW{Qg8jh`NTrzSl2^Sc>Tlcl+@!ldZ-^@?j&>3t6xGbSjW z;tE>Fp^N#U7vors8hG)+TGS0=KsP@E<3v*ca2f{(fz9{6b${^ z7MFh8Sh9a}Pwdjy%gp}PRa|yFJAZ50n_at9za6>LzB7@B?b|$6$#;=S#n)!@E`J@I zAJ15?>2YdpcK)$9H|}-Wr2nlrmuV8SK-D=u{o>VGFNCUpFMDt#@MZn$eXXn3v?PbE z6Rx!gt=*~XwZdfArj?sdeOtkFHl$5rUj}bI|5Eo2om_Tmmly8ZRO>#iYF@#WSIJYK z-m;bKK6SKu#4O46?pwNfHfhztZahuT2-C@ zm)xzq`J)OiO7N-q)o<1~(5}77b@9=d(phzB+jpqmZt5-Y`E2)h)tYmBiR{7=yQ;Ku z)GSv@o}IQXGgCkDaPBg8aV@4zGM0DCPd>eKP;u#m$zlDwgRWUx-oNJ5m2vS((e=cJ zc?v%q=N-0ZHF8+;``qK}j^BSTdr{*t(?cr%?hMaXyT~i+ZvTJPQ~ycOBd5;1aP`r9 z{a!J%9?o}vWH@Ebj9b#3tNr)0|J!x#?c3UbHxZi4>gQZp{@Y%w%EwXo+j2qM^kbph zmDKKV#;F=hX_WqB?o5d?g|=@k&A{zjM#Jd=5-eKvpc}$2TL|p?tX(u`Wm3z$X=mp} z$nDO#8YJQ)%6_Byc%YEDpG;1B;=jM!=54d_Gdjb(;*p5wwCJ_(*6+4ISy}Y&o$gHC z+wK+H<~+O^f4%O%P5qZAQ$5mH7W1U1lo^PJZawRq^WiHm|w!0vr9Gy%IiF5?q$L zccb#xLpq)bTJua#&&=KPx%)els`HGl*Q@(Y`?d%attfhVEhn_`+ZwCi8EGmLL(G40 za@Pbt%iS3nW%)DhopfdC)oE+rt_|J3>bb6u`oT+qqoqZ}l1DB!8B^(YJWiWBprw`^Ngv_*KuG<3iV()+&8lRA>5Brm^Dv z?Cqt}yAS^<(|*2jmEF=uEY~*QJsr#xy>`{gR?b9^4!M_knRauE-GVxI_$*|cT$#4q zZoT>3U)L&CT+1ct?zut}KGn?@ zf3+s`_MVg0Pxr)3%@vQ%TGv%Hw>rG1WD`@bm)@ng727gSt=;ycW^ixCw(L(umv262%R9`Qxqp_e>9@vCW!?PUYrT?d zYd?FrhJKzDUkUesBbilqEu7^QW)|2p_dW`57k}`N?`84!yK>y| zMJ9DW*9+`_^qn(){UzQ<=0|Ic>UOqU+so}=RPTSG{qb~F=76`HaVKBq7?|!~;oo`T zn25UHe1U^^+zh1M4f>U5?B?K$PFl?IOt0yuK~ts3L77b_&-Xuw7JcA)SA;9ze%a4u zvs)NlIQ`zuum0r8%XeA+fWhSL3+y}ID?8LbKfCMRlvYvE2E&tO7AtyR#$HNIus-}Y z?tHAo#(OsP$1gwA?ybvp>9v}YqHg!^lo~rx50N_^SZuCuS6>R`lae6wx+XY%t%?g`02)X z>I|DNt^FK%I{em=@U)e?X6~M<#qMY>81gzNudV%aQDK_!>f6C7?X6i;9JejGHfh&M zrYE;Q9O+|zcKyYd9?!~8XKZ)t?7li>I>(%~9{yp=?ua~By8Pwx*Jr7(l6b;0w=<~c zx+NcNZ2Pv+P_XBmF3;(mbJ^0bDlzf@}9jl9Ytc5O2(Nmh~yKY;ULGPw*axa(edlSPW z^($d7*W>Dd$HI{Uj+-Y~#>k5CT+}%wq&U}pUt;1T2i;#K-(_1hnVS399Awr1)IYfs z#3guu>nx+lg6k`C??wc%?=@PcG~rtL-LmJ)o~`}cI_vP9$(Lrx32JaV_MX4o%6vI4 z&}*k#-m}M&E$?qdh+ljiwC2;V#(=^pEO?9uMa#F_$1&;T7X5QhHcg5V8?}?qCf3+ zig;>$-)M5qP-x1%(~hqdLN8xYe9gG#ec`Lry~W~|(>C^%YhOz2oS&jmUC94LJZI_R zci&jHoSwb(Rh;b7g)GxN3WYugXdSniqIUnFv*x0cjJAC5=00E%oa2@wa>eqHo8w+h zGcNtU8yfXKHYeO9R~*{8C;hblB!`H`Q*WMKFF2n&uOssLBP&N!)k8UF4`04>I3w)R z8QZk*e^N$sjF*=ziEwIs)ZVF;%+wY8E4kxU?VR85J6Fmr?b~ACG%vckc++x$Vwub4 zGcry!JYhS!rAs2Z=aQYw5dLF~Q0ridrN8Wzv{#$u}?WL*N z3zl=SUR$wUc;*AsBWm6;OE2~+a_Fw>0O09#=Z}}98(@`KBxCnqFa z_$u6RC~wy$hKO6{+4_z*-Rc9)C!E{%H7#$#qWHVYlV^v#il4XYccz(&p|hBUne6p& zaYgNxnqTZEo(HI#1nHl?7SYK#fx%7te0~Jek?InzVit}m$!(|3luvyfX}sZI+X{20 z&u$6MO^bI=d+=hKsm1HFS0lS`1j;kc3T`rf`|{kLZH>iEGxL?su2{M&BBlOR{pH_> zKDPb2`sKq3_Sm^I)ITfAOjOw~CNi0|QE5`kl}Pi;?ff&GzsIWfKl%93c9DI4+KrnI z*>5YfF4nabR0o^qz ziu}Rv&dgdHIYM zuY9^^QBc`NofUSunXkh1`(AxM*pjyN;DqyFZw{YPoygjf?JH99vflo|KrP zRBI^Vbmfj;-k~qI`d4JfOI=HTH!sO0sH%L{*R<_*_gB7c^gna*aO}ooS~h3YpZ(sM z+`CVs+j>*|t?Bm{JXkTme%^%#%%fWCVKMaYwOB(cdfE`vB~D5cF=-}%iN|i5K1f^;p*A`Xz3`Z+F>dIBAy1{a&(qDc7IdyB2CLHs1d7sr`$YGgld( zbu0XDJ%{7(?^?q*mJ+dBO>D02o&EZD?+5Fu%J{3&obE5yI=7zF534AArnY%kmUV3D zk-%z`$i}$&6KCXocFAz{I9{-gV~=tk1Dj7UIx5TCr-MN^97!gfQbY0RzdU-7TGK^n}&U)l?ng zk(mDQ&!cWmp%kuAi}U>zx1avW$Ss>ETPU>o@r*#RYZs^L`Ro4D*%!D-a`GdWG;NV| zCyxtTTZ%;MI@fL9wdb<$?p1jwHcdLcJb3%=-;0h-m94XuYUf&A-ynaf;>%NphoVcq z+|3Mq%PF#5z2wu+zv7|tsto=|%okTla)`P02kkxkPrrRneyDsa_f_Tzf{(xb%?dCu zO>NL#5q|8Xp@_N9zTm>*Ma~=Fxvjpbey!w)#_q|NUk5O;SDCAq|2;G(Q5}XjnZWjC*EDwb zavy34JG=3+`O?cz?y|j_rB}Uq-oi@_uEA?$UW*-KRy-j)?YUurkxRmAogJUK#r~z_ zmByE)e_!7vjHxPIa8b9#;@1xFI%M0J|3DacH;c_=>9YroyDAMG1Y*K-`x z&2(3f)X+#NTyiYM>D{idNY)!pI*(dboQsjX$1!>7p+@T&k{68n4EHg1tx)*1-kfuX zmGA6TZ>61|Pl&l#w(QgeC-qmXEHfOB6*0EHSZ2Z05?SWjXRw;}q|kh;)xG}>iBFiT|W!F7TE3(kFX`YC;FO^?CEtL@FE zTeqDM4y(WQD4uPhX8#}UWVX15{h}uRCu})tK1aWoaESAEy3S}KuCc21?(%AxYrcN$ zYnDIgn|P!y%QCU5Wa@jnjWJ#)=5ChxA9%51L&7ocHHWS}GHh(oUcRA>=l)F|_cyn~ z*q+TXIdwhq`r_OCo7fDu*qsZ%pn2IiT~g_q=#}q!??1ct)%&I0=lr+fn8uWy1tACb z-kw-xIOnm7PK(YRok)X{3-Z@k#RA`)Ez8tyJbiZ8p6lwzUu--maQ1w(P?!Jhi;pcg zsQzO3`ozMPp*_%bZ+X_#$2=zM(Ua8oY{ng}2Li>~QkB4W-*E!jw7fX2roU@Pj zk(bk1Q1Qb{QF$8M$)`&7dP1DD_uZAU3!C?Ch4JRxvw_J{C)tl~Nq@j;&3-ENu&7yN zf`Dzvv!m%^2}haa&M93ryQWph8GKZ1`?cM>@-yY^f80>7UHhZOMw#K%(#EL5)!ugl zCiV2~m?bok{nry={`m=$BHfN`zqnJP_WtjUENAY%|2CN+ICt8GPh6VQPo1vM4yq2d z-u+@@#f}6UNA1{@Z5F#Fwy9(mKbC3UR}$%@)_iD@^!CN8*?ZnhV4hdhd2q_pvYxM{ z8ooCY=UG2n=&F%=GdiHgUP=9qxoi5m`l`>LUzg^4&6pLna{aZ-EBn{)e_{7{^W!!ZNY*PX;c>s;^UwLHh{^)@8oO5|n~m?jwseX5 zzm|EON5z&cO+Dw=Dl9&~p(({^*MZ|tk}0HQJy5^x1v* zX#eoV`uYXBI`Uou;{5OqSVmrG0ixd}{UN?@KGE`Rq%1xZis6|Ns0_^Z&E=7X1A$ zDQtPN^>@14flDsC>eF=U)$2;`7t+R>5?sRV-Z0Muw)~Q#<)BEe*N!eNyw% zOEMIUObj814IGUM%#Ys9TX%l_g~#8Nx+i&fItMJ+9{Y|h$Km3)#OMH?yjORn*KFQ? zhg^#5YgNb@5iCwegllFo z#YN6{DOzb-Ga>feue%bl>z3RXJU;QfhEwQ5JG0%>c8QgVc!hb^-w&E@5Pr&6wdd?s z?;q-c^VL@9T~d9q&iCrl7fBwj=^lI$i|eMzx|MXso{0>f$S`lUA4@}E$)XvYL7rNU z-Y+?fwuq$tZF9)dO1-#M=-CNL?fzYdVq&}2xCJb9W_&lrV6orapzR^YcCTUUnUk=3 zky>Je@2qt_iQ8sbYCrkG zrjmlD<*vJy^u6ew@Wf(Ck7k0STHx73eZc_>HZVQsW0iXtvq2;yNp0@71PSNZCh-re zx(~dH*feWL!ite)Z#jRa!A*a`wScJ2vLZk*;EJuR)HENdd>4`5 z%N=gZdUMX6s`2vCBtOqNyE<-ql=!P0(pWX|+`04T)%5SGn#m;2-d{F(|DUh<8`cGL zpR=$1^W)u{o15)ke4jtveqW^D^v$0?pS*p2J%@gHu=`~3^Rl*w@85iqWEj8ebFul( z2Wu2}T`FIwSkGf~cy^2VVIT31?J;k7YbLq=k`Dd$Dy{Hq+P0GEd7oZAZJoVmZf)Ey z(;3_M|EX?czdS!JeX{tBGPC%5S(jG)`n&n$>zi*MT|RsDP1)3@}eVKojby?uvXN0;riHn5ubtX}$2_J4_ zIurG0#^m!J(>6@@_jslAW}@4B*COlPzwUCK{r&po+m47GKNoE|vccoylB0#@)1H1! zs(+X2B4JpTzTjV#@0%4@;sRI$TWy1GT%P5!ndw_YqT|6&lD`Z2r(N_tBxuPMD7fnU zB9Rr9OWkFf+3(i`O;%C!_v+%|4)1r`z<%n5m}ke;RU&=0%s;z*14K4VT)lkO{A&su zD=zM_b6~vqRl)T4hMqh@$4Hii=bP?!=gcem!YW#?EB;O6kbm~1MMq1Ry^n5Vl)T%V znlrh;AyYk9^@w=ti;#`k8@nG$=6$bD`!?VIvM8VYW3?%MGM5(WWE3lS$yIQy;w|$# z*mu)b>IkdkG4n4z)$EH@Un*`dPjKx}+H61XZcgD0-Bp`C{kBz{7i+(nWS)`d^R&x6n*J)K&gSaLN*}qP6YOhbcXlTPxU5vkt?hb#&B;>5#0^PUvc)I8a6F?QK|ZpAN~ zXNQ=nEvXG)Uh#{I*{>(KYd@b{Qrebs^~zheqU%z&rD9eF+0)-9hXu}>!!O~!qGIZI zejn4rD_=G=2K{b4{;qL}uG*x|N$)~#3tw;2owYYoVq3;Hvzc;@tfo7oRio-^>Zb}= zONc;_w!%?4(dv*lfm?3{t=$%~TK8&}_tslMZ%sDcT5{DS{Bn$MvGLj7V{1Ih{2J?y zcgv-%J*UalsAc;xa@yQr2@&h%H=3VDJQrzr@O8VH^>T-~-+rnr7s*yRta;Q=|gt;TK6oI4N=|lrl!I1-@p3LU!KKx|NMHjW7@@2J$$viTsD#CAC)&*3H2+z zSd1UjE^;Q*W`LjKR~MyS+PZb-s+aQhwu6OE_oh-lHpDIJ#Q}`ta|r<>mUQqTz1s zSTB3p!TFB>kFeBQ<_?R6rR$dSDln%CZV|q+k%wjZ7imTh3!b3KEw~m> z=xoZYlVAZE-(r)q7fswR=ad@-$$V|$J^eXSdWM2s$`2bOt?TArjE`%?+}RUn7?XTR zZ}kh=@}_z#v1r~K4?ShXuXNOD>;0&kxnZJz4Z}36N0m03n;o?q_bt<~b#1&pyK47_ zFU&u~f0P^dHa;@c+m$i%#-0~J2@5I~b?Y%t`|3J7lRLk`L(^s2Q(oUZ`}Rk8W75%YiPnji8`hc5ebSQaki?!- zy+G!5gRYmu;@Q{#m`__VUDm(o$hKofG8^9>G}`6aR%gBJ)#|v5Qor7wIM{rC-nRQ@ z0oU^1vy|%R{!oh?J=ylLcK;%I(*u1z zUQ76xDR!rM6>#N!}#{C{5kt*G#;eqq- z?EM)gFV`mi>O(<5`}$|!)64bkDs#^|zBbryW_9PT{G}HYR@sEO$-i55xZF`F&3t>5 zrs$qkU8f`NXNdmk;V-W*mW~wtvo|mHV)5_IyCm#>e!6?~>(`rGmCNe_znfce$5`&_ zs{R)^fB7oy^o*Wl-<5D>)@@#CBS?L39AWoz4r%efq1Xlg0{B;MTWR5M?B@4}C=hZvNvILcQ&VKci|^OZ?K zSvUEN%8Q?j&r=RQKDpJVT8bn1jg0@-19QKxlURO_ao)8X52k)8o9=C{u$N=U<8vQF zdhT4_U44D`wi5k^w;vSwg(Y(-^ekuKpHt5;FM3a*7*FcO4}6scHJ>spALi|O_->L$ ze<>@=&52DBt!yrVh7mWv?v>VyjW%rlG{aBmY1_x6d?~t}tXod6`}tFC6XS-vw-`8* zdbsxGRbJSvl^zy&|BTF%CZk5}Q^NffjtfF??->%GvB@)G)(*#IoeL%z+`XZGuk-A^dwY0uCtcXHonc0Rzfi`e z&V}b1@At3EbTSl4%hcG?by#Ejy`Vc2O^-LHE`%q0u8656v5$~LT+Z1&+wR}0 zuEf^kz)bt)WoxAKjMgtyT*S0?a(;|&i<0od11=%eZf2VbXK1|56koTqNc!lsw#17U zw3M4SW5S zI-zHNZ_!S>-HdE!9&CNXCM8hkQ2&cjsnWk>p>QvkQPbYZU#0we7gb7SJv?)>clkQ0 z6OYzpuI=U8%6449b>Y>M|DCh91SHHYJDFQ5vGPT~^7c1>9lNBn{#9zsn{|P~Zhz~e zC+peODw4uk!WH6Xvftq?%*p8aC@{a=xA~fQEYI(64VUxrM%;@GIC|sk!h1~#JC5tk+H{=jto{k~=ZAbkh)sJjnJpZ`*cI__s7C23Q*UN_{ zr^15IH}So__&&bCZkvcihPQ;{JvV`P*{~^WlUY9ekx6LUoU#1##6wPtJGX3%oH%LU zd0`=W#Xh6%Wak$<{K7wfk;{0%mL%Jx!=!QZk2lw*aO;oiPet39Bb&okEjjS{ufwJM z?uBK&OcUKt*Waj~Y~qrg$T;Di?Ps)A_}eNaJIS8iCOY#! zUz(a0@4OdtS@u_a-kdzGcV4f?n*^1ejDq6n8bDQV|C+~9+_ihHm5c<6l$Jk zaFJfvdwHus$r2sTv)fJ<@yT0nT4}z*_(JjX^NS36pFiFoYH+vyP*J|Asm}+qPqrV6 zQyNqk+1#JNxUI%oG}N9`^}%e7#{6H~xV>U7zS%vINu%pr1#iF^u_`A&pZ)uupJdv< zO`g*=P-c~?S;)pXVZLm^*ih$t=R@0080kK=wV8YH=9dfoEIo!xg*rAhvdnoSR@0zj z-?1u)t2=-FMTK<}La(fCsMpK&dV9U;!=80>Zpdn@GD>OAnxqtICUPzP!R;5jBSmub zCTKYLM4H^b(0}(%enIc$rA)i_t4Uv&=3jkJ>--^$pQYlN*W1JwPg|)UCdkcxe9Pl~ z@gZhcHvZcX-xDJC?7@WpZ|Xiyog;nZ$ijPeJN|wDToNg9Gi9##M#nnM2RF4k>irMy zKcn+ME&r&=nRJFN%Q+>?J*M3&w+`RG@yv-A)g|Hwo3&&<%wwBbfB$5P`EQ|V&8B}| ze4p&pdRAn9pQ)?|i{#%~Ayb*}S~stIa7~NfPd2L4{a=RFs(qR(`4f^Wm~779ICtW+ zV}^n;Cuha)2@M;Y`Qkeds_kFFrny)`;qmSI>kmWrtvP&9??qVpEWVl~sNAjiYRW=2=8y6f>IG4#iMq711p4x zS$)51=>yGQOYYew>zCx1MXbNxyzJt2p0orbn_!>5O#!Q~Fi&2zN0IfG^&74G?q-W+ zPn3S}*IV@?cg4ffb2FBnn>iy}=hELe$!(K9pFdsjNz;w(PJQe;^FoQxoKHES{ilsJ zb<<-cn!YbHV6mOPPh0kf<8#JTHSyhI!Rh)J_0uMwc2S7TiG0}fzOvsr7~6GFb!8?DUKE-(CW;MU7?f$ste8o%eoKW%8-_;-PsgUOOd*=(=* zr+bF6=dXL{H0#+9h6^(CuY=r{HgP9hzEP=VaJyiO-Dv~E0?zn%Q~8Z{Ysn|NFKOQr2W31QqlerVT z=5VLV*LML{O*<|xIr%>8hNt=SDbnBdZr+YLA5ywjq5g|UxV_W4)8V;oL8s+(jSME9 zEzddlJ2$vxk^VUen}h|7nZ6%#(Y&o+$UeYv!B% z)oq(g&0kMpR?3|GvVZ;mvnP2YUzblmT3UJD@S&dPUt96Z2k-j@l|5L`W5FBi6PNLf z@6m+%U+piq7VVs`eRLzAu*&`UM&VIMTy=Eh!#%&Gs{ML!(}&Vp&8 zv1=MV&$L`M?wYuvo;&c+yqV34|II&~y3X}HNVlmxXwvPe$#WeJ%%9yqCFOJAq?~J$ z{>*Fd*}S!V%e0qQzy1+#6fym1H`D!Q(63#)z7|dl5!Ih?ELn2hq(u)m-N<-3ZNGd= z%hQ$34tgT@XQ(D-ZO*OnJhbxj)PgL|9}9O^Wp!_E;W9bE$YK4}=Ea2l^>O=FxXYOQ zTV(w8OZcQ|`xQ;vzgPWqZe>w=nG;y5CFmQ}?yPe`{Agx8M0<|0<0i+S>DXyRjFWS_Q|gpU&;b5qomk z+%F>G|NHHe=I-wN|GR;I-*xlVJEmOBoB99eqcye9OQd%#W}dfL=2rE~Ns%>9|I(km zV=EBn5Lo*9=AQY}iWmM)yr@mhqn7nwJvB)?aQ2S< z`;29RriIL%b6JHur_pZWqujRQpJ{DXb>H7rZ`}EQ{>QU_+w$Z7yZ>(Aoqj%kWr?zd zc7>u@`ElQa=92mn{tsSn_?i7>@|3LK+jradS0^~{5o{9ms`uR9cv7cLa{I2!*Y;eL zFFgD?eB~^;H5S31a$@r`PR`kugJ{GO_CZ-IlxNXGZ)F*^ede zlQv4cd&+djL#^}^m~pZ|S6`ryNcgJ1No9SJ?6BRlhd+qNsA`Oi1K z(BEaU`(BL6sdo>KW|a8uO|y9Kdwu;U50*5YeI~UxL&c-Fp4IZtJeCr3rzGO*?O2^n zD@vm$WawPtsI-*MwwlEvdvo2|zn6k{Pu2S6pncxCa#7;t14R?vzlZ-?HuwH*6sgxZBFKg8(Y(*ww@6EuVMBA!lvh zG_PBFTcu##^t9TglJ#YitS)JrDH2mbkDiCzxdpSXVI43tz6mOcLnzETIXI^|Je0b-?41pLuMv@L5dTP79P43advG} zjX>*U^^0}dl_n8?Iu`R!wY|7unc9Tt-F#nKPlRtwshjDt$>QvxL*D5hd_IV=h9%ib zUzTQ2HvZiBQu6e-CEJxY)g3#@=5O%JVfNg_gC4CBo7TTN6?eEH-XV*9rN+rgHH!1( zKCHg>g5gd5vvhNoyC=^izVKsY_|)@l$(kGQSf1Nd8DH6E6_S4W%e~eM`3J>vtNHV; ztmo`FyzqnS6JGCd7Cvty%cSoWk5>Kkn6~<2L%-YYg`c-M`b~6ke*Z^6cInb>#;Lbu zGp5xDvGF@BTfJxEfz}MEi(KiZrh7Mj{cO(bdcTAc zy=J*)l%GBLz46}G^?w{2`j>zEApJw*K)m0wkIRFKgQxxGnf>KyP`DrOhlf`jdUkx~ z{q*_bEH;MX=L;wHls&amD5%$u7I0KtG=IkD|Gowt34=iSew?(vWNr zZ4mX_w}n^Vhh>YpkGr3TQJF3 zkdzeP=E7#hZ4_xWU3-l~M*N$Z_sxPo-#+v`GJfUe@62!Sy;@axP}bwk-<*2G)Y3gx z(X#_1K3#Ayh}%8)Z@^9yt2zVo*{A$R?anCu=y>H3UA}t3REM4?$sJO~ zE#et_Js;Q=e|i}+?QuqOnS0E$2Q?4;N`33)tM}J2RJVW4t^N@HV&z`h9RWdRq5+4L z4U#$;*I3>$n{?kn=Zve3bHALyddKaqcM6s)*s3@^_QkcQ%N@7RKQQfT#!1ID{w(>7 zIek($uIK*jpAZ$lve@86WU|;Bx!V)uCI}w9utMyVXFlKlW*f^eOBOkg*ose5ABDZ+81wDpK*V~u|m{to2-R&xA z?7YV&BA?u_dD1fhD@6v2r#l!fDEH{8=nDBvIq+^tir13)%31H*^yLi1Pd*J7-yYT2 zz^*!P$Gi3Jk0O~?Mm|(sXXpOtZGwLD(Ixe3MSP1rq>t8LUi~=0=7) V3oYPHfB{ z|2mZ~T>Wd;hr=rmP0D)q{IbEbz*9?u^WxK;&Q`qfsW)oB8nkPIkI2vE-kBb5GbYTB z_0l(d_pm9dw$ipX^LN&~yhof9*mmf=lAF}49)8B1SMpC&^VQdB0oEUucJE_$eRWQ6 z^-;^%{h#-1UuC>vw6VS-uW+X7HK)avO9Vw$OMIKkwT&S%FFZ0^O6sVMFuQu%;ypW; z9z5odBAjSe$G2ummBe<(EpyMaDE{tBb<3A}sbd>rcd{wbZ+?J(z$brE+t{pm$5@Q@ ztrw@i5Z$xDT)R!)=-$!|tqlHqS{Ey(5*&ARTrmWNV+-q7w_YP2F#!Rok1sPyXJ&mw&%pQ!M>iq;g8$O)2QZ zD{iNA6=rRj|94IN)LL{^;#d9dG7gD)k7;_v8=o2$O*{PW-NItGSmO_yOH0)`PcM+0 z$=2n*&?r6A=+y(=O*^_LAF@{ydAL%Mf7uJRi)$BZeLmlQbWKXT{~^X(OMXboS2BET zFLu6se4BN)bk++UzC!8eFODvi2%IsYzhX{i%_qHUvEg5*8-6V4+VtTPPfg~PC8zZ^ zc3t|TU|f%fMdn|v!ah(?WS|C%;0Qh$%toViQgCBylBp56+ih_$FHXk zCj2^4&lk60PWu1$gXdcg{s|QEsavb@<4I58Mw|Ep3+m6*x=m}3(f4Pwe~w^DyGz&;lls8okDr7VEWZ1F zVVT3@x6gz4B}-Rk?=AZD{`%{iErtI)Y-cxEr+xfi@vOpF4iWdf|p1|ki%zxY+t zyZ=>ue{=s*nd1WR;4ibWnZfizM>Y{AQ*+SZuU7rt{>R${>+kPB)Ndr9t>hYXh1GSU zcNJroipOPFE|ZhZI>ot)+n#t7z1vn_n{IK1ee0KX--ATHtIU#`XngqRkFyu%-~a!E zIr{DH-6>n+RafU9dw%=(?(_FOHzs+`QMZh~Yrp1`&9lf|rzY9>v7C7mX73(9yZuqo zo9ohglV9|kde<*{RAHEZZU4RhvUdK@=cn6mskrIp>@E>R#?$n+uy49Ov8;np<}D}?mfn_xw07fK&Ux;<9y6aYl}>u5d8@a_=O+K<6-IO3pL!Ir zW9P4;TT(X;?Yj}aLi^X6W#4ZfuV3)Qsy|h){q4z~Gw<#$)w?*$iRbm1sGYx=&NW_~ z=bG*DvFYi8ig()k@_iY(4{K^F99C zy=T%7nePcp`_8s6TWT3Rh5dL|>UBrcs7dS0(?g~wU)`xF@T>bAf3@aPVfN6sPqg}{ z%dVWdcuJ$P-`082H&lM+UgLc}^VQKvIiK_k8;cY6zRoPsxMov$=5kM{8Q-o)Pu$#t z-~VRr-M&mm@2*SqRui4{kBs%viEk6ijJ^bJHvdqcxOZUczTop+C?D{9EQ>x^HqJ;lrpQWcICj1szDRJE*j&pLP*{WSD${piA&3O9Q zuQo$=frtBl)!4=>e;1mTt(f+$IY0ML!*hvLYo)0Y>w?8Re|7pqTBSX={B=cAr&uhe zuRmK=`TMP34E2{L^FLVe%J+55fxHJhvM=7L7U!S&MM$RQ?G(=cOAKzce^E}F_vvY1 zX2*fbX%S44%Om-+k7}L0vru@d*R$6jERr9X2wxSyUM76n`D^*NLfjg%c;l~lTrCf`yiahb1#LDq|)ynG6 z3;CN8CLVp6l6gAiss6i+y<7L|co)B$_>%R>yQXcd>1*8<+lIxyf4$UNeCf@SXE9qQ z7ryn0oZFQw{-jeZX2Iv@UJRvsSv302g|Js|vOn{F`oR`<<#hcpu209D7@PVM;uh8m zSSYVk{J`V#n<@B%|24J!OcUZ-67`mZe3)=?&1$_Z1$W>_p_1|P=1+%`%ZSt2VBGv5`54@wDv>u^9_B ztz1~@JLeQ|)xCWvGUKAK(Z@q3?9Jjf)nc<4T_PQ2 z1@*pfxy6>&TG3t&zrUVc>Fld*SQ}`jduaBudpm;~T>oTORUKst5Hnr7xpe-elX{h! zFACXexDM1;G|z5x&Z#Rru(k;cZ z;5SF^s#tj!-Atj^oJ$kayeiFpY5ofe;4LxP%l^C3L&KFx)LL|M&596%aN((?CNep) zj?Ime6au)l-}F?++g_;Otgva*%EIe^Q*~?$dXt0yiLL1mW;AfJH)PFz%y@^nZL&`j z+h4&i+&2Ps7I^yX-SAQHPzcwb3ZAy#3BOsHYOK5$OIsX&ac5GN)+^SO8mAzW9Iu+H~(`%IaZ$Rbb9`pB*sj_+nK zmbALGP^9AV;fiIlP1EI@A3U#%nyE19ykfVX!HZOt|GCZ2cuxx*znxjgU(|Q7zW(Sx ziR;D6oR9P7H6`r)b9qN~QB(Sc?SEPpe&?Iv8sKgM2^_;q@IL#qNZCD{#nSX zpF7_#9DiHv^c=Z<;omA+(QSs^<`e404#}Re71}G#^YCd)#Tt8o=XR4Sj>uJ{ZRa_< zQ{~*UeP2#@a{S5lnxMz3T;0NWTQ=A2ZnddG&WxFknb)T`H~-%El2`B>d-Q3hhrhL- zvR>Ai7OeeHl(p^LkI$@ZJWrQ2OKbO-TvVC&I**%S4fj?1@M+dL<{{6;4>Sr~UvSCJ zuHLF&KKk+IS9jN+Q1q{R_U!dse}-$umUE0HzrVT=)7Mw^`k7cK)5BW_im%#dwg|ZW z_+fWKW=_cULkueXc2oB>2+po8etC?^oTWj5A??@90Ndw&KTm|MjBt?rr5@Dm>W~=8 zvOr5OUf=s$&aHz6<{z2LrXSI2zM!{oU%IkIdgtN#XZBmNmn}|<&RLy&)mr*+(%QA# zB06IXw&m(fY&^MW)$izpAGH>%7&z1YFCFVYd@7MWnL+p1XXgohjEt+|)-?DZKAYfX z-X!&rL1dPAkc!WI#c2n4?($@bH*R`i(&j%W*6dgU*Y5e(ZXDmRG_yPBlhO<;2gB`! z;Ta#u>g?q3@imm3nQnzE0qk2kubn+C-*1ph9J8tg0vj1w!lAPZT3*Vk| zz8<{zI8!q}D_flbH@i`BXP9gK@>T2nuGVXu)nt+`yTUK8mo4?*%jMa|8A~i;c8lyh zSv5U8>rOz`?mKSWiqQ_mU_o7$gN)K*!4p1O8%`SR*V|zHf!t_yvgtKPPZ;@ zVZF0;|LKUOj@Hr>JwNbu9b9OnXy?X#y(VJsgTp1I%l^sRt;ze8`1RJ}*$)yH%&fN; zYgoJS?c+;2v(gSu(|ge2lj6Vn;?9VSwZ$7JCHTlKUQ$&XQI~b&rEZ(8&|c1yZEN>f z9KSXH`Gh!`X#3W(mIBS2|BdFanEmObdR8|>(aou+qc(^gC=59KdS^>{{qFt0|MH1) zG_Bj=R=PQK-jP{rPhGxye!tpk**#1@1h{X!+*_||(_8pq$FJvi?eEAxo>HIaqV1?K zX(#s|o02PBUfLpV%bjm#b~3zucA)v0OLKS#&-*oZ>)-s7@LmZ$H#?tdop#M+|PtCK#hb=3WTzoGP;i`bvZ zJ=5C`H>jk3R;b^(up@?N%~`Iv57TEnj%Qmq;k2w#@Je?Uxli$&kGnQPo9*VN(*qwc z3p1No7{K@2oL~PSa8-oCN4A)!&Skb`W!dIWW&Jm;+*G?jrRNBjYL@3Ivs>>?B7$-Jvp>?n%Zg=-+Lwd?PKQI)}IY+3SJW2JNfkL zmW0lZN1Z;LUZF)heeU^RyWBtB-oC!KGJb;cG0C1sDt7ftY`!|hd~cOdnzGHwd}AWZ zq^56e2QN!1R(vw*QTw$iM5!@SNig(KeZ$%tH-A38DW5LE<|#Z!z)v8UOYFdeCQ%); z^!N75P71~So3o@NaAJ)0Mc+djhk_2JPTXVtTQ{rMV8#U&&)+As{$4%r%X4j^pgPY# zu2p-l=oy)I2Cmw=xqfZJmyE2I@?d42Lc@8t4oJLBXkIyShA`W_TfXUB{;$sM5z3rt zWq4+Sf)(TJ0wWpUuS*hIHGA|N)um@J^K@EH`XICL`)82IDX);Bh#{ugHNw?&(wT2d3J35jDH7aM=+Fi z#0rG2I;y54kw*X0Q8Uo*e$-Y1h0P zqAbno=!7fsG``4}tcu#=(WCPzcU#ZL=8L;lzXsA=+Rgt|r<=70jE`}eSE-N`E{HV>{ zc3D!iYSa3&m*Q4>%FWX`b=Ky7nr~bi`}NAr-@+qju*mu}o&I-ddga}e+pU$epN7iL z-jd>Rna^N$?ZqdXQ}-F(mNH3ez5XTB>xatfPdRZj(m!~t_S}3f`+w2A^wJrh)50a{ ze{A8*pSAVlYPOCB&mE81&NWGDGfSvNe`i!-nCG`CDKu=u9^W0YzK+@Z)*gQSxm^5w z{M`BRKXwb8Tz0D2?RUZU`Qnv(x4CWE{yF;p?{iW+cw6meak#~lswD5KJfg$8scS{p zx4q3fkC$)da@b!{oL1;^$a;Rk!;|h$-a2qD@LW~DP*!iQDrfS+Ni7#o-dVF*)AQhm z4IaXA*MF+%Z(6nEtC8U8fFP?FG%_<5_ovq=Yq%t$d^>*fl2Giv_>sq2^ zW!cvo39SB?DdrpbH$rUwCW|KpS^^hkuTQn+ewQA`FP~X5`GooA1Y6d7n>JqFesA3x zh6m>gg)Y>kPOPs=)ncBp{k%@VX0>P4xu46}|E%fwCG$yn>DEUk)l^D*4%nJ zduc4!^@jJi+%A_rRn2wSt-q&cr|Dsf&F`($6*&~V)YgALdrx};BiB^X^?PkMoZXVt zvh4L94V$jdZx`Lr@7=%hyLGl^eQ{{mKP91e-wMrpZ#@>X2)LY3UVpF2jECo;n49kU zL+d}MbDXgGlUBNVmxfpNvDd$j8h9<(B(jsP`)BQ|FT!H*FU`kaLxp$YewH_`mAR|rPyH>M8M^)AA(>59?~Yur z|LE5uEAc@5e1qDC4|`;*92WbY-XQkg?&FW&p;PsfHy<$jz^Ci7;?+WtHz#kL>3UN- z|8%|1_THVDaYuw~n$NX%FIIYV=!!4v(n#S@Av>ujOZV%ErCq;q=4CkJ%QIq8)xzq6 zzOm{8=6<{>F4_YERRc->Y8Dni;pZ&27$;n@_nXF`jvKz~f_1!tK-R zer!*PTz9HA!TW{Gqpf@HOLkAb=Xt2TPW+Yh?$4ipid4_lpIzE>Wkr3H+5ft%w;z7| zp5kbu7c2bHHDy-OipsBdQ@R$;ydG2|o^tEr-F0ggN^LOvz>)j9Ww)f5{j3E3nJfG^ z)W%=gopVw3o3g*<`5mjL`TWlRopMUvZJCSL5|er*qow?+!M{XOvdXXjN;!2rl!Ry+uYuFI(+sU&3dhQ`+()!2Kn+vpLtt@UcF2B#9Hk(f= z|InHwVI>vUmkVEa9M^9By6XSgg1x5}T$Ru4*P6~^HTB$P^|Jldtov9KOMag$Yt%XP z{_)Kum8rkD-fTL3Ae@bB^9#M5O&-gS?>^kj^T2CapnUSb9m{(qTP16(`ux{$JbL4O zss4Xxq%M!b_A={ue}Q@Hb+^1(kUNRTx!m@KoYjfM1yV0qmPh!8ZP%U2tg=?Us(QU) zghuO@cU;2Oc~^e9d=sxxa5Gd&x_Ud@Qt&g&i@Cgv-~O+V|Ng6a#c_?^R~$jL|Ndw# zT;x=$^OoPMcc1v`{C>HZ`*A$4=Y3qaPfD?C z+5LpQ#rYBZJ6;~KW4rP^=E8fOHMvK#)3$DG$d6hi^Jc+(ixn1EI`+F2i#oQ?-DSOV zv0bk3Avy7z-!^R4-f>S(szCbgqPyP(UR~JJF0LMallxJ=)SBc^2N!ME-?#Q`(tY## zLTk~QB>s{Xj^k?e2~&Lc&3Sw3&eMqUQ@gkJuKu4SeJZKqU01EZ_UDJn;+-#f_VHLn z+>mFiW}tGajA1bbr@gksrLz-5#!--&m0DCa9dm zS^Mc>$QLy!rrJOIdRUjcY3|S7U7GUo;In`6Nz7d3tK>E9-fI}m6MkKC9`age{*Kd6r z<#kK2&u`hoYR;S-^Z5(6o}e1O$ZYrjea;gn=`^nV zE+Ast*?-Yy-_NwRe13U(&!SiI1w~#3pKky8`}4zxZ_MeO2R#y9Cml8n*wkppH5(py{`Z7nnlk1?y48s?9V3OmU_}Bp>`^%=9O4lFZ^3d3l zqjdRb1CvxBl{$On?FZ*;Ov3qJC} zXXm$yo?9G2iv|CkO4L!{{kh~vfAW?;29HY4Rop)E<;PQ%&&N!egm!S{{)+F^6nW%z z=c#Hnul{~#_tOiT&o%aJ_FTD=AU~ym$%eccdGR)s99Kk@tXgx*Y;8xH_z3* zICH-_vunD>gpfrwX(9P%O?Mf++u-~0lT$sJN+-Fy{hYUHWvam>vvu;vjTkOm zym_;1!}Wu1@r*(bV|4G{3pf3j#{N@r84FviU3&G$jJ0h}4k`26?eAS}mN^`-GIz^P zC%qFg_a54)iKZ5OjDN&-xNrq?*jjsS?b@tc_tps9;aQjGo>JB1!dCJ4eefccQ!9Sm z{}8RPbBjmqt%K6Xdne6!UCs8sYG!^%>GRT}_q}KT9X9{wbvEtW z5&Zw+`T74d#N`+$O&46nBFt=TX#wuffi5R-IKim7U2r|yCl^=n%; z<8i*Z0wVbq*XlJ}wzaPk|8RFz#T}-FvQ8;;nXbFVMf@xK`1noR8dcwoPZm{po%~du z%6faf*OPA_?{C}T@b_he(za9j=JWm6%wH~G`F_vMxVYt0H%KwhNj>>&&ZDh-ce&p_ ziuNzrBEMH?o2&cMBdY##8!kBQHkLk<5TB86U!uCE>_g~0mF*U1h3Xd_{XVyI!_);* z?`(Tdi0^q)E@G@}5VWj$8IyjiDaV?r8*`sE{jq)b;KZ8;Q&M;C5leBMe~)GRri~)@ zXLm*jt*za??foy|m%D_*tc?$^6q8`8W=j)h3_p~0z-GGF?cDMno3BgkC+^cuH2q=I zy+I{6@#%vP{Y_p$N3OY_Qu=4HyuS0BSVMBjf7y$o4o45HXSbMhXX~+ls)>_)1pd?< zxB1~KTG5`co-2RPK^?Wlxr@2u(xoTwND<#~PPO$@$NC?cd(Ju5&s`i_uCvI|??%z$ z#RjuK{W!o__F!kPSM$-O(ph^Gvqi)I{Q8r$C6wX(9j&B;pLsIgv)y9kQEOV)vbU|R zKA)?%Y{K2eGP8_}RwsRF@}9G0+4BM~F$Ra*?i-G(#k)2iXmh-)JX}(qOovkXbSM{v5{962NvQ6yvtm|)2@|JxS zZR9;PQ*Zy)<#BpPY|>AAA4;lR|8{rH?XP?1@!YNFyS%z3Q!}P;;-i*-#{c+sN3=+p z*Q9;S-5MqQb6J-IFI(!tTR|&Z)i^f=3*Ks4v7}JD_0{>lEWvJHwv!So>;x@Sj^XBnT>jy>AB{KOPD110vvmfWn{luv|zK_ zrzweIb3e~+vvXv>ZLz9lbBgGr}_lExa~00ulG*V zlAAA1hF#ZvsTQrzlHsLi5$%0u$-OwAXS42p+hlyBMsic4VC<)QcO@ubc5ZJ*Hif-=`fcpQG}4d0i2m zc)~z;H}j=UAyW^oRk;~+F*9<9)J|rT^7cL2^71yad6Ii-t=8B)oapw;BEd|AtDUEH zN5{HPTWWQtc<+naxmf+n0r?FRZzlE6Klbo9`8A|=gk9|GSwfw=MI1C`nl1n|9R-~#J9 zu`WBf1=7G`Ha0c~?MBz&H!wkLMz^pqp6+;pQKSB7^v%3zccI$r;a`$JJ=nK5 zlQyq>rjpG+D4uPMUcAQPw2=Qvz`|+T zS7#s6*?Tp?tL)M`x8N|rrskm4PZ;V#?%!Jx7MvPmYst?2E;UDc>l7yw?bJPNjB%-z zyhSgL2WF_r?D+Od#dfEdchQRjQ!m6Y?Or`8Q6;hQu8+;@W)*(Vis-D0Pe1Cp{wma; zJiOT7sP|U%&mNb?PWB1^F17lsdr(u&v$xgE)6=d!AS(KcSd{T0m#>X0x4N#Lut{O^ zMDC-z7e7DWzw7dS{bS3l=lP{~FMjv+)7?e2|9+?ZdL8)vZqC0toBGEG*x%)T-~Mj- zyWi&fYAs&H^_~}d#;Z1CDhJ#AoWe=#52n?(um$KCiM{PR`}z5@>fBxO>C25T?=^^z z?K{8Ea`xQ+X0!Is?$P`IyU^sn$!x!K`^@gwRkzf?=jSRuu&aVMWTn~CEz(y$$rk9U zZC>d+t?jT-))puAeUr|fm=@8!c1G|)Rc^W3SqzE?bvY7wyE@h$-*cby)k3Bz7nh$| z-E+oKths)T4mY#Nrp}+8Mk~~!=f*c53fXe#)@}pah?+UMrIY9S1~r{%GU3rU)HY$h zhE1!k=iG=yrRQsf>+ZC^TzKfRumH!|w0%kn7ql;R%$wG5Z9x^&EzVbsOd_#cRiwC! ztvk&)d6*_;CH*}4qkT1R&^8g_N1-kO@0hll+UcK>_ON+b|8DBbe_!AKcZhfJOVK`* zv&+W5e)nF*FPyu+HEh_gD6T!VKL7Ba<#F{tHvRbcHED~4ef_<;`>I}ke4Ue0^ZoC} zkM|$VU;Hk`EOyIxTfw<6s>{_CWCEH0vU}Kav|VL?VR`CxzQW%L(SOaA#IN(M>NxSu zaaX0~{JDGOl>aQN{`u%geaZ62`rMz(ie2LS?0Wily=Tm@iH+$xH1+5KZOI*{Zx+>= z?TcCY_}ljR$KR_jexDZaBmJ6X=cMcd5BAEO{kY{tUYu!8Wl?9}>=bbu-;LkhUiR)V z%gUb+ocwiD{`*;V0yft#@vB<6p138W+oHeeT=N~pc<(Le?w@;?KKba4f1j1>>zt~1 zEvzMt8JuU=Y~xcoueil&j)Tn837r$#nqe-X;^06u$k=$(<&j>4aX)KxoNyRyou{ngTVxeo{NoH%?6EATvz%g z_~aEWu*>sUASJ7|JE>FSf5MmAh`hEX8|&4@lG+8oyE!k6Ea#uM_uR7Ep5GPb?KR%| zN%zXB?+e0$+*DPAf|OEKgZ8OU%u8dsb|@lYW8!o}%ROsM*S@)!pxb|PW4OBaQ`vc@ z8Y#2ado(Luvzj-r#YDvGykzwP8?K#m+r&wrn=H zRJPQq4|vhg*7Hi-tByl)`$~IGhfZUuYA4Tnycy?rL?|Y{-v$!{G%jv4WJ)onc!Q zc+Pz>S+(u>rm(HMH}c2{@rC&rS*WRGO`NP5y}>B$P}ha2?!25=7JYrtVk&m*kmZ|Z zqY9T*Ib1UX7MLp6Phk#wU1TJr6}JD~w?fJP`IfJyFHJll8FTZQ((-=RI^`gij~Ygk z=YCDJpE7%Q*i61PE3QkkWh_%*Pt}Olyiz@7_3Nu?oB3kb2S{(t-prSJMR8x`lx^>0 z@9vBdt@qx!s{Fdq(}ur?8pEcryH&3Cka6O=R%BdbDl2AJ^v`Xp{>FO!>#bKVY>MCV zMqKx|>*>0So8q^=3D^B?x?&GJ#d z%zyV~k>PBAx98LEUOz0W!m>p5Ky&>UuPMz|=^wkDkDS?GTWcG2#?JP)!F*l)e?L+; zMKIjx|CD&(Y;}09lY*yT^%Jj-IT>vi%s$S&ue36%^jGq>m>3=L<(rSb_>jdI%@lQT_{He9|%+mFB7Ihy#^Pd-M`X=s} zU2m^vH<#ah%ek$*M5#oZj_zr+`|+Yb>s z%X(kj%(1hN^kcV?<}&QQ7nRIt;<4Fz!`uyXc->02^`TOFZ?~2RgHWf9x2?nm?@Uvv8zxe6VBS!(%HR~NNY+CSP(H+Nt zB3>`Qwb^U^1(fyOH5nYV3!gZC7HzfNkP~=JokK9}R?&(~C!TAaVhg5rEXnY`H}k?{ zeeuOFf6HA=sj1}O^`?7)`=Kjk5461G=C58-A{`#LLv+S(pYk!p#R{oCv z@3X{r!qu7uBKPVuIMy~5Jvs3{f5wM(t*@KC_hdW0TUXS3>g-ubt&iu5eBZ4#)m7bo zt*ZG-g6Slw$lgV6>u-PQ-McSg_u^~PuWqhRUq5ee)i(&Exr*z`%JiV~OXhvu)Aj|1B5XHT zrF}i~YUWkr)#-P;mBY@jnK!x0@0I1s=S${IuDZ6?#y3ymRpjdi86stHo+&#l3lr)M@JN|zl(G>l(d9teg zG?{(p*>&bvE_Gk@dY-1M!{nI7Z)Q%~aOS}Kw+fT083ZD{LUt|64hfB}tyB@Hb#n+` zB{w(ys-Jr6jf&+$j(!^njo^=28cMe(ly4~goLYT*%76B0{ZU5K6KmN-n9PkJqZNi0 z=8)YrfyIl>1nR!8e_&{Sxxhn#vENhgTuge^<4)VX_wIgiJZhBI)yU;h^nc%`gX<0+ zQc!M^|COSyxO;xt{=0v-)Wq1FZ+Ny`*!i=mbG22?J$*I#gDYt*(DF{jIX_fqD~@XW2)mKVRPY z?Xj5BW41$g?|~qk=bdbQ{ly96n(*_#osSF7WtWUS zBFVY@_K)s>9a@154E3cw3ueg8Up(Ed>caMx#l1#?PN%PIyeYZx>Y@9GZYVt2;HKPO zD*9wY)r4d>rfK`!zc*xTd3W(yl||DQxnDkMb<6MlkNvx(#x3LZ3$5M1S zWmVUVe6}4`<(@HcRMKQ^n2rphu@wQ{`=M?#yQTxo)MG zf73<1CI>rBlMk6+oc8ME-Mgo8OIK2tcauTb;xk#UlDh8{RgYM4xO2I9cgQeu+*_Jn zD3#(Uv-GmVo!K%|Ct9#I`WbfodF+@2>zeTyLU+wxA z*FnDX~I>xmET*;vvAGK3&i_GP2xl+28xAnz0(TTioYky}g zZg}xc^m*i@^zwPr^FK{UDfwxdR?q!D*&%Ie=bde}w=U`l%Q{!~Xnd|W>nmTPA+~g* zmyXe)npw90CbQQ+v{~$VEBf&kLr0Y@TmqN3U1B-*a_y%gh3afy54rPuW>=Z3?3sMt z_)&0S+!C&(y86qb=PGmXo{`uS{M56Eb?&RFxznTPr|DPyI-^V8t19*ctmx{@E1m!1)YT)b`$SK3X4hCIo)%v@%dtL>*X~5<*^7I( zUUvL*U5+rf19`b`)zUK7FMnsO$%+J%XSr~@T@;* z6uo?J`25^;uKMhJomI;+k9h=Wl<+P55UjFqgXOj#s}wEvR6f(?eQ{g5G4ln(jaJ>5 zs~7saPwv-O`fCmyY_$Ll9B5A8d6tcv$<%OqpahF%{oZKbewm%Td(W@GV7POIYMmz& z8{3|;J)9F5+TJ<~9cDjn%^?g7dKJFGjNqw zNU&#UM^I{6qwvg~3Z2Ib948y?OgQNio3XO@os)m_YVI8yW;i4*xOy>9A+){ZL*;hM zUHl6V8%l_q7YWoKJD&I1s>k}+o^`6Lo|x=VS1OgW5h^VA^io>dWVobhtrhb^m$lZ+ z2ZeiX#T-%=DNVU}WUKY2h@^Gr9HNr`GcTDJaeIo}qp&%md5`r(lNsi@7pE*$sqmR@ z;TZhc$}{0LPl)ilS=S>EJ+@-b^^7WJyEVDz5zhyMs6QWB`PW{JsSgjEeCf)zz)Q`C zLYD7a7_oI_LCqCAQ$FdJGo-dpTf-xNw#sOh)b@!z%a0lEI2q8xI4Lc7dG93C(mlsc z{wlDsNzi^$5#X}=RmIt$#SbfZ#mcWYTnP>?4a;4Ub~mufbM55UtHLXeZE@dz#e05` z_ugIgoIDp+Zw@MWX)wLsJ@ZOtz3z;%3tPn6WbXXs3t*npZ(T6A)1F->WlQDz2_|lH z%NqhTjr5NQPrLQUGFG#-d-c_=;df#ccCB9}9m4%icdd!|$K{tQyCfvJTI*LzuL=8a zsT+MVHiX-4HIJ_vIN+oRW9yyw^z~Erpd3Je^xtdcgS+(*O_=<`y7TnqTths)Y zzg9^BA4!_TV`=&u68{_r{;M zjn%Ktn>hVi)*`+mtmp48>{P1Upre#%TCN{k)o3YTI6K9^ZE@N=^(4{HPuB*XExI3l zbZwxt8ux7_A&#DTuLPIuJZCbqJ>6@v&tBay7Uc}(etD6Fs^;}}j!nlz?@SVq-#g>R z?$oE#vfp=me9_HVe5}a6#XirmnyuJQaLdk^K9;F3g$^%%_CfT-GeOb&^O78}>t28!}9#!?@;IOI?eTJta}vE5=gxVnf5iF6pD;v2&!aB=SxR zjCOHK5er)8F>l51jWcGO*7IIFaMLT=rOB#>|F!AIh6YoWI{r1RJQr7G#2f4KshnUw zWHIT%ysbL3W(Nt(ov?yuU&9?u(RB?=R|ys^*L!qe#qtg3jCL$|88+Xhn^F8skc6`{>7&Sw%JL=N0cZ~&Xr|&sl)Z=j8qUPpW-w+UT z`QC?4hK0PBk5mY99xCcz$Qg3E;Gjy+s#$YIvd--4VBtTTv)Pqhy~Y3Ao4?kgXM`rZ z1`7)xsIKfv+QsYZG&{V=QSRzdxxfjQNBiUgCt97ocIDbb!KS2Li7SggbTsV@@?Xlc zcaPeV#7yH`j>1h3TBDM9Ik)Miaxh)_@UK4Weo$M2uU%GrN?$FT_}X_J?L2yIQkRd- z60%ooUofjp`PdVO6KB-JAC&yOqPb$}UTf){m+wxFik)T6dUQ+pmWej4F}ABWE&uuF z&As#ITXs#lZDwzql_a_)ZRz1$?*%E2cx69OHVMp=? zo7+40a&f-Db4^|4Txs5V$D{<-Dxdk!t+rn;IMw&y2A^K#y29VK&C~a3Uu4~pf9c)( z|3A{59^}8;E9><=zW(>y!}b08DlyUNwm0v>x<#l zyWP)M+8y3M`|j%Y-^WkBohqNInS8kBsd`LSFaN%IdY_x`fBN#OR2 zOk38(dwB)#dHwbFb;s_m^jdkl^|D30!3P_QM>WrOPV|*fZIN<{F}7ggbadVz5XE8J zV!LU+@J()07OqC;2?8c8+zVSTICDIaI$=5?Tj9FHy2cphooq$CU;)hun9y8jIkPp!;(^(|T;)2oQxZQd zZ)(i+pZ2Nd=Vr@&*~a|Ka@7^qEG&6&R79j++q?P@<134uYaX4R&+<`scG~gD3Thhh zezNW>r{6F9{#WS6{|%4xitnDxKA-h-n&;-nD^0bPr|waw zjz0RJs(|xt!R39guH3S7`B8WDL$E}2hl9?!zgHA{y5+8NWgFbt{B5x*OWmnj!_KUm z{qN;G1pd@-S+BHldt1J!iIv3SDLLJTx4suHu{!4UGUB2~tj{5h;KjkPZ5PjRTbn8P$f-@+70p~Litn5+ zY*VVaH!Ya``8uaVD%aIzYX0x-*}A^9qPS)s=eGRLkjC~a!iG(!MEfk8&(wU>>$BWk zG5tGBXS3Qr_TAxM1Hd!$OlD@&!K-o%jf^3u7C()OEuU>6Puu?fHK!dB76U( ze_j1&!u5ak6XIjNCSQHKf68_l#-GbmH{4jEuczPFqkr6NOI)Sj*Z;b0u?)w1Hzq%r zae+5$GUwidZ)9~hactb(tZ*WrE3_{+LGOUmw+)_IH`g;qvl<|~#lU*cRTJvx1Tg>U4yhgaitRtQGkXXIL#OLg44|qF|xSe#E zd$7D#n8ljs&KBkTh6Pyyxm_(LKN}^&8;ix%B5wGzvdghwmw4UKJ@H1uH*r4JRQ10W z4Nqsxdz{I%X{(uYJHzj?j!kC%_Wt^O2Ky}J7*^bI4!^fj`%~{mv)@whdFt!K-hVIc z^xPvTbt0et$FyTQ`(MwlKe1AQAOO9JEhuWb|3f> zyZmsQnhJYg$Esd6A*rOj2b|_`u36Z5D4|C9>eU0sf8>4Ix=iPYy2)dv)TB=dvP=uE zOw-ugcOi7g!N7&@685EA&0EdwlOulp3<9)6{D_q*=7yo71tReQ{j zS>4;8IH!E_f<*JyYjV0x+9QV~%&Y`SfWa3O`i)IK|(*i(LKV zpUkw!aY8#%AAdHTxWMq*Let!MD5RX-jo048+m;P9_ zZ1K|KZ8>XKF0lDjkTAvI>z&9cJC_GPsVLSeF6U46lbrZkQK%&?fAfyCr*oF)pZoFI zqwTu)DNoLc*_A!1@4rjDmOJu<&xnIz*11L1LH{N!Q(YYY{M@A9LYtn*S$V&kym`rr zW&70g+E*_&SSVAxaZ$ZUeNgv?HH?V&Rb;!zs-)G@~3~@ zp+-M}My1b9YBLt<9GQHcrEO33C5ao7^)~9~mAC!RHsagIBdYG9^vsXf=E{4cI}@uC z1Xezh39;{d(CEoB_4tBKI~{($-Mi~#Rb1}r*L*KGU%j}WX(@9*bga$<+}Y)`L`;&K zSVAYs_eT5X$8HzA`#QYfX3h@_`9Dl7%zd%TS)&eY*z1v9vCzUv&}0HrB-@?(`^J09 z=S^@uqVpq9z@z5V-uCvx56?_!?>F-HXf(=J5X^pZz;$h4)0c}Y4*u(M<5o4#{t~cz zuc~H=TJ{6?Q{T1}C}e%*(mlZ0fBXagEZ$h2<)YaS-Ro7ICrhn(+St^;mv@TXj1%)N zi_Ew>FPKYbYjihrdeWDLNjbbBrUh#sTlOrN{B^a2)1ku|R~15dB?FW)6}~HIwM`G6 z5cAgZ!h~5o`o$B}Bx@UXdGBcQ)IGt4_JX zvvXMh$7UDSy`uMi9f(QHy5N3x;ij1u*M(MvJPyxZVHvsKAXe8Xs$#L2bDriEGq)=m zTTI-pSeQsDX9-F53nreLRpc(O+n#nzx%BZafcwN76`9r6>F&%Gv z{T6y}+nBf_cDC(x)h|XiJOO*tT;*-s?;WeKb_kZzOS2K;l{Y@rd7Gi>>m;FwDO1|o z!?I^>7W=$p(uKk-mup9MuY6r0X0H)yQD_*i;P*K4i(AsW5TOK*!~m0vx4&(^5nN!z zZ2bMO)`oQ6Ig=MA=Uq^VW^VmZKXd1eY`1<>!7AlH!u_qmXMXOS@=>SiaaObLwuBv@ zGZvY9rkza^6L@uP<4vz4Va0}vyJk5)u7w>(~3q|NDMB*JAIU-Mj1e zSnd7)>+<6tfBNI!{i`nh_3z)q=eOJYIUg$4TK#?d<@@E;{U&xXbMM`)tK*Sh>8bOq zzG=#%4c__}YvhxAoSL4;wY`2_P$lnYf2V#2|MKe(_4nWX^W3cHm)@R=!q)%d6EsAm z_ej--S8%_P&z-wm>ft%|z!REfM_gt!xBusmIM}Q_+3s+In9&0{&c3iJod~%lGQxA# zF6H32YHJedWBuGOvRx-%x(KXb@k zsu<?bE|z7QxEs2cUmabC}~`%9;;u=-@a?CDH_iLb4MW_hK!9E;)H$oQ07 zF(si>Ve9dG_47D|Di^AXTn>21y<+O3MMnaDv`w{(Fw$7W_vpawUoLMYtT(NBwap>$ zuIm)h;}aZqa*7{5!Mak|RkrKgjDSrGPV_3hRhaHz;c&4*=*k@dRqf+#YZ{yEuYHqg z-*-t@*y`V66y^RqU-R&6HZyj-+op`(8{@r`*HdBAtUP>$dW*7?m|5wi@XbZ0;-i zM61)zKL~obK7#$cT9HJ=)G6g`Os;OM(b&}&ZV{}ge}-()6ue<#Yl9U z-8&(VITQOlCFkwmc(ylr^JZ4foIM+vmo=~1ur&YO-I@<`_OTvw6tUm7D&>b#&4)L9 zcLEdTHGjU?GoYJeioc4)YSpRD9&fhtsORXqrS5FybUW(1 zQ_eMsds@p{{q4^VPMUbyJL~w5r*ZBAmr{+ms%0I26rW;O=he!}dr_ufE$!J}ctfU% z@WQitp1ty#DOF;PUF}jd2h5uf9C{_wM5tpU%$dEID42tR=qm7>-mRX9)7$1_=lI@#VWbyg)a|3uzPRypQKq=7&bT7@BIJk!_RB~rv3i5 zz5d?6Kc~-r|9=0_hN+yYr8yS&@7X-aUDLm1zs;LJtg`&6r+@GyX6K9Khvb{&|2V8$ z*}UiAJ%Ric<}y1ii;AB-J8^d6Zsl_KcYSwccUl*fKY4fJ?!?{o%HL&gZdtw8@m@lH zhxrxho6<+6uS%bl?(@L{&-7tJojy#srVkU&k+rlgDtq$g#LbDDmDAnN_02JV;=g)J z{bngizpf^ZuN*oIxN?c37t#D)7sy);1 z!sM51?vY88joPbR^-|AmS-q5}%yoOj)}D&DUGIGM?CKCblBHxfJ8@ZT>=E_KDK6>r z=VXO@dw#H!)QIVxIHA@k?bg*Gp`=-%cG=-emet?6va>8y?9{FvUOTb$bz!2SIrDwA z7wjzAI;q*6WBNK9C!ejWm#Tc*ns{rf>h9WHpQWpp%6z-cSD7PyWWBY|)YaVuH^Pn?HrS>$d3jtjszx-JnIb zqW8AnZq>A|`m;eoyWMxhJkm3q?)|GuNNu{w?uE}(mQ{Ji&$nk4jC!-});xPwQ@QU| z0-dKGC){zB&bq16Wv_Va%h%P1U8Un?i!Y`raxT-2nU%rp&T~dN=A7y5eRib>Wf#R> zzH4;dXVc5q+0m18BIae?-kElJdbrWDn^TTG_exuLGp3>0)9h3Ikwm?lI zjBj~vxKbn>P^@X=>NdJ{`DOw*^& z=u#Eec(tb3TJzHz%TVutW{>wM~k7o_<|By!DyPTWPVSfl8ixx*aDE+r*cZ9!)wdw9RkJt!=Ebr}z3szYXfNShCw&?ems46`{(VyTvAC z-P~>zTO3%wCPFOpY?YqMy3(bQr}y4jvFwJWaFo-9t+#B=Jw<={Z~q~u7tOm{_Uyji z?H6-6Zmw9~)Gf-t^TAEG`_;l8Yv(OLob6ck;@~!)%h$h)+F1F73jC~C!e(;R>Xpsv zc@tc9rZ?p#U**$f*vG!necjfF@!KwnT)uhYXq)(9#}8+XwR-B8_H52j5volVdYp4Q z{@kkIXvRh7P1ZxGvY-&z)M;xmR(|MHA^5gTF$Ln*Gew^K(=+qTsbn?DV z`xJ>o7q(vA)){p4Nr8dKytEd-nJb=Ovr0Sq_4%wPoiCTSrV5Ff?YpD9T2!pWCG2-e z>6&Lt?@aw<_gJY)w#RcmW4)}}d8KJKKfZh@HMCIq^`uns;)(wWFZC`S-*PeX+mR+I z9zK~SWTYtG^k4Vt=Oue1XUw>>c3z6L$mN-wEWc}SavDi~+H#yT zi}&ZZ982+aZt6V8|1<tShI7cCXAFU0fM_w`xljeC~uym4*iwDzx|_5U7O z^~A8q{{EpPa7=%*rR$5JeU>b{p6qbi8@p8J_A9UR8?##0N?pwKn6pyg;}Gls^x~&zo0en<-^bca@lvt-?33#k^t0Uq=Mm8Q1w&sp z5k~Xr2LoBP>eoiamftoLs(ruyf^w#z?$5bVXeJ*mfBUVSO6>y88_%XGg--Ii z{`0GKGoxyt(&HO%g&i22gLX7qm$&`;`RvuC^Y3oYzwxH-Sep3lZ(q;)+wZ@cbu3h8 zs^I3?yCap-I5!&x*OYCZQ`@)h&fM&0HoY-ZcbEP9efIZS(;2fQ>(e);PFuXPZ|b$p ztpSCrPW&+bUz=d~d(VX)SMiTEibB$Rbzd!85qHovYmtBAhvW?VDS6h@L%pSH-Mp7?sn=6qep)w!Tefy? zv8<)k|1Rdp;FRsEfAZ|FT)k4SH+%8b)lzwzG&ifQsaUfqbYk^xldNu0AKe#wcO-4F z7qT+CcIwjVQrFn6hI$RYzTeG5RSLOg7({(vsaMEu(yb>ix1EhyWJ>4Sz`X~xqt06X zKV%}Dq^MHzqjQQ^z2G5_OqU2{i9HkByPHjCn|?Qb6;t_ON#aBs2jM*XopSjr>u(-N z$lkHRC`~5D^~kK*544l6gkR8Ia^>RwO{;Fz{0=*C+H0=M^28s>VOJ7QSabG$Rh!=7 zf32Z==cYA@0(H41b?p~w6MdevuC|KFWN?Z2xxX~hTvEyL*;m=Ey{Gx^F#BFBHGlpf zD0br1hiam-Q+~T|$~HfHcg|)F?&oR8F3(V}&*J!_W}%c5#&=FRVoOAR{LEwDW4ZOJ zuS8}ctkKDP%%)jZ3wLoS6gq11Q`xE_t z^7_wvX%XaS(PxmkW{G8itmP}K=MBvpFKU|Rzw*5<7TJ9->GBKS-niYr`0bOL{~x%~ z-gq}Ma9VwXNlw(F3V#`kkI&U!#{@q-xs-7Ud(P)IE_>BIi@NGu0j5^Yn}Gb8AR6-gOPUJoAu4U?}U&J@>ZcHYOgM z^}^)5d2cyO48P+7?Q2VCt2D2Rco;O%xH&oB@Gjw)ac|L*0$=aVj>SLnrZQW^PHud_ z(SKW6+~lrSWKpllwNA;ZW5Hh*pS{l(Dc{H=b;PK(hKb$bZ-vNg7Kv0#X9G3{^~ns% z^;h@5K3}f&#N@y;js$rRk)@6jbAFj{EIvKkz$2r5s^Sw5uSpC3N<__9`I#`;<$2tJ zOP%eS^10Il0#}JG_}Ig@_~90({DP>5yIR^AxYyj}%PO0(?9Iy1p3v^4(Yv!=rkeEq zl(-rsAG$@oapRX$mrul1na=y^!N$3?;!t7UFM-zj!;YrCuBzu0ugP>pJzm))q%@yz zN=18Z`0-Xhd=o0 zzgYPH-NvG|^WVF6c`RCO@KZ6`TvDxnQgiWJ`KlOK%f910*PfN$)#>hP;f{Hqx>>3 z6$i%zwz`)ec(NC*3{f&SU2Qc-E-ISg){gbxYnL*<{qwNF(95vB3|!Nzc+g>zOu>04{0~=-jG+yGI^FNobkxe~j ztA+l*Zryi1As1g;_MhriZVv6OSm-!=?KRaoOFwLwyW?A`YRtx?-`N|urFUGde>FR6 zw%Mc*S}|_RP203;u0=1-+I;mo`Z;}u9`_^DqmKV)G_Fa$sT|Q9CaxFJd!kVyL969SAb=?Bgm*5EW@Z zf4t+}hTm27K@}?YK~tI8Z)l(PoGcMP$$aI#l^4_(M_DcPVG8Bp@0b&|(CtT-)mNvj z?h`T^zpa?jr+T^AM?yo@pyhdzz=i~YOP7;a?@af7!6<$EZCq>>Oi<^_QK9jSeR{cbQ+eZ{FZq1Ml?p$85 z!M@2^U*KoO*H3e`!)NnV-ggl{`>f1Wecn-pTkWhWXP0q#NT1lgP02-bO`;xmheC(Y zz3sZM1H3+k$8J8k+t>NxF&6=Oh4?osR`fEr@`reCIpy%}?Nzot8|_=(a;}v1(0VXq z?Vfdww|`zYw(^_QtRhrWzj94>N5uEVdJ9v|lu3Qu9dB^%_=D?O&vxr8FgoZ8{QdAz zY3n2|_BF@9-wKcRbbB?OsaN&T6#3RAAGuQIZ`VAyxP12Q+*iwcJ}nnKe%{$Ta8+bl z;=TF4a}*4Ji7h{TNg?&cqa@~!_e|rOBBr^>XUE?-su|w)g?swssv{3sO_yJ(|I+I8 z=JyhQ>!VqBCuDt+Yjv)bvrzMknr`}&`J(|#%!b(A%amueXa733ExzQCe!}jWV5cj0 zmQH#svPf0K&Nk}qy?Pc=b{X4;TOxjGusojs?Nw|+<+DTOxBl&8&wTs0;-d7X1z!U0 z{c>9J(Jp<>`Ea3WZ96xAHjnNP*8ghJp}C-b8K3MqpZa2d-r9K#cE`RqbiAEuf49#4 zsN$l3Q}!)hbW-rE_J_Nl?af^y8!p{klTmsiGN@SKZ05SSi!q_$?=A@a(fPekM7D5E z{in;%=J}*LaP_>;xNp;V_KJ9(-ee0$qXRr)E&qd5YBv1%^KAKl=0X|soA8@mbGcHd z%dTQ!2hEHgoW!UuU}#`ygqSKotd6_gC3{@7cK-Sm$A2vKd+U8SLEuEt6BZ$XNph1o zY=X6ECm0;M^3z!3yH9M}|EFfh9&W5( z{R1D_Vvh+|w6?@M zygIm~D2~TW_}pyO8P;D@d8cVVKP$F|>-o_s*J2FW7aSBwj^WhH>{)&A>hT?7ceI|j zX4FYj;X=B+P+&E>HQ(iLX zs+K$4&(}(My_&;2Sv>SypzVQcTi6~vn)`Fw)`E*N#aE<0d|tS|_0ln|11hGP^D{I< zPF}gQVb`q{J2O}4)iAZKz4?=+F3^%Ch;J+B#BEG=6~|=OwoTL8m>@ZO*+&=tvu$gu zxX!k(-PICS-?o-v)78Z3c?-8Xy?(T{%FE?y^a};Sr93NdT~+YCzEN&(`#jHUT?gkn zD|o)>opYqR_1?*ovre3Au~bYtwgz#Fj=ZM zh;@gG=TeSdrE@1wXawF`dP(Jx(Xk@q6eEFctsd3RN6Is676sM!@>~vWl=3aj;kH?J zxI*-{u#(5?hyss_&Qqa5&7o55FB0w>Oz(>fmRBmjQjuOdNn;}KthI5m@$qx-{rP_V zc0pBDdHMf>(yG5NkGFsPn{R*r@AFq*{{C&BpJ%_v_XGFKyD#;Z@1Hks@6?Y^UwwJ? z?XPpi>vtCqE>RNVUEjS|c4K{`$6=1}hC=_tUrR0a@-3HtcmGcN<-Oc@5aB^|*kt=_`8;acLZ{8}G_~?#Jnv;jr&UHJ}_q<|b zdw>4`pXpJq^LuV7ns@Gfnrsm9@R0d0gByzvv|nQQ5Pvf{`|Eed7xP*q-mETJd9nUM zz}+wbzG+d`94=l99G15qS5In|2xAus+^|KKB}uQnd0v6^^Q#QoE}1L*_}Be#t4n1J zcfRQ%bGeqpSnlPP8`z3<1)7rHRq=Fuj=I2<_55go{*9(G0c~DC!;9tzG%v(IW_G;j zn_O;RR$Y}PX!mNO(51y+YuTaBsPnYKDf102hm94#T1GRmxc=M4xahsVPjk0e%FW3$IwS-6nhY{It)3lU z(D+L8S&abO;_#HWS02om@Kf4;;%%)@+UKS31>Kt0k}+}Ss;~+*KS*6eR*k64d=bp>qVM8 z|K8Z+XSB26+q9qqmy2@3+Fx0lg)}@rYVbrfReS3lczJ0VVQSw=5uv}X5Qw& zY4RzZra5yQ*CakR>eyqiTirSJ=i8Ljr0fS8JlfiVE3f=L)%#^dF|VSxY8>{ z{r>-WzTYWz|ME$}58qwZ-@j)z^Z!3TAGTlTH|O7e{rYnA^>JKw_wKV;+Ezc()Jtxfi| z>;`)wr?4MxNAy*876>jqkh-N=;6T0YN14ShI6@pB7#Vx@C3&RYa(l38momqajcs#} z{QFq6=t^Qk&CdFq)Ox>7^)`IrVSaJ1?$ZSo3K=W&Yl|%+icC*vUrZq-rVSO zTw8Lb*_|gx`97_i_F{_zpX9-F+`+kZ*CqtE?8r?iy|$lG^_tl?ug>n+H~CEmA81vm z)o)4KaplN8QD))n*jYDj9^=$Ah<%s%-mBwkZ2A#R-Trr0+(KHf*?)Fijb7LL<)x0k z>7}>QE$6mQ+;{0=l6-AA$Li^`YQMZ(s`u?;Ics8fb3tqNliH@E_6N)x7D=}i+?+pI zuWPSny5FWhFWzbhXe+MSu3?iMC)v2;=`!}j2w9eTY314&MhU({0^4qd>21|+Gu^mV zYohws?6_>+omZdTeBCDza($}-3(u6uH(rJl4O>FiO1Is(=)O_&=!e`{i`1X*ojEad z*2kEN!vdB6MGgsUof@ul?aZ|ei3iR*zfsuq!Ev{uz{h*eT_?0Em^tFK<(nO+R~)ok zYx|2`ck0W#Z0hyjTN;GCZ&&qW8qZzXLp2 zS##fFliM~7w>PqUY+7;ckD&8Y$&h^=2XoH9=sVS1YGBRuVZoaTQ^dTQ#7{@tF5Z$p zt@+a7a{?99k9^TqcvGLr=3?w_Fkhm`?O?QC@{O%pZZ3irGkPv9?qf^p+FkT znWW$qC8M)($8LRi;l8bJ-?x?pt=EN2B<4)5m()M_xn$n= z3ayTdd@3y;4spGjuf?tWz^G#V^6kw!4?X?}E}ijzd0#H){Rx!{Gb0wurEsLp*5EoW z+u7ISyfgM{+u=*TVef8g9Zcc99UT0)?#a*KHOEc~tX8hNFg1atcgvj`cKh5r%U;=t zADcF@>cZZXrz_c{XRNvG&Uom?(fa8LNylR^Jmb?n5&2M7dlP3~z&~TbxYf6It^1H_ z^tHys=1Y;_hue)OwnctkV6)%GK=CwFu^!)(iK5m|rn7HKe-qzmST6hZ=F`S^Z`Rfv zJ@e!+L{njw=;3sAR`#x*e zOj&&`YHw~abD5%Iz{0kbIZG4x)7%n5|0vX@Os}7R?eOPA!6AG*BZ5}%zI*BW%H8(* z;^ih)Fa15f2u*zP>Tbn8o1ZnBp)Q=~JpC3wEuOMTL)B7^DeUzNM%xQts{hnh?%mia zC*;XtwYucK_}N|Ak6jEJ&vn=5*{%zFCae?Mwa!O6xbt7jwd-R2y*_bBINmbJIk#8?h7zu(oJ*%s&X`O){7gfgQZ-};X! z%$vKP`@MECceLEm$Z@Ky_pSd!xy^U0Q*4e)#^`?BzhC=))tg?iTlamm0w&yfkvL<{ zo5qDfKA&qoeLR^R?BvI(-1R{rp(W+qpOz-A&Rx?__>1xBuH%@L!+)4}8s~GC)jlqq z$q_-OiSy1T@jVE5)uhIx%VqrH+@g~j?&*H@r!M*?-cs1LWd-Zg*#>bh&jl~Kzap09 zv_o^^jF>8!124=n_B>{5o?KhI?VlWHqW0q12ct`*7~Zw##qhFCD7*G{^Zn?pU$dVo z{HUCwBlgDPp^EeFj^as+xE8$%Kf3ze-+z~9%fH?z)${fBmbxP%6(N69+3&Jmjoo!F z*iG|5gMUGN{O#t%eCZd-weeGS@m>0Cd2R_;uwuDIvZZyDw9`&&f*$@4TCG z=99bJQ~yJ(hq;*U?p8S2{~>eN*;=con@fIOzL@#v_Ffyl%lcKbEZ4yccC`%-r~=uqEZhX2if zo`(A`i_CZ8^4VbF=VM?stA4yXa9tTG)b|U zJUSc;Yz&M}H)YR0H&dW~!qehse(ayEXGe2cPgmq`_^?Y?+WxoD6+MODP4jB`l$`gs z-(7g+UeTMa(|2s=UtIq!z{!Vq=b{yd-UZt)UFyL1eCb!ec|L+FjB7OG?taLP@iFs(k%}l_v~s zQu{*Z$vyIXF3sHD%O#=tWi5-&Ta&pHLSAUS@!eH_WXe;HSDRgfHqBhZ=XKD^b!(>2 z+k?RiS$^+q_sLc8etWn_bJo3OQ{U{dSpOz|^ zwYhtLT-p+_{ca!2?L{W9FUBcPd~q%N&#iD*S&_QcT^qme{=QnsYxO)I=U|2Ht&Qmy zR4)G6FT(bFcYwqUp%?c|xsus;>{@eH^!Q80cXPMp-X!GLh>twflRBioP z$FO8>+qe3~4SuO_uUCsUEndn0VYRJa6k~xaT5hLF)`$D#=oZ?t*u+KkwTbGKuKEZD1&t z_Gj<*7uREWuw1;_xZ&n<<%XF{&;IW@Ci{YgMPlZxI<_zGIsRQV{_Xxg{*~MO)%8nP z_-6b&IiMU3W3qiqbMmj_SH=C=6&hF*xJ-VVYfJ33h^%5LnJGDQW+cOz z|2F@Mm;S#g5?pO9eSZJ5F1KwC43pQiE!xq*< zDgU`fq2bs6s!9L;`<(y3z4K!7vjnrBHAz47i$B+!YX8sXRf)~b`FBVN+~aXohQg|UpFb@A-~UoKpVymW~09;1rm0;kb4X8Tus*+k+P{@w z|4*6ngXh|p`AVCM3hJg^J9$F5?`QF{NJ|TbdpZoK{r%+_793x0CcJp=-qX*;8k$#k zzfa#@Kj*RJUslWHp z{YQ8cg8uOrZeW_R@6S?y+ur?OcKW~8FJzpt<^QGS;&cBCJYPQVV*IZyCO^IBPg_>s z$$o(44}YN{^Nch9E~WE5tAA;1)V=>pr1e`)!y+ws3bKKv2?+rQDEu(arx&DVdW zSvBX*)PLN6Z=S;f_6sa|sTc3H=-*gnx8w81FqZps6YIN<`qUNHw-|y!M z+<#F2>d4c_3o|k{f1R>XiSJwzFT2H!jW22~RhHjbp=iV(%eU%K;+*AD>z_V)nm{Gj1g{wpA``X<_kSdF7vXZZp5=gQPX9-1g^8v6}xlgv;&HVg9Ld;oWl*Qh&V) z`5>H^_pR~WuE*uZN{#vd-kG>sq^+L&A^4z|jf=mn{jOh&d`pZnEm<937gj8F{3v?G zqSoozck|DAN6+P3zh_^~nDOb*bV&hsVas#%%0^EAdVdudC`>x=O>##&&p}1rS)AX4 zSK8NIyS06i?2463n4ZjTxy9oU^Ji}5_rD8*V>8`Nw9_CXKuM*s2V+F$(858@(#I?|Nh1vZ*oecno(> z-S^X}pZ#0CPnZ4VBn8Vmhom_~>;&}{T~w9XZ)m@7{w3qjovb14t1)Zd>)yy_wLNy> zt0Y~bOYNjJ<35W^DY)@}vAF+7%XssS-&$Pn8{-@QtYClF{$z1=VVCKBa`1M zd%53wEyoa8^@uNNjqZ!yJ*QMWOF!B=tNFa|lvJ+b7u)!H_3C$QRXZj9`3x^k_1e{C zWqY50?eh2cJq|57vg4sabt2PG-{Mw{t{_S{=!kZWoFNh&lw%Xi;wiL*Y_Kd*2<`up5Io%G0w zzqzkI{P##NFM181_Hx!A3up3P7hH9UZP$vl1zeR|Q{U$EFS^FJ`mm$jZQ+Fa^72$4 z_vuV64yu_?=WR84yQW0n>4}BmmnqY2w|Pi!RaQIh@bLXs-Vcrq5;bCrrd~PbG=b}t z?G3+Nr{^8qT69~Yt2Rta`bc)SsBOLC*9Gc(1=cPqV&k52d1~AX=& zOxOAF(;n+9T~Yc5mK}CwUuvX!1eyKotfTAGV_W(i&!_qQ0-dxyT|zn^^8Yu(>6lm16H z_#3*kSFW5XfBepO15=INygy$4Ewd7xA^-8)wv~MHpEpTpUp=(<)$cz`g}-&5@yLEK zkN0SpvBW`>x!bh+Z_eXM6^);9;H#_CLA`5yhmX#1-1_M8oocPv;0D%^Wn8QI9^IA* z6AtN9_RRgZdqVEhIcXC0=hx`y39T*li@KZcq?tB*kLT;t~>B#ZS=kh@cvdHL&Vze5X}H}uw={;c+Q>*?Fej%{Axgm>?r&%$4Wk3>F^`5V9${6y@3IP;lxi5ZXTe@x4m zR9VNq=H6w49p7AD6#w#?U0(evtC+bu#k|QTc;7E2KkepabEA_j)?57gE&Scso29EO zs%VOb($xif4Jt*h&b;hy`B-?*-J%H_boBnZ&oul0wdo6^P4(w5j(#C`!k8Af%$>h~ z#^%`P>&`53UA)G>ZRM}c(g9lvvzugQXg{w%et&U@luM7Z0z2pCt)G-vOyS5pdA7p) zRPJt*?XrS%3adhOYjt+F{Qkr{W6tKe^{Rp!XUU{0^>CPq``-z9b1VNbr_>Fen(s2o z(e9S~1vazymGgZ#QW!BQeA~&R3+Lwg6mH_PDP+i&UhJ{t)fCCN+1-(kw`FfMy~Hx< z{~x1gh4s=)8ZH^R*9P3$rSx5{F7Y($!T^aq;wj!=qg$`;nEGsD=XG_9=9%|jz1WeQ z$M95W{*trHUY76Wn3B0OKXJvj4-!t+R!+6+lm9%4Dfn~xpM~2p*ZqeVUB0^X+6S?} z6W>bhE(hw7);Uvek4O3=4XPd8bOIK)L6k2|?|`V0|I{YxyD zI4V1iyUo0quXm@fJj{Fb4+THQ-p{VLm*zRDe0kWM-zk-tWcht%Ps)LBkht%`24=R(qHo z-`~gy6iJz6u5BN0uP|#(zLSueR0~J#yM*csLOCr#N1uJVz-4gZQ9XOo{2trycME5| z)z)LW_~?M)692Mg+qmy2rq_6}CJ7Y({4TntqFhH_weUvNzo<=YsnI7c1l3Dt8s4f~ zC3-wCOHSXI>*n5U$MuPe-40Y=ofq@=^2CQ5_at&HNqT!_uZX85d-cq@#fnj1ne1;& zTXp^8WA7LJcf;0;9jpGBa=83+9?% z7Ap&ScdT78<8t}jlanNpoHV3&tbMWnD|dY_Q$y(sqmR>D?xnTK?T_2|P;+?^zw*H; zcQ+Yp>DcQSD}TLmVcnDcI!AVIZ~M38;AYR@ws*^%-XByE&XLt9v1|AL&67eyE}5(dOJMc3`+f2Htm;ZlGowNgu77_`Ua{=I@j-LFK>5Q9 z-kbkcm(^Q}y!+j6J$dud_da`D`d`<^>^ZSv**V^Mt$VFZjr2_=vww0-4J%+ z!l~H1?tVXgu5mvwxp5>o?l!05dY9PTNzwWh_t>}XJHaN_G&j&uZ{o`jQ}zW0UtM$b z_)pjP!vFtX-n;dahd*G~*`yPH+E_S3b%Yf+bnU)jo6Vu3QhzLp^To}5t`{DiS?AC; z+ilG@_EUT9O9GqTpH-|hp1U&0+&rqlGul-?!WT)In8-PZtha&%~SaU7uMUFv1qgj zxoqEcMo5?YJ6}!Y) zEgF~b%3k;3TYvi77@)SPk%A4Gj+k1>L2Gh+*aWZnqGf&>XdVRzkZ%xw{Fw(AD?HxyE1Kg*vof%4`k{m|0+rU`|q%| z#IKoqdgk@avaXY^ztVHRZNm9`FVf>)mB^ZZvhiDbJ6R@05Ey*w$=1m1k$tYyY6!`ruzF`V!wXf6$31s2&q=jhac}DPGb_R`ehw|MuPvA|pV7oI!zAHM#Zwz5ALmtbmpr-n z;KB>`1`UIa`CcJLj}#mG)WmMLaGv?R;KXAF#-~$vMil0(I?!-6R83?--uBfmCyEJf z&@pduSo6PcLY0+;bkx-P0&&X)DZiEqDgOT++HTn7Hfw>`>+Nyt1VZhC=IGvNFq>Gp z?>Em6n~D=2Otxi{BW^I2Jk7g2m*d>8I{r`bwkbLG6O1>TKe_WIFt0p8!)J=#OD~a# zqB--7{w99eeEx>2^$R8~!(W$T)}$3|mzuuiUK3aJcc$st$E7?{4;9GlzEc0)P(H3$ zl&|#V@Beo$U##V9e*K*bcxmam#-&T z)lF{k|2Xw<=+WL!+uhsOM!S|3+&3@`QD5=wqxOnVtcMFrT^O{UEV29<{ElV)Kc+w~ zV~z>;HXQL@f7>UfFY=RfZFU9Uw$84u`Y(*ycE`o`KFLp6W1HRh?)a6=SedU8ddyyJ%@`=u^jAZ4)N6b9roOCK+7Q99eUX!O3)d78_DR8h zQ3vJjo;-3yZ+YaKkN4kQ6_{cee6OC}(ml3l+2zXHb=O({=`Hwk)Tb!2uXXiQRR<*l z9ba3ih7VB-=d|zoqMemFMSuOPMXSAL-u~?So%scK#|g_iE2id7@Y(+ITJ=-wOV^&<+dG^6q0`E#vHu=FTRLIFEt4HP zrd8Zsy!6P96}!yOzCRwi|Ji1RIn@eJMXFwPUcB`8=h|SUNQ)vd-IzBYvmy;vS{pOE zMN4^09ef@b=G&Te{B^D1=}Cv!!~d?HRyx^|kNa505%J5fo@>dioV$cG&^oVPLI0ZH z%b$OlP8iO-%wL|P`_QJPJOAzvi?4FG3*8!iuz$6$U9A<7Rde;nx(60>O8S4z^m;zw zlt`WbiMCGe1;>N~%QYJ0l`8fW=tkaOXnC4PO*JlZW?^^9ah9_E+`As~Y%~h+TG9Wv zqk4}_WU74Oz3)%gsqW!@T;x>FE9AFEwLWXhmBh#T?aMrE41Q#FJTwvGhzQ;s@%g9M zEz5|AMRSF9_MF?g=9t*Vg-_FebImlq{fVJ-pVE_cwm0t-sD>TZ(lZqcTfoK=S$k8i zxLm8RB4*|tKc+2q&*t^tWS4oPo2FEkqI0|N$ijUu69cV`XI8o-{cl??K6$CyO`f8U z!5draLsq}OIZ+~g^CU5IgQE^j(1{bCWI zyy!~og@0z*mN`Yg|BC!t-thPB##bS8&zU253&QaQD!MYE*lMU*RRBTzje}SLr zjCUVno6a=6ms@3Bpmyw$q9EUN>&{8l!s3!5UWXJe-San*lhI^mp4eXc{@lqad6H)q za@~&eJg&RT(1!o`qxz5Uu5JwMTy<*BO14VRx<41E9;)Xo@9T~_@k(KS--CA@@%l$p z*uoFqj?cV&TQX?1`{VC^X00;DJLj|U#`@$2wCxmlv_bLTEx{{xcD)|oa$jmO)|!6! zBg)csp~BiEz%IXeOW)3{zN?;}^S({^TlZz%?^V9f4lD^Y2rl%l39l@#7wUOYIRC(> zq~iuj7OI@L7w?KMW%capT#_7p*Y`hrQtF1D74gqJw>=JiC%O3LRPBUa9JRkMHk_za zI+(Za-367drdeVWKL2zKt@x(%<8<4?*!7jVE(-Q}H8mD5thfAVyJz+-yZ`XheMd}K z>RDsv7ybyB+r!DHP@~iDB{p~ZVb}V-?eAPazG9z|9mAb+?N2yMzr&0d`>rp_U#wL7 zZj-s>_v2^QEv-zqsuh%dY31@`%ahNagxYh{6VI@FBqaM;Pxnp_4ZBsv`g7w6ZM_$5 zceoEN;JWiXb1IkOoNtU0Kb|H%WnCudDB#K|bYinmN%!u{|NgFwWH-E8n)Udhlh@OS z@%3Un?!oRIvANfJLIp%k<3BQ|9&|p!`u-%}^M!sHta+&uFDdGAHwnD(S#a~cQN@Xr zK<+a>^BIlfrf*~ZTfEETn(7h0Poj4=Xyr0z-7>lJ`$CqCp~kn~#3`*Ub}Np%+?_Os z>wdEGUxf^A+3mf*bjwV?+h)Wl{Qi~_Aj$Uox7)q?nyY^Y1`xx@>lrXI>D=NgWeRbd~oFIbk4J^>y&45G~7w5{1u#XynAoX zO@m$jQ{EKUUzjXBscf0nQkTUA7N5SW7M}3Ad+%gsa`U`3o7|@!7Wm*1W;~ zPCv_MF?><~SG=qLDxEKQN^T0*k*cn5+f5GcS@D>+rrGRWaQT1Ft$)5e&8_3rPS7yY_f+Pm`6sRoy{s*FdW zLi<)m9dSFC%6X+gU*J)zz+}k}uUo(+ z@7?sjkEgC^Z8OU5NEAPDYS-b_Jq8b}SKYeu`drH_>j#l3FRuzs-z9E$|G4nkRcUPZ zFaIfv$l+CxJ|4E&_2KNJ=g&$8o~)Aey4w5mXY5O}PItDe>Ozla9Dc0vRJXe8CZ8%} z?Jkvyh4&LxY}YK@{q&W|-U%sgv+M78tUYjO_W`crT}MKgkCkb1mF@f~H_ztsr zjkC^FWPOwQ+t#q6WC`!ybT(JBix0eAm+yRiIZJ=S=6Uy@F6o}l%^be;o2f~_tm3G? z-SUC0GyT7Kum1V)p>n>eyI-dGtYZoJ0t$@t!Xv-x-+z@>UdAWddU}TWGvWCyIdzv$ z)Jt{?+_d{~N^9%!<}{uEAE)M-=5061(lwvbEgQ==e`a^xUQ3reQ@yK`Syc`FcfQjz z5HDV-Q~7&mszann*`@hyClBZey824YUjEqy?CCwtoT#wgo~f*9nxQlN4KebTsfQBals{p`;KlG zFDQOpbbRM_#=w^u?C&%8mvCQQ5m*`e&M@;&QruxD)1Q4&mzXkG*G8>~sEVI-z4WeY zp~dUA^Re&!m|85~KRh`1i7mg>#RFG_Qmnexy-X3D|2gu%U_Sq(mV2T_Y-_K$zVF`#7*9kW>&@cH!4-+#|f2XJ6NxX z$+!PL8ziOZUe!-W#lf@OZcX*lnc#`-3OEQ;TYK>fYe*I$)p6Ek{2AUY_#8|G!7-<{RO@v=l{&XF1C=P$^~^taYHo2C1HU58GJ`-SF{Yvi1J93^@E?bo5+_tNGV$gDzf(+)%X1q%e6ilmi zlkq*UD$`!cUG|4i_w5t!*M|kTqy^ZyrkDxt@-&HlWm(PtW@Ub{Z(*QB$0U27Cz+OJ zx|)iti<&Dh{jUD>Em!@D&7}(6qxxRo<+^*PD?6+*tX&u8f5KhB-0OMJIAHkz27S`17sWOmQgBwYIc(Jj%1p z*~`0YR(zt2jI`Ls;5ime_otVqFK3?U;qmEseY(Qkw@r^jCdt;CzvbN2CR;S|i^Hma zi*sGuw2#jI)O^b^XTyZP45sOAPq}Bil&*-kx8Pm3vVT?Y#68!Nrp~VYX>ot@uJY{8Zw_QKAd)_m?-G&=#mKH9SH#y1G(RAmDuL--!R2{fFdDo5Q2Oo1j33O1J^5@Hf61G$QtsB{1x>u<%-Ym#A+GN*yG<*N5Nwr5L z_qM!puIYNbWRjjpdPkPY_Kdd)U!O*<-FS0XbBI*T9C?eWEUc^Rd&(Biyjc9?#=gz1 znwtcToIgB_dz@1xReyGG?$PTl#;V&LUdBzUQaHNi^VI9t{Nj)D=5~hu+|++XLtMc- z!M8Ir z_RH%D%iIomk*4zwj;l^}CrmO*#$Tx^oy;-n-CLEMlK00G5$6KeDJYx}^mUdn2(vP28q|@^Fxfi~2 zT)e37xbjtt_A<|>iv?KYUDJh>YCOm^DqmB%}O|OO=`8e%)9KZE;jk9_nCV;x9Huv z;obS`$BpJ6&t~s7^?2~szT!&SB+(o83udoyIaJ?pNbYuDXzsOc!`=qvO8t5>zQ~Z- zR|J#9Qg3?d&6ivpD3URKL1gEpWkJGME;~&*b}wfA;+ytQBtu@ev6XIFyrZu4nMI;p z>g~M|e^W!Bu6$*reX~ONahSjk`5PykJ8aa1L~6BU+ZB!6ijK_SO4JHo6Dp>hmCKws zol|&ve5=_>o$sIja_rO1@AF>FyFMbl{`E&TSGP(3y`^6%nf>hSO}wEJez@}3_1Tx- z-Ec3Dqnz3gPM(%)A@t9A&*L`ME~Q{*lfZ?w zO#W?V>XQ~-KV*5TEc^Y;pZ8bf$7Dzbm9>73*eoC?{OtMlEAK@=wKVlSHLO4WMCJwa z--7b`tGh!=?_4haW4rj^-{x6bwiyn4m#SWw*7jXDWXETpMd#lZEnRtY)@6-%H+<&p z47OFSP^j%;{JwO1w7o!s#D$}c3H>74Szcdmh|QLoc)v-|f3_z_pKqm{wdc$&bDsoE zb&me%xcK$W&xscG8)kn@5}20a`R`D(MgHk8bLHlJdt6q3@W$!GbyfF-C%xJpEUs@^ zyKC`uhM9LRt(ECFe_qPReD<`sbt~*=L60*WcXK&RV*2^9T zL_ROGuCu*VwIOhp2U~c(PB6pKWsUPc7(O&Avem9IwTsLx*uuK}y7H8hXEGn_tIEBd zsh;X{PVpvdbK0A{*m(~%?0=ey7+U{WdU>Xbh!w-9*6Z0l>&_?U^FK1wKedkG!M|;F zTe)6;_%ipe}VhK{Eoo?uWO$$-ke`~?_xJk3D3*^TgBVn6s&wT>-aarJDujM zXMA#6^wrn(^cI!aEl-X-P+a#VB16OEzxGNvbYbsWFBy5!~8QvP%j2mujxNoYQ$Uif4W=NB~tzVZt_{eRz3R2 z)T`D$Zr#o0$0CzNPZ@=;6*?5^)G{IU}s5QAh9(tAf){Wtit5m$mhVJy` zw)V<P@75=?-nMqh`=xuChfn^{ zQt`Sw)BIh(hwY{Rdluf8PcN|Xb+*Zsj0iW{zvIRQ*_OFhcLQ>{52-$$&)XPYU3^^D zepY|m%tcjK)`YF?ZJ#QwU@GOc^3vK5>vH?k7f)UA?W)tf2!{`5?u^d$5hskCLdtWS zit0qT?nUsKSSYFFcKu^;!-vSK-$d(A^A&#Ux}*Q?O*1@KHBL8O9O}*51^MQh8e*VeEqc3WA ztzBvP|5)eam>TIE7zn;2g&6?re9&5%wmrLD# zd(87J$9bX*Q(o5Hb+heBf4t@K;S&pMPc7wFazAAqaKj+f<-^Y4)LO5nx!WIf2SgbO zT*#2Sxc9-gvr@_Fj`l$=ZlAT@ec6&TQL&-;XW+IJj~rj$r;Iaye&GLJ=yGJooYx^& z>L*OwT$BAxN=IeB<|4K%({qdEYj*@Pw=8|T>%2$8KmObbd(T7OS7#O!F`kHwAwmXycM0#@goa?q;nAux2`CZf@w>RHpt&UB2lk~4INg<a<(* z8wajpIsJ6&zx@0!msciNxNbK7UAt9b?JUkW4`P;leE4&VlU}G>(AMeoSDsD_T|9AO z+?jIb1B)CB&buA!+8(=QOT>ZKk+R>S^Ccf0O<7u=Z_KidXZs|#@(*5{*;l@Cjoy0O zud;nc#Jo?IeeUZ&rtIBt=xAs6gZed&kGE8Zt3Qiz^w9Eoy2rlbhSOx8H9G9h%9_a> ztempbP0S5vUY~6cEZr82KhnRR zJK)m1{69W|6W^O#@7dIqcCBG+()&Hlb~>5ox65<{-K+TJ_4xE=*XIJIKSOVRWpe&j zKhsuao_x#XfD0@8KFL%woqo-D_~Id*&KaT44g^iB5p~g*xE-?hZt9Xdu1zl$udjD^ z`*wk8pS@DO=B>VqaxYx9_FiLWNVw9fmJCI3}5utj!fv;_^SfH|}P=%Rl37YID9`Wt(+lLdL&O&zXy6 zawmnGzK_%NRj=7}qj!;U&?WE2b8_$2rY>sv+@$04?N9Pr!yE2rmZVNOCax)3w*QP% zXvL}BmyEua*aqa~7CP_m?a+)`v*w$`6}4qGMZDX@_1z;3GBSS5Vd|c8Enqn#tE(BS z*Z;2OXLh2`%j;WQ_Z$%6+^)tDcKi0df~8AhT~uBt&prP8bmZNtIS1Q+c|KXmeBWUC z)$^q?T;WIZGQu6RT4FZ7xM$EYUEz|6{+WrJc{}E7-i>)u?YFOYgHZ0|dlt$Ycj%NF z3q6_49Ic)4O1I4+)~h`Zm^fei&dBz8||tx%P^-)1Q`)2AyK;my;&wojl~&cUP$5_tm58 zo>*=(Qd6ENzOy~c&S_(V+FaNAb(^M4xjt{XychrKuNA7i6M`gm&ARX;S9;}7nb}Wz zT`nwNc|!l%oigX(>@!Xa*nf%c-!8H?^UK^-aUUh!bXQk>^mPzdp8h?MoEGu>BS_9|Se>y)d{ zeBaZwRn#!G%zJ<2xj_2~^A_s+ae4TE`Q^O*`LEv%E-c5mYOBR;r#Z&6IA^XzvyM?a}it$2AVgoa;Yz{)K4q*T>aj$LkgC{=7dF_#z{CR{TVII(TewB{!oAf`&UW_3Z0x!g@Ni~w*?Bi>HN{tA{x|RZ6}pwbMk9W* zUqu4v*7F|Q=7s9E=wCfE`7P_a+5oA!cTX2v%@z1OpgmC6Po3S+1Wsi`^N`YA%ljnTpHkt2eJmc@I-i|ZYLXQ7Z``y+&-1*dS_fMf0 zb&p$GlZ`Y^zS6y(KRs#f-Ph%F>i0PP7ZSVb6j<%jGV7@S4f%VYTUM`O=$CZet|Qjh z7jwAs_HJd@meWZoC4Ht}A_Q+391?ieeO&UpDx>Pcn8MIiqEXvV-`XGYSnD$HqQg#o z$BwifGby;Y>ABwh9_4>={fXOV_OF`S`L;grjmCq*(_44(|N6R9e^$ejuYnKh zFMOK)!}R{q9kP%3Uu}7_@s52v@6-Lt`(A4;y&|;7chv%KL1#gOPtggfc8^Zn{QTqR zQnyp@AG$AjRQ|)b-(h>EeV}4>WUKg2(XLR5pHi+rH{Sd9@1?!jo5M@G0{#8Pg`Iw_ zoG?#Z`rPiB=f7Wg+-Z7e(ZuAuRJV}VGJb`5ml}NQGgoioiqQ7IVHcCdGT9oI-jHYDciE#;$E|_&b|kuXU)If62Tua^}~^Tch}v`w*CU8&vhKe2%EE-SB@o!`<)NT|JL@ET^fwf8bl%z!P!eW7+}zu&XVrZcV&4l_Oy7 zh01~#(lup$2_H9lYwp|LnJc|zjluEqp8L;~N>BeQyjv)tJ|RiCb!kw78|$G>iZh?> zNj6fy*V)VH>2sj@yY-INJsxa2TrVEX+Sa=65}((v=gW0l?r5LcI;p-RaovZ!1nuw* zTQtS~G#uHP-L)uhQxlX#?*y&YsxK_*X zYoYj;O*aKTPkeDq-M-%JwapgUS!vaUm5lmvB@?<*4Aq{u_&4f|x(nWy?F~^z*nJQ)2PVv8yrr zVYNA^-|L!~^NLkr3+xVQt>Tlt+w$5lYRR|1O3r<|#ro#$Y`4^1UVJBAIY%k(xBppN zCB?k>n;bFc*67UG{;fi76UVblS-eUT_Cr-SNojwIF$)5J$achM7`-K-mw6D2TNX`3LGPh1| z%DXwq0j#f+y3OK#&)C2604KXy+@%kHlvpemH%*Qe(O>-2XScFpoq)@a{Lpiy#=ml= zbnXuFnte~EqP;#@^pJoPpHuAJoY^jtyjj1!LnV?_lREkRe)N52Guyy&Y->1+pn5%j z<)o`Wg5|C2bM$AdvI_T|CABCraY?j6L;KaFh<$2?Galdgu`l$^+Vryve%M z)#A40mkrv7BgC~W4WbKI8`evusd}BUyS4PMD!a>ObEOC;o0AMj9v=MQuNi;w#nshz zLK$XP%3C_OS6>u;dn(DJ`v1`>JM&uZM`!r)S25hMy?*_to_^@;-(4*w*BKRS>1ndM%J!l*SzDNtloTcO|<1s zn`+sQ@09j^-7{yN{_=qGPdw{|%z`H=EsW=TByw%dTjs890hCvVA+W6enQ*<2*= z&i1IfX)%}5%{A}0{dvK2`B^SkD2Ln1GgnN!g%Tyc=S|-gzP{UVW5iZvmkSaC0nEvA z<+seA-L2R7e}mt*IJHEs|NDXE{gx^3U$M^P^t7CC{7o>Uu}*G+|H=E?hHM?F-<6@fD&A{Zg9Hxlc{+909fe8xnO>X3CiqKl z%4@q8ENpIWIibAYDp)euG%Uz!R$#!%gfh!bUl&dC`Qf#pK5O865%b5Az=B=wbr zKi|MI`M=Kh>-^KS_RZ*-I;*hhjCDoMT3s8>OKBezR~71~hg{Toag|+uhn_?IpC!LL zB7PV&Gn_SDcwT6{ zZSoU$#r2=3RK2_}xu2cq_upk!NBzw{d7NUh~*K^zH zX23SlopU;Gy)BmxwYw5F?^H_B)rDeTOkP+2S514pbY7DHXFz-VX5G*_=EVoiwWTI9 zWUNvuJ<51zRoZ^Hc-;f<16p3S=Dd2Wbdlk<$QIszY;8hax(75bin(tU`7_JfYn@k8 z$BembR?7r6M5ZxB9lVfVk^huSN2wqDp>smFJC&bPeoR?&;0Jyo?E7TZfS_3eDloAPPX#;84S zj_Ypi`29(tLniK+#?r5g&7bUgv{Bsk=0Y2X&--^Q)Ck*W#(OOn>eWBkjt)l!Dxm`P?mY#~acO*+Cc7{{s z6Sl5Y~R6Io783G!wO`=&lkW)h3x z6SJ&K*B7Tt3Qu0XI`Z}7>lauLdIvS<6+ha+a`#famAjC`sU?=#q1!{t_D%HR|M)EL zzUw;K>buAKYeeIe?KtYcuM=N;V&a80UtM*V2F`3*?tffRD*N8#@HG2eQNikr-*=s?9jpC%r+D2x63)cN z*Dbp2F1txs{G`v!%WwP2%)1dcy+%S_aPzHeGeat7JC%#)_S*i_s=4j2Pc? zjwYYg&NJMO%nf-Ja?Rse?V-ZQW9saOavX6RY@jrZ{P zjPpF36Na&57$ z+UsA>zIjTN$X%Tu53X6Us`ejBwY_m?tFv&w^(Wu!^5@P7%X^j9)&#P(*B(2X+_J@D z|GgVg27g{H6f(H~-y-Rj+idH3^`HIC<}3&{%T<2jm}G8~S(bESe_mwuy6iZK*%|eF z-n(cl`D?gG=HxLrSrBq+VwqtS}$gz;^%Ym`gAEjsKANcZ|q;&PQ4qZFTeGiuG=pW2kWvn#W7C!MMvMuc8 zxqod3-kdkFe;lA%U$?WMDDAMB8q3STM?p#&wi>gq8>L;?B_}NKTRpM8wDjYqnY(n8 zjlCQAXR%jqI&$$%UFG$f$#15`)gRrsal@vH{rw@9S7zjNmd@q$m@!fB$n_UO(;j7vE;D|tbx+tq z<9QWgAF)f+5U1dkg+MCm|b}x1^ zD-SE?x)3M!gJ(nRuO&JA?OLWk%aBTqG1d=g%Ad16=yl-EBRQrTe*$=x#vh++v@*xc zX|kKZJ=V$R-8*aQ4^*nTax=YmQ(D3JdS62J3QfP(u6(GD zTsB!U#(K%5pw}wq=NvdQqxWW`X1PqvKjDW{6?|+{{+?f> z^2FKuvHZELT=NBjj}|@TbK>dVQ@`U}?Y0k}%M)B`W~}dI?%}Yv?Ns^t zS0|3&%lt~ zYYMKG|OEX-nO1TQZ)jiK$y(#&G_6cgu!s;YsFm71FF9{$-Ke zRCwy@wjH5+i$c?8ywks~nEGpbb)7+OqWu1%&iIYKpLSOzY2OgxzdozW==s?treekO z&)!y=bmjf5ygZkaym{5TLRP7~Tl(t!uNkFrd+Lkd@;*HO`MK%qyY*=f&hzHnbAR)E znsMME*TCdOEL;o!NwusxCR*h>(NlGqP4Tr`bB%#OMBD(~8tr6sj4*Tn6& z89je*Cf;&P!#{Is+>9s39IKYqvkE^{zhT|Z5vMwLw#&4X1GjfhET8t^-_v<(f|f@8 znk?(sv7v3DZY+0G$JDN0(`UKQG15ET&{27%Lj6dax%&$v-N|#)1ynRK?VIBAK1W|UdDV^HOpZnuvEqOa-^%8&?%J7s{!??< z6^*2+#~Y?yT3S@P?qyx%xz7oP9rJ6P-ne&*`L_o<$gX)IIQ3kEUhYeih#5<2Vy|k& zw%j)Md^(5aLQCd`ce|&p%ZgE2QXbuyylS#S{r)qv7Ip5*VO-_c80jdgIpL^q*xRt# ztWp~T?(+&+vjv{A-opH0isW-Ca9%s6j5Ejn(|PZ0;6uw^|3E&mE$f0SV3&j@SH z_?EPaH@m7{P1}6M)OyCwozaTQcI&3ImevS~u3cNZH1+v*u9=Otd$;+oe*EawgudA! z+s*2jPfhxg8oP6Px|5*zpV!_cj{n&1vsrAv+TAETQ~GN{$n1YFw=6h&Ve1Zw7s|!U zl9DPsl+{XdOeXw)q+{+LP?7tD!JpLX_Q{fApttB>uv zeXClY{o98N8probJYBH4f+0cY+L_ntUwis~JaqR8>{w&Xcwp0p@*@r>D$C2hhZnDj z<=DcuC%QgXCpuYI!Y$@;NprC9och3zCl^~7pGZ0>w?A)TPRal1iuI=XvsVPISnqP- z#XXkA9q+|6*GTSbe$iS{8zy(rzJ6i-;Yv%lKIZFB)_Z4vIVR_#m(>01(Z(`qw2EAydIykR`lM{ zo)lIu5G{V!DsY<1q;p+GMihfa=UmhrPmN=FT{O?7^{0Uv{m>*8Y5-(l<57d1`Rnba9QGvc-1x)$i7K z7>{0S<36n{Am7+>t25;9hCPmK2ZVMSabyIjUbNG2@TiwLU-SF#($bdCrEd3S^r87&z~8%CpNA0 zM%cF7Udz86x80~#|7wE+yG{0Yjd%^7tZDLhO-z3rYmmHpBw??Y$}{8m)f$aK|0lj= zxa`TgdW}@PXX3tFo$S)jD{mJU?n%uy3TA8VJe>EN^={yl`~8>JUDB_7qq%>*{gfA1 zUZ`(c{cN&VwxNkp_k`m+;x5~)Qog!ziISP);eU%ff|FV@b{wthJ))@Hv%-H(5OK4i|-JaauiqhQI?@#Oene*z%vXJ|wQAy12h;$?>(;r;bUt@9&e9DronaAGvNhXDh30c-E_~28Id!2YFxM>el+>iMI&P*{dFS_^^xjo` z(?XQ<`|_L5UO62tOuVrxmiuTATi}8{XDTN>tIv7Iz?9s2z%%U2i-#xIi@l6we(~W1 zpZrX%>FUbqUw$UcdGLMr+=WNx2TzQ>6d({P{_yponf1pnURwRldgqjjiZ{gPtrstK zS$F$)$fn!Ie=n}LKBVwUar2&QJw@kNPis(G6A*wrXCmCxJ-!!22O-^%dbOc1-H)VJe?2CTjaI=J2YG*Uh$mS{h!yVc(+z>T9Y#Sv`s9 z-R~j0z3fN#w}6P$SGmjPFt_Eoo(=HW9aT3ygZa~~oV6*(_*+&8#-&d7OI>n5^NP%r z`HJfs?|yn!DLnbSuCzy!`;${8+-#0(mY$mT`PtgiBS%zoj2DXkUv99!-rIw#P_SA~ z=K8fotIQ%#eV%vv>+6C$|Eok#bpCwzyFHWV{leK1uVolp;?*~vEIcZ!-F-af#`MsT zlf{#w8Ehl(rki#2UW#EbO1af>FEFzGd4QSq(u{@ijPpYx9=skP9o&S*1 zj&uACFBUzqd;MC&;?Jg2D_(ysez&`xjj8CHRD;07IHxXMvkQ*Jk-BS_Z1(%-Y_t39 z)+f8}@4ueyA2gluc~D-MMndTmx27z%=)MU|d@q%@7vHtBo4kG38?m$Z%+$|t*Pa#2 zb+tR>w7_L%VsW!qMa;vWhjy^HDNQodbX6CxI{x;bYRBhBmsrL=QKgydbDq0;3taDE ztoN8$>-?_T-h9tey_?sczVnJSEI;Fx$)o&IN5Z=5gE?27_9u4hzpIq0!meE3)Maj? z`IhU|<%eGSmt&q(=$dghbUokgAuvO0nuobeth1ldzR7nIlN?TeEYI)d_}*&98?LgV z{rtA~H(YjHowbMSLPKG|<_%4H%R?4@kNf#ZCNZPlEcToJp+zS`LjT6TPMBdB#oM(a z>B2Up!Uv2ZDH}w-X->)wubr1R?+niby^AN;CiQ1Uean|gP%D1C+l4DSLT*uMLzko0 zs|nlmO>Y~|(A}^zu%*gUEK$p%O7hz3TLsRxb^8qK3ha_?PQ1LY>t7@ndGPVH2cKre z&Y!SndirO?w{c+)lZ$;`sWh5u3BqLslI& zaQ1s>7(c7>mSYCXyQ5o{ESs=zpZh`^rpq4C@#}W5x!b-(S6+18G zeZAe3|0QFE`rK{P7WK5BY*PJw`Ck1>6UlU>yO#KZ zB~IIvuZT)!|2}t7P4CU($bF0w3^K;4c6s;2dVg?V4BYLnw0fUV`pRr&cE+FU9THd% z*RSIc`eGOw_DW}~N1f1T*~Z@ipQK+!Jas*>wv;W0X;R(G$Tjm9X|(&_zq;;gbOP_% zx!2F`oxQTdL{p7FC+%o>-QSDR*;v)u%0k4hP?1EKR-8WJ3h)7%A z$;kY(F7&19rxm7Cyq~5jU1mOdi91jEfB)Q%)xW2hxPGhiI(~`udH=y_+~;Zw~f$=Pan1wt+QZldTMcRy5K4nVJ36a=@-)2#RLs4 z5NDhjnHZWFg3dS-Wid51Gk_d%HfK9)NX+d^dR@C&uU~K|C@<%K_wG{0<994g(FIM; z3OlL`%K7yUHai#8?mfRRUH$o;@ArQnlkT~=W_{YpaMRV#V!9{!MD_+=xpVM}(<#O$ zr%s$Ya)^Bb>rBgr7@0RdF}{1&T1tfKHsqD5on!bQrL8Wcx^&mp)pL*jU()KbGV@{m zo20i4kAAzy-?@3{h^Wp)gF@EXo|e(fOLTk~*X&^si?b`^v*Qb6kmlCDzF$;!&QAue zYiVI>Vr2}b+QRAX+$vs$?C$#M*$bv>%RiX!&d@8Vdt*Xtw_wiMV+;YNg zZuob&;n<~HH;;;@B;_AWN&ob{nd8E}Be(ia)}J{zZ`#B9;uEKSZ9n|K=N0R+H1=yh zuGg!vr$6{VTh;n;{IZz;%l^yD{qtjWNPhomJ-eW}v3Ri>cd>cYvi|{-x0`Kd*cmZ{ z`HsUgv2zTjk(CXq74ZyZ^`{S>V#ws4&}zJ6$}@&w{R8o{)mWD$e+;kj6Z13EW9Xf_ zdbP5=@#pyZvT60YhC3sS8g*i3W*$_X#xk?p`o`_(hM3q15s?hfuBEMG2=ap})1WwN>=Mr|b9a{n;J_&9H8Gv!`ygc2hTZLfG^x z*Cqrm`!B!ig?y@^A-jJAKX=2#sk5aIoIJ$+An`fNkH5=-+C_;P3lm%oqNw{+Pk||E1T(gQ79c3}@fRUQU0QV#xe|!$1DqFZ!+jgTMbt z{hcoT=jDg{xnJI2`+5DA{oT*?TmGy!`&It>&(hEL?|z=nIoZzQ-2b)t|1SMp-xct$ ze%8|e_dkFBpP%-xzxY%Ae7>}LO>^tr^`(ku<=?V1e4lUppx*RB{rA=>oqM;=z5YLq z+3aV&uWtAL&j0>>SN`RMM1~6+Xa@>hcqcz`Yxk6`%UgGD+PZqC=z&W|&K-S}zw=o9 z$s3W)I#Xn0*8I29IH-K^0K1<)a57Lc`wg0(2c;WS5L9U>r{^@-Vnb@c1Ozz=-dkrwy*O+SlM(z4HZS#NS|J9rRMKWAA{LNn2w0E}UjmF)t z<%MMGJ>R^oufLp>%2;gnpSj67>d!X@y_Tc(E(xiO&l7(}GoCqe>DFKV?)}qb@67pc zz_6O3emh@ z%X@BUQuW*K*`)pA$uovJSA(s;o!NE%Elo~e{`cyxJ@|Z6YwPk>$xD~Y z*^U1R%)T`tzx?VV7rCC@!fU1pMP5tYkhJ)vR3ppsm6Pq|56SI%YQonet@D#5ba8#U z?bNojduPs)&|4)E8GLW^4hv(GXEhJqUdBtkKXSoD){yi4y4O0}I*P5XY&tPF?5^|t z{~OQEw|jU)RU)?j^|gSQ74^G6_ujYsTIZFy>Ch3&Fehi{WkFeU zgQFkUGZ&bKh9*atc+Naqrq`w_9xz&>zH)en4HDbSd zDo0r6R>sm074yO=>dPmocXGYBzKnHl_@Z|iDl2{_cBN+IW+eX!d98IW@!Ix-|61!N zOf_YfNLm=$Dt#_BNsFs@7*E6s8;erZ| z{pC?c)i1cV%zCZ3b$Mrqd%%R{stHL|pMo~cQd(P(7I)zEm6k)-)^GgZm3eWV??bD} zIabdds`(SvxIewr^2_4>91+p;HS-*EpRQB7ee&p^FE>;@KJU~?`f;h&v@G-lUwxgj zPlcdv;D(b^>*f1=pBDYUb|vTgVN-Kyp46CW;m59Le3#SvxtTRaSpRc4x1iSRw=>jp z`M(Ps()jn!n)6D%TDf2+Foq9}ID ziu`rCErsx$JyU1^)<)W7t^kY}mM_WHQD(Cg})Ky=9gVgsGtC#$GVfge{ zp-AGi&RJhOPx_{@qzByEt5xzN{Y$NF;_J29TmSkjdl6VC&-HX;6cf|oPY+ji-g@zg zQTZ>!@i{w>XlKW_?>V*lNx`)@I*r-e7D|^UF$<_mNwu{e4|~+PeX3`Ab+DwP-v@KQ z+=n5bGTQ5BxA%wLUt}Usc>Rh?*N2+xhR1elFWjBCS#iJouJVsu>tFObuQX;#*XugZ ze0JI6DJ!b(Dl9O1aOe2_Qw6WAR>+96ip+XqTbMcdsH)PZ4T&pRxzfAzv>JBITDtDx zp5I9)pG8`1c=tr*-P3bwM@=_o$omx@S>W;crRXshGjkV@jj!vEoSPpm^yIV12C?Q> zi>fco%M4jJZ_ANS{RWP?!8h(+ThDLLl=D35zRq^_2iL@v*K%Gw^!UUv^K&)-%*0n5 zb-D0PC^+QxO?9zdJ9wTXZKR}nXa3#PJjJSX9VgG#7ddP7JIZq2%ImG%^@&e%>Vdw8O@7PE4Qtu zdpG-*$+g0O*;Wqj|I3cPzV(?LqRB5KST3~JG#59?umCt=%rmF6( zou?GwT(zViXwF54p4HLqUK0+c+2lW7Hha^lS6Z(fG8W&7aciFCo4l>^MA+rZh#%XY zJuTU%Fe58lt+=lG?g0U@-*esC%2;CFN*_>?`RMQ~P|-U+&0Qq^>)8d4k0M#0HzXXh zd7@kYK|`p%=1-5u=Fs#$se?^xv_7uNZ%Xcd%=P)$kDM-_Nq&DN7G{OqZ?Jmzb9>X@ zh%?{sPA(Lmtw+ivaV(Ee4Lyo7P=s{_Y2H`8?OQGXN;l@F^`*L#=R3nqW~Q#$UvbU+$C3I4%9-1Le~ta}V)C

dQLQ(7^|}6L;TPjs-O3{Vk*Ay;Q>V=`KV|!c#VzQDjo`AalFPXT zURa-HUi!n_yLxWS^|y>7Gfv4C{bYIH;x;2#t8>2^hxX1ZLidGcnyzA1U3q!ppF@)y z#Hx!O6FzUrez0xD)l0|O+AXU@13hLQ+PIbnS7{1=xjL7Qwzs{dkfs;!Dz& z?+aF*U%zO6%d;~ZU%P+Y`|AC1sq|XWb8KRDZjb*R3fB_Mt78w|Xf(e;S!TI*+R;tZ zwkcfUIs91d$u_T7vxG}KS0-pg$(xAjZ*!foB_VJ9;s5)l-T1apZT%_+4bGF3*q6V0 zHJK;ySW!{^$B(sQ$jgQmyH&n)+5&f1z@_=Xtv^4hBBMZ1OdpGmAbt*W$zrPp2Y z@=N8JS0?i$u?Z>9ntu3%$f%Iic#!Q~$`aj%$bYuLiC3^Fn2hWan>NbWU~OnJ|w>jOMI~8;U)7 zPI5jz(2!vmACRM2{jx>$-#NK&(Z8237AX82za%x$YMs{S?Cn)wYt+}AZ4)+1`?&6h zcDhrWz4L81ACt}Pi~jgH)Z`VVonFaXvfR1sLcwKr=L#V;pZ9#%J}d0xkU*|esV^$#64$UNf3Tn zE9bZ8PTJCohl46tC7&qDH>nN%lD&1BPW^%_p^WFIzx(|9+V3CitLH3V|IO9%&hO;h z7wxrTi;eggI9ACjMu&+#U%~3Tb%C3#{qvVU)-&0wR80FQvPWdnxY<_|%a#-ewJNQBT=Fi~O8P^XZQW;= ztQx-Wi{s+#&YWA5p?_{ye%`sSH#<36UoFiHd*ODO|HW0;w?}+^7S=9M@%q(MZ#?Hx z^ntl2ZDm(QFRHCG>0aeZ}Lx|@|t_Q-wvp4fjEu56w1Q^lez zUAjDcb$#6D?lYnag_a(Hc~g`3zqqyV^6!<&CwIr56u*C5vZ+W?=q=kSg_HUl3vMKy zS~N#smCB5y@)K64kKU+vJ@7bn|Fl1sxYoX&*FL%a*WVML)PL5!`@O^^)viAL^@oze z=NW+ zzwfd8f6G%DOTniZIcmiVnmTmYS|)zZb4uZH_p5wU;8*vvpxE~Iw7;4`@)sBqYb3K~ zoOmd4VQ=a&vnpLZfp_X}Sg*|fx52H?R!>-E%i>(2sN1im^4xBWTWIH8r!eK9-M7S@ ztmchM)098!I`C9fek)9~co3oEU!5FZZ*jo?xN?u6;>M%(Nmh2Y-#cUYMUM3>+PK2` z`M0zW;@&qZy9*}#km*-Hb;*x)!s{K26<_4W9Qb&4Ip2i$7J)HF`QC>vrLDYY`C4Jc z{^?U$r%l!By2+?6x;k*}6zh)o^x!LhD(n8_)p*~O%hlLd@U7RNd&8M3hX8%ubC!?R z9c``uZ$812Y4Tc&@>`iNrR5IpIrO{c+HK96hfGl)x2=-DEcxTc-!5D4>go3*w{)C) zxkR98lYYUEz9S2_&L}Wu$`vdrHa|A;=%%9H%0pUVA8YOiwPZY-x%|1!Qpuu^D$AcN zJ{u7#5I$w%`fn>5Gg;Sfo0G|JW4u{?iHB%UWKKoij2rbS5jJlx&OUB^OqFM&Ur|BR zQXx-o@yGiXF@Jd-6MZIVp>cX|&{F5!%b48P+Fn_c9?hrU$vkzdd`^;K)2x?f=QJ~4 zFaKa)G;N8k{Lds2<10+3&mN12^q%@DN4fCcjy0*5p3nVqGqUsSh52{CizZyMn)z^z zVE5+Q&g$nAUmyFBcB%e?{TYbQRnSv;$Vb#r9Xp=0u|>;0RWVoJ9j zx=|~hWE(oe{jA$@+d1Ldde`2XG5(Q!`?$|3b7P@Wow2pz?0}BuU1cgwPxf)XP|K`| zUd0nvESJB%HS}?a?7jzQv?sCJZ9Lt)LwJE+%&wVNe$0EUx$(odl9_>Pob|IUgB~pZ z{xNRfoNL!}^ES;cYrC-R^!%%JchY~?Pn6LPDU)4p_y1R|3-5^&$Lc3Hy|w(srm`UV z+di!acSS$D-Fkca?4P#{JD+Vgm|nN`>!b#o=}+^PpVf4^-OO|-E9-&xiaEQK+`B(s z-@f0>PBtJfa8}*VN-sYt&$Dma4b!H#?=Ii?^lECCmTbVSXv3(I-*+p$=1o`qw`A8Z zw~y-eYge6KXJIb3=iZuzXFpdLxX75FOySECIF@`(;l;ZyG4G(xSHepg*O+d9{;heR z|MsM#3#)_QnBPvh)qj5B#0;SikDur)s?AjHk1nTjc{|g_VLzMdC%%x2IOb zq~AUvq_dVilbca<(^M_rUgVL#!zUikU!e+F zt=9XjC0m?C+T|5fPvp+1 z@$S}}$UBp}>%t+K?=!+W>*TCTC3DrEYz;Qq;^qDBplLZr*9N9DYimE$yX|;)w#dcx zkoxzii+5}JtFte9-CniK{0+1}sqa&a8e`FD}J2RzT?#`oUX&<=cQ)aj4Pj>C!`sBXBo6F7Y4Zv1 zwrTFy@6C@;`TXVVv3oB!e_3#=@XcjU@y&hT!ya}%7U8U$DDQZze7DBxJ*NzO{{$U5 zY?)i1#6Hg}Ay7$LIYsWZ%D=3sFH~Mz?Yl2sws>>GuV>TFscM@ZG4m-qDZb#s?CPUm z{3o3A&y1TFV|f3e(glP1sZS*9m}aD%dvoYVU9LjPi)V&zK^AUawOrOWV&1Q*kH4gU z*>aD{+z?CUTaK0idVNJdAFDl$l;b=neJoGjjb&!=`}){jYF+m>B(P6!zCOKd#_xQ8 z*Y~p}rhb&4B9#>OzTkYW$?!$=cE@+`37=LH z85Qju@keE+-Yng~`U}ksKc9rQ8_E7|yr`F7@Vj}=_haF5#UDG0o{K+y`F6vz=(Ee% z4p}BG(BwH6#Mt>MY}((MjG|61%S630&W0RO5VSn!>-;Wt_SS=LzoQ+mvMTRoxzb-H zupn`BdBFGk(K@16jm}JYlxnBHMPgR*FNxz5T8*{5U2I?8Y5vnL^gy$Ij=}QTldlwL zpRP#U@$lgKOIEQNzEfXF{pvZ=@q7krNW+^*rDH;xvnp2>DJ$rI4ct`No9ZWcLSXUw z$5Gok{#KmRZ(pHulN-_NR>x3D-e&Xp6tUw-%v+p-$7 zU4QxYoxVLNsS;@8*i+AKEAD-}rmrFV zmH*1~lhHS~Y2<`;UF}#W@Fc+NR@fRFBN0xK-<#{wmvhFSt4!6^Du2P3Go|#={l6L_ zQ^l*62%qIR@o9g$RCTO>aXib z>dP9hx_Erf38%}u3hWf(S4p1j|NOM(*MUI(ccotM{<5h$$9&A?SXs|}Ki*JslB!;w z-QBXk8w@V2nPTiZ@yJT$j$gA%@2|99a)ABXL$y~Ck@hjsmuqV`h}1{zFe~xvN_=y@ zHt1Mw%7m4txKtN-$Z+I6vK5k#d{ZkHxO%Smj{3tVUH)Ia{YdYn@h0(q3pd~Q%R95I zUwC?)j5gcqbG?k-g^YFPYu@snueVs>YkEgh`@q7GRc1*PNr?9G-pc zeSO99@2hz8MHl_iTr$_ldBJtH+SfbpTHo)@>b!DIisftFy;*(hzwArP?+j z-b??kTo-*eCdgp}cfgF#Kdzp5>h1Y#ZpJdTx4V{Ke%O>n*Z6dB&S|%cJLZOD{h3u%!dCCS^dj^9FU4gKesM8=+b-7g zWb28;8S68nOZakcE|q)W9pS4?1*%owfm0d*N%lV=KrafughF_qi*4ig8Q#8 zZC7}rR$NlR}%=MF}RIRWqsBKudxTtlG`YxG`QGar| zZoa<}!s#!sb;;-3s;cc%Ut53O7R~55VUwVLO@Ygf#^b+!JUo7W&-}waN-TTyqENfZEP3i z-!{kDRxaX%kLI4u91pj4{b?5RXg6s8yrf1b{mZMH)zh{7?HU#@leo9+*2XWs{l_kC zmS4u5=GZOheC$PZ={+`efm^?qzclkI^xb*du;%VRt0O001{MEGb4!c-)-*fS=HeBX z8;e{gda5s4ym3YSRx|c%GPkZiNjhyUuw5=TbV*Eh@A5>})2j^re}BW;msql?&Ohl_ zaha=da?Xy^RdHV(W8Q2Jp1w;+O8C}gS>cYg-1^lLXXKQFHt2c$*kf{7FN14u()sx+ z$Lz24a>dQb-C+A%S^UiF;ET?$B=)JAC53Lj-Mb=RPG*{D;u{5S;rdsqTkGSVx7GZ$ zoXc3#=+K+;zrtnLjN~y%&bsGez&aK7s7^+$@d9$7GL=IpJwum8~|d`a#l z-T%{~YrdX2#;81PcYl{pvYD&d*?h5?wY+f&Pn5)>@Kl4 z+Fe0=o@^2H;d>jc7iD~+ZdJpk$#Kt`xXm8e<^H_Z)9RumIW1;l+!7Z>+FBEWSCWYOsIUye#-SzsO@jL&Hby|I9918 zs&jqH{IjS1_kLeSDRHU8=d`^y`&u}Qt@-4-?4I|R z%X)98h@7f#3tal6OI5O`JTx?W+6iA}XTzdt@9VS0rnddJIIyu#bispchRLndCVrbI zSYSNo+#5ancJ71I4}6*X!Sw8gVBT46Q=h-}?sdIyyes+m`M-+y=lTCz=(zM;cwT5A8;*5LV!CPu3UO7}R7GKcJtoBr2nae~jzB@aC>t4*Jy%X9+0~N2A+wqDj~<$M|P_{ zIa@g6N$I|>&WU1?Q|EpNSnXKl?jBO#Q7QIT%6!}ZnW?8GOKS|C-V!tlu$lMrR_b|< zz=IaCdFw>BKQn&4t)!`MhX1PxFXvdDe^MsP)#%`s^ZcJz8k<|a=E-Ra?Q`aB=>DZ4 zd0DW9oz*8x;_s`+Ld}0A=Lu|LbEsuWwmY*;Losgkx>836EtY@by-&s88A?W}TOQzj z&yXJ}#B9Xba`I?&-S=7fMQ3-|sc1j*+B>z?`{t)r*T0`K;@yyatJ}9v^mgoy#E@MX zG40)-cgUZK+qGm_ufS^Og!-2uo&pPYc)u<_{xSLGodsR_m-n@8%JDnPvQpNw_rA3o z=kJUniR(qKl~JYDW^zXgGv~S-xu?9}-DA(`e_!HGx22rdUh!1cYTq0$ll5P><(*7T zp15jF)}MQA79p+)$=F7oKwM_|LtrUhpJy z+S0gR9!FY!A6tHU)^atQi`O#tP7yfK^l?E*wb8^+jqHiZhlLeWj>i5C`5T>j>)&Oj zBL|m!;fS0hP`UB!m%Xz(T)89ve|^08;=3~GEiU&XAN`fx_b7a~;|~tIpOHJit4y@u zE%mg#zrSnmEx#`Yx+}96-G8=p-_zPK?ZWb&`Wnr}ec)CE{`h!$&E}isznWeynH(spe#GJT%s_=RfnR0(#nj}O ziW>6$Cw;BA_#HGaG|SUj^~5eY(`u=ACwlK~+~!wva|7>=DPPP4ABUT0X5_?O-z8Ad z@EaWS3_5NhMp(nj-LlR+4Bsvdy`~mf zro$Q(%20c@LV!DK(UWZ-dG%K7#?4IZlAo@~{_g%ZNiEgm^&UoEEiHO?G>*gu_1 z+}`+(_d>1X&o&A?BvySlF`!Yj(8ReOb{mtVf zU9}INV3{!0an%{wd$*3A`Y+?JxvG7^6SakL_cS+FO?ArJ8kD&~cI3D)fvy)otI&yKXy|Bw1KsQq_ZBdKS-{i=1=eZS0e|J`G6uCG|oCh>9o!zm>Xxwl`>>niA4&KIBglr>v%YO}?m*t(9I zDYkR_Gz}wuOg@#s<|4Uz)1h}Sf(}nzwWhxF%JGS>D_32dF7){N6;GwPjvS57yR=NK zHT*pPobP5eoul7($~C+5zPoH6`-B|xhks_g7i7KF_^@?`aXy#d^bI*%#i#!HlcARz za9233b#K*F&@+IWi*Q?u1~gOO7me-yEsYkbnEJjClyBzsF><{ z9`4>&$h9$aRj5$l^U#kz{L|O3jH!~D;v=}~&)nbHMW2GN*Ur53wn#TIP3G?*4>i65aPN;6L zo9?Kqa;B--&dJ{CkBirpGY1309oN4Wnf8017gOm+nYHNf$ZTh&vWy!_`w#V#vqO(*yTE z*Vc9jigg#=aq)%Fw!P<`+bQ1Mzoai}xmwGzTE@C2`7Pf5?S7uyRy{BJ+10hEso+cR za}%96IUgRbE0FrCcT08K-^ZW5n-U`~Uk7Tc>-TP}_n*YD`v zm8+Lvx7nEE9_Dp+y{6NPwZbZnYcziCU4LzhPf)B^T+HQan=PDOT3kL=AKY8TlKPMO z9m}5}`sH~`fZo;_{{#dIc?u>s>^`o0T6CFeZIfNm%5!fr()|l2#_N81@aRCG>GF>Y z??<+$&h0xf;oj}jaR-058923^Si$l_;S6u>`9FD@^=ZCWtL`t|w9)AJ{uOrSi$$vz zIBuKV=%&8=BICR-nb9JycYkkw%~NLA8ru@5^tR3I+c{nLQ=fgDV?@kWJ@LMDZJorv zw@ck}TPA(zTT;>I+O_^vqBQgR`1Xz%yN<~VC$}W&m#7@t{oj^fsm9>hN8MAqUn?kW zm8;V~{5Q|yE{j%F*_z@cj7t@EL;Ph926d zm{u*F_+f^fz1PiBF9C~n`*=QZIIHbg@4`Jf_qg{S$>=*~4&M1jk7B1biHM)OHC_8{B}c)_@joF>byJ;N8aY%=?lP=nnd;)+$fdpVed6U05xD{@*D{N~PZ!(clC>d? zyMFGQneA@prpuq*_l;%ap9_i`R$UwT!{ne9)OHI#D9de^S~ z(chf^tM8HYuWuZSbH2F$dCnFd;+S#X>hV;jis-Hbv-!Z>FqvX>yHTB!`&*WxpFm1d4$XVMfe;Y(w;SU9mwC4BBfqp znxB;6++Z+rh(p6adC%RX>Kv+d?uwoB*Ef0caO zzwX8dscWYna~FS6pTWFH>ek~Q=Bt>t_r|pC+Bf^ROXdsfhk~(!wtLr~`aV^<=gCg?|3-|)mp?k5K3{t|YhF}O+yY&}lGoKek@y1~`y-S;CUUFC|uD9Yw`jcf= zOiww_DJCqe`FuXs_s#eB_r1H%zS?NQEPP3LZRdj=ALer|-I1qzuT4L_n=K|`X8y~d zvl-{V95N7YZx=f`XLTOmq00|NW89qDUdYJqf22I$99sTo!LnEE zfjoZ&`8=*aZ{fV4lzQP-t=RSJznLdon5=Q|)!8kQeT{9+*L7^avLq~ee*G0+l5(Vf zPSpDOr)RvDRWCUs&QmY@J92t?tKQ>?(_RZ^RPK8#o1RZKEc@kjv zb4gI{W9Ph*``@&g@26gLv{<_9OJ2j%WiZ+`4~*ZQ??^_;#WF(}Wc2r0y=VH@oCrt9jca>yz0nqi^$!V!ni@udi3XY_Mmh z;MIltnaPd+I<2;aOJC|$7dU!vd7+fD^rO|M9ZYu}=V+byDQvZA?cHx7t(70uHw&Ns zUe0_*^Q#t{vi{pD;fF4aDa(t$&+l6KAninzyvI&Ywl!AfclYxv8?RRRvg4&y;GE+v z`>e7*tzvH#vhhASE8D^GSahmv{!ISa^&a~d?VZFWT(Ec2oR!XNttY(yw&_IACY>|2 zAH3d(9yAs4-?iQJU6ba%Xk$Br0@3a9dY#JzpSk<{+qvx!Hoo4uSlma}*}%p~x;fTR zqIdgAU$g1QHPp@@eWoTEUDot(+5ERmN3Wfe68)aN{GzR*(6Lo{r_B%QX?#9@ZR)%i zw;glpgXSC8zrCGx>hUT$-A#+kK7X_N?y_CS-R8H`!+GAj9Kxqec(Jyuhh^cZ2l{1l zRmv#_7tS4D&Q>_xX=_xb5dXFFXV-B1Pv0WwS7@Ryd9>KvLNeBOFZ;H4i-Qj>nf!ak z@yc5@wL%3=DI#2UyOhGBcg4IrAhu>UTW4CsjC9)xZTssN9y-aMZFN}w-Q{&lCgt*! zuq3aYu|23$X-&Y2+aJ7c&Ru>j^r*|Td#q^_&29erC9C=0HJEj~-EPm-PtrG6>fJlj zXq|Iye)OT!w+~xyxZLt)`e&!;ZHzUE`yyhL_0>hptuqcST)L{!%IbpKf|Z_?Av&9@ zKFUO^dCUlL&Gp~0i?#ldOXK^~(>KPu?^mup*>PU*Z$kN1{l9f`=hs3 zu`=tUZB(Y+EPwQ1xe=$3F;`YvhLq$&@!8EzF;C80nfPZqif%kKX>O&6ef`X2pR@@N z%{;lDH#6T0ln=Q+)joBDr+)jBRrAF6*Yf|`_w%e_m_}Hg<-Cu7)8AIBulT!uTIaIA z8(!uu_nn=xV5j?xPstKuU#wK?BWf7`n1Az`*`1!5%B^+hNQUj-Z9NImIO3QUb`1&SYaX(aYmkZ`{_`t`V$}L&Ty9d7MA>Q@0|r=7p^qyx#BwOYD6~g zlaL6TqWia+P2IG4KRZ;eKJx5f%a*m?{_~PQ$Cx*7Im7kuf!_73*ta$|pWVFD#m;7@ zojdrsP-lOR>~xpYcUSkd=lS1weyHaA;R(0$Q;+^xGjpNM(U4W4O!dlH-b=gfw4?YI zoO%AG{y^Q&SEl0BKATTZ_f*gL+9=;-TK|x3p9`1i9rZVoN!3rgA6g%u;Ky7flcb~Y`}q?0 zdcFGf@mfw&j!V|E$Sqn?lryi>PVTWzzVM2l|OjUVYl}>Lr9?V_hI z1LV6l+kdn1QfR#`5r4b%7d!ha5%s@Z2Ys$S_-_@sq2!tBzT}yzVGhqP&41X#<182% zdFO;izWO55XO@%xp5hQ*DfvA_rrG7%G2`m%%j%pnINm?gQ(5}H!BP+Y-%$)O^L+s13>RXFR}b`?(N5MI}{cbe6Lj82PLn#qSB&8uF! z>h*ugtTVTDH~zPpUzTIHIpeyB{Z5ucHcFnICCyP@%L>{4hkOry{wlIv_lj`kt@vmcQn-Xtc4=B5ScGBdjecG?z%+2;Z z=TRSRmZ9|Abf3+F%}P4Pi8a%wcRwzdc=F@a>^gU=dA!yc8&VifTbNA9<;do<6# zsGPZRdBBdK!bSV5mMH#G7y7n8VJRga{TlvT<7CG@v!She|Cfl zwH|3O`}25Wsoy;MnrQ-a9BEH&avmB8JPhSj~@T3eg3bx z(T?vg&uA)dHR;>;BI(p;g`)Bmjj=avB1%6@%Zni1P3^N>|E1+<4aip?|R6&SXCY`R7@)Sav!}8`(%QF7aNuK0Lo{ z*_YGDAAETJ*jeB0#5bMu(SE1a9zI*YVvXkdWohy!rm$6UF<;`AUu@5?)+RLZxX2Nm zi0>-z)y0+W9=*L@Y^Ro3#8;-B1@p6Dr?B@_97~h&tgoyZnRnK&cKcP(xWcSBxUT81t5!^o zYkyHK4JO@)pOi`%mo%bXUB4u5v#pvS4aJ5x<TIUTo{ST@(;Zb0CmBzF?7iUUOpk-Yudk?n;M?H+oJ;;&G$@-7A^|PJ#cZ`{FBd`V+Uv}3P7SVsroUE^6uLjJXS*FHiBdW>x=SYQUin?I? zx_v)3*7am5-+F8m+L+9cE1GRNW#!k}!b5t0f4!A>ZJQJDL~-3G zr|^)*?1TCVCxniuSA6VVJGmyPMLJ9A#*5|CCkIw%GX(}`-p-$!JNw`I<0>x>sz-cp zHM`8=CvvWNn*HOKy57^frg^P0D5~E(qx)(5Qm#+i4{6Vw_D1H_PEYF}8bR{7Q7e@2b_hXSvGiJH@Pw_e!$B-d!AF`jm3`b{zohmc5bZ~^q*KSbL*vX%$7M_L9wYp3;%qWxTfIeXUUVj zPwPv}lN$HevoEoAwkVRivY`ECy6`v4{Sy`5MW0%S2lL4_5D+g`mTRctlhTMPUy*! z_uucCE_|)L^49y_ADx^z7oLROT=8(K$~zzHot$@C=ho}r3i@X>O=iEL$S%DD6}Rlo zTElO%*UZ+wexWXLO3}Xu$0fBHcdxywkoGdVP3n=`mK8j)k`;0GJ;pbTV^^1{U!VTp zW|OzEBdc|T+dSQQLBB57?VHKVY$&wo@v3B9(-4(szj+?EG8x8+y=9BGIa&0h?AngH z#}3zT_MGX_zj-a7zREHF#uLuoAoCQiZ_aPzI*xnxE!VrlvHF(J`^dOQMS?dj*gN_z zD%$pn@8hYEYaJ|Kmp!<8*h~Gw#&1zksb7B{!SKA= zYTH^@r|Kil3Y+gfS!MCWR%P+A^Sd@|$h>@0sq5vbf@xhLZ`@tgm*PB_JTc zu~)S{ME(68RkitIGw&D9S(RZwYr#<+)%{`88m}}SmYXYymQH;#@3z9N!Zn{%eJ)j; zVpcN1F&tHynaCLyb(m4AE+s}XtZp1yB$^a`FQlP4Y9BlWb{XPVu# z#vQ&N=fr&fU36Pid!p}dv$H$n57jT#f9G_4>5Mp$ZEvs4ng99tWb6ATS8ZRk9F0)D zl9;m8)H zTKPt6x9NeB<(u!jP2FJ2bxix+t!GL%a+K=rV^&!{QBiqu^TRp$ZxW;dE(m-N23ysfA$W(#`1lo(shN4b9iT_ z$9C&$8u>pHo^@-p9p`I=mRlpfm2-f(BNUR)0k zYa6eba@e&PwI8Q<%3qOq5x(tajPKoOyPvN!ye^zjoVRdUMT@tIf%S5Ycew?N9rN09 zkDR&q`1>#S-%Gjb;}dGqGFd=j~G@CHMY3u>Z_i*{b%%~8=4=pQ|Z)~hzs36h1amC&jKh(}WK6ODs&T8Q#_WxHFR&>^1GUMKU zdyR`*=dBFB`to>1y2y>5iE`a`{TwHv(DwRqD%pFfpa1b`KmIvpZ@+g&No%F3};K)CVmn6M&eaYue$$R}_2e@i2 z{^3^{Liz8PoJZ9qtG>$>+!Nap*eJ>qB6W5xms0q7c9z?}EL-Ad7GHjRCQNUG6Za3% z)}wMyZ+x`=H=p6NBG0|&XBHLA(!OhTXz%Ld0q&{?^>>|);0eg+*}$O0P_JN6qqlkO znx)^uq7(kV(p7e-be;JHB+-( zQnt;CQ}2P+W|^n;S6-U6aOZPRFWlk%;e3q6n!}}=ne{JN?mAN7^M1`8zR;>-m(WA4 zt`%upD;UZd-fpbOo+h=`a=*OZ=eGL11F|8@H$0WF6AN09zLv>7MAc{g+RKjTt>x}2 z{aeu3_Y#g}HW7ju^A-#W;p zmHycHbA4CzKf42mCL2!Lu{9uG^h#-U)K`N;zsw>()N69CQMKu}H&(gGl(Mccv_!^t zLH#@V+nZOU>Mh?`dn6U3rk&w^VJ*qebr$|GRn?MNSg` z+Vzon`9#4Z=9^Yph8ul7x$FkhHpc7o?mlET3EP)?W{Pp|6OaA7E`VKdle{arJ4;3x`spiUmiuZ`s&b z67Br*4x`@h&r?hSe_mhg?0wx}lj{<3hq6VHOY$|N3SN9TQJc+vsPmiRy2bO0PrvZU zJD#lA(`4*AKj?jkLa`1*iG<0C-%o9PGTkjC`4(+|Z*W}n@YS5fwUf8R30~cIJkR$e zk9=frDdUoDU2aFy>%R#9zLR5KyeDu1OM}_cpv%I{oZ2^U)IOZrxGr|P$DW(XcdbjR z|AZ`l!0S{0@4n5AOjf%zHZRyT-#BKniSfi;?9@b4`6_Iv;TjuxK}n_qJ6 z3*2C)YAhyUbw?&CTsLUpq#uFtr+3s(&wjM`+KermX1(9lBmKmxm&cSbVdsip4S&>Q zcVwNfU&+<2q_+5M%Otjdhbtz&ZfMVV*DqAo@F0Zyt8I$|v$4VRp2HH)l1?rcoRp`_ zzR>a2WQmFE*lZ_l3QVeQ3B0-F*RgBCGoM_G>J?=SasH~FqQfhFjVmzSPBcaJtFCb2 z%6dJo*IRNTir9+%XX@&Hj7_(kZ}rP7t# z+O^jrSF64|!ZzE|ZG-ERO;@yC&WVIIJ=^1@(d77#p?;mKDo+&ejC)^}x;QRezW&1U z6?_3%A-Wf>9A)>k8ub7Ayy$rFHSwD~QT!WDlo>kiR4rx$o&% zw{T*10h#>#h-|C{9< zmwmO7m1EVy>?NnBKRVE=Tpe)zSHq>0J5lRuRn?=Olz-}bu$OPyzxo4ZJ`YUxI(5|8 z8ZXndSo9@e%8EMQd9TOdUER0$I`hvdmknF` zUDmJ5e5k%E$#&|}^DD9@I)n$__T`DLe>^*G={hN{yjj;4Yd?>;xh+s;Ki_^nhQoWM z-iGd%@HDA$w?1%ZjceI+E6XcP_3v0So^IJ!^I`WI_X)qkZr?m4EmX9>LD+n%h`gif z&E$g)2cmvneQF@M@_ZBF4z7gP$< z0~8N$T%VL8x#WHqcUc(c{jgK3oQ|n-tW2F1=OJKsDpOhLoZJsvCzq|e6DQ36wCeV` zRb>?}KNaV#F0eQ;GyLVFqW|m%qFim%ejT3lc;*c5`W~r%iT&A!t?t~}o4Q@&|HRGq zx-!=ezK#l2;Y_P@yl7Y2^K9!%S9w1v*~s$A$MZgCFT4_ZQ{#=n#5HR^yGmU<7+=z)3l#N&KojG;; z(GANNHDudg%QOFy(!0-MojYU0oe2MFp)XvfIaMCKo@{;E%-np^+o?RNr8-|TR(;-N z?(_e!%jKAbG1m8VbeFCv5L)!qe%3UeA_O5cvIkq_Bn_jojb)8#P`?wdKoc+PI zSW{V1c~+WqncwOa3*K}oANP`aQD5z(%W}P6MrF!1{jmJrZ*~d?B7y@qU$^iVDcr%{ zd2O8&NB5o&heGCOGi@2e+v3;cbTFI20kqV50i?W7AESA^`Dw({Nc6|xsg zAIWe<*{r!=Yp(J{e}=G89Q)aS-0p|mzpa!n51AzW(I9G%RY?;=Vc4ewYf3+ypS$l_ zz4ybHVbj7s%kpf@`z0lm`dm3sHR624m-DTOe=HBr@@f2)B7exY`gnTAgvV`3SG*jz zr+%q8DlzAvhV;ShvV2kRFP+;{{`zFi>Ho#&bl$B^XcbbAvw6kilN|O&V5f|}u@l!@ z)_<(xf&X0W8M1izzDu-d7SC5>Jl0ZWT#4pEtSbc>VRm3`6m%Thsi#=d1PI+;ja%>f1mL zxn*--*(ccfJ=eQzR~DgkTTds5WnETKhL4edX;;!MoAQo#y7{lI&F?c#|M*5ddy}SM z0-MeOW-gX`{j8id7K?&=`h@TP+Pb(aVs@5355n*6vprDR5_4<39LPX*O*KLXw(t1*{ z?Z0KrX6)W@N&iylb?5cspIjufxoy996|a1=ykKK$Phd$tOK3ggg#1f3_sSes$Qm46 zW}kGCCuxCozsTd8+)c+q%ruX$d7@`No8Q#5Jo{?YLjTL_A7A2ImcH5J)Wm(OPrtSN zAcjwc&s`oe(&v7HO9S5ZwQ-z>nvQF_08l({d)b_ zwVn^9w?A(3ezpDBw>SP9@{a6YGk;O^*#i&G-?GqAS|xwTZ^vB=h70G{B|H>7GHJKC zafsREA5Yj%bYA=M{`a$Md1oFd<~7W@FKU%Ial*d`d(1!Pp3{11nQqEpJkRU#$KbtQ z{`Pq$N8Bzlc}gyO|65O;LqcNeycC<4IMt+8dL!Dm++q`$0u_DUX$wQ$BI5 zUC1#}Kxl87iP?e>#L;rXGX5F{m zk2~uzPegY8WtZDt9QxaSaX0i9@%!$c_VVce|NE!@d+5DBNqCX#j`i0awyC)U@7sGr zdT!m!C8~LRWiMF$JS~r9*);kua+&(1!E0(_g5MYE1A!AOJ&fB9nSU2QE~~=pB>CD+ zNb8NNuhM*_i|@4;TY5z8$yD8A;2|vfSF(#cY(ddwao05wv+G4Bxz?rKT)XT^Fw?G` zVeSnzOMUq`kL`75=@d}!P12AZLSKYm6v8UuRrH@>Cc6` zpM=}K?fh%F+n}rHHm~EG|D1I^E-RcY7R`HB)3qVuvcLkR`L(WP!haTDuX)rjUBGp= z>b5|t`C-jh2PfM_zGz-rA0wIbYU$n2&T%y_?VW3^bmaHjwx=JMvC)0WRe{Q@pUb?k*rxv_LoWk&ti*L=B|mu&u|=p`#Umi#?cc_wqd(m&SY+ds0b;e3Dmeo>o| zkafmh`X3H1b!=TzUVrv)#GzGxRUXOaD(UO3|J3x^<=*hFZ{Xh|An%X35(3mZCUO(Q`LDvVF>#vr+*W@GY`-2V%f4m-n?XS-CX^jlVxl? zt~eacU${6ZtyZtGwBJouVtM5;( zg9@3;>$6v#(DP}XI7eScx%MbWeg(_??o=fy*~JDsemX8XQNf#97tLL}k?q>Ll&=oe zExjIXDPgW}4q9FouOn3}cu{e$Gy zc3<|k{hhb+P4}(&5zDt8)ULaiepH7`IH>Z`nj6Nx)k<&ckL>lZoGz-kt~o8Pb5NPprDS-e-|b%lS@xhc*V-O zV|`ib4(_rGC1>AGspQ!rDy?|LSZC(O+*{@!mdASUWL$c$lS$X#PI{mAPQ>zd1B^l1WaI9WQ)IeFo z`odL%eUs)IFkQXmpwQ%hn%Ayd_d)N$DX)JS!ueZWvR`6_P58u1Rce6YX*w(Cz=!sRD7x$re9>2BFp`OW`-`lmV{WmlE z%3YO{-&l|AZEUKPD$b6+=E@vae&=y|{k&j;6SU!xcFW7k$$RfUKT8)pdw zi!*;Jy!m*aqg%4f?bWXiPHaBiv1#LG)irz1FcefPDaIg?}Hj5Z&+or<&l!-{5@ zF8;?Q?XNohK`rF5I>s}BmgG9Hx(o}9~D2WHGUob9|$SL3MCysHs1yF4zYWZttV zjr6+Pwg1OH*NGNYv%ZTO^asqMe)*XfaXr#gye<%V+*pI=Sn!%Blkq982c$ z1$@mks&KhIsVcT0w0`MqFLv=6>t>~{LOGD%gP^?dBR+}|Ia zR=On2;FirXnNPb`_Ram6z{RuoFrRexse`dMl4rD6)wljmjo)(N%HCbS{ru|~JJ$No z_wc{YTTrTd#^1Ql=Z^f!4{@zsrLm7Lc(q-kGq z(x%=}fOTKouOHm+t&Up9WdFhf2>Lifcc0n0OskAC?n zHd!%9dgrC%X=%b7H$3K*)o$23H@j2aVy@~FQ|*is^|_Z*W=^!@s(qPuPH>v$mX~c0 zIitO`KJt8e6tnBPmBEjq8Ptv#iP5q6zU#v!|7t|#w`jh+?jn*`Rs38@dvkt+%iH|Fxg}OY zv(2_{(REMG;FPF8oZt3d-9bxp>m~odI)|%Dujc(Jy1%R?!reFip2W@Yk^;u!DU7-| zu12#sYL}L6*)hj>!{TG>!hOoG>WeiL{?Sumld*Xp_9J-#S2Ak#hp4nJ0-7Q(?SKrj*Gi%m|O3UBA z&yx7Qp1xeT^wyhBFO_V*-mE~pEIfcWbLOjrAX@`r_gMc*gq77`W7g)PZr^sxZ z!n^YL&I|gL4|k<+*LJRZHqMI)!vGBXWthuix&0Sa5-?%?b?wp)(TQ1}E-v(BZ3@c_ihF-bX_Tb#P4N)5; zZp^eQRF2JNAf9<}ZHx?+{~UG0%gSnbYL!eplpF!+<3o|~)>4s4V;%zF9!V%r6+N0XkWZCSD8@05*R{cqN>EIVYgnIUBPy$7q>Ce1O+ z)6M^NPL%DynTC3Yy^-u|xUSUY+imZ-^M3JJrga&rA9AH$88a!|y}jpS*+fI`{Eisj zKmH;r!tYBaK0Wi`Q)5!wiut=4+qYYn-)r2zsB!m}?Q`{BCHg$L=e~8}t68UA_+B5$ zmEUl4W{Bg7Hx)O$9?U(nHDHdML2Zea?)RPZGhSYqpO!h*$!^1|HrM(`=VL0*FTYh- zp|!?jMw|B8oh*)9r~Y{y>wVixD(2_mm){t8o0X<4ndJW@5kBd*#yyd6udN05g_{-VEMeom+bh|sdY?AXkg0A$nonXJo zur&X_nD^!lT=Vz2y^~(PC;wLV+IqzrhWiHVMJzY?)&|f5=HtR+_%NOh+}|?8y5`H$F^QaoR#! zq>0Pri%xZpiT-URi>Csw9K`x-jz3YkA^Coz--|Zm23!Ac+4q+;8HGwHHkF3FeOP9%NFzY|z&l9ikmCu=|{gh>Qf%b`OJrg7s2uxo;b91wB z*0NOJ`49dD9ggCwxi|T1+>%W%)_5&D`<40cogD{#1lQ^Ia6Obz?@RYtFMFk+px9*l zsv?Ku?iXsV>r`)T%4BvpJ^R(P6&%4=zcXIY`TqVweY<7DYKxQ!jM+C{UCQ6j^Y%?a z*t#?xN0CPsItIV&UrgNBuyDtR{^@IluKRd~%;jramBLfBQ$uIH-LE76wpYmd#NO0c zCmP@=TT$vOc`Ikyz8c}xyw1CLL%r{=cwqc8K6>J`vesReQ+YcsJ`ZzPy8A@Yia?)G zXWsIFYgaCBP1distt?M!wT~&__GwB{&T}aE(re(ulG_#6F(*A`>61NDSyJD6%v?^s z>7DUELSz4a$BV4*4i-)`esX)FVY7Gg;!Pd(QF1?Ja(``!x%6r4)!$w_PygNbULAw$w>Cirl=2Zx=RySJ!7rJcK9kEKeuBo@B3HWRW|F) zF61rcd81PR+-Ap4Hu+{6ncez|h1f?#qTxj&VDdsg?>e__WW- z{gd={@&Cy(ip_cl@4eu<_s3s*TK(NQ1<%g1Uf#aZmFF8n_15m?cZA|gwBsWJ?N=BX zFm33JxFn=(9+}>GGw*~@a}fK^+cj42eePQx=lIT$=WRd#du6ZXny+1U533$GDOJwY zo74VM^ts+YtF|REr*BnkSe&EnE|__bm-(siUdv_o6L+T{G1Pc_N>8+S*cPT1M%Y`I7yUiX zal+xGZExJszF$**Djj@(EOdWIanxSfmP59Uhc8V$qOdFA6OWT&;UB?&r&LcR1}R1# z=6-YT3D-XxA6xaD)+V8)(r0E({UNhM^=X2rKU=-g<-nsNzdekvUs`!zd)eQ8$(4(C zCVlR{&0)T1V|e2Z-!MBiOAhwlvsR+XhYQvjN(ipLYTfpjH|F593G3Oi91XuLh_GG1 z&~70lh4oY;FW!{;nLq%AD-_17NN3B@@`G#(z4>rdT%AS zHNT5iyX$`SF{wXmv^r=WZ@*Lf!S^$gU5%8&{!9@l>G0(`t8jAluIcjM0#-abE$qR^ zIU{e<_Xk}s&wp7~wOC~7#(*C)**ia;T9P+$n%%?*kqlW5o|Jz0n&YwQLQ3%g$DmW^yxEx-y{?xrUFpdceoc<; zz>C6d+Uu%=J{PTCp^-ets8jRCoh2{rS08HV)y_0Xcwgz>y-DQQPS&r^ovu8L7t}Uo zC_8bm?U633m-_Pgo~8KDM;Dr$SerP!`hFBDe$~EpYcF%umZE28EK-v9@#p`)tMPvF zM-SPp7Mqg3JlW~ccV*tjt?y>uuW!iQYP$B2{f$LDcLm?iktkD?6McWkL?64?^(gKtz&5@uT`C z-tW_XwX&Vmi5w$Gzw>&4-}oXWohutJ*IZ14o~hU zTwu5^Fn7WE;M;n0ma9LYsBLDvR;#DF-5`m6K|9aeyI%a*~ zU+}{Xwy7ogDs?}DX5ap_(pS8pe#3WHyFxFs*Bgx;ar#Wr_V3C+|gWj?-LaMO0(sPsod zCz}tp-kZyBwQjqbJlp*YkGW2!iHB5rk^)?3cX+VQRphW@EfIWL_9({v-7k%;M?Q&# zF(tz`oKNOpm#js}EP0RkNmdmf{d|^*eG>DiU8JK4wE&YM(fbZpvc`G**F4nG> z(%SuVyG(NU<_OO6I%_J=RjxUy?utBm{9BTpN+7SGzT_)+owO83YKrTOX6D`waI zdcw%6&~(!A)Rd{m?=kGxy~h3P%8e4+xCuF_XHV9*oO=;`K;rdhx2~6y?yX45TWt1Y zhMcne+~gM&B! zY+P#f`R=9L`bAfgLN8ALTDbS@pYP8u9y@7k79oF0{>bkC9SM&= zcXzRED3DojL0G;1{GJu%z2!@NH_rdsEpVn(QfA%i33c0oCG6K<-OoSeg>IFtuG#h( zRt3?qYNgk|1_eA_`H+)EJ8*{MTGc;u{zM3TT`|?ndx8_kn*9%(uE;C-b(&^sH*7Ls zVW>Q^e82egK?Viw+f|KkL-I7FVwPFF@;HZ_q_a-zS;GfObw5k zf4sjbIH$Hc|K~HuDb7<)Y(Bf}qkQ!@MqyXc6J1&B?&%)y3a?Rjo1Yf4S-aO+T&UrE zc^>#S6J~QWgXxUyoTB_j28ioSEKH21Px#9r%4}(BGM(`et7d)gR@M-ad*Zr2%6FG4 zIG2}ul$T#;VCFG&=DF)(?%~C)akpcN2RFy1yQ;E5N?$L;|KFd#_WQLpN6*++&)=0k zpIdfno7wCordNbi*jo?W*m1+MmGRQ5O>8l982tR?%KZHDO02A84bBLDnJzomkN?Rl zwl=4h|3@d3u`(w1n@K9vznQp#tCeBO9a+X08wS0)L_NktKR*U@_2n1hT~@3%aA14E zxQ%VaCgv#%1SUvZ%{94l^R{SCHhcA%&)5AK7K;iuczbv>eBEyCaEbE?*ES|6hE)zT zWKX;_Tr7G)Z~^aDrsjlu|2Yq8WU)6}au*j=R8?(ao_puU!gbq{eAY1d8`PiSTfkbx zytArd4debOwiS$X9qP9o>+@s3u#tK9U&ajQ+=O`!;Q|jXKH%8K%5>Di&FPJKN<)kFXM>gjiMzaKW z0f$(>R@rB)$*c^D*Yjk&n%{fe%XIF=g*$1eM9ou zv3G1`f37MYUvJQVU59()v^FctMg;@&FY#YbHpDuH^?!eN_T%#cS%m=qj`#8E(gsIv zJqwq<_U@d_E`bf*)*gY+{Ld}s{3}0OmxJxWW06N<51z9(#4sr6Yg_llbC&Fx>$u-> zU3~qs<8ps$=Po?QF#EWf!@mUS3y;Njt(U&Q%+j!PSM#6R|Ga;`x12l5x`8eFAj33; zXaknN^I!C*O*kw6{P@q^O?w%R&FTO2n5p33uRniJe+f*y7SOTyyZx8@%FixbxDt3Z zJmu%+r~4f>HCKoqnBF^E{J=5YBj-6EJbL<=m4l;z`Op7)X%A+Of14-NTWUMyEMQn@ z|EhM+iv3yNegw1h)aP*sKiI$V%7Xq&tc()>19x$%%P+tBSbp9A^u7Pfe*T~QbG^p@ z@TLFrU5noJ_3bY_X3z0oUgiZ$*_VHlKWfC5-*_yw!byHQCm727zer@C8$uUwl;D(iqv4TVEge&td1k z-hXn>_9xcmF&x+D`7-0NzV!SD^S9mKnDD>A@_%Z1RgLWbvIqag8H)ei*8B3}gNE0H zwb~ahO1*jZhU3e>l=us{4G{$ait>woS)+=4%Zf8PCG zzv;st{!jYL>y`hXRQ_UrVt@Wj{sRxWw*0H#%J84}+m5d?1{)Teo)FIA{dN4$jV0_S zxW8$znSaP%``788GPid5_2VHM?yvss@%#0k--dN_#7=P4=1FC#3T4HM-}<)L?bA&4 z+t*HXbMDgp%cEv?-|~9d_xU$gtn|5hQ&D@}^hqn3V|R2*Z|V^j`aGq4-|w@$D+G1d zn?&dT$vay=dCReFQ5VzQJAdyJd+UAed(eW3n_qh5{Jy*M$4gdg1+&BD8W*4L-oc%e zy+`rK!<)+QL+?j#`=DA=vv{miea{J5(U+n9PzMAMY3r}q)3@xM;- zb5D*wWvRP&o!x7xidf12W{Y`A@ry&>{dlc8e<_!2-gf_#Eh+VGOGG-vf5abqQM_GwNrX;S> zuezYF{z>Uz>wVkL-{!}Lc&v`nUOY*;?ec7iS3fRQgd|wZl^+-(;9ou~JwUH5N^PwTt4f{NWfOZTM|zJGNpY9^>r-& zBJvlV<67~fZO)$OKW{Bg+FNh*XkN$a!vFiy;|2NnE_U?#j)=!#y8AM6_hwF;4Lf`R{i(K~Q{c%MHsDA50ZQQX6kg7PVNAStbu}kUH*)H$+DLMw%1P14`+FzfBS8(dZ)-Mwbx${g-m{{%i7(3l{uX`LEJ4Udc9=* zn}+LMxtng@YLf0Xz3`-ahE;Rj9tR_L`@ZO}7o~phIBVdMsju0VtJH2(Yq#V@@lt`X zsK>su|JAo$6P4Wj@TQEl``YP$Hz@dv>AgC7=;Ev!-trrl-+pW16rPoQQ!eN8eOs>Z znR%rpT&XiOqeMghe7?7P!u2)Nbt0j)Tk^CD-L-v% z{LUTQA62Rz+Isey?8&Xi1(pOoKN04Bs_fjEWvU@_H+bx4Qs()t-2Z9P+wD~wexE$| zMtj1I&8M@sKHG3)<`wxLqWPNZW4v~xZN1sP?EVIoEroS`Tq3c%tI~h{>vqq(xs|eU)}z~G+iFe2>$)0mv7Fvf)2{S+`jXE} zlcoL3vfp)n_OP33CmVM={fCO6=dr8qTaI0R(OtV})t)I5DRq^}cGs2pV=ld%;IgGf zzDMqviPpqVcXhN5Y?^m3%l%>4E}zx6M0PWBWcb>2N(HVH=!kVbHN(@R#>mY3(#mG- zPdn3|*DsiKbcT80s~*Wdo2`#Kx$_%39P0M+H1Hex#LGDTUNyC@O?_)h&d)0msjolm z`t#{X&q4EVVa=ZJy`3EzMY6@jmrvAeJ?DF8iix?R$CK70EeDLAq?_9Bl8?N1^vY+~ zu*f|R{v4aHsMEZ*jPrWv)Rk60vLx<)^T>5!Pqm!CMXN$j`fc}3vpugR!yGi# zu02^4(k-~?mXP3)2{YnPitzo4a@>D>+5wHvlO}I|x#Y=_V~(?!re3hHSg)0Pv0JCC z^I>av#qzoZhrS2#6x1{9lK!?kqh`@=uJawQckDP+^>xuVg}r-MoiHf4wj^lBDXo`B z{C7PGF}kn$ekl)&rNyS`ti&&?BK000{r&E-j7+l5i7n9*8s%rF_@;H+zO8oKCfak) z#&_3rvvOtkiy>)di`VbzdFbnuap}azr9Cw*W?ubjZ!0Dk|Jl50TSX3k-c6CK_VvBH8WPvnUfc8QhGvd) zP+r6GTRSTnVg(L${MTb>6M7(edvkGK=%Jvrg$Yx)yma)Kd)BDSV{7hi!G4d29o||_ z&o>xf>Twko`hDwhgOu(Q=DSTE8Yxa+CGatp{^&zT;VOHe3mszI#0gu>BqXCRvw61zHfW!R=0(w0y6uJcXS2V=7#lW{X2TE^jqBm;kEbKWFOAC zapT7?#mRmPN{(;e;>rH%kcynwA>NF+ESsmj-8CYVq3Sl?)$QOTZP?^ z&^Z$<*q#+?ZU20%xa`Q(*(>v>G#S16X>wfcHrt|I?z-|x`f$9bHedJo} zVK3~Xxxr|&)LqX5cC2MP*Z;KG`!r@atw!Z1xqp+0l0LhS$O)nvbG<&-MOz z{^Q@8dYSwc!C7C$-DP!e8+3pAkh|psOEDYk$uCJqJ4-@*T}sYcZx6Y|T+MIr#&=`|s+hpOeSOB_KmWeS*z8`NJG)6zXA*l_;+Jiasur7!Cp8{!vEIm+=a>D^W})4k zyrU)hXEvt!7G0j9zcF!>?W7J4#|h!#-*$Sq^544i?@E2ovcJdPs60)wnK?Bm`;^+p z2Y>hGO!o}C>dYvyukF_25c66Omx|XnB0h&?CwXT~yTf?ySMrao&zE0uyqurl-;}wj zl(9&!_uK9$snJHRNwL*5sP5(V>dfPlnHA^dPI~ul{?VG!s#G7=D7kO! zervAt)x^h!+exb5uD{SOSX;mHm5;zY{(1aqDjGYI3=>rk7MU4|=Dd1QcRA)|=F<$l z-(M2GeY@N~QK6D$R{C}0$--Ob#=igfT`PXSfvL!W^mBdl%W79v@-Mh_J!TF^>D#>; zySKE)Zw(Wz`j^S{Y0A#f#e5e&Otg_xtTw$>)T+LvCVbUVZcg@=?n=%2gG*DF=k@Kg#$U)+c7K5_gZPyj7KRHAl;_>p-F?4d+N#;VR2nW+e(%oV zusnC}S+vqOuJ!|UN5ex`hwa(6=<@EhDzmwRs&%is{Z^CZ2y!`p`tXl8PDL^I+aFIj zDfX;gC~~&om#S%{uF7W`rDxA!$akp^(BEO`x$^JEo|#59ds)6df$?2@~4a2d-R z<6A#pU9;UQ%X)R9zUODLg$&DJpupPlo2h->C~cCJD`pwHC@g;HD$?>t)c= z4eJ~1=O(|5cK0gRZ`|c1>QS^-gK6denijV38~-x6_c}5x{vlki%(wI5v*m%ty8K+% z+hPl!unBFIzg+dWE4kP%rZ<1@nIaRFa`$C&VN6=}+v=ZaJr7XYeR$GV`AIrGaqCWH zN7`KX-1^iq;Kh^J(=!t#m^HH#Bd6%HSwGoeGF5-_THVKwZvI|t%B|xR9xZysBp~L) zVxf;ya@+$ejx+O@hjZ7iUzxmLafPj=Yiy9!y!om3ZEc<1Y~p2?PHC5luM)1fqP9`{ zS;qE_D&M#t3f152e_^&FVzZ0czDDyt;RQ(Km&p4fX$ zIqd1#T-mQoFAtv<+!Pi&=SuJrrV9`My?OgR&EjAIXIfy|$75%6S9Q0zd}DrZ6U@82 zLTKyDi=Pbjn)LM??;gLsu8n1zd#UNFkGxTTU&|QY_)$Ig#q(!u%=MdlcH*A#FoW7^imRsF(P$G!sqgs%;mPpwBJ@ZAb_xfvc*G&I0@wmIoInfG@mi!-v|oY2_7i*P1Tw`4AGbJvr#laqrC!vQPBz>zQ2@Xn$S5 zHt$Vz%gXKUdwlkmz4AS|YQ?H+wug6|y?wIr`{fzGWA=#i%CMOS`sN*w3i5lUta9?x z->zf-xF=*kyY)Nec!i6m>6{le*KH2Y*|=2da6aR@drpRBhI=1Xhm{rY%nY%2)?9mm zlXv32qirjXKia1MXN%UM{SjZv5B@ySK4<#8v`_!))1{KTzl(?#9=aR7`RmSF7q_Y9 z?+thSsCf3qR;lLP+eODuE-z~>n;o=j(e}&pIemmBVm+ke79GexdX?R@KJa~vu5jAY zEU$f+Re2^aOP#mfcpCq^Ma|E9ZwK<*|Mxf?^yIHr@BFF|AMb8n{~2iq99q{MHkkgx z_fdn-l+sGo)gSAPPUX6WhPK?1p1b$Yq6Z$g6`5C0xOl6t?4gp;ihz2TRh{nxGoGGw zo-I4K{Q@g_Td{W6UH{qnv3_ouV=pL)ug zzUSAGWsxeY@0)2UM?W_{_I#T6;dRYQhg(-4mE0u~8>n65y!*-dPnYVaR&EcnS2Zwy zEo7Oo)9d;s<=aO>wjDXldv$$u%u&XuaFO+Kp(d65@1}QmcYX7cO%v()^e}3-+NQdj ze}gXwi}u<+f7zKTP+G=2_mi-(L43safaP26Pt|O_wB46Q=pIx0jN1H?@<}CL$DVgg zc`zgK%e+&|Cx4oH3T77B4t3O!YD`u(P@bCyq?8_Dr_#jZzJ z)f!B_4=?Kc_P0a(=yX@V=9l7ce*6`SOSvDJ#_1GSxLbl#`DXr=eRo@5uAa2*y2kX* zFPvfD_f9=?ti*aj`A*ZuT~oFkd3{qko9V@YP#eC3CkwVr=-$j7#CGVN_{L2pXYRiE zRaIX#ms%t2 zSElo7x$uV7KGwC~Z-g(}U%j z{bu8I;MTj7=`DRPi-PyEu4`L)@K=?zSihpH}4bw zl2RN204ReyPw60hO1!k879SvD^4wNnh`^drA3E zttUFw#q1BZ`O5BH{pZ%s6Lz(4=luBim-)}r@V;={Sjjsg3B_i5FN0s6YtFO0DbZi| zf8sH_goL0sfx`bAyC$*OsT#ARYy4ytn;K^t9ypZb>=`n*97-@^y=SdKf0v9NRjp-tE>L$%_J$#W{mn<1G0S4@gGX zZjkLPkD6%tAbEY}hxBc%Tu}jbHBVVH4_$m(_pcy!L#Cnity}k3tDjr9wz8n=(>$Xl zhIJ{{OWn@B+PWh5$Gl5ds+P*FeBIx&u`qb|>YrQdMQ?P?W;-u><J(^;dbF`*!nSM=Ikzv#HfrAAboo(n~XZmLU1lZJz>bOmpEcyY2j*OXkg=>0iG@ zT&0{hx69`C?ULj*J&P|+nDv`uL-VS`FBVM|irRf~m*?H%5A-%pzuB7afBv$Pc-+1t zRSVd2b9UO6ubx(~`|9>1#yZc`b9=7eIQ_{ZQLoIP_E0&edhy}?vg&aUx1QbnYPZ96 zlPKNluuB}*s((!RpK#wiFzD_dJ=et_o)(+xKfXR);`rjF6FxiG^vKe(e6_BBEkGB`un^l}YH>(`lM_e)W|e z^}4j&?`NS*&osq==|*5YqxppwY_zc7o9lO$Y5HZ z`B<5&Oh3JiebK4Y#_JBmi~bdTtlFZd^D=NUzsFbAH!r5XT=QD%uVus98H;8+CrNya zQkteS<41=tvuBkpPkvC!q~C0NGkCjw+?~5Wzfw9mM}5)V3G1t(r|9{dWmGyPYgyAf z-SYcEtGy{vA=9c<+P;LHn!Ecq%lbJT6W43irq-LB;I5b>uu@KsQ{0tfsr7#C98FKl z_M(6@v$WMZSnr9{e425(J+(sW!He{|W!d|srYpWq*~2I0D|b~OME!Y={mV(KYL;rR z3RqCwwo(1;rTX<{2Tgq5*loUfkA2~5_mYfl@qN&yRxBA=~vRJyw3ar-=`f1 z6y8mH8~w?le#foyS?ksd+GRv-+?cCTHnn{Z0imze|K@u42c;_m+bky$>q_HS&NTtToz&LJG1k+*l~mJYxlf- zkvO~YX102$pvwI9iIrXP_kJE`ztMi(qV7HOG1EhplMS!edpk!TsbAD}Fi}_4KQpr7 zb>L0CDJLgMa!fV5#I2`tP5$w(x_`BA=PEjCDkt9Mf6u@8RM(SxOCK&T)jhHz$q=!o_;5&*KPOR5|-o5doo_ln7q;d*@knwH$I-pd`aYYe!s@bjeV=nsZV`$ zx3@yd)=aHwlmCp()9plNNzHDbSN|aVLAhI^SlPoDLVBL9iMAzr-mj{-_hmBnui4@q zJ1b{{OsC4${dtO=7N4vBlpi=BbirYX?UwTzrYr~RUak9cY~9PLA@yf7c_q^|rp2&Z zpWl1Y^}xilFW$UPm~Z>(z`uxVmAcInxAz@NY3LU=tQ3}?wsR_b%~ILmYf?FBD|Eis zr|+wikotYV>S@ct>ci#r(%)zP@j1O9qhjsF|A(hKE|o20s$RNmcc0U@erF38`5BED zmh#u1zu|J&)uimt&DW)D$;pgwdrG=iFZ2t}u9G==_D;r>D&3v(?t<^`oV7kEyJ(q{ z7uV{q^Q;QPYZU!Yzp9qp+^&T&Tx&{9k0If?yI?$)1!np@d$=}lX}sy z&X0%l)3?0|Q1o^t*O4Z_?5k&-}|p+$B&vlJrVPVS@c(`OjL5boOk_mf16FqgZDlR z&ow{V_gCCCw9e3WOV**VgA(&oS5`cjeVr#?Wc~5fyo|Xardh9_*ID(Xs>iR{=ipSi z_f5>z1@~)D{Y}k`xR}r|d+`qSkE@TKz57q*wVJEo1p&GKExuJN7Oart{#YRTcwWbR zTZ8w{7ihgMxx>WvJ?QlUAuHGG=Jnh`XV2X_Eqv{vPnqy^-Olii_j!v01MhVepHpO< zofVTfd0}aI=?>O_p!Yq~PpwqTDEuA#Rr5kE!y%x5p=0rro-@ zuRc_>AX+hNM%$ffDUnY&`NabkZsnG43s@`tZNrtVKkHApulmjxd&Buwf&Yt_`J3;% z{1%JOjD5G@;?>>DZfSfzr&%K@d6l(m?Yg}s=05*j9dlC;2q455@nkTL{JYH_3 zvY^+jrr+lL@5QO+%o&flUf*7j@?`$qP07pZ>O(#k7TmO+@~vX;`XlPU5>^;KWP8V* z{A+@8`_+d5E51id9$uI%Z+YaFtn`K}a<`0we{tQt!7KIuak)*4{!aCbJ%P0zJ+j_Y z*(Vx(?YYQ(eYH>hGS(gYMFK9JzMrgTztrr4cZHtA^x2}T6a;r9s4XiK@tFQ)Nymqq zf66*;ox9%i!}+u>rfTf5Ipp86Xtx+nyU5ZPD3m#4=dQUsE2ldjeVVaopY(3w z8PA`E#272TRrpb{Pk-*qTlS9=YF(eG1^s=ZlHYP(=|o3>$EZb;q8q)2l z#~?aYeOA%Yk0N%m#_ij#6&-l+_)bH1%k)W2%Mw@K3Ey7$Sw~EAGv_%k1`f;e;Ml%| zUy&bjpS0U$PW0jVVs)GI`S;jwhD-eZXqueg!{GVl{7NI`xoYQhH+KH0eIaKM^81xX zYTM1lDYu;k;{Ol1s7AhKy}1vg{u&;kf(k(VCEh zycbm#h8lm8)8$%TsUUDp`mC0BxvFN(SbtwtF$&Ox%|LJwP}~U-?R5Yj|*AWq``+-)&Rdawh*; zGTBwqzNYx_7Mpf=^(F5Qspg)U+qyhr&&`5r%bBvjS)UwdJ8E3&Pm~Qm zE-;a$vOZbkjzg~9?7%aQKQ?<``uk>?zS_Q@FEqRj8UDWJie0&cGq_%{d~$e6=#0N& z+wL#7>P&hpoDWY_FNGhVB^PYtrl+~f1MWX_xK-oA6}9!_5x>Zq;v<+$h* z=OsrDS=+N4a9bL@_HR{cau1u=+bVM`neoQ$3>j}HyE!vYi+AsTA7(U1ipjK$FwKO&@-TcDo!iE{2_&4ous)-CawWhV*>dTeV zC#l6}_HcB0dY(Ab`m?9KKd8_D)8dNi7UvCHkNx;te*2R*yRhl`TaAu!(ofjAY$d#B zZtczIX^i1`U$rkF^uG1nIfhTw1?nr=4f2mwS;cQ$FBNrU^_jOTl%LxzEc14-{dQ)# z@V;He+FMud`gc+^@87hLzRjHaY#v{edH1>m@yPd@@z~udSGYXgx@h}^7kcl1uzDuk z+AnET{v zeGQ+=F9k_M@2jDYgK{^&(~Y^bdg8{pF;iW7Yc4XZ>8^iNeAw=3&lD5GTU)wTh`0sc zpS7%|;QjrJ0&WM=^*-#qbSUrW<2O}1x{Qx6e3X^Fq`KjUO-P5|si(qM%Np;OynN2O zL}ZuH{=H{+$S&G>^Yi(v4(WLp&wR>bl>7Y8#N}0<;QO4)`Omjc==yk~?4SHIt#$uk ztGA3mtG7h9-~P=0M25-SZ2Lh0j!;=YoHVn!nFWX|Dqv`Yw8+cM%wqb) zzZ@bgmKH{q(;ZJRYSj1cU=6u)U)Zc~i%0t-&AEHN_Swvx#>Mk@?oO9{xuwK%>Dq_W5?C#G z4xT*BD#ChV)oZEG42%v6^5Oy~x(}aN!S3jAu>PS%4_ktGIERedFa5SP_1qFI4oO7{ zER$C7wKIm?S->D?$I!n(qkn>i0LKGXCf9#ThhkkAixkQ`OdaNOFJNkKj4hN%edrgb zClGDTQZ#?R9HUOy8U{H*LB+oN?-(-OH*g=}Vqsp6PTfUfQ^Zj*+lfp4uN?bd<-0Ef4e!FcGVx6 z_)no+fQ4(5i%{KiJ|+#1Y-WcOT>saczj})GQA@$oqE?6ct0(?y^K3f%$sjv&$6{rP zwt}NSr_Pr-!kW|iX1DnF`R%V6nyU}g{ENEjkZ{dx|EUdS#gDGFJI=X#;8an4(FB2W z_A_)P7zG%*IJmezFdR6?uwnUB+3)LlzwDWFpniYv{=^jCIy=7t^#4!?odC_J~^D_fTj`$%ZCpi zIG9>mSQzT+|MxCtZTd6w`2L!yiDm^2C*)r${r(bu>Ro+S!_)JOiL8Ijr?JVbj4^0< zD!*_x6Kg}*3G;dX(|3ZFc?E-)c`f{(@5YrE@FL&(w0z6|e%U7+ja7e7I%r+zZJfhY zYEdMX@ZZ~%<-g&sR|(l2vmgJDnkuO9#Khxp&cv=~Paf7kXZrNN(K$v`VO~PEF2|u$ z@A$9&X?*>EmbnHC+qI_MPIY$;JoFVl)aRT~++5^vPidV;=0CH>iN;^<*FH@QD|j7$ z_?Wf=2gA-C4SNbEr1!>fGSpN|2+rjF_D463!CaiD&tVtC1k+!PIS=$K_VZ0+pQ&!n zk(T|EX;Tq{a=x>4{So~`^UWITZ~wEnu)n9K#$$Fj_npV}2`aC;-Y6cq%2>Is?0=Uk z$AfJwJO6MC{Njy>cKYA?QOWR0-h=-qo8SBY*k7$!eW*9(-!7hi$0{lr?rht?E@=bz zjhnn*{Bxd2{7Ee++5Ai0FfK(vW7FaPhsFLe|K%4wS<-UgPR##AMMm>_4W>seHa+_% zyM7by+heOc@euR>)ocvgg^g-=n0`9+XX@;)_r>a-g!${zvck zx;}f)<=7?qW&NRl%Bl1rJc!|-$>&qY{dntNFMZUq`AqR^uTKk0*52Io;bUgJ*0%TJ%JY`J z-`qUy@{~^k8lU!N8@12*$vpk|``m+Dt`&IQ4qW(Uh3TSZmt3i)=V~w1&YWz!d_B?W zZq4ja=~nanSo8UvZU=if7HwzSb|WU&5MjZGY^J;Q1}nr_7UH zz3`m*(S)DvA7LtDiO|Z?JwOaPGt0wj3pmgDXBieb+wsNLp&+=JPIW zIiH$3qOM9-OlQrmsn7e9(%=`Tw=3*-wCl!nf7i6*FCO#$;P~{lBkju-vp^%0chcQ$ zp6q@?k0x8x=r3M5t6tgSkC)O8SEW!3ffxG?$}0T*s`ck>D0|yj_Fc8DvT5mQMRWaa zJG1WHPA@y}Z89TN;1B17Wp`U%>q4DjQ`&MBXmv*KG)~8P}c5u!} zKkV}3n$}h3nJzUK3YB@8o_z3Y?X3UkklcH4&t(HW5$oA%b4piCdG+UTQ><{Cxb8)l zui;&O?di5xyj60yUb&<7_g>iZ4A+BPhwSfe{UNr$KsuAF?#raM@~d^<@82~sE?G8- zJ1qZbkIA!mO-sIfMJ3X!#*rxn#2 zb6WoB)Wvmg1OsetavM7oUUV|&F4Ne$`>cpf%iXjoHqo`^{|ootw+!jJ)s<^G>0kBI z%7$~Zc{djw|4@49{DesXSBuUzc3N0HWj8FHTxwr$e$v0RBTrXga$C~O*u(ZlzwXZ4 zWTWZ6fp_`@AG-_nQ{O(`T~@W~E&HS2%L2Guy=$v=-gN$J<62$7G;v9aM(nNFpP_5! z<=soDd?V(+Eq8*+5r(+=`ySkzwtKqD)!6x;B6L)Dhb3hMPEy{Izjn!^wVJg@Q-fcf zc7JU3TjHJ7rj_-ZU0>Y1Ra9mn@?)~Uu0_#rdA?NP5-S1wo~>IN^Srd%!mvdR7!$nL8u3fA6&Y*CM`z*ZYRqnr>bs>bI^nkjv7zJs{^!aPOXHZ@XV2Y-Ovg4M32Yk^du0$VRccy2(?ArzW()RkwhL4Z^IU@Psxv=Fu z^A9HZM!kPozj|~0+dJDx`$C6sPD0|^#80QE_*>3%i!?aZD7*M|>d$Y9dJIcT(?S=2 zNc`|?yE)tE*UEntV;5|io~9lh6fCo2#c%g%9X0hCMQySR6CTY?TT;E?m~8L5 zS6Y`Q`=V!ZeZA4{(3G=(mOYOa7fsI=e&-%1lD8_3;c>sk{*Ik`t7hCh>b|4TIq~ZG zb(;1fD;{$9@3WrSy;aI8Po{P9xrO^W&jkf*{kpSkS4GjCDW_)@c0HYQ+HP|~>YJ&z zey`lCq5oQrue0@6!I`tg=azqsa7bc4Bdzsp@|%mdHf}a*$$RObSl_tyO3+$CNh?n8 zjzW(c?Zxc8hut2R|K{5KDB7s*YvygfuiUl~+E%}HJ_j#;wr6usi$loE*RySpUnrY0 zL$E1##rkB9nop18B<)+jZ8zI=>O#$W8KL`6epG%xeuVwaKhD<5E%HH6q}M*OyMA_| z>dNnL&lQBvyJ&OA^-SBsSnbC6`nL0#C(UwpXV=_c5-#%Puy-%HP(_Py+zw3+LnWul8AG*D2NSdbi zY2KAvADFrF-yQw6%q`kwLohb5<8c;lzve!dr{oG)1))wlF_xbnS( zdiQJfF-vFUPK@)t{)3# z^eZgi8}KMm^pIX}`-S6uUu9T~88XxIo29g>c$O%{9yt{!x<8i(k8ceU;mz%=!0^mCk4We3^B(s{h%NyZm?Lp6aZabF1;2 zvB|y#pVf5zB>pUUykc@>&6yp=tioq@9zR^$C_h9__t_RR z>7khK!+qOz@771C+|I6$KBdxD`z774cfRBA`CWFQhx%I{SBKhe$(^1wchk*^GoBxs zcP?A3TseAA^X2Gy;ajJ5R&ANBc!hDwYrpsB zsvc*sZ`=?wIe>M~jvl8+7gwm;g>L+JV}ag<)A!vq?KVFPJgZ%>qJD)$-?n(J6&eSY zH8Jj$pQ;^pagAMBUsm6J)~S+N`Nmc4ev?*T*?LY&G)S!Ev*MJ!4f6N)J#(60BXl); z(w`+0)Lh$a{-mv24g`OYkU*7LRC41qU}iWgaC^?Gnbn_ita@x{yA zz9;|nO<$BVf7;cIoB;cylfHJS)EhQVdUNzfX3dFPje_4Jk3U;FIj1@+p%;tOTwf54r0rpF;PjtF6dFF-%W}BMUZ>lcXlB>tAxz|wBPNY=y zd}PkUx66Jz?ph;X_;hybq;D*rgAOQ^Tu+O!uR0#7ed7I}szc$A^q#4H`tGy6VcGhy zdj4nAUVBfJSKU%r_xk>%n*|v+a_25#w#>4)=l$bW_y;b5lYA`PsdN1vs>v=1HD7i< zNSLi4w^(~hP$2IXK1S|K0#-Ly=U!Y9^W}5Z_X7>$73{fyzWR))hBSef)S}#Wn?j z2iE#QKk}?^hMu3VJbCBVd0W+Eqa63#dKqJ0W#RIn;_2N_7WK+uCb=$&hi;V5)6$jx zbpHE&nPQ*U-=1;KTT_}4u)j!C$IvsT>ixez+azyfS2=tM%fT zx}R&6`P+hLdDqM9_U#M(F=b{_Xz*_%!-%FmpZ4a^%g)8A@-;`a%#x{R>y;wpSH=sln7kCr zxg)v!>_I8b=43-dlC$Jhh=-QpMMFfsKno^oy1$45_X_HB!sA%6LbC}`ro zahB(iqYh~sc4fMEp0N8|mQYZTVDR|=u=Ykyfj-s5j6npn>n+isR?WCw$!kE8`JYx;Y3 z%IR+ApHrEIkNnuPc9~Y`ns3={+HF>xL8tT&8s7}EzUKdPO$6uJAEz`ge<)wJVtIhX z%`1PWtfRadc&|P!+NRDkB}#agF7eT`poU2D#(_>7C&SNFBFZw@cUS#IwyjmU74S9d zYDDL;N$NX4X73K#@89k2vA=KU#~^XKh+H>nP zNl}$s&AWg9PEj&A|Loi+(a`j*Z(jX1mGX(YFqK`mOo=&lBmY;qDt-SOckb`ex0^Xl zs93h-y`}x9=*W5LQLQ^4rxpfTc6I$_aDF1Wx9LgrTpvNvAVC8Ei2t!&L~KrFU^xh9}Devw6BlZKK;A1%|orU)y7Xt4$EC{n&ll+ zr(eV@xZ9bL$)%l@Ex!HKtDE-)L{0avtSR?Z7KvT|Uh2=LtX*r)XMeu^pgl!r?;eTB z#%x#d+v|VLkmq1+lYFFnDS1Xs_9N-ti#GlZo-T6wdU|W|gd8411p~|_+7fx4g z=h}VRjMHP@v6R<)JsEuro6o(F{2fv|KYR7BTFoCj%ATl+&zmb#-}=7%j7Y_2$B35K zX}gxxUY>L*_E?v#!@llVu5yP37Lz!&ijuCZQnh5;Y`b&)nhly-S9?8X`X0D)^}5W) zSBJMhpIU07`73Clri$c~go>vDApzGqtx`hH$^?C%yX;4z8Dr%39d({}dyX}2kh*iL z?qDg~{C)!`A@k3iqEGv`6tdKB4qRnAlVkUufVT^eS*evREA83fzy4-mPjWV2Im^-J zeex|k-x?RDxL%v`PDH;a@UUU;<#T!R)d%K!_-!+OY4p@S<0*%x$H9~C_BXNxJ8EoK zEjeG6KU+t5uCVbX>*Zf<-?{i4i?NQ|tTXfdrf%P7jPbP{(raXU7goCNSfKUAz2HQhRvKpGUz_^43-l<(hWw-g7L)WVhKQC)NMkd_HF?F0NWs^x>14+@c+Y z*JO=VYEDhrH1&2-?w;o!cO4pY1T+fF54~GZ|EKqQfXgMdv+LJLI#`r_T==quU+`i` z;q__x@p5r@9(%`M+EDn(Hc?7_ef@!!oFLs>dimyN zPl~iY?tR|zzB7C4>gRP6gVyb6(zWI#<<+Zyfv9CSPa{R>M02#|^$KRG%^3E4L z{&;ckiV4Q`=GW)&dreuVUzJgFdL_H#Y1hRPdM2!4Tdq0VR_PpD^rZ1($*R*efyvHa zp4~sDpF20-wPCB-r&^sPzb``Do6W+EVT*Z)3cXH! z$c)qs6{}I1y{t;P``FvS$&Wp{LN{8h_&sx>*KhT=JJ#ItJXl|tblUkmPyg@udt#Sc zG`HxaCmKBbdAWVvX?5>9uJ5@*)qQ>!x?lgB{PEGpnyvFr?z?KT?53lEgz2m}!`S(k z?8=rh8DG)4Y zxs`5ei7i^SWmbg9d*z%>5%oFqt7hC3kxt<&o&AR8$NOU+G-C2D&l2|dymSA~`~O3Y zPuDJ*wX5^{JZrta?^n(DPJ6mq@xdLTl}{&cUQ?|Wc`t6UXE4u;gn8!Ne8EgFuUTEH zJ|9_ic-}7+kAw4BRVfj_IcVFzyz8b&x(7(Uao%$z5?4Rm?YvGRRJ@rci zB&YP9G~V}C;BjW;k>|}JIexEezO?#n|0)|i<(>Zu=`WIu&(GxDXRkf^LPh*X9g}pD z{MV8_X7g8hDW=ao_2f(DwVwR77w7DIqBw9I`jTt#zhlXRL#zs@XWnEFK+!@ z`ziMiK8j$LuK(aC;JL!SY4V0iMQkf0zDn0QMsf9~}iStn4~WmuVZ_~y~$hh_OP z8E-83)a6v7Rle=Y*MgE~TJt1NOkM5R{QLQu!_2QT=kA`mEaPRfO#QYc!8bP!ET)wq%fkjf+@0G92 zPcJ+4RbruLMOIdzz|ChiYrS5<>#aPd zXYbrgV}83KDk%36*9DHGEB&P$2K7@<6$Ea1y!vuv+PSnB&a6G#ye8e~+ivi2$DZfA znf+A6YF=pM)haV zUo6n)Q}Os+SA3pb*VkW%yO>oi|7Jb4U2EB4*t#%Z;fJhQ| zyy?<|DUN5-pC~89&l5grx;FIk`7P`8pOr{w-EfJyd-n9isPX0yn-Jmsp>qNn!s>}r$T=(h6d#jl+`>dM}?)y&`CHFzu1x>13XN4c?} zX`$!+qgP$GxRm_YiZNgA^*f9AK-L+@57!DF{<$Ppd(TgfbI-cZJ0m@NMWQR%y)AD2 zZH$w&irks9{a8KE|9)p1$k>+o7N>i7T1d{;3>X;r-+F>Vj>vB_8O-7N=wu z+%34az4o5G_j|n>yN;c^^R@im36&h%la@QXxtePs-;||aV%_&V7VX{=tXf``{cTA< zPjg-11)DAB)oxv0`pi(E`2Ah=J2_Wx8QK547nx_%{bRy(f!g4ur|YHDjfBnGyUOlf zG0Iz({6(X(<-l{pZSy&w&e_Ph=z{FF?!JE$pI*M!J3E_cR;s-9pU|5tw{U z%u>GaPpuJ$*uN#GcZeyy={f-!|e4Q4q3gIneJr%EHYB*(diS5r`x?@vyKnXi^T_18!sgGG+J?n9sFhcQ&wqd2v;Lx4 zOOju$b~Hz4lz8m&^;#NyS)W%tlGUlMU9t9f&)nwv_Dc!DUxb#<&)O@KYvVO*hxzr} zKJ%*M|ERb>^0WA_^*K4*=>ONpKf|^}`Y|kF@4I9enVOou^3?NvpNup1#4KE7^5?Sf z^t>sT85=(JI2GIQ*7?lRy8YNeL-5|I4cDGCEW674a-TtUkbc0K@_p9Ilh*Dyet<8u zx8=mfm$KTW-7uDCegVsW&z;kIv+@2p$V&2v8Hdgm(Z z7kB3#c4H6HTfdz(`LN#WOHa339lO8lh*5eAySKW#u!9MKk^%JzDjlK{8>pL${A@GYM2b$#y#tykNqzJ0>l&U$S%pSTGZ2SXQTZ}_sPM z+U&U^Tp3`N_~y9y!+npfBc+|Hj-J~ldo=IsqR+nd`d=?jo^`b?Fzv6$i|_BA{n0n` zo!a-)Ili!UKrD|QuZ73JKY`zYMw;Y95&-|T=( z-sx_i-A%KKOz#(b67xA>x9!uj73VMQc<7ybMO0kNYE^Zup;XEnZ5j3y$BU&iGF0wA z{?0!;;VegjH=B-il5>XDDHm;r>Xi@n*I~DEH#`FXr7y zJQVxx=Z$8m7?HUBYpUXR8m#=c)R%e3scqjaZGx^FX5PK7`Fq>J*80<%?gYmsYTB)w zvf*8V=9=wR>#uHbJ(8mT0{m;f zyfxgq_hDlTKeyDo4R0?BNwrCOuG)3Cy=uNyeU>;Y-x-?}*?-o*`SABQ$IIvyw(GpB=C7 zzmwh`-&eC^&GK^l`st5X%0!Cwr{^DxbbYa3>t0IHX~qkw|J3GpSY|RV@l-H9eW?D< z4)fC&B!BWA%0KmH;wKezDQ$zzJ-bo@EVen_sITAsd>&hIpvtr9Q+8b}Tw%Vwb-tNd zV#?x!yr$)eM_1mca6FvuxzF(X2Z-L(l!TSFTbAE4hTpX?_@*=$|n!iHy*{h9z zoCAFV-Tm_w1D*aoUop?);JRLU^M$WwU%0FOcK)7d(`Wm3TRUI%>V9?Scox6mvyW{* zci#lKiN~HbM4&0z;)V{k|*!IUX;CI$J#nG z`4|aPyZURv^*@@Grv3VNQq^f+cAMkjvn`U3G~WlM$;%g3uPD9Iacg3C@rwrEV#DTfA1(D$j~tpE+t_n@!H1?O;lwWT867w!#g7Q?o!t_Hj%u^Ise%4!m zP4C)q#f5?XhbtfdwB-1%qI>5xtFP#To1x)i4YMzL-l$xC^|DIez737TQ}^e)Pr4XKTZ4Oq)_`TEA8i!T})M{PAS(P zGnyN2WX5tL^WBz>u`%y0v=>*LvS6LjH!)=5yG`Dww5!hjc3UV>$YGM~xOMSokM21S zLO70yygbX#n49~HC*FiHHlWO8O53$mM*G=Te^jo|6Z2a;A&YdkePkrvroK=}g9rG#;oDO~Nn>#1_se?mv zgyW0kMsuz2vkmrq*wNg#UNh3i;gY0qSjd?d7Z2Oc$!R|I<|PxSl+JmpPoKk$?Q?3) zUVTe7?wGz~>L>1L0q(g)gr#%xZ5cd4zFu`b~5x0q40IO}uigZ`)&omyR(p3kznv z*e|h3uUdB}z^yyyt>fdg5N9rMCQ6qyK4_|-*%d=kskJvUh?O>4eW6#iD$z(D| zVT1k2RrNv^4E4P12M!5pZz)rONQ-!o&E#JDXw`_;G~mg|9gLUT$ao z@=A%#HfOxV-o4;xRE#OCyROb&+Snlf?A_77*Pq@x{6NlN{{D%kB5A3Ack^nStLMc^ zT)D}+Naefu^Mfs)cV&*H+X3Sj}}$NzuTQgqME-gn)3?73xR4 zgu57S|6AB=e|FdY?`Igfnllc?F5Dk4#-PqG@WXyz`%|Xd_Iu>k@lX15n6>i8-2Zlg za%^qUf8&he7#$f-9A$md%3Kp5w7!AiK>PDV>9q>;>N_M3oMmlRmUCj@zx$JM%|ktl z{p&+qI1cds%KatW$*|+#e}#GV><0^-|FQmLxMTLe=@3I+`~L&%Ckqe%W0g;O_}}4Q z`w{;05BA^L!;rVU-m#8h`|14)6dI&I^4GkWEB%o1|McGrGq&45s6Wf}=Gmi99~Ay5 zUT=5&+xx$wRzbj@L*n^q9hpBiSJtV0xqOs8Q;YvxZ{SDGWxRh&!u;mz>#fZTXPHs2 zxhC}HL2bSCOPb8FE#9v`o%dTR_9CzL+pH`@9a$d zw04*;ojhmbE<-g(*ULUXr{$+GYGT1#*;vuw=1jy)1-U$TFmkWKj@$!}fleEU%6+GCmh34Kj>Zyk1icr?2A z*rB}5Xa8}$`Rq|IUZ!pOy~3wdfBxD0_zQl#-~B?r)m`b4tmc=BUZ41Q%|t!Z6FR5w zx>@|5xFRv&|1FVsA9OdI)=FIS?Prepw)ZAacfMSC_g1u8{R6j#=EwF&`Qx+J|Kxujc6)h9>w5h?Ik_vPaeOC} zTfLa39pNo0d(a~9w&bY>i)5gTr_)Z>&CE-+t}YVyUphs6t=3YtD3Nay-LEKZJ7;~? z`}6v>9rJE&xE}Mi(>%xfjq5^R>Ajr{tR`klUIx3boIlA$lS`sVe@(aK)h}W>;!oVa zs3=YjJlVg;Tuv(WTzBZ9w~y}6tGBd2-2bz0;;)WF*G}Hsr5JQ~htlj$pJ!^PTH@_df@wL>(5Hy*&9b&&_3tsZu959Qh|?H~sXn$DgkIU9)r8 z$rtaqa?{#7bIs5DmhW7BE2sAOv7LHdTb5kh$5#_D)2;MOnT2t5(zSRlmHxPQpBLs< zRF}M7ap7;u&ka4#d~>6$uO9L_#&AEIRkU7p(}(X)LG>wCPM5s1u1n2g35+@acv}2% z4Zcmzhj~{O&-;B95#{zW_~G_H8o3NNeLd$* zxP1CrM4f^}q+xPZ+y4`1E9CDV-te_JEA8Ad>3jaiIzFCkJb0zG+;Hp7N!#`tEt1mR zy#MaT+J%mZJV!RZs;$o#Jj!u_=P>u_Dpe_$69RL}V-87$KU!^Fcq4j~c(QL_VdS@n zb?X=k9W8RFUJIR~9yf2QuED3z!3@@+wFevL2B=?_3wdSNoAb8NUQk>0lgpC{eCC&S z6h9HZyR@)%?yJw&eQi#1{M`89WZTp2K|h4^nNL<~*zaE*XmELw&(oU8^`D+CS$$!q zj>u)5+5fEAT6>QldtB4KU3vce-3I#GC$5iOm2>t<^Mvn8C#uVv+N;{XhB9BzI(G5= zf{e=Z3C`1={k!xzw$X#NpuytIy591&rEJM!KAZmDYG&8}_AIGlw*Cd9@RKG=)~hbB z-sonM_rrSM*PObOm-0$39eY>!uyo_r`m=VyyMzC2mH0Blulbu~x4-8fpR)pu?laBd6p;zKb!clPRk z*U?fh)_S6XFs4qVAQztWB$D*7HGH%OVV9jMvp?6of{|tz6^#aI?n~q14ms zvsM*%tjhiElKFY>gR4ptgiKDxPJLoC%TU?4Bb77ejva4+!sDWCzW;mb@;s(i7rhnW z(bD}U@o!Pw%GV}ADS?3>vvq@gmqcJ|9JoJgoj3z3AG+ zBa?T0K3^$zfZU?blrv0 zf*Cq9zOSrxnjg60OGnYkch2r1F88)oYke!QD~q4Jf9A9ACgKZv?{u91U4N-Yct*PVY$ zCh05eyM202>WuyTOaDIlXk2q*`kon&e0S{53EiT0q&k*y?XT=NeXUL>W*IGGt98FQ zw>-b@{`2xrF>4OJU$R+H>`mt44|nx9LVd{~v6;_$^^~(6;^<(S*th%uHor55+%U;9z z`EMpRa0`4*pB()D&)u(k44!#))md%bJSWTl^>T~(OXbB(RXqQO$(;<@SG@3t{*?E7 zcS>*CE*g2ON5VP2*74MgaA{qEKHZ4k?)RojGJQSHdI#!-grh#L3@ZKQ_2p+w|J0X; zAGhcJKB&5H!iB#)vK0q=bMqy?m<)jKWmnG*(*QZO5Atzno>#e(@C;y$7AyT8qK?=uk$p2hs~Gy@$IPx zEUh-2ynlMdt=p@w{7k6tib%eB<4%Es^_w5l4C@zh%~_%l@S1(&-q~q3)vlM{{VQ1+ zmlW?&F26_E;L}dI%{-k;8CzADuC4f&VUs*XU9EU^!2j(0o3d#ir&sS)-7~4A)SRbm z;_p`XKTa+e}eIat|#1*Rrw*Q2* z7gev`usTNdq(jb|lv}O48|+?~WJw#}pJ{$;VnmJ1x^5*I3$w{j=I;Nx)z>uUQ}P2* zFQK2k8f(42d_Hw~bAiMaAAZ~nqZVF{ssB|@rWmTCUoa@|TXp#9)1t2Rbop`v+Z=>bRP zthjnj_x|?w?5H!VrFKZ)>s9G!E7!?9t#!u6=aeq9(iT2TZ{J1g`D||2WEDB2uN*ByT)Y1@=ZUocfXxHkHj*}p7~Pwlt*8`cV4<>mW+u|{_L z^xGfQEgTP6kJ4Y?YIat3ShwWcDvNpR*X#(po^nyqzn)JkvBxH#^NNY8 zdYpZ2)PI>#ici!~N40C$wk@jNxnX1VmCEM~eC)Zn>-KsZMf3thbk0hPvuRkq3 z`8mziMkeCDIgdg96R)Z2a}R2;dCKwcUGhTfrTL;|S9qO_js)L2zdB`-kFW4^O|yl8 zx84dQzdsXmf+J{#d_uv|X{K+z^5pri_I=jk(cV%WuN-pW@0HtYA8ehH%28IrZ+2y~ z*qz-u4>x(7d2?x_YkjZ(f-U>I9cBC__g_fSb8Hc9Ilp-C>fF|U+?`2>Cwx>m)3kNL z>PIDuW+(ZH*mk{HVB2~^3waM!k$fvd)B=)+5bPg-qOj?Gu`uB zSq|TXMIUSKRO+4x`7vqYk<}X=)r8i)YLb7UoOd@c{@e+sfE_PBCR_6+?n>!aQ`o1q z*C}G>KGoBcT*JPzUEiJ}7R%1P=Yu@wjQ3e*8X3we7iTV8dum1J#KqTqbz}EN-umro ze$3(5rL9XPh5m@VvDmKB%9N-5=+u^aEA?Sgc3ugrUI)RlL6-WSuXuJaL`_j>-NMR9+Qx#m4G&Um=3Cf`TO(=|N&OLyk- z&h^Gd|I~a|oK88$DkigTolp4oYH{1LNrkhQ2PDSFHUAd;yTteKI@`5hJ)fRBq*krF z%&z{)$um2$J8$*GMVVy3bgg=I{#@vppr^^sdmk^hqcaaZ0 zT*X*sC3Bt8*tL!=e!kwsZ|{ocuQ7G!zx_H;e|PS!ntFbZeP{dU*(!WVepv1y>3?s+ zt~FWa*8`$5g%+KWdi6qnS^QoE~=O`%b-YrS zAB!BXzV+Zy?Ylj>^^!}P{%%!B`&q*C@La!St$EfBxn0k1{{EBsnftEH&D9qUaX5ER zRWm!WXQg8Gn$P-MTbQ=Bng2T*B74vKY*PH*rV{hi<4X@+=DFV*{PfgJGyb&}yY_O* zi|+Y$`NqO2&o6CUW2`hQ^V4}1qvze1s-vqNX0``uouz)Eu5nF!$0TPgduDd1F*k9up{9?T}@h6mr7r@#o!V4+fI>xVa+8Fi-EJG$*A>Y0?oli1mTTS<~zj8@t+2Jc& z+PmhyeyxzNBD&{T{N2qREOoq||_l%jpQpL$0ya>`JzLvC}HOp=7ak;jS|g>|f@K&u_`%7Mc+2 zmMiDT#b|aUo;RiSoQZr$){3>my0JJoVYVJS>xK0$jfFsTXip& zyR)@Ed()9JuO=?+WhB%5sgJr3mlmA3)4r!=Q&PU~w&~8QnYW6gq{DJbqWNCgpLqUQ zSN=Ay%ajQVDz@yJ`CVjTPylnd#*cfmw_DeVxj(%Z$5~PN=k?;*U)OKlUT<++$Lq$c zjQr?pD(rIBx2MXbZ+OIW>}{&w)eXmC=o2v?m9xA|B!2PL-|xHgX!psq$mHvs%|E#2{(4>&*P*dR^;{B< z8e@>hoq{(0%aa$rj@ag5q4bJF$!pdTgNYBs%rz=5mp<8Dw1A!O#)<9wCbP^9+;+dB zNleO=-ID9z+!PDxnkYJx`-2FYS^YXXt=TKR@lxz zPhTCEc7FLeXx7!oouBlWE+?4wiJW>aw%GMd`=ZHDbtWXd^nSg+e5%H_!_{{cT{1P_ zii=H|{qf1(RR_1UJ-B9SuE^chs&V(mmqKl?-0EB>!`ymfqn8^u`1S}HJ$}jEH|2Mt zDYyQ9@!hRApEOTe^Wcc;m-Y6+#_wDAt$c8a`!vtCW0ng11-cIx9`MgRe&SWy9i_X4 zAyQ6TRoxrhl9rmx_q%eY=)otA`)T}>KOW^#TI(PnT4Vfw-_ZJ~z8#eLsx zj5Bi(>|7MZ7Bz3~p?Y~W(FqremR8y1hA(22RGr&4V`k=e;Ya!t-tMZg%2_K`UC!=y zpXy9+m8t`L2`RQ*y5cTMcaSE)~q^OV1TymrmJ3CbQ%rYHZa=zg>>(WCQeW!2`C znR4EuCq8#f5nJE=_BMxPS-f3Qcm0-IZEN1F-@aaJvVY@b9=(|%>mnE5s^2tqw#K8_ z$#KmU*N6uy9Hzv0a zc|VL!mcM#*r(bdMwaSMp{yovQk1O%4_ql)O`rBTYq9;PnrY>K9`v(7vMJKrJ^Cr0X zo}as&!F5$}v_+zb?JcR;+Yg_%E)t7ZY}+uuP`ccE?Qgs3x-pJMtUEc@otK#NsQs0B z(Sn*uy?stjmlUk4zZU(Uy3qCGwAM{KeXeS)&Aqtg^T%_^i8jBUGsmbW*M_{!x%+li z*7K+Jwe8W7)83wJ&C;5ZsUYvY!)w|lwHzmNk$WCb4U?UV4^6*eDg1i&f~(Jbls!vA zjunM|$`FqHoh7!;WOe$b-klj-bFXfE+23bs7H_!9`2Ke84>6wI0Mthi9@ep)zBO3ja(zq4lFtNc-__)@*W;_<#~sfTOx?%oahDOwe( z$Ng&7CXE~GrmQ!(F-zRtcB9`E|FCagi+K+@ma}bS*z~Xe(j=uvZ!ZfjIHK8ACqHSm z_SS{dR{Szfv%l&)<97Y*LkwNt|8(!HI(B&Vo0$Bwhjq%kB?Z${*H@P9eD#+t?e{XP zgTm&acK1&oIkM@__w&=G!cVmAO|N(Dh<(_nAiMlq|Ndw{)SM z!YBR9ElK^kXRqI8pYdvWP{~<8Kkq%!aqNqp3Cv}?kSTUT#q7oAixMaKzSO6=W=xxQ4lRIv6OZP3WbukFX{4Xc)0FPM9%H6qCIyGh*nM-2Wv zVr$NQ);YLi-5gKTU2L3+rQCkcn}xglj`FRVF7GL58XkD=(KcO2uZOZVsg^}r2cLTU zxF0{cl#Q?TZqcQTrtcv)EDx8=P~3k1@$0AdxA#^jANqW(zWcxEJm0en3-A73YgqKP zzqqSjEI?jOczS@v%F7Eh<7XV`U{^eRB+aGo3;RrKRY)b^!-?|S(wTCc}K3( z+eLB5U+-3p4%_*5laBr`yA8I=zV;sXp1iE<&3sWS`|k6sbA?Y=F9~1HbxQE@y++Qp z;f&WDw9oReuJ8UgecLPlO^c^Z_z>OilC?f~d$g=s%vA3evoF69ydvoDrD?Z)z>;+^;>eevxL>nH6UaIhs{uIKzrPrq|l zZJ*kt&ZE;037<*Ub${l6K%|V}+-e%3^Y{?8?n!cDdkbhHGQ_Hb)9*YxvB`(s`^vk|W@X9sNmIqySmwr`{>i@Iq7Kblv26= zsa*Y&D>hv(oV;V=5BXkZ;V%_bEjzmWvE-Hi3a7e?mrtyDCwB5c&x@REybRBa-j>8H z{q@XZN`O}JRqwfLY{Mp9e*bJ~__IRG>ZA=P^i8F%S566B5xc_MEb{#^vs3ifJLm1o zs%5L=7EXS;DtYBQ38%L$MoW&}-(cFw{!0B1LxK9gkFmVF*y_qfdO2P!=hs=foX;+> zsCu@YeCW6OJ2Lin>uqK(p4nr!Ei95*uzE_KTY2&E+nc}TJ~dsTz1wHro6sudx6DUf zSGr0*Nn_>r^66Ts9AfU1YoV>MyxjF}ep!HLuT>!^mFO$+ZDjuKBEcETSbD7QN}C@p1jshiB`*-SvKP`R79g zrUi3XTITs3v-}yl@W7$(2jX`$1uxM`oIY>OA3cYt;=>=)-10u>er?jo33zib+~#CS zyR-7g{G!WRUq6aODkI63%rW-{ZYTS(jaVxE90GuHOK8E)WX+GUB8@C_cQNb*VhRt zaiJ~Omn}PMaiTc*g{b`o*NUCD&erUix_AF9|Ni?K!p2E~A!G)%0X@;3WJ+`ChO^)(`?_i`$>K7JzL%CKwG)&=XIPs>_s zR6p^mePEGes{I_@?i*X5OFS$vU~_NF`Q`KeS>RU-m$`cw{EA+@&6WFdrY1Ptwlj3n zt|>M5=e$zvGFq6}`Foc^!_ueD`*<2Uyc;L{TO^aTWv0sy?H+;Ge(AG91Zx%XInPyN?z4@(6Q2o8o(*-T- z9ahBtS-H^h0N+nXqi@F7t_l3r;j_Iew|45Gtl#Fx-@WjU@|&U7v-FYmsWiTo2{lCf8ebq7F_a<~VsTb(@ zd0x~=Sax#T{`SN5LTSIYGOI_&ym)i;#pj|^4b`txfBU9Rxx2z=UZ(Qf`SvE^EBb6A z)Sj)XtKcay`yTm=C%5j_K_}t&J8hmFHu<0=sopsGYg&%Q3g7M4T&la1_bq&_U7M}P zoTBE?PlTOY@pbLQ~Vz6QI0 znw?H-XB}D;lj$ZiZ&F6#I+^EEnys@^A`>NxzSe!+6#B)&>g2jP7Xt(Hw(V71;%7ax zlIucVZRnc!qT!z3TZ@ls-BT#IU4QJxk|tfoD($@&_;$Z^Un`oe685X%*p8rMN0v^q zP;{F+W2K2!n8MG9=T_gYd{&p?3RcxvlJ#rdg|3YY9F+B^e*c^*T>C%C<}cSY$0|Li zt@Y804OV(7ZBw4EK9?mut5vX#|KiSLx1V@!%$aV)anHbVFHfuTw&jM&{S$4Dp66O# zpH*~zP3J#`gO`(f)z0qI?{)WNll{H@ebFob=@~nc9`?6MOx$!|+4FVo7f%g^@ZS-e zCm9GTykVR7Z%^LONpCI(?{T`)^6u@y^Wx9f-;7u$Rhv|xc;~Fcqrah(?TtNlyVcB& z4)RZu%hAaH+Va@Ctz-R^O){3B9raHvJ@fJFX=91{cjcW^EEzeIwB|1eT@&2@AhFb)Lnk{j( z*X@??EaO$N+l%WR{3g#l{lc_~&qQ%f*Ws;Z%Y$Bc*;ho>GUc;a>s-G0{9)SVaG5(s z>1xY@xlZKYIQ;#^*=V6{Yws;Q${~I`jFZ1;YEo+Ha#x|SMF&qeyk_!T@`C%!x$2hg z)%FGQQ(sPeCF$^Zy~n!Op%usYO(#!Ey8SkC`x&d_k+XySrQdQmzOGMwnjjY)afKuTkQMeUTDM;8i%!c^ zzI1-W#MH)VabmaSJYRpimgjp)&#%jJZU5z6rzV|mc(?M~I?HM%2G_ZNpPt{oy`#$a zTo&&{=1Chg_HRBhC-ZKk#WJDr74-sj_a9%Gq4ssg9=Uxb&VLUjPLg+TKFSjL{h#4Z zdDRQ-wKKjJgdQ!7Pi?%jTw+iT5iR&*|SZpYGGA{Ak7eX{o2yKbmc+#lP>A$;9XHd=(pvU!lG%cTabmMyPgD(l zFps7Fo4e>U{WVL=j3ta2HD#th378uD_m`>u$;A3kEff6aEg<>}n#l52!i5>#H|STg~RDrjfSSWU8F~*Y^1vcATrtcj^A6Cy+fuZfi}+pU5-PJo|p# zd}*?Os){#nYW-njHNL9ouXxH z9zpTj-<9q%6n_-w(eV0M!#;KE4=rvRx#u}@rK>bA8;caKb@AU*?|*3PZ%aRF;aKmwYnJt4pZ4nQhh3huZSX&9e|K4C z-Omhf){D$-YYxYi+Puzn@#9ged#~GOt)3d@)9Qb#!KgmN((uQ+DYj4BrcBh$_)vf8 z!LD1DHkxd+W%jQti`aAJr_P*bW}$bYJxW>`?kXjFZx!4s%$@c=u6xf+zuhrQ`ky|K zPHeP3KBeGKu=U1*ADzxsACtBmyYlnYjlWyMV=rIw>$Kl}t9*m&#g~_(yn41R+ui3N zsWmBV(w*J^7Pu6dZ#t5Av0-og<6QGS76H6*N4=}qlb_~)iF$Z@-bFUPmsvMGPR|f2 zx+!W@`bNOWarejaInxX?YYuMmJsv#uS)Bfc-%~qh`%mqZ)?OJHXDI%@_zkc6|1H;k z*x%z_7zw99OuQ&CM;Q zJFept-EMM-Gt@##%=mG%?c7FBk8V<})l9~&yZ*5yq_<})Jpn*N$fK+#* zBR>l}^Z({Lg_OGu*9rtgl+x>Y>mPiT5o9RMHfPW`Z)lI65*-oJ@I3L{+3(X8ulR~A zc*<7P_={mnL%{-R36{zQPZn(B5LaMX*WGaNfWm^gd>3T93O2Lu>SlT)Z}j{83Wi9H zGq-u4Jm6qAc>P*p(}s;3|M!0A=;&a`+4Db%p~#_p0yE2j9|j*8nig)jKT$45qn=68 zVSD?Mw{^F(ZbqNJ-S}YtX;uU4Lk|rC_4H=!HT}T&xMchD7KVp0I{cldoZqA@)Y~t+ zBl+*UnKCDMGkyn5F~4sA`x#GTl~c`s=56ebZ~keV?l_f77~#4gZeG zG!!&2nCoxnFxO{z!NpK@)2iq%-^%B_%>NwgKmBQ2t627LpMeHXLOyR9`>*CVjr`2h z*6-fRF2GRk%<#ANzy8Pf+B$M_4YDW1_%<+F*~lEee@{MP!Qc7WrP({APjDxkI(zc$ zS>^}-{{G2M`&Y1_EP&(2@BCukY;lE#(>Gk)!~L4y&fog~w3i#(uLqNw-8uUFX|Y z_M5*rTU_AA@BKMHmM>KN;6L}jechCY*AgbIH95lgXT4eDoqAD+I0tK8fjiee`X~PB zeC_<^-;P2D-4)g^zRzVX_`vbuPxIwsmYY`24e#FZzxv(G{8HQaS z*#AcEzWJB?hwp8rJ9p%6eLl`;`{r+UE`ODW0LK@mTS>L^ns0TrT3&768h_O*xS}Yh z?$K-EEBkl2U-*!Gv~lA8`a-)`R~1V27C$&|FYb4C+GVN2n!wzyMSV>&^BffA)t|i7 zQM!Dv)6wC_qz4m&M1Jz0V=LqhoTKdXtTXwY-KQfFm$uw_zv*7HSNnNwy&lQ96Mcd& z+MMUJ2F1?IdA}oTQE))`p0!nLb{Zd7a;gz7TCkFZ?}C`?{GS&zkG~ZWn%Gvq_R`n9 zPqRFavi!c=?|o<$AJgiaJL@E48V}4YaMh{!JCV1waOQ-J=Mm!Xdz0H&g{T*qR|l5J zUH+zdUE|yOtNd$>EnX}+*%@-$qGHLC#|N3R^pfW18fqG)bN{kdn`!@mL%+bodCj++ zESt>5;WejWUGip8f=x`; ztA#gBHpnb1Ua{?XDZj3tj>N?qTeb9l)jmJD|L+y>`jZ**?fQ27?QIH^tLwbA^Q z^Qr}|e2QE-=jW7LOT06BvKB}fTvfeW`_{!IX4jsMhK>4DxDNpPD5&Yuxy94Oa=TYQZQg;NsQ#+LZD+03dS6U46q{NouxjRI#gzP|cdZp?DnF{6 zZ+J;Zv!^+6(vy=ny-w*)_`7D|(md9qx0heM?EXaIq~~veJD=i`tlNy$7is2N=RBW& zENHF6Zu6`UTP9DMt?|z7^ylB(YR%d|hP#BWPQ4e-VErYjH9zQ4<`jh)Th7+MeCeur z?g^XsQ`KzKzpK-3Jbd!Yyea%{8{4A5q%X2UdpR5CoLl_uBIo5vevdC0JhsZ|J{G8C zb^6EALS@_edsm&G6?ATj-pb>*Qau-LynVvhG$!c`%g1LgYI>U6US->#vzUL+VwEv# zbYG`JX#L+Qv9oN}zO~x4SasIYR%L11^qTsnKeDg6y0?6JSH`C)cl)<qUD=pZ>OwY=2ZEmZANa>0#Eme2Y9N^)aP5jJz3~ALv-ch@K}0J+c`kK@CFj3=d3Oy|om-Slequ@J9%@o7n4zN`DIUiW_T z;Z}M5#DX75-Rq(kxtsDeyjo>$9=*F|*PHw)XQ!{J{SfdXMbeWUYcuUBmeou5h=79X#JMYkQz( zn`Ok?8C-hBtcEL(`d^;#r0?0g^`F&#dYpZ_E`6n&(fwIli!N2A3F>JspAq@8qqKX& z!o=lXrBiYyc<%ojdAhZ;@AyB(RbN>Xy92+6Po8z8_>RwWF7?D^K9PZE^- zQm_4mQ!j>=U0{-}iTI;=k@d(JMU3@rpAU8%s(8TCI`NJvwz1_kzgFfm2TjXMV3wab{qHJM zwqwkv3zw?DQjwcuB5?fm%cm20PPLr*m6h`9mWq`g%ciwPw~TWyo=MuCv-2y5j7p8< z3Xw0rUH8TN&c9Z+c<-Nw#mTjnIzRW^HQU#klyhR`ugjuuSlr8s_FFqtMpdl zfCZGxjaeHb-B}H3|r<)uv9 z`oF_jfkE2#Z0dHEq(wFLFO}U&TKzuHyQ*-&u5fX!a_#$v(x=kfZ?kWHz;WmOABpb z)-JQ0rT*Sl)mL^l^GO&R?!6pVJSnm1>hscY?^V|A3YSjp`da@>!aU=- z%NPu_TCcq6%6W{msqDz`5^Y$?`Q=X~Djpsf;7S6_9{KUOnf z!?wl3#v5#H-2OgWAkNaY?~{i<|L)W>n-gw%FFsbU*_OITPc)G4>$&3dbyM4%YgaPY z7S(Oi3j7`T&-Cm=WdqfdD}+0*?7c3u|AwWr>i=CCN77Yu!k;l&ReA5?x#!l(_ub$t zpHDy`$Na=E#wi+iSsw5B_Pm>a&WfG&^KaBBMFcMpm7Hk4qWk`}j5C!}9Q(TV-Ig%p zl-TJ}Y*D&Z{Nvw{B}a`X9ulpd^ep7oO#|`hvM<}E*KXG3^DZ@ie(T>{{TW%M^Uuz; z4hq(ex}oy%)OEKzQYZG+uRpc0>(`vB*uH`!&27!5^#-S}EPwh%@_xETvhSs}jV~pB zWc{!2I+<;>{p|Pac4a@_SU$OZt73NN)(F0cw7n7cpLPiaEqKJN{7Q+QsN5jat z^xd&}`oHYyzV)v5&-eEIlkS~u>#|2j{p^90!D5l$Rn_WOu1R@+?WfEg_iemIv$AH_ z&iULl<0YHF{O99yYu~%29k}=N5NFYKm#+QpVvg;_Dl9B*!J8iQJy+c#?YCM(#zt*v zw@1WxAC5UsW+(*)%zqi9EUWOa`P(iXnWY7D&hFrw;l~grvD|#Y7V~wVX06}6xzBmM z9f!HgPeB&n0@cf#d+WjUp_iF;z8UxwbUip`fZdb2o%-g8?@cpVVo!05MmefbwaVVS~ z%VIP=wtMqz+dP|$M|z9n*Kdp5f@H(DSZRWu5HU+`>UAWF!{T{ zS)_Nd#jBY%`{y)%h|rH?<8&02@OxemQ|KnvwyosnXNNPf&(+kAgxz22WLJG5>PY>~ zU*{Tae^usQ?(eG>Z&F|O zu&wo+{rt+e_rsRolm0Y;uch2GXX{=)UH_%_>uS8q@5IOCU0Cqu=H`__1=g9(@k=hJ z%JToS@onvuxD_`)SY=MlztdZLdzIT6EiM?>`gY?NCCG=-hRb&x}w~ z-}t|jy;D^EVUfD@-X7bAt#eFMbr=4Wiw=9Uy3y_arSBJBex8zc%srw%mop~abydgh zq=1Fiip#d-hb2#|H(2@b`whNDa$ENBX3Fi-`!M^G`{rlY->Ezap62>@@~4SsCbt-` z5e$32xAyCfso!iR`e(_9?(+}HN&M8_${w8mb6eAs#QToAJGGaW{W~}FR`e{MN4d->btGe0^XKX}PRY4_##hwTJA5(6Ghs0#2zGOy;`GY2Pcf7Y_c#5+9YBe!%%(5H&y_p+}}kCT^sptHW#M5`{J`wT9RK!RKR^4#wMR)(o|iX=wjYm= zSfiy`<}u->ZDjOp^UdB@YiBz6DztDItXnqa=A=47<^~^6fAQ37 z@uBf6%h|WyFp=TelrLSntx{Up-Bm2_MG6` zYyNL0o3D?3g?Ffv|FWt_E_p@qUn>8I$fWVl+16uMeyv5;KwY?JkH~eukGU?qUihs`xwB@v#YyO}83dZa323Rdw>? zuQgA?gnGY~++D%2tp4s)&jQ{Xm!|O_WBsh(FTDC2b9%Gb4>@7anL85}mUu0Vp1nHj zh?JB-D3h4Shp@G*hZa@$%}xF4$|j=lZNJ6cKhZ`T*R5M@ax$`e*S^B5C)CzIJ@wq( zR#T`gmH+a7>DnLpN? zspr&_dUvufT=ciedjFOcES0OQlk+WdjIH-@-Yq=aDEKB8^LTwn(05loa^UWT3x8tf8E>P z=6g-@eaIZ8%iku?C@VQz`Yv(_CvW{uW20v0>{WWNQ?AH<+w=KZrh&0#_7hFpwaTXWXK-JjZNLB8IsKMyOh=rPtbWh9+EKoZN2>5lM&6RF zy&k1?a%+BShVe|h6aQ(`$Na9H;@Pve>{CqZK6_8u)aKg0k1E2v($j=CH?4kITL1r6 zeSy!G3(9*m&aD%**{w8lnyis;a{oLQu4UJ!OzBYE-n(~6o&65=s}o*M`X1D4rO|Ln zr9^F`gr?M`qFoDG3fKPGvzg7-Krz$Z`7!glEWxm=Cj2T(cfNkoec{>y&!to2cu&4E zP&*Wy`#6nT+1RdT)%sW0i%$Mf-yT(LTxHvT>%DjV)z3}a7W?g)_qF@@Gue$NS15Q@ zZ}{xqus!HyV3tBu-<64X52=gT`PK8$*w=;UG|r4 zoiDm^b*|5@ja+>^FupLcAZpUgG?g0aH? zFVFs-lFiv2yk_P1qV+phUN~d@uYS?%=_kF{#?1f1xm~kc$Dq&G>S@inUC*a|ntamC z>YH7;cxCLN%jpq1*7BG3%@^`r@~4RJPl6u5!{RN~FX!F$_j^`z`1H4=&F|RHt$V9r z{J!4#@DUC3D>pjVsrbC?_b!3vW%m~v zzrL};_2Pn@jq;@zxsETG=)U8cC)>W-*u{RUcE??jtJof`YB#sSsLeml@o06~lkGQR z+^5}oWnWu0tBEyCw)oeLz2dWOy<8IZ=T)1tc4Fo2&U%a6J9{j>jV@fvsf_65Id~_1 zuE8lIX^*3KEjT#%e3{=X6LZphic3Y>ae13b_f8t5i@iMkaF#G{wZvUjr_1w~ zey%D#b*W-~W8W6m=Dku~UGJO@Eqy&9|M_3uyu5JE59fmttBsv3t9)L}_xJY=`f_0t z&n7;V_a=N9J2F}uY!n2VJkIRC+jqPCV$)-xb=bJIlyBD# zbR_v@1m||~em2~z_SYtN?F;i8t;NrkPcIIf{AtxQ@#1SUH+6Gw`kY;}>f@~TC-2jZ zDn8lfmI%y0!(^o1^{AwoHD1P7g-YGKt&GAie@>4IwW z6>kpJf7RS%^E0h+v$Nrj8}F{K%YJ-;e|oZf*lNp+g{!@#m96DG3a%|Zd@23ts$EYj z7wMgOJZHj$wEAc5pPsl@$cLC8T34QA=$xhSFi&jKDZ2}ox9Ps`mwGrW zsk75#pTR_y@9zSIIoEDuE^FdBeXnAn=E3WqIK^6|GN*(EPbr_8Ft1~&@xy2z9&ToZ z!21GHe@`!Qo9C>s$+3Rba=!kBH!o=&&vR+mpXLO%m?k{k5i4SG3z|hiad+ZT!xk^VUyzFZ|C-WOLv5LmI}ii&M3>9?;US zTpsnqBspl2u2Sig<1?1$w#Hdm%VamaG5ME%CGPyyDwpt|8}j=9L{z6~*8kb3;<MwfC+p%r z5k7X6TlC*TLc- zb3xIP8vB37%o6{6?I)D}x}w9~`1Y6VmZpGG#VHXL9?)mv!J;Utf z6I-SWu3`~pHn%W>OsO{h<*4OkGPi(CzlySRP8DS~w=e@s3L2Rqj%6`4wKRjB%VK6> zXf_>uF3Xx7$t7uTuc=9?i{7qCy6vgD(n2&O=k~VT+htnYa&K?TowujD{QLFf`F8cc zYV7A3UbC${TY0v+Z>wC8lVoL79dov=vtYJ1dz70Mo8AHWU~gOZYRl}?_Sfc2+7i^p zwyYuFQrkpx<$}2j*EO%)I(5RjW<_y_n->@qQdaOMBr(++6crUYO=eJkGM<`7e9Z`}4jnI~K;U={>u;Gk3PMx3hNpdx8Jg`#!a`F|Z3e zH%wgFs^}09<@WWvd>}*X3whUu6$_^>oV$+I;aK4LLm~1CnXB?MQu94H4K{6Kj`;JN z;llQ9Mh1VEn^f<5Umx-38$)cv-rj}#UT&YguzTOav-Vn24ZREJE?v3z?|0(^SL70M zmS;cxaF>}qyJ6+jeXWZR+B58X>UQlvQ%Z9B-`vEXYk%{pCFj0RSf8Js^_bzuIW1+C zPx*8B)OPXxf3nT|Zy58M-hH~fYre|<*L)ej>%GDKDE8Q3?dpc+h24kk>vw+PVPsqO z%}i|9y8Ao#H{ZN5^B;HH;=L=Ueymqqz<5Ja>h&$j2#H&_>)U_!{q-;Zx7zQ(|FFI5 zdV5=6@87fbf9lu$1~aT~NJmLrbTl@qeSW3<$GO~`ELPwD=hyt%X0(aT!01nO-h+(K z_N9JpW&g7Tj@lbL|KxSLe&E)rL!t=@^%*R_|Bv5#Xsz1t=zm}8uK#wE{!458%UArd zzxCe#`X~R?-T&WK{rA6m{(s{w9gAC!%Ez95&-mkeA7hQaWUTgq@ADWvnEpkY^iBJ( zFCOb1%zgd8{__7@!p#1dM=@q|H~+u#x9q~-JkI@7Kbq_El<@o)n{}&u#x4n|6Emz{ z%x37RFVWri`>X!WMN=CW&TU;e^`ZIt|5=(1(7wBw5LQ;zSeD^Kbgn3}OIZJt{g zX}NY$Ime!pW@*+dR;zo-CoQ*;51HgHU7`Q?$*qhnWk;$Mp1k^V*?7~B$IIP6{hPS( zVBzS(rqwglh5f4M6hN)0nx zmOfbDWq8+rA}?RULFM-T3zy&Utod^F!J{)zubvfIcgRXwfgVQ{NdFPwVfsYZqs14fUyMsHlDOF@Evm z6U`+ZC%4$=8aMsDn0?js+-{@%(m&h2axD3|Qmj<|_JfIn!CO<0=y5$Z-u8ET+=_&T z^=5ycsNHGN3iy3_MfQyPdulstt{AO-vG1MZwufntCv}F&{m$Gn^~|qc*Zqf>)Abq( zLfM_x^Ie>IYi6+Ja`9xTwO3gc&9Zmu2bi}7vFpEF)N<4E98Y_D|EgQ>GDT-U2``@B z@JH)!XYDlKjpgbOn-!L?Hv6nR!Dh<&Z~Z9=*{geb>_azhawvVq|Mhy*g`@R9`q%G` zJEN!jWi1o)`G}~wyHC!a<#m#0LHtQIzDJXfvR^Y;y65hM({|VO9?X5HeuDp?YL)g5 zqu-{yxuJTCCOhZ~2E`mXcC7bGhKa3OsjgvygZqO9?;kqV^JACY>zyBT$xQrLa>=h5 z+IGg*6XR#x^LX}6sHpV(s>0tMee+Ly=hV9-zK<)Ae7KZ}ZLO)`)u6=zxki5je!SXw zbVc}qiEkrTzsTr!OkTI!=GD5il{#}~O3q5zw9V3H%GVWk#aheE@Ag~l{AgY|t4q7O z@Sbn zr+TlL*7tc#R5GkgteB_!c$P%+b!$(lz&Sf7f0msT67RV`aI3*~B|X(mA?ltCn{@Pl zdmlgW^xcX>k@p0(U*6H)rJBJZ9F^(u>Y_J)%(to?k&@ZA$@#&#PwxENd8Yo_(-Swu zX5CwJXLb&U`+5)8xOYuA8jD+A+MP;OvC}*8c*gbWLjAn@Q(A8PqGbYC7H;1aSdm+K zai3k%f3=+TKEW1~+p7#L?VH*6ZeWpQGM_K@Y~!wZmDRjY8<}V7Ex35+&8<(RJFLxo zW2bJCJgMokFZg5XoQblB8m>3YpS#o2Lf80QS@DO$qRmb=UoIzfww-ah&G(o0a?}2K zt0u4UQc?9!`TSS4B)W*MHIfD6M-q z_Hf#h+!OIH=gc$>6QxzK-&4DHmG~b1_T<}{Gsm+zE?tLbNlrh zEoa+yX0r3>O>poswY1dTZWMgo(&gr{lP$vQAAPxKSNZSiSJfq56N1It>#j3ymXWcy zU;mV^^UbtLEsZ=PH9RVN9X%#-q;@Irp1ryKpH}?V>W+ZZLi#)dLxP58>9l89#-zS^6$g$mNmO4 zUHB7wQQ^gr!b__fr`+||OKcR7(fSs8sPen*sy&7L&Tk6OD}7k{*;%2))jay=i!`vn_w9SV?8l+ET+^iY7R@|YxKs5|;y+^e&+rm2W&ULLKq3!=NESBzU(wVrn>#IS+yUpzJ8(Jlh&cdkUA6txWetYb@kp0`j*Q-Qq z?sv^T*e&<=*jL*->ZO%S`wM(U4u0XA_D$qT#*vWa6OjWXDERh6&w*Yl42 z|M}H%!b(dL>pgWt&+1H?7V9TJRi*vtvOu2B`uB1*Hv9{VHpNFw%8UEIZ0m$Q|DGy2 z$4=J2wqwz8Puu!0xgK_^9#s~Nwr^gZU(U^C;xGb>VSF zfkQuvzJ*qNnZ1{Tu~z&;c*XLHjg#4OXFM)`v!&sWOnrjeNrAhwr)^5NJE#8moX6Ki zGqoo@vW_j2I@nyf!u((dXYrQDQCwY@rn#EW*I2srd+g-eL+Ve>wCWQA^4FMcXPtbC zecsu>{?e^;_Xj*?cB&}db%OU=vNo%IlFRcAV0T?dgPYR&B-_GSnN)D>=N1E zR=8tEL`cmc?FFt)ro|zB$8Yi1OK_ZR^qk6Z@|`YIj)=rj>1-|2s!0)kMWRj{Z`LKv zj10QO-?eVZzdH}qw|VW0bBhm*Z;d?ps(<<6 zwSIzMc%|3OeByj$HSZBsQ9r2#kHX`2vz-ccRF9iG zCY|$76Pn5sseNVj$@SN3_oP3K?ElJsRQ>5H<)q8YBHZc@zSt=4<6>|}!6nn>^!%(H zf_w)&KgHE=W!;^7y_oN=+qBQi&a$=5;@)tNzqow0&zOfra>lt9XQb=9qjTdA#_P+n*#7Q` z3~IS&+!ZmwspryyDO{h!U#6Zns5*8tPCw#UsKphpm``&1HeQ$Fz85zAXrck@+)jpr ztUfbl#%hUf$hqBOQqv}GVXeOFRm@321GP@!nQS39-m)yb_(I{>>~!XRH?P%5=RYdD z@zrw1=2{Wiui@5LCLeCKtPe3YIm_N6`N&WFwa4ir*Z*8qnVD1A#;kJxgt644J*8XY z%x-%h(AD0NC(CcdlyrGZkG!>)-0Bdb5`^9UsqBy*j4nA;e5Ega%*zI z1I4!9Kl3XmZ~y&KSlGYx=bdGyJMGmN=9#;PN3u37bjX=$0;j`}(=_jdS}?Ixz50;dB4KbLVQY7?#zKH~dpbnxzzL^(ZnkjO~{# zYt-yT`vsOx^f1MTf*WV&rg45yZP5o|C|2Yfdy8&i+JY#e!pBZ@>1m# z_MP8Oc~8s}XPxu0H1m+_yF{B$j^7HrlHb)UTNd#SwXVY6%XD%TPiQd321azdwm`Eo=uoMYinJ<$)} z3_a^U{`usZ^Hhr^IdR5hq`;#)%*PmxJvSj>{I6<#^$I}QUuLpMd5)YScb@aUJ1@LqqqYB>kCA_my_xXk zf%>m7%ih$Zn@@*+Ih?mPPMzg0Pe*$?kLX9gCmi;*^&4eg*w()|_H}Qo`$XQ4Di*TA zL9V(N)fZmUI=QuG;n#mH6Z?GjE_(80(w|v(lBUiw>o--_++Mk>p$|{4qLn4 zW}k<|;TeHH=884h%zIPmmE~C-(dv2R(oNeBDqCe<89Y9fwKC#t*SxgCqvC&GmuwK4 zcutIClg@ncca@t|^xO+;CfDEk6R@=ZpXa$q_w2pN?OO!eaur zCH&6(3z}OchlAc zf5&X+ozObz+YeUxv_CG!@ipwuzb(R;IOZ)1SJFQeB3Ne`vtq%sy+`-&o_c7fRe|wY zUQz2GS)PVM&T_NdO_wN7jOLwS(=J@}^M&!rSrs=HXx#by;Qfx;S5apERV`0%PjX}q z{OZu%ePDjO*Nd=SNozuO3#~VLZ96GKtZ7R9LVh70jn^r261#NPhM#yQ&XE-_7Lyqs zm7||mAt%WG-fuGZr^P=tPE^W$S}k#P@rQK=_Md&_BAw<>u4w6w*1tP#3oHBSSx*F} zO;$V2;@B>tHtQ%~-W?I|Grsd|E+k65=QEpKbkO3W{}Ij8>vJj|?@-+SJaFB{rQb~! z&S217-&?QnBr@ZWSeY{SW!6he79I9kYqK(A+TnWZA4}>qbR@U4#Xl-5u)q59pn_3| z5pze>r1hP8VF~FoW8>_82+Y4QCH#@BO56Viy?b&Z*LKaC`{IQEr1r0ha~zc<=4==F z`NORzBeraD_Ki!^&j)s}@7-P1C%hz1Nou#XoL!*YTT?~B`Z+Tu-fGX3KbsL$z@mFy z`_RdS&)Hx1p2=7=OL#|@%c2t;FHcI!wk#Ll!J5$}u|^?Oo~uFYe<0^(H=&rlp-oHA z?VLZSQtWSc+1suC{Y}~Y>2gkgP5Tmmc$tVF-L1ahz>KwT?th#t`*5PGd#8OtW6$dC z2Y7$1-tggwcqZTKSM&DNbHz70-@FoUIz5di)0=S_ON;TjzjL&7AS zKAt`)7Wa>7~|lm>yp@ZEHHNIM2Xqwn?hYtxlzw{ z9)H7fdZDPg!tw0B#)nC37c2CrFAMm*M`4w3bnW;2a)m#)nKv)?l1vw=4(}@2vm~&K z^{%I4Qs(@VE(c^U&+bW!-S@2X-;>WF`=(rcT4bfCd9x_!XTOf#e9i4MLh3sm*EC-U zPwEw`uP?Ru^XnM<%>bdV%`<}v*=*MF$%;#tW@s6$K6-<(pRcY=BVMVdX6CY2776Wb zYrb~P+BrKz`1WF%b!PoXpBJXs&N>n>tL@eeHorgLi?TQK*Bw3ZwO5Qoz^G@6?DvXe zPvm?1Zm24rcE7|iqvTrR(w+y2d*3}fzhhx#{$$b0h)eJ4gY%|(Nrq=Ud#+dFR3$#W zgQHF6F~>rqIakCwd;RW7e*B_a8eY9;(y=AeXItvA^)xJNpV!tuLH&ab8(W@>=#Fy} z!?)LV79Vk`DmpBBVP>Mb;&b<9Cl*djm$}*hMj>dO>9_Fb>AIg6u(Eaas=PbQYuq+p z;k@O}*YCAnwz9e#;1zp3 zwdPyY{rxYezI|FR?>6bT*TvT_kL{F5{&TP9Y=^Wd-=kH*`au&Ig)$DWD2-0S{slF(na?_p8Md}S?B$GrQe zt)!ng8cCPT6j=5-!|5HP_j#U;Sp`PIT6TBiJwClM-VpZTKxRa^)^4_Ge_Jrv!^^Z%@H$d`YEQwTWYvt*Esi!$|Y&xEUUt*Pj*Uj zZ`*5UhkTB>eMtApedAAMhLcm~bX@8(tY3Yt=-$WRN9&i}G-Ksw4$tyhXlYigdoqCM zT*8zEmgY`28W+y?O~3tt^R(BWsozZ8c(der4aM7y&2ID*X*|^_~HZuGvdJy(?YGCHh``wwKKU&4Sj7hmY<1K8f&a_=nfH9ay!N zJG=hZ-ZM*-U)XN(G+R^OZTo4e!pe`co4Y5S{+!01URt$r`tN-@mh$WhSMrzaKeO>} zmS+6b)9up>5?3)qP3W4~t*v`$Bhxe1<3TaOOjkD~DL)HTQRd0MZ*{wV>DjLtJQ~es z+k+OW&HmE;OXc3mRT1Z(`!#-=Z&?h3RsEwQ-h5wy zVsY$oiFbD2UMe*D`)>Uy_H9?Ic5vXl>kk-rUHjFmaNx1uyyjcguZ~u1GhJ!==$6(N zHn)>6)>R&={_wb-UGzJb)?Fi$MM3qCKKR@J@%rrJbVu;zv+nnXH;c1#*B$XG zn6Lbe)nQUhy20L+c}-5Iu0F6oomRil>}K+(zIX?l8w>k=HEw=x&f4E}M($&&yQQYc z*{nTMPu_jJE~YEfQGd-Xnah1iQ~xLDV#~IsGxx*lFKVaql{giD`J!R)M@;hRxxgLH zf&DkkzdCW6!I!|)y_AVs=MFWW!6L|mTx~3Sx+(; z2m5ce5#G2|+wiEc>!IlU_MJZF9%hHwJXT-vNz1J+^W~m5ec7uB=}1nKApRLs80sG$ zI-VUMQSsJecDerXa zUwSfM;*Ob5gWk4NQ}^qNKa`vpapUjDs_RAPT+eJ^{IdSgofFQI(_R)brPP?u7q3rV zl5q3shS$w21+E?F?E7(Gk;KPURy)&$j*EPmtoEzgRL_Lvv_;#RaP_-WSQhj$FaG>v zS-SGIlm5%fY{^0q zx;E10({6rq-)epEn|OixdyVt?@!MwHy)+}Zzy8<3D@R1`I;E7~?cQ(b?WupyD#7&* z^Y87gM+6eqzw%!E_?darm3}Ft zEeDiI()p6a-1$RVcd4tZ@mnD! zweS7O2j$xH?B4#mI=lTAhtSlu>*^G;cYf1TZIeoxAa*5V`i}ZX=Tgl&;vXEj|MmaU zJvsim*S`ODIxyeK_(#CIlgDd{lIMJW`eyn^$Mf6R=l#;WSUOj%`R~o#$(aZLF8(I` z>)y-^`xsG2t;zH66?~M-8<*Qj_=`bb^iYD^6Or*h-1s5^v64==+3!yLt@JP zxwi`c#hq1G&(Qp@snB+T({D$;r_SWpQ#N)N_8SV{aJM_`+;#4(Z>N}e%BLTU@AFwI z3{EDwer3Ft<-@v$Q$%@NkLP!X`lsh7);(6_uFPo?`feYvm_72}zk_?`MsVH`Xz%SP zWf93g((E~f(Ru#<1b5SjTHij-l@iY^IrBO`e17QqTln`r4gJlJjiW?4q(m}z*B?;& zswS`B?z%|eUe6Yh?;B*U73xPWmrG-ke|~CJ1?!F{XX`mmZkqBdczx5+P^{Cew-kUIt287+OQ zjpu9lYl9fM8H|rnVe)D*8{o2aFeU7iIUdle$lMyWW-(iK9 zTBFTv;n23YC#hF8d+WdWecV|mc5e3nwLPy6%?>;~S%13R^O!tabG}fEb5V`H6Q@`8 zta!cIRO$D&dAm<*->S1tnzpd$fad09yUx38O`9vaN`7sOw40TsZp*PE`Mm0t z8S^LRid@l|`TUbh?Z=HO?#tRTE+2UFiQOu1XM>h~;8PW)*Rd;4vE@ohpK;o9>)XGm zj+ZgpWqoJsyRSR<>2%U}wtDW%|6fEM%-Gy}N}%eQzl^x*;qvQW|7X-(ekN*=HA^{t zNpF)r%2wx_ zlfNxhIgrJmA~p0)Voq@T_h(Z~PUgP;Hg|RTiqG9=6ARKdORc{7+~e=QHCrw$t^dfq z%6x_=f6>PKkKc$YF5u?yeB8IWb9!FDnZws6eizVbk6IfaTU9@IMXpw8R6t>0gMr<> z;HbFZl;?Z1)31wloZY^UWp9<|Ip$bp@78Zsu@Siw%ht9leJFi@=*EtT2j2^1UHg6} z|JA9W^D&2N%T{*#?3iUPT(sj-jr4cXbv04-|Cy4Gc``I~lvzc`7JG-)yqWdj*4+nB z%l?{< zZPgvEFD?74Gu}_nocoR?I@R!m#N6{!*L|6m#B6k;zGXv*cKvZ(b#ATKe<~jx_#5Ff z<9kx3dQRx)eEHY+4qBuv5vu3@IKv?+^m%Gl`zF=j2O32yCOvGmS?k+b_~{gLaaq!u znGf^1UTs=!=C(+6cb#16+co-ICP|-=PBybhD61CSesTS?Gq1j0S(&4MVgJvENhU1J z_t$PdartZg%3$65F=w6a>s9YxER&pZQA0vYwB741^P@uyOMRwYG14_FSbwEk$Ng@< zT4chcv4>Og|LNvH~hL-aK-3-?|BY?=EvUFPXB&^vTIe=5BFQfk@e}+xZr5(Y}#< z%Y6%z^U=d~TKhc>y=DYH)VIx*nsn-G@0~UEeC#52yyq0G1KB6_zb#BS8Gf84@rmoD zsHgEPol?F(67NryRnKUu+O5Mk!)9UALaqN_=6-$@81OOuh3~ijo5PoK>=QfqLCSfa zRr4~7oqwVmEDHawIU`(A*EIE?)$8E%Co~J9a^)*HF1~nJJogdPO!0F8%j2^I{%)3g z662ooBeCAtd=LK{|GgiaL|DDP`iGgiGg*epn_XvvL}l zF|V)a%laFo9iX4#BXS`kU#4rk-CFbipDFkE&Szx}XIINvChl`jFUx&Y_Ce5d)x z^{>u1Hv6W|oFVZ`dbY&#uagc0Q(tsX=FA*}+wUr8{NPl7v*YGwEx|5_PZzqXV_$On-F4B^u|Ab&R_`|7 zKEJZ@ZvN`X)3+uinduz6c19-mlY-UhMU0n1B`*4V*vPLqwqT!2F?a0*Na?pbbMi2Z6a7Df0653 zZm+$#>Hf(|Pp2oVZ`C{Udn?0IHqX5x>ff8Tyn6iN(pi@n4xLNB6XNn2Zn3rLudKMg ziT`WShQ8YBOjGOLossK~RXt9%i>$nv^ey5ni^kjHjdF=HPm(GhRW5Wic{C%y;`nRE z;|}`MG*^CDAoTX;pY2ZdH#Xn(>*9Zt_PFM8e9-yD#m_PyrdA$&c&bZe-b>a$hp&{F zT{(8hCnwrvdD^+%0fpL$+wBwm6Mb|(zZF}?V?68jZwZxGtv?s;2sYVzVV-*G;tRc5 zpC(5ge{kBpu|Iyj+cF)wkRt1?D@CWh3zAqiVUg;b4n>3NqpyqWWhMm3T$)$UaXfU{ zin|VK*~N};A0@=^5%dXK?&Fxw`Tf?VvcO|%=fAH1QY3s=b&>Figo%G+*Q$zLnzo%= z-*KJ#44DW~o4P3no3{S{crfyOQ|g}$0t*_}|CdWo{==PeAx=7Re~5@{YSBh@P1!BW zG&C00#6@pE{AbyvKC{@J?rzoz?Vb@2d+NOfZWZ5GX({-w@B6aP_rESI z{M@VQ{{6^?zX8|WCGzz9`!-K9NLXrcyqEWE+UvAa;UYVVwK>Wsh;+&6|F~q7;%WaP zXrWWBjM}Mt2Z|f`{M5DoY?3XtS+RMh;{5d0W~**KShclKRXd}mX5rQKamiN;=Wpwt zzBc-2z1ruwmTIYOk0#eMUd)`yr>mEFHLX(O%97rgWLxn^qD^aO1>Lr}zw^irCf&H#`%%>t&iNX_dFYV(Nh{y&fN$W9|y1%g0@b z-Lv?$gT8>NUb*YjyqC2dQ#L+%n6T8){%nx%{a&T-%YEvnmos#!TsGcg+H%;tTP*o< zwfW-NOHX<23r+riyYSRH`w5=PXG)oB0@s#ZKmFBs`6<_a;DTfX0nx_(}na^RU%<$iV}x7B7rpTE!5ur|Hc zR+-~t#^J7doF(;!M_l!^RUGQMePNH1H?B;a^J_zY?(G-3j1OnkovUSHjGfZ4<13F* z-V&ot&x!-v1+$&ZcdEtL%s;hd=Z3%MwN~vq7!tef(jtqm{>xtNUEss7?OVSy`GQf> zsr{XE^YfpZoFuCIL%4f0XY?drbUH@Q>mf~uAMTMD~9}>%Qcujewr_GxeX2g*& zVYynwtJ;;j{_wH;&5+WtC|<97H~VmmtYeV=`R>hmC)I+S3=5}mT`+m{VvT5DM__?j zu;UIhlb#>JOwF^uteV_;TKHv^MLAPM{Vk=CBVB=)!s}j3=e@mn*`;QuPP(Afe2e*l z*5`u0%}i2Rf5a%zm%rjG=cadx#*b9u>{gow$oOwLrg})7^9k=pPOqz5%3V0~FZ^2d zaz4Wfm#K!H>!pMecf40G`FtVEp(ng>QeFI;?Q`$lYEzEhld(g7?%5FUt3UTo()?{u z_~Uu~;_Q8v<$aqk%DlQ-#gP1-g>~VXkO~E_clu97-m_Z&@vucsGX zlwAMUboFh%xHtJsu&q(LhN*$uSz|+A-C3EU^FmkDy)4}LKYFWn$NZJ+|0Wu03EcXB zcu&m=zu(H<{Ok8^GBsmqXxh-r5Yl(Wp;I8cZQ|bR59(co&lqZb-CY(V^0?&Dx+RW& zbN$s0E$KM(E}!rDUr(+cjlUv?Ip0psw(xK&6TPIGw(9W78HfISd2i;_+RV^Z^-?@oDB!mIc4cyaN(-Z2lYnYIwlx=j3@JlLexHFgeeW}N`=S?|tpRM2j(VtnF$C`;bbnR?C zw*wNKs;st4t0h-VGh>U9pV+(itwL>d>6hr!;!<~iv#ogbFxGHpWX>eEB~A11O=ohy zzrlS&e_zk8n-3dT@7cIRbbW}mS|!`8FF^`bpQo*wHT%zPk)JC&zBJg^%iesNe0f6F z)Wf#2Hk(6shF9fA^&grZky%@1|NYv}4U!XF`ubDj4(&>3np-T(bvE_4WT^Wb(H!xa zn<+26ibnV6&pW~kL-;@Gv!5z%e>k&i_R)`l_kVu9qrElw zk#DDGyUg6e`cQZGCk4BF&zE%v8P_*d#a&V0Qhz_iVz>3K1s6Q6KZW}}dibqSSN64g zTJ_O2veP7kwqCV=SLU*a^ZO}3%m19aTe|vv=_}wTiJN!JZSpMe+g}YaDm(4!E z{F{^4Rjsq?SJRK%ytzBM#qxsEzbnrEfB#e*p62OwD=+8Ut+pyo>z&nQ??k*G_V{w{ z5&Awmb*cA(*`MDp5lLuL_0V_vexWw^`qLfq+J(C3>OHpK2}o6WdUQ`?L|;twh7j+v(;X<<=1kv++&dy)FzNAFW!&SP~g@wLiGlrd)h zR}*Tmz0dW=vlmVw-apv)$Z(avT6r?;&RgX#E-RM@I?R|n!Jl2##ZIzWP)lHsx&q_G zQzdU#)aY8A)w)n$)Z1=p9qB>gwtNm{_ z#W@BhI7N0`dau;Vvo6xWnY;XfS|Uf(*9)cJ4BJxtt}fPBw0NOfZ(RG(#($SjxOn_l z_PdcK_f&TsE?Ca#Fn`XaSt-!BBCY%N{@R2; zE3=O1oUpaI#Jr}0LA>*C)06tL6!}*y$$CXsSFaAJl3nez&HI_K`lk)r<};t2eRb5b z^a1aM!r7h5CwP~|&Q~Zg58MCz>H70hA5Sy+33p6?^(o}%-gl18kFL#I)%ZEjs7ReN zr;6XIO?`$;A9Lb2?iLA_%=(U_{Z|tNbL2MH@0k#Az4%_E3gb-CGuJHJyo2AKt)KkB zCBuA0{dR%F1wPE}>tn?|v>&DVg&e=;QTapN?&sHgC)3w2SFwEgC@b-q>9J|iDoZBk zX`SO*^Cfx1Vq4Xv6Z^&2@V-ckC@|x7THriwn$VT7^=_wrYo@Kyv3zuC^D-|X>)%|g zQ!G1Of2!`t+HqFyebStlDa)D;^Jp#>&oZ{IUv>S+@(uI0*|AmaSS>E^E%#AI(KPs8 zgo5y99@)lM%<&SxjL&>MyyLHRh@R?2uZc_tV<(rqU!7PyLxcURU$90QL+UKKldCj0 zNq!FH`%~*8y>Nl?&x7F#|7~9UaP8pw|MQ{;)1A9pO;pz~UgFT1I*IvYde$2K<^0U7 zDed)2C#&ik;!W$6_x5j?zW$S|%A_|RIoAG)m}0NI>s80GY`>qU(k^y6_og=a?|)Xx zXRiC{o>&K$#JC}6kukm)ja%g2}lewV(y9Xa`q+B%SIq~p| ztlq};s(oKB&xt>2pH^`|OyO7ES_|2`QKwd)o!#12sJGEMZ+*RIODsE2tMRm}oY4$K8o1HVA0FJlA~xs)qga3I(asY&N$BS)6~bZ9Pq0H2j*Du=+3W9H#94J6>xn7V^x|Uit0$3CF`$ zB3-MRFW+9yS=wee?R<<}=iEC@W!;Z1$scN+-P*Kpn)5ClFRjAz<0YcY+ukl?t6%X{ z|NnEhW&ZoWT+x}|?ouBtIdQ9Pa?t}7{q&93%mm+_TcA9D+c$&uX9q9uk6c{EKKG+% zYwL;IOAfxd@90!thD?>z)ByReP^bu zV0x~b%q~;3>;pzuevB<8}%?Wc-b_APSwR{@A}zfI9%*mnrQYd zp-#8Rz5OlkiRQ!&HR(%a62xS7B^q8>9#xd8xmlC-vp-`=Z~@P$KOxid>LeIs1N`^@ zxvRy@->~54>03PiS)?EAd=O>4Ykue4KPk&=-sfDJ-T2uhrN2I>``FrQ7N2PbLg&wv zzt?X!zL;}5JR(5-N&jv0$;A)+y~S@aIoI$Wcwb^Esmc}if%nyCl}TGS{%E$TIDfmK zK}-MH<2iFauGlxrXtAHztc_dd#{68sJ~ieu(6eugdXJr`E$Lk2%p+Me|L^l_ zV%}4g7@I3tSTaRcI%ocQR{yzX@4}*R&f+5x(@IOe+g+CKRpH%|y?45$@*#;!LECSB zw5nb3*r9Uf3yHs<)GpPSW}R%ix9pSXOkHOAb)TxVV<#L~w$c9jsh{pLk9+2xDs2he z#gNBSywD{ihb~ z<>GoTSXW%?^ocbznKb>3YYekM0&C!=ckg^B zbZnen``O^!p7flS#63+XbbmjKN!eU*=4)x~^552%@;^^#Rq_u#yDjNhM&(11Du%PJ zC%=^cYJO<_KS6TV)2QMji+NVeFi>cl{?_nVY|8zP3t4;aGGFr6W3#yB;hSc{#jSmD z``z;P<4fzOFM1sOYR8ZCYXK7uXMGFYH0MHjf`t5wm51~lZ%-(nOugPIOJr~VXx(?KbzY(LDylkA?~9Min}MoH7mW>WLV>zc69c<#ap-h36wpO-}jaGp2~rmdW$O#-yZx~ zuz)95<{R^+3K7GKZ_l>NcYfM2-($&)Dg$osQ$-G&R`2_v_`>eE#69Ds!Z~Sc^Xk9+ z6V~}z{$}285_(}X*PM!f)>ay4C3T(W zKhb~uN_}GK@}R7oqL7t>YeRP}yqWXKVRk(GgrA0O2Q=-Eh@?hN_7ZWsA6YEF^WMbs z>ZhZ4JazQ0f2exO@xS2hPg|AkGktBkt$Tj=)NjpJ6k%hzWte~*>n7k zS>Xzo-GcLkI5*xGOWH1P%58Gd@};`D+VnQT+it#0>`kxh(*E7)O;+cerrdwkFt}60 zvqz(F>GFEUsi`05_%ZI}4awx|3$8N3Hc-IrcL7xsehC&6x3tN`SDAA*|wsj z$j;*(va-R(e`Xf{zh%25wkM_c%C1=@YwvHE%|3@?HQO7%Uw3BiTs>WsZ(sb*#+>g< z7=LVh?@>Clp>xS*PR1ww8yMT}=*J~6dgu83(Q`PwWBTf!#Q|EHoH;W;KGIPNi=MVf zK$Y>T|K6HA&jK$MxhXBL|FP5kS>-&JU&<9RpUP+3Uz;azJ@w1k@9O)eGo00Uq#>?& zS^c`uMukwLc$Q5cVz=Ilxu$P)#A>&Yd1zS0Qr}&dC&zz{sY++_+R!rhyUo{aAzX*9 zYl~{kF3#N`!PdR%sH&*Tx3KvNt}FL1G-!RJ-xkl(zPrs*EcsL5q^_x|4)ygyVIe1< z$Q;xQnKA7KZ*lzRosS*Ye~LR|^JeS!Z?oQg_CL0Z^>!JzPrhwUqqIV#+uE?JZ5LRT z3{LH6`!)AX(R8VOIc>|ct_Ah|x*NSVI&Y<5%#-g^ou2rlFIb;uIxi`pC-2ms8#~XL z&(Yv;?2ui5?ajVhmNi>f?URZ+`P=4x>&g24%VIxh-%q^te`)^_fv^*23j_O=%#OFY z>fFC`c=<8+6DdFaRCQLzI2Wk0-3efezpy8?OLwxx?GM~B|1w%Vn&j>N<^K3H!K~tC zwW0p6!x`}g?_AgX>}`2}Ip>9*K$T^c3&+mImG;7%N(Kd2`R%V=eEwV`=aQ^WvGyi*4fP4)5kL6WA*K!|bf`yShitFLF(e&OhB?@u%|AmfyRs&Xqir zlR0(OLrdlx-0$C9ub=r+DdbDj^CvU=IhSRAPfNYd*6H`vNbREbCf2=2U)-PBdL<<8 zx6JJ?GsE}A^cJ(NpUxm^Cx3Twqv5=WKbprvqj|g|B0kRCT0h%#+Y4^9%3gmqF=v*C z)pzVPShum4PyTsRYk`&1^@$o`ix;Y_>6zkHx37K9a=u(4t0Sptcb7VpbldjT?X_Q! zwX<4#&wIX*MQq`+vzfN#4j$ng&i@Nn zeJRtr{n=6UMd!RXt&LCWa}2#LRxFP^`hD{;?GvA59KUVwYEauY$Jl%mXONl9TiG{} ze>kQTSWb|i5qOOG%Jfg(zDJzD*c~{U?6FmP&Uf}FTb=Ic?rCq`E9eobw!0$b-}~zM z$9r2J%l*P#HU|&C_DN!2HSdPhx{132PQSZmY^>AI@mE1>=lio}Hyd)M zT~gyM+^b?F;Q0cl_Q69^Icj_jA9Opv%HJ2bm8Pdpvpi`Lf}q+Ov-0sjIGR zzSp^?bKXWCiI*9Tdl~1+{XCiZt8PeJvh2#{kAiUJ%0VWaI`sTG1IrZ z@j-D+9rZKPvR6&{W6!vdA?`o-z5~0s`#di;%HMdrf72>iC8^ETQ>Dc&e#x{F3m2PS z9h@EIYu6~xlON7g>9BR9yYm%Jv)uH)ecqoGmlyOdSoZqNyZbr*t@>SSJF{(ORy?lf z)9n}VlNDbZJgw{Jtk;%{mBly`kILS)|9v^l;GVle-t<34JI-zI_1G3#!p3iz!;`sN zcS)tZlvc%sY5CK=j{Hg9`$Ro1(lU9^x|?r=${&79$hgq+40is61>}ecV*@UIpVYkc zk_;mSLkkNd^XU`+a)_`RTAG=eOn>;1MZJE__T-YZ*zIaEx6AIXys<4;U37MN&TT)f zw4)&2@}%3}!q5NyX1V-J5n%Z3+? zi>94S6CFXvUn2G z*bM3m3kwfUWORA+##W~Bnb*xaglfF~oDOCT`d%9Kgd83MdctY%d4$@P`xUCY>|=XT8@ zxk2Z`jVsqqPT@*Od(N@p-*?7@ob+s_Kg&(jf9;QOs`q1XZkW7xrQwJ5vsdokxbm;P zR#d~@m5X^VoP7D-n&AbDLAlA6(to#^)2$gUT)T1W=#%*@|4yBK^Ka^ey^HV0bI;zt zYkxvlncq3TV|@skA3pYfB$7q{^!^DSMT)Uzi`$6_b2|om-*{I{m1`rcK^#W3dOUtE1hTWXa4YB zmifo-6rNnh`tLjrVjs>g+Gtkt=l@TMTMTP$|CPu6zZ-S;%l()C@((PT!~1`m>xpZB z^i6xd^!yiNntP=2-7>WhatSK074IyEc%(|zq9-q-hkN)MPaF(fc_@y~dj8}*V}|72OxL-~L2-}$#c z>&Y9Rf1f|__iWfO*ZM$rU*}w5hvR2Xe)<0IuWv{9%&X7q1wX|*`1~)OW?WLnvWt1k z|7&MYe5qgm>i_Z2@#=T~vni)#=cIo+|6+xO^sQNc=5G5h@@KJGSz*Z^?@#;14%}b$ z|M8#oJIzf?%}v{)V>cN;;Fc5-&%u9&8fZ@=O$InbbsLNbhUnV|1QUS=NyX#PAvE? zZTQ#6_SWkx$1-lG?ztb2A3WDGX;a)sYmtW`*4@fyt_n}J@66t3&-QY$?WFaES+O!{ z>|V?qQN9OXN>)Dlcv<=AffpYxBz)&hd2eTTcD+S}k(_hR{U^bXRMPpGkN>WE?0+IW zoNsy8(KTsbwXV3Bn*0CRUavYme+mD_+b?`xitD&Mi+5U3-P7dlR%nzrJ#pcOjb~ap z|7^K`%w<{V(yv+8)0UhIyYYX{^^e8NBU9HE9A$dQFTH4*$|Vo3n`ZWb^#NR7d^#yv zt^Z6W{yBJ}bJDscKb5=kXEkpX^KbC!k=OLvaIAidPNw??4Y&1oZ?<1+A7r|A zzu9k}iFqCT9Dd@5OJ0aozCUnULt{mzq*txjUyi@4VophEZ#dn}K5f&*2Gtm|%t%A? zEnJ+s6Rt_z?u>e?R=m^w*rzV(Hm#kBmp}AcM`^XcIrm#Ha{bQe-J7+2dvpZ~;|?VJ zTCv`7Sq1yC#dRLRn_e?5abcTgA7*!bx@mpn>o?4q2Uk>WSlAe5{VF1Tw~YO2UklaE z){|<@JKGI}KU5s;+UosIYr(YXMr{(Wrai@OHK09wY-BXzIC*+!6D#lNARBxR zCp+9zfa{D(_`iOA7w@k}lbe`g^PYCU_@}yBw|nxwwblaNrRq^99-HNzowNV?B(`b) zV^&@eX#JR-zR=wN%(VSNLh>acao?|Z=5(BstvlWLBJsxCyv%c6E3P%wXiw$1RO9A9 zYu*+xw-cI)9decatgoP)plR)&7ZEHC$BCGiNDbHg5A5<=i$pIt`2`M{t5Q~ z#;+^9h3nY&8x89U9t9Q1xPJB7u+raoZp8cdZToBI%2~WLUA4i%rOWJoy|;qs#i?YEFpa^s7lA3Z|kQ=Kjs#AvI%jXlR9#y z^>NzDkZ9ZEuNPl?s@dxu7`#mQ)YRwlR$o44ePK{~Ui@^5P(^ZMI2gIosoN&O856czl-eO%A(f z{8BN&`i(E=Es=Z6A=-N}H(dV9?T3o%a-5X5MCu&nnQkP7rcSnelyAoqf({WuQku+MeV`Oz``M_Ejd(Soz3B|pMmzd2j|hiTG%h1_rjpVXz@c@l5bzr~y@ zb@WP1-05>SEfRmLE$O&X_abJPk~ zy)2|BCX%ZL^Hd8 zX4B|Od^@#mo%5gE`A%+ZV(mJsQ%!Enyu``VK6iSSmGd`ug`}umH*c)jcOh8vj;ns! z)+$3|Cz)){74B{6>!<5BOYrEv_u@X{^F(NK;nRc6|8_n+y-Vp?v6@x=nS9-vfb(A? zmsm__h&Y_O>(Je->(M#wyME12a^3IzO~0<(ZR4^P4=+tpusm$^%a|>=^~c&sX^s4O za+Cg42?gwVo%K1bYI)zSw?b74Uk=8I&KHi@TC&$#WNX;&3y;=kh+Zh(=&iLw^^li` z0(-2;j1QrYB0s3yxT<^NLE^~=h28Z_C)cF6tX;K#>Zhrbw&n-9U8=dtGg~XBa>Io{ ztsPS5Vpvx%-lu!O>r2i&dConB!8+SNHaEp>SlN|X5&3kBU}lK->4^`!qCdX+-4j%D zV8u6vclZMKr|jj>-8Y z({##u`|Vp>yQ z4Fc=Jo+aGavVkM-&8?Mjf1?lE1tu7lx5Zc&Zu*e4uBlot{FqMkon1D&t{s$DW0+aW z#5(hywWjB)&=0NN^?HjxvRrB`&suI$v@-eIOliMkd+*A#ethe{dMbO_k}o?F{}#>p zn4WP;4sF)k`}wj88@Fb?$;9g&{=8YA zXGw`Ql^*iHlI`SkW6k!qx}qfq@{{EE-kj5>^Y(X8QIvAjG0)v|)-%7mQE;~Aq@xLE zZD#bB!{4@9<|*$qIu+S0|2A(;@x1jrRo32nb1z)vTHh_d{@qs|&TZ1P$X|KSdNpgu zbg@-IQvMTm&%M^e=Kh$~_@RYjCkI7rfk>gVMpxGW8@*)5DHCc1SJq-nPL~!ZCb>-|xes>3a*eUt!hsoE!8ww}wyo(rSCQ z1v^xI+KRhZ=Grf5(@wUv+qkCrN1=F$f7p*KpE+4(J2o|6N}lnM={3(4zMLhGU!9NS zKbG3+xO!r?_tE-!XC{bicTPJcwQvN{lPuDznazgy(?_b>? zo*CHLaGzcpC13C^^j=MZU(~X+D>EkV|8Kc**2aqHoG#atPr8RbO*6?{^(ej8;L8Ig zgVzfFe-m##u0H;H_xG=1?1o!rtla!${$&5&8~tAI<>F@Ov1MI3bI`i}nN1wCjP;uf z?xp5y(>g0wPF7RVo4e(Zx>0qweB2tvmlGF!;h7ySeW}r-mBV2#=Nn_s+LC>5{q}78 zFfHKgB^HrZp>5#{@0?EhG4u44opI~ce*Y8;bAH?`{`<#)4|6Maf18z5bE@pG+xJ?f zHuD9y)&84KJbL?Kod2uWS9<@;-@jj9;8*6c^QgU!-Ng(2zTWvE)%(KpoL4k!hM#YJ zp64{bZPn5C6<0R~EazrbUHL9=r+=P)asNrfpujdW`3W4;XQ?)=h|KP&SCrVZdUJu+B>#E zw)IOD%v|(MinvueA14L9KC*|U!_WD!*ZuyBWh={@^UrL2U?pR+XiKl;+3*#ce$Rf8 zu=7*2uyV(X3c(DgF71g=c$Y7^BVZdK-fzCD=+NdT?`u=?-+SHCFKm9c>F)0)-Xry* zZ}#W>_!Kbzf0M~`tGLz7TAJ67%{X-|KeD>zn7+XBdYgFRN3V1~d1v`XtZ)0=x@S?8 zxBIz`f92F!^}2Tz-8X!4!{tF z6l2lYAQ;iFEA_8(1MkBgUH0T{hSG{ImbQdry9OwELRjtp&Ma zD|~q!GAH_G{hD5H{$Ex^_jV@B0(Z6=L;WvV9$UA&+}|xwbCW;qmU5x>XC|lbA$jiz!=Jp_ z())s(oy?>B>5a|PI;=t+owcTEXRozb=<+YXSGL1K`tEwg9@A;5_0cAYLSJMIH*hH@ zh^jmZmHyp-?dPt&gnBjMr>hWyVQ8ZPQzR-UHuaQ*!oyUKq&>}0mk zx^bXT^5Lx$dm=U-wkrT1K#=H+sp(pTN>`Y$Zjw`%zj4NH!>M|zijUbFpW$M^dC z-}}4ro?lRV`MWb}m8X7VwaF&sK*?iI_x&ip_`AVpk){&U$`4=rvzMp$Cu{AUvueSM zZ`aheEVu1@WPc-1cE;YgU$2z5tbgKq{QP9YO>--}a!sGmeEpuja11^!0<>_p^_a+@wM*rGS<|c==^o)v6Nq08n;Hg zj)=c~@p}GEL5g+aCQ?7FSmjNf>g)Ge=?FAcZBsH#2;5dUC&K7hmW|6-3)dJ~#p(Jp znQQLuePD5=-diZ7lC`R`|L8<*>C_{fOimA+WG&bJ)KHtwBy#Za6PHMtzOtt#@te6s zEpy*~n&n;F@9k$RV<#jWnC$$V#jC1!$(+~Iew30^pV#eVeU-jMSoe`+PTd#!M*qB8Z9iT&#g!yM$63Qs#Mww zp&O1ao4Q=r)&JP`>V<9Bm#3FjbI-65w%9ND*x&7=i0{3re%oC48L*jl&fMU*%Qxvk zLth<(v_`L&V$K86!*$W0?@t!YPTPO8R@8Y#eV&Nr#TT~{9TL`GewVque}BF9rp7Ai zibeA-HTJzMDm}y2m7sd8;|=>=2gM^x<@U8tl*_Czxp;Y+%xrzvsd+&;4|lD7A#&mE zK8JhvWiN+wcKOXYQDvw5HS(Vt@BWU%pVn^J%{+VC+ygSx%JZ|YPA!|tTqCHQ*^uq` zUDoWKr-by9Yjzt&IZrNqS*jU)Q96L@Wc{z+xrcsAz0KF1wPJyP)0Ja4dhhuL8C1&k z#KiiGVB)K;L(oM z*uVO~`_)Y|Lb~TaVHa#u)tP(Y!mc=P&a($^%$WA($Ca$IhDoWmrvqlp<@zU4`zB&l zrIkg1TD_8TRONo%?T&tpOLxp(=2%m9|He1<`3oQ1D_GBPNqbdJ|J*CGU;i~E1}rVO zzFhC#0Ud*uXMF0CyGl$RrL0|lwrYiLP~_v2CM{?9nQvHzw4cbn|COa|_m@i{r$zVA zSZ!z$U?H*HTlyx0)ah+=g<5OY-L$t@c_h64*}I^bhSxvx)t}k@{!1cjg7x>eE8hIL zb*IN9sp3M8dsayCf`2W00?I{O{f#Xrtql?K5R2}*y!uLb(9t0GPuiQ6^6GS!eEjay zojTVyrO4VMmZ#W3QrRg$A^7c<-)2X)85&uZ$Q@t!Z*FtT4XH`ND|eM2E7g+OX3sfC zz333o-bD2TUWot?au?- zja^IZ-_I|rHx14<%iZ#5r`WX#Z}%+L3T$6JgApZ z<#};W(w_pqPiu;UX8zbPaRb-SkXkd@TJyNCTA`weI~CPE7A!hhETVU$$iV4XUudEI zZW~*#`@8ejzEN4vZY_7>%$)CEc-HPnd<9noYNUn{=7&()+RAym4|OP zqs9I&|JiDVehTg?+QIi>=lT0Fnst^Nb$bK$xz?I$S)|2W37Ew>Z5sdSHyM%tzkibS zS$ihnU4l(>=G@RTDak^!nJzZjJUyeg_{NGW=N5N{d_KwaeBa6Ab^Gq#StoS#?a5D` zpPBz(s4p+yc|hJxl!3WRbix{o2L(0yEpVw>l4Rrew$DqQRX2pUpW7dVF=I0p5^9U z6^)(U-;%!VtEjc@nH+FoW|w)?$yKWSMjhObKU@f`WAc0$eD_kLrjet_?MpWgv|V=G z?Z>r*L%c5Z_=-Bq2Cl98$AViX*a($g+%j8!+uP}!Kj)oXzx4VF`P!8IF0ZG132z8Y zU7D}+GKr73vF2pQkj%JiqYmvhvA|e^!3xot}AkdfD#=Pnl1bb#^Z~HYKfl z^V;O?UGZ8*yDPW+j=HgJUg#CI+0tIQ<_|wj^?Cb>ImjtdH`rzkhgHLo2mZ%PQXi$% z?OyOq_nuE*#mpOG&z#@(-eSGfcKF402@$!Cnubg>ULQZN^!3519|_f}9QEhqUwyQ0 zzqBI3ODV*le_eJXbT*A$c2>2iiW zYfGyA!kL=#+ACu*uQ+>{qQbQb2d9JeyH0E?pAhx&*8M0hvBfUm+DzOKH zt~)%PP2vqd_H{fkT3b-(F8OAy?pi(ByCO?f=12XVbF<5$aP#C%4s|i+;(gYopJqM! zpxNAgk@JULxq#qH%c+*^=8}@47MtUZBqN{L%Pp|8h&8(X^mu6}%Ha)=l2)f=0GxijiGl*HG$$TF2a;&A<>8#c8%PWEY5 zRM_!dkKg!zaJs6gST!wcQ;1!Ms>`{Wy^A&%O_5pi>>MAH$5El@_v{2^g8i>?-d}p{ zbYk)8m6C-ADz^PCcoPuy^h>DQ!IaN>H||V5)es?aslH4tMzl13^V3bM=6+)S{wXl2 z_PKhw>{~sxXS?@aoMhqVbj#p!OWXkljrSb_XBN6Rsaa$T?Ot??|H-HGKNps;?G>AG z=S_>+tlMb@7e7u8wp*f;kbaoqAK%7F`vU)}sycm7i))+u{LxIo%?X>-_icNgna+BiFkJ_tw@z^J~QnttT z>~(9^Jd75YUA0x{yXP%plX$eV)VxXaf~sw3_pPq_H@EepN*-iByX-SxWZA)rLtE>4l~>m84l9&h;PmGOOdx$RML8T}jcpRS$!W_i3~Ap6{UAE}>QXQfXx zrair+#(B=6eZuQZTl;x)dY(1}&5ud(`ehY!Y1YP;>HBLnH76%zEcwYCUeI{;z!IHZ z*Y(<_$F)~Q{)-igU4E@Hzaw<(EdnUl?Pb%>?33RgsbBxx_0P{w?GgFOho=0rQ(n8aB>C!bi&pEhqPN8> zoZq*Z%;r6pVmIf(0;AY(GxBbJ=n<52>B`}_&MQB22md{$UymL&yeXfm$>($TX@~fN z<=YsYALV~NA#225<0d)vK>zX-xAS)#Rc=f+?NXi_Z~S(OXV#7#l9IdM`n~Y!gcBCeU~PM+to zZQSLP8O%FZZ2eZcR73R6i|}9P=2p}SY)CmWbCtry`i%YTjz6wf--%cv@l05$@~@ZQ zy}RF&%I!6Ed%9Hg5(DeXf8IZrT>QLMD&6g5O6j(k%ib@V*Vn{rSH5Y9b312y=(1AE zs-}|x2P+fjOm$3L#NRe!a{uLf)p4d%-CPn@aGS8YOg8#^KV{{|;0^B;)W7$+RG$7= zG(V$hLDZ3%s(JN%vL-8|MfAjuzPIh0X7uxCQs>Uz++z=w<}cCQZoMeDR#ZN4UhBa{ zAxqC)Ti7kR`Bv>r?{~|lT|Tg5)=80v+#Ot|I}Zu^x~z^r^+#rhs@qTFiUkux;%z>2 z9=+&z`B+?G;WXA2ZVXn@#Y!w~BKgsi4c)KXy_vIoy5pBryIWyAE9yN$m+LDF{(A7R z@P$pG1^YXV3kA^6^3NuCmT{%|Ec<>bP-1T1O5R;F zzOCM1=#rY35UKEFMA<=%-Y9Lg)xS9tSids$;E|sFj`?R#_kMdVG229c@!kFcVbg@WQk{7l zOrt9f=rGUwyZdjeqIh2ub3jwWF4u-1YbISSyZK)zR;6^~vp+?m5AQCW<#yEld(ig} z2euqFWbS!!Tjc3e(JwY$X*ZaboM~Lw!evx>Y{Mn~nB5Tv6a*^`-mPz5{q#>z<}BT+ zdeh^v>fFL9&MCVdEdJYeb4$p*SMIZo9>4z)xKaJV&k5Fwm$=^uFH;g$Tg$lq?)qm& zT9=&)zLx(yuW-LIaGk;a#?sGI4i;T)c_yJ8{zh)G!HH?5t`SGyY>VsQ6_}Jit3GUM z|GcAh6TH@YOKyl0ZT+~sUpTn_A^%E~Mx$@BZ?*T-Uzb#~a8P;0m0osp_Qqg8@6uZW zkN0eTps+kIgL`N3+2@PqInA+MYgoq6l`hL8v}b?7q^C+-wD+`cF@ICGI(F6tuCrAS zj1)|6{xkVT~?yZxkt4$ob}etz{9mq&BG(kDmQhR3Yfwe9@vbW_(yd(L);%yiy&B$IFFtY{gl zb#M9@b_K=8EH8OKKW3u@lgY)&IZH1|oNumKKj&xOS-qAEe)_kJk7zxQ^fY|))UkKs z>W{k3-Ag{i{@zygt~e{tqjq&uU3LAA1G7ZtuVm@HK6$xWn(wr%tb1G1=UZ}fG`+7^ z%P>4AR2KioE$OjYo%Q^+vQxF{PT!iUHpO4TJ7?xmmG6Hhn!a36-w-0|EdEc~fid6d z)_L#Pt*7&)zGyvHP5RU6#E`jlhr%j5?dh|4A8r2n=ic4lc`~^dY9?N*s$Zuvr*sty zTfO4G1jCv(V-c^)RkG(~)YiY3*k*a@+-&n2k&dZS36o|9Kj3l_Qr(|7ZD+fnoO9rs z9La{GQgsXWSW1Zp{tnV8_yz9aYdLFOD@>W!*Q1w``A{Ns9TR5rk(vf$&T?$r|xh#dVNkp@9OnG z)gwPd$w*Z#7p!k7wO9FiAj&pB;j`PM+qGupZ%=-oQS|zY#QYm-+1!3PPoI8UmvzT{ zQJ0+S#oggyHtUo296s}dLv{bwqkOX%Rh9O=Xt_}uux^Ik`x{#)yL2wT>U%uJXZqtm z6?L{c7j^r?r!V((ja%e7o##U3`rGF!{%Utj+qUa5tG4+~cMso)Gxdc&+fKFB{H}G2 z|8#y~=j@M?sxq>ntry;To;)eTXFjJ>dhW3mGCF)xn>0RW#PFL11*C8JC(*n6&c{Pv ze&|iy{WCSqXXQ^G(OuVWhIy>e-gj)yLJf{j?Ju^zUi6mx(guMflXsG03MWN`di1pl ztJo`d6lrhO*VLVV^KJKveJjr$trs>;)IEC1R{j6EOp{SDbVfP57%@)eOD}$Qx2+6 zobhfkcWy$(PqnJgPk(!zRo~0Y^xA#{les!yWLivMN=SxBbVJwFClbNF%w7@|8L37m z?j~%1HSL?T(wb9lr@ycHe)^qxe9MHFMi*(djG0jPV)0!tXbU3 zq7&k16Sg)vUfG?{ zdFtR!l{$CN&Gm{GeSny{p#ao{mtz z-s|kXtA~8|ZQ@Bcgd*qAx1@foV*BAcC5KBvHG<@SG;^irP)1)YGlhdACbN+oh z_hwJhZ?6}&oE1Cfn)GrktJ7F#d)o6%UdF+!Ek7n`E?dxdkuTs+eUx+I;mtf;2d4i} zK51p$b6UoXRqW!_^qYn``}ON{mU(>A?%EpjKAr3QnTP#3vz$L)&h%Prl!SfQD;~yFLc;L|8rydcJpKkEzvn&Ak#un-1<3=$>#= z>}u|j-|6QM*zL^_c6?#5{lM9Jr?nDM8)W{*e`8wpCH&P}olAj|Ew^+%cV1VzUdVsR zwVuO0i+S(W!f7n_S}yhPe6%*WaL@aFM505;)kT$K+UK4-8e3KerzpkfExzZ$_4fEG zldU_acepK6n6-W8bA^eT`wZXf`U^K3O_};Su;@*q*{Z6u`(|$Gw=JB;o!NZ)&xiWt z@8|C8YEDnG|Ee_oW{)Mi!rH>iyJq+9n(4k;*yl-2DG$%CW8opqT`QDdUY{8ABP@Hp zarpW@hV|!FH9r+!dn{6sxBaDLnB2-oUzDdDohB_^;UvRiAIxJYzi;xqs4GDio0q4a z2zYkjApft*;4j55{LPf+U#p8vKA(Bt`Q=j0?wPv0^R4f) z$HmUtY1Yyj>%Yv^Ty(E{`P^NBug_f6eKnP%^L?DX}M=ca5d zWBU4dxm=D~iT$*H5*J>1GP2a)-+$wR|E9Ii)GqVrHOff$YNq}RTC!X9(aiSkLN3Nj zXBZydv6{EC|J=*$nd0GTPFo9?P0ZTkRb^@-uHLyzx5QpPexYE`y6o)Ju^aCvajmiE;VC#asqWL|-EZ6{B=CH<_Ey-ExwvFn ztKpCNMeo>yl>19LZ^?z!bv>Q4P&4lBG=q;HP1nxl;_Kr5DUlv9FL%zSg}a-41vftu zY?BIGeko$bMT?yHmX|HUR$h0ULN+jRu36t5TEEZm+{yE|ryCSDHUIGB@cb{CS^qya z>EyxZTe5oRH<_^4|9f)ep~8o{&l*n;@XYvcC$%Abd#=NpXByA;KfJ2F{Hdf_@qQ7H z)K1+QSKdbci+m8lxTVfBv+0@IOCBZ8yUBgBqSL1EoZ6d~v4Vg7zfUMNfo>E>S6h?r~P?Yt0ItY)xYZ7+TWDsX6v}UJz{tN zd{p1*A0q#2kGsijm(Ga!Bl@$eX<3;{h4p2<*7JfTF*1dX0{ZIn)Lydt{<%|ma{jNY zTufW$Wc_@j@!O6$^DmRkZG(=rY~SAg%suEQc~rG;^Spf78%yhJ_{v#7AL-g4(d)M` zaNdW_vP_?rwaz!GEtELv9IN)>>iWa^)417Bg{8^PF%{N4F!g8O<B=rT($Z#Fi#yzM5X)$C)1*p2#gxYxgoNbzAz)Rca#7DXlZh z4uzJhoJn-~_1H*p%_Egmm+SA^gqJ_9)VM5cdiLAp7tv34UpBgs@7RCZIPAgZ@a@z5 zkIe2`Vts3S{XWI&rl}is>MpKm|8=$LS_wm`Wrcf7(Ds!pCVt$-Zaq`P@BV&;`h&?I zw(dD}Xx|3oqw5TApU|*r+8>>os+W*Zb$H%HR-J}dcIHba30%&)$FV)_OX4#1pXb-! z>Gz-Q^kt7hoQKA_9lvk-Uf9>UicxpTl{+7H-Qs!g*0rn7CkJvP>e4VnE1ehR!U zJ^1MM*@M4&eR!RI%x}N)@2y4Cw*yZr7X`FUuRqdzZQ{F++pD>*W}P|gF5TN<oZ|Ba>O=<}t=GT{!)?_Ci*ys-N8U;v1QYwvW;^!Y7sOx>)b=x8u1W*QZ=*R+H=1 z_k2TG*6MfG7Z|VD{wCS%nBT^9E}buJX_CpwFCWjleZcT<^EX*$>*O+vin`_1TO1Q6 z>mT1||D@(-L0f60f4jYsY4YzhmN_z2YTLdDspVhn_|o}da_&mm`794VNi@FO6Z1H_ zsI_KssP>bmpQ972zRHP;`nEcClw8_-Sc~t;*_tD@i(j2zx4pi~)cy761je=Td#mch z!wc^$KXO-4woF-n_rmLpcjLL=)IWH!a@pITyPfj)%)9ufC1w4knkDWp)^TnsvP|$0 zdN#wMGH=V%ut^VPp_c4-%w@b21IVWnqIb;{p11z%D4b8^budk3T(6q}xJ z-Tyl{FJ1G$%Nwg@yH=&h-2DCTs_~!B1zK7`*QBOesqi#g#m}2!_hH3^{wK;R4_vIy zN4L*e+;w7Iz_(e|kJ_t)|9Y)%m4ETuZ0mN)C&F9CpIa+B3({D6}Z<}EnRqW3fGYg=RMQD&Z}5cBhM?P@@l(7 z#%&+=_fAZrTOK^rvj4Gb`I3Z_>s-_R7WF%Ct0|T+zpvw__$uGHtTJ!WUd8DtR}Zdx z64TQfGf(N@7YTWeE+1wim6~*eZIZ6>-P6tL!`mlpYwh{FR!7MC?&pKfT&erKH!a(w zd1^!M<@Xs6qXlE{EOx)1)w^%UBG-$Ik!`F+D{gJO`N*;Sr(*Eo2|v>XPnR9I|AF^o zN!hnI&0$ve9|?c^dQ&&HCyb|`^4H8xcQhdA871asn53|-NfEAJ>o>M^7?oCVosRL#x`E;T(@As zskJPbLb=NKw#rpbJ7uxuYnsC4tx=nn3qB9`5?6Jt*gm`E>B0K)J8!O+{uR6G!MgA4 z)TMH3Z9R^!G%t|llYJ#DQ~xK*;!~ge&hOcd^KLBQT4d*+iVsJ3jg5@{`i{eMKhSxvKn3(!_7pr1}-l zEO_5V?3{Sbal-Yi`$gq(ig{nIs26Px-nhje?82OBTcmquOEztdm)Si_uyulub(%}{ zlRFO6_T5&@xE@q=vDW*Nbj8ML!oE)hUTS4+>v>~3c@oFY=l9qiauopY6)xM1mm zQeWy>CyYHo_PycZ<{1e~N>U9@xUk^L5USdJ? zx)*armNs5EKK*xqrqX83z3YB174_B-@?CshHZgK{e@h#ddnO!|~BtJ$yW2cu#*PO?3-7-DaS0~74 zvZV|#lk^#V`R^k35# z98syBxu;}X(Y~DX59V<&3V0rv)-!T&=ky)}Uze ztCmGaa&C%v+lLu_KluVYJ}5By?hmg1>+P`m!7Gt>=_>?Zlu4u%vpB7Ac^dLlz-{Xt zLm3OEH7|JGSR0QmDlZD}tUvplQCw*IPmc)?(%!~t&Xs#;r2U-xzlBS%{kvyse+}jr zpZ}GW`J*Dpuxs;?O%LTBrSCFOU##AL@R!CRZQ117!)_{dk0bX@_`Ih#`_sv4=Ba#t z=Ks94=ts`8Zutjuo~K2-+>_qV7oPCFqI+VZ#aETx(|0{!3chhI=ZRRRH%rpA`sLA) z%RZ;SnzGpZVT^S45=$M&sY-PPi`K915NT20wVciBpUNkWGV7*`lkL12);&@AbavmN zoN%3UCR_Fv?&KDp^eedW!v=YMo_W9aE;%v7U8U?`j(*fXK~M8C5wXo>^FROhO6R>$ z;hg{VQ7DhqdhX=21{Y2kn9i!dQdQR3cWhO?QXK1{z5i+gCL8dd5BaKfS9GSpauL}d zoxh*nHMy zd+WZrthRX-H$9W4aeuF!64@N^XP#b^|Mj;A*8QqpD!;#8mQ`<~k`ME*58Izqm#r1a zUG*bBZ-Tz+UGB3&{qJYkY@VxpMLHZb76hnl!c}NJ1aCKFK%4x zJJXsyUh#a?)EzHkGarIPn)Y789p<)@AN+zIfajHVg7Jho|WgrikMOR(lz3{dgoQ@>em-scRY`GA zA6{|z7H7PmSp1fVqUEcrIj1;tc~`CD3%2wr{eR;0gt|+G5$`wNFi)NNHR|};?frAp zG!mPNUw2xF)W#~lar(^iBJuT?l7fg$mNvPJ45sbh6yIt;J#hW5c#&+?qU9I)J6D$( zuU*#c|E@mgaeg(gNn?zBZ}`OQHsvQlhm#(wW-a-4a%*PJ#_vBG7()vdy;?QzZjt2t zAZGuSwZ(@F>@rN*>Qyg)c3w4cw%g4~Yu^># z-_zb-VR32qoJWkatCn;G9P|*ZI4AtU!BXnB{xaRfKO4O#$o_Jiy>hv~7u!-6{)O%8 zOaWJJr~Th~`PCD~y^oqwR`~Q;{-FNSlS5mCsm9G0|cdF`1tA;(1isW>1`)uq%w z=U%wbW%@3M8}klKv^u*?t881^51C5<^?le{+oL8TefPw)ruX)x=Vv^f0BOtd1XUc)}xuB;daGS z3{Nuil`iP+zg8~)?b{O@(>XUaUe97$c*630h$QDitw1x?lBk*e@s0KlA-_|54UtYn+TmScWSAdD!!t1|31+;Q5 zpP;UJgW>G?g^iLQua@(D@ziU#-W=F$v&y1;_5SsC&EHs`&(M}!Guff+fBW;s?K%cO zEzYf4C^a{?fG1u5Rzb4A&C}rSV?42aw)WF`%JQ$y<@@w)Mbb*w{gaX(ZPD}n6&&04 z$S-2@SKDtB1Z&padp%94e&_n!slUY36t0}v@li|s!P3LF#c?V+{^e>ji0r^rIi;=5hQ-(hs_9=Qa@(){TYu){+T+VFhDd#^{K57n@8`<4xsD>Uj`Sgugc;kXcg=G?)nV*+|9#?FUx;Ep1-30&?={UU+-+Z@cnht{hGt>Tb@u`bbP;;rwH-`3$DscrTp$W4Hg6{#{j4{ZmhzeRf{_0K)n|FPr0eIEtWHd<6F3v;lqW8ijU)Adt) zuaMwtcW+z7nR)E0Y5AoyWCY$Dd=Kb3c&vSCz6%sNxnRnX!~ae^Y_wl;+ zX|>50RecOjl)ZJA%$t)b2W!r#q~88z$e56l zGW+;~2m!I3)0k9vzOsM0{cd&epKZtM52=`PwR*Xy9S*;<>qv6T1vS5U#rjblp;KI= z!<<%c{rhQ%Lj7sa%^EADtEXEATx1T^-gQf@bJF{ZHVS^5 zLRWrj|Hr2>$zDly{p-Ak-02;xRpz_j7_OP@y}e9W%&5XA>4;ss&Rzo5t)sv6kN>IhFuW&!XM=+J@$GplcQ3iEd;Qk?w!JPXofcb5+=>z%qaW1y zYlW-VU;D66LqhH1+J&80D-%cp&8c_SQiFNVwcMMBAg`9GT`+|$n5IM36zd1tp~>KZ+_ z@LwO!*UirtoA9E9XGzMf!oMn)?Cm~p^Ka_i9C~be?k>)~hh(q+n*HX+#P-|YRzG#$ zasF`3zWwa|bM~6(Cw!=%wCc&$$8jxFZ&s=BxjUt21$w@?=~7*?u0ke0@ro4p)f=1l z{;W8<-{Io1gpPo757eT>MS71ihPT}@l0K)KVDbIhn|qB*q+Wdun{xK{XYm8`L!NJ3 zd&FtALi?T;i&Gokd2v)uubndO?x%0Z9yn^w7brNTr>Io(=){Q`JrE55)7X1+#GpuhjgfX zT<6!{H4#$Q0_GY|^>3c4(#yVnA?CH_Zi_t@ft!>bZV;Hr>i%ecPWB%G&DXQ<^)J~` z_H@(KHrb`8ro7AWpOzT7>=TdZWX_5^LiKZJUT%uB7tA_3^U!Qb+Zu)BqaRjniCvf~ zY;*aX+V&X1rI$6>XZB|kmqOK>zg~}=$bPZ zSrd(y)_eIJ{c!bM_}$J&U5gsJ*rx{BYO7(Xj*gx^GVk5D{^;R9ytM0Gf68=+rRO*| zYbZ9ooV~elMz3Mc^OBN1t<@Zgn(1;8vC1c&Wjy|`f111ANk$gqts<2TS!=f$ zmZ%qhKeOK~OI$w3?cqP4emnD|uDkhMiW_xi{t!Erw|>?H-B5+1{I%KAr}@t8mPih? znUx{Ae)g4itIuzCO}xF&baMn-#@1cwN8UP3Wv$tj{A#{+;s48>0i4WlnzpCQDgWtr z+M*S?C%`;FBymUZyZY$KCnt6tEm^&4;ai7?|04UO7j6q)d*4j|w&ah%gW`{7y)x>W zzcbDtSYi9MWmZ*Ob|-Jo3jElT`zFf!jFr$?AJe_bs_&*2?qV`KaXJ5}*Q3IE_CF>* z0s`O4A3Ds)P2^2@zxBHOIbF`(U3}~kW^EUR!h~YG!dCFVzkT`2g@`r#>-V~DOw;zA z)p<;5K&i)|^FnxWgW zrBgoLprp}s?)S{C);%j+->M%no#rU{zxc4ms^4D}ZF4HSy^gX(ZQcGQw>a&K;^M}B zroDZfmb!{l&up+dpU@g;<;T;pn2Q{A$^=P zPG6#PzCu*ON0C{)lQ$i8J?}o*LSuUWRn_Dj-0B-V&GQyi+nX2YKKwBGZIP~x!tNUr zC$3eVxrlM{r+;yC%dVW!m(N+5YVCE|ddZPwwz!b~CFx>U`&|=u9=2L0b~|>tUW)G* zQ`vgmIeG!yNiH`$AH_WID%FzD6+G(My7aEtg8x(HdS$L~Poa6TNXSXXOc^A}v$WvXut%qGEJ>gR3By}zas}K5p z@=KB)sc*8~8)FfnUbmTTU14Y9_vzmjw%)(jC#S(#UpyfwZ<(_Dg<#`=9Q8kyr=#wA zr#LA%OjCD0d+zbB*yOvxp3iym95-pYnM+DCtusgJ{wS0_|$`l6Q4m7O{L_w)D( z6IN|f!Zy2I~HA2)ej|1ST*(@a<}SQg%Y9gFZT5zrw%tsy)^HcgOWz z*CA7f*=_HFqz^1#V=aGO>CpdWYu<66$cy{7>C3G$6XCvJha6}99-O;?)~kH+4SFOuFEE_n_g~T>OIbDtpEMB;KvruAi??Xn5RF=Pc-}d>d`l? z1=H@|dA{v)Oi+`+t~079FRO+Bv104iOtG0^rWgC)^^L~;4t+P(V9zJF9__xu^~#{q z?!v_i>(BrE*w1EIUYo!(uP5`~je5QR!3N0(xF?B=J$YZ{fBbK4&69Jp(qsH4TCZ!~ zn|tNSp}%3tJzl@wPyc)E+&aIX+bgZ#_-XBYxMIm#<|*mk%lg9ggqgzsx-I5i?c&ui zU&!G9ylrI%as=x zdZViHO@d2~@40(xkAUR+%a)>TGAmpzS5ExUX?jWFJNv|vpQfQki?ThoX1A{S#U$xl zE@JOgkR~Ny7g(Cqoowhe_i4z1+ZxS^;;YErIAHO>*oM_i>$KLS!gn(M=B`Y3=Z_V|BTmEVW#3%8aD_&bWWv+VBGbur# ztNjPLHlCTEsuTSG@sSB7yBj=37eDxV=gfYWPmfqj!WZrO{$63uakqcQ%Vu85fBCD; z>(@*v%IYH)4ejO z=6$L+#LCjHzn=2lLo2`Up=MyzZFkc@`m1OE__agmio425v6}h`3M*D0+1q+AM)ype zO_H0h@|y0=7FXolGOd{7t!CV4^8B@7mGjLi%Y_n~e(-B3`s-Un)oa%rGjd!fow+8z zWn-#Q(T?Oz&pB5cJzP8Y&A)`u8(cL_^?W}U=<&>%pDLs9{#kaoq}%eSfQ1buTk?Od zVK(r+qjp5$L4up7*0q~TtE0Rueq9q?efLz1V(ad=_6@tP?0ao_*fzJ3G3GK$={mkc z-Z=#?k8nNjIxFdMa-pJ^VpCxK_Ka5dU=jO!Hy(wCFR{D#>D}(7hc6vH{jAg?`Bi<) ziOH*Xc=9(qFVd-Xc3^IoKc@Tld_vld7mK zw$I6u{2eIvFlrO;y+>EK#hu?1_RU#a%Tslwxznw@MLwC+N<2QSi+{-cZC3Vv&R@vEwOXEZ4Tc9QZ(qy&V7mQFvhzvMrxjhd)^NuO z%09i7WYS$!_^4IMa%ttA=7}pLZp1DXDrMWnAW|v&!o<_;acTK%&t=;dtz5ERkv}$t zYii^~t50HE_ot@q;@98nGwD*qB)1aw0`*B3+3J}-Pu4g(@4=d7KUTi^edWuV_kWh2 z_T)Y~&HG$=Y~=J#UbfCA)r!j6<5{<6&)%ftytK^v)OC~7!i$-1#LC1**7^V5`KnDw z%pq|NbM2L>qPbyjVi!MJ_~m;`YkR1_uz}4#9@Cv|^D=IE1=;PKAHdk8HR1jB3QfBo zZm(;fXD5^?)r%_nuXCDv=9R|s+Z=IOjaO#<(!T5}{kX- zzBaO|uzZ34Gyl*2`p-7lZJF=Dpz&pvy_L#IuY_gVU*@ZX=lW{bxA1<{=|AyqmR5GC zu^IbWp_+xPUj6g=2OcJoc1%s)c-#+S7xsMl*JDo?%;iRLHNP$w*qHQ=W5TpcE3e6syOpdyxnD;F3g(sDQ)4_0Jn$RURE1Tc)RX;smBZ5i#zs5*F8Qud*7-4 z^-nDL?o|mY%=Uf5?2xk0I%IO)bQZ7VcLMkRKCeH&VU}S|yiK0NeYMMZkBrZ22&9xL zt=_uGUDo}z3Ab9>-nZXB%jK=xCpc;Q-im{d+9D6Vu@TWbZy&gSQbE+mmsLVVM#`V( zG`8o9dNo_8Jl}FlPWZW$&YA;yE{;^TJLfw&Oktb( zxw@o|({7sA>i0N*53ZF{%6QzB^yQ`|E1ZmfCokf$>#Q+mNh)sI_}a+{V#^L|J= z$uap)p5yJKYr|)Yb@APu;=b&uY24Obv8yKUlfPp1C;44cSlyNCpWeyNlm72p7Si** z>o5O?Yd<%V3RR<{QKrOb%-b zTrB^)|DW0guKQQR9&SC!&wu&~mh@I5XcNH}Ds~fptd9mE@H2 zkPk1XJ>15_TlqE6{&bsCy?xxOTpe%Sbv2iA{}pNRG$jcN)g0%_`JHQGbL!e`e(N8< zcqWv7($$yRvUCf0mmlO!qTv<+e5cJpPC-R z8nxrp4vE_gc7}cxUS5Xk3pR3}xaW802I~p-3rzL17>_hAV=yyg(AL-2w^4OCbMN3~ z&XmNLObadsTwSzudHN6k)ArE}YV-a#)>K(F>%3tIna`i+AYIKKyrtbjH!lp<%|PO?^F!L>k<@0+|(9w=i4PiYz>UnFvs{9sRFuwa;*<9P1e{PPSGj1L?- zdE?yE&pa`27!|C8rNcMZ3;ozK`}TirMRxVy=ViCezo9;J)85V9n^y{-ILP`zGBh&g z)BVa_5mLMV2;Y|c!pZ#RtbO^co3nTQ3%;~}ga0i5D@P?#p7Rti)>rNLBYc{L!+_b+ z`i4Yx-LZcv#RW`%wRywSC(J!spLT$ufGJACdge`rxpVC^?RNgRocn)`@Q3}O`EMR1 zJpQSl|GWO}uXxLbm^qDR&wM_t$(e8H8*7&w-SFnY%>OUNC9R9A8MIIDf19?B?|mHk%jiJ)Q2saQ6S)Q$GJ|mHwN1{JF36p}u?1 z|NKY)!h8R1_x|(0YW{!itxHz-_Ac7^Hl6uT^*IJR_TG)M4~nlbJYoFLBQ2e*e!!lY zJ>}Q`Lep)mH!J?lpY#89p6-MFn?Wqmf8`v4*4_TC5|NfOE&k`SS$a3wG^CxXR}c^O zZrHi;?DL0zPp?Z%XDivnc$3lI_22cMbygcU{1NxLE0mIz`@LUk&i}TCvb6tO+x+kT z3uWBAY{sOvHm$$^6L0;?-ux*&e8-AvD+b2@#*?Ns?Y;Rw>W{OkR@QsQ4{0e+AF zD%@NXckKM@6Q_?o{QY0}TfEDf|2xAB$_kn4D;d5-%!r7HV4VN||Ht3wr~a#7IB|pV zR`cJ>`>(|Gygg$V{k~rEU!!mA+&Oll|F4_;So6pJ+W%cF4hz^Xh}5NCyf?-EhL*1J z-KA{m$lGqO)@yLa7oPOjQ^qZ?ye75%oy)AQua7X>P!Y>>FRH6nmAyr^!46}faL;@)0C39 z3naI6)^OTiyE^-Ck;DEA6)HCiZ#(mft&9^g&9qjzcR%Q#j;XXa)Zhd;j2oozkfc( zX4!A`Ol5vceck15-g=HKg<&6JuDWAHYj2iw z6)`&fbxY2V8L}bFN>?^2X4^bgJ$9;icU=3kmx~tp-hIb=cg5EF?RD25H8xt$OPecw zA){vBR@>7jroN0^mi6}CKV6{;AFsc=g5;i@-xlfTo%o2IedMdA$xO!hGVr#||=k$#? zwPiS_J&JtrC}qj)sN|T1^$PcQDg7#&nA3CYQ(J*TURFu7Ryf~;_cs@6=&`)`VWOz9 zq zUYMV8!^kWlV-n|!b*^X1g0 zRLf@~4SS9qe~@VRC{J*$tHr$E7w_Fad@%h%J*#cgvT1wH{dufX`M<Qu_Sw(h z@7G*Pl=01S{d|R8X`9CNhc-v@KgIdo5;WmbV>G0spK^#-&G<(b2<|*#bj zoO#;(_#gHE_ekiwJlWH}^L3&|c;nfH2j#OBLXZ6p`}S{(!TYqk-XF|&mLz%Sow@q{ z(c_zIJ%5O1edA5{?X>URPXb2rLjPu5JNZbiS^Znv$KxLF4}Sjs_tM4i z1(wy%u4pnZ)pfS+$-8~kT=o`+$mOEl_WXk3g8FLTYV_3Cl+@dv)%^7G?{SNY4LU55 ze=@yFmwt(TwdZk2ugj~eGj_*%Z`~*CqbB}g^4!m9>NA<|&#<{1GG~daS;d#BGV|g+ z|H)ZQbkZw6lPuFaU+APL$HJv|82=<}oH;E%r$oefV*TkId_z5p=?}q4?GJ@H<>_a=XvYFEir~ zKHKtP+N<956Kms53%0ybe|)c3w%28XsnOcn-kauEkGqx~K7H!!+NJ8&w!*vXmj<3F zzN!A5C&h+`H#E%kRms{z_m?sBXFRB?6%Y3@8<_Fmbn*+=``)pK7uOb*R+ zIeDO^hSl9zSMZRElDy^f>^DDFt&-(Bd!T;K%Y7bmgI;W~{HnUx)JKi0{g5o*hf|W9 zJa(%lzxrLergGU~*SoDdu6EeBl^kr@=lh;7dD7I)e~#5eo&IvptWah8Gv;pF38C8GXLSW%REK5t{h$ey@E++PlcMz-HxRW6W5=9cROi| zPH=74_o#gvzTFD7JCmfXnCN@|eEq7VE5?Gh{kP^V+|u{|SFL|m-koqkWscK&W*KT; zi9t?6&5gICYO{`6ZoHN6k-poZqfd8IW9Cz{!YSVqj@^5(qW*oBoWO?mz__1+9H$xY zrCwHWzdC)Pz-EJx(*ninCv6-yZ$0Vg)Z}$^V}L^GIsvI0M^m=POtP8kH&wV+W3A=R zbDve4owt^IB-lAAXP%m=!NhYmR;rS_?`8f`zXkC#r{`=m7kbYpGjXC?_qET%zHgobJ52xw9 zCC1{ZoSnREOy$f!S8*+xf8T~tXx436JMME+dRsr$ZhYvb*nG_V@*RtirT=q4rrM|Hz^z?(eZEf}U-&eE`BE;HwffUw zO}A$(oOpM=`3ptAxOtZP%BCx156Ia|)hFLK`jxHnlrO1g&0S8GqPDM`p4$I=f7C_LEyV*(}Fv1+Z)~+ zA4sUTQtgA#yOua%P#MKDB^wen}_~C$DV)JjgGF`k*ORZwECXb=4*w! z4i=wmv!BghcOcATjme{K5r#l!MYFlDmt zE?@oZ{g0ogsyZ*-TD4;B%)A}$yi@J9J{T4FFF2ua_1?CB3cN|X!b2AZ2Y-1nMbIl& zT7Lb(2Ik&tJk`~*yVeJD|9SdR(|?7HM9H=nNfkdHWCZN+c{*>~wUijetjxaiBk8Ufuc>+6)+U(~i7*OV(TP3tw2 zlszzc^6URi<(2CSIgV}WQ<6L8y8hjLIj@8E%#2^_cTH2S3uw_Zu*+NaZr<$o#-*V~xZ?CMfUa2?VFHKv@9?le~(WY!d#k z-AzJ)f8T;)ArFfl4N=h&oBNgz^|ild7h1Ah4*V(F{%Wh4ahhSh$4&up#~Jf#9M1|j zvrp%>pIh0tUd~bE^uJ?Uv}J^r_M8v-@m;?D=DH;Uf~(gSoonq|#CTxE!L@n@E1geT zSmf=BTF&w42jir3DHD(8?Ka@O`^VI|D}3VdUOwZUGtaJh(dqq9(4 zIfPScGyQILw{Mub9 zo-4f;*?Hig)rZXs_J6${YkzXi@x$#?er`P_z&a_-&~18hgR4P_nb>9zd zHZjsHZck^~9>gcy!*=@qzqx@i2Yr^j+j(Zur23aZ|GocaiF|2Vc>3j4?Y8W9owGUm zYRj~jC%O0)_4@X0Xp?{f<`)ou2hm@@)lK69sza5&k)t*_dZR52EM)ua)vwwzWhwyFDvsv46bN7E2@5@a) zW|wT6@+LT_=C1z4RI$kmFYJ$Soj$ucW?RGBu8B%X@5&zj(f3?cAG@J!=^TH_+o6kG zIBqfRzUE!lZQ1)pc|wM)KvxF){z8k>k$fc!&ChIeo_M=wX{Ynz=zSj3LbrYN44t+x zI_&#lzsI3*;tIQ*488Z6ZkoBh;aa%Rau^z`gAtAsh^CN>+65q z-^k)rYG<#!ZogGj>az~hsh{e2 z#cr;KZc$s$_ldzr))q`YVD;up64&fmX{Xqh82E?3iYhs-=lA$SpG3vS{)U5(K2LMM ztQN|1ynI>UnpM8XPp}%Ve4(`c!>sffj=Ha>gmBvbUjBCVeud5VrfZioym+a1^r4u^ ziIW^>boUhsNS!*+FyU=#^&dx{IB_kVGSjx8brb8|1XO3_N%trJ{o(S%_6ED$?mca{ zcf?;yo0&d;#`6iCYJF#N148rP&Pmte>$0u;?z6ThPx7yr>qqVUqk3|UzrpZ4 z^OZ@=iy+N}s258s6F-)$zTuR4H7C^YaM%5VwzIZIuL`*rcC+$fddlqlASb^y`l{>G z&VJ^xegEp=-umjjMiIUjLjskR?QcoA%@|-*0baLqG2@x4R#QFsXtLX6U!U%of8m=w zPc8owQ_`_tT0fj!`A^5@yib9%#naZUl0Ef0Ymr#V%k84mvbDR5&+VP={3urA%!c5W zU0H3B93igFIsf>&Vx;G8nOIyub{um)GoTn{zT>_Sa@1iM?CP ztTuG)TeJLa_pGL^Q#qQ>wJE7ji(h|b$FjXQ^8e~THs2wd*Hsz#nbY`|@a_YGR;BeF z(p~?}r=n^TP{0jcZ?P=e?G=ug<0RLVV(syntsHt%G}A`ed)JXW@x@10M1I(#KBI2(NoViG-OW5{;y*i2SN#6+cyY&z(wB|(u{Zo8 z7jj4L-LjJV3`e9GuV!n~8ustoeWqG@m8W!1tq*3Czx`-?@ZH|%$WN>DnYE;}=C$eE z+Olz0(#GQ~&Rd)qW{F>K3GQETI^JmY$$Ls`(*F7X6FhsYr}q!rjrV4@DaTx`m!9-8 zIT3W<&Z4C(N{Zo6(_Q=X$+C4uRx588sOTG=4HSQ|N#})M`@4q+6BjvOObK(E5Vo7s z-Bv-nRdi+j0{0(+-`DGxYI_~cQM;}@+qr$4fzPF-mdlo%OVv9)dHM6Vy94weoUG%w zzft+Q=iNWG%e<3UXU{FJG(GYl&A$HZ+`qN{``+^Y^x(03Dwiv<#UMJp>{@12#+0Jh zFIw;DJ-zm{N>X?0+l-B!xmO--+qkdy@LxBZ9rrq>#6O-t>yB7`<+K>VLerDeb)z*; z_P)5*?yFcAeC(-7#^=5JE^@lh&yn09n6uo0PtNb?DW1;_Tc2sX%iX!~n!9S=w_m?^ zKfPHl*~hffj^my->%MQ_!=4%zw~58gusosq+3j0U(01O}jtL=){c69bbzOKV^33w{ zQj7iZE4MR$IvVOww}yrP+x+_Uk4hdwo_u_~m5~9xmde*X~rvu<2f2^ZI1T z_t$#1{uH{)^yI+&l&n;1=_x4}IbGk1-MeR)Xn(X?_#1afp{C)LohM_1Lgze`oHsR> zzghTga~fX`(@#;k*x2+hKRLFg`m+aw?_Ra`%%8VhoAc*Ad%vGCJt(rwLBF-2e)^K) zvy(5DI>ng@PD}J!I63je%Xgob^PS~pbtyZv$?{>^JKkRhc24}Drc;}v{*h(5Zq2q0 zj{e545Bu#bSh%})ckX+>d7&;dKhjOFId4;(-$#amCrb=X z=Uh(qkjxYL`p<7($E%*;ZsV+_JC%D9VuYgWbM^Mmj(R%Zu>bSgylRfE?_`ZnJ$5sh z(y~|PXS8F9NKgF}udOd^mwN14H2sW5dF6HQ>fQg?DjvQ`NI7c6^Ky;N2ltAl!T!to zTh}bLn>sP)i9SP!NAisPCbP^{Ld^RGT0R8VuN7q#Kd|?E&P}80-azZj zW53S&mIV%t{ayGXUcXOAvrr+%TiYtgXYrQw zc`D@CS2n4> zayr*>y0ha}$i$ydX1rBg@u2pR|1sM&UZ0M&y6SD*_Fr>O)7x#+*PWQ7Ixljqv|{U? zuf=(Ot-%&LF{jq3b$`sSFaPbs=rQm9@svN+F%cdC?|t&ve!aXki~C@o^PfYWmEX0T zwwYW!V#07PIev}y|MX2^yv@^sy}s62TsXm_^TV;?g6GdeQOo51-mhgfR+P80;G3~S ze{=7;dr_+8Mjdmw7p-q*TlD=#A)~U;v?*@+o7-N!yPUlCdELX)SDV;$-`=aYw$l~= zD8zH(^p`%T6B-I`TfRj%7Vuu(A+~R>#sdB7eD4eQ6k_I;&Rk_RqlfEWPF}duj%_Qh z{(D-Y3BmYM1sXYOuLY(MMsRgJaVqdzYzTzAv-y zv1RTapZ$BfdYoiMp02nY9vR`f;7E0|?$kZE=RCQ&U`740N82Y#Oz!2(dsY3yUgD=| zhTY?r?9(=%ST&2kRQdjmWSN;4HcqscTl;(R@|x|jUmfReKcrZ@?CE{e$T?vZhwI)I zNUb^E_18CDdSZ@s@0GbH9)!rI^&LGO{Qr5s^Qv^I-)xdL)^|Pfv;02_65g^Eg*+ZRtubX6Jyyzn`8m zH~%WWVp9UaxFi=g7HcJbkc*=RoR*xBuEc&-}6XOucy5)kU2N zdNm#|0>Y==z9pCZ`GSO6#FNj9Pw(xEo5#lL#JF$4H+`vltdi=FD)+`MRBNp0Su3o_ zSpP~`IP5gDnC9sz|L0sx-RV8&`80_OxplHzl`7BtXBCclx1DSEGDFMn(~C}Qob-vI z`Tuc={fFh-Z!q%C2;22$o2-rhq;nOQ>bI0fxZj!oEyG@FX1edxQj1bn?Lhla(yV<# zW_K5F+rKgC*VQgDN3mNA&`!M_M11WpO#CvR<%WqgpX!rg(Abq`O|6TvI;~%8k zFY#~xCV3}4(&fsA@}KkPc^sU2W}AJOVAX?D$~omlQorxcymowXV^6oTTj6u==)O-< zEYmt`3uAnnp@wM2^ zSySE0QbMjDH?ldJ_pfaC>N~xO%EI+?e!Q*R9&F6IsPN;ehx4ulo!tBGiI36Evo=W^ zCg)Cb&+{n!e{gSq|I`JI*Y+P|ex={Db-7Oa>Lo=szN-qSM!vb2`)lsL&{YbS4>Ro; zCaiuWbbiumm(8_p_3ctS?ap;Px=0wb%N8x_jAM^%FTT4dg9x~ zZ}D4vy=vmwx5=_xX@9+0l=vSyy_ax5*)GwzZF|^WD#{VSyn}U*38q{lsEwr*+Xc z$vWMe>+Y`$^b5#(ze<6Ne{M~~wO{2@l9AUn{&pExYpz)HdE2xP$y>RMOj61|uPg4D z`e&;i4|AxDccj@%d4*=Z!|HmP>hJ4IBf|5(#dlTTnYwxF^c9!77T!L~!zKJ_+tF94 zN+R6vy!BWuJ`2W$tgx8Dc$T+>{rCFT=BbSzHhx~YvFwe9>o1*>$$^qTD|N5Na6V!; z3fL9$GqFH~HMJ|xZ2jANPFF*8#e$ZKwYBVS|9Sf7tEUeQIIkbvp! zk9rBQ7fT9PD(zp!D)KL?_~t3Y#n!WuJ&&F+QT(S?gq)UNqvz*tNhm~)hovE+v ziZ0@v_o!vYOxJz7heFCz;(qh_wrJPPNVU~{)bjMFPLzRY6(4K8im7Q@&xf+yw%JF| zE~+!WWV-3Wg$ViM)56ppeD|!GkkiNEIo*5Oy`P(=JiU~@bykux52w8N%SrK1w)0pY zUhDLROR(z&pm3ND*EH|1-IA@p=DklmMnbP{jg<+A=jE^S=u6f?U(&;J6+M1Z@TQw zE1CM+XLq#T#Mf7sn=$V3Yp@QV%6LS~V)u&^t6$4T+HYYASrVVOFgxm5{5oIn^^;WG zGzI^JemIso^XlKr`)luuudOaqtGB%UH}RX&Qv3Kz{7WSIPixOyTye7NVa-=B{X_K} z@Ado@SqfTy=g+#JcJQdcKaQ*MR9If7d`Fery7&6mHm8T*4)-yhd_Ked+qSFRGwl>V?XwHo79f#X z&nC6Rqdoe7nRsM{*{#QY4C~~?B_3+VE{@E4_wvi)Lya{xB~G928KhZDFInMqjLZCs zM;({5w(=iWy?-xfZY(+xb9(>pKRXwPPuSJ9!20XPkU~ABzp_Uyl|N2*4*BYuT=6@w zQ>0nZ(XF$tzPSAHqXko)qEsKhcG}B2^L}xc;l+B}8I=ZM4X6G!IGd|1`F+^q!S|Do zx?fM6ps>z5>(h9st!DY{ zXD?r{OfUB}4eI>&Z~M=_qkH%53YvYm{P!WnP5;GK?dN(@YWd}oe(H`V&c)A_CL2y% zoa303QC1UjILPru^~?K{p6@(c(HABCykPUw4N+G&spQ(1Rkt`w@B8git7eiEn!b8l zz^&^?bsmKGHD@_}+Qa_CYQxw1);sJ;SN&rR_Bh{OGGXSeS!SAAJO3`8E_u58%_|2< zVX^tmt#Vgynm@Ox4(;4vZ66u7l9Bz!t^(dSZzQH(KPG(U4M*S7vy*?@Zuzsi+1+#J zK@pq84|9bDkNE4QUQQ@D{iew0%nv>@nPm_QpFLi%BtE8r;d-3$^cU8-){n(P)Vm3eWd?{d5@Z`YyizyX;|NNhA z-1p_m`?dDkllT%IWQj=rmA=AOvNgi?nmCuTag>Yxoj}ovEt@}_PRk7XHlZaNq|Wu%g_-Mw`2QVTp#HZ~#%X3) zzrE?~;OULF);dpbf1mvL!s*MrA8l9fJCU0EE}X~nfajKpukKpkG^ng!dUws<6u0Ko z;~br8Og0+7vbom;o?WT6EjQv-(-oK9*LF1M?VYc=R)IZp)4c`4GvxaU-oKjlBu7qp zN&NQg=ttVd^?8X+U5S5t)WW|By}Gl4DY0tXiaNg2cg?Q6$ar`;?aA6g_SSdPR`$MJ z(`9L77}R^4p?K3*6&5R-q8~zeKMiNTEVe636_(2CO?r97I7M(V^J@O-nr*!A?N<1| zopvd3reB52k$dO%+r9n}IMpcgO{Ul)f%=brZ=Sn)?NwWDS}Ra*t$5|>^~GKqscxqp z{JB}bDYamlM;6n~CATlP-dwWwhJu!eVeqnp;-PHKD^6W#5IGrPx9z3UhuE`|&aIUD z&Hwm*vva;q_4dk)48yetUbtS~B=KWk;|-(P6`cDk?XvfNYB;-NpUd$V(@u*0^_(>4 zHMe|vdJ@M$*+py8q>?wUOzWzTJ(7~sb||xU{)>;7uikaxGCBMBb$s{1o31QookE|b zf^`qfTj=4#=e$6T+t1zOLF?VXk30*vMjTvqe7DAgOmXj%6T^8bAOH3*-ctEzLR?T{ zi&e;nEApE-nk{w*vR*0vSbOkyJNpiyYsddI&N)%g;d5=Rw_T-;Us=gH+uZ)$j`hKh zp1)uCD1LvGnzf1VHD9qXr=kS4Zj+2Jp2{6}w(s~aDXy?kORz`nkiY-WKP+hyZ1=jW zgMPqWA5q+mtP1xzOwqwwbw-rSLQsOm;S-%(z%td zq;C{QS?yG?GFbdPBul0~-ts~I;=kKxipMzau7CIY!P@_Mlj{`S|Idqh?e*+{)r*x^ z+kPDoI}#=udCj=y)UIPm23wY=XPw)atG0eC>rQp+?`^>b7P8^`(=V?#T49)1_4(t1 zdXrB+OIqgdb$IgcVyLITvc7=ftd~`pGU7Gq6K+`^>T!H?=aoKtYkJIALouHZEDQRd z&vI{e_f6rc|FMnn_YoiN?7n+)F*&=oeSbc;tl;Lq^?P4hF@C*!)i(G0;i-q%WF*s{ z`=8S^ymH&*Sljabh3&JV+E^F37~Bziz;}VC(RrUFSABl)<`dTzRqcKqqBH4JNkZVC zFav`giSH?$=R7~pyTY9?^~r`iJEvr4+sm(-7RSB6F0j68gGF&YhsVJ~W?s<_PZSq4 z&h`p$w-Ct^zJ5lycd_JF`D>ZRdS8=v-?}8X&;NK$QrD*>1@o_~7BKy_lRU_)rV_$+ zGFdCZ>4bN|$9it%9JP*Yu6k0%HfG$48oao<@Gmah!UwUiNvU%Fz_p@Yl-A_cSgl6nd&4c|A!% zi*Ln;NhuYQp~eq&HdUWI?%E;1@z9oais$x^d&`~I_7%BJs#ttaKkIjQ!gTif_>Cp2 z4DIEn`|O^w@Y%B}n??O!Li1(Sd?e)Cie|q%^7vI__lLJU{hssUHvNCD zbuB!1vnY0pdH+QApJF~+ysRI#d8I1!?W*^v4wy3`Z0bz44T>S>uKYcBeMSo}pLV7M zx z?x|(2smb;Ofu>3oyCxP~cc}^GHOpClMZ4qB#Fe*?mALKrcrHtAo06V#!Y$`{rg!S@ zO$)4r>-(Klc`K>4&Quj`&Y+Q?(Kc^c13q%p#G^Qz3<5ZTdp5k=vSYv z)>eM}Pht{N^%kxJ(mpGv9J&$S|N5fOei8jCpEep-$1e}_D)OGoVCI+nva;FZ9J@l` zzZKeQ{;aHPg&uNCO;*hRds1nE%ID-?Pq(WHO0NGj*}YzXapRgxeY`D?N>tvloqq9d zPRKvQbPdM&h1D;rQ?xCeLL1QF-B+yZI8mwLg9y+x0JlbHNIy-Nr28t(E8Q zZrB=G=4=0|+Fj9is|nl0qg{)43X`FiD~{#r@xDe9j8<2}}zv~B;ja_{-CTCr(&IX0OuT0T*JwNH`V zp~=h7JIXAdcJ|_ze=n`RY@8zeV9p#56K@f|rM@UTl5;r!)9+n%7zGDQRks z(qDUKo;+D)bCJJlQB(95`yH1q?R+tHvETVMm4YTk@76Dw9;4Li@!qL_X}ziBngcSM zs*XX>80 z#4O6rlbX zm@V~SNsFcA$)g(*Ls(LSoD5s6H_3~h(p_;>QhFYDq1MX#d1keB-~ELPTTbO3-g75u zU%m4Qn=k<($rO!JF_pdF!!lGKFV*|HWe-1xIm48=+3THowmLA?R)0!5p=y%(*`w*> zQQ^Z2XXH4Gi&imze=;ew_|E2p?0TL#H*JJ>EV;_g7haZk`w9;vzIcB8oryx()V))(u39&WWSchb)X}+c_p+dDyzfl6 zJFm^X4d$76o_DD~b;gbBXM6aUnIDD9>u;LRZ@t)6WGwW2XMw@amA5Ayc{FFO>_efj z?8kH5yeCYN`xo;eWS02+X5Eu{InC1oVq@ohn*Qwy@8b6vO_OD8ENU*Ezdzwym1XS7 z7bjEb;U_j7PtJ!fymzj&IN{FO z&On8Iw$UF}tT`IYId!X~QD6rvYkdWm(t@blnRbUF)2~Y;c)Zws$09+E%dwbii_E;f zsC$==Z2P+CaoLTm-`Cgt{B@$_ym}HxLX3`xXkEzFNv((foYd|3Tm5$WvT}jDD-6&1 zsvqaA_BgBK#rS%mj_```*N@*`^QbFfSG#?Ex#j*RK@x%!pZq`ioMCSJyyJ2u`vh+B z){6$1?z5|}tGTZy^v@?U>#fTlxm6yv>$sJ#$9+A1Inu=CR935X`I${JQ;T>TQ;p`m z*Qyp2wpn=bC-Yoa+3YQx+P&-I@0r~Ctx%CZ@wI|LRAuvzqfY{KSNT2nHZWRMasF@M z-6k!G>%WT*89tUVpVfPD(QS#`(|w0kWq%!gYn@#GiGBU5tre@1nDRq^Mx467f-n7# z-`pw9)v;>}8JF)d@JK(j?C+x&*0LX>=CF24P4(NAIlF*;zgE55+ut_r)7k~R)`h(- zZtO~s42((sYVWmTS9aSie)g?0Y}<^(i>m(qX<=G&`ODPRCp|u``6zr+^q_-__JsL4 zlT%8{rH&=mU#|b08IhCU{bg=&uS{t~>n7H3qLbgxoD{$z@&3~LKW^8{)Y2y2-~GDn z)uE{m=dHb4ywPB@M!(QqCHwh@{9C*9>b_po(lXvvQ;}S~>dczeS=Qmd&TwdMbUea) zc;?zkr>{AGXXDs7kZ*5~J&T*ZQ|9QRgi)I_Ljf z{W>;oHuvN>`v*@aT+lzf-*V+=+0e)Jrr&uipYi8L$FArx692sUqqg-NL4oD^n;tHi z6}nYfo-byF{dXnVh4%$yoi)x+-peO9W#|8}o;zaZ^9nm%FPv^%_}R}ot4;aA5_{37 ziYKmTMe2W2xi|mIV~+a*s|+S9)xX_p*7W$?&Ry138o4Ppj{7I`L}yJ)UNGfSV!&6= zqxV(Z?|z)KCo)P(naSfQgC~3H!}IrZ*|(qZ{9a@>TP#6vUZL^x`Mu}a!h7%DJ9mwt zj(uLRb;_zEC5|p1_KEE4x?sa|%=xH%_mup{b-Xe&Yf43b9ay$|iQ4&u@?{&}^YM$- zpZ{^|danCx*8?t1D-W#yz3WbS?)KJcc3$jFb9Q$o2R0pR{uv>2>iY|~Y>3;G-?>om(1aZJuKwQe%0N zJN2$y@Q#Ufd*}UgxVkFNbNk7qmfEV`*Xjd5*HX5*UlRXsJ?pVsSrgf-qSwK- znyu}QhTww!)0LSX(;e#%P4$Vi|8bF3eOvw_{;Lh;zjEI(AHABsV@C@^@|*r?hrhZk zTxO;6RcNPOj8{~>kFD3AoDG2*BHi36g|qgRc79t{l!No@Y=1oE|jDBA+(?A;g`(WLAR7Xp4&Q$xuZ5V^X}!6 z&Z*)@Z!R?`Vygad?pCa}+4m|f|ASfis;S#6_+0spFZTG$R~##Izp{SH4a3Vt>ILG< zMP->bZ?`{RZ`;Ab^|MgiH-=yGxJ)&3{?7Rig^Oc3mwi8-`R$fcbB=6?awy ztT?~Vr!-up_)P2MBu9bG^~ZXx-bzK^W8HOMbkd$LUM3u~nC12w8uaUU3f7zv>y$Rw zxc{$9z@-H?3P)d@xUuntS;!x)`s0E%mh+wV?GV*24byp$@=Bm)Nt~4D2eTC_%wc;p zq&~6kFx1$0Heg!Vl8<|zgz@XVHb3|7u(oAw@6$H#FXC6%M;;fePPzO#wPrKl!{49P z&k8S&kk-kqVzSgh08t^{dj>=&Y`ovtRSxb1A2sqPqG$ z4(nY`F8!VylruLXz$app=ZZrS{s%pdq-}iib9NqU*Tka_-mLnxZKZG69Jkz^6Qc^A zJ&Ify=6*nQ*BZYUQNQQ-v}l%aWbTvMkea(KVdZ5poiFbHFFkU&w{_>_4F)?n9__XA zi}YR;a4jG{XPeX9m-(GhE^A~>cWE?L<*sj+~&+Gn2O0PMe%@D>*4vB1r1XiNi)5e?H1Y=r8i%Y~EXC;hhOci{vU!Gf~HTbOUE+32C{b%3jvM=sf zG3Rvt`i|24dN-w(bAGq})c%#yFkH9d$-kKHdP}DFx8$3aHNMpNY+Lz;PjY|ELbIHy z|EC?lrnB?_|E?2HzI}Y3nrV=A%iT#q`+8}(yzO6~^)mPUf?oH({?mTeOFOpWoMnpS z{=)|(PFqJvRlau2ti96Ooy%%syZcZ2wjPJSsjcoGz6ZWNYA;!D+W&Or1?RSvUm|`N zb8kzFUAV|F>H6IkE#Rs>NnK7J<%!efxfG z|8D%Szu@OKhrmDYrf)n`l{0PnOn%vGQwMPKI2q5qf_9Iiq7iHPwxU|W-NZ5RsThIyUcCHYh}e;X&a~69M-BY z?0^1zy7+pzGV7xMW_FL$#8{ab{eLnz>P{~EeEE6AGw+`>dZJ^O<-eZ2WM22QQ*jcT z+sp7YPa9SU+LXoTWUTj|%q~=UmKRv3^Hx>m8kt z3tx`&{9l*HwQ`eM`+By9R_%*yDJH@trAD{Agzg$GnC`}xzAW(m=Lx@+SLx?C2|QTh z^45c)wvWlXzTK}l?{x6y?maIjKl5P^-xt8*zjO}YmJ9Os)8F!Ls@PRxd$_yjs$s-V z@#{-(9os%-_uW~)Yh3S?Sa$O6wXJ*I`s=dG*-Mk>rEp5;o_T+`E49Y;+Fb96hd27X z-|*2)^VZ5E9Icg8T2po$neqLJUUiB>f6I~ZY0dAeq_!A)YbBW0hvxa-_w&#fTI6f! zc*!Se($2HuUoO3TG{eXH1oMgzZ{h#hmxDhq?<+sOP=1Zf7BxOu#%KH9B}EnQsM_!L z=Gfe8yDS`*)+z~32oL?gd)M{`li;8TN0F%Qp6+tST6eDY7?eB42svGh{vo++@0E(K zKMdEsL@sfh53F2d(s=oYetLb5LyW$tu7ZcDwn(^i$zSji2rMY4B?1!9y?JafN>0bA-Jq_2>J~4UybFN45() z=&cX*d+k@DClze9@D=wW-Zyo=l5gv3uIfchWC*p7nzk=w?TT%}tV^S8uC0>0U8!tam>0QFC_om9z>||Pa)v8^qRw^#`6WNk*<)o95&8kC1Hm{lr z0}YlvSU2s$g*6YZm{%NJdZ3Rpmxbz*E#vI@UhvAMNf_#>MMS1eIR*(BIgwb zE}wuai|PwAH+DJQB=^WHhlw40>IYK+toJERdM$*||xZZ=DY zms>+$u$)jyP4dsWVzhu=q*cS5sZGq0Ey2$!U#Wn%w_Znr*GIZUg!$~DsP#%)nvP9# z4ifpv6n61`fDL!;cZZW4mVE_JUlfK_9Az|YSn2#mnPrXJw%+|&dwwr?yT;JtV)JdO z6rn#7cP=K&$IP_U`Wt$~(%{p*$H%LmtoXqcR9Nu)a#PKpFFP3omkQW&pOQbz-n_ng z|KDxf78fjgK4XV#z5Cg!1OIicimnur^v+E zU3VtktJ>n2aI}KbM;3X@nLYaFS4DnYs-W(Eo~tPC?;KIylb_?wMeo#WtY2mOiG^*w z+vb(-26p@1{Z_xMu-mz2nWEFL?DebaV&(ek#o{L{V(VZ$w2x_F5tBdri=Tb$i!VyJ z{T6Dn{`9!HI%md}4J#-9>bS7{@M8Jg{yAs$)BgQQwf(ivo$vVMI@6DHF06mTYN_VG z&!E2POnlRgOPzAXb{XFkzBo^~YFj^N509wra*;3AAEa!xPkjFPa|c85-`8wkE(ZU( zzv2LU;-QoC*yd(&S{zbv@bzcZk2)#mBP?AZz<<1X!xneNyzBr5H)TeyLIDX=hl$dg z8#zBW_!L}bF3@70$6grN!2ZZ&vCjL#W7j_~cPB- zf9~D^mTCvJh8c+uR*5Mv+Ob^r;}>BxHj{|WdEofW=Enu4PZthxonTa8TicbjNVfTc zl*S;C(-@X^PNpAXfh1CZ?3baRCAKG$vv3B}|Ja@qS0||T>EoJt zwRe9rT{dIjl$tR83xiv{!i(<~^SG}GAGQDee`0n07XD{{|L6Q)}5l=(+a zqh`+mPaYx0ob2wKt3T)NcYM|*I)N!aNYAEQwXH=){(Yv$DZ{HrUR&^~y{ofnoyz}J zx^Jz5_z~ZvrJU!rR)`t~y2~k){7!zg*r4b0QR9`pwSP7j+;`w`j9cpME+Nk4!}sMw z$KRLCe=ZC7)myrF$?$)2@E1=#)TMiW!IY=1n~xdK?3={q7H~m@hws76t0jsFcNXw0 z{&(;KgJ_i85ogiIEAGiy#rWsS6uzDIuK8ra<{cjwWbvu43|AJN_(DstA#{ts)Pacg z)ee(FCcF_V?B8hkmiNeU(dtyzs^#~eUuV>M8kLEoe3_ty-eeuxssE+M>e$2t5q z{+azY9`7FNIbW#~abj&)>`>XUx>V?$*8b~>GQFGEIJX>1X^piw$|%ET{|^#Y{gn9Dk=D*~s&e&@!b7J2b7X9NeC1r~3;(3OddOQjHDtTM6!)ipCM)Yc_lVqa zEYWc75tAv>{o?yCPRNmZDjUhXYtH_r+G`tMzc+sQSw6>m-vMC-Nu6C1_bdAE#EhNWGkKx-Iw4rBdPfxhLDL`X4VhoZxQb^?%WkO6_D5zH4bSRfV2M zlsu8jR%5bhOj($ENaNc7{-1y9Gx;Vhm>whkaL1cnJJKZY9B_Urw(hh+lj`-QWvgE+ zweH@P*JR%}(d^0Pk1wijZMkE(GodI}P&@Peq{z^_JF-e%-+5Xu_pUKXjJ94xMP=L`7SX9q4kOPFVu@#Jlw%F=a_%K;k3J1agIyfH#nMI zIG2*!cE(M``MvGN2NGx7gzLK(@a~dQ$rKI{o2ZcEb!g50>kH1^aNXZ=rDo2A*!1RS zA3~;WO&5!4a;-R)T(`GUZCh^6^518T1qENmiO*x2B*kZ}DJQ!8?#!jpK{^L7&)@QF znp%^pn6!UaPVVhl|HAalSfo=|i5gAgVSdiZ@U!Q>1l#=Xzq6hv-98#=9_#N@|Kq0g zVKyT%-dk6T^<=(13_Mx|7cAsJtI<^WC)iV{5*DU;V0=PnYbQ*{l9A_tfhmj`F(t|G!>beeQmI z@#&8lR&rA|e|jJFPQH)5_Jyg&`em&=clrNDKdC*|UHi+lh~BWUfqSU%c8e^nz`X+3L3UANhm7ojCqu!WFh- zJM`3l@YO$$f6^c`N&QKO%;fMVrk0A&pV(iOTdP{#u`UVnu}l9li7NBr}PtFKbs%V@e+b@>yXDPQ@n zd|enAVL3N+a@DW7F%!Crob=S5KK-6$wqoDepz5Y24jZR`eNtri$81I2q|+Z0Y?}TS zL{!yQ=Q+H-|H|I+=i{F&U+PU)dPzvVDfs*P*)FNd;u`j5o>eceM5l)IYZ=Yr*I#vV z%RVRV-iL>HcOJBN`XKY8K5Rifb4=gwCus)rC&@oKUSqTRmpJo=S4-q#8#9+*o$rtw z^es}J zSN9!A-FRO1-&=uybEg^BBo=!XPriKS!K_QBY}3_@cO>jQc=}>!+J^35TDu=zt#6zD zVGq;dpNrp{M{j8_tuHj%t@t$~EY|mw%6&Hne*`d#r8?N`s=oONaXwG}hBeKomzv}*o+SveW`hOcq5 z>o?D9@HlqZn`M9BWXm;^b=$Wpl}GHEc{_jp$@-~!x3?vHSolQyo~hC$+aBvppJG#N ztBcF(eu<^n#;UJc;u+H6`(0pb!F?Rq~&UHXM6?@TRrYgxwhr{;sx<+xMSE z%ECH&In&uDt~t)UJHARCxE!5v;D!%#&@-tY7X?$7XFmV(;_%1Q;u@!xZ%sTd`rGc6 zLEGyoH+`6w)$f%qFpRmY^`+!7pQifckMSEN(`O`F?&d4@u{?O;Zp+*YT^SM~&I#I; zE)4EAlIQf-@9l0`edE*gwyzv&tq*GqR_C+rKk;LkRO}h{W-VVS4Rs#Y$;X$-g=ro+ z5M#I|@!YrOQlHJ2dp^9o`MUqT{{fTd&$DHD9olBfKACmvB~MCy&sLu1<-LgtmG|zR zHDF$q@J)8Y(Hg6RCk2)t+%_d``H9M!qJkg4+4Yyk>Mn6oRJ=bu;HyP>zG82j_LES( zTU-arxF+ZKpR>2A{P*JO&4;T?pEaMVlb_zZa{|-#!p%Qp${#I>KC!LL?)+S@?wAdi z`xLBQcb}K{v)gZ7WiqpF_PTmr!J~G1T?Tp^n>KS>MtwXOuq&*q_RQ&K8JpQx8Sd_s zQJ1wW<0^IcpD$PQ@5_r)+dVV<&!4(@+BdabP-9a4-|njkY}UYWGXweM%zXu zx??Fz{M>l?-+QDszjF1Hjd>p(T;wyYU}tc|&o4i}ym?W&j!nnt+Db;{p0Dfe>mwgd zIdSE{t*nGx(>1G&)|}dM;HZ{vi`3)tPwW|wu3Q%h@Qpc_E;>a>dUb35LYE9twq{pX zfm-Vn$B39-LbEKzV){Oek39}B({E%k!?!10_iWU3cv#&m`Q2yd~ z@ZICvm&5hXM?1Zr&wJ|P8+(asH~6*pz4&osU$kPq_phRY;@C;uTp<^}cm0UFcV|jU z0H6LZ)wH(FQr?sE@1HnZ>YMlAf2Ob6_2h;Vq7B($=N7&?yuALJtnOP8&--Ref^*|crtjoR}iLRS9oLigRCt2TYIecYV6 z`(Mu}b53x*Tr}I~bn3nhsnN?q*KTQh8O;*5^2N5Nv+bv?xgA-*uamKS?b2kmJ&Fp> zGiHWduJZczSn}DG(&o0T8}88#Pv7#}y-;AeA2A1bKh?GnBM)G z)B9}Ig$;Z~>srP1^zX1GSo_|7KYvf<_je_%2LyOuJFrci{XbWhm1N4$ycjhK^5jrgIbE231HMN}ErIvNKu|9sT@{CYN{qnN{U z(`SE=F<){vwwPT$vE@cbtj4saUEI1-^BV#->xPI-Ti+oT*`qNhqm^^UR-^iQuCjdn zCH3d0U8>i)%~t{a=*Jhvx8;pzMI*mu9V z9#|pBbSlwu?Vt7e)21DX-e~xz?B@SzA0ln*XPz_QdzkZMQ%`Q2<7?-;^JD!F=dTNA zyY2gBclR#uFRs(~ZIWc3_591%cVDcz*Lpt*oxbPH)8h*J6!Oc|@5erkS(Lx)i{!N0 znT$nzM`SHt==tdtJ}_fmkjk*t`tLignCbf>nHH4jviY22xI4G;+@l*pwHujhAC@h@ zAA2||DS@-TX<9nZjXMm7-ucx(zWqqgIE%AC>glZqI@{ee?#ybC->133xcTAbzZMaj*Qf4T&EP zwbhj?CmqhJc$lH^tRi53_x|1G6FVk=wdw@jvM!}Lw_aLA8WsRXy z>laFHJXfJ~PI5Q9=D9`Fc6js#ym&Buj!^3aRp-Mit0xG3Jgx7e^06gLDzNd8iz;`u zd^D$c>qN7@<&$`9o0^9Q7>8CCk#dFZspse9``w z$z5NZO;WDM#+TNs$S!qO)mrMCD*Eq)SJTQVMN>;E)`zg(3+HlLy5?AXaAxl-1#RWr zrAt=(F#HLfYWmBoGr+R7C{fG(wNsem4z8xvO}zC#R%>Y*i2Vrg?2J1gy~n|@f~(i? zU}DbF0QUSPW{s zf<>-7CS5UYthW;SfA||iT)_P;M{70~iiB8&gk@;0RcEn@Td;|-QGA7u<5I^|Z!5N` zbDOnS2Ht!uzcSF0;gx{W!Nq->rcRq7a`f`0q<{}oj~)8p6dvUn;`Tl&F#EG7V#MTCnMI$b%n`tfnQ2u3J1yaFvs;bMO;^fb2p8Rm<)7`U(QlA!GrKDiwb%dI@k}fK_{_uaemY1Wf84`z%kI+R%L^Ri z{{DD;mH++i$NL;BSl?~m9&T^re&TLPWi-EU`I0AZ_86GVKhC&p_xw7qvs-(gX&J|V zQO~}0sK<29+RzhgDr@J=*}U&&kJf0)`<7X$fU#xnqvZ%dv%k7(l=QLty%bL)Q_SfoF0e7cM?GJMC%&4Pl$+t&ED^*{Y!C@7z7R=e_y z`1I+W^}XhkzMDo$=lxSY*c8{8*eAQ`*z7eQizj+NE)`U{WFTS^v#G*Q*Q$Tz=Eq*o z4VP*(yY1onX6HULsVIeG;^~D?J{_`h_9*6XozymINpZZS=lUn2AGJKKUdtA2;h8v% z(X26GLg>`_+!G!#92NHJtWC++xKZ6{c=g;w6_;IYlh)N2KjvY1;Lvf0SG7ESozbhf zlUhjuLFMnXm|GqfcG&Q7@Bg&U<&{?f`>P^5`{UoW_P_JevpBzQ#$(TOK9;*KMX%eW zIkQ+NX5|a7oE@L63b#I)u{-L9OsuZYZl3o!u`gz?;E!JDDkgO)a=H0si`UPs=OrxZ z7ucc85yQnee^0l-j(S~=oNMOi9UmyM=(Rt{vHkt2XKQcl_G#PaC0RdMqs&&u%{(`8 z!HBUM{{o6`?Gkw{> z3uTwX+d3Z_Toe@M-Lw8=RPpBp$@N#S^>nXUks6ZbGF?aA<@r0^j#*0ei@Ij4V4AFY zLL{j0>Z*<=q3CN9RM%LDC@f+C8NoDL+(m@JtTuH9Lp!I7&yxF}R5v%X?`U>EmUsGW z-sv26hV9HLZ}!H#{F|b?Gq3wbZsK)yUFC(JS8m-i~mh{bV*TPF0kvc$)`fc<)-stgMd+(QvaAn9x z|0%)Kntq$e>^IBXYnnEtpiX|Sz1cGN)1SJ^>Lz@9n!fYLQZ@b=dqp$fHM`XuzPsT} z+;W@med70JuiZ^4IkhQMCHU;FnfK@Hcs}ifYqW0t_nXh}{@G}myW@V9XFvOeuoZ7+ zw%uf%XdAxACp|su$FjN%zN_{7exEK)Rr|JTU-iZJ_SX+Ty!m(E|A6=N%PzmY{j6Y3 z`{T10{=C0ZvfKV*Le`mC2Y)a8m%nJOdf2`TdAoN%JMFtW|HQ(SP(J>Cl@`w*o9^3I zyRVE1&$2pGcU*3JJ^$N6J(Y_;_OAJSbz|j^xH#qaXOH@EKbkc!L?M#t(#4Zai&!V? zWJGN^*|e~=yJcEOH{bk8OIcd{_v|cGRneXoHf>(Nc4ExT*?t-p>Z%(NhcK5!uf4lMRF5~BUcjBJ(X0DZr71^}NBJuTflk&Iq8-Mi9(!Fa-Hu{|Zv$n{rt~zVK-S4gM0~Q{ax*Jiu>chL>%V$4mPG9u9 z-~UIwxayT@Kj$AxKN)-ZZ<$NGM8T_PHJg0WpR>=|{8U19C1=je$V+oxrmhWKet7A{ z?fW}=CjYCj`nNT^?YF(>(Jt<(_G~X}J$9cHB)d)I zn5Ebrx6e-nzgPWt&`Jztt)JBxVzb_8p35Ym!W#BTS=V~@Uv2l~*EkU-_F>V&ga6mw zeym}!JLp^TUB30Voqv@);M#M3*Ks-iwYzScE>Y&5o4CWWboXnmmPOUendL63EN=ce z>)-Y{`6bU{?ss)>{dcE+>-<@}7v8%(=gG~xTl;7H`kb1#P~g$yixE>kPMf+XN3ckn zNxSB1t(tdSMfY9X3w05zEuWp4z3#eI=HI6>3O<=-sR~90hUS_I*#(Iu8O5oI3T3H9#hLke3TApndd8Yu zc6MB;c`5lxSzLw|hDM;KthA(=1(&{CW>Im8f|;cW7pzfhY-}>!;RK^*{nY5({KsZO z|K`On?4SO7gW&y>NgEGrJNk(4`gGU)_iJ4fHMTuku~m1zj{5Aw|9;GtoViV7QqeEf z36{?1KJ&C2i>x#_9T6yY#wf7h;Ri>tOCB`=tq-p(;x^whqsh?Qe_O&Ki5e!}R92fp ziDMQr-J6@HJKZ@TtZxy%;&@`sNe``h?sX=|)k6!I(;j$=-^sdU+^S)@^`_H-A3vUO zDYAIEMsmC~vD@gB(Q3w`-;!!EPoT9xN|9UP;EA??)+sGs84Ak;Yeg>y5GEi~ylWASh6kJ+6M1-Hyt zB6<8|;w~3qDYulifQ7PYE3Y<~K06_0#lYmyWLnRBjlt}YVM1@Q@2(5ext;P3NKNmH zIw*BrwTjjGwTRS;qr9#&8WVTuUOjtzyLq{N$n9SNe?Bcw-CenAm;Tr1wOgZW@5+_0 zUX}goua*?Jq7Mo1sim#im~S5X{o_W*{8c>P8LO`- zyI<9=S^2AsyU%FSQ8jzpYqhOzscvQO&N@#oz0K@fd*@a44bLqT>esB6x7*gv7VD~I zb-0wv&fcT1ZpqJu2X}6seByQA?(hB=&YkkyAouF*Ve{PEYwIlXCT84tyCGliqQa#` z`d6Q`T@RN0wIbil_S+=MSCS7LzstOQTqnP7alxtivqS%LbbQI&_WHk^X4d@;=5Mx5 zxaBkJsdQM=t|@`m?HwQXxSwS@T(9Gv!=(2{+)&C>wdYkuiqFHGV;4+J_$pUUAW$)|`D+jY^kv_~YefpM4fzy1DL6W}2T&@>IpdhBn`f zH?N-WZ@ARX*Kl?BQ*NzY!7T4qn_7CWSg`QOqx$S)x-SBxr|!|YQM|t6zCy!}i*tH; z9S&sJYddrQ@RK&r3!HI|Nw!y2zah_HyQ}8IoUd!9GO{^lh8(z)7$xo88n{I2@uAY> z(+;e6Qh!Qlt`nJkI5l5CDl=xsyqpGZ=hL?iv>ehBd(luW6aHANpkKJ?PSVDbC5;QO zZVqFU*m1mmWs%8(145?T6gF7AGz>ae@ZYLz#)BOsHTSZbs0vC#Q;`c@tr->HZD z+D$@Km~^IPB{#7CJ#zPkztmrocgrU3miQ)OXi-}o=-qtzg@&L{zngm}!yK`YwBwuC zulzKt@Ji;Yod>I~o`~I1zvcafZ;`sp{IaUK39Pb9ncOo=rtnST{1W`MLX6kSYxhST zi6?nGe4357i*GftXznv|+!B2!u}7U}g695-_E%1?Z+mMZ7G#|p6LOl}$DfmNkGt-* z*y=m-8vHX=l3FIe78Ue(t^43=>c8MdbsMug2y+rF%(#C7vMf%?Z&m(%~5Z(4I0-^wJM9aAG%++?J(P#=81=DgD<|(o;*os)o=DwKeg0t`*|&I zpR0K4l$_p=X1YXr~1zfyLl&gl8<+0 z|NbAf7tNN75q4p_P31U^Bd3MWahdasZD!%A$nPIEyURx_?mLd-=>>iTIolV~R zs=(^Zl*6lTZlC>Y@AtL!zMlKnU)#ORe%*v+T_ztq*o2$-PTlbMlFPi>J$l--f2H4B zg61u*J~;1<)#1v3UlFDiRZlC}e%QZOy`_KoQvH8+{|KYlkDJ`nJmfDZPJX#|cIn>g zrjAT&o0l6ZPceQ;`LFZ-^weong{RMdx20!xf?a%8L>IaM$>wRx{bhQp$~TcXoa#dCHAlQGxy1?n=K>l>t=hiJ8s+Sfc@_G zZhwo=Zkz7=T#tD{^gkbSx5_fPHxc$nb0%E;C_G)5yM#$~S()nIbF)2HFZx~}y5-W( z;u}rh!#Gc*izpwJiE27}D3NjU3=>8LyTlfE{TRPnJSDd3=O6#Q$jhb8t(W?#Qd-nked&U5|6 znw*n9nYS%uNngE1lk?on|4Ir|B&NKOjAK5v;<{*(81r%;iI$BnU1D(sOO|o*uZmnW zw{LZ@Y+LiTN~dpTuT0Lf``<6o()+-3Zi$+J|05rtkov?og?YkEeU4{@nY!Nn)HK>2 zIN#E#E3B>Oxx4V5BVO0Gn6*sd)oTr|$ePIzX65|HO%kNm}lI zGJ}Q6H+>F0HAP|W>6!9o!kL;&#g0YzoqD-JOMU6zhSQ!ejb6M8IbF;-=i9zh(Sc6S z)z}+0RZW|DM3=Fb!AS)>1;33Xf-^#PB8pr>DuB*ix8*#t90rsO1$$}r4}vo z_4B%JUDa{lp-#3$q!rp?9eR^ zT9TIP*R^8JT=hDq`EP2c{@9>f8u?*Icd?cF(X6nv6}-~7Kk^w&d33M)$$29v1LEt;y)~u`0a`Gv;7u{|Mv9FjhlCT+WtfO zLbLbPeHQ#zBC0RhpYvn==NbP+rp&ebafJP`{F?fXvUw)|{6(cQDk4{%cAxP4vg)4z zqiv^cgrCivqxa&a@!!kM?MI64FJN=4_||-MbKv=oO1CrB)2eOmJbw7+)b`ek*In-M z)PMKck$%Wl_}$#owo`sgN&OT%!As)9idJ`Bo2-YA9V-N!p4n$soRwW+u4Tji(30c4 zV?{X^zt6P#2k#8+u75LIx?I&(_hqK%`{J`m*4miMmC=37O(w{KO3l$P+{XwJXK^zLt8 z{p+24`>oZ%kIS!W*Y364Q(OK0aAEb2r7i9I@7Ml*C;ORyKU2$Y`R`xf**?@gBJjTB z&HvQ}32&j@Im79lB3ugfh87k^v0VDWnN_I@AU2nNxI(m{g0X^OESG*zetwC9p@q4n zf`LL1m%e9ST0TgT0hH^a5N%^=Y-H+cXlCT(XkudNX5wn;XyRn)Vs32c=4fPK>F8vq zfLDnySWPUvLuX=aYBAmM1fxd1>aEBQ)r+ymKiXaXe(&A9+MS!<8{3wDt6i4 z?|(S{bY+9t~ugKGMvfD%8=#2ISv4(CvQ<5}Uc$RW{HBDRbBS7op z!5j1InYJbS_ z*6{6=XMr;o_+C^q?LYWNRr1~TOm$QL1D>~PqD+z>2XC3W$;MpA;rf0fm6mlh=3cVG2OYyA17pu3bx_DQLNz1+iae|f8X;Z5Z~{F$pWt4$Uc$X!0vzu^t1&qby0 zyG`aFGQPzZb>pv0+=a4>Wf}Wg!nf=Q6P$YeLz~$31qL`e7I3 zE?g;Dc%wUX%MQ&omwH4u|Gzk^KFX!rH);9njKq6fXDt@+ZsEv&W9OG9yw?47*0I(b zPPaX~ox8g&{JJ;jU47zoadGV8qnU*pZa7wZM6WsdH%VM~U2TleNzHE;;x3A1dBqw^ z9}knOJMwhOjYkZ+UB&yBZ4qzJP~Nh^X{m^N#_Wt@)6hsm$L@r-Uac(_e%-~=SL;LW z9`(G%qN}vvMtAU*9g$@q|3<%gE6klKD1S6=&eEg4tCz04(fxT#VU&yiMse}XkGqRa zM5_yDZksK(G4##R&|A5;CM-+RzjLiyIy2*o_QJb<&T~I+e6lm(%(cq&XI6I@&aXJc zydvO+tI5>jhl=4Ej}9eo4A^y4MB~OINsY_(k61O%JrdP8`G{BJ$RpW3->38(&uOaI z!RKrfbX$P`lHi9Qe+<~y7EM$Aewp2A%+{>^?6)R@`*nhCPDAeoPP4;eH@F^e;H}yqTXw+j2J7xb{x_|) z8|3*8IM!RRv_IsKY2~zFJN}SmPK&1n>+**@UmohrY5rWmsCP(p2h-}{Ux&&c>F6Ie z-N73k{A;cMv98wwojbBMgM=*jpC^=c>f>Vo~-Y5nZp+<2$uyhc)v@(GZ(tpv;5)uyM2E<{gv(N zd!LxJ+st!WFmaNbmy~Aak|iLyM+bv|)Y6XQ}7ZdXbYIm3xX1;6SFj2Z- zursmfGmFcDi5<@}r2bu2FZ>d8Y0q`_7>@RbYIm;hmueIX509S3t(|Ba($sg9T;oqff+SCnL`5%Tz{p(+U+&`{;hwj|g6BlxKaPvRVv}u0+f$7lw z@DEb=4n$Y5H$~p8J$kE)`zn*R+|q~t>;L_ZIQVWA@18XgVQ2lpX+*!CFqxQ}bQ9tQOk9t&P= zEohyZESjul7G@Zflq~vq@!oHLP6Y8ZM}!@H;LaOn_{5US@Iqp8sf-_kv-Z63UZ)2{rmHuE5&UzdHqy<+p&5bM%((&|BNokzt3lCzZgF!>iV*z z-A@;!-;3uhl#k+{oyeWjT6lxa_6DDIg1XOvV^^w71g-C~?oQN~X=pCEF)?m~$l{Ri z`|Emq)fL^AELS|Xu(spkbIT6H^gsDMCi(|;cQ76gdj0kM@&4m8jMuq+QR4mh>saq! z>x3;g_Ol=B_{;u4to~*_%f^qw23&8B%ig`Q{{J0b6Smmggrg0j%^TjNW!1hBe|(&m z>-U>?(vQC0Uw-XA&(Rrusm#-OBg|&7v&Ay=_cSiNmLMpRz&peI!J!0;t#uELH!{cZ zRahq6Jn%SWgP0jpKbv&W>*|y-OHb>GR%V1(u{I8E24N4B2cKmWF<}TxB zwjQa1f&#^@`~IxGF(aROGb8glz6i4pM!VB&hHKJKDSRuk-n#G8&L8Gxe2+YjA7f-@ z(@)ge`tL`5@??oa?Y)Ky-xJmyzEB^&^6T^e;|c17-vMhIQ8k5=DqK_$+dEB`({&FDLz(Q`0n27C9yskf%@+IY7nf`NM>w|CI*d+teZ zgCf|p6I74bocMI5?%&KCDWXSeJbl`7T4pfa-N7;af!Upw#Vh}M&+j|DgD3ofR!qBu+_BXC%;gUa?|8jE z`2N`byUo8pFvuMgv1v{Jz&3Bmx99&g{ynzb({jB`e%T)5*+TR7`_{kJ|Mz2;%Z_PF z{fxHcJncE3F8uLoX9i#M>e;75?Xr@q&mC2o-W!16s;||kb9N}|JQ3a;@g&>PtjO|2y7Gtc`8~a^s?#UM@D&xu|ICx{fBXK=j~S`T z=8V(c7w!1?IBDYXBhzG_7|vC#XRq{0l5Lxj^(g<`{W<$9eLUZKzLj^WePXz~RAh;Y z_=FgiBEb``3gV4m#?85#t<%fvcq``JXSjJHzj4KrKWBf=?sl-7dFy|rbzQj5r}hIs zV$43ND=_Wkc%n3+-B`cj$wFRzo%^nS0Zg3sp?z0w{#Gd~ zmGQIKXYuQ@!Az^;^N!sLzR*5nLcI;UA#WvP(x;C?N2WX$?dUv~T_BrxK-OZi)#UlT zbMLiC%-Or8g#X=P<_eDf2ZlC{niX8gaW@c+*RFudhUVGMdk+krt}uccX(;CFO`{66mZHB&N%tw6N`t7CFdKxnK5n8 z%Y&akvOo4!xVz}u!E|2}*99VtK`dT^8YqlO&!6h<;1vqI$NFyi9sQm0Mf>ZY)Sdi0 z>9^{4Zo8AU?$9$d=>1wy4y+1cFh&A1M zuiK`&L1dbv__V`Z2E})xSx@cT&UWpPRRllV=e?jNV6$RPzIM-Hvlj=;E||V}%W}Tq zUfvC6w)%H_n+4v@_nqr*-!*xj?#KSU9ZQ`T)L*b>a!+LHJ6Kr2{9-P&QTW33o6nLj zJu+2kRn_7LeDcpPad~eP)3~~Tm*;oYFQ&b-7d)y?y8=Sx59MAMev>=kT)|S+vsc}K z)!*^_itjRa8msjWZrHcn`9d}GuNk(rXXL&c*Ds%6X#coQjG6OY`knJTz?@@$dwxrP zHzrL$r^kMRmA#?h@ja@gc3ah^JyDq4?89edc>;-XoBj7gh7MO`^Xu{0_;~ZjD?fjv zKlVtz70+TMc)~?NxX}j}qua5WBSmRKr-Rts$1~Cr&-+A_S(etli+{wCqFg=km|U$n zoA{a8iT8YLw#_s@JagvGm7k>prHt$M%$c}Q((SB4R$HKP&#X>Ma}ZmNE%?r?z}3b& zvjbNf+srClnYr;W4Jta5h;KQG=dX}?pwbYHp2v~SBMa?kHuTATS~ad>iO zz0}XC+#5?2dTU;CZ!9tBebSxuGC=C*!TrZCJv7<%;P=K7mELtfH%C~_a@$^~JWZ|s z(u;li$1iO(sru}n^s++g?~P>nQq82+I*%#;#O{56U;N@&_L?>Kdb)h<`qcW}iyw6Nzl)i{Znx~kucD=|d9$v+ zezmUr)m_yGzE$OtKMWS`mZ|Bx@YQPXZmvCN-c?<`^_6S)Yvq=ARW}%<5B|RYF73m$ z?Yl+yw7<<`&fmHF_Q7_}SpDSP_s*2>ZF*ZJfB!DG-Q^eW*yZ1q@Hd&?kG=nW%)gYW$gX+s+gK diff --git a/lib/colvars/Makefile.common b/lib/colvars/Makefile.common index e3fa4662e6..5958765077 100644 --- a/lib/colvars/Makefile.common +++ b/lib/colvars/Makefile.common @@ -34,6 +34,7 @@ COLVARS_SRCS = \ colvarcomp_coordnums.cpp \ colvarcomp.cpp \ colvarcomp_distances.cpp \ + colvarcomp_gpath.cpp \ colvarcomp_protein.cpp \ colvarcomp_rotations.cpp \ colvar.cpp \ diff --git a/lib/colvars/colvar.cpp b/lib/colvars/colvar.cpp index 723a54ad39..e3676084ac 100644 --- a/lib/colvars/colvar.cpp +++ b/lib/colvars/colvar.cpp @@ -791,6 +791,11 @@ int colvar::init_components(std::string const &conf) "inertia", "inertia"); error_code |= init_components_type(conf, "moment of inertia around an axis", "inertiaZ"); error_code |= init_components_type(conf, "eigenvector", "eigenvector"); + error_code |= init_components_type(conf, "geometrical path collective variables (s)", "gspath"); + error_code |= init_components_type(conf, "geometrical path collective variables (z)", "gzpath"); + error_code |= init_components_type(conf, "linear combination of other collective variables", "subColvar"); + error_code |= init_components_type(conf, "geometrical path collective variables (s) for other CVs", "gspathCV"); + error_code |= init_components_type(conf, "geometrical path collective variables (z) for other CVs", "gzpathCV"); if (!cvcs.size() || (error_code != COLVARS_OK)) { cvm::error("Error: no valid components were provided " @@ -1495,6 +1500,8 @@ int colvar::calc_colvar_properties() // calculate the velocity by finite differences if (cvm::step_relative() == 0) { x_old = x; + v_fdiff.reset(); // Do not pretend we know anything about the actual velocity + // eg. upon restarting. That would require saving v_fdiff or x_old to the state file } else { v_fdiff = fdiff_velocity(x_old, x); v_reported = v_fdiff; @@ -1516,8 +1523,9 @@ int colvar::calc_colvar_properties() x_ext = prev_x_ext; v_ext = prev_v_ext; } - // report the restraint center as "value" + // These position and velocities come from integration at the _previous timestep_ in update_forces_energy() + // But we report values at the beginning of the timestep (value at t=0 on the first timestep) x_reported = x_ext; v_reported = v_ext; // the "total force" with the extended Lagrangian is @@ -1651,8 +1659,6 @@ cvm::real colvar::update_forces_energy() // is equal to the actual coordinate x_ext = x; } - // Report extended value - x_reported = x_ext; } // Now adding the force on the actual colvar (for those biases that @@ -1975,9 +1981,8 @@ std::istream & colvar::read_restart(std::istream &is) } if (is_enabled(f_cv_extended_Lagrangian)) { - if ( !(get_keyval(conf, "extended_x", x_ext, - colvarvalue(x.type()), colvarparse::parse_silent)) && + colvarvalue(x.type()), colvarparse::parse_silent)) || !(get_keyval(conf, "extended_v", v_ext, colvarvalue(x.type()), colvarparse::parse_silent)) ) { cvm::log("Error: restart file does not contain " @@ -2079,11 +2084,11 @@ std::ostream & colvar::write_restart(std::ostream &os) { os << " extended_x " << std::setprecision(cvm::cv_prec) << std::setw(cvm::cv_width) - << x_ext << "\n" + << x_reported << "\n" << " extended_v " << std::setprecision(cvm::cv_prec) << std::setw(cvm::cv_width) - << v_ext << "\n"; + << v_reported << "\n"; } os << "}\n\n"; @@ -2150,7 +2155,6 @@ std::ostream & colvar::write_traj_label(std::ostream & os) std::ostream & colvar::write_traj(std::ostream &os) { os << " "; - if (is_enabled(f_cv_output_value)) { if (is_enabled(f_cv_extended_Lagrangian)) { diff --git a/lib/colvars/colvar.h b/lib/colvars/colvar.h index 74f7fdee51..e2ab0f3c1d 100644 --- a/lib/colvars/colvar.h +++ b/lib/colvars/colvar.h @@ -569,6 +569,14 @@ public: class alpha_dihedrals; class alpha_angles; class dihedPC; + class componentDisabled; + class CartesianBasedPath; + class gspath; + class gzpath; + class linearCombination; + class CVBasedPath; + class gspathCV; + class gzpathCV; // non-scalar components class distance_vec; diff --git a/lib/colvars/colvar_geometricpath.h b/lib/colvars/colvar_geometricpath.h new file mode 100644 index 0000000000..a7ef7f337c --- /dev/null +++ b/lib/colvars/colvar_geometricpath.h @@ -0,0 +1,270 @@ +#ifndef GEOMETRICPATHCV_H +#define GEOMETRICPATHCV_H +// This file is part of the Collective Variables module (Colvars). +// The original version of Colvars and its updates are located at: +// https://github.com/colvars/colvars +// Please update all Colvars source files before making any changes. +// If you wish to distribute your changes, please submit them to the +// Colvars repository at GitHub. + + +#include +#include +#include +#include +#include +#include + +namespace GeometricPathCV { + +enum path_sz {S, Z}; + +template +class GeometricPathBase { +private: + struct doCompareFrameDistance { + doCompareFrameDistance(const GeometricPathBase& obj): m_obj(obj) {} + const GeometricPathBase& m_obj; + bool operator()(const size_t& i1, const size_t& i2) { + return m_obj.frame_distances[i1] < m_obj.frame_distances[i2]; + } + }; +protected: + scalar_type v1v1; + scalar_type v2v2; + scalar_type v3v3; + scalar_type v4v4; + scalar_type v1v3; + scalar_type v1v4; + scalar_type f; + scalar_type dx; + scalar_type s; + scalar_type z; + scalar_type zz; + std::vector v1; + std::vector v2; + std::vector v3; + std::vector v4; + std::vector dfdv1; + std::vector dfdv2; + std::vector dzdv1; + std::vector dzdv2; + std::vector frame_distances; + std::vector frame_index; + bool use_second_closest_frame; + bool use_third_closest_frame; + bool use_z_square; + long min_frame_index_1; + long min_frame_index_2; + long min_frame_index_3; + long sign; + double M; + double m; +public: + GeometricPathBase(size_t vector_size, const element_type& element = element_type(), size_t total_frames = 1, bool p_use_second_closest_frame = true, bool p_use_third_closest_frame = false, bool p_use_z_square = false); + GeometricPathBase(size_t vector_size, const std::vector& elements, size_t total_frames = 1, bool p_use_second_closest_frame = true, bool p_use_third_closest_frame = false, bool p_use_z_square = false); + GeometricPathBase() {} + virtual ~GeometricPathBase() {} + virtual void initialize(size_t vector_size, const element_type& element = element_type(), size_t total_frames = 1, bool p_use_second_closest_frame = true, bool p_use_third_closest_frame = false, bool p_use_z_square = false); + virtual void initialize(size_t vector_size, const std::vector& elements, size_t total_frames = 1, bool p_use_second_closest_frame = true, bool p_use_third_closest_frame = false, bool p_use_z_square = false); + virtual void prepareVectors(); + virtual void updateReferenceDistances(); + virtual void compute(); + virtual void determineClosestFrames(); + virtual void computeValue(); + virtual void computeDerivatives(); +}; + +template +GeometricPathBase::GeometricPathBase(size_t vector_size, const element_type& element, size_t total_frames, bool p_use_second_closest_frame, bool p_use_third_closest_frame, bool p_use_z_square) { + initialize(vector_size, element, total_frames, p_use_second_closest_frame, p_use_third_closest_frame, p_use_z_square); +} + +template +GeometricPathBase::GeometricPathBase(size_t vector_size, const std::vector& elements, size_t total_frames, bool p_use_second_closest_frame, bool p_use_third_closest_frame, bool p_use_z_square) { + initialize(vector_size, elements, total_frames, p_use_second_closest_frame, p_use_third_closest_frame, p_use_z_square); +} + +template +void GeometricPathBase::initialize(size_t vector_size, const element_type& element, size_t total_frames, bool p_use_second_closest_frame, bool p_use_third_closest_frame, bool p_use_z_square) { + v1v1 = scalar_type(); + v2v2 = scalar_type(); + v3v3 = scalar_type(); + v4v4 = scalar_type(); + v1v3 = scalar_type(); + v1v4 = scalar_type(); + f = scalar_type(); + dx = scalar_type(); + z = scalar_type(); + zz = scalar_type(); + sign = 0; + v1.resize(vector_size, element); + v2.resize(vector_size, element); + v3.resize(vector_size, element); + v4.resize(vector_size, element); + dfdv1.resize(vector_size, element); + dfdv2.resize(vector_size, element); + dzdv1.resize(vector_size, element); + dzdv2.resize(vector_size, element); + frame_distances.resize(total_frames); + frame_index.resize(total_frames); + for (size_t i_frame = 0; i_frame < frame_index.size(); ++i_frame) { + frame_index[i_frame] = i_frame; + } + use_second_closest_frame = p_use_second_closest_frame; + use_third_closest_frame = p_use_third_closest_frame; + use_z_square = p_use_z_square; + M = static_cast(total_frames - 1); + m = static_cast(1.0); +} + +template +void GeometricPathBase::initialize(size_t vector_size, const std::vector& elements, size_t total_frames, bool p_use_second_closest_frame, bool p_use_third_closest_frame, bool p_use_z_square) { + v1v1 = scalar_type(); + v2v2 = scalar_type(); + v3v3 = scalar_type(); + v4v4 = scalar_type(); + v1v3 = scalar_type(); + v1v4 = scalar_type(); + f = scalar_type(); + dx = scalar_type(); + z = scalar_type(); + zz = scalar_type(); + sign = 0; + v1 = elements; + v2 = elements; + v3 = elements; + v4 = elements; + dfdv1 = elements; + dfdv2 = elements; + dzdv1 = elements; + dzdv2 = elements; + frame_distances.resize(total_frames); + frame_index.resize(total_frames); + for (size_t i_frame = 0; i_frame < frame_index.size(); ++i_frame) { + frame_index[i_frame] = i_frame; + } + use_second_closest_frame = p_use_second_closest_frame; + use_third_closest_frame = p_use_third_closest_frame; + use_z_square = p_use_z_square; + M = static_cast(total_frames - 1); + m = static_cast(1.0); +} + +template +void GeometricPathBase::prepareVectors() { + std::cout << "Warning: you should not call the prepareVectors() in base class!\n"; + std::cout << std::flush; +} + +template +void GeometricPathBase::updateReferenceDistances() { + std::cout << "Warning: you should not call the updateReferenceDistances() in base class!\n"; + std::cout << std::flush; +} + +template +void GeometricPathBase::compute() { + computeValue(); + computeDerivatives(); +} + +template +void GeometricPathBase::determineClosestFrames() { + // Find the closest and the second closest frames + std::sort(frame_index.begin(), frame_index.end(), doCompareFrameDistance(*this)); + // Determine the sign + sign = static_cast(frame_index[0]) - static_cast(frame_index[1]); + if (sign > 1) { + // sigma(z) is on the left side of the closest frame + sign = 1; + } else if (sign < -1) { + // sigma(z) is on the right side of the closest frame + sign = -1; + } + if (std::abs(static_cast(frame_index[0]) - static_cast(frame_index[1])) > 1) { + std::cout << "Warning: Geometrical pathCV relies on the assumption that the second closest frame is the neighbouring frame\n"; + std::cout << " Please check your configuration or increase restraint on z(σ)\n"; + for (size_t i_frame = 0; i_frame < frame_index.size(); ++i_frame) { + std::cout << "Frame index: " << frame_index[i_frame] << " ; optimal RMSD = " << frame_distances[frame_index[i_frame]] << "\n"; + } + } + min_frame_index_1 = frame_index[0]; // s_m + min_frame_index_2 = use_second_closest_frame ? frame_index[1] : min_frame_index_1 - sign; // s_(m-1) + min_frame_index_3 = use_third_closest_frame ? frame_index[2] : min_frame_index_1 + sign; // s_(m+1) + m = static_cast(frame_index[0]); +} + +template +void GeometricPathBase::computeValue() { + updateReferenceDistances(); + determineClosestFrames(); + prepareVectors(); + v1v1 = scalar_type(); + v2v2 = scalar_type(); + v3v3 = scalar_type(); + v1v3 = scalar_type(); + if (path_type == Z) { + v1v4 = scalar_type(); + v4v4 = scalar_type(); + } + for (size_t i_elem = 0; i_elem < v1.size(); ++i_elem) { + v1v1 += v1[i_elem] * v1[i_elem]; + v2v2 += v2[i_elem] * v2[i_elem]; + v3v3 += v3[i_elem] * v3[i_elem]; + v1v3 += v1[i_elem] * v3[i_elem]; + if (path_type == Z) { + v1v4 += v1[i_elem] * v4[i_elem]; + v4v4 += v4[i_elem] * v4[i_elem]; + } + } + f = (std::sqrt(v1v3 * v1v3 - v3v3 * (v1v1 - v2v2)) - v1v3) / v3v3; + if (path_type == Z) { + dx = 0.5 * (f - 1); + zz = v1v1 + 2 * dx * v1v4 + dx * dx * v4v4; + if (use_z_square) { + z = zz; + } else { + z = std::sqrt(std::fabs(zz)); + } + } + if (path_type == S) { + s = m/M + static_cast(sign) * ((f - 1) / (2 * M)); + } +} + +template +void GeometricPathBase::computeDerivatives() { + const scalar_type factor1 = 1.0 / (2.0 * v3v3 * std::sqrt(v1v3 * v1v3 - v3v3 * (v1v1 - v2v2))); + const scalar_type factor2 = 1.0 / v3v3; + for (size_t i_elem = 0; i_elem < v1.size(); ++i_elem) { + // Compute the derivative of f with vector v1 + dfdv1[i_elem] = factor1 * (2.0 * v1v3 * v3[i_elem] - 2.0 * v3v3 * v1[i_elem]) - factor2 * v3[i_elem]; + // Compute the derivative of f with respect to vector v2 + dfdv2[i_elem] = factor1 * (2.0 * v3v3 * v2[i_elem]); + // dZ(v1(r), v2(r), v3) / dr = ∂Z/∂v1 * dv1/dr + ∂Z/∂v2 * dv2/dr + // dv1/dr = [fitting matrix 1][-1, ..., -1] + // dv2/dr = [fitting matrix 2][1, ..., 1] + // ∂Z/∂v1 = 1/(2*z) * (2v1 + (f-1)v4 + (v1⋅v4)∂f/∂v1 + v4^2 * 1/4 * 2(f-1) * ∂f/∂v1) + // ∂Z/∂v2 = 1/(2*z) * ((v1⋅v4)∂f/∂v2 + v4^2 * 1/4 * 2(f-1) * ∂f/∂v2) + if (path_type == Z) { + if (use_z_square) { + dzdv1[i_elem] = 2.0 * v1[i_elem] + (f-1) * v4[i_elem] + v1v4 * dfdv1[i_elem] + v4v4 * 0.25 * 2.0 * (f-1) * dfdv1[i_elem]; + dzdv2[i_elem] = v1v4 * dfdv2[i_elem] + v4v4 * 0.25 * 2.0 * (f-1) * dfdv2[i_elem]; + } else { + if (z > static_cast(0)) { + dzdv1[i_elem] = (1.0 / (2.0 * z)) * (2.0 * v1[i_elem] + (f-1) * v4[i_elem] + v1v4 * dfdv1[i_elem] + v4v4 * 0.25 * 2.0 * (f-1) * dfdv1[i_elem]); + dzdv2[i_elem] = (1.0 / (2.0 * z)) * (v1v4 * dfdv2[i_elem] + v4v4 * 0.25 * 2.0 * (f-1) * dfdv2[i_elem]); + } else { + // workaround at z = 0 + dzdv1[i_elem] = 0; + dzdv2[i_elem] = 0; + } + } + } + } +} + +} + +#endif // GEOMETRICPATHCV_H diff --git a/lib/colvars/colvarbias_meta.cpp b/lib/colvars/colvarbias_meta.cpp index 27781ec733..8540e4a945 100644 --- a/lib/colvars/colvarbias_meta.cpp +++ b/lib/colvars/colvarbias_meta.cpp @@ -37,7 +37,6 @@ colvarbias_meta::colvarbias_meta(char const *key) { new_hills_begin = hills.end(); hills_traj_os = NULL; - replica_hills_os = NULL; ebmeta_equil_steps = 0L; } @@ -203,23 +202,37 @@ int colvarbias_meta::init_ebmeta_params(std::string const &conf) target_dist = new colvar_grid_scalar(); target_dist->init_from_colvars(colvars); std::string target_dist_file; - get_keyval(conf, "targetdistfile", target_dist_file); + get_keyval(conf, "targetDistFile", target_dist_file); std::ifstream targetdiststream(target_dist_file.c_str()); target_dist->read_multicol(targetdiststream); cvm::real min_val = target_dist->minimum_value(); + cvm::real max_val = target_dist->maximum_value(); if(min_val<0){ - cvm::error("Error: Target distribution of ebMeta " + cvm::error("Error: Target distribution of EBMetaD " "has negative values!.\n", INPUT_ERROR); } - cvm::real min_pos_val = target_dist->minimum_pos_value(); - if(min_pos_val<=0){ - cvm::error("Error: Target distribution of ebMeta has negative " - "or zero minimum positive value!.\n", INPUT_ERROR); - } - if(min_val==0){ - cvm::log("WARNING: Target distribution has zero values.\n"); - cvm::log("Zeros will be converted to the minimum positive value.\n"); - target_dist->remove_zeros(min_pos_val); + cvm::real target_dist_min_val; + get_keyval(conf, "targetDistMinVal", target_dist_min_val, 1/1000000.0); + if(target_dist_min_val>0 && target_dist_min_val<1){ + target_dist_min_val=max_val*target_dist_min_val; + target_dist->remove_small_values(target_dist_min_val); + } else { + if (target_dist_min_val==0) { + cvm::log("NOTE: targetDistMinVal is set to zero, the minimum value of the target \n"); + cvm::log(" distribution will be set as the minimum positive value.\n"); + cvm::real min_pos_val = target_dist->minimum_pos_value(); + if(min_pos_val<=0){ + cvm::error("Error: Target distribution of EBMetaD has negative " + "or zero minimum positive value!.\n", INPUT_ERROR); + } + if(min_val==0){ + cvm::log("WARNING: Target distribution has zero values.\n"); + cvm::log("Zeros will be converted to the minimum positive value.\n"); + target_dist->remove_small_values(min_pos_val); + } + } else { + cvm::error("Error: targetDistMinVal must be a value between 0 and 1!.\n", INPUT_ERROR); + } } // normalize target distribution and multiply by effective volume = exp(differential entropy) target_dist->multiply_constant(1.0/target_dist->integral()); @@ -235,14 +248,14 @@ int colvarbias_meta::init_ebmeta_params(std::string const &conf) colvarbias_meta::~colvarbias_meta() { colvarbias_meta::clear_state_data(); + colvarproxy *proxy = cvm::proxy; - if (replica_hills_os) { - cvm::proxy->close_output_stream(replica_hills_file); - replica_hills_os = NULL; + if (proxy->get_output_stream(replica_hills_file)) { + proxy->close_output_stream(replica_hills_file); } if (hills_traj_os) { - cvm::proxy->close_output_stream(hills_traj_file_name()); + proxy->close_output_stream(hills_traj_file_name()); hills_traj_os = NULL; } @@ -523,6 +536,8 @@ int colvarbias_meta::update_bias() case multiple_replicas: create_hill(hill(hill_weight*hills_scale, colvars, hill_width, replica_id)); + std::ostream *replica_hills_os = + cvm::proxy->get_output_stream(replica_hills_file); if (replica_hills_os) { *replica_hills_os << hills.back(); } else { @@ -921,13 +936,16 @@ void colvarbias_meta::recount_hills_off_grid(colvarbias_meta::hill_iter h_first int colvarbias_meta::replica_share() { + colvarproxy *proxy = cvm::proxy; // sync with the other replicas (if needed) if (comm == multiple_replicas) { // reread the replicas registry update_replicas_registry(); // empty the output buffer + std::ostream *replica_hills_os = + proxy->get_output_stream(replica_hills_file); if (replica_hills_os) { - cvm::proxy->flush_output_stream(replica_hills_os); + proxy->flush_output_stream(replica_hills_os); } read_replica_files(); } @@ -1089,11 +1107,7 @@ void colvarbias_meta::read_replica_files() (replicas[ir])->replica_state_file+"\".\n"); std::ifstream is((replicas[ir])->replica_state_file.c_str()); - if (! (replicas[ir])->read_state(is)) { - cvm::log("Reading from file \""+(replicas[ir])->replica_state_file+ - "\" failed or incomplete: will try again in "+ - cvm::to_str(replica_update_freq)+" steps.\n"); - } else { + if ((replicas[ir])->read_state(is)) { // state file has been read successfully (replicas[ir])->replica_state_file_in_sync = true; (replicas[ir])->update_status = 0; @@ -1550,15 +1564,11 @@ int colvarbias_meta::setup_output() // for the others to read // open the "hills" buffer file - if (!replica_hills_os) { - cvm::proxy->backup_file(replica_hills_file); - replica_hills_os = cvm::proxy->output_stream(replica_hills_file); - if (!replica_hills_os) return cvm::get_error(); - replica_hills_os->setf(std::ios::scientific, std::ios::floatfield); - } + reopen_replica_buffer_file(); // write the state file (so that there is always one available) write_replica_state_file(); + // schedule to read the state files of the other replicas for (size_t ir = 0; ir < replicas.size(); ir++) { (replicas[ir])->replica_state_file_in_sync = false; @@ -1661,15 +1671,16 @@ std::ostream & colvarbias_meta::write_state_data(std::ostream& os) int colvarbias_meta::write_state_to_replicas() { + int error_code = COLVARS_OK; if (comm != single_replica) { - write_replica_state_file(); - // schedule to reread the state files of the other replicas (they - // have also rewritten them) + error_code |= write_replica_state_file(); + error_code |= reopen_replica_buffer_file(); + // schedule to reread the state files of the other replicas for (size_t ir = 0; ir < replicas.size(); ir++) { (replicas[ir])->replica_state_file_in_sync = false; } } - return COLVARS_OK; + return error_code; } @@ -1693,6 +1704,20 @@ void colvarbias_meta::write_pmf() // output the PMF from this instance or replica pmf->reset(); pmf->add_grid(*hills_energy); + + if (ebmeta) { + int nt_points=pmf->number_of_points(); + for (int i = 0; i < nt_points; i++) { + cvm:: real pmf_val=0.0; + cvm:: real target_val=target_dist->value(i); + if (target_val>0) { + pmf_val=pmf->value(i); + pmf_val=pmf_val+cvm::temperature() * cvm::boltzmann() * std::log(target_val); + } + pmf->set_value(i,pmf_val); + } + } + cvm::real const max = pmf->maximum_value(); pmf->add_constant(-1.0 * max); pmf->multiply_constant(-1.0); @@ -1716,10 +1741,24 @@ void colvarbias_meta::write_pmf() if (comm != single_replica) { // output the combined PMF from all replicas pmf->reset(); - pmf->add_grid(*hills_energy); + // current replica already included in the pools of replicas for (size_t ir = 0; ir < replicas.size(); ir++) { pmf->add_grid(*(replicas[ir]->hills_energy)); } + + if (ebmeta) { + int nt_points=pmf->number_of_points(); + for (int i = 0; i < nt_points; i++) { + cvm:: real pmf_val=0.0; + cvm:: real target_val=target_dist->value(i); + if (target_val>0) { + pmf_val=pmf->value(i); + pmf_val=pmf_val+cvm::temperature() * cvm::boltzmann() * std::log(target_val); + } + pmf->set_value(i,pmf_val); + } + } + cvm::real const max = pmf->maximum_value(); pmf->add_constant(-1.0 * max); pmf->multiply_constant(-1.0); @@ -1744,74 +1783,47 @@ void colvarbias_meta::write_pmf() int colvarbias_meta::write_replica_state_file() { + colvarproxy *proxy = cvm::proxy; + if (cvm::debug()) { cvm::log("Writing replica state file for bias \""+name+"\"\n"); } - // write down also the restart for the other replicas - cvm::backup_file(replica_state_file.c_str()); - std::ostream *rep_state_os = cvm::proxy->output_stream(replica_state_file); - if (rep_state_os == NULL) { - cvm::error("Error: in opening file \""+ - replica_state_file+"\" for writing.\n", FILE_ERROR); - return FILE_ERROR; - } - - rep_state_os->setf(std::ios::scientific, std::ios::floatfield); - - if (!write_state(*rep_state_os)) { - cvm::error("Error: in writing to file \""+ - replica_state_file+"\".\n", FILE_ERROR); - cvm::proxy->close_output_stream(replica_state_file); - return FILE_ERROR; - } - - cvm::proxy->close_output_stream(replica_state_file); - - // rep_state_os.setf(std::ios::scientific, std::ios::floatfield); - // rep_state_os << "\n" - // << "metadynamics {\n" - // << " configuration {\n" - // << " name " << this->name << "\n" - // << " step " << cvm::step_absolute() << "\n"; - // if (this->comm != single_replica) { - // rep_state_os << " replicaID " << this->replica_id << "\n"; - // } - // rep_state_os << " }\n\n"; - // rep_state_os << " hills_energy\n"; - // rep_state_os << std::setprecision(cvm::cv_prec) - // << std::setw(cvm::cv_width); - // hills_energy->write_restart(rep_state_os); - // rep_state_os << " hills_energy_gradients\n"; - // rep_state_os << std::setprecision(cvm::cv_prec) - // << std::setw(cvm::cv_width); - // hills_energy_gradients->write_restart(rep_state_os); - - // if ( (!use_grids) || keep_hills ) { - // // write all hills currently in memory - // for (std::list::const_iterator h = this->hills.begin(); - // h != this->hills.end(); - // h++) { - // rep_state_os << *h; - // } - // } else { - // // write just those that are near the grid boundaries - // for (std::list::const_iterator h = this->hills_off_grid.begin(); - // h != this->hills_off_grid.end(); - // h++) { - // rep_state_os << *h; - // } - // } - // rep_state_os << "}\n\n"; - // rep_state_os.close(); - - // reopen the hills file - cvm::proxy->close_output_stream(replica_hills_file); - cvm::proxy->backup_file(replica_hills_file); - replica_hills_os = cvm::proxy->output_stream(replica_hills_file); - if (!replica_hills_os) return cvm::get_error(); - replica_hills_os->setf(std::ios::scientific, std::ios::floatfield); - return COLVARS_OK; + int error_code = COLVARS_OK; + + // Write to temporary state file + std::string const tmp_state_file(replica_state_file+".tmp"); + error_code |= proxy->remove_file(tmp_state_file); + std::ostream *rep_state_os = cvm::proxy->output_stream(tmp_state_file); + if (rep_state_os) { + if (!write_state(*rep_state_os)) { + error_code |= cvm::error("Error: in writing to temporary file \""+ + tmp_state_file+"\".\n", FILE_ERROR); + } + } + error_code |= proxy->close_output_stream(tmp_state_file); + + error_code |= proxy->rename_file(tmp_state_file, replica_state_file); + + return error_code; +} + + +int colvarbias_meta::reopen_replica_buffer_file() +{ + int error_code = COLVARS_OK; + colvarproxy *proxy = cvm::proxy; + if (proxy->get_output_stream(replica_hills_file) != NULL) { + error_code |= proxy->close_output_stream(replica_hills_file); + } + error_code |= proxy->remove_file(replica_hills_file); + std::ostream *replica_hills_os = proxy->output_stream(replica_hills_file); + if (replica_hills_os) { + replica_hills_os->setf(std::ios::scientific, std::ios::floatfield); + } else { + error_code |= FILE_ERROR; + } + return error_code; } @@ -1883,5 +1895,3 @@ std::ostream & operator << (std::ostream &os, colvarbias_meta::hill const &h) return os; } - - diff --git a/lib/colvars/colvarbias_meta.h b/lib/colvars/colvarbias_meta.h index 0ba2bef1c3..8e98274b2d 100644 --- a/lib/colvars/colvarbias_meta.h +++ b/lib/colvars/colvarbias_meta.h @@ -215,9 +215,12 @@ protected: /// \brief Read new data from replicas' files virtual void read_replica_files(); - /// \brief Write data to other replicas + /// Write full state information to be read by other replicas virtual int write_replica_state_file(); + /// Call this after write_replica_state_file() + virtual int reopen_replica_buffer_file(); + /// \brief Additional, "mirror" metadynamics biases, to collect info /// from the other replicas /// @@ -251,9 +254,6 @@ protected: /// This file becomes empty after replica_state_file is rewritten std::string replica_hills_file; - /// \brief Output stream corresponding to replica_hills_file - std::ostream *replica_hills_os; - /// Position within replica_hills_file (when reading it) int replica_hills_file_pos; diff --git a/lib/colvars/colvarbias_restraint.cpp b/lib/colvars/colvarbias_restraint.cpp index 90588f5a1f..ab02820cf0 100644 --- a/lib/colvars/colvarbias_restraint.cpp +++ b/lib/colvars/colvarbias_restraint.cpp @@ -1295,7 +1295,8 @@ colvarvalue const colvarbias_restraint_linear::restraint_force(size_t i) const cvm::real colvarbias_restraint_linear::d_restraint_potential_dk(size_t i) const { - return 1.0 / variables(i)->width * (variables(i)->value() - colvar_centers[i]); + return 1.0 / variables(i)->width * (variables(i)->value() - + colvar_centers[i]).sum(); } diff --git a/lib/colvars/colvarcomp.cpp b/lib/colvars/colvarcomp.cpp index 3075ed82ca..431884a877 100644 --- a/lib/colvars/colvarcomp.cpp +++ b/lib/colvars/colvarcomp.cpp @@ -7,6 +7,8 @@ // If you wish to distribute your changes, please submit them to the // Colvars repository at GitHub. +#include + #include "colvarmodule.h" #include "colvarvalue.h" #include "colvar.h" diff --git a/lib/colvars/colvarcomp.h b/lib/colvars/colvarcomp.h index f615680ba6..5e7a91e872 100644 --- a/lib/colvars/colvarcomp.h +++ b/lib/colvars/colvarcomp.h @@ -24,6 +24,13 @@ #include "colvar.h" #include "colvaratoms.h" +#if (__cplusplus >= 201103L) +#include "colvar_geometricpath.h" +#include +#endif // C++11 checking + +#include + /// \brief Colvar component (base class for collective variables) /// @@ -688,9 +695,6 @@ protected: /// Reference coordinates std::vector ref_pos; - /// Geometric center of the reference coordinates - cvm::atom_pos ref_pos_center; - /// Eigenvector (of a normal or essential mode): will always have zero center std::vector eigenvec; @@ -1383,6 +1387,222 @@ public: }; + +class colvar::componentDisabled + : public colvar::cvc +{ +public: + componentDisabled(std::string const &conf) { + cvm::error("Error: this component is not enabled in the current build; please see https://colvars.github.io/README-c++11.html"); + } + virtual ~componentDisabled() {} + virtual void calc_value() {} + virtual void calc_gradients() {} + virtual void apply_force(colvarvalue const &force) {} +}; + + + +#if (__cplusplus >= 201103L) +class colvar::CartesianBasedPath + : public colvar::cvc +{ +protected: + virtual void computeReferenceDistance(std::vector& result); + /// Selected atoms + cvm::atom_group *atoms; + /// Fitting options + bool has_user_defined_fitting; + /// Reference frames + std::vector> reference_frames; + std::vector> reference_fitting_frames; + /// Atom groups for RMSD calculation together with reference frames + std::vector comp_atoms; + /// Total number of reference frames + size_t total_reference_frames; +public: + CartesianBasedPath(std::string const &conf); + virtual ~CartesianBasedPath(); + virtual void calc_value() = 0; + virtual void apply_force(colvarvalue const &force) = 0; +}; + +/// \brief Colvar component: alternative path collective variable using geometry, variable s +/// For more information see https://plumed.github.io/doc-v2.5/user-doc/html/_p_a_t_h.html +/// Díaz Leines, G.; Ensing, B. Path Finding on High-Dimensional Free Energy Landscapes. Phys. Rev. Lett. 2012, 109 (2), 020601. https://doi.org/10.1103/PhysRevLett.109.020601. +class colvar::gspath + : public colvar::CartesianBasedPath, public GeometricPathCV::GeometricPathBase +{ +private: + // Optimal rotation for compute v3 + cvm::rotation rot_v3; +protected: + virtual void prepareVectors(); + virtual void updateReferenceDistances(); +public: + gspath(std::string const &conf); + virtual ~gspath() {} + virtual void calc_value(); + virtual void calc_gradients(); + virtual void apply_force(colvarvalue const &force); +}; + + + +/// \brief Colvar component: alternative path collective variable using geometry, variable z +/// This should be merged with gspath in the same class by class inheritance or something else +class colvar::gzpath + : public colvar::CartesianBasedPath, public GeometricPathCV::GeometricPathBase +{ +private: + // Optimal rotation for compute v3, v4 + cvm::rotation rot_v3; + cvm::rotation rot_v4; +protected: + virtual void prepareVectors(); + virtual void updateReferenceDistances(); +public: + gzpath(std::string const &conf); + virtual ~gzpath() {} + virtual void calc_value(); + virtual void calc_gradients(); + virtual void apply_force(colvarvalue const &force); +}; + +/// Current only linear combination of sub-CVCs is available +class colvar::linearCombination + : public colvar::cvc +{ +protected: + /// Map from string to the types of colvar components + std::map> string_cv_map; + /// Sub-colvar components + std::vector cv; + /// If all sub-cvs use explicit gradients then we also use it + bool use_explicit_gradients; +protected: + cvm::real getPolynomialFactorOfCVGradient(size_t i_cv) const; +public: + linearCombination(std::string const &conf); + virtual ~linearCombination(); + virtual void calc_value(); + virtual void calc_gradients(); + virtual void apply_force(colvarvalue const &force); +}; + + +class colvar::CVBasedPath + : public colvar::cvc +{ +protected: + /// Map from string to the types of colvar components + std::map> string_cv_map; + /// Sub-colvar components + std::vector cv; + /// Refernce colvar values from path + std::vector> ref_cv; + /// If all sub-cvs use explicit gradients then we also use it + bool use_explicit_gradients; + /// Total number of reference frames + size_t total_reference_frames; +protected: + virtual void computeReferenceDistance(std::vector& result); + cvm::real getPolynomialFactorOfCVGradient(size_t i_cv) const; +public: + CVBasedPath(std::string const &conf); + virtual ~CVBasedPath(); + virtual void calc_value() = 0; + virtual void apply_force(colvarvalue const &force) = 0; +}; + + +/// \brief Colvar component: alternative path collective variable using geometry, variable s +/// Allow any combination of existing (scalar) CVs +/// For more information see https://plumed.github.io/doc-v2.5/user-doc/html/_p_a_t_h.html +/// Díaz Leines, G.; Ensing, B. Path Finding on High-Dimensional Free Energy Landscapes. Phys. Rev. Lett. 2012, 109 (2), 020601. https://doi.org/10.1103/PhysRevLett.109.020601. +class colvar::gspathCV + : public colvar::CVBasedPath, public GeometricPathCV::GeometricPathBase +{ +protected: + virtual void updateReferenceDistances(); + virtual void prepareVectors(); +public: + gspathCV(std::string const &conf); + virtual ~gspathCV(); + virtual void calc_value(); + virtual void calc_gradients(); + virtual void apply_force(colvarvalue const &force); +}; + + + +class colvar::gzpathCV + : public colvar::CVBasedPath, public GeometricPathCV::GeometricPathBase +{ +protected: + virtual void updateReferenceDistances(); + virtual void prepareVectors(); +public: + gzpathCV(std::string const &conf); + virtual ~gzpathCV(); + virtual void calc_value(); + virtual void calc_gradients(); + virtual void apply_force(colvarvalue const &force); +}; + +#else // if the compiler doesn't support C++11 + +class colvar::linearCombination + : public colvar::componentDisabled +{ +public: + linearCombination(std::string const &conf) : componentDisabled(conf) {} +}; + +class colvar::CartesianBasedPath + : public colvar::componentDisabled +{ +public: + CartesianBasedPath(std::string const &conf) : componentDisabled(conf) {} +}; + +class colvar::CVBasedPath + : public colvar::componentDisabled +{ +public: + CVBasedPath(std::string const &conf) : componentDisabled(conf) {} +}; + +class colvar::gspath + : public colvar::componentDisabled +{ +public: + gspath(std::string const &conf) : componentDisabled(conf) {} +}; + +class colvar::gzpath + : public colvar::componentDisabled +{ +public: + gzpath(std::string const &conf) : componentDisabled(conf) {} +}; + +class colvar::gspathCV + : public colvar::componentDisabled +{ +public: + gspathCV(std::string const &conf) : componentDisabled(conf) {} +}; + +class colvar::gzpathCV + : public colvar::componentDisabled +{ +public: + gzpathCV(std::string const &conf) : componentDisabled(conf) {} +}; + +#endif // C++11 checking + // metrics functions for cvc implementations // simple definitions of the distance functions; these are useful only diff --git a/lib/colvars/colvarcomp_distances.cpp b/lib/colvars/colvarcomp_distances.cpp index d9cd9d55e4..7cb4c30c31 100644 --- a/lib/colvars/colvarcomp_distances.cpp +++ b/lib/colvars/colvarcomp_distances.cpp @@ -1013,8 +1013,7 @@ colvar::rmsd::rmsd(std::string const &conf) cvm::to_str(atoms->size())+").\n"); return; } - } - { + } else { // Only look for ref pos file if ref positions not already provided std::string ref_pos_file; if (get_keyval(conf, "refPositionsFile", ref_pos_file, std::string(""))) { @@ -1041,12 +1040,15 @@ colvar::rmsd::rmsd(std::string const &conf) cvm::load_coords(ref_pos_file.c_str(), &ref_pos, atoms, ref_pos_col, ref_pos_col_value); + } else { + cvm::error("Error: no reference positions for RMSD; use either refPositions of refPositionsFile."); + return; } } if (ref_pos.size() != atoms->size()) { cvm::error("Error: found " + cvm::to_str(ref_pos.size()) + - " reference positions; expected " + cvm::to_str(atoms->size())); + " reference positions for RMSD; expected " + cvm::to_str(atoms->size())); return; } diff --git a/lib/colvars/colvarcomp_gpath.cpp b/lib/colvars/colvarcomp_gpath.cpp new file mode 100644 index 0000000000..530aaf3284 --- /dev/null +++ b/lib/colvars/colvarcomp_gpath.cpp @@ -0,0 +1,910 @@ +#if (__cplusplus >= 201103L) + +// This file is part of the Collective Variables module (Colvars). +// The original version of Colvars and its updates are located at: +// https://github.com/colvars/colvars +// Please update all Colvars source files before making any changes. +// If you wish to distribute your changes, please submit them to the +// Colvars repository at GitHub. + +#include +#include +#include +#include +#include + +#include "colvarmodule.h" +#include "colvarvalue.h" +#include "colvarparse.h" +#include "colvar.h" +#include "colvarcomp.h" + +namespace GeometricPathCV { +void init_string_cv_map(std::map>& string_cv_map); +} + +bool compareColvarComponent(colvar::cvc *i, colvar::cvc *j) +{ + return i->name < j->name; +} + +colvar::CartesianBasedPath::CartesianBasedPath(std::string const &conf): cvc(conf), atoms(nullptr), reference_frames(0) { + // Parse selected atoms + atoms = parse_group(conf, "atoms"); + has_user_defined_fitting = false; + std::string fitting_conf; + if (key_lookup(conf, "fittingAtoms", &fitting_conf)) { + has_user_defined_fitting = true; + } + // Lookup reference column of PDB + // Copied from the RMSD class + std::string reference_column; + double reference_column_value; + if (get_keyval(conf, "refPositionsCol", reference_column, std::string(""))) { + bool found = get_keyval(conf, "refPositionsColValue", reference_column_value, 0.0); + if (found && reference_column_value == 0.0) { + cvm::error("Error: refPositionsColValue, " + "if provided, must be non-zero.\n"); + return; + } + } + // Lookup all reference frames + bool has_frames = true; + total_reference_frames = 0; + while (has_frames) { + std::string reference_position_file_lookup = "refPositionsFile" + cvm::to_str(total_reference_frames + 1); + if (key_lookup(conf, reference_position_file_lookup.c_str())) { + std::string reference_position_filename; + get_keyval(conf, reference_position_file_lookup.c_str(), reference_position_filename, std::string("")); + std::vector reference_position(atoms->size()); + cvm::load_coords(reference_position_filename.c_str(), &reference_position, atoms, reference_column, reference_column_value); + reference_frames.push_back(reference_position); + ++total_reference_frames; + } else { + has_frames = false; + } + } + // Setup alignment to compute RMSD with respect to reference frames + for (size_t i_frame = 0; i_frame < reference_frames.size(); ++i_frame) { + cvm::atom_group* tmp_atoms = parse_group(conf, "atoms"); + if (!has_user_defined_fitting) { + // Swipe from the rmsd class + tmp_atoms->b_center = true; + tmp_atoms->b_rotate = true; + tmp_atoms->ref_pos = reference_frames[i_frame]; + tmp_atoms->center_ref_pos(); + tmp_atoms->enable(f_ag_fit_gradients); + tmp_atoms->rot.request_group1_gradients(tmp_atoms->size()); + tmp_atoms->rot.request_group2_gradients(tmp_atoms->size()); + comp_atoms.push_back(tmp_atoms); + } else { + // parse a group of atoms for fitting + std::string fitting_group_name = std::string("fittingAtoms") + cvm::to_str(i_frame); + cvm::atom_group* tmp_fitting_atoms = new cvm::atom_group(fitting_group_name.c_str()); + tmp_fitting_atoms->parse(fitting_conf); + tmp_fitting_atoms->disable(f_ag_scalable); + tmp_fitting_atoms->disable(f_ag_scalable_com); + tmp_fitting_atoms->fit_gradients.assign(tmp_fitting_atoms->size(), cvm::atom_pos(0.0, 0.0, 0.0)); + std::string reference_position_file_lookup = "refPositionsFile" + cvm::to_str(i_frame + 1); + std::string reference_position_filename; + get_keyval(conf, reference_position_file_lookup.c_str(), reference_position_filename, std::string("")); + std::vector reference_fitting_position(tmp_fitting_atoms->size()); + cvm::load_coords(reference_position_filename.c_str(), &reference_fitting_position, tmp_fitting_atoms, reference_column, reference_column_value); + // setup the atom group for calculating + tmp_atoms->b_center = true; + tmp_atoms->b_rotate = true; + tmp_atoms->b_user_defined_fit = true; + tmp_atoms->disable(f_ag_scalable); + tmp_atoms->disable(f_ag_scalable_com); + tmp_atoms->ref_pos = reference_fitting_position; + tmp_atoms->center_ref_pos(); + tmp_atoms->enable(f_ag_fit_gradients); + tmp_atoms->enable(f_ag_fitting_group); + tmp_atoms->fitting_group = tmp_fitting_atoms; + tmp_atoms->rot.request_group1_gradients(tmp_fitting_atoms->size()); + tmp_atoms->rot.request_group2_gradients(tmp_fitting_atoms->size()); + reference_fitting_frames.push_back(reference_fitting_position); + comp_atoms.push_back(tmp_atoms); + } + } + x.type(colvarvalue::type_scalar); + // Don't use implicit gradient + enable(f_cvc_explicit_gradient); +} + +colvar::CartesianBasedPath::~CartesianBasedPath() { + for (auto it_comp_atoms = comp_atoms.begin(); it_comp_atoms != comp_atoms.end(); ++it_comp_atoms) { + if (*it_comp_atoms != nullptr) { + delete (*it_comp_atoms); + (*it_comp_atoms) = nullptr; + } + } +} + +void colvar::CartesianBasedPath::computeReferenceDistance(std::vector& result) { + for (size_t i_frame = 0; i_frame < reference_frames.size(); ++i_frame) { + cvm::real frame_rmsd = 0.0; + for (size_t i_atom = 0; i_atom < atoms->size(); ++i_atom) { + frame_rmsd += ((*(comp_atoms[i_frame]))[i_atom].pos - reference_frames[i_frame][i_atom]).norm2(); + } + frame_rmsd /= cvm::real(atoms->size()); + frame_rmsd = cvm::sqrt(frame_rmsd); + result[i_frame] = frame_rmsd; + } +} + +colvar::gspath::gspath(std::string const &conf): CartesianBasedPath(conf) { + function_type = "gspath"; + get_keyval(conf, "useSecondClosestFrame", use_second_closest_frame, true); + if (use_second_closest_frame == true) { + cvm::log(std::string("Geometric path s(σ) will use the second closest frame to compute s_(m-1)\n")); + } else { + cvm::log(std::string("Geometric path s(σ) will use the neighbouring frame to compute s_(m-1)\n")); + } + get_keyval(conf, "useThirdClosestFrame", use_third_closest_frame, false); + if (use_third_closest_frame == true) { + cvm::log(std::string("Geometric path s(σ) will use the third closest frame to compute s_(m+1)\n")); + } else { + cvm::log(std::string("Geometric path s(σ) will use the neighbouring frame to compute s_(m+1)\n")); + } + GeometricPathCV::GeometricPathBase::initialize(atoms->size(), cvm::atom_pos(), total_reference_frames, use_second_closest_frame, use_third_closest_frame); + cvm::log(std::string("Geometric pathCV(s) is initialized.\n")); + cvm::log(std::string("Geometric pathCV(s) loaded ") + cvm::to_str(reference_frames.size()) + std::string(" frames.\n")); +} + +void colvar::gspath::updateReferenceDistances() { + computeReferenceDistance(frame_distances); +} + +void colvar::gspath::prepareVectors() { + size_t i_atom; + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + // v1 = s_m - z + v1[i_atom] = reference_frames[min_frame_index_1][i_atom] - (*(comp_atoms[min_frame_index_1]))[i_atom].pos; + // v2 = z - s_(m-1) + v2[i_atom] = (*(comp_atoms[min_frame_index_2]))[i_atom].pos - reference_frames[min_frame_index_2][i_atom]; + } + if (min_frame_index_3 < 0 || min_frame_index_3 > M) { + cvm::atom_pos reference_cog_1, reference_cog_2; + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + reference_cog_1 += reference_frames[min_frame_index_1][i_atom]; + reference_cog_2 += reference_frames[min_frame_index_2][i_atom]; + } + reference_cog_1 /= reference_frames[min_frame_index_1].size(); + reference_cog_2 /= reference_frames[min_frame_index_2].size(); + std::vector tmp_reference_frame_1(reference_frames[min_frame_index_1].size()); + std::vector tmp_reference_frame_2(reference_frames[min_frame_index_2].size()); + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + tmp_reference_frame_1[i_atom] = reference_frames[min_frame_index_1][i_atom] - reference_cog_1; + tmp_reference_frame_2[i_atom] = reference_frames[min_frame_index_2][i_atom] - reference_cog_2; + } + if (has_user_defined_fitting) { + cvm::atom_pos reference_fitting_cog_1, reference_fitting_cog_2; + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_1].size(); ++i_atom) { + reference_fitting_cog_1 += reference_fitting_frames[min_frame_index_1][i_atom]; + reference_fitting_cog_2 += reference_fitting_frames[min_frame_index_2][i_atom]; + } + reference_fitting_cog_1 /= reference_fitting_frames[min_frame_index_1].size(); + reference_fitting_cog_2 /= reference_fitting_frames[min_frame_index_2].size(); + std::vector tmp_reference_fitting_frame_1(reference_fitting_frames[min_frame_index_1].size()); + std::vector tmp_reference_fitting_frame_2(reference_fitting_frames[min_frame_index_2].size()); + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_1].size(); ++i_atom) { + tmp_reference_fitting_frame_1[i_atom] = reference_fitting_frames[min_frame_index_1][i_atom] - reference_fitting_cog_1; + tmp_reference_fitting_frame_2[i_atom] = reference_fitting_frames[min_frame_index_2][i_atom] - reference_fitting_cog_2; + } + rot_v3.calc_optimal_rotation(tmp_reference_fitting_frame_1, tmp_reference_fitting_frame_2); + } else { + rot_v3.calc_optimal_rotation(tmp_reference_frame_1, tmp_reference_frame_2); + } + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + v3[i_atom] = rot_v3.q.rotate(tmp_reference_frame_1[i_atom]) - tmp_reference_frame_2[i_atom]; + } + } else { + cvm::atom_pos reference_cog_1, reference_cog_3; + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + reference_cog_1 += reference_frames[min_frame_index_1][i_atom]; + reference_cog_3 += reference_frames[min_frame_index_3][i_atom]; + } + reference_cog_1 /= reference_frames[min_frame_index_1].size(); + reference_cog_3 /= reference_frames[min_frame_index_3].size(); + std::vector tmp_reference_frame_1(reference_frames[min_frame_index_1].size()); + std::vector tmp_reference_frame_3(reference_frames[min_frame_index_3].size()); + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + tmp_reference_frame_1[i_atom] = reference_frames[min_frame_index_1][i_atom] - reference_cog_1; + tmp_reference_frame_3[i_atom] = reference_frames[min_frame_index_3][i_atom] - reference_cog_3; + } + if (has_user_defined_fitting) { + cvm::atom_pos reference_fitting_cog_1, reference_fitting_cog_3; + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_1].size(); ++i_atom) { + reference_fitting_cog_1 += reference_fitting_frames[min_frame_index_1][i_atom]; + reference_fitting_cog_3 += reference_fitting_frames[min_frame_index_3][i_atom]; + } + reference_fitting_cog_1 /= reference_fitting_frames[min_frame_index_1].size(); + reference_fitting_cog_3 /= reference_fitting_frames[min_frame_index_3].size(); + std::vector tmp_reference_fitting_frame_1(reference_fitting_frames[min_frame_index_1].size()); + std::vector tmp_reference_fitting_frame_3(reference_fitting_frames[min_frame_index_3].size()); + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_1].size(); ++i_atom) { + tmp_reference_fitting_frame_1[i_atom] = reference_fitting_frames[min_frame_index_1][i_atom] - reference_fitting_cog_1; + tmp_reference_fitting_frame_3[i_atom] = reference_fitting_frames[min_frame_index_3][i_atom] - reference_fitting_cog_3; + } + rot_v3.calc_optimal_rotation(tmp_reference_fitting_frame_1, tmp_reference_fitting_frame_3); + } else { + rot_v3.calc_optimal_rotation(tmp_reference_frame_1, tmp_reference_frame_3); + } + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + // v3 = s_(m+1) - s_m + v3[i_atom] = tmp_reference_frame_3[i_atom] - rot_v3.q.rotate(tmp_reference_frame_1[i_atom]); + } + } +} + +void colvar::gspath::calc_value() { + computeValue(); + x = s; +} + +void colvar::gspath::calc_gradients() { + computeDerivatives(); + cvm::rvector tmp_atom_grad_v1, tmp_atom_grad_v2; + // dS(v1, v2(r), v3) / dr = ∂S/∂v1 * dv1/dr + ∂S/∂v2 * dv2/dr + // dv1/dr = [fitting matrix 1][-1, ..., -1] + // dv2/dr = [fitting matrix 2][1, ..., 1] + // ∂S/∂v1 = ± (∂f/∂v1) / (2M) + // ∂S/∂v2 = ± (∂f/∂v2) / (2M) + // dS(v1, v2(r), v3) / dr = -1.0 * ± (∂f/∂v1) / (2M) + ± (∂f/∂v2) / (2M) + for (size_t i_atom = 0; i_atom < atoms->size(); ++i_atom) { + tmp_atom_grad_v1[0] = -1.0 * sign * 0.5 * dfdv1[i_atom][0] / M; + tmp_atom_grad_v1[1] = -1.0 * sign * 0.5 * dfdv1[i_atom][1] / M; + tmp_atom_grad_v1[2] = -1.0 * sign * 0.5 * dfdv1[i_atom][2] / M; + tmp_atom_grad_v2[0] = sign * 0.5 * dfdv2[i_atom][0] / M; + tmp_atom_grad_v2[1] = sign * 0.5 * dfdv2[i_atom][1] / M; + tmp_atom_grad_v2[2] = sign * 0.5 * dfdv2[i_atom][2] / M; + (*(comp_atoms[min_frame_index_1]))[i_atom].grad += tmp_atom_grad_v1; + (*(comp_atoms[min_frame_index_2]))[i_atom].grad += tmp_atom_grad_v2; + } +} + +void colvar::gspath::apply_force(colvarvalue const &force) { + // The force applied to this CV is scalar type + cvm::real const &F = force.real_value; + (*(comp_atoms[min_frame_index_1])).apply_colvar_force(F); + (*(comp_atoms[min_frame_index_2])).apply_colvar_force(F); +} + +colvar::gzpath::gzpath(std::string const &conf): CartesianBasedPath(conf) { + function_type = "gzpath"; + get_keyval(conf, "useSecondClosestFrame", use_second_closest_frame, true); + if (use_second_closest_frame == true) { + cvm::log(std::string("Geometric path z(σ) will use the second closest frame to compute s_(m-1)\n")); + } else { + cvm::log(std::string("Geometric path z(σ) will use the neighbouring frame to compute s_(m-1)\n")); + } + get_keyval(conf, "useThirdClosestFrame", use_third_closest_frame, false); + if (use_third_closest_frame == true) { + cvm::log(std::string("Geometric path z(σ) will use the third closest frame to compute s_(m+1)\n")); + } else { + cvm::log(std::string("Geometric path z(σ) will use the neighbouring frame to compute s_(m+1)\n")); + } + bool b_use_z_square = false; + get_keyval(conf, "useZsquare", b_use_z_square, false); + if (b_use_z_square == true) { + cvm::log(std::string("Geometric path z(σ) will use the square of distance from current frame to path compute z\n")); + } + GeometricPathCV::GeometricPathBase::initialize(atoms->size(), cvm::atom_pos(), total_reference_frames, use_second_closest_frame, use_third_closest_frame, b_use_z_square); + // Logging + cvm::log(std::string("Geometric pathCV(z) is initialized.\n")); + cvm::log(std::string("Geometric pathCV(z) loaded ") + cvm::to_str(reference_frames.size()) + std::string(" frames.\n")); +} + +void colvar::gzpath::updateReferenceDistances() { + computeReferenceDistance(frame_distances); +} + +void colvar::gzpath::prepareVectors() { + cvm::atom_pos reference_cog_1, reference_cog_2; + size_t i_atom; + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + reference_cog_1 += reference_frames[min_frame_index_1][i_atom]; + reference_cog_2 += reference_frames[min_frame_index_2][i_atom]; + } + reference_cog_1 /= reference_frames[min_frame_index_1].size(); + reference_cog_2 /= reference_frames[min_frame_index_2].size(); + std::vector tmp_reference_frame_1(reference_frames[min_frame_index_1].size()); + std::vector tmp_reference_frame_2(reference_frames[min_frame_index_2].size()); + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + tmp_reference_frame_1[i_atom] = reference_frames[min_frame_index_1][i_atom] - reference_cog_1; + tmp_reference_frame_2[i_atom] = reference_frames[min_frame_index_2][i_atom] - reference_cog_2; + } + std::vector tmp_reference_fitting_frame_1; + std::vector tmp_reference_fitting_frame_2; + if (has_user_defined_fitting) { + cvm::atom_pos reference_fitting_cog_1, reference_fitting_cog_2; + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_1].size(); ++i_atom) { + reference_fitting_cog_1 += reference_fitting_frames[min_frame_index_1][i_atom]; + reference_fitting_cog_2 += reference_fitting_frames[min_frame_index_2][i_atom]; + } + reference_fitting_cog_1 /= reference_fitting_frames[min_frame_index_1].size(); + reference_fitting_cog_2 /= reference_fitting_frames[min_frame_index_2].size(); + tmp_reference_fitting_frame_1.resize(reference_fitting_frames[min_frame_index_1].size()); + tmp_reference_fitting_frame_2.resize(reference_fitting_frames[min_frame_index_2].size()); + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_1].size(); ++i_atom) { + tmp_reference_fitting_frame_1[i_atom] = reference_fitting_frames[min_frame_index_1][i_atom] - reference_fitting_cog_1; + tmp_reference_fitting_frame_2[i_atom] = reference_fitting_frames[min_frame_index_2][i_atom] - reference_fitting_cog_2; + } + rot_v4.calc_optimal_rotation(tmp_reference_fitting_frame_1, tmp_reference_fitting_frame_2); + } else { + rot_v4.calc_optimal_rotation(tmp_reference_frame_1, tmp_reference_frame_2); + } + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + v1[i_atom] = reference_frames[min_frame_index_1][i_atom] - (*(comp_atoms[min_frame_index_1]))[i_atom].pos; + v2[i_atom] = (*(comp_atoms[min_frame_index_2]))[i_atom].pos - reference_frames[min_frame_index_2][i_atom]; + // v4 only computes in gzpath + // v4 = s_m - s_(m-1) + v4[i_atom] = rot_v4.q.rotate(tmp_reference_frame_1[i_atom]) - tmp_reference_frame_2[i_atom]; + } + if (min_frame_index_3 < 0 || min_frame_index_3 > M) { + v3 = v4; + } else { + cvm::atom_pos reference_cog_3; + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + reference_cog_3 += reference_frames[min_frame_index_3][i_atom]; + } + reference_cog_3 /= reference_frames[min_frame_index_3].size(); + std::vector tmp_reference_frame_3(reference_frames[min_frame_index_3].size()); + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + tmp_reference_frame_3[i_atom] = reference_frames[min_frame_index_3][i_atom] - reference_cog_3; + } + if (has_user_defined_fitting) { + cvm::atom_pos reference_fitting_cog_3; + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_3].size(); ++i_atom) { + reference_fitting_cog_3 += reference_fitting_frames[min_frame_index_3][i_atom]; + } + reference_fitting_cog_3 /= reference_fitting_frames[min_frame_index_3].size(); + std::vector tmp_reference_fitting_frame_3(reference_fitting_frames[min_frame_index_3].size()); + for (i_atom = 0; i_atom < reference_fitting_frames[min_frame_index_3].size(); ++i_atom) { + tmp_reference_fitting_frame_3[i_atom] = reference_fitting_frames[min_frame_index_3][i_atom] - reference_fitting_cog_3; + } + rot_v3.calc_optimal_rotation(tmp_reference_fitting_frame_1, tmp_reference_fitting_frame_3); + } else { + rot_v3.calc_optimal_rotation(tmp_reference_frame_1, tmp_reference_frame_3); + } + for (i_atom = 0; i_atom < atoms->size(); ++i_atom) { + // v3 = s_(m+1) - s_m + v3[i_atom] = tmp_reference_frame_3[i_atom] - rot_v3.q.rotate(tmp_reference_frame_1[i_atom]); + } + } +} + +void colvar::gzpath::calc_value() { + computeValue(); + x = z; +} + +void colvar::gzpath::calc_gradients() { + computeDerivatives(); + cvm::rvector tmp_atom_grad_v1, tmp_atom_grad_v2; + for (size_t i_atom = 0; i_atom < atoms->size(); ++i_atom) { + tmp_atom_grad_v1 = -1.0 * dzdv1[i_atom]; + tmp_atom_grad_v2 = dzdv2[i_atom]; + (*(comp_atoms[min_frame_index_1]))[i_atom].grad += tmp_atom_grad_v1; + (*(comp_atoms[min_frame_index_2]))[i_atom].grad += tmp_atom_grad_v2; + } +} + +void colvar::gzpath::apply_force(colvarvalue const &force) { + // The force applied to this CV is scalar type + cvm::real const &F = force.real_value; + (*(comp_atoms[min_frame_index_1])).apply_colvar_force(F); + (*(comp_atoms[min_frame_index_2])).apply_colvar_force(F); +} + +colvar::linearCombination::linearCombination(std::string const &conf): cvc(conf) { + GeometricPathCV::init_string_cv_map(string_cv_map); + // Lookup all available sub-cvcs + for (auto it_cv_map = string_cv_map.begin(); it_cv_map != string_cv_map.end(); ++it_cv_map) { + if (key_lookup(conf, it_cv_map->first.c_str())) { + std::vector sub_cvc_confs; + get_key_string_multi_value(conf, it_cv_map->first.c_str(), sub_cvc_confs); + for (auto it_sub_cvc_conf = sub_cvc_confs.begin(); it_sub_cvc_conf != sub_cvc_confs.end(); ++it_sub_cvc_conf) { + cv.push_back((it_cv_map->second)(*(it_sub_cvc_conf))); + } + } + } + // Sort all sub CVs by their names + std::sort(cv.begin(), cv.end(), compareColvarComponent); + for (auto it_sub_cv = cv.begin(); it_sub_cv != cv.end(); ++it_sub_cv) { + for (auto it_atom_group = (*it_sub_cv)->atom_groups.begin(); it_atom_group != (*it_sub_cv)->atom_groups.end(); ++it_atom_group) { + register_atom_group(*it_atom_group); + } + } + x.type(cv[0]->value()); + x.reset(); + use_explicit_gradients = true; + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + if (!cv[i_cv]->is_enabled(f_cvc_explicit_gradient)) { + use_explicit_gradients = false; + } + } + if (!use_explicit_gradients) { + disable(f_cvc_explicit_gradient); + } +} + +cvm::real colvar::linearCombination::getPolynomialFactorOfCVGradient(size_t i_cv) const { + cvm::real factor_polynomial = 1.0; + if (cv[i_cv]->value().type() == colvarvalue::type_scalar) { + factor_polynomial = cv[i_cv]->sup_coeff * cv[i_cv]->sup_np * cvm::pow(cv[i_cv]->value().real_value, cv[i_cv]->sup_np - 1); + } else { + factor_polynomial = cv[i_cv]->sup_coeff; + } + return factor_polynomial; +} + +colvar::linearCombination::~linearCombination() { + for (auto it = cv.begin(); it != cv.end(); ++it) { + delete (*it); + } +} + +void colvar::linearCombination::calc_value() { + x.reset(); + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + cv[i_cv]->calc_value(); + colvarvalue current_cv_value(cv[i_cv]->value()); + // polynomial combination allowed + if (current_cv_value.type() == colvarvalue::type_scalar) { + x += cv[i_cv]->sup_coeff * (cvm::pow(current_cv_value.real_value, cv[i_cv]->sup_np)); + } else { + x += cv[i_cv]->sup_coeff * current_cv_value; + } + } +} + +void colvar::linearCombination::calc_gradients() { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + cv[i_cv]->calc_gradients(); + if ( cv[i_cv]->is_enabled(f_cvc_explicit_gradient) && + !cv[i_cv]->is_enabled(f_cvc_scalable) && + !cv[i_cv]->is_enabled(f_cvc_scalable_com)) { + cvm::real factor_polynomial = getPolynomialFactorOfCVGradient(i_cv); + for (size_t j_elem = 0; j_elem < cv[i_cv]->value().size(); ++j_elem) { + for (size_t k_ag = 0 ; k_ag < cv[i_cv]->atom_groups.size(); ++k_ag) { + for (size_t l_atom = 0; l_atom < (cv[i_cv]->atom_groups)[k_ag]->size(); ++l_atom) { + (*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad = factor_polynomial * (*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad; + } + } + } + } + } +} + +void colvar::linearCombination::apply_force(colvarvalue const &force) { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + // If this CV us explicit gradients, then atomic gradients is already calculated + // We can apply the force to atom groups directly + if ( cv[i_cv]->is_enabled(f_cvc_explicit_gradient) && + !cv[i_cv]->is_enabled(f_cvc_scalable) && + !cv[i_cv]->is_enabled(f_cvc_scalable_com) + ) { + for (size_t k_ag = 0 ; k_ag < cv[i_cv]->atom_groups.size(); ++k_ag) { + (cv[i_cv]->atom_groups)[k_ag]->apply_colvar_force(force.real_value); + } + } else { + // Compute factors for polynomial combinations + cvm::real factor_polynomial = getPolynomialFactorOfCVGradient(i_cv); + colvarvalue cv_force = force.real_value * factor_polynomial; + cv[i_cv]->apply_force(cv_force); + } + } +} + +colvar::CVBasedPath::CVBasedPath(std::string const &conf): cvc(conf) { + GeometricPathCV::init_string_cv_map(string_cv_map); + // Lookup all available sub-cvcs + for (auto it_cv_map = string_cv_map.begin(); it_cv_map != string_cv_map.end(); ++it_cv_map) { + if (key_lookup(conf, it_cv_map->first.c_str())) { + std::vector sub_cvc_confs; + get_key_string_multi_value(conf, it_cv_map->first.c_str(), sub_cvc_confs); + for (auto it_sub_cvc_conf = sub_cvc_confs.begin(); it_sub_cvc_conf != sub_cvc_confs.end(); ++it_sub_cvc_conf) { + cv.push_back((it_cv_map->second)(*(it_sub_cvc_conf))); + } + } + } + // Sort all sub CVs by their names + std::sort(cv.begin(), cv.end(), compareColvarComponent); + // Register atom groups and determine the colvar type for reference + std::vector tmp_cv; + for (auto it_sub_cv = cv.begin(); it_sub_cv != cv.end(); ++it_sub_cv) { + for (auto it_atom_group = (*it_sub_cv)->atom_groups.begin(); it_atom_group != (*it_sub_cv)->atom_groups.end(); ++it_atom_group) { + register_atom_group(*it_atom_group); + } + colvarvalue tmp_i_cv((*it_sub_cv)->value()); + tmp_i_cv.reset(); + tmp_cv.push_back(tmp_i_cv); + } + // Read path file + // Lookup all reference CV values + std::string path_filename; + get_keyval(conf, "pathFile", path_filename); + cvm::log(std::string("Reading path file: ") + path_filename + std::string("\n")); + std::ifstream ifs_path(path_filename); + if (!ifs_path.is_open()) { + cvm::error("Error: failed to open path file.\n"); + } + std::string line; + const std::string token(" "); + total_reference_frames = 0; + while (std::getline(ifs_path, line)) { + std::vector fields; + split_string(line, token, fields); + size_t num_value_required = 0; + for (size_t i_cv = 0; i_cv < tmp_cv.size(); ++i_cv) { + const size_t value_size = tmp_cv[i_cv].size(); + num_value_required += value_size; + cvm::log(std::string("Reading CV ") + cv[i_cv]->name + std::string(" with ") + cvm::to_str(value_size) + std::string(" value(s)\n")); + if (num_value_required <= fields.size()) { + size_t start_index = num_value_required - value_size; + for (size_t i = start_index; i < num_value_required; ++i) { + tmp_cv[i_cv][i] = std::atof(fields[i].c_str()); + cvm::log(fields[i] + std::string(" ")); + } + cvm::log(std::string("\n")); + } else { + cvm::error("Error: incorrect format of path file.\n"); + } + } + if (!fields.empty()) { + ref_cv.push_back(tmp_cv); + ++total_reference_frames; + } + } + x.type(colvarvalue::type_scalar); + use_explicit_gradients = true; + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + if (!cv[i_cv]->is_enabled(f_cvc_explicit_gradient)) { + use_explicit_gradients = false; + } + } + if (!use_explicit_gradients) { + disable(f_cvc_explicit_gradient); + } +} + +void colvar::CVBasedPath::computeReferenceDistance(std::vector& result) { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + cv[i_cv]->calc_value(); + } + for (size_t i_frame = 0; i_frame < ref_cv.size(); ++i_frame) { + cvm::real rmsd_i = 0.0; + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + colvarvalue ref_cv_value(ref_cv[i_frame][i_cv]); + colvarvalue current_cv_value(cv[i_cv]->value()); + // polynomial combination allowed + if (current_cv_value.type() == colvarvalue::type_scalar) { + // wrapping is already in dist2 + rmsd_i += cv[i_cv]->dist2(cv[i_cv]->sup_coeff * (cvm::pow(current_cv_value.real_value, cv[i_cv]->sup_np)), ref_cv_value.real_value); + } else { + rmsd_i += cv[i_cv]->dist2(cv[i_cv]->sup_coeff * current_cv_value, ref_cv_value); + } + } + rmsd_i /= cvm::real(cv.size()); + rmsd_i = cvm::sqrt(rmsd_i); + result[i_frame] = rmsd_i; + } +} + +cvm::real colvar::CVBasedPath::getPolynomialFactorOfCVGradient(size_t i_cv) const { + cvm::real factor_polynomial = 1.0; + if (cv[i_cv]->value().type() == colvarvalue::type_scalar) { + factor_polynomial = cv[i_cv]->sup_coeff * cv[i_cv]->sup_np * cvm::pow(cv[i_cv]->value().real_value, cv[i_cv]->sup_np - 1); + } else { + factor_polynomial = cv[i_cv]->sup_coeff; + } + return factor_polynomial; +} + +colvar::CVBasedPath::~CVBasedPath() { + for (auto it = cv.begin(); it != cv.end(); ++it) { + delete (*it); + } +} + +colvar::gspathCV::gspathCV(std::string const &conf): CVBasedPath(conf) { + function_type = "gspathCV"; + cvm::log(std::string("Total number of frames: ") + cvm::to_str(total_reference_frames) + std::string("\n")); + // Initialize variables for future calculation + get_keyval(conf, "useSecondClosestFrame", use_second_closest_frame, true); + if (use_second_closest_frame == true) { + cvm::log(std::string("Geometric path s(σ) will use the second closest frame to compute s_(m-1)\n")); + } else { + cvm::log(std::string("Geometric path s(σ) will use the neighbouring frame to compute s_(m-1)\n")); + } + get_keyval(conf, "useThirdClosestFrame", use_third_closest_frame, false); + if (use_third_closest_frame == true) { + cvm::log(std::string("Geometric path s(σ) will use the third closest frame to compute s_(m+1)\n")); + } else { + cvm::log(std::string("Geometric path s(σ) will use the neighbouring frame to compute s_(m+1)\n")); + } + GeometricPathCV::GeometricPathBase::initialize(cv.size(), ref_cv[0], total_reference_frames, use_second_closest_frame, use_third_closest_frame); + x.type(colvarvalue::type_scalar); + use_explicit_gradients = true; + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + if (!cv[i_cv]->is_enabled(f_cvc_explicit_gradient)) { + use_explicit_gradients = false; + } + } + if (!use_explicit_gradients) { + cvm::log("Geometric path s(σ) will use implicit gradients.\n"); + disable(f_cvc_explicit_gradient); + } +} + +colvar::gspathCV::~gspathCV() {} + +void colvar::gspathCV::updateReferenceDistances() { + computeReferenceDistance(frame_distances); +} + +void colvar::gspathCV::prepareVectors() { + // Compute v1, v2 and v3 + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + // values of sub-cvc are computed in update_distances + // cv[i_cv]->calc_value(); + colvarvalue f1_ref_cv_i_value(ref_cv[min_frame_index_1][i_cv]); + colvarvalue f2_ref_cv_i_value(ref_cv[min_frame_index_2][i_cv]); + colvarvalue current_cv_value(cv[i_cv]->value()); + // polynomial combination allowed + if (current_cv_value.type() == colvarvalue::type_scalar) { + v1[i_cv] = f1_ref_cv_i_value.real_value - cv[i_cv]->sup_coeff * (cvm::pow(current_cv_value.real_value, cv[i_cv]->sup_np)); + v2[i_cv] = cv[i_cv]->sup_coeff * (cvm::pow(current_cv_value.real_value, cv[i_cv]->sup_np)) - f2_ref_cv_i_value.real_value; + } else { + v1[i_cv] = f1_ref_cv_i_value - cv[i_cv]->sup_coeff * current_cv_value; + v2[i_cv] = cv[i_cv]->sup_coeff * current_cv_value - f2_ref_cv_i_value; + } + cv[i_cv]->wrap(v1[i_cv]); + cv[i_cv]->wrap(v2[i_cv]); + } + if (min_frame_index_3 < 0 || min_frame_index_3 > M) { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + v3[i_cv] = ref_cv[min_frame_index_1][i_cv] - ref_cv[min_frame_index_2][i_cv]; + cv[i_cv]->wrap(v3[i_cv]); + } + } else { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + v3[i_cv] = ref_cv[min_frame_index_3][i_cv] - ref_cv[min_frame_index_1][i_cv]; + cv[i_cv]->wrap(v3[i_cv]); + } + } +} + +void colvar::gspathCV::calc_value() { + computeValue(); + x = s; +} + +void colvar::gspathCV::calc_gradients() { + computeDerivatives(); + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + // No matter whether the i-th cv uses implicit gradient, compute it first. + cv[i_cv]->calc_gradients(); + // If the gradient is not implicit, then add the gradients to its atom groups + if ( cv[i_cv]->is_enabled(f_cvc_explicit_gradient) && + !cv[i_cv]->is_enabled(f_cvc_scalable) && + !cv[i_cv]->is_enabled(f_cvc_scalable_com)) { + // Temporary variables storing gradients + colvarvalue tmp_cv_grad_v1(cv[i_cv]->value()); + colvarvalue tmp_cv_grad_v2(cv[i_cv]->value()); + // Compute factors for polynomial combinations + cvm::real factor_polynomial = getPolynomialFactorOfCVGradient(i_cv); + // Loop over all elements of the corresponding colvar value + for (size_t j_elem = 0; j_elem < cv[i_cv]->value().size(); ++j_elem) { + // ds/dz, z = vector of CVs + tmp_cv_grad_v1[j_elem] = -1.0 * sign * 0.5 * dfdv1[i_cv][j_elem] / M; + tmp_cv_grad_v2[j_elem] = sign * 0.5 * dfdv2[i_cv][j_elem] / M; + // Apply the gradients to the atom groups in i-th cv + // Loop over all atom groups + for (size_t k_ag = 0 ; k_ag < cv[i_cv]->atom_groups.size(); ++k_ag) { + // Loop over all atoms in the k-th atom group + for (size_t l_atom = 0; l_atom < (cv[i_cv]->atom_groups)[k_ag]->size(); ++l_atom) { + // Chain rule + (*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad = factor_polynomial * ((*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad * tmp_cv_grad_v1[j_elem] + (*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad * tmp_cv_grad_v2[j_elem]); + } + } + } + } + } +} + +void colvar::gspathCV::apply_force(colvarvalue const &force) { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + // If this CV us explicit gradients, then atomic gradients is already calculated + // We can apply the force to atom groups directly + if ( cv[i_cv]->is_enabled(f_cvc_explicit_gradient) && + !cv[i_cv]->is_enabled(f_cvc_scalable) && + !cv[i_cv]->is_enabled(f_cvc_scalable_com) + ) { + for (size_t k_ag = 0 ; k_ag < cv[i_cv]->atom_groups.size(); ++k_ag) { + (cv[i_cv]->atom_groups)[k_ag]->apply_colvar_force(force.real_value); + } + } else { + // Temporary variables storing gradients + colvarvalue tmp_cv_grad_v1(cv[i_cv]->value()); + colvarvalue tmp_cv_grad_v2(cv[i_cv]->value()); + // Compute factors for polynomial combinations + cvm::real factor_polynomial = getPolynomialFactorOfCVGradient(i_cv); + for (size_t j_elem = 0; j_elem < cv[i_cv]->value().size(); ++j_elem) { + // ds/dz, z = vector of CVs + tmp_cv_grad_v1[j_elem] = -1.0 * sign * 0.5 * dfdv1[i_cv][j_elem] / M; + tmp_cv_grad_v2[j_elem] = sign * 0.5 * dfdv2[i_cv][j_elem] / M; + } + colvarvalue cv_force = force.real_value * factor_polynomial * (tmp_cv_grad_v1 + tmp_cv_grad_v2); + cv[i_cv]->apply_force(cv_force); + } + } +} + +colvar::gzpathCV::gzpathCV(std::string const &conf): CVBasedPath(conf) { + function_type = "gzpathCV"; + cvm::log(std::string("Total number of frames: ") + cvm::to_str(total_reference_frames) + std::string("\n")); + // Initialize variables for future calculation + M = cvm::real(total_reference_frames - 1); + m = 1.0; + get_keyval(conf, "useSecondClosestFrame", use_second_closest_frame, true); + if (use_second_closest_frame == true) { + cvm::log(std::string("Geometric path z(σ) will use the second closest frame to compute s_(m-1)\n")); + } else { + cvm::log(std::string("Geometric path z(σ) will use the neighbouring frame to compute s_(m-1)\n")); + } + get_keyval(conf, "useThirdClosestFrame", use_third_closest_frame, false); + if (use_third_closest_frame == true) { + cvm::log(std::string("Geometric path z(σ) will use the third closest frame to compute s_(m+1)\n")); + } else { + cvm::log(std::string("Geometric path z(σ) will use the neighbouring frame to compute s_(m+1)\n")); + } + bool b_use_z_square = false; + get_keyval(conf, "useZsquare", b_use_z_square, false); + if (b_use_z_square == true) { + cvm::log(std::string("Geometric path z(σ) will use the square of distance from current frame to path compute z\n")); + } + GeometricPathCV::GeometricPathBase::initialize(cv.size(), ref_cv[0], total_reference_frames, use_second_closest_frame, use_third_closest_frame, b_use_z_square); + x.type(colvarvalue::type_scalar); + use_explicit_gradients = true; + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + if (!cv[i_cv]->is_enabled(f_cvc_explicit_gradient)) { + use_explicit_gradients = false; + } + } + if (!use_explicit_gradients) { + cvm::log("Geometric path z(σ) will use implicit gradients.\n"); + disable(f_cvc_explicit_gradient); + } +} + +colvar::gzpathCV::~gzpathCV() { +} + +void colvar::gzpathCV::updateReferenceDistances() { + computeReferenceDistance(frame_distances); +} + +void colvar::gzpathCV::prepareVectors() { + // Compute v1, v2 and v3 + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + // values of sub-cvc are computed in update_distances + // cv[i_cv]->calc_value(); + colvarvalue f1_ref_cv_i_value(ref_cv[min_frame_index_1][i_cv]); + colvarvalue f2_ref_cv_i_value(ref_cv[min_frame_index_2][i_cv]); + colvarvalue current_cv_value(cv[i_cv]->value()); + // polynomial combination allowed + if (current_cv_value.type() == colvarvalue::type_scalar) { + v1[i_cv] = f1_ref_cv_i_value.real_value - cv[i_cv]->sup_coeff * (cvm::pow(current_cv_value.real_value, cv[i_cv]->sup_np)); + v2[i_cv] = cv[i_cv]->sup_coeff * (cvm::pow(current_cv_value.real_value, cv[i_cv]->sup_np)) - f2_ref_cv_i_value.real_value; + } else { + v1[i_cv] = f1_ref_cv_i_value - cv[i_cv]->sup_coeff * current_cv_value; + v2[i_cv] = cv[i_cv]->sup_coeff * current_cv_value - f2_ref_cv_i_value; + } + v4[i_cv] = f1_ref_cv_i_value - f2_ref_cv_i_value; + cv[i_cv]->wrap(v1[i_cv]); + cv[i_cv]->wrap(v2[i_cv]); + cv[i_cv]->wrap(v4[i_cv]); + } + if (min_frame_index_3 < 0 || min_frame_index_3 > M) { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + v3[i_cv] = ref_cv[min_frame_index_1][i_cv] - ref_cv[min_frame_index_2][i_cv]; + cv[i_cv]->wrap(v3[i_cv]); + } + } else { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + v3[i_cv] = ref_cv[min_frame_index_3][i_cv] - ref_cv[min_frame_index_1][i_cv]; + cv[i_cv]->wrap(v3[i_cv]); + } + } +} + +void colvar::gzpathCV::calc_value() { + computeValue(); + x = z; +} + +void colvar::gzpathCV::calc_gradients() { + computeDerivatives(); + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + // No matter whether the i-th cv uses implicit gradient, compute it first. + cv[i_cv]->calc_gradients(); + // If the gradient is not implicit, then add the gradients to its atom groups + if ( cv[i_cv]->is_enabled(f_cvc_explicit_gradient) && + !cv[i_cv]->is_enabled(f_cvc_scalable) && + !cv[i_cv]->is_enabled(f_cvc_scalable_com)) { + // Temporary variables storing gradients + colvarvalue tmp_cv_grad_v1 = -1.0 * dzdv1[i_cv]; + colvarvalue tmp_cv_grad_v2 = 1.0 * dzdv2[i_cv]; + // Compute factors for polynomial combinations + cvm::real factor_polynomial = getPolynomialFactorOfCVGradient(i_cv); + for (size_t j_elem = 0; j_elem < cv[i_cv]->value().size(); ++j_elem) { + // Apply the gradients to the atom groups in i-th cv + // Loop over all atom groups + for (size_t k_ag = 0 ; k_ag < cv[i_cv]->atom_groups.size(); ++k_ag) { + // Loop over all atoms in the k-th atom group + for (size_t l_atom = 0; l_atom < (cv[i_cv]->atom_groups)[k_ag]->size(); ++l_atom) { + // Chain rule + (*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad = factor_polynomial * ((*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad * tmp_cv_grad_v1[j_elem] + (*(cv[i_cv]->atom_groups)[k_ag])[l_atom].grad * tmp_cv_grad_v2[j_elem]); + } + } + } + } + } +} + +void colvar::gzpathCV::apply_force(colvarvalue const &force) { + for (size_t i_cv = 0; i_cv < cv.size(); ++i_cv) { + // If this CV us explicit gradients, then atomic gradients is already calculated + // We can apply the force to atom groups directly + if ( cv[i_cv]->is_enabled(f_cvc_explicit_gradient) && + !cv[i_cv]->is_enabled(f_cvc_scalable) && + !cv[i_cv]->is_enabled(f_cvc_scalable_com)) { + for (size_t k_ag = 0 ; k_ag < cv[i_cv]->atom_groups.size(); ++k_ag) { + (cv[i_cv]->atom_groups)[k_ag]->apply_colvar_force(force.real_value); + } + } + else { + colvarvalue tmp_cv_grad_v1 = -1.0 * dzdv1[i_cv]; + colvarvalue tmp_cv_grad_v2 = 1.0 * dzdv2[i_cv]; + // Temporary variables storing gradients + // Compute factors for polynomial combinations + cvm::real factor_polynomial = getPolynomialFactorOfCVGradient(i_cv); + colvarvalue cv_force = force.real_value * factor_polynomial * (tmp_cv_grad_v1 + tmp_cv_grad_v2); + cv[i_cv]->apply_force(cv_force); + } + } +} + +void GeometricPathCV::init_string_cv_map(std::map>& string_cv_map) { + string_cv_map["distance"] = [](const std::string& conf){return new colvar::distance(conf);}; + string_cv_map["dihedral"] = [](const std::string& conf){return new colvar::dihedral(conf);}; + string_cv_map["angle"] = [](const std::string& conf){return new colvar::angle(conf);}; + string_cv_map["rmsd"] = [](const std::string& conf){return new colvar::rmsd(conf);}; + string_cv_map["gyration"] = [](const std::string& conf){return new colvar::gyration(conf);}; + string_cv_map["inertia"] = [](const std::string& conf){return new colvar::inertia(conf);}; + string_cv_map["inertiaZ"] = [](const std::string& conf){return new colvar::inertia_z(conf);}; + string_cv_map["tilt"] = [](const std::string& conf){return new colvar::tilt(conf);}; + string_cv_map["distanceZ"] = [](const std::string& conf){return new colvar::distance_z(conf);}; + string_cv_map["distanceXY"] = [](const std::string& conf){return new colvar::distance_xy(conf);}; + string_cv_map["polarTheta"] = [](const std::string& conf){return new colvar::polar_theta(conf);}; + string_cv_map["polarPhi"] = [](const std::string& conf){return new colvar::polar_phi(conf);}; + string_cv_map["distanceVec"] = [](const std::string& conf){return new colvar::distance_vec(conf);}; + string_cv_map["orientationAngle"] = [](const std::string& conf){return new colvar::orientation_angle(conf);}; + string_cv_map["distancePairs"] = [](const std::string& conf){return new colvar::distance_pairs(conf);}; + string_cv_map["dipoleMagnitude"] = [](const std::string& conf){return new colvar::dipole_magnitude(conf);}; + string_cv_map["coordNum"] = [](const std::string& conf){return new colvar::coordnum(conf);}; + string_cv_map["selfCoordNum"] = [](const std::string& conf){return new colvar::selfcoordnum(conf);}; + string_cv_map["dipoleAngle"] = [](const std::string& conf){return new colvar::dipole_angle(conf);}; + string_cv_map["orientation"] = [](const std::string& conf){return new colvar::orientation(conf);}; + string_cv_map["orientationProj"] = [](const std::string& conf){return new colvar::orientation_proj(conf);}; + string_cv_map["eigenvector"] = [](const std::string& conf){return new colvar::eigenvector(conf);}; + string_cv_map["cartesian"] = [](const std::string& conf){return new colvar::cartesian(conf);}; + string_cv_map["alpha"] = [](const std::string& conf){return new colvar::alpha_angles(conf);}; + string_cv_map["dihedralPC"] = [](const std::string& conf){return new colvar::dihedPC(conf);}; + string_cv_map["linearCombination"] = [](const std::string& conf){return new colvar::linearCombination(conf);}; +} + +#endif diff --git a/lib/colvars/colvarcomp_protein.cpp b/lib/colvars/colvarcomp_protein.cpp index b9f9c60cdb..aa61cdf1dc 100644 --- a/lib/colvars/colvarcomp_protein.cpp +++ b/lib/colvars/colvarcomp_protein.cpp @@ -7,6 +7,8 @@ // If you wish to distribute your changes, please submit them to the // Colvars repository at GitHub. +#include + #include "colvarmodule.h" #include "colvarvalue.h" #include "colvarparse.h" diff --git a/lib/colvars/colvargrid.cpp b/lib/colvars/colvargrid.cpp index dc1a709edb..bc5ac3c57c 100644 --- a/lib/colvars/colvargrid.cpp +++ b/lib/colvars/colvargrid.cpp @@ -109,7 +109,9 @@ cvm::real colvar_grid_scalar::entropy() const { cvm::real sum = 0.0; for (size_t i = 0; i < nt; i++) { - sum += -1.0 * data[i] * cvm::logn(data[i]); + if (data[i] >0) { + sum += -1.0 * data[i] * cvm::logn(data[i]); + } } cvm::real bin_volume = 1.0; for (size_t id = 0; id < widths.size(); id++) { diff --git a/lib/colvars/colvargrid.h b/lib/colvars/colvargrid.h index 2ba0566e49..7792b7d0df 100644 --- a/lib/colvars/colvargrid.h +++ b/lib/colvars/colvargrid.h @@ -557,11 +557,11 @@ public: data[i] *= a; } - /// \brief Assign all zero elements a scalar constant (fast loop) - inline void remove_zeros(cvm::real const &a) + /// \brief Assign values that are smaller than scalar constant the latter value (fast loop) + inline void remove_small_values(cvm::real const &a) { for (size_t i = 0; i < nt; i++) - if(data[i]==0) data[i] = a; + if(data[i] #include #include @@ -58,6 +57,28 @@ bool colvarparse::get_key_string_value(std::string const &conf, return b_found_any; } +bool colvarparse::get_key_string_multi_value(std::string const &conf, + char const *key, std::vector& data) +{ + bool b_found = false, b_found_any = false; + size_t save_pos = 0, found_count = 0; + + data.clear(); + + do { + std::string data_this = ""; + b_found = key_lookup(conf, key, &data_this, &save_pos); + if (b_found) { + if (!b_found_any) + b_found_any = true; + found_count++; + data.push_back(data_this); + } + } while (b_found); + + return b_found_any; +} + template void colvarparse::mark_key_set_user(std::string const &key_str, @@ -843,3 +864,18 @@ int colvarparse::check_braces(std::string const &conf, } return (brace_count != 0) ? INPUT_ERROR : COLVARS_OK; } + +void colvarparse::split_string(const std::string& data, const std::string& delim, std::vector& dest) { + size_t index = 0, new_index = 0; + std::string tmpstr; + while (index != data.length()) { + new_index = data.find(delim, index); + if (new_index != std::string::npos) tmpstr = data.substr(index, new_index - index); + else tmpstr = data.substr(index, data.length()); + if (!tmpstr.empty()) { + dest.push_back(tmpstr); + } + if (new_index == std::string::npos) break; + index = new_index + 1; + } +} diff --git a/lib/colvars/colvarparse.h b/lib/colvars/colvarparse.h index 8501ee8c14..f4ead26601 100644 --- a/lib/colvars/colvarparse.h +++ b/lib/colvars/colvarparse.h @@ -212,6 +212,10 @@ protected: bool get_key_string_value(std::string const &conf, char const *key, std::string &data); + /// Get multiple strings from repeated instances of a same keyword + bool get_key_string_multi_value(std::string const &conf, + char const *key, std::vector& data); + /// Template for single-value keyword parsers template bool _get_keyval_scalar_(std::string const &conf, @@ -322,6 +326,12 @@ public: /// from this position static int check_braces(std::string const &conf, size_t const start_pos); + /// \brief Split a string with a specified delimiter into a vector + /// \param data The string to be splitted + /// \param delim A delimiter + /// \param dest A destination vector to store the splitted results + static void split_string(const std::string& data, const std::string& delim, std::vector& dest); + protected: /// \brief List of legal keywords for this object: this is updated diff --git a/lib/colvars/colvarproxy.cpp b/lib/colvars/colvarproxy.cpp index 5f8e82d30a..f077984556 100644 --- a/lib/colvars/colvarproxy.cpp +++ b/lib/colvars/colvarproxy.cpp @@ -7,8 +7,14 @@ // If you wish to distribute your changes, please submit them to the // Colvars repository at GitHub. +#if !defined(WIN32) || defined(__CYGWIN__) +#include +#endif +#include + #include #include +#include #if defined(_OPENMP) #include @@ -704,28 +710,39 @@ std::ostream * colvarproxy_io::output_stream(std::string const &output_name, if (cvm::debug()) { cvm::log("Using colvarproxy::output_stream()\n"); } - std::list::iterator osi = output_files.begin(); - std::list::iterator osni = output_stream_names.begin(); - for ( ; osi != output_files.end(); osi++, osni++) { - if (*osni == output_name) { - return *osi; - } - } + + std::ostream *os = get_output_stream(output_name); + if (os != NULL) return os; + if (!(mode & (std::ios_base::app | std::ios_base::ate))) { backup_file(output_name); } - std::ofstream *os = new std::ofstream(output_name.c_str(), mode); - if (!os->is_open()) { + std::ofstream *osf = new std::ofstream(output_name.c_str(), mode); + if (!osf->is_open()) { cvm::error("Error: cannot write to file/channel \""+output_name+"\".\n", FILE_ERROR); return NULL; } output_stream_names.push_back(output_name); - output_files.push_back(os); - return os; + output_files.push_back(osf); + return osf; } +std::ostream *colvarproxy_io::get_output_stream(std::string const &output_name) +{ + std::list::iterator osi = output_files.begin(); + std::list::iterator osni = output_stream_names.begin(); + for ( ; osi != output_files.end(); osi++, osni++) { + if (*osni == output_name) { + return *osi; + } + } + return NULL; +} + + + int colvarproxy_io::flush_output_stream(std::ostream *os) { std::list::iterator osi = output_files.begin(); @@ -761,10 +778,45 @@ int colvarproxy_io::close_output_stream(std::string const &output_name) int colvarproxy_io::backup_file(char const *filename) { + // TODO implement this using rename_file() return COLVARS_NOT_IMPLEMENTED; } +int colvarproxy_io::remove_file(char const *filename) +{ + if (std::remove(filename)) { + if (errno != ENOENT) { + return cvm::error("Error: in removing file \""+std::string(filename)+ + "\".\n.", + FILE_ERROR); + } + } + return COLVARS_OK; +} + + +int colvarproxy_io::rename_file(char const *filename, char const *newfilename) +{ + int error_code = COLVARS_OK; +#if defined(WIN32) && !defined(__CYGWIN__) + // On straight Windows, must remove the destination before renaming it + error_code |= remove_file(newfilename); +#endif + int rename_exit_code = 0; + while ((rename_exit_code = std::rename(filename, newfilename)) != 0) { + if (errno == EINTR) continue; + // Call log() instead of error to allow the next try + cvm::log("Error: in renaming file \""+std::string(filename)+"\" to \""+ + std::string(newfilename)+"\".\n."); + error_code |= FILE_ERROR; + if (errno == EXDEV) continue; + break; + } + return rename_exit_code ? error_code : COLVARS_OK; +} + + colvarproxy::colvarproxy() { @@ -826,4 +878,3 @@ int colvarproxy::get_version_from_string(char const *version_string) is >> newint; return newint; } - diff --git a/lib/colvars/colvarproxy.h b/lib/colvars/colvarproxy.h index 3bbdfe522e..21944106f1 100644 --- a/lib/colvars/colvarproxy.h +++ b/lib/colvars/colvarproxy.h @@ -571,7 +571,10 @@ public: /// if this is not open already, then open it virtual std::ostream *output_stream(std::string const &output_name, std::ios_base::openmode mode = - std::ios_base::out); + std::ios_base::out); + + /// Returns a reference to output_name if it exists, NULL otherwise + virtual std::ostream *get_output_stream(std::string const &output_name); /// \brief Flushes the given output channel virtual int flush_output_stream(std::ostream *os); @@ -588,6 +591,25 @@ public: return backup_file(filename.c_str()); } + /// Remove the given file + int remove_file(char const *filename); + + /// Remove the given file + inline int remove_file(std::string const &filename) + { + return remove_file(filename.c_str()); + } + + /// Rename the given file + int rename_file(char const *filename, char const *newfilename); + + /// Rename the given file + inline int rename_file(std::string const &filename, + std::string const &newfilename) + { + return rename_file(filename.c_str(), newfilename.c_str()); + } + /// \brief Prefix of the input state file inline std::string & input_prefix() { diff --git a/lib/colvars/colvars_version.h b/lib/colvars/colvars_version.h index 2521fdf872..0f1ee9a0a0 100644 --- a/lib/colvars/colvars_version.h +++ b/lib/colvars/colvars_version.h @@ -1,5 +1,5 @@ #ifndef COLVARS_VERSION -#define COLVARS_VERSION "2019-04-26" +#define COLVARS_VERSION "2019-08-01" // This file is part of the Collective Variables module (Colvars). // The original version of Colvars and its updates are located at: // https://github.com/colvars/colvars diff --git a/src/USER-COLVARS/colvarproxy_lammps_version.h b/src/USER-COLVARS/colvarproxy_lammps_version.h index 0a4f9fdf4f..d976f40510 100644 --- a/src/USER-COLVARS/colvarproxy_lammps_version.h +++ b/src/USER-COLVARS/colvarproxy_lammps_version.h @@ -1,5 +1,5 @@ #ifndef COLVARPROXY_VERSION -#define COLVARPROXY_VERSION "2019-04-09" +#define COLVARPROXY_VERSION "2019-08-01" // This file is part of the Collective Variables module (Colvars). // The original version of Colvars and its updates are located at: // https://github.com/colvars/colvars -- GitLab From f9e34825f0f07ac60c97a593b363ee518e83ad56 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 16:42:52 -0400 Subject: [PATCH 409/469] workaround for xcode oddity with compiling voro++ --- cmake/Modules/Packages/VORONOI.cmake | 8 ++++++-- 1 file changed, 6 insertions(+), 2 deletions(-) diff --git a/cmake/Modules/Packages/VORONOI.cmake b/cmake/Modules/Packages/VORONOI.cmake index 5ce974a7ae..89fa70bf98 100644 --- a/cmake/Modules/Packages/VORONOI.cmake +++ b/cmake/Modules/Packages/VORONOI.cmake @@ -18,8 +18,12 @@ if(PKG_VORONOI) else() set(VORO_BUILD_CFLAGS "${CMAKE_CXX_FLAGS} ${CMAKE_CXX_FLAGS_${BTYPE}}") endif() - string(APPEND VORO_BUILD_CFLAGS ${CMAKE_CXX_FLAGS}) - set(VORO_BUILD_OPTIONS CXX=${CMAKE_CXX_COMPILER} CFLAGS=${VORO_BUILD_CFLAGS}) + if(APPLE) + get_filename_component(VORO_CXX ${CMAKE_CXX_COMPILER} NAME_WE) + set(VORO_BUILD_OPTIONS CXX=${VORO_CXX} CFLAGS=${VORO_BUILD_CFLAGS}) + else() + set(VORO_BUILD_OPTIONS CXX=${CMAKE_CXX_COMPILER} CFLAGS=${VORO_BUILD_CFLAGS}) + endif() ExternalProject_Add(voro_build URL https://download.lammps.org/thirdparty/voro++-0.4.6.tar.gz -- GitLab From 5b4b418289c86fbed8a4fc93b72633e1cce304b9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 18:24:14 -0400 Subject: [PATCH 410/469] use check_language() instead of enable_language() to get fortran compiler name --- cmake/Modules/Packages/KIM.cmake | 8 ++++++-- 1 file changed, 6 insertions(+), 2 deletions(-) diff --git a/cmake/Modules/Packages/KIM.cmake b/cmake/Modules/Packages/KIM.cmake index d9d028f6dc..31586bfbe0 100644 --- a/cmake/Modules/Packages/KIM.cmake +++ b/cmake/Modules/Packages/KIM.cmake @@ -20,9 +20,13 @@ if(PKG_KIM) message(FATAL_ERROR "Cannot build downloaded KIM-API library with Ninja build tool") endif() message(STATUS "KIM-API download requested - we will build our own") - enable_language(C) - enable_language(Fortran) + include(CheckLanguage) include(ExternalProject) + enable_language(C) + check_language(Fortran) + if(NOT CMAKE_Fortran_COMPILER) + message(FATAL_ERROR "Compiling the KIM-API library requires a Fortran compiler") + endif() ExternalProject_Add(kim_build URL https://s3.openkim.org/kim-api/kim-api-2.1.2.txz URL_MD5 6ac52e14ef52967fc7858220b208cba5 -- GitLab From f61cd68ca47aff365b76248d95e816b8b3aac687 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 1 Aug 2019 20:43:33 -0400 Subject: [PATCH 411/469] add missing parenthesis --- src/KOKKOS/kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 6fd8f46e43..32550e8285 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -239,7 +239,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) #if defined(MPICH) && defined(MVAPICH2_VERSION) char* str; cuda_aware_flag = 0; - if (str = getenv("MV2_ENABLE_CUDA") + if ((str = getenv("MV2_ENABLE_CUDA"))) if ((strcmp(str,"1") == 0)) cuda_aware_flag = 1; -- GitLab From 5076f1a36c2d2ccbff93e621fa0460ebe6ca947c Mon Sep 17 00:00:00 2001 From: Evangelos Voyiatzis Date: Fri, 2 Aug 2019 10:55:18 +0200 Subject: [PATCH 412/469] small clean-up of fix.txt --- doc/src/fix.txt | 77 +++++++++++++++++++++++-------------------------- 1 file changed, 36 insertions(+), 41 deletions(-) diff --git a/doc/src/fix.txt b/doc/src/fix.txt index 294802c4fa..c64d61d949 100644 --- a/doc/src/fix.txt +++ b/doc/src/fix.txt @@ -169,7 +169,7 @@ accelerated styles exist. "addforce"_fix_addforce.html - add a force to each atom "addtorque"_fix_addtorque.html - "append/atoms"_fix_append_atoms.html - append atoms to a running simulation -"atc"_fix_atc.html - +"atc"_fix_atc.html - initiates a coupled MD/FE simulation "atom/swap"_fix_atom_swap.html - Monte Carlo atom type swapping "ave/atom"_fix_ave_atom.html - compute per-atom time-averaged quantities "ave/chunk"_fix_ave_chunk.html - compute per-chunk time-averaged quantities @@ -187,12 +187,12 @@ accelerated styles exist. "bond/swap"_fix_bond_swap.html - Monte Carlo bond swapping "box/relax"_fix_box_relax.html - relax box size during energy minimization "client/md"_fix_client_md.html - -"cmap"_fix_cmap.html - -"colvars"_fix_colvars.html - -"controller"_fix_controller.html - +"cmap"_fix_cmap.html - enables CMAP cross-terms of the CHARMM force field +"colvars"_fix_colvars.html - interface to the collective variables “Colvars” library +"controller"_fix_controller.html - "deform"_fix_deform.html - change the simulation box size/shape "deposit"_fix_deposit.html - add new atoms above a surface -"dpd/energy"_fix_dpd_energy.html - +"dpd/energy"_fix_dpd_energy.html - constant energy dissipative particle dynamics "drag"_fix_drag.html - drag atoms towards a defined coordinate "drude"_fix_drude.html - "drude/transform/direct"_fix_drude_transform.html - @@ -208,27 +208,26 @@ accelerated styles exist. "eos/table/rx"_fix_eos_table_rx.html - "evaporate"_fix_evaporate.html - remove atoms from simulation periodically "external"_fix_external.html - callback to an external driver program -"ffl"_fix_ffl.html - +"ffl"_fix_ffl.html - apply a Fast-Forward Langevin equation thermostat "filter/corotate"_fix_filter_corotate.html - "flow/gauss"_fix_flow_gauss.html - "freeze"_fix_freeze.html - freeze atoms in a granular simulation "gcmc"_fix_gcmc.html - grand canonical insertions/deletions -"gld"_fix_gcmc.html - generalized Langevin dynamics integrator -"gld"_fix_gld.html - -"gle"_fix_gle.html - +"gld"_fix_gld.html - generalized Langevin dynamics integrator +"gle"_fix_gle.html - generalized Langevin equation thermostat "gravity"_fix_gravity.html - add gravity to atoms in a granular simulation -"grem"_fix_grem.html - +"grem"_fix_grem.html - implements the generalized replica exchange method "halt"_fix_halt.html - terminate a dynamics run or minimization "heat"_fix_heat.html - add/subtract momentum-conserving heat "hyper/global"_fix_hyper_global.html - global hyperdynamics "hyper/local"_fix_hyper_local.html - local hyperdynamics -"imd"_fix_imd.html - +"imd"_fix_imd.html - implements the “Interactive MD” (IMD) protocol "indent"_fix_indent.html - impose force due to an indenter "ipi"_fix_ipi.html - "langevin"_fix_langevin.html - Langevin temperature control -"langevin/drude"_fix_langevin_drude.html - -"langevin/eff"_fix_langevin_eff.html - -"langevin/spin"_fix_langevin_spin.html - +"langevin/drude"_fix_langevin_drude.html - Langevin temperature control of Drude oscillators +"langevin/eff"_fix_langevin_eff.html - Langevin temperature control for the electron force field model +"langevin/spin"_fix_langevin_spin.html - Langevin temperature control for a spin or spin-lattice system "latte"_fix_latte.html - wrapper on LATTE density-functional tight-binding code "lb/fluid"_fix_lb_fluid.html - "lb/momentum"_fix_lb_momentum.html - @@ -238,62 +237,58 @@ accelerated styles exist. "lineforce"_fix_lineforce.html - constrain atoms to move in a line "manifoldforce"_fix_manifoldforce.html - "meso"_fix_meso.html - -"meso"_fix_meso_move.html - move mesoscopic SPH/SDPD particles in a prescribed fashion -"meso/move"_fix_meso_move.html - +"meso/move"_fix_meso_move.html - move mesoscopic SPH/SDPD particles in a prescribed fashion "meso/stationary"_fix_meso_stationary.html - "momentum"_fix_momentum.html - zero the linear and/or angular momentum of a group of atoms "move"_fix_move.html - move atoms in a prescribed fashion "mscg"_fix_mscg.html - "msst"_fix_msst.html - multi-scale shock technique (MSST) integration -"mvv/dpd"_fix_mvv_dpd.html - -"mvv/edpd"_fix_mvv_dpd.html - -"mvv/tdpd"_fix_mvv_dpd.html - +"mvv/dpd"_fix_mvv_dpd.html - DPD using the modified velocity-Verlet integration algorithm +"mvv/edpd"_fix_mvv_dpd.html - constant energy DPD using the modified velocity-Verlet algrithm +"mvv/tdpd"_fix_mvv_dpd.html - constant temperature DPD using the modified velocity-Verlet algorithm "neb"_fix_neb.html - nudged elastic band (NEB) spring forces "nph"_fix_nh.html - constant NPH time integration via Nose/Hoover "nph/asphere"_fix_nph_asphere.html - NPH for aspherical particles -"nph/body"_fix_nph_body.html - -"nph/body"_fix_nve_body.html - NPH for body particles -"nph/eff"_fix_nh_eff.html - +"nph/body"_fix_nph_body.html - NPH for body particles +"nph/eff"_fix_nh_eff.html - NPH for nuclei and electrons in the electron force field model "nph/sphere"_fix_nph_sphere.html - NPH for spherical particles "nphug"_fix_nphug.html - constant-stress Hugoniostat integration "npt"_fix_nh.html - constant NPT time integration via Nose/Hoover "npt/asphere"_fix_npt_asphere.html - NPT for aspherical particles -"npt/body"_fix_npt_body.html - -"npt/body"_fix_nve_body.html - NPT for body particles -"npt/eff"_fix_nh_eff.html - +"npt/body"_fix_npt_body.html - NPT for body particles +"npt/eff"_fix_nh_eff.html - NPT for nuclei and electrons in the electron force field model "npt/sphere"_fix_npt_sphere.html - NPT for spherical particles "npt/uef"_fix_nh_uef.html - "nve"_fix_nve.html - constant NVE time integration "nve/asphere"_fix_nve_asphere.html - NVE for aspherical particles -"nve/asphere/noforce"_fix_nve_asphere_noforce.html - NVE for aspherical particles without forces" -"nve/awpmd"_fix_nve_awpmd.html - +"nve/asphere/noforce"_fix_nve_asphere_noforce.html - NVE for aspherical particles without forces +"nve/awpmd"_fix_nve_awpmd.html - NVE for the Antisymmetrized Wave Packet Molecular Dynamics model "nve/body"_fix_nve_body.html - NVE for body particles "nve/dot"_fix_nve_dot.html - "nve/dotc/langevin"_fix_nve_dotc_langevin.html - -"nve/eff"_fix_nve_eff.html - +"nve/eff"_fix_nve_eff.html - NVE for nuclei and electrons in the electron force field model "nve/limit"_fix_nve_limit.html - NVE with limited step length "nve/line"_fix_nve_line.html - NVE for line segments "nve/manifold/rattle"_fix_nve_manifold_rattle.html - "nve/noforce"_fix_nve_noforce.html - NVE without forces (v only) "nve/sphere"_fix_nve_sphere.html - NVE for spherical particles -"nve/spin"_fix_nve_spin.html - +"nve/spin"_fix_nve_spin.html - NVE for a spin or spin-lattice system "nve/tri"_fix_nve_tri.html - NVE for triangles -"nvk"_fix_nvk.html - -"nvt"_fix_nh.html - constant NVT time integration via Nose/Hoover +"nvk"_fix_nvk.html - constant kinetic energy time integration +"nvt"_fix_nh.html - NVT time integration via Nose/Hoover "nvt/asphere"_fix_nvt_asphere.html - NVT for aspherical particles -"nvt/body"_fix_nve_body.html - NVT for body particles -"nvt/body"_fix_nvt_body.html - -"nvt/eff"_fix_nh_eff.html - +"nvt/body"_fix_nvt_body.html - NVT for body particles +"nvt/eff"_fix_nh_eff.html - NVE for nuclei and electrons in the electron force field model "nvt/manifold/rattle"_fix_nvt_manifold_rattle.html - "nvt/sllod"_fix_nvt_sllod.html - NVT for NEMD with SLLOD equations -"nvt/sllod/eff"_fix_nvt_sllod_eff.html - +"nvt/sllod/eff"_fix_nvt_sllod_eff.html - NVT for NEMD with SLLOD equations for the electron force field model "nvt/sphere"_fix_nvt_sphere.html - NVT for spherical particles "nvt/uef"_fix_nh_uef.html - "oneway"_fix_oneway.html - constrain particles on move in one direction "orient/bcc"_fix_orient.html - add grain boundary migration force for BCC "orient/fcc"_fix_orient.html - add grain boundary migration force for FCC "phonon"_fix_phonon.html - -"pimd"_fix_pimd.html - +"pimd"_fix_pimd.html - Feynman path integral molecular dynamics "planeforce"_fix_planeforce.html - constrain atoms to move in a plane "plumed"_fix_plumed.html - wrapper on PLUMED free energy library "poems"_fix_poems.html - constrain clusters of atoms to move as coupled rigid bodies @@ -303,16 +298,16 @@ accelerated styles exist. "print"_fix_print.html - print text and variables during a simulation "property/atom"_fix_property_atom.html - add customized per-atom values "python/invoke"_fix_python_invoke.html - -"python/move"_fix_python_move.html - +"python/move"_fix_python_move.html - call a Python function during a simulation run "qbmsst"_fix_qbmsst.html - "qeq/comb"_fix_qeq_comb.html - charge equilibration for COMB potential "qeq/dynamic"_fix_qeq.html - charge equilibration via dynamic method "qeq/fire"_fix_qeq.html - charge equilibration via FIRE minimizer "qeq/point"_fix_qeq.html - charge equilibration via point method -"qeq/reax"_fix_qeq_reax.html - +"qeq/reax"_fix_qeq_reax.html - charge equilibration for ReaxFF potential "qeq/shielded"_fix_qeq.html - charge equilibration via shielded method "qeq/slater"_fix_qeq.html - charge equilibration via Slater method -"qmmm"_fix_qmmm.html - +"qmmm"_fix_qmmm.html - functionality to enable a quantum mechanics/molecular mechanics coupling "qtb"_fix_qtb.html - "rattle"_fix_shake.html - RATTLE constraints on bonds and/or angles "reax/c/bonds"_fix_reaxc_bonds.html - write out ReaxFF bond information @@ -335,7 +330,7 @@ accelerated styles exist. "saed/vtk"_fix_saed_vtk.html - "setforce"_fix_setforce.html - set the force on each atom "shake"_fix_shake.html - SHAKE constraints on bonds and/or angles -"shardlow"_fix_shardlow.html - +"shardlow"_fix_shardlow.html - integration of DPD equations of motion using the Shardlow splitting "smd"_fix_smd.html - "smd/adjust_dt"_fix_smd_adjust_dt.html - "smd/integrate_tlsph"_fix_smd_integrate_tlsph.html - @@ -355,7 +350,7 @@ accelerated styles exist. "temp/csld"_fix_temp_csvr.html - canonical sampling thermostat with Langevin dynamics "temp/csvr"_fix_temp_csvr.html - canonical sampling thermostat with Hamiltonian dynamics "temp/rescale"_fix_temp_rescale.html - temperature control by velocity rescaling -"temp/rescale/eff"_fix_temp_rescale_eff.html - +"temp/rescale/eff"_fix_temp_rescale_eff.html - temperature control by velocity rescaling in the electron force field model "tfmc"_fix_tfmc.html - perform force-bias Monte Carlo with time-stamped method "thermal/conductivity"_fix_thermal_conductivity.html - Muller-Plathe kinetic energy exchange for thermal conductivity calculation "ti/spring"_fix_ti_spring.html - -- GitLab From b5f19b93c24d27f90096c03e27877e57f53c5eab Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 2 Aug 2019 05:15:29 -0400 Subject: [PATCH 413/469] Step version string for next patch release --- doc/lammps.1 | 2 +- doc/src/Manual.txt | 4 ++-- src/version.h | 2 +- 3 files changed, 4 insertions(+), 4 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index 9a3d7e78c8..6539b85af9 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,4 +1,4 @@ -.TH LAMMPS "31 July 2019" "2019-07-31" +.TH LAMMPS "2 August 2019" "2019-08-02" .SH NAME .B LAMMPS \- Molecular Dynamics Simulator. diff --git a/doc/src/Manual.txt b/doc/src/Manual.txt index 927ee780e4..85828f1d90 100644 --- a/doc/src/Manual.txt +++ b/doc/src/Manual.txt @@ -1,7 +1,7 @@ LAMMPS Users Manual - + @@ -21,7 +21,7 @@ :line LAMMPS Documentation :c,h1 -31 Jul 2019 version :c,h2 +2 Aug 2019 version :c,h2 "What is a LAMMPS version?"_Manual_version.html diff --git a/src/version.h b/src/version.h index 9007966450..b74aa30172 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "31 Jul 2019" +#define LAMMPS_VERSION "2 Aug 2019" -- GitLab From 8fd28cd78d24bb2a3e7a126ad0614e03f1f42cfa Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 2 Aug 2019 08:40:59 -0400 Subject: [PATCH 414/469] fix typo --- doc/src/fix_rhok.txt | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/fix_rhok.txt b/doc/src/fix_rhok.txt index f013ebfae1..7f0a72d1b3 100644 --- a/doc/src/fix_rhok.txt +++ b/doc/src/fix_rhok.txt @@ -39,8 +39,8 @@ An example of using the interface pinning method is located in the [Restrictions:] -This fix is part of the MISC package. It is only enabled if LAMMPS -was built with that package. See the "Build +This fix is part of the USER-MISC package. It is only enabled if +LAMMPS was built with that package. See the "Build package"_Build_package.html doc page for more info. [Related commands:] -- GitLab From 9ed43e55f090ffef11cd71ea45f88cda2b57b371 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 2 Aug 2019 08:41:34 -0400 Subject: [PATCH 415/469] add some more descriptions for fixes to list of style in fix command docs --- doc/src/fix.txt | 62 ++++++++++++++++++++++++------------------------- 1 file changed, 31 insertions(+), 31 deletions(-) diff --git a/doc/src/fix.txt b/doc/src/fix.txt index c64d61d949..409fde3503 100644 --- a/doc/src/fix.txt +++ b/doc/src/fix.txt @@ -165,9 +165,9 @@ page are followed by one or more of (g,i,k,o,t) to indicate which accelerated styles exist. "adapt"_fix_adapt.html - change a simulation parameter over time -"adapt/fep"_fix_adapt_fep.html - +"adapt/fep"_fix_adapt_fep.html - enhanced version of fix adapt "addforce"_fix_addforce.html - add a force to each atom -"addtorque"_fix_addtorque.html - +"addtorque"_fix_addtorque.html - add a torque to a group of atoms "append/atoms"_fix_append_atoms.html - append atoms to a running simulation "atc"_fix_atc.html - initiates a coupled MD/FE simulation "atom/swap"_fix_atom_swap.html - Monte Carlo atom type swapping @@ -176,29 +176,29 @@ accelerated styles exist. "ave/correlate"_fix_ave_correlate.html - compute/output time correlations "ave/correlate/long"_fix_ave_correlate_long.html - "ave/histo"_fix_ave_histo.html - compute/output time-averaged histograms -"ave/histo/weight"_fix_ave_histo.html - +"ave/histo/weight"_fix_ave_histo.html - weighted version of fix ave/histo "ave/time"_fix_ave_time.html - compute/output global time-averaged quantities "aveforce"_fix_aveforce.html - add an averaged force to each atom "balance"_fix_balance.html - perform dynamic load-balancing -"bocs"_fix_bocs.html - +"bocs"_fix_bocs.html - NPT style time integration with pressure correction "bond/break"_fix_bond_break.html - break bonds on the fly "bond/create"_fix_bond_create.html - create bonds on the fly -"bond/react"_fix_bond_react.html - +"bond/react"_fix_bond_react.html - apply topology changes to model reactions "bond/swap"_fix_bond_swap.html - Monte Carlo bond swapping "box/relax"_fix_box_relax.html - relax box size during energy minimization -"client/md"_fix_client_md.html - +"client/md"_fix_client_md.html - MD client for client/server simulations "cmap"_fix_cmap.html - enables CMAP cross-terms of the CHARMM force field "colvars"_fix_colvars.html - interface to the collective variables “Colvars” library -"controller"_fix_controller.html - +"controller"_fix_controller.html - apply control loop feedback mechanism "deform"_fix_deform.html - change the simulation box size/shape "deposit"_fix_deposit.html - add new atoms above a surface "dpd/energy"_fix_dpd_energy.html - constant energy dissipative particle dynamics "drag"_fix_drag.html - drag atoms towards a defined coordinate -"drude"_fix_drude.html - -"drude/transform/direct"_fix_drude_transform.html - -"drude/transform/inverse"_fix_drude_transform.html - +"drude"_fix_drude.html - part of Drude oscillator polarization model +"drude/transform/direct"_fix_drude_transform.html - part of Drude oscillator polarization model +"drude/transform/inverse"_fix_drude_transform.html - part of Drude oscillator polarization model "dt/reset"_fix_dt_reset.html - reset the timestep based on velocity, forces -"edpd/source"_fix_dpd_source.html - +"edpd/source"_fix_dpd_source.html - add heat source to eDPD simulations "efield"_fix_efield.html - impose electric field on system "ehex"_fix_ehex.html - enhanced heat exchange algorithm "electron/stopping"_fix_electron_stopping.html - electronic stopping power as a friction force @@ -209,8 +209,8 @@ accelerated styles exist. "evaporate"_fix_evaporate.html - remove atoms from simulation periodically "external"_fix_external.html - callback to an external driver program "ffl"_fix_ffl.html - apply a Fast-Forward Langevin equation thermostat -"filter/corotate"_fix_filter_corotate.html - -"flow/gauss"_fix_flow_gauss.html - +"filter/corotate"_fix_filter_corotate.html - implement corotation filter to allow larger timesteps with r-RESPA +"flow/gauss"_fix_flow_gauss.html - Gaussian dynamics for constant mass flux "freeze"_fix_freeze.html - freeze atoms in a granular simulation "gcmc"_fix_gcmc.html - grand canonical insertions/deletions "gld"_fix_gld.html - generalized Langevin dynamics integrator @@ -223,7 +223,7 @@ accelerated styles exist. "hyper/local"_fix_hyper_local.html - local hyperdynamics "imd"_fix_imd.html - implements the “Interactive MD” (IMD) protocol "indent"_fix_indent.html - impose force due to an indenter -"ipi"_fix_ipi.html - +"ipi"_fix_ipi.html - enable LAMMPS to run as a client for i-PI path-integral simulations "langevin"_fix_langevin.html - Langevin temperature control "langevin/drude"_fix_langevin_drude.html - Langevin temperature control of Drude oscillators "langevin/eff"_fix_langevin_eff.html - Langevin temperature control for the electron force field model @@ -235,13 +235,13 @@ accelerated styles exist. "lb/rigid/pc/sphere"_fix_lb_rigid_pc_sphere.html - "lb/viscous"_fix_lb_viscous.html - "lineforce"_fix_lineforce.html - constrain atoms to move in a line -"manifoldforce"_fix_manifoldforce.html - -"meso"_fix_meso.html - +"manifoldforce"_fix_manifoldforce.html - restrain atoms to a manifold during minimization +"meso"_fix_meso.html - time integration for SPH/DPDE particles "meso/move"_fix_meso_move.html - move mesoscopic SPH/SDPD particles in a prescribed fashion "meso/stationary"_fix_meso_stationary.html - "momentum"_fix_momentum.html - zero the linear and/or angular momentum of a group of atoms "move"_fix_move.html - move atoms in a prescribed fashion -"mscg"_fix_mscg.html - +"mscg"_fix_mscg.html - apply MSCG method for force-matching to generate coarse grain models "msst"_fix_msst.html - multi-scale shock technique (MSST) integration "mvv/dpd"_fix_mvv_dpd.html - DPD using the modified velocity-Verlet integration algorithm "mvv/edpd"_fix_mvv_dpd.html - constant energy DPD using the modified velocity-Verlet algrithm @@ -258,14 +258,14 @@ accelerated styles exist. "npt/body"_fix_npt_body.html - NPT for body particles "npt/eff"_fix_nh_eff.html - NPT for nuclei and electrons in the electron force field model "npt/sphere"_fix_npt_sphere.html - NPT for spherical particles -"npt/uef"_fix_nh_uef.html - +"npt/uef"_fix_nh_uef.html - NPT style time integration with diagonal flow "nve"_fix_nve.html - constant NVE time integration "nve/asphere"_fix_nve_asphere.html - NVE for aspherical particles "nve/asphere/noforce"_fix_nve_asphere_noforce.html - NVE for aspherical particles without forces "nve/awpmd"_fix_nve_awpmd.html - NVE for the Antisymmetrized Wave Packet Molecular Dynamics model "nve/body"_fix_nve_body.html - NVE for body particles -"nve/dot"_fix_nve_dot.html - -"nve/dotc/langevin"_fix_nve_dotc_langevin.html - +"nve/dot"_fix_nve_dot.html - rigid body constant energy time integrator for coarse grain models +"nve/dotc/langevin"_fix_nve_dotc_langevin.html - Langevin style rigid body time integrator for coarse grain models "nve/eff"_fix_nve_eff.html - NVE for nuclei and electrons in the electron force field model "nve/limit"_fix_nve_limit.html - NVE with limited step length "nve/line"_fix_nve_line.html - NVE for line segments @@ -283,11 +283,11 @@ accelerated styles exist. "nvt/sllod"_fix_nvt_sllod.html - NVT for NEMD with SLLOD equations "nvt/sllod/eff"_fix_nvt_sllod_eff.html - NVT for NEMD with SLLOD equations for the electron force field model "nvt/sphere"_fix_nvt_sphere.html - NVT for spherical particles -"nvt/uef"_fix_nh_uef.html - +"nvt/uef"_fix_nh_uef.html - NVT style time integration with diagonal flow "oneway"_fix_oneway.html - constrain particles on move in one direction "orient/bcc"_fix_orient.html - add grain boundary migration force for BCC "orient/fcc"_fix_orient.html - add grain boundary migration force for FCC -"phonon"_fix_phonon.html - +"phonon"_fix_phonon.html - calculate dynamical matrix from MD simulations "pimd"_fix_pimd.html - Feynman path integral molecular dynamics "planeforce"_fix_planeforce.html - constrain atoms to move in a plane "plumed"_fix_plumed.html - wrapper on PLUMED free energy library @@ -297,9 +297,9 @@ accelerated styles exist. "press/berendsen"_fix_press_berendsen.html - pressure control by Berendsen barostat "print"_fix_print.html - print text and variables during a simulation "property/atom"_fix_property_atom.html - add customized per-atom values -"python/invoke"_fix_python_invoke.html - +"python/invoke"_fix_python_invoke.html - call a Python function during a simulation "python/move"_fix_python_move.html - call a Python function during a simulation run -"qbmsst"_fix_qbmsst.html - +"qbmsst"_fix_qbmsst.html - quantum bath multi-scale shock technique time integrator "qeq/comb"_fix_qeq_comb.html - charge equilibration for COMB potential "qeq/dynamic"_fix_qeq.html - charge equilibration via dynamic method "qeq/fire"_fix_qeq.html - charge equilibration via FIRE minimizer @@ -308,13 +308,13 @@ accelerated styles exist. "qeq/shielded"_fix_qeq.html - charge equilibration via shielded method "qeq/slater"_fix_qeq.html - charge equilibration via Slater method "qmmm"_fix_qmmm.html - functionality to enable a quantum mechanics/molecular mechanics coupling -"qtb"_fix_qtb.html - +"qtb"_fix_qtb.html - implement quantum thermal bath scheme "rattle"_fix_shake.html - RATTLE constraints on bonds and/or angles "reax/c/bonds"_fix_reaxc_bonds.html - write out ReaxFF bond information "reax/c/species"_fix_reaxc_species.html - write out ReaxFF molecule information "recenter"_fix_recenter.html - constrain the center-of-mass position of a group of atoms "restrain"_fix_restrain.html - constrain a bond, angle, dihedral -"rhok"_fix_rhok.html - +"rhok"_fix_rhok.html - add bias potential for long-range ordered systems "rigid"_fix_rigid.html - constrain one or more clusters of atoms to move as a rigid body with NVE integration "rigid/meso"_fix_rigid_meso.html - constrain clusters of mesoscopic SPH/SDPD particles to move as a rigid body "rigid/nph"_fix_rigid.html - constrain one or more clusters of atoms to move as a rigid body with NPH integration @@ -327,11 +327,11 @@ accelerated styles exist. "rigid/nvt/small"_fix_rigid.html - constrain many small clusters of atoms to move as a rigid body with NVT integration "rigid/small"_fix_rigid.html - constrain many small clusters of atoms to move as a rigid body with NVE integration "rx"_fix_rx.html - -"saed/vtk"_fix_saed_vtk.html - +"saed/vtk"_fix_saed_vtk.html - "setforce"_fix_setforce.html - set the force on each atom "shake"_fix_shake.html - SHAKE constraints on bonds and/or angles "shardlow"_fix_shardlow.html - integration of DPD equations of motion using the Shardlow splitting -"smd"_fix_smd.html - +"smd"_fix_smd.html - applied a steered MD force to a group "smd/adjust_dt"_fix_smd_adjust_dt.html - "smd/integrate_tlsph"_fix_smd_integrate_tlsph.html - "smd/integrate_ulsph"_fix_smd_integrate_ulsph.html - @@ -356,7 +356,7 @@ accelerated styles exist. "ti/spring"_fix_ti_spring.html - "tmd"_fix_tmd.html - guide a group of atoms to a new configuration "ttm"_fix_ttm.html - two-temperature model for electronic/atomic coupling -"ttm/mod"_fix_ttm.html - +"ttm/mod"_fix_ttm.html - enhanced two-temperature model with additional options "tune/kspace"_fix_tune_kspace.html - auto-tune KSpace parameters "vector"_fix_vector.html - accumulate a global vector every N timesteps "viscosity"_fix_viscosity.html - Muller-Plathe momentum exchange for viscosity calculation @@ -364,7 +364,7 @@ accelerated styles exist. "wall/body/polygon"_fix_wall_body_polygon.html - "wall/body/polyhedron"_fix_wall_body_polyhedron.html - "wall/colloid"_fix_wall.html - Lennard-Jones wall interacting with finite-size particles -"wall/ees"_fix_wall_ees.html - +"wall/ees"_fix_wall_ees.html - wall for ellipsoidal particles "wall/gran"_fix_wall_gran.html - frictional wall(s) for granular simulations "wall/gran/region"_fix_wall_gran_region.html - "wall/harmonic"_fix_wall.html - harmonic spring wall @@ -374,7 +374,7 @@ accelerated styles exist. "wall/piston"_fix_wall_piston.html - moving reflective piston wall "wall/reflect"_fix_wall_reflect.html - reflecting wall(s) "wall/region"_fix_wall_region.html - use region surface as wall -"wall/region/ees"_fix_wall_ees.html - +"wall/region/ees"_fix_wall_ees.html - use region surface as wall for ellipsoidal particles "wall/srd"_fix_wall_srd.html - slip/no-slip wall for SRD particles :ul [Restrictions:] -- GitLab From d750cc02c0518739bc2f2ad4c1c4552d644cfe63 Mon Sep 17 00:00:00 2001 From: Anne Gunn Date: Wed, 31 Jul 2019 14:26:21 -0600 Subject: [PATCH 416/469] Changed the code in the read_F_table function to conform to the "expected behavior" description in #1572. Adopted a best-of-both-worlds approach, though, and processed the whole input file all the way through, emitting a message for each problem found, before issuing a final error message to stop processing. Updated doc to clarify requirement for uniform spacing of pressure correction points. --- doc/src/fix_bocs.txt | 4 +- src/USER-BOCS/fix_bocs.cpp | 76 +++++++++++++++++++++++++++++--------- 2 files changed, 60 insertions(+), 20 deletions(-) diff --git a/doc/src/fix_bocs.txt b/doc/src/fix_bocs.txt index db9c35069c..bb7ac3713c 100644 --- a/doc/src/fix_bocs.txt +++ b/doc/src/fix_bocs.txt @@ -47,13 +47,13 @@ or {cubic_spline}. With either spline method, the only argument that needs to follow it is the name of a file that contains the desired pressure correction -as a function of volume. The file should be formatted so each line has: +as a function of volume. The file must be formatted so each line has: Volume_i, PressureCorrection_i :pre Note both the COMMA and the SPACE separating the volume's value and its corresponding pressure correction. The volumes in the file -should be uniformly spaced. Both the volumes and the pressure corrections +must be uniformly spaced. Both the volumes and the pressure corrections should be provided in the proper units, e.g. if you are using {units real}, the volumes should all be in cubic angstroms, and the pressure corrections should all be in atmospheres. Furthermore, the table should start/end at a diff --git a/src/USER-BOCS/fix_bocs.cpp b/src/USER-BOCS/fix_bocs.cpp index 936e5ff58e..adce231bf1 100644 --- a/src/USER-BOCS/fix_bocs.cpp +++ b/src/USER-BOCS/fix_bocs.cpp @@ -59,6 +59,9 @@ enum{NOBIAS,BIAS}; enum{NONE,XYZ,XY,YZ,XZ}; enum{ISO,ANISO,TRICLINIC}; +// NB: Keep error and warning messages less than 255 chars long. +const int MAX_MESSAGE_LENGTH = 256; + /* ---------------------------------------------------------------------- NVT,NPH,NPT integrators for improved Nose-Hoover equations of motion ---------------------------------------------------------------------- */ @@ -630,24 +633,32 @@ int FixBocs::read_F_table( char *filename, int p_basis_type ) double **data = (double **) calloc(N_columns,sizeof(double *)); char * line = (char *) calloc(200,sizeof(char)); + bool badInput = false; + char badDataMsg[MAX_MESSAGE_LENGTH]; fpi = fopen(filename,"r"); if (fpi) { while (fgets(line,199,fpi)) { ++n_entries; } - fclose(fpi); + for (i = 0; i < N_columns; ++i) { data[i] = (double *) calloc(n_entries,sizeof(double)); } - } else { - char errmsg[128]; - snprintf(errmsg,128,"Unable to open file: %s\n",filename); - error->all(FLERR,errmsg); - } - n_entries = 0; - fpi = fopen(filename,"r"); - if (fpi) { + // Don't need to re-open the file to make a second pass through it + // simply rewind to beginning + rewind(fpi); + + double stdVolumeInterval = 0.0; + double currVolumeInterval = 0.0; + // When comparing doubles/floats, we need an Epsilon. + // The literature indicates getting this value right in the + // general case can be pretty complicated. I don't think it + // needs to be complicated here, though. At least based on the + // sample data I've seen where the volume values are fairly + // large. + const double volumeIntervalTolerance = 0.001; + n_entries = 0; while( fgets(line,199,fpi)) { ++n_entries; test_sscanf = sscanf(line," %f , %f ",&f1, &f2); @@ -655,19 +666,47 @@ int FixBocs::read_F_table( char *filename, int p_basis_type ) { data[0][n_entries-1] = (double) f1; data[1][n_entries-1] = (double) f2; + if (n_entries == 2) { + stdVolumeInterval = data[0][n_entries-1] - data[0][n_entries-2]; + } + else if (n_entries > 2) { + currVolumeInterval = data[0][n_entries-1] - data[0][n_entries-2]; + if (fabs(currVolumeInterval - stdVolumeInterval) > volumeIntervalTolerance) { + snprintf(badDataMsg,MAX_MESSAGE_LENGTH, + "BAD VOLUME INTERVAL: spline analysis requires uniform" + " volume distribution, found inconsistent volume" + " differential, line %d of file %s\n\tline: %s", + n_entries,filename,line); + error->message(FLERR,badDataMsg); + badInput = true; + } + } + // no else -- first entry is simply ignored } else { - fprintf(stderr,"WARNING: did not find 2 comma separated values in " - "line %d of file %s\n\tline: %s",n_entries,filename,line); + snprintf(badDataMsg,MAX_MESSAGE_LENGTH, + "BAD INPUT FORMAT: did not find 2 comma separated numeric" + " values in line %d of file %s\n\tline: %s", + n_entries,filename,line); + error->message(FLERR,badDataMsg); + badInput = true; } } - } else { - char errmsg[128]; - snprintf(errmsg,128,"Unable to open file: %s\n",filename); + fclose(fpi); + } + else { + char errmsg[MAX_MESSAGE_LENGTH]; + snprintf(errmsg,MAX_MESSAGE_LENGTH,"Unable to open file: %s\n",filename); + error->all(FLERR,errmsg); + } + + if (badInput) { + char errmsg[MAX_MESSAGE_LENGTH]; + snprintf(errmsg,MAX_MESSAGE_LENGTH, + "Bad volume / pressure-correction data: %s\nSee details above",filename); error->all(FLERR,errmsg); } - fclose(fpi); if (p_basis_type == 1) { @@ -691,9 +730,10 @@ int FixBocs::read_F_table( char *filename, int p_basis_type ) } else { - char * errmsg = (char *) calloc(70,sizeof(char)); - sprintf(errmsg,"ERROR: invalid p_basis_type value " - "of %d in read_F_table",p_basis_type); + char errmsg[MAX_MESSAGE_LENGTH]; + snprintf(errmsg, MAX_MESSAGE_LENGTH, + "ERROR: invalid p_basis_type value of %d in read_F_table", + p_basis_type); error->all(FLERR,errmsg); } // cleanup -- GitLab From eb7fa1b6cb6a545fc80a2f84c10b751d75bb5823 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 2 Aug 2019 17:04:59 -0400 Subject: [PATCH 417/469] Update CMake documentation --- cmake/README.md | 654 +++++++++++++++++++++++++++++----- doc/src/Build.txt | 1 + doc/src/Build_basics.txt | 24 ++ doc/src/Build_cmake.txt | 2 +- doc/src/Build_development.txt | 86 +++++ doc/src/Build_extras.txt | 6 +- doc/src/Packages_details.txt | 4 +- 7 files changed, 691 insertions(+), 86 deletions(-) create mode 100644 doc/src/Build_development.txt diff --git a/cmake/README.md b/cmake/README.md index c11326f9d5..95b2dd7447 100644 --- a/cmake/README.md +++ b/cmake/README.md @@ -33,12 +33,17 @@ tasks, act as a reference and provide examples of typical use cases. * [Package-Specific Configuration Options](#package-specific-configuration-options) * [KSPACE Package](#kspace-package) * [MKL](#mkl) - * [FFTW2](#fftw2) * [FFTW3](#fftw3) + * [BLAS](#blas) * [LAPACK](#lapack) * [PYTHON Package](#python-package) * [GPU Package](#gpu-package) + * [MESSAGE Package](#message-package) + * [MSCG Package](#mscg-package) * [VORONOI Package](#voronoi-package) + * [USER-LATTE Package](#user-latte-package) + * [USER-PLUMED Package](#user-plumed-package) + * [USER-SCAFACOS Package](#user-scafacos-package) * [USER-SMD Package](#user-smd-package) * [Optional Features](#optional-features) * [zlib support](#zlib-support) @@ -50,8 +55,6 @@ tasks, act as a reference and provide examples of typical use cases. * [Building with GNU Compilers](#building-with-gnu-compilers) * [Building with Intel Compilers](#building-with-intel-compilers) * [Building with LLVM/Clang Compilers](#building-with-llvmclang-compilers) - * [Examples](#examples) - ## Quick Start for the Impatient If you want to skip ahead and just run the compilation using `cmake`, please @@ -205,8 +208,10 @@ cmake -C ../cmake/presets/all_on.cmake -C ../cmake/presets/nolib.cmake -D PKG_GP Controls if debugging symbols are added to the generated binaries

-
Release (default)
+
RelWithDebInfo (default)
+
Release
Debug
+
MinSizeRel
@@ -249,6 +254,16 @@ cmake -C ../cmake/presets/all_on.cmake -C ../cmake/presets/nolib.cmake -D PKG_GP + + LAMMPS_LONGLONG_TO_LONG + Workaround if your system or MPI version does not recognize long long data types + +
+
off (default)
+
on
+
+ + LAMMPS_MEMALIGN controls the alignment of blocks of memory allocated by LAMMPS @@ -319,8 +334,8 @@ cmake -C ../cmake/presets/all_on.cmake -C ../cmake/presets/nolib.cmake -D PKG_GP - LAMMPS_LONGLONG_TO_LONG - Workaround if your system or MPI version does not recognize long long data types + BUILD_TOOLS + control whether to build LAMMPS tools
off (default)
@@ -561,23 +576,6 @@ cmake -C ../cmake/presets/all_on.cmake -C ../cmake/presets/nolib.cmake -D PKG_GP
- - PKG_MEAM - -

A pair style for the modified embedded atom (MEAM) potential.

- -

Please note that the MEAM package has been superseded by the USER-MEAMC package, -which is a direct translation of the MEAM package to C++. USER-MEAMC contains -additional optimizations making it run faster than MEAM on most machines, while -providing the identical features and USER interface.

- - -
-
off (default)
-
on
-
- - PKG_MISC @@ -634,21 +632,6 @@ providing the identical features and USER interface.

- - PKG_REAX - - A pair style which wraps a Fortran library which implements the ReaxFF - potential, which is a universal reactive force field. See the USER-REAXC - package for an alternate implementation in C/C++. Also a fix reax/bonds - command for monitoring molecules as bonds are created and destroyed. - - -
-
off (default)
-
on
-
- - PKG_REPLICA @@ -695,6 +678,16 @@ providing the identical features and USER interface.

+ + PKG_SPIN + Model atomic magnetic spins classically, coupled to atoms moving in the usual manner via MD. Various pair, fix, and compute styles. + +
+
off (default)
+
on
+
+ + PKG_SNAP @@ -757,6 +750,16 @@ providing the identical features and USER interface.

+ + PKG_MESSAGE + Commands to use LAMMPS as either a client or server and couple it to another application. + +
+
off (default)
+
on
+
+ + PKG_MSCG @@ -811,6 +814,18 @@ providing the identical features and USER interface.

+ + PKG_VORONOI + + A compute command which calculates the Voronoi tesselation of a collection of atoms by wrapping the Voro++ library. This can be used to calculate the local volume or each atoms or its near neighbors. + + +
+
off (default)
+
on
+
+ + @@ -825,6 +840,16 @@ providing the identical features and USER interface.

+ + PKG_USER-ADIOS + ADIOS is a high-performance I/O library. This package implements the dump “atom/adios” and dump “custom/adios” commands to write data using the ADIOS library. + +
+
off (default)
+
on
+
+ + PKG_USER-ATC @@ -853,6 +878,18 @@ providing the identical features and USER interface.

+ + PKG_USER-BOCS + + This package provides fix bocs, a modified version of fix npt which includes the pressure correction to the barostat as outlined in: N. J. H. Dunn and W. G. Noid, “Bottom-up coarse-grained models that accurately describe the structure, pressure, and compressibility of molecular liquids,” J. Chem. Phys. 143, 243148 (2015). + + +
+
off (default)
+
on
+
+ + PKG_USER-CGDNA @@ -1142,6 +1179,30 @@ providing the identical features and USER interface.

+ + PKG_USER-PLUMED + + The fix plumed command allows you to use the PLUMED free energy plugin for molecular dynamics to analyze and bias your LAMMPS trajectory on the fly. The PLUMED library is called from within the LAMMPS input script by using the fix plumed command. + + +
+
off (default)
+
on
+
+ + + + PKG_USER-PTM + + A compute ptm/atom command that calculates local structure characterization using the Polyhedral Template Matching methodology. + + +
+
off (default)
+
on
+
+ + PKG_USER-QTB @@ -1197,6 +1258,33 @@ providing the identical features and USER interface.

+ + PKG_USER-SCAFACOS + + A KSpace style which wraps the ScaFaCoS Coulomb solver library to compute long-range Coulombic interactions. + + +
+
off (default)
+
on
+
+ + + + PKG_USER-SDPD + + A pair style for smoothed dissipative particle dynamics (SDPD), which is an + extension of smoothed particle hydrodynamics (SPH) to mesoscale where thermal + fluctuations are important (see the USER-SPH package). Also two fixes for + moving and rigid body integration of SPH/SDPD particles (particles of + atom_style meso). + +
+
off (default)
+
on
+
+ + PKG_USER-SMD @@ -1280,6 +1368,23 @@ providing the identical features and USER interface.

+ + PKG_USER-YAFF + + Some potentials that are also implemented in the Yet Another Force Field (YAFF) code. + The expressions and their use are discussed in the following papers: +
+ + +
+
off (default)
+
on
+
+ + @@ -1300,14 +1405,27 @@ providing the identical features and USER interface.

FFT

FFT library for KSPACE package

-

If either MKL or FFTW is selected cmake will try to locate these libraries automatically. To control which one should be used please see the options below for each FFT library.

+

If either MKL or FFTW is selected cmake will try to locate + these libraries automatically. To control which one should be used please see + the options below for each FFT library. Otherwise it will default to KISS + FFT.

-
KISS
FFTW3
FFTW2
MKL
+
KISS (default)
+
+ + + + FFT_SINGLE + Use single-precision floating-point in FFT + +
+
off (default = double precision)
+
on
@@ -1325,7 +1443,7 @@ providing the identical features and USER interface.

-### MKL +### FFTW3 @@ -1337,23 +1455,21 @@ providing the identical features and USER interface.

- - + + - - + +
MKL_INCLUDE_DIRSFFTW3_INCLUDE_DIRSpath to FFTW3 include files
MKL_LIBRARIESFFTW3_LIBRARIESlist of paths to FFTW3 libraries
-TODO static vs dynamic linking - -### FFTW2 +### MKL @@ -1365,51 +1481,32 @@ TODO static vs dynamic linking - - + + - - + +
FFTW2_INCLUDE_DIRSMKL_INCLUDE_DIRSpath to MKL include files
FFTW2_LIBRARIESMKL_LIBRARIESlist of paths to MKL libraries
-### FFTW3 +### BLAS - - - - - - - - - - - - - - - - - - - - -
OptionDescriptionValues
FFTW3_INCLUDE_DIRS -
FFTW3_LIBRARIES -
+See [FindBLAS documentation](https://cmake.org/cmake/help/latest/module/FindBLAS.html) ### LAPACK -TODO + +See [FindLAPACK documentation](https://cmake.org/cmake/help/latest/module/FindLAPACK.html) ### PYTHON Package +See [FindPYTHON documentation](https://cmake.org/cmake/help/latest/module/FindPython.html) + ### USER-INTEL Package @@ -1499,10 +1596,11 @@ target API. @@ -1534,13 +1632,273 @@ target API.
sm_20 (Fermi)
-
sm_30 (Kepler)
+
sm_30 (Kepler) (default)
sm_50 (Maxwell)
sm_60 (Pascal)
sm_70 (Volta)
+
sm_75 (Turing)
+### KIM Package + +Requires installation of the KIM library with API v2 + +If `DOWNLOAD_KIM` is set, the KIM library will be downloaded and built inside +the CMake build directory. If the KIM library is already on your system (in a +location CMake cannot find it), set the `PKG_CONFIG_PATH` environment variable +so that `libkim-api` can be found. + + + + + + + + + + + + + + + + +
OptionDescriptionValues
DOWNLOAD_KIMDownload KIM API v2 and compile it as part of the build. +
+
off (default)
+
on
+
+
+ +### MESSAGE Package + +This package can optionally include support for messaging via sockets, using the open-source [ZeroMQ library](http://zeromq.org/), which must be installed on your system. + + + + + + + + + + + + + + + + + + + + + + + + + + +
OptionDescriptionValues
MESSAGE_ZMQBuild with ZeroMQ support +
+
off (default)
+
on
+
+
ZMQ_LIBRARY + ZMQ library file (only needed if at custom location) + +
ZMG_INCLUDE_DIR + Provide include directory of existing ZMQ installation (only needed if at custom location) + +
+ +### MSCG Package + +Requires installation of the MSCG library + + + + + + + + + + + + + + + + + + + + + + + + + + +
OptionDescriptionValues
DOWNLOAD_MSCGDownload MSCG and compile it as part of the build +
+
off (default)
+
on
+
+
MSCG_LIBRARY + MSCG library file (only needed if at custom location) + +
MSCG_INCLUDE_DIR + Provide include directory of existing MSCG installation (only needed if at custom location) + +
+ ### VORONOI Package -TODO +Requires installation of the Voro++ library + + + + + + + + + + + + + + + + + + + + + + + + + + +
OptionDescriptionValues
DOWNLOAD_VORODownload Voro++ and compile it as part of the build +
+
off (default)
+
on
+
+
VORO_LIBRARY + Voro++ library file (only needed if at custom location) + +
VORO_INCLUDE_DIR + Provide include directory of existing Voro++ installation (only needed if at custom location) + +
+ +### USER-LATTE Package + +Requires installation of the LATTE library + + + + + + + + + + + + + + + + + + + + + +
OptionDescriptionValues
DOWNLOAD_LATTEDownload LATTE and compile it as part of the build +
+
off (default)
+
on
+
+
LATTE_LIBRARY + LATTE library file (only needed if at custom location) + +
+ +### USER-PLUMED Package + +Requires installation of the PLUMED library + + + + + + + + + + + + + + + + + + + + + +
OptionDescriptionValues
DOWNLOAD_PLUMEDDownload PLUMED and compile it as part of the build +
+
off (default)
+
on
+
+
PLUMED_MODE + Determines the linkage mode for the PLUMED library. + +
+
static (default)
+
shared
+
runtime
+
+
+ +### USER-LATTE Package + +Requires installation of the LATTE library + + + + + + + + + + + + + + + + + + + + + +
OptionDescriptionValues
DOWNLOAD_LATTEDownload LATTE and compile it as part of the build +
+
off (default)
+
on
+
+
LATTE_LIBRARY + LATTE library file (only needed if at custom location) + +
### USER-SMD Package -Requires a Eigen3 installation +Requires installation of the Eigen3 library @@ -1551,9 +1909,64 @@ Requires a Eigen3 installation + + + + + - + + + + +
DOWNLOAD_EIGEN3Download Eigen3 and compile it as part of the build +
+
off (default)
+
on
+
+
EIGEN3_INCLUDE_DIR + Provide include directory of existing Eigen3 installation (only needed if at custom location) + +
+ + +### USER-SCAFACOS Package + +To build with this package, you must download and build the [ScaFaCoS Coulomb solver library](http://www.scafacos.de/) + + + + + + + + + + + + + + + + + + + + + + + @@ -1791,5 +2204,82 @@ cmake -D CMAKE_C_COMPILER=icc -D CMAKE_CXX_COMPILER=icpc -D CMAKE_Fortran_COMPIL cmake -D CMAKE_C_COMPILER=clang -D CMAKE_CXX_COMPILER=clang++ -D CMAKE_Fortran_COMPILER=flang ../cmake ``` +## LAMMPS Developer Options + -## Examples +
OptionDescriptionValues
DOWNLOAD_SCAFACOSDownload SCAFACOS and compile it as part of the build +
+
off (default)
+
on
+
+
SCAFACOS_LIBRARY + SCAFACOS library file (only needed if at custom location) + +
SCAFACOS_INCLUDE_DIR + SCAFACOS include directory (only needed if at custom location) +
+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
OptionDescriptionValues
ENABLE_TESTINGControl wheather to add tests via CTest +
+
off (default)
+
on
+
+
LAMMPS_TESTING_SOURCE_DIRCustom location of lammps-testing repository (optional). If not specified it will download it via Git +
LAMMPS_TESTING_GIT_TAGIf lammps-testing repository is cloned, this is the tag/commit that will be checked out +
+
master (default)
+
+
ENABLE_COVERAGEEnables code coverage support via gcov and adds a gcovr build target to generate a coverage report. +
+
off (default)
+
on
+
+
ENABLE_SANITIZE_ADDRESSEnables Address Sanitizer support when compiling using GCC or Clang for detecting memory leaks in binaries while running them. See https://clang.llvm.org/docs/AddressSanitizer.html +
+
off (default)
+
on
+
+
ENABLE_SANITIZE_UNDEFINEDEnables Undefined Behavior Sanitizer support when compiling using GCC or Clang for detecting code that is running into undefined behavior of the language. See https://clang.llvm.org/docs/UndefinedBehaviorSanitizer.html +
+
off (default)
+
on
+
+
ENABLE_SANITIZE_THREADEnables Thread Sanitizer support when compiling using GCC or Clang for detecting data races in binaries while running them. See https://clang.llvm.org/docs/ThreadSanitizer.html +
+
off (default)
+
on
+
+
diff --git a/doc/src/Build.txt b/doc/src/Build.txt index df30af36f5..50d62ac889 100644 --- a/doc/src/Build.txt +++ b/doc/src/Build.txt @@ -29,6 +29,7 @@ as described on the "Install"_Install.html doc page. Build_package Build_extras Build_windows + Build_development END_RST --> diff --git a/doc/src/Build_basics.txt b/doc/src/Build_basics.txt index fa4ef12586..411e7858ac 100644 --- a/doc/src/Build_basics.txt +++ b/doc/src/Build_basics.txt @@ -310,6 +310,30 @@ current LAMMPS version (HTML and PDF files), from the website :line +Build LAMMPS tools :h4,link(tools) + +Some tools described in "Auxiliary tools"_Tools.html can be built directly +using CMake or Make. + +[CMake variable]: + +-D BUILD_TOOLS=value # yes or no (default) :pre + +The generated binaries will also become part of the LAMMPS installation (see below) + +[Traditional make]: + +cd lammps/tools +make all # build all binaries of tools +make binary2txt # build only binary2txt tool +make chain # build only chain tool +make micelle2d # build only micelle2d tool +make thermo_extract # build only thermo_extract tool +:pre + +:line + + Install LAMMPS after a build :h4,link(install) After building LAMMPS, you may wish to copy the LAMMPS executable of diff --git a/doc/src/Build_cmake.txt b/doc/src/Build_cmake.txt index 6eb23b2bb5..b2411272eb 100644 --- a/doc/src/Build_cmake.txt +++ b/doc/src/Build_cmake.txt @@ -120,7 +120,7 @@ The argument can be preceeded or followed by various CMake command-line options. Several useful ones are: -D CMAKE_INSTALL_PREFIX=path # where to install LAMMPS executable/lib if desired --D CMAKE_BUILD_TYPE=type # type = Release or Debug +-D CMAKE_BUILD_TYPE=type # type = RelWithDebInfo (default), Release, MinSizeRel, or Debug -G output # style of output CMake generates -DVARIABLE=value # setting for a LAMMPS feature to enable -D VARIABLE=value # ditto, but cannot come after CMakeLists.txt dir diff --git a/doc/src/Build_development.txt b/doc/src/Build_development.txt new file mode 100644 index 0000000000..7ce4b0e8a6 --- /dev/null +++ b/doc/src/Build_development.txt @@ -0,0 +1,86 @@ +"Higher level section"_Build.html - "LAMMPS WWW Site"_lws - "LAMMPS +Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Commands_all.html) + +:line + +Development options (CMake only) :h3 + +The CMake build of LAMMPS has a few extra options which are useful during +development, testing or debugging. + +:line + +Verify compilation flags :h4,link(compilation) + +Sometimes it is necessary to verify the complete sequence of compilation flags +generated by the CMake build. To enable a more verbose output during +compilation you can use the following option. + +-D CMAKE_VERBOSE_MAKEFILE=value # value = no (default) or yes :pre + +Another way of doing this without reconfiguration is calling make with variable VERBOSE set to 1: + +make VERBOSE=1 :pre + +:line + +Address, Undefined Behavior, and Thread Sanitizer Support :h4,link(sanitizer) + +Compilers such as GCC and Clang support generating binaries which use different +sanitizers to detect problems in code during run-time. They can detect "memory leaks"_https://clang.llvm.org/docs/AddressSanitizer.html, +code that runs into "undefined behavior"_https://clang.llvm.org/docs/UndefinedBehaviorSanitizer.html of the +language and "data races"_https://clang.llvm.org/docs/ThreadSanitizer.html in threaded code. + +The following settings allow you enable these features if your compiler supports +it. Please note that they come with a performance hit. However, they are +usually faster than using tools like Valgrind. + +-D ENABLE_SANITIZE_ADDRESS=value # enable Address Sanitizer, value = no (default) or yes +-D ENABLE_SANITIZE_UNDEFINED=value # enable Undefined Behaviour Sanitizer, value = no (default) or yes +-D ENABLE_SANITIZE_THREAD=value # enable Thread Sanitizer, value = no (default) or yes +:pre + +:line + +Code Coverage and Testing :h4,link(testing) + +We do extensive regression testing of the LAMMPS code base on a continuous +basis. Some of the logic to do this has been added to the CMake build so +developers can run the tests directly on their workstation. + +NOTE: this is incomplete and only represents a small subset of tests that we run + +-D ENABLE_TESTING=value # enable simple run tests of LAMMPS, value = no (default) or yes +-D LAMMPS_TESTING_SOURCE_DIR=path # path to lammps-testing repository (option if in custom location) +-D LAMMPS_TESTING_GIT_TAG=value # version of lammps-testing repository that should be used, value = master (default) or custom git commit or tag +:pre + +If you enable testing in the CMake build it will create an additional target called "test". You can run them with: + +make test +:pre + +The test cases used come from the lammps-testing repository. They are +derivatives of the examples folder with some modifications to make the run +faster. + +You can also collect code coverage metrics while running the tests by enabling +coverage support during building. + +-D ENABLE_COVERAGE=value # enable coverage measurements, value = no (default) or yes :pre + +This will also add the following targets to generate coverage reports after running the LAMMPS executable: + +make test # run tests first! +make gen_coverage_html # generate coverage report in HTML format +make gen_coverage_xml # generate coverage report in XML format +:pre + +These reports require GCOVR to be installed. The easiest way to do this to install it via pip: + +pip install git+https://github.com/gcovr/gcovr.git :pre +:pre diff --git a/doc/src/Build_extras.txt b/doc/src/Build_extras.txt index e6791de21b..b0bf0c9cd6 100644 --- a/doc/src/Build_extras.txt +++ b/doc/src/Build_extras.txt @@ -88,7 +88,7 @@ which GPU hardware to build for. # generic (default) or intel (Intel CPU) or fermi, kepler, cypress (NVIDIA) -D GPU_ARCH=value # primary GPU hardware choice for GPU_API=cuda # value = sm_XX, see below - # default is Cuda-compiler dependent, but typically sm_20 + # default is sm_30 -D CUDPP_OPT=value # optimization setting for GPU_API=cuda # enables CUDA Performance Primitives Optimizations # value = yes (default) or no @@ -354,6 +354,9 @@ be installed on your system. [CMake build]: -D MESSAGE_ZMQ=value # build with ZeroMQ support, value = no (default) or yes +-D ZMQ_LIBRARY=path # ZMQ library file (only needed if a custom location) +-D ZMQ_INCLUDE_DIR=path # ZMQ include directory (only needed if a custom location) +:pre [Traditional make]: @@ -366,6 +369,7 @@ simply invoke the lib/message/Install.py script with the specified args: make lib-message # print help message make lib-message args="-m -z" # build with MPI and socket (ZMQ) support make lib-message args="-s" # build as serial lib with no ZMQ support +:pre The build should produce two files: lib/message/cslib/src/libmessage.a and lib/message/Makefile.lammps. The latter is copied from an diff --git a/doc/src/Packages_details.txt b/doc/src/Packages_details.txt index 43274a9606..47341239f7 100644 --- a/doc/src/Packages_details.txt +++ b/doc/src/Packages_details.txt @@ -1,4 +1,4 @@ -"Higher level section"_Packages.html - "LAMMPS WWW Site"_lws - "LAMMPS +tion"_Packages.html - "LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c :link(lws,http://lammps.sandia.gov) @@ -1191,7 +1191,7 @@ USER-PLUMED package :link(PKG-USER-PLUMED),h4 The fix plumed command allows you to use the PLUMED free energy plugin for molecular dynamics to analyze and bias your LAMMPS trajectory on the fly. The PLUMED library is called from within the LAMMPS input -script by using the "fix plumed _fix_plumed.html command. +script by using the "fix plumed"_fix_plumed.html command. [Authors:] The "PLUMED library"_#PLUMED is written and maintained by Massimilliano Bonomi, Giovanni Bussi, Carlo Camiloni and Gareth -- GitLab From bd87b672327e10c8e1eaa3a99c8628ab0e9091b3 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 2 Aug 2019 17:35:26 -0400 Subject: [PATCH 418/469] Update false_positives.txt --- doc/utils/sphinx-config/false_positives.txt | 2 ++ 1 file changed, 2 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 1dea229393..67252659bb 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -2443,6 +2443,8 @@ Salles sandia Sandia sandybrown +Sanitizer +sanitizers sc scafacos SCAFACOS -- GitLab From 91fdd98fbc35f2a078e69551236786610a5190a9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 2 Aug 2019 18:44:40 -0400 Subject: [PATCH 419/469] restore accidentally deleted text --- doc/src/Packages_details.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/Packages_details.txt b/doc/src/Packages_details.txt index 47341239f7..eead133add 100644 --- a/doc/src/Packages_details.txt +++ b/doc/src/Packages_details.txt @@ -1,4 +1,4 @@ -tion"_Packages.html - "LAMMPS WWW Site"_lws - "LAMMPS +"Higher level section"_Packages.html - "LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c :link(lws,http://lammps.sandia.gov) -- GitLab From 0774e92ecea9aeaed8a8f0ad1cea7cc635f44224 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 3 Aug 2019 06:40:31 -0400 Subject: [PATCH 420/469] use KIM-API 2.1.2 consistently with CMake and conventional build system --- lib/kim/Install.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/lib/kim/Install.py b/lib/kim/Install.py index de22950639..836b5ba205 100644 --- a/lib/kim/Install.py +++ b/lib/kim/Install.py @@ -18,7 +18,7 @@ parser = ArgumentParser(prog='Install.py', # settings thisdir = fullpath('.') -version = "kim-api-2.1.1" +version = "kim-api-2.1.2" # help message -- GitLab From faefcc776a70b490ee70c2522c5c2d99c6322ec4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 3 Aug 2019 10:38:41 -0400 Subject: [PATCH 421/469] sched_getaffinity() is a Linux specific system call. add preprocessor guards --- src/USER-INTEL/verlet_lrt_intel.cpp | 6 ++++-- 1 file changed, 4 insertions(+), 2 deletions(-) diff --git a/src/USER-INTEL/verlet_lrt_intel.cpp b/src/USER-INTEL/verlet_lrt_intel.cpp index 2b28eea3a2..a3c05c46bc 100644 --- a/src/USER-INTEL/verlet_lrt_intel.cpp +++ b/src/USER-INTEL/verlet_lrt_intel.cpp @@ -102,18 +102,20 @@ void VerletLRTIntel::setup(int flag) } #if defined(_LMP_INTEL_LRT_PTHREAD) + #if defined(__linux) if (comm->me == 0) { cpu_set_t cpuset; sched_getaffinity(0, sizeof(cpuset), &cpuset); int my_cpu_count = CPU_COUNT(&cpuset); if (my_cpu_count < comm->nthreads + 1) { char str[128]; - sprintf(str,"Using %d threads per MPI, but only %d core(s) allocated" - " per MPI", + sprintf(str,"Using %d threads per MPI rank, but only %d core(s)" + " allocated for each MPI rank", comm->nthreads + 1, my_cpu_count); error->warning(FLERR, str); } } + #endif _kspace_ready = 0; _kspace_done = 0; -- GitLab From 5b3423c60eb48444f959fe63d5e03ec6b09c0571 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 3 Aug 2019 11:16:14 -0400 Subject: [PATCH 422/469] tweaks for Linux to Windows cross-compilation --- cmake/CMakeLists.txt | 1 + cmake/presets/mingw-cross.cmake | 7 +++---- 2 files changed, 4 insertions(+), 4 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 187b41e980..fd4cd51662 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -229,6 +229,7 @@ if(PKG_MSCG OR PKG_USER-ATC OR PKG_USER-AWPMD OR PKG_USER-QUIP OR PKG_LATTE) enable_language(Fortran) file(GLOB LAPACK_SOURCES ${LAMMPS_LIB_SOURCE_DIR}/linalg/[^.]*.[fF]) add_library(linalg STATIC ${LAPACK_SOURCES}) + set(BLAS_LIBRARIES linalg) set(LAPACK_LIBRARIES linalg) else() list(APPEND LAPACK_LIBRARIES ${BLAS_LIBRARIES}) diff --git a/cmake/presets/mingw-cross.cmake b/cmake/presets/mingw-cross.cmake index b53e5a7b93..2ac24490bc 100644 --- a/cmake/presets/mingw-cross.cmake +++ b/cmake/presets/mingw-cross.cmake @@ -3,9 +3,9 @@ set(WIN_PACKAGES ASPHERE BODY CLASS2 COLLOID COMPRESS CORESHELL DIPOLE GPU REPLICA RIGID SHOCK SNAP SPIN SRD VORONOI USER-ATC USER-AWPMD USER-BOCS USER-CGDNA USER-CGSDK USER-COLVARS USER-DIFFRACTION USER-DPD USER-DRUDE USER-EFF USER-FEP USER-INTEL USER-MANIFOLD - USER-MEAMC USER-MESO USER-MISC USER-MOFFF USER-MOLFILE USER-OMP - USER-PHONON USER-PTM USER-QTB USER-REAXC USER-SDPD USER-SMD - USER-SMTBQ USER-SPH USER-TALLY USER-UEF USER-YAFF) + USER-MEAMC USER-MESO USER-MISC USER-MGPT USER-MOFFF USER-MOLFILE + USER-OMP USER-PHONON USER-PTM USER-QTB USER-REAXC USER-SDPD + USER-SMD USER-SMTBQ USER-SPH USER-TALLY USER-UEF USER-YAFF) foreach(PKG ${WIN_PACKAGES}) set(PKG_${PKG} ON CACHE BOOL "" FORCE) @@ -14,4 +14,3 @@ endforeach() set(DOWNLOAD_VORO ON CACHE BOOL "" FORCE) set(DOWNLOAD_EIGEN3 ON CACHE BOOL "" FORCE) set(LAMMPS_MEMALIGN "0" CACHE STRING "" FORCE) -set(INTEL_LRT_MODE "none" CACHE STRING "" FORCE) -- GitLab From d82ae64d16778523fb0460b4ac3894cf6ffd01dd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 3 Aug 2019 11:16:55 -0400 Subject: [PATCH 423/469] minor tweak for consistency --- src/info.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/info.cpp b/src/info.cpp index 21297c52c6..caa2d6fdd0 100644 --- a/src/info.cpp +++ b/src/info.cpp @@ -60,7 +60,7 @@ #include #endif -#if defined __linux +#if defined(__linux) #include #endif -- GitLab From b65ae605e5d8f6ce7b6225ddbafafc2188f86421 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 3 Aug 2019 15:17:18 -0400 Subject: [PATCH 424/469] Added one-liner for HTML-only docs in Build.txt --- doc/src/Build.txt | 3 ++- doc/src/Build_development.txt | 2 +- 2 files changed, 3 insertions(+), 2 deletions(-) diff --git a/doc/src/Build.txt b/doc/src/Build.txt index 50d62ac889..8906549350 100644 --- a/doc/src/Build.txt +++ b/doc/src/Build.txt @@ -42,7 +42,8 @@ END_RST --> "Optional build settings"_Build_settings.html "Include packages in build"_Build_package.html "Packages with extra build options"_Build_extras.html -"Notes for building LAMMPS on Windows"_Build_windows.html :all(b) +"Notes for building LAMMPS on Windows"_Build_windows.html +"Development build options (CMake only)"_Build_development.html :all(b) If you have problems building LAMMPS, it is often due to software issues on your local machine. If you can, find a local expert to diff --git a/doc/src/Build_development.txt b/doc/src/Build_development.txt index 7ce4b0e8a6..16a3d3d20e 100644 --- a/doc/src/Build_development.txt +++ b/doc/src/Build_development.txt @@ -7,7 +7,7 @@ Documentation"_ld - "LAMMPS Commands"_lc :c :line -Development options (CMake only) :h3 +Development build options (CMake only) :h3 The CMake build of LAMMPS has a few extra options which are useful during development, testing or debugging. -- GitLab From 58d27403f15fc8e0e92bfa8f73f5665dd08a2753 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 4 Aug 2019 18:28:26 -0400 Subject: [PATCH 425/469] CMake tweaks to improve building LAMMPS for windows with mingw on Linux --- cmake/CMakeLists.txt | 29 +++++++++++++++++++++++++---- cmake/presets/mingw-cross.cmake | 3 +++ 2 files changed, 28 insertions(+), 4 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index fd4cd51662..e961fe25d3 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -133,6 +133,24 @@ foreach(PKG ${DEFAULT_PACKAGES} ${ACCEL_PACKAGES}) option(PKG_${PKG} "Build ${PKG} Package" OFF) endforeach() +###################################################### +# download and unpack support binaries for compilation +# of windows binaries. +###################################################### +if(${CMAKE_SYSTEM_NAME} STREQUAL "Windows") + set(LAMMPS_THIRDPARTY_URL "http://download.lammps.org/thirdparty") + file(DOWNLOAD "${LAMMPS_THIRDPARTY_URL}/opencl-win-devel.tar.gz" "${CMAKE_CURRENT_BINARY_DIR}/opencl-win-devel.tar.gz" + EXPECTED_MD5 2c00364888d5671195598b44c2e0d44d) + execute_process(COMMAND ${CMAKE_COMMAND} -E tar xzf opencl-win-devel.tar.gz WORKING_DIRECTORY ${CMAKE_CURRENT_BINARY_DIR}) + if(${CMAKE_SYSTEM_PROCESSOR} STREQUAL "x86") + set(OpenCL_LIBRARY "${CMAKE_CURRENT_BINARY_DIR}/OpenCL/lib_win32/libOpenCL.dll") + elseif(${CMAKE_SYSTEM_PROCESSOR} STREQUAL "x86_64") + set(OpenCL_LIBRARY "${CMAKE_CURRENT_BINARY_DIR}/OpenCL/lib_win64/libOpenCL.dll") + endif() + set(OpenCL_INCLUDE_DIR "${CMAKE_CURRENT_BINARY_DIR}/OpenCL/include") +endif() + +###################################################### ###################################################### # packages with special compiler needs or external libs ###################################################### @@ -148,6 +166,7 @@ if(PKG_USER-ADIOS) endif() # do MPI detection after language activation, if MPI for these language is required +set(MPI_CXX_SKIP_MPICXX TRUE) find_package(MPI QUIET) option(BUILD_MPI "Build MPI version" ${MPI_FOUND}) if(BUILD_MPI) @@ -175,11 +194,13 @@ add_definitions(-DLAMMPS_${LAMMPS_SIZES}) set(LAMMPS_API_DEFINES "${LAMMPS_API_DEFINES} -DLAMMPS_${LAMMPS_SIZES}") # posix_memalign is not available on Windows -if(NOT ${CMAKE_SYSTEM_NAME} STREQUAL "Windows") +if(${CMAKE_SYSTEM_NAME} STREQUAL "Windows") + set(LAMMPS_MEMALIGN "0" CACHE STRING "posix_memalign() is not available on Windows" FORCE) +else() set(LAMMPS_MEMALIGN "64" CACHE STRING "enables the use of the posix_memalign() call instead of malloc() when large chunks or memory are allocated by LAMMPS. Set to 0 to disable") - if(NOT ${LAMMPS_MEMALIGN} STREQUAL "0") - add_definitions(-DLAMMPS_MEMALIGN=${LAMMPS_MEMALIGN}) - endif() +endif() +if(NOT ${LAMMPS_MEMALIGN} STREQUAL "0") + add_definitions(-DLAMMPS_MEMALIGN=${LAMMPS_MEMALIGN}) endif() option(LAMMPS_EXCEPTIONS "enable the use of C++ exceptions for error messages (useful for library interface)" OFF) diff --git a/cmake/presets/mingw-cross.cmake b/cmake/presets/mingw-cross.cmake index 2ac24490bc..fbec42529f 100644 --- a/cmake/presets/mingw-cross.cmake +++ b/cmake/presets/mingw-cross.cmake @@ -13,4 +13,7 @@ endforeach() set(DOWNLOAD_VORO ON CACHE BOOL "" FORCE) set(DOWNLOAD_EIGEN3 ON CACHE BOOL "" FORCE) +set(WITH_GZIP ON CACHE BOOL "" FORCE) +set(WITH_FFMPEG ON CACHE BOOL "" FORCE) set(LAMMPS_MEMALIGN "0" CACHE STRING "" FORCE) +set(CMAKE_INSTALL_PREFIX "${CMAKE_CURRENT_BINARY_DIR}/lammps-installer") -- GitLab From f2757eaf4182a883583278295a8961b60b3aebd3 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Mon, 5 Aug 2019 13:58:11 -0400 Subject: [PATCH 426/469] Mention LAMMPS_LIB_SUFFIX in docs --- cmake/README.md | 11 ++++++++++- doc/src/Build_basics.txt | 8 ++++++-- 2 files changed, 16 insertions(+), 3 deletions(-) diff --git a/cmake/README.md b/cmake/README.md index 95b2dd7447..01b6f6a60e 100644 --- a/cmake/README.md +++ b/cmake/README.md @@ -286,7 +286,16 @@ cmake -C ../cmake/presets/all_on.cmake -C ../cmake/presets/nolib.cmake -D PKG_GP LAMMPS_MACHINE - allows appending a machine suffix to the generate LAMMPS binary + allows appending a machine suffix to the generated LAMMPS binary + +
+
*none* (default)
+
+ + + + LAMMPS_LIB_SUFFIX + allows appending a suffix to the generated LAMMPS library
*none* (default)
diff --git a/doc/src/Build_basics.txt b/doc/src/Build_basics.txt index 411e7858ac..04e11009af 100644 --- a/doc/src/Build_basics.txt +++ b/doc/src/Build_basics.txt @@ -235,12 +235,16 @@ running LAMMPS from Python via its library interface. -D BUILD_EXE=value # yes (default) or no -D BUILD_LIB=value # yes or no (default) --D BUILD_SHARED_LIBS=value # yes or no (default) :pre +-D BUILD_SHARED_LIBS=value # yes or no (default) +-D LAMMPS_LIB_SUFFIX=name # name = mpi, serial, mybox, titan, laptop, etc + # no default value :pre + Setting BUILD_EXE=no will not produce an executable. Setting BUILD_LIB=yes will produce a static library named liblammps.a. Setting both BUILD_LIB=yes and BUILD_SHARED_LIBS=yes will produce a -shared library named liblammps.so. +shared library named liblammps.so. If LAMMPS_LIB_SUFFIX is set the generated +libraries will be named liblammps_name.a or liblammps_name.so instead. [Traditional make]: -- GitLab From 51ba9bd52069f34d0c112a1182660192bc81192c Mon Sep 17 00:00:00 2001 From: Giacomo Fiorin Date: Mon, 5 Aug 2019 14:12:38 -0400 Subject: [PATCH 427/469] Bugfix for Colvars library (update to version 2019-08-05) Bugfix for group2CenterOnly (coordNum option): https://github.com/Colvars/colvars/pull/278 --- lib/colvars/colvaratoms.cpp | 42 +++++++--- lib/colvars/colvaratoms.h | 6 ++ lib/colvars/colvarcomp.h | 10 ++- lib/colvars/colvarcomp_coordnums.cpp | 117 +++++++++------------------ lib/colvars/colvars_version.h | 2 +- 5 files changed, 80 insertions(+), 97 deletions(-) diff --git a/lib/colvars/colvaratoms.cpp b/lib/colvars/colvaratoms.cpp index eeb7985fec..af17d8df66 100644 --- a/lib/colvars/colvaratoms.cpp +++ b/lib/colvars/colvaratoms.cpp @@ -178,6 +178,31 @@ int cvm::atom_group::remove_atom(cvm::atom_iter ai) } +int cvm::atom_group::set_dummy() +{ + if (atoms_ids.size() > 0) { + return cvm::error("Error: setting group with keyword \""+key+ + "\" and name \""+name+"\" as dummy, but it already " + "contains atoms.\n", INPUT_ERROR); + } + b_dummy = true; + return COLVARS_OK; +} + + +int cvm::atom_group::set_dummy_pos(cvm::atom_pos const &pos) +{ + if (b_dummy) { + dummy_atom_pos = pos; + } else { + return cvm::error("Error: setting dummy position for group with keyword \""+ + key+"\" and name \""+name+ + "\", but it is not dummy.\n", INPUT_ERROR); + } + return COLVARS_OK; +} + + int cvm::atom_group::init() { if (!key.size()) key = "unnamed"; @@ -469,20 +494,15 @@ int cvm::atom_group::parse(std::string const &group_conf) // checks of doubly-counted atoms have been handled by add_atom() already if (get_keyval(group_conf, "dummyAtom", dummy_atom_pos, cvm::atom_pos())) { - b_dummy = true; - // note: atoms_ids.size() is used here in lieu of atoms.size(), - // which can be empty for scalable groups - if (atoms_ids.size()) { - cvm::error("Error: cannot set up group \""+ - key+"\" as a dummy atom " - "and provide it with atom definitions.\n", INPUT_ERROR); - } + + parse_error |= set_dummy(); + parse_error |= set_dummy_pos(dummy_atom_pos); + } else { - b_dummy = false; if (!(atoms_ids.size())) { - cvm::error("Error: no atoms defined for atom group \""+ - key+"\".\n", INPUT_ERROR); + parse_error |= cvm::error("Error: no atoms defined for atom group \""+ + key+"\".\n", INPUT_ERROR); } // whether these atoms will ever receive forces or not diff --git a/lib/colvars/colvaratoms.h b/lib/colvars/colvaratoms.h index 9756e0e364..c8b6ac4541 100644 --- a/lib/colvars/colvaratoms.h +++ b/lib/colvars/colvaratoms.h @@ -207,6 +207,12 @@ public: /// \brief Remove an atom object from this group int remove_atom(cvm::atom_iter ai); + /// Set this group as a dummy group (no actual atoms) + int set_dummy(); + + /// If this group is dummy, set the corresponding position + int set_dummy_pos(cvm::atom_pos const &pos); + /// \brief Print the updated the total mass and charge of a group. /// This is needed in case the hosting MD code has an option to /// change atom masses after their initialization. diff --git a/lib/colvars/colvarcomp.h b/lib/colvars/colvarcomp.h index 5e7a91e872..c3c663e357 100644 --- a/lib/colvars/colvarcomp.h +++ b/lib/colvars/colvarcomp.h @@ -887,9 +887,8 @@ protected: /// Integer exponent of the function denominator int ed; - /// \brief If true, group2 will be treated as a single atom, stored in this - /// accessory group - cvm::atom_group *group2_center; + /// If true, group2 will be treated as a single atom + bool b_group2_center_only; /// Tolerance for the pair list cvm::real tolerance; @@ -941,9 +940,12 @@ public: bool **pairlist_elem, cvm::real tolerance); - /// Main workhorse function + /// Workhorse function template int compute_coordnum(); + /// Workhorse function + template void main_loop(bool *pairlist_elem); + }; diff --git a/lib/colvars/colvarcomp_coordnums.cpp b/lib/colvars/colvarcomp_coordnums.cpp index 059b0c825b..b6dd6535ef 100644 --- a/lib/colvars/colvarcomp_coordnums.cpp +++ b/lib/colvars/colvarcomp_coordnums.cpp @@ -91,7 +91,7 @@ cvm::real colvar::coordnum::switching_function(cvm::real const &r0, colvar::coordnum::coordnum(std::string const &conf) - : cvc(conf), b_anisotropic(false), group2_center(NULL), pairlist(NULL) + : cvc(conf), b_anisotropic(false), pairlist(NULL) { function_type = "coordnum"; @@ -156,14 +156,7 @@ colvar::coordnum::coordnum(std::string const &conf) cvm::log("Warning: only minimum-image distances are used by this variable.\n"); } - bool b_group2_center_only = false; get_keyval(conf, "group2CenterOnly", b_group2_center_only, group2->b_dummy); - if (b_group2_center_only) { - if (!group2_center) { - group2_center = new cvm::atom_group(); - group2_center->add_atom(cvm::atom()); - } - } get_keyval(conf, "tolerance", tolerance, 0.0); if (tolerance > 0) { @@ -185,7 +178,7 @@ colvar::coordnum::coordnum(std::string const &conf) colvar::coordnum::coordnum() - : b_anisotropic(false), group2_center(NULL), pairlist(NULL) + : b_anisotropic(false), pairlist(NULL) { function_type = "coordnum"; x.type(colvarvalue::type_scalar); @@ -197,69 +190,60 @@ colvar::coordnum::~coordnum() if (pairlist != NULL) { delete [] pairlist; } - if (group2_center != NULL) { - delete group2_center; - } } -template int colvar::coordnum::compute_coordnum() +template void colvar::coordnum::main_loop(bool **pairlist_elem) { - if (group2_center) { - (*group2_center)[0].pos = group2->center_of_mass(); - group2_center->calc_required_properties(); + if (b_group2_center_only) { + cvm::atom group2_com_atom; + group2_com_atom.pos = group2->center_of_mass(); + for (cvm::atom_iter ai1 = group1->begin(); ai1 != group1->end(); ai1++) { + x.real_value += switching_function(r0, r0_vec, en, ed, + *ai1, group2_com_atom, + pairlist_elem, + tolerance); + } + if (b_group2_center_only) { + group2->set_weighted_gradient(group2_com_atom.grad); + } + } else { + for (cvm::atom_iter ai1 = group1->begin(); ai1 != group1->end(); ai1++) { + for (cvm::atom_iter ai2 = group2->begin(); ai2 != group2->end(); ai2++) { + x.real_value += switching_function(r0, r0_vec, en, ed, + *ai1, *ai2, + pairlist_elem, + tolerance); + } + } } - cvm::atom_group *group2p = group2_center ? group2_center : group2; +} + +template int colvar::coordnum::compute_coordnum() +{ bool const use_pairlist = (pairlist != NULL); bool const rebuild_pairlist = (pairlist != NULL) && (cvm::step_relative() % pairlist_freq == 0); bool *pairlist_elem = use_pairlist ? pairlist : NULL; - cvm::atom_iter ai1 = group1->begin(), ai2 = group2p->begin(); - cvm::atom_iter const ai1_end = group1->end(); - cvm::atom_iter const ai2_end = group2p->end(); if (b_anisotropic) { if (use_pairlist) { - if (rebuild_pairlist) { - int const flags = compute_flags | ef_anisotropic | ef_use_pairlist | ef_rebuild_pairlist; - for (ai1 = group1->begin(); ai1 != ai1_end; ai1++) { - for (ai2 = group2->begin(); ai2 != ai2_end; ai2++) { - x.real_value += switching_function(r0, r0_vec, en, ed, - *ai1, *ai2, - &pairlist_elem, - tolerance); - } - } - + main_loop(&pairlist_elem); } else { - int const flags = compute_flags | ef_anisotropic | ef_use_pairlist; - for (ai1 = group1->begin(); ai1 != ai1_end; ai1++) { - for (ai2 = group2->begin(); ai2 != ai2_end; ai2++) { - x.real_value += switching_function(r0, r0_vec, en, ed, - *ai1, *ai2, - &pairlist_elem, - tolerance); - } - } + main_loop(&pairlist_elem); } - } else { // if (use_pairlist) { + } else { int const flags = compute_flags | ef_anisotropic; - for (ai1 = group1->begin(); ai1 != ai1_end; ai1++) { - for (ai2 = group2->begin(); ai2 != ai2_end; ai2++) { - x.real_value += switching_function(r0, r0_vec, en, ed, - *ai1, *ai2, - NULL, 0.0); - } - } + main_loop(NULL); } } else { @@ -267,46 +251,17 @@ template int colvar::coordnum::compute_coordnum() if (use_pairlist) { if (rebuild_pairlist) { - int const flags = compute_flags | ef_use_pairlist | ef_rebuild_pairlist; - for (ai1 = group1->begin(); ai1 != ai1_end; ai1++) { - for (ai2 = group2->begin(); ai2 != ai2_end; ai2++) { - x.real_value += switching_function(r0, r0_vec, en, ed, - *ai1, *ai2, - &pairlist_elem, - tolerance); - } - } - + main_loop(&pairlist_elem); } else { - int const flags = compute_flags | ef_use_pairlist; - for (ai1 = group1->begin(); ai1 != ai1_end; ai1++) { - for (ai2 = group2->begin(); ai2 != ai2_end; ai2++) { - x.real_value += switching_function(r0, r0_vec, en, ed, - *ai1, *ai2, - &pairlist_elem, - tolerance); - } - } + main_loop(&pairlist_elem); } - } else { // if (use_pairlist) { + } else { int const flags = compute_flags; - for (ai1 = group1->begin(); ai1 != ai1_end; ai1++) { - for (ai2 = group2->begin(); ai2 != ai2_end; ai2++) { - x.real_value += switching_function(r0, r0_vec, en, ed, - *ai1, *ai2, - NULL, 0.0); - } - } - } - } - - if (compute_flags & ef_gradients) { - if (group2_center) { - group2->set_weighted_gradient((*group2_center)[0].grad); + main_loop(NULL); } } diff --git a/lib/colvars/colvars_version.h b/lib/colvars/colvars_version.h index 0f1ee9a0a0..77b3bd7e38 100644 --- a/lib/colvars/colvars_version.h +++ b/lib/colvars/colvars_version.h @@ -1,5 +1,5 @@ #ifndef COLVARS_VERSION -#define COLVARS_VERSION "2019-08-01" +#define COLVARS_VERSION "2019-08-05" // This file is part of the Collective Variables module (Colvars). // The original version of Colvars and its updates are located at: // https://github.com/colvars/colvars -- GitLab From 97501f0946580b98d50e83b237544fdd7dc79b36 Mon Sep 17 00:00:00 2001 From: Giacomo Fiorin Date: Mon, 5 Aug 2019 14:59:40 -0400 Subject: [PATCH 428/469] Fix typo --- lib/colvars/colvarcomp.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/lib/colvars/colvarcomp.h b/lib/colvars/colvarcomp.h index c3c663e357..1d95cbe600 100644 --- a/lib/colvars/colvarcomp.h +++ b/lib/colvars/colvarcomp.h @@ -944,7 +944,7 @@ public: template int compute_coordnum(); /// Workhorse function - template void main_loop(bool *pairlist_elem); + template void main_loop(bool **pairlist_elem); }; -- GitLab From e39b85b62fd06f25e94ff4e51cf08e453b35ccf1 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Mon, 5 Aug 2019 15:23:57 -0500 Subject: [PATCH 429/469] Update kim query url in docs --- doc/src/kim_commands.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/kim_commands.txt b/doc/src/kim_commands.txt index 93c4e8c4a8..47beb776a1 100644 --- a/doc/src/kim_commands.txt +++ b/doc/src/kim_commands.txt @@ -365,7 +365,7 @@ an array of one or more comma-separated items in brackets. The list of supported keywords and the type and format of their values depend on the query function used. The current list of query functions is available on the OpenKIM webpage at -"https://openkim.org/doc/repository/kim-query"_https://openkim.org/doc/repository/kim-query. +"https://openkim.org/doc/usage/kim-query"_https://openkim.org/doc/usage/kim-query. NOTE: All query functions require the {model} keyword, which identifies the IM whose predictions are being queried. This keyword is automatically -- GitLab From 2092b2c010a8e2bc419e94a8d9b48befc6847852 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 3 Aug 2019 06:47:27 -0400 Subject: [PATCH 430/469] Step version string for stable release --- doc/lammps.1 | 2 +- doc/src/Manual.txt | 4 ++-- src/version.h | 2 +- 3 files changed, 4 insertions(+), 4 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index 6539b85af9..46f83698ec 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,4 +1,4 @@ -.TH LAMMPS "2 August 2019" "2019-08-02" +.TH LAMMPS "6 August 2019" "2019-08-06" .SH NAME .B LAMMPS \- Molecular Dynamics Simulator. diff --git a/doc/src/Manual.txt b/doc/src/Manual.txt index 85828f1d90..e461e585d9 100644 --- a/doc/src/Manual.txt +++ b/doc/src/Manual.txt @@ -1,7 +1,7 @@ LAMMPS Users Manual - + @@ -21,7 +21,7 @@ :line LAMMPS Documentation :c,h1 -2 Aug 2019 version :c,h2 +6 Aug 2019 version :c,h2 "What is a LAMMPS version?"_Manual_version.html diff --git a/src/version.h b/src/version.h index b74aa30172..2154f428c4 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "2 Aug 2019" +#define LAMMPS_VERSION "6 Aug 2019" -- GitLab From 3ef93d6e1b97384a5d11b8e1b31ec0114f089974 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 5 Aug 2019 16:59:18 -0400 Subject: [PATCH 431/469] cannot forced enable FFMpeg and gzip on windows yet. --- cmake/presets/mingw-cross.cmake | 2 -- 1 file changed, 2 deletions(-) diff --git a/cmake/presets/mingw-cross.cmake b/cmake/presets/mingw-cross.cmake index fbec42529f..920b377e48 100644 --- a/cmake/presets/mingw-cross.cmake +++ b/cmake/presets/mingw-cross.cmake @@ -13,7 +13,5 @@ endforeach() set(DOWNLOAD_VORO ON CACHE BOOL "" FORCE) set(DOWNLOAD_EIGEN3 ON CACHE BOOL "" FORCE) -set(WITH_GZIP ON CACHE BOOL "" FORCE) -set(WITH_FFMPEG ON CACHE BOOL "" FORCE) set(LAMMPS_MEMALIGN "0" CACHE STRING "" FORCE) set(CMAKE_INSTALL_PREFIX "${CMAKE_CURRENT_BINARY_DIR}/lammps-installer") -- GitLab From 2d643233549f83b7e4d49712ff8b864d39c163c7 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 5 Aug 2019 17:21:11 -0600 Subject: [PATCH 432/469] fix formatting and augment explanation for bbox option --- doc/src/replicate.txt | 15 +++++++++------ 1 file changed, 9 insertions(+), 6 deletions(-) diff --git a/doc/src/replicate.txt b/doc/src/replicate.txt index 79a481746e..50e6e4c6d2 100644 --- a/doc/src/replicate.txt +++ b/doc/src/replicate.txt @@ -14,7 +14,8 @@ replicate nx ny nz {keyword} :pre nx,ny,nz = replication factors in each dimension :ulb optional {keyword} = {bbox} :l - {bbox} = only check atoms in replicas that overlap with a processor's sub-domain :ule + {bbox} = only check atoms in replicas that overlap with a processor's sub-domain :pre +:ule [Examples:] @@ -45,11 +46,13 @@ file that crosses a periodic boundary should be between two atoms with image flags that differ by 1. This will allow the bond to be unwrapped appropriately. -The optional keyword {bbox} uses a bounding box to only check atoms -in replicas that overlap with a processor's sub-domain when assigning -atoms to processors, and thus can result in substantial speedups for -calculations using a large number of processors. It does require -temporarily using more memory. +The optional keyword {bbox} uses a bounding box to only check atoms in +replicas that overlap with a processor's sub-domain when assigning +atoms to processors. It typically results in a substantial speedup +when using the replicate command on a large number of processors. It +does require temporary use of more memory, specifically that each +processor can store all atoms in the entire system before it is +replicated. [Restrictions:] -- GitLab From 21f3f51ea2a719c9e57bdaf31c34b385c0c4efd4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 2 Aug 2019 10:13:52 -0400 Subject: [PATCH 433/469] better error messages on accessing invalid IDs in variable expressions --- src/variable.cpp | 65 +++++++++++++++++++++++++++++++++--------------- 1 file changed, 45 insertions(+), 20 deletions(-) diff --git a/src/variable.cpp b/src/variable.cpp index 3fffa11d5e..1093ce9066 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -18,6 +18,7 @@ #include #include #include +#include #include "universe.h" #include "atom.h" #include "update.h" @@ -1302,8 +1303,12 @@ double Variable::evaluate(char *str, Tree **tree, int ivar) if (word[0] == 'C') lowercase = 0; int icompute = modify->find_compute(word+2); - if (icompute < 0) - print_var_error(FLERR,"Invalid compute ID in variable formula",ivar); + if (icompute < 0) { + std::string mesg = "Invalid compute ID '"; + mesg += (word+2); + mesg += "' in variable formula"; + print_var_error(FLERR,mesg.c_str(),ivar); + } Compute *compute = modify->compute[icompute]; // parse zero or one or two trailing brackets @@ -1604,9 +1609,10 @@ double Variable::evaluate(char *str, Tree **tree, int ivar) int ifix = modify->find_fix(word+2); if (ifix < 0) { - char msg[128]; - snprintf(msg,128,"Invalid fix ID '%s' in variable formula",word+2); - print_var_error(FLERR,msg,ivar); + std::string mesg = "Invalid fix ID '"; + mesg += (word+2); + mesg += "' in variable formula"; + print_var_error(FLERR,mesg.c_str(),ivar); } Fix *fix = modify->fix[ifix]; @@ -3792,8 +3798,12 @@ int Variable::group_function(char *word, char *contents, Tree **tree, // group to operate on int igroup = group->find(args[0]); - if (igroup == -1) - print_var_error(FLERR,"Group ID in variable formula does not exist",ivar); + if (igroup == -1) { + std::string mesg = "Group ID '"; + mesg += args[0]; + mesg += "' in variable formula does not exist"; + print_var_error(FLERR,mesg.c_str(),ivar); + } // match word to group function @@ -4001,8 +4011,12 @@ int Variable::group_function(char *word, char *contents, Tree **tree, int Variable::region_function(char *id, int ivar) { int iregion = domain->find_region(id); - if (iregion == -1) - print_var_error(FLERR,"Region ID in variable formula does not exist",ivar); + if (iregion == -1) { + std::string mesg = "Region ID '"; + mesg += id; + mesg += "' in variable formula does not exist"; + print_var_error(FLERR,mesg.c_str(),ivar); + } // init region in case sub-regions have been deleted @@ -4080,9 +4094,10 @@ int Variable::special_function(char *word, char *contents, Tree **tree, int icompute = modify->find_compute(&args[0][2]); if (icompute < 0) { - char msg[128]; - snprintf(msg,128,"Invalid compute ID '%s' in variable formula",word+2); - print_var_error(FLERR,msg,ivar); + std::string mesg = "Invalid compute ID '"; + mesg += (args[0]+2); + mesg += "' in variable formula"; + print_var_error(FLERR,mesg.c_str(),ivar); } compute = modify->compute[icompute]; if (index == 0 && compute->vector_flag) { @@ -4123,13 +4138,20 @@ int Variable::special_function(char *word, char *contents, Tree **tree, } else index = 0; int ifix = modify->find_fix(&args[0][2]); - if (ifix < 0) - print_var_error(FLERR,"Invalid fix ID in variable formula",ivar); + if (ifix < 0) { + std::string mesg = "Invalid fix ID '"; + mesg += (args[0]+2); + mesg += "' in variable formula"; + print_var_error(FLERR,mesg.c_str(),ivar); + } fix = modify->fix[ifix]; if (index == 0 && fix->vector_flag) { - if (update->whichflag > 0 && update->ntimestep % fix->global_freq) - print_var_error(FLERR,"Fix in variable not computed at " - "compatible time",ivar); + if (update->whichflag > 0 && update->ntimestep % fix->global_freq) { + std::string mesg = "Fix with ID '"; + mesg += (args[0]+2); + mesg += "' in variable formula not computed at compatible time"; + print_var_error(FLERR,mesg.c_str(),ivar); + } nvec = fix->size_vector; nstride = 1; } else if (index && fix->array_flag) { @@ -4336,9 +4358,12 @@ int Variable::special_function(char *word, char *contents, Tree **tree, print_var_error(FLERR,"Invalid special function in variable formula",ivar); int ivar = find(args[0]); - if (ivar < 0) - print_var_error(FLERR,"Variable ID in " - "variable formula does not exist",ivar); + if (ivar < 0) { + std::string mesg = "Variable ID '"; + mesg += args[0]; + mesg += "' in variable formula does not exist"; + print_var_error(FLERR,mesg.c_str(),ivar); + } // SCALARFILE has single current value, read next one // save value in tree or on argstack -- GitLab From 71ce1c20274d373b4312171d8f4ef95921a16a7c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 5 Aug 2019 23:25:06 -0400 Subject: [PATCH 434/469] use cube() and square() from math_special.h instead of pow(x,3.0) and pow(x,2.0) --- src/MANYBODY/pair_tersoff.cpp | 8 +++++--- src/MANYBODY/pair_tersoff_mod.cpp | 8 +++++--- src/MANYBODY/pair_tersoff_zbl.cpp | 6 ++++-- 3 files changed, 14 insertions(+), 8 deletions(-) diff --git a/src/MANYBODY/pair_tersoff.cpp b/src/MANYBODY/pair_tersoff.cpp index 62c74576e0..5f53760e71 100644 --- a/src/MANYBODY/pair_tersoff.cpp +++ b/src/MANYBODY/pair_tersoff.cpp @@ -30,9 +30,11 @@ #include "error.h" #include "math_const.h" +#include "math_special.h" using namespace LAMMPS_NS; using namespace MathConst; +using namespace MathSpecial; #define MAXLINE 1024 #define DELTA 4 @@ -604,7 +606,7 @@ double PairTersoff::zeta(Param *param, double rsqij, double rsqik, costheta = (delrij[0]*delrik[0] + delrij[1]*delrik[1] + delrij[2]*delrik[2]) / (rij*rik); - if (param->powermint == 3) arg = pow(param->lam3 * (rij-rik),3.0); + if (param->powermint == 3) arg = cube(param->lam3 * (rij-rik)); else arg = param->lam3 * (rij-rik); if (arg > 69.0776) ex_delr = 1.e30; @@ -744,7 +746,7 @@ void PairTersoff::ters_zetaterm_d(double prefactor, fc = ters_fc(rik,param); dfc = ters_fc_d(rik,param); - if (param->powermint == 3) tmp = pow(param->lam3 * (rij-rik),3.0); + if (param->powermint == 3) tmp = cube(param->lam3 * (rij-rik)); else tmp = param->lam3 * (rij-rik); if (tmp > 69.0776) ex_delr = 1.e30; @@ -752,7 +754,7 @@ void PairTersoff::ters_zetaterm_d(double prefactor, else ex_delr = exp(tmp); if (param->powermint == 3) - ex_delr_d = 3.0*pow(param->lam3,3.0) * pow(rij-rik,2.0)*ex_delr; + ex_delr_d = 3.0*cube(param->lam3) * square(rij-rik)*ex_delr; else ex_delr_d = param->lam3 * ex_delr; cos_theta = vec3_dot(rij_hat,rik_hat); diff --git a/src/MANYBODY/pair_tersoff_mod.cpp b/src/MANYBODY/pair_tersoff_mod.cpp index 698dd8fa03..9d4bdb7fd0 100644 --- a/src/MANYBODY/pair_tersoff_mod.cpp +++ b/src/MANYBODY/pair_tersoff_mod.cpp @@ -25,11 +25,13 @@ #include "force.h" #include "comm.h" #include "math_const.h" +#include "math_special.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; using namespace MathConst; +using namespace MathSpecial; #define MAXLINE 1024 #define DELTA 4 @@ -241,7 +243,7 @@ double PairTersoffMOD::zeta(Param *param, double rsqij, double rsqik, costheta = (delrij[0]*delrik[0] + delrij[1]*delrik[1] + delrij[2]*delrik[2]) / (rij*rik); - if (param->powermint == 3) arg = pow(param->lam3 * (rij-rik),3.0); + if (param->powermint == 3) arg = cube(param->lam3 * (rij-rik)); else arg = param->lam3 * (rij-rik); if (arg > 69.0776) ex_delr = 1.e30; @@ -314,7 +316,7 @@ void PairTersoffMOD::ters_zetaterm_d(double prefactor, fc = ters_fc(rik,param); dfc = ters_fc_d(rik,param); - if (param->powermint == 3) tmp = pow(param->lam3 * (rij-rik),3.0); + if (param->powermint == 3) tmp = cube(param->lam3 * (rij-rik)); else tmp = param->lam3 * (rij-rik); if (tmp > 69.0776) ex_delr = 1.e30; @@ -322,7 +324,7 @@ void PairTersoffMOD::ters_zetaterm_d(double prefactor, else ex_delr = exp(tmp); if (param->powermint == 3) - ex_delr_d = 3.0*pow(param->lam3,3.0) * pow(rij-rik,2.0)*ex_delr; + ex_delr_d = 3.0*cube(param->lam3) * square(rij-rik)*ex_delr; else ex_delr_d = param->lam3 * ex_delr; cos_theta = vec3_dot(rij_hat,rik_hat); diff --git a/src/MANYBODY/pair_tersoff_zbl.cpp b/src/MANYBODY/pair_tersoff_zbl.cpp index ab06e6ec31..d5e3fb1b0f 100644 --- a/src/MANYBODY/pair_tersoff_zbl.cpp +++ b/src/MANYBODY/pair_tersoff_zbl.cpp @@ -28,9 +28,11 @@ #include "memory.h" #include "error.h" #include "math_const.h" +#include "math_special.h" using namespace LAMMPS_NS; using namespace MathConst; +using namespace MathSpecial; #define MAXLINE 1024 #define DELTA 4 @@ -226,7 +228,7 @@ void PairTersoffZBL::repulsive(Param *param, double rsq, double &fforce, // ZBL repulsive portion - double esq = pow(global_e,2.0); + double esq = square(global_e); double a_ij = (0.8854*global_a_0) / (pow(param->Z_i,0.23) + pow(param->Z_j,0.23)); double premult = (param->Z_i * param->Z_j * esq)/(4.0*MY_PI*global_epsilon_0); @@ -286,5 +288,5 @@ double PairTersoffZBL::F_fermi(double r, Param *param) double PairTersoffZBL::F_fermi_d(double r, Param *param) { return param->ZBLexpscale*exp(-param->ZBLexpscale*(r-param->ZBLcut)) / - pow(1.0 + exp(-param->ZBLexpscale*(r-param->ZBLcut)),2.0); + square(1.0 + exp(-param->ZBLexpscale*(r-param->ZBLcut))); } -- GitLab From 4a55e9dd0c860e8c1f420eb274ea3fc91d6ff498 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 6 Aug 2019 07:28:00 -0400 Subject: [PATCH 435/469] fix inconsistent enumerator bug in fix ave/histo vs fix ave/histo/weight --- src/fix_ave_histo_weight.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/fix_ave_histo_weight.cpp b/src/fix_ave_histo_weight.cpp index 1f0d282e5d..f4ff0ae55f 100644 --- a/src/fix_ave_histo_weight.cpp +++ b/src/fix_ave_histo_weight.cpp @@ -33,7 +33,7 @@ using namespace FixConst; enum{X,V,F,COMPUTE,FIX,VARIABLE}; enum{ONE,RUNNING}; enum{SCALAR,VECTOR,WINDOW}; -enum{GLOBAL,PERATOM,LOCAL}; +enum{DEFAULT,GLOBAL,PERATOM,LOCAL}; enum{IGNORE,END,EXTRA}; enum{SINGLE,VALUE}; -- GitLab From 59046e7444d709b7bf8f70c1f1ca890c93162975 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 6 Aug 2019 08:52:54 -0400 Subject: [PATCH 436/469] step version number for stable release --- doc/lammps.1 | 2 +- doc/src/Manual.txt | 4 ++-- src/version.h | 2 +- 3 files changed, 4 insertions(+), 4 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index 46f83698ec..ac19749dd6 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,4 +1,4 @@ -.TH LAMMPS "6 August 2019" "2019-08-06" +.TH LAMMPS "7 August 2019" "2019-08-07" .SH NAME .B LAMMPS \- Molecular Dynamics Simulator. diff --git a/doc/src/Manual.txt b/doc/src/Manual.txt index e461e585d9..c63137ef6f 100644 --- a/doc/src/Manual.txt +++ b/doc/src/Manual.txt @@ -1,7 +1,7 @@ LAMMPS Users Manual - + @@ -21,7 +21,7 @@ :line LAMMPS Documentation :c,h1 -6 Aug 2019 version :c,h2 +7 Aug 2019 version :c,h2 "What is a LAMMPS version?"_Manual_version.html diff --git a/src/version.h b/src/version.h index 2154f428c4..7387a3a1a4 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "6 Aug 2019" +#define LAMMPS_VERSION "7 Aug 2019" -- GitLab From 131c5aadd2d938d9ef1e541ff452169b9a315292 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Wed, 7 Aug 2019 19:16:54 +0200 Subject: [PATCH 437/469] Error/warning tweaks --- src/USER-MISC/pair_cosine_squared.cpp | 4 ++-- src/USER-MISC/pair_cosine_squared.h | 5 +++++ 2 files changed, 7 insertions(+), 2 deletions(-) diff --git a/src/USER-MISC/pair_cosine_squared.cpp b/src/USER-MISC/pair_cosine_squared.cpp index 67cefd894b..4c8d738cee 100644 --- a/src/USER-MISC/pair_cosine_squared.cpp +++ b/src/USER-MISC/pair_cosine_squared.cpp @@ -154,10 +154,10 @@ void PairCosineSquared::coeff(int narg, char **arg) } if (cut_one < sigma_one) { - error->all(FLERR, "Incorrect args for cosine/squared pair coeffs (cutoff < sigma)"); + error->all(FLERR, "Incorrect args for pair coefficients (cutoff < sigma)"); } else if (cut_one == sigma_one) { if (wca_one == 0) { - error->all(FLERR, "Incorrect args for cosine/squared pair coeffs (cutoff = sigma w/o wca)"); + error->all(FLERR, "Incorrect args for pair coefficients (cutoff = sigma w/o wca)"); } else { error->warning(FLERR, "Cosine/squared set to WCA only (cutoff = sigma)"); } diff --git a/src/USER-MISC/pair_cosine_squared.h b/src/USER-MISC/pair_cosine_squared.h index 8c294e0d36..a638270e68 100644 --- a/src/USER-MISC/pair_cosine_squared.h +++ b/src/USER-MISC/pair_cosine_squared.h @@ -91,5 +91,10 @@ W: pair_modify shift/tail is meaningless for pair_style cosine/squared This style by definition gets to zero at cutoff distance, so there is nothing to shift and there is no tail contribution +W: Cosine/squared set to WCA only (cutoff = sigma) + +If cutoff is equal to sigma (minimum) then this pair style basically +degenerates/reverts to only WCA. This is for convenience. + */ -- GitLab From 8619462b3b5e9f0ef7ea9917f318646703efda72 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 7 Aug 2019 16:14:22 -0500 Subject: [PATCH 438/469] Added logs for examples/kim --- .../kim/log.7Aug19.in.kim-ex.melt.clang.1 | 107 +++++++++++++++ .../kim/log.7Aug19.in.kim-ex.melt.clang.4 | 113 ++++++++++++++++ .../log.7Aug19.in.kim-pm-query.melt.clang.1 | 124 ++++++++++++++++++ .../log.7Aug19.in.kim-pm-query.melt.clang.4 | 124 ++++++++++++++++++ .../kim/log.7Aug19.in.kim-pm.melt.clang.1 | 118 +++++++++++++++++ .../kim/log.7Aug19.in.kim-pm.melt.clang.4 | 118 +++++++++++++++++ .../kim/log.7Aug19.in.kim-sm.melt.clang.1 | 71 ++++++++++ .../kim/log.7Aug19.in.kim-sm.melt.clang.4 | 60 +++++++++ .../kim/log.7Aug19.in.lammps.melt.clang.1 | 92 +++++++++++++ .../kim/log.7Aug19.in.lammps.melt.clang.4 | 92 +++++++++++++ 10 files changed, 1019 insertions(+) create mode 100644 examples/kim/log.7Aug19.in.kim-ex.melt.clang.1 create mode 100644 examples/kim/log.7Aug19.in.kim-ex.melt.clang.4 create mode 100644 examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.1 create mode 100644 examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.4 create mode 100644 examples/kim/log.7Aug19.in.kim-pm.melt.clang.1 create mode 100644 examples/kim/log.7Aug19.in.kim-pm.melt.clang.4 create mode 100644 examples/kim/log.7Aug19.in.kim-sm.melt.clang.1 create mode 100644 examples/kim/log.7Aug19.in.kim-sm.melt.clang.4 create mode 100644 examples/kim/log.7Aug19.in.lammps.melt.clang.1 create mode 100644 examples/kim/log.7Aug19.in.lammps.melt.clang.4 diff --git a/examples/kim/log.7Aug19.in.kim-ex.melt.clang.1 b/examples/kim/log.7Aug19.in.kim-ex.melt.clang.1 new file mode 100644 index 0000000000..17fa1bc534 --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-ex.melt.clang.1 @@ -0,0 +1,107 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the example models provided with +# the kim-api package are installed. see the ./lib/kim/README or +# ./lib/kim/Install.py files for details on how to install these +# example models. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init LennardJones_Ar real +#=== BEGIN kim-init ========================================== +units real +#=== END kim-init ============================================ + + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.004321 secs + +kim_interactions Ar +#=== BEGIN kim_interactions ================================== +pair_style kim LennardJones_Ar +WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (../pair_kim.cpp:974) +WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (../pair_kim.cpp:979) +pair_coeff * * Ar +#=== END kim_interactions ==================================== + + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.45 + ghost atom cutoff = 8.45 + binsize = 4.225, bins = 21 21 21 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 8.45 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 28.12 | 28.12 | 28.12 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 145069.63 0 164146.22 128015.94 + 100 95.179703 154939.42 0 164017.94 131602.75 +Loop time of 3.48256 on 1 procs for 100 steps with 32000 atoms + +Performance: 2.481 ns/day, 9.674 hours/ns, 28.715 timesteps/s +98.3% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 3.0502 | 3.0502 | 3.0502 | 0.0 | 87.59 +Neigh | 0.3646 | 0.3646 | 0.3646 | 0.0 | 10.47 +Comm | 0.01783 | 0.01783 | 0.01783 | 0.0 | 0.51 +Output | 6.8e-05 | 6.8e-05 | 6.8e-05 | 0.0 | 0.00 +Modify | 0.034349 | 0.034349 | 0.034349 | 0.0 | 0.99 +Other | | 0.01547 | | | 0.44 + +Nlocal: 32000 ave 32000 max 32000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 19911 ave 19911 max 19911 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 4.25375e+06 ave 4.25375e+06 max 4.25375e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 4253750 +Ave neighs/atom = 132.93 +Neighbor list builds = 3 +Dangerous builds = 0 +Total wall time: 0:00:03 diff --git a/examples/kim/log.7Aug19.in.kim-ex.melt.clang.4 b/examples/kim/log.7Aug19.in.kim-ex.melt.clang.4 new file mode 100644 index 0000000000..8e076815fc --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-ex.melt.clang.4 @@ -0,0 +1,113 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the example models provided with +# the kim-api package are installed. see the ./lib/kim/README or +# ./lib/kim/Install.py files for details on how to install these +# example models. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init LennardJones_Ar real +#=== BEGIN kim-init ========================================== +units real +#=== END kim-init ============================================ + + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.000989 secs + +kim_interactions Ar +#=== BEGIN kim_interactions ================================== +pair_style kim LennardJones_Ar +WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (../pair_kim.cpp:974) +WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (../pair_kim.cpp:979) +pair_coeff * * Ar +WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (../pair_kim.cpp:974) +WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (../pair_kim.cpp:979) +#=== END kim_interactions ==================================== + + +mass 1 39.95 +velocity all create 200.0 232345 loop geom +WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (../pair_kim.cpp:974) +WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (../pair_kim.cpp:979) +WARNING: KIM Model does not provide `partialParticleEnergy'; energy per atom will be zero (../pair_kim.cpp:974) +WARNING: KIM Model does not provide `partialParticleVirial'; virial per atom will be zero (../pair_kim.cpp:979) + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.45 + ghost atom cutoff = 8.45 + binsize = 4.225, bins = 21 21 21 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 8.45 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 9.791 | 9.791 | 9.791 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 145069.63 0 164146.22 128015.94 + 100 95.179703 154939.42 0 164017.94 131602.75 +Loop time of 0.924494 on 4 procs for 100 steps with 32000 atoms + +Performance: 9.346 ns/day, 2.568 hours/ns, 108.167 timesteps/s +99.6% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.76434 | 0.76847 | 0.77207 | 0.3 | 83.12 +Neigh | 0.09089 | 0.094446 | 0.099911 | 1.1 | 10.22 +Comm | 0.038599 | 0.044759 | 0.051381 | 2.1 | 4.84 +Output | 3.5e-05 | 4e-05 | 4.9e-05 | 0.0 | 0.00 +Modify | 0.009396 | 0.009685 | 0.009941 | 0.2 | 1.05 +Other | | 0.00709 | | | 0.77 + +Nlocal: 8000 ave 8018 max 7967 min +Histogram: 1 0 0 0 0 0 1 0 0 2 +Nghost: 9131 ave 9164 max 9113 min +Histogram: 2 0 0 1 0 0 0 0 0 1 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 1.06344e+06 ave 1.06594e+06 max 1.05881e+06 min +Histogram: 1 0 0 0 0 0 1 0 0 2 + +Total # of neighbors = 4253750 +Ave neighs/atom = 132.93 +Neighbor list builds = 3 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.1 b/examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.1 new file mode 100644 index 0000000000..1ca44c98ef --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.1 @@ -0,0 +1,124 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the KIM Portable Model (PM) +# SW_StillingerWeber_1985_Si__MO_405512056662_005 +# is installed. This can be done with the command +# kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# +# Or, see https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 real +#=== BEGIN kim-init ========================================== +units real +#=== END kim-init ============================================ + +kim_query a0 get_lattice_constant_cubic crystal=["fcc"] species=["Si"] units=["angstrom"] +#=== BEGIN kim-query ========================================= +variable a0 string 4.146581932902336 +#=== END kim-query =========================================== + + +lattice fcc ${a0} +lattice fcc 4.146581932902336 +Lattice spacing in x,y,z = 4.14658 4.14658 4.14658 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (82.9316 82.9316 82.9316) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.005415 secs + +kim_interactions Si +#=== BEGIN kim_interactions ================================== +pair_style kim SW_StillingerWeber_1985_Si__MO_405512056662_005 +pair_coeff * * Si +#=== END kim_interactions ==================================== + + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.07118 + ghost atom cutoff = 4.07118 + binsize = 2.03559, bins = 41 41 41 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 4.07118 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 10.36 | 10.36 | 10.36 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 -126084.25 0 -107007.66 1528.8768 + 100 94.450495 -116016.03 0 -107007.07 2282.2685 +Loop time of 74.6055 on 1 procs for 100 steps with 32000 atoms + +Performance: 0.116 ns/day, 207.238 hours/ns, 1.340 timesteps/s +98.6% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 74.446 | 74.446 | 74.446 | 0.0 | 99.79 +Neigh | 0.096611 | 0.096611 | 0.096611 | 0.0 | 0.13 +Comm | 0.014594 | 0.014594 | 0.014594 | 0.0 | 0.02 +Output | 7.9e-05 | 7.9e-05 | 7.9e-05 | 0.0 | 0.00 +Modify | 0.03454 | 0.03454 | 0.03454 | 0.0 | 0.05 +Other | | 0.01396 | | | 0.02 + +Nlocal: 32000 ave 32000 max 32000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 9667 ave 9667 max 9667 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 450192 ave 450192 max 450192 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 450192 +Ave neighs/atom = 14.0685 +Neighbor list builds = 3 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:01:16 diff --git a/examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.4 b/examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.4 new file mode 100644 index 0000000000..8c4148ce15 --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-pm-query.melt.clang.4 @@ -0,0 +1,124 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the KIM Portable Model (PM) +# SW_StillingerWeber_1985_Si__MO_405512056662_005 +# is installed. This can be done with the command +# kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# +# Or, see https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 real +#=== BEGIN kim-init ========================================== +units real +#=== END kim-init ============================================ + +kim_query a0 get_lattice_constant_cubic crystal=["fcc"] species=["Si"] units=["angstrom"] +#=== BEGIN kim-query ========================================= +variable a0 string 4.146581932902336 +#=== END kim-query =========================================== + + +lattice fcc ${a0} +lattice fcc 4.146581932902336 +Lattice spacing in x,y,z = 4.14658 4.14658 4.14658 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (82.9316 82.9316 82.9316) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.000946 secs + +kim_interactions Si +#=== BEGIN kim_interactions ================================== +pair_style kim SW_StillingerWeber_1985_Si__MO_405512056662_005 +pair_coeff * * Si +#=== END kim_interactions ==================================== + + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.07118 + ghost atom cutoff = 4.07118 + binsize = 2.03559, bins = 41 41 41 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 4.07118 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 3.489 | 3.489 | 3.489 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 -126084.25 0 -107007.66 1528.8768 + 100 94.450495 -116016.03 0 -107007.07 2282.2685 +Loop time of 19.0792 on 4 procs for 100 steps with 32000 atoms + +Performance: 0.453 ns/day, 52.998 hours/ns, 5.241 timesteps/s +99.4% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 18.78 | 18.855 | 18.937 | 1.5 | 98.83 +Neigh | 0.026047 | 0.026274 | 0.0266 | 0.1 | 0.14 +Comm | 0.09039 | 0.17196 | 0.24675 | 15.9 | 0.90 +Output | 3.9e-05 | 4.975e-05 | 6.1e-05 | 0.0 | 0.00 +Modify | 0.015667 | 0.015819 | 0.016008 | 0.1 | 0.08 +Other | | 0.01008 | | | 0.05 + +Nlocal: 8000 ave 8029 max 7968 min +Histogram: 1 1 0 0 0 0 0 0 0 2 +Nghost: 4259 ave 4303 max 4202 min +Histogram: 1 0 0 0 0 0 2 0 0 1 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 112548 ave 113091 max 111995 min +Histogram: 1 0 0 1 0 0 0 1 0 1 + +Total # of neighbors = 450192 +Ave neighs/atom = 14.0685 +Neighbor list builds = 3 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:20 diff --git a/examples/kim/log.7Aug19.in.kim-pm.melt.clang.1 b/examples/kim/log.7Aug19.in.kim-pm.melt.clang.1 new file mode 100644 index 0000000000..f5845d7fc4 --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-pm.melt.clang.1 @@ -0,0 +1,118 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the KIM Portable Model (PM) +# SW_StillingerWeber_1985_Si__MO_405512056662_005 +# is installed. This can be done with the command +# kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# +# Or, see https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 real +#=== BEGIN kim-init ========================================== +units real +#=== END kim-init ============================================ + + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.003591 secs + +kim_interactions Si +#=== BEGIN kim_interactions ================================== +pair_style kim SW_StillingerWeber_1985_Si__MO_405512056662_005 +pair_coeff * * Si +#=== END kim_interactions ==================================== + + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.07118 + ghost atom cutoff = 4.07118 + binsize = 2.03559, bins = 44 44 44 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 4.07118 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 10.44 | 10.44 | 10.44 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 -85249.847 0 -66173.259 -33302.387 + 100 253.43357 -90346.68 0 -66173.441 -14888.698 +Loop time of 74.248 on 1 procs for 100 steps with 32000 atoms + +Performance: 0.116 ns/day, 206.244 hours/ns, 1.347 timesteps/s +98.8% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 74.118 | 74.118 | 74.118 | 0.0 | 99.83 +Neigh | 0.069623 | 0.069623 | 0.069623 | 0.0 | 0.09 +Comm | 0.0137 | 0.0137 | 0.0137 | 0.0 | 0.02 +Output | 7.6e-05 | 7.6e-05 | 7.6e-05 | 0.0 | 0.00 +Modify | 0.031883 | 0.031883 | 0.031883 | 0.0 | 0.04 +Other | | 0.01433 | | | 0.02 + +Nlocal: 32000 ave 32000 max 32000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7760 ave 7760 max 7760 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 402352 ave 402352 max 402352 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 402352 +Ave neighs/atom = 12.5735 +Neighbor list builds = 4 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:01:14 diff --git a/examples/kim/log.7Aug19.in.kim-pm.melt.clang.4 b/examples/kim/log.7Aug19.in.kim-pm.melt.clang.4 new file mode 100644 index 0000000000..0b4632b999 --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-pm.melt.clang.4 @@ -0,0 +1,118 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the KIM Portable Model (PM) +# SW_StillingerWeber_1985_Si__MO_405512056662_005 +# is installed. This can be done with the command +# kim-api-collections-management install user SW_StillingerWeber_1985_Si__MO_405512056662_005 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# +# Or, see https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 real +#=== BEGIN kim-init ========================================== +units real +#=== END kim-init ============================================ + + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.000997 secs + +kim_interactions Si +#=== BEGIN kim_interactions ================================== +pair_style kim SW_StillingerWeber_1985_Si__MO_405512056662_005 +pair_coeff * * Si +#=== END kim_interactions ==================================== + + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.07118 + ghost atom cutoff = 4.07118 + binsize = 2.03559, bins = 44 44 44 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair kim, perpetual + attributes: full, newton off, cut 4.07118 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 3.517 | 3.517 | 3.517 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 -85249.847 0 -66173.259 -33302.387 + 100 253.43357 -90346.68 0 -66173.441 -14888.698 +Loop time of 19.0287 on 4 procs for 100 steps with 32000 atoms + +Performance: 0.454 ns/day, 52.857 hours/ns, 5.255 timesteps/s +99.1% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 18.81 | 18.838 | 18.883 | 0.6 | 99.00 +Neigh | 0.018598 | 0.01914 | 0.020732 | 0.7 | 0.10 +Comm | 0.10341 | 0.1475 | 0.17393 | 7.1 | 0.78 +Output | 6e-05 | 6.225e-05 | 6.7e-05 | 0.0 | 0.00 +Modify | 0.014839 | 0.014925 | 0.015047 | 0.1 | 0.08 +Other | | 0.008997 | | | 0.05 + +Nlocal: 8000 ave 8014 max 7988 min +Histogram: 1 1 0 0 0 0 1 0 0 1 +Nghost: 3374.75 ave 3389 max 3361 min +Histogram: 1 0 1 0 0 0 0 1 0 1 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 100588 ave 100856 max 100392 min +Histogram: 1 0 1 0 1 0 0 0 0 1 + +Total # of neighbors = 402352 +Ave neighs/atom = 12.5735 +Neighbor list builds = 4 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:19 diff --git a/examples/kim/log.7Aug19.in.kim-sm.melt.clang.1 b/examples/kim/log.7Aug19.in.kim-sm.melt.clang.1 new file mode 100644 index 0000000000..1b77e58a3a --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-sm.melt.clang.1 @@ -0,0 +1,71 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the KIM Simulator Model (PM) +# Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# is installed. This can be done with the command +# kim-api-collections-management install user Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# +# See https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real +#=== BEGIN kim-init ========================================== +# Using KIM Simulator Model : Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# For Simulator : LAMMPS 28 Feb 2019 +# Running on : LAMMPS 7 Aug 2019 +# +units real +atom_style charge +neigh_modify one 4000 +#=== END kim-init ============================================ + + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.003447 secs + +kim_interactions O +#=== BEGIN kim_interactions ================================== +pair_style reax/c /var/tmp/kim-simulator-model-parameter-file-directory-6Acs1QDbXgBx/lmp_control safezone 2.0 mincap 100 +ERROR: Unrecognized pair style 'reax/c' is part of the USER-REAXC package which is not enabled in this LAMMPS binary. (../force.cpp:262) +Last command: pair_style reax/c /var/tmp/kim-simulator-model-parameter-file-directory-6Acs1QDbXgBx/lmp_control safezone 2.0 mincap 100 +-------------------------------------------------------------------------- +Primary job terminated normally, but 1 process returned +a non-zero exit code. Per user-direction, the job has been aborted. +-------------------------------------------------------------------------- +-------------------------------------------------------------------------- +mpirun detected that one or more processes exited with non-zero status, thus causing +the job to be terminated. The first process to do so was: + + Process name: [[33054,1],0] + Exit code: 1 +-------------------------------------------------------------------------- diff --git a/examples/kim/log.7Aug19.in.kim-sm.melt.clang.4 b/examples/kim/log.7Aug19.in.kim-sm.melt.clang.4 new file mode 100644 index 0000000000..72b62beffb --- /dev/null +++ b/examples/kim/log.7Aug19.in.kim-sm.melt.clang.4 @@ -0,0 +1,60 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt +# +# This example requires that the KIM Simulator Model (PM) +# Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# is installed. This can be done with the command +# kim-api-collections-management install user Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# If this command does not work, you may need to setup your PATH to find the utility. +# If you installed the kim-api using the LAMMPS CMake build, you can do the following +# (where the current working directory is assumed to be the LAMMPS build directory) +# source ./kim_build-prefix/bin/kim-api-activate +# If you installed the kim-api using the LAMMPS Make build, you can do the following +# (where the current working directory is assumed to be the LAMMPS src directory) +# source ../lib/kim/installed-kim-api-X.Y.Z/bin/kim-api-activate +# (where you should relplace X.Y.Z with the appropriate kim-api version number). +# +# See https://openkim.org/doc/obtaining-models for alternative options. +# + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +kim_init Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 real +#=== BEGIN kim-init ========================================== +# Using KIM Simulator Model : Sim_LAMMPS_ReaxFF_StrachanVanDuinChakraborty_2003_CHNO__SM_107643900657_000 +# For Simulator : LAMMPS 28 Feb 2019 +# Running on : LAMMPS 7 Aug 2019 +# +units real +atom_style charge +neigh_modify one 4000 +#=== END kim-init ============================================ + + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.001307 secs + +kim_interactions O +#=== BEGIN kim_interactions ================================== +pair_style reax/c /var/tmp/kim-simulator-model-parameter-file-directory-6tmKtZEXzhgv/lmp_control safezone 2.0 mincap 100 +ERROR: Unrecognized pair style 'reax/c' is part of the USER-REAXC package which is not enabled in this LAMMPS binary. (../force.cpp:262) +Last command: pair_style reax/c /var/tmp/kim-simulator-model-parameter-file-directory-6tmKtZEXzhgv/lmp_control safezone 2.0 mincap 100 diff --git a/examples/kim/log.7Aug19.in.lammps.melt.clang.1 b/examples/kim/log.7Aug19.in.lammps.melt.clang.1 new file mode 100644 index 0000000000..f697504777 --- /dev/null +++ b/examples/kim/log.7Aug19.in.lammps.melt.clang.1 @@ -0,0 +1,92 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +units real + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.003037 secs + +pair_style lj/cut 8.1500 +pair_coeff 1 1 0.0104 3.4000 + +#pair_style kim LennardJones_Ar +#pair_coeff * * Ar + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.45 + ghost atom cutoff = 8.45 + binsize = 4.225, bins = 21 21 21 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 19.23 | 19.23 | 19.23 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 6290.8194 0 25367.408 6750.7421 + 100 98.747096 15900.676 0 25319.465 10184.453 +Loop time of 2.43768 on 1 procs for 100 steps with 32000 atoms + +Performance: 3.544 ns/day, 6.771 hours/ns, 41.023 timesteps/s +97.8% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 2.1895 | 2.1895 | 2.1895 | 0.0 | 89.82 +Neigh | 0.17546 | 0.17546 | 0.17546 | 0.0 | 7.20 +Comm | 0.021001 | 0.021001 | 0.021001 | 0.0 | 0.86 +Output | 7.9e-05 | 7.9e-05 | 7.9e-05 | 0.0 | 0.00 +Modify | 0.034253 | 0.034253 | 0.034253 | 0.0 | 1.41 +Other | | 0.01735 | | | 0.71 + +Nlocal: 32000 ave 32000 max 32000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 19911 ave 19911 max 19911 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 1.96027e+06 ave 1.96027e+06 max 1.96027e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 1960266 +Ave neighs/atom = 61.2583 +Neighbor list builds = 3 +Dangerous builds = 0 +Total wall time: 0:00:02 diff --git a/examples/kim/log.7Aug19.in.lammps.melt.clang.4 b/examples/kim/log.7Aug19.in.lammps.melt.clang.4 new file mode 100644 index 0000000000..2d25348b06 --- /dev/null +++ b/examples/kim/log.7Aug19.in.lammps.melt.clang.4 @@ -0,0 +1,92 @@ +LAMMPS (7 Aug 2019) +# 3d Lennard-Jones melt + +variable x index 1 +variable y index 1 +variable z index 1 + +variable xx equal 20*$x +variable xx equal 20*1 +variable yy equal 20*$y +variable yy equal 20*1 +variable zz equal 20*$z +variable zz equal 20*1 + +units real + +lattice fcc 4.4300 +Lattice spacing in x,y,z = 4.43 4.43 4.43 +region box block 0 ${xx} 0 ${yy} 0 ${zz} +region box block 0 20 0 ${yy} 0 ${zz} +region box block 0 20 0 20 0 ${zz} +region box block 0 20 0 20 0 20 +create_box 1 box +Created orthogonal box = (0 0 0) to (88.6 88.6 88.6) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 32000 atoms + create_atoms CPU = 0.001194 secs + +pair_style lj/cut 8.1500 +pair_coeff 1 1 0.0104 3.4000 + +#pair_style kim LennardJones_Ar +#pair_coeff * * Ar + +mass 1 39.95 +velocity all create 200.0 232345 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve +#fix 1 all npt temp 1.0 1.0 1.0 iso 1.0 1.0 3.0 + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.45 + ghost atom cutoff = 8.45 + binsize = 4.225, bins = 21 21 21 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard +Setting up Verlet run ... + Unit style : real + Current step : 0 + Time step : 1 +Per MPI rank memory allocation (min/avg/max) = 7.633 | 7.633 | 7.633 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 200 6290.8194 0 25367.408 6750.7421 + 100 98.747096 15900.676 0 25319.465 10184.453 +Loop time of 0.726239 on 4 procs for 100 steps with 32000 atoms + +Performance: 11.897 ns/day, 2.017 hours/ns, 137.696 timesteps/s +98.7% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.57617 | 0.5835 | 0.59084 | 0.9 | 80.34 +Neigh | 0.046682 | 0.047783 | 0.048641 | 0.3 | 6.58 +Comm | 0.065469 | 0.071509 | 0.07899 | 2.3 | 9.85 +Output | 3.9e-05 | 4.6e-05 | 6.1e-05 | 0.0 | 0.01 +Modify | 0.013205 | 0.01363 | 0.014044 | 0.3 | 1.88 +Other | | 0.009775 | | | 1.35 + +Nlocal: 8000 ave 8012 max 7989 min +Histogram: 1 0 0 0 2 0 0 0 0 1 +Nghost: 9131 ave 9142 max 9119 min +Histogram: 1 0 0 0 0 2 0 0 0 1 +Neighs: 490066 ave 491443 max 489273 min +Histogram: 2 0 0 0 1 0 0 0 0 1 + +Total # of neighbors = 1960266 +Ave neighs/atom = 61.2583 +Neighbor list builds = 3 +Dangerous builds = 0 +Total wall time: 0:00:00 -- GitLab From 838238b1ca80f44ea8cfd90e30b39a888c5f2077 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Thu, 8 Aug 2019 00:38:41 +0200 Subject: [PATCH 439/469] documentation --- doc/src/Commands_pair.txt | 1 + doc/src/Eqs/pair_cosine_squared.jpg | Bin 0 -> 8949 bytes doc/src/Eqs/pair_cosine_squared.tex | 16 ++++ doc/src/Eqs/pair_cosine_squared_wca.jpg | Bin 0 -> 6780 bytes doc/src/Eqs/pair_cosine_squared_wca.tex | 11 +++ doc/src/JPG/pair_cosine_squared_graphs.jpg | Bin 0 -> 29869 bytes doc/src/lammps.book | 1 + doc/src/pair_cosine_squared.txt | 95 +++++++++++++++++++++ doc/src/pair_style.txt | 1 + doc/src/pairs.txt | 1 + 10 files changed, 126 insertions(+) create mode 100644 doc/src/Eqs/pair_cosine_squared.jpg create mode 100644 doc/src/Eqs/pair_cosine_squared.tex create mode 100644 doc/src/Eqs/pair_cosine_squared_wca.jpg create mode 100644 doc/src/Eqs/pair_cosine_squared_wca.tex create mode 100644 doc/src/JPG/pair_cosine_squared_graphs.jpg create mode 100644 doc/src/pair_cosine_squared.txt diff --git a/doc/src/Commands_pair.txt b/doc/src/Commands_pair.txt index 6077fad8ec..47d4c40d8e 100644 --- a/doc/src/Commands_pair.txt +++ b/doc/src/Commands_pair.txt @@ -65,6 +65,7 @@ OPT. "colloid (go)"_pair_colloid.html, "comb (o)"_pair_comb.html, "comb3"_pair_comb.html, +"cosine/squared"_pair_cosine_squared.html, "coul/cut (gko)"_pair_coul.html, "coul/cut/soft (o)"_pair_fep_soft.html, "coul/debye (gko)"_pair_coul.html, diff --git a/doc/src/Eqs/pair_cosine_squared.jpg b/doc/src/Eqs/pair_cosine_squared.jpg new file mode 100644 index 0000000000000000000000000000000000000000..682800652d695f3fc67772e15946165b539d0f0c GIT binary patch literal 8949 zcmex=9G120;#ng^b&n8I>5A1R0qH8UG()kY`|EWMu>c1}I=;VrF4wW9Q)H;{Jbx zVXFWG6C*P-6ALrQ)eH=bwTw*63@n1ILW+itY{G$w>`H|qMvW5}awt1(JSZA;@q>zS zQc)8pmzcPOq?D?fx`w8fiK&^ng{76Vi>sTvho@I?NN8AiL}XNQN@`kqMrKxVNoiSm zMP*fUOKV$uM`zch$y26In?7UatVN5LEM2yI#mZHiHgDOwZTpU$yAB;ba`f2o6DLny zx_ss8wd*%--g@}x@sp>|p1*kc>f@)+U%r0({^RE_kiQrin8CgR5fG1|`Ad+2iIItg zg_(t&m4$_Yk*S=4k%?K5g;mjzO~^5jJ+V+&$*7S-#A)KfjR!fEje|ajCKX-e5>qjG zsQMA)HL%Z!^H>vEK7)G<;jdc^Jj{#?OoGgU4E79vgBNvaFbpjIx&9v)?{BA9_M4}_ zdAurHiltY)>+9?pUu@-EV~=TfIvabiuR1Q%vv)hoxvBv6O)ulcZRFSeal7(|ec9`6 zzuLRL>~^fKUw*4?!Y#K54WV646L;zuN*fdzIXw`Lt*zvLv+)DJ|KGX$_+QG&bh;kf zYsG!HI;414u5-YIyjhVlPqv@&TIYGF@$34y1x#HU^uhZW{xdY~o>Zg!A(iu#dC$XB z-|TnWKdQI-{cpd${e$&sfe+)G<)RkXA5E4s-zaZB{lLr1>wFpN8ZWvQ?lb!lo%ne7 z550F=*9&L%^TY-8yIf!QMmcd((Mg`JHFy3#GVbBK!gw>J_`K{IBVUtl5yO?`6K`m( zYMkV0%OLvn{)cnB%>VN47qI`Z`O5wuUyI_mx*yIhsXJaTXruXHc5imrHML7iBYdyE zxqkh+;B;Oa$0tee&Wg|I+WB13eJMkgdDB1rm;V_Amv5VY*vfA0>K}Oz=O%wNauWXH8N_kBIK{58vsh|wuK zA)*;kweG^Ioyt$oS*VM?n!*t1Dncw~JX{m`WABn0xes6OZCo7{A9p+Q#+_H?n#-5u ze7F_eYJ8^VxP#Nr4zrbd-o2|TkMeRq-q-p_U*bpo;cv6bHo14`s9*WA*Z0lG%;J2p zvzPMj?lZWT^wvo09lNqZ&(H5~4`%Ipf9S0G!D$~guGG{%k~Kb5pW*uVQPgRRS+D2q zt~;M^sQhvL!bP15ol3o878jjXX&eZ!V$fjxdiuxXN9ApHGR`^o6s|tnH1B0sRK&5h zwof1Ptz_MkxOC?Jo36>Rt`&BzAA*nAvu^zx9rwZe#*YiHicGd|`=?p7>#%0-y_l#4 zVd<_XZ;HIQ+diwQ!RoE}QF{TK+|`kHA}jLlADk!d8TxGYk@|gC)+@13?Ykzx7`aWlKrb+AK88~-pavXqhdmcNzd*M#UjV! z<{!epExTN2b$>~edZSI@vIxmM-KSSe=Nf5ON2oQ=yaX>-Q{wEMJuo zC%t{!^uuyeWm~V8&OB^ByDnJi)NK~ti)>+2Zz~pUY}JW4#`w|%)XNw zV{hI$ve~haxxFvq2Gg1~779%q%Ih+ij*0|2utG6!#?@2P0*?BHOuX=*r~knGb8{h? zkumDG@0Kf^y*Itb!c*X#yQGZK1PmiKIt=RRFz%#|%Q#cWyNoK%+{;}gpLUdQ(R zU9wL&v+UWU&yUhuausA#=SOdI{d4-!9`kRPKFUp9U6b*5o(=Qr`_Ac0PCv4=314~A zI#Ep5O6kJtUu!0v5SKl5ed~|>NB*t<88W!_rC-cq*|zIjW2(fZy!9RW`MPH|8hhu3 ztl$wcZd-ng6n*8AUU(tS+{|pbEGygLj*WUhNey@%FeUAO@;)7ChlO^{2DE(0NaI0>0X#A{uwXrkhtX1txZ`!Qb&iLKg zOPZabq4u<^NC2a&sLbc%**uedm5%ac#Xc$HTD2f$lD`8hgQsgj9rus@%m28|yH(Hg z;@7tI4|lhf_8&PZ6PWoVPFlQ{FAVb|1e3ktVPzkRN70;fdxZ^svxDir?|iuJBJ|G=bk-T98k zZOV*W09Xb*mPs(tlHO->)nAnOmxHQOz@9 z>Y_TqnO@U^99fz;l-Dv8)o;0eH1Z#J4fn_VZk?pxZX0uRbieFi;C*)A?=|bD2VdoK zHa@9hj{48QQYU%vL;b_}_8Lu@Wv`wcyCHr1x@Gn0<7(cs+ikr)wLPB9e;+>K->sl+ z%UAzl`Ec&xx7z4OelvBiq)*f_J862*$(H-LH#I9?ufb zn~BS21a@#m&V4%1<591uqw3r%CCoYwHtvVc_uaaG$uGIq zcXQrdJ>~E|?d8*TCb=GPa-U(IJg2N)v77(?Af5$tX zZ5Ov07!+SOVLbjv{iES^lX%G*mtEWE{d@L4@`}lA=?vkL)tSlVx^oQN_}Jg8w0Z7S zezwC>LF4HC_ISC3AN_JOOEVwVW?lB!Gd-YjYvm>TO@~$Iv{^>ZF+7s<>Y&WyIwNt0 ziSmc$>b*Yr?VsTX{W&`M3$L2WhI{UuWcylo?bjpIy_NcyIhO61q!#m}GQ*Fh!$0`L z^oMuXAF6NtC;lOI>%o2Pu9p{X%w8#+9kWY;Ut7xU$3os_b%wzAzg{Jcea1`I~v5nG{<-ne}Ra$v1n+L zmHrQRlli|`Z`MDss&6g2XZs^%pXR;~WlNXE+d3cq<4jZR zi=Lj^ps<>uQZk6~OpWD_zpH-yXLw|{@ge6wiHg~WgJ0Z>ypnGkz1MW{Hlbse9J~&f zDqBp@WH=_lJi+7OvHru|=YP1@X;yqbu<=RewFwbF+WoqFw|%&`^-Ph&{5PF%mQR-5 z^M^+x!2A#MhqpDdD}MAx?%8LxyKk{#zz0C1X@U1L+<=_9_mC3g<)S80JBT$(H!ig34 zk4uRk?&pd7(SBrBPgGcc+Je)Cdj2Y{p`ihhcW1PQ1VnZ+FnNeR{2ssU+T{F4zwLSW zTjz_&N9@}=>D#Hhe{3dfy&^c3@8g=y%Cbu@YdNIeF=ESLesN1{-SnzbU874M*Dl|b z-4PU=Te2{ACq2*Ge(! z-aX<~a7pNBa+g7ck=Kizk1ZcH*z$FK{Lk>irB3ya@6SJ>>(vjx<^0d^jQOGFnOQBX zU)n7?#g)G6_9CNslMU9pekgA?$!EwA$k@f(_3~GV>fB_$OUBlQ>E-3Bb8mL4&X}h1 zWU_;FNjUGv^he(&eyBctz3SN7%-ZVQ^yK1|cb3hYxcP8qp2&H_&$5i%&lGMg*{Nr? z^0|nKe%~+gjy=f_|1Skc2Bgq=kBr}hbz0coLId>rl-k> z@uf&$%>F(*^@`+&N6gMX;*HbRd^cn1(w?l#_u>p*O^7}w6*>FwlrR&LyLL+KSzn<>zhL6rCI9jV$S z*TaL|b90$YHk~zY@wn&~IkTUEfm7wml>qi5{~7q}O#aw?y#My@NA+XnbygqlM47kz zF;0A#tMsZi>aOCh$|u>YS1Km`sO?!TZSX66-Tb~d=Ii?ujz8#co2Pl%^go06k6AxU zZKG=W-dSJSu(i!%@x02p+&Vc)O&S8iyK7e5IH0!oT^ECP=f{-!g4e?nA9mR2s!iWm zaBItVZM**rj~cF#G;L^Vt0@w~y#9(fnvrl~T3r z+lfnY?#<~RJ}dCfkJC=;VpzT=voO2L_1j$Qvm)XXZ1?o%YrAT#UKtd4rD<*RVde>y zqMzd5e107Mcji9>$KS>k^R!(rFW-{uec+$s_U(OlUX}f4Fr0MnWdN(WN9bn-h7;n& z3}?)18{?Vk4+f{#b5>0MR`&5|0{h7#tMf;ibZ;sd}lw&(0p9|$_4iOrN@5U zewf?d_x{1|UDx*bF0(PLbg~tW+r6Q;&GWR1k=Ewo?;Yn1tiw}X87jm77_aO7&)}SY zg#VAuSN(ssG1K1$ez+Ygzw!PNf36C($5B_ec5Yc2CR|!=`t|FP)WiM)l@hx*yFOD| zS9v1vWxQjcgIxHBs_O@(Oqca%KlGQ1$qvh3wj`=b&P*}cDv`Z{RsQd5W3~s@_@)3*01v?v)-BUd!zEY>k~dS`OM*& z^~=h-VqvA6#Y8#h>8SzSax?9=sxnlZKPIhf{FuFAPwm6?Y$ucJAFa(k6#grx>h5Hh z*ZI#}!Z=jt7KK=!iVVLPyW@a*&jmZpAJx8p`*ptTo)%H#oBq(`!qX4k$-n)7yXxA^ z-_V`EFU5#=mEj4+_EW|2UI+6<*VM%rs%TCsJGRixU%k+_X$J^qXL#<7A-D zJMoxrt?+MyS8?k5e$=jTeAJsHFMN9WYxA-&JJqI}3jc0yag&R^tX0$6snkKtAGx)e^|6E|+(ZaS&+5Tu;>A(7pd-k&ETR)bi znNPBsF3nfC#cjQ^d5T+JVKe`+7d7_T{5^jZAD;ZuD}T(+ZY%e?tXZuWBG#;p;@|Xl zQ)t@3LZO^4)#Ecxo)b+e?LSmiHhuY@$RFy9GqxAS{qXnwQN7~yVsA^;c`TY}kA+!B}A8Nv&lJ>6ZDr%m%@`Gh(C|4*zFptJ(UWVd3{j z?EgeAU;NL&^E3NDgY)|%{C_l;uUma&*Zm$HQ+;ih58LLizVU|rt-007t+jWLomc!- zcrJ66c*mYdmGAtI__=RpO4S(H?5mx(CSN5@;-^cUQ>o;0+g-&DGROZIKVAQqA2i~# zY~F^o|3ou$A4|{YIsdr6qij~wt?t+H#z!va?%B>7=HAc#FLJlmj(_q-#utxP)~#Gu z#qmtg@{|v0MA7V7>E0@<;T+vry{=F&wsKEJc z#XrL@Z~feVaEE{Y{_Ol-IUDY0FL#MM&k>lKS#Z>zB$~+0(?cZiaGcI4#@`3++(aXu-ANv${W#9Dv z*#2$ahvi)+GsWWBez1FAQIcAtUSid@xccdl3odtM6T5_Br%aG@jf;%X-*Z~XU)Wts zXX1{-$~{fC97|myE{29^tvC>1z_5Tl-28EWyPf2Zsmt6GALWW&j%ZT`?gPI zlO);X)Me*#B;L608I#`oNAuCyx_|fb`F}i%=en&Dt+K7(d;2aSJJ0*O948)QW0whF z*RYZODF1Nz`G@ub`h8za{xi&A?_S4s@7TTxSz2q(_MI-6WGuH?W4+6V_KrLo{{;u@ z%NJ$Y$?PgRsW*ES$DbdO5i41az3bsKl8k8Luw2LgPjvf{{l9d~?SJ^)tZyy9Cvxel zue5X1<;ZLEk61N{8D;V3%I=&Xro!9#sfUNp>QRG@^|uFGW6K|=O@45?VoH{s-ABHe z5AC-o{rjk!I>)#4eC+=8?K39+xPIZH%LJE+Zrw5&3qwT`G-Me>)=KRRIwi64)Fdkz z!HGYFe_md}u%7+GKCX)P2ix|q&c4T4EiWbO=Qi!z{iAx}5vjVnPj`oKoq4g-T4}EI zhR*@vdjcKgY9IFZ?vuZ6I>SUZ$of9}k5xG>7xuUcY}+xTZ=Z8p#yW?036%`*yS_-R ztzC92D^n;g>R{Q1Qv^wXyfH&)9hf9fJE}9D286OVJX?o?Zu!7z3!G2Nu?k%Th&n%h! zS1LREcDJO$6@`q`dyGUfl~s5@8U_V97@TghFx?+{OLpGE)RgexE8)R=%JnWC&r|4i ze9_S`Nu++unIeB%hKtw-v-jKoXLzvg2tU^!@sr2@gcbZ}c)_;cLHj}e5AEER@BhSp z7%6O<^k99@!aK@NH>CMv0@&|^$E%?2FW88idttul(>)vfg?w371$it9IQ7bnL*av? z?CQh&*i?@nv`ziTpUv7fk=fh6sZ^3vyL9=}IXA@YKi#{M>hxTn!;RtXTiFEYr&axGuca@JtJPcu+e1M^Bb)D`9 z{##E!99#PE%htqUIqxI(^731HRE753kB zRliibS~|m2`e|?8y2qVikw+3b4sVc5SU6kq<&MW|i_QKs@Z@fJFZ`o9>T+qXzjtlj zE9tvl_ih{ts!VRuE^xNVdAUm?$w{>R?y0v)o^M`&!4?p3p6@~_ z4DuWs7f9Y(=H&U=YBqAnDF!S@)E!U@CUl!gQ6{6(Y zXOYOmWb`hxE~k}g@4kImKTMaOUHI>g{Fb7-&BEDH`E91w3djHE2;Pply<307BqO^m zj5lfof3&Z-U*q*-<%io5`zD9(`4Ibc%Cz#&4QjIveY@eyb;5yho_XZr`&Xw5Y>Svw zJ8fV359L(d=Wo~k_RRX&l#{gm!?PKx@}Uzt+yI}|SvA-6GJn{U9otnoU!KFthZrHZGl*Q;{&*Y7s zuP^eiTpxMSj<3T0@b`Zb`?p+7l#|(TDZ!n@=i;JjHa*F{$|cnIgtp z;S0JpZROr z!onpL%$~b{^sjYzCfPUP)U4bk%}v|I-~XPX@YTi0%l`Sy1$_Mn;>B$=KWeT^xM=Ed zYwisB+>7s(s$-qb%)1=zB^L3wTZ4V0(r&2_-+!>Ks`2_*-u@@{qkZV+*+Cc9vEG}y zq#{W6@vfr0j&-{BJk(_wgCHsyBGgrOrkF484`!6s1$TwAN;qt@Zx=)Ai?M&U) z{q*OPpqs8gr%!JD%pVxOCAQw@qi)CEOQzDkVP`fg?ASCnt!L95gF8!lnmClV*4$iP zVej`b{OxYhMT_re&gc7MsQY`%**RIewtn`X#?0_gx4W^2>4Y0sbKJ`%8Fjor3?II} zzsWuEVXxY=f6=!)Rc9x8mlx_iPdZl=dv^m{r3!-;7sKlnYyJwyU*6-HlK18GiS@Zh zdWCI#=T6c*tjxFSRE1W7<11|^=rBFz=r&~deo+J05AT0mKOf$8if@=F__4Nkcg)d; z{vuKLGdwLi_iWxs%Z`m;Sh zDp$OkHc$IU;_^e6D$*n81x74-dR@D*mShEsEgtGAJOHm%QL6@inr_T(bIdczNgy4X6+|W<>`|$YxYk*Tds4q Vt>(FEr#d+ShaQkajnDr7CIEsj6yE>< literal 0 HcmV?d00001 diff --git a/doc/src/Eqs/pair_cosine_squared.tex b/doc/src/Eqs/pair_cosine_squared.tex new file mode 100644 index 0000000000..96ac6a305e --- /dev/null +++ b/doc/src/Eqs/pair_cosine_squared.tex @@ -0,0 +1,16 @@ +\documentclass[12pt]{article} + +\usepackage{amsmath} + +\begin{document} + +\begin{align*} +E = +\begin{cases} +-\epsilon& \quad r < \sigma \\ +-\epsilon\cos\left(\frac{\pi\left(r - \sigma\right)}{2\left(r_c - \sigma\right)}\right)&\quad \sigma \leq r < r_c \\ +0& \quad r \geq r_c +\end{cases} +\end{align*} + +\end{document} diff --git a/doc/src/Eqs/pair_cosine_squared_wca.jpg b/doc/src/Eqs/pair_cosine_squared_wca.jpg new file mode 100644 index 0000000000000000000000000000000000000000..086bc6367399f13c1529d860102b13ee6130e5d6 GIT binary patch literal 6780 zcmex=9G120;#nB*rbwj7khlf{e_9jQ@`?$TKi7vND1J0~9baF|)9;v2$>8asNNU zuvLJ8iIJI^iG>;DY6b?zT1F;j1{Oh9Aw@$+HsQcTcBMiQqsEB~Ih36?9uy6__(8=u zsi=vQOH5osQc6`#T|-mL#MI2(!qUpw#nsK-!_zA`Bs45MA~GsDB{eNQBQvYGq_nKO zqOz*FrM0cSqqA$$M%wS)E2#Ckf{3Xc1#K^?L z!py?X%EH3H$W+e2$iytj!m4P(ZXWYowZ;xuvL#)F*7#z7xMlZq~KiK&=8 zRQ(9@8rWyVd8~;npTRwb@YgK{9%e=cCP8LF2789T!Hc>y7zP+KAGOcOtv`C9V*Nw+ z)<3F`X4)vKcbT4Et$o%_T0-wh#G=c2?;1j8Mpjk`q)Q$&eNoSEWB!PrJ7dzVipfX6 z+nMgqZkuY#y;{23&EwPx!8eVe9xR3@C4cU1tvr8R|EKPMhRyr`_WbJqH)E^Rw^s}r z>&<>_|HvJ9QU8lRdqs$=dG8;uPu$K%`Q83o`txt)KaG1SP{OrS`pG1f6D$*NL>|q2 zP|vwy|JC$qr+v2S7q80NF8xHKEArVi=f)cwZ5VGbFfd4)grA;g`*-7?@Q3?3qATvZ z{4iblYCr$Fb-D|-U;pZx#cR5xuQE(yo$to*sS0T&hb_Wx9qek1d-~9Ny->yDgXI%{ z>_2?=L9f^Iv)j#f(Ol)c?8MrV%`^9$w$N*qUBIdk z!>S5 z(z=30AbUc7*R}r)Vs-`;hni|X)pPyW9Qb4ZNAAEqm)pr~0A!Y~|_~yO-56oa`v=E^gM{$IorZJ!8o~ zaR%XycVz!FFjrjn_|gC1ul$i;ychOd{2HCIYujuIRf%*StJTaCLOyXQe9~YRK2k5V z@95*-{46i71!m1tns@MPbnA|tziq_InjD2rDz_9xd2)t0>^GmTs9N@U=YzRb{~3RP2Kll;DHH(1F&A*A_)3FE6PfvyZ9fvyZ8SJ&q0m+U@WZGG(W zx@WDA+de8sO0jD>oe*sd(<&%%WS6<#m>KlP^+)M%#~&u0)O%G@4xbWb^ldqA@Oj^vlVTmLTjCw}jBn3V1QBk^2k zS7!;W5i8SNb9?4HmE=~B%XN{R3Ji=k*Uw3XA9>HY|Lyya;Ya6bT+jKk*8adgsf{1D z_DuJ0$y86SEP4I!l5B^6Tw%OJikE%dYO-P&hrFqjy^Y& zVc|60-XG)_WzTb{NVau(SDZy3=f?%|1%udzO+{F!Tzmn&u(SB(_Q8|Npn%cNhQGvr`%Zt z99aTbu7oQ-j_<0HZ~W@3@4hp;*ZoM;isI!js&e8=pPpJ~z9Xh#;ySmNGOKtRB7_+4 zUnsSno9xy0?!D)p3-46!?mG7OVdmn43V8-6m5SKhWInhR6fv+*_*3+sVbcBI*8dr9 zoL}*u;bnK=`n>gmKc4<)P~HEn{6E9S`GNl#E{iRW+x{pw{x|dCs%F(CU^8-3x#+tv) zey}$Ak^GylkKXfV6nK|cR?F^~cInQe=-Ht=JKrtzbBlZs8Nm0n;eAB>hP=L8=5HE5 z>{QA99Q#r^XzKa!>X~v6XZ)V5Y5Kl|@j<NOFOufpSB={(=%GApm}lcHr_Eo;{G^ArA<^&S6K@^Op2^qU&va+8xQhoBGMJOUt@$x^MUD0k{ztj-E|wp4FS#yxv5Nmp{=28q)kU^t zdlr6t(Y9N^bw7W}`tCI_J-5H;$o1ZT*BrO5 z@37yzzwJAt==1)CSC$0-aXNMB*#rJ%587X`)=E3bNj~zGdwlpm!`9mQeWu;nJNH=F zNc?h}Tbi4#dnzhU`o7r%i{6NZ(+u-OJEZq4i+Rp)`$y)3wZTX1rT;{JOpn?+-@EO- z&$bWG+rPYCai)0Pe34$8>B4T6?$a_kIc}tSTrS}8TE8XGfwkuM2dlIn#UDRE+J5NK zB3Y%h=3~29l$R95ZC?5&`-axtqsk3dwToZIJBFW&7g}Z~^>=3-*L{bAd#WGqcbIsu zFKK?Wz3`uP^S>>OUvfnP9au%enHT-&4&3?U>tk8A=w-EPrw>P|e%-r~S@5jwwKbD= zSe%Q@T_`iBrdi_T3HDl7(dYGYdsLVHSp2ZObAE7}_tedo^i#VO3zb}=Pvq~H+7M~j z*zln7R)h6x>)W+%m$X-VKH9Zyrt@(VJy}_QCy4_09qYw^O#IKFp7p#UsL1w(QYT}zoiRb z{^R>_sLlT7_Dg>^hwVHyVfPvTC(#KHCakr4U^qp+f$v|J_KAJUb(igAKCo?GnenYk zzVlDvn#@3*TXUzkn6&TDwT&#-nE7c%-|5dB-}9B(^EgzPuV<{+_#yqJMyF3 z&gDO*e^lRAr~LZ4%a80;&MRx|KZH)H zirM~+M|JDY-5RS!_XHQIL?rs23z^{aF=6f+?OPcOnD$(I7vE!_HT%uBee7npZ=W)b zxtD))o_Uf@y2Lr{ODh)e>wn&7Qh$DZ!+(YkYTy4e^j=?jOY-a*`%J;^x!un?IyK~F z-k!HOS2$~07sF52J)$h}+xm~ptv+U_c*VwC_IrED3>*DQ-v10Y9#6Yy^SGAlM1^Xa z;E9t5nOt)cp6#3a;p@@4*V+@+=GXpRo{|{I`+n~8%2#a6@Bi66w%+}9_2%10OJ=Ke zs`@lTVMHaTcpmvwX6v~ae}1@*=$AC^zwmEk{G^K&xK45#wsSug*H zKeiQqq~5yazEDMRV0YMsuNp1irf*13S>b17#3<8b;O3^mJn`?+Jmt-Q=ls+1*R$EN zM|0KgyqArcnkIE;%YriZZ=Qc>x2I=j?jOyiE>FIy<~(Bm87}<0EUR3g?o6EaMIF1` zIP<9ve6JJzbHB8<zD?^R{N8@kj|IYiTRB`O};dw?s`j*+q%K=rHkoOQ~X{~5&oFfXsz?kWFK{mQ(u z4byq{)owbkQgDV@Yg4D7nC}uM^9Ntn?dxLrx%=Cs;QZfi|IU=JsV|zRd{y^^t-0sY zb0YuR_Dx(r_di4KjLR+`+#B~){AWGYP+;_UDu1R}Z^1pZ0;TJ_1 zpGW;?I1tZUF+FnkRlTqFQqILC|57@a|9Bm}xzYc(z~PFC$80A$d|UIM;YZqhj{gi7 z;vcd9lc^W@&+w_V^qmDQRtUKh8clYkRlJe+J%L*&BUVzX~{S+v23jQaa0!N-gDyOp>C;}OEP5|49u;C&eVFU%v*B(+^3*UwXr6d(8BzISo4T<-LS8iBXkeG}teg)1o4)^xkue^7Lgcf05+ z!g#Xc^25E;`}A^`@4EWOd6@}EfL{07yAjGw#nU2Uo#l(qR%~niVD3HnTi3_E6F=(r zx)l5fcbMU|Piw!>#_GKZ0_UH-OO=aI^gJ}J$Z*H=msw|<5AQ17-m!k`jkTes*|(#s zrMoBirL?ineB@-@qaAamLh|Ri;>HG^_pCppt{?bz-5}~!)U_q*1#f;`TU}W9y0J&w z=S@g8Pq_JS$BO5N=W+h z?tkXCAN2ptTrvG;=GV7ZAK44pKY3%vRewYJ$o|v*3;6TanIHJiAZ}y)QT#}p{)I2r zC)2O|(X26f8^*bIN&BfO>mF{|)$ppI;PiyDc{kKIt?^ZN-m&eY+}721PfL4OC~j-A z*xd2<(Y*je+n7C@4Q&lh?Rk60!R*DNE(Y!A{5JDy{g8eTvGziJcEyw*{Xr80 z(!67}gpJnBTa~A}joEI;yX+UcGJCz-wYVD`a*7y_xxcX2Vkiy0YVzgkmeZ#t)#lyR zORR{Bj+`Yq!DvFHtVc@XoHlla2VGlT87j=1?IbEze=FO%v;9z2X?y<`%_pDNwI1j? zeI#i6_b0n7+J5;RIQwLq)rn(!`47&Qs4;$A>-nX-dgYe=f=A}1+>^hSkZtQ^DjR)r z0@KU+KQrZ?*v`0~8@kTqw)g4P-ZS4O%zJim=G$kJ49;^KO-*X)S*hirQp(cBusL4q z-}ySr_J`?j&VTE5bX)r|=-2z8Jy-VF^+^Zrzn-#V>MUl7pPTrO-f;-+6g|md9)2}c zVta>Qx}d_0b%)h1?&$aV6~I3G-`RNX^>*BUI6tH}n`$rFd*#b+f$fvsze_#5xnzp^ zZ^gR}-nDLRl%>F0a|DF5K@Xh#@{ja1e*|%38+@Db!ci8dA{@-@- zS>@Y)mG;D`U$HqoduN!&Wh=P_Y>^$zDve*2_AYk*C^q>~wcGBCU#)GUuErd@eB+MF z2^j{jX+drUj>mT_;1@Sr{$TxE?b4M-9eZRyS~!bbF7dXl9EZq|g5w@J(AJ6XyHM#kxVm^S(Ge!ln&tEaQ>zbs$5DI;R4jlii>2b$Kc z5uG}vEiAy1g*nWG*C6&SMo|L*Dew?{rc{_RZZc}Z(1vp@3b<^JJeuT`FE}f zul14ra&_iE_Hk>t&0H26S;6iZ=JV6+n%JxBhU@AZ&RepSe`+s`cgvg=JFk2B?Hifb zCPYNsR_Nl6&bVf=$iYA~)PakA!Kz>K?I!DaZr?e$By-!Y6m#?7xO3ActVxP|TJ-7E z0mkWNNk{ut=4Iu^oyzt0+OuWbzS%xI=85-N-%fR##-`BlLN?NyZ*kGYi6@l17(VJ2 zUHFsxcd?0g#*DKM-nSL){rkEvY1j3o-6;aicWygspStnl^AW3+%=fZ|5ANf=w1@fO z?O1WQ?PlKs@^W@hpA;$E?WxmObY6M4@#c-HGdoo#N0*?-F=O-N^QM3$6*fLjkU*)qc+Swcb@ZbEE6_>p}rU;#1p1sY`bj@_Jr4DZte*(M81UAq0CVyw`5ni1s#ou9*`Dk{e&Y$GRYkjxw{_VN{T7=`) z0Z?FL%C@6N`?m$C%*Rou)lc=Kl97?i4V{6`(DtA3pS2= zSvK*u%OwHEq7@7}PAksGFusf?JXD0u1uWv*!hTJi^KE*8YiVYow5y5mf{G_@5~-;+ z0*(sJ*GWIt4I+#|WN*ZuH6?hoHuSFjlVUGIBo!S?ByuXbN#Jb2)->9s%yR&cj* K@X+%AZvp^TjAv2+ literal 0 HcmV?d00001 diff --git a/doc/src/Eqs/pair_cosine_squared_wca.tex b/doc/src/Eqs/pair_cosine_squared_wca.tex new file mode 100644 index 0000000000..c086be9306 --- /dev/null +++ b/doc/src/Eqs/pair_cosine_squared_wca.tex @@ -0,0 +1,11 @@ +\documentstyle[12pt]{article} + +\begin{document} + +$$ + E = \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - + 2\left(\frac{\sigma}{r}\right)^6 + 1\right] + , \quad r < \sigma +$$ + +\end{document} diff --git a/doc/src/JPG/pair_cosine_squared_graphs.jpg b/doc/src/JPG/pair_cosine_squared_graphs.jpg new file mode 100644 index 0000000000000000000000000000000000000000..43559d7ca0deadf00b4e655cf1a53c69ae896a89 GIT binary patch literal 29869 zcmex=9GX20;!+E2cfnjDieIf{e_9jQ@`?$S^Q6GB7bSGBUsc8w)EV6Ei!<|04_{ z$l?$M|8FtyFf%eR2`~#VFfjfNf`}FrF)%PUPk?YBB;&yo77R}yYzQgAlGv5S^Vnda z;`tTx1EeiX7}ewOBfg!J}dcdbSq+D zVBj}id4hp~fjy{XC4-D`ss>CSFXtNeq&+`h8dXWQJ0JOKe(b_3h6hh(X*w`4Ff!zx z0y&IdsN{NcQt*6T+g`yfHoOxpYUj++a$o?fff!RU?*NmzJQDTd>EL3lz)llBtYuz$)Za93NH6 zG%#NH6=1GFbEy>fXXrQL`_->GJt_e=96Bh(H@Xr8yHQ% z{^vYgR|PVYf4<1F4}wc4Ffc`|WMIkw1p@o|{sog&4M4IlYVPbbbLiD+02yo0&wS$w zIIl2xih@E{-a^mkL8&@d00Ya$pn`&eGBt2MsQL4Yafz|d0|o|$61%iooi8jmcNu|9 z@LZ60z150HB1ITgE6b9CqzJP&&fA)Mw+XFTyH!WabQ0;=} z9hSy81_q(!JKY#e(pPS0U_iu?py~#j&Pi(+7!iVz{j~FgA0@`ou@MhsTMFWMSRs{U;um0TU2e$ zaEv-34g5?DzYG{8*ckUQFfi%_Pgb9}MB7IR9F}%=O^j^`(i<3;nWU~@5PJ6G6i7)3 zEWQ|67J5`SH$O|i?7$%O6jb8rz~q=X_JSP5X3115!N8~&!hjqg3=9Qs(-MAOEK6lz zY|8+Zk%)+9(JWywNng0b!Y-xO=7b!Gw=T?BX1Lw7H3O6c7&wDkdNqAFFfbWx z2IY{AK?xGiI+mD#OH0+WJ2x^2w$A(<{33k^LPde!%;#!bKxv7Af$`v{pda@d7);ue zL0OkGY0f;O^Tr98;Ib@H*mVNKQ9HldfO8BCzS6-74B%jeW*Y_u3%i2dnv}W~wXSFt7(DtOU6fUc50dNC}1PG3HdRNpIkowC6iS((&L4NCCm z8}~e5Txn_6t|04M_%4lsfkC2;bCc}>wmDzT5||?@r5hL@CCK*9V7Mmd_JAR22HO#M z1;8Qn0~Df2n2BW{5)UhrU-=4Dy#D_Y215Y`MrLLvR%R9^CMIT(1Pc>0D+42&u!4Y) zsDYWFh^dl^Lx7l~p^b;4*tyTd%>+j1}cxrne`PUTYYv^M+ zgX?0;*|nmIR=FP~Za$S%R4Y_WF^rV{K8Y_aWW@tU8>i&wr>p9}$UmFdH0O-Mjn_>A zIw}nx*B=mgQ@!KK;)E!HA3Gflo12fb?_QOrEvCS;Uj9h9+zrPR!G@h3=IZ+WPFn0= zEM=;eCd@mkGQX!zq$zcZ%FG+L5ANAB-LPNhMduoi_m4LRvQ%&Ho2SBLAl=GyY2CK{ z?AP|z?~cDV&t~4@wVF|vrqYOT@sttWwy5&@`fJ?lHpG@Ty-7k|T?b3A zaWD0mGMjnQZY9}gU0Z)0EWLVa-MY}yqSdRX$0qE0^%SIPXDJS?nC6w}oSJXlBpoqR zaYOsQCj!~BFRqE%IsW9l61!Jsy}S0sQ(uaZ8SAdTcv`GKS^3AS*tI22R*w{Ji`H%Q zmCn$~I=v-5^>o$tru)|gCd)qWf4eqj<*(PT*RR{R3zd2ny3T#_+vJn>3XA7(&fDi( z`YF?R$;yyQA(kgSPmGEVG(~F9?3z5QsM#*iv;CTwm0r#D)D7qPPwcbKv;QW$hV9>u zoE_U0-re5+qRin+rTpoL^-tFX2*33Z^gNNW<>raLy$y3FbRUmCnG#~tGiP@1UX>M( zpFHcdlB|EyuYT+Jq&jE&k2%(oVnHEmiVUvmX@v7j%k=VoIo30~n~B3rT&9>9ORK_KL1X3a=*f^6L4RO{`=L+NG^p5PANo;*HcNJ?2T93|oWs z7Jl1d{hvY3_2V7JX=0vXClBmxuT?b$*~|WKmYfGpsurKh<#NY*p1WeU=OV zGfZH8H+cfX;veh(OnmZ(qq+35ZP!#qS&@a@j4k~W{yATK?8&o(iY4+>oRRZ}LVNrffpQ0Kw>KR)UAJrowm;I|ZcbgZ{4;9|rrojdv2JlmJB zyx)5L?e2e@Dz3zwewuVqUF?~m*qe?Ch7acYI?ISYHvGh@qR88AXD?Bqz60cl-w~hu zPq-TipIP-Rv{-BB)RaNxkfL`QLokH0DLj{O*={@AkC47gttY z*_#!&RX=L_TJP(&ujhR|4;6^Nbp?_{$ck;7^_J5xs60q&hB%Ar!a-P3pCO`i6 z_&-D9tt0;#mOp=&JMpJVrQJ1~$zOJ=AAfuN-{Gx2_3lrUr#Qz?a-aO6DxhtdY|Xr# z{X%gI^zOcC2Pyi{GF|0)Rm-9`GHd5_ADgpzjnzh<5|6nXd`$R8&j##Jw7OlD!o z_;%xy|D`AMtWtSeT^^4@$YMGdG<@tu_ z;CUy%E!Q*5^@~+AH!ix9m%ie#cT_~(uj^?S_UtI1w)|6&hS4TZvvudfS1z9VN_EcW znL1CWOe;F?$+n4Q^I@4OyH1FC9_3~8K6m8t_PvjHJN;7EJ!ulmb$UhZy5H*++pf;w z`gLOFtc2(dpB6g*)L)%{ktf$r{S^CW{S?tt`f9h1Pb$}QI&|XqrJcfw0{2Xw z%(|VctCZ#`*yzr1CBnMMzaNwpGk5<=d+j>Mg>ldK_wo}pU5&ezY+Y*RlrCg4d3MLA z+BKEx#R}i2b>+sqcqggjb1=~0u`~a{lx5D!ccJMheE+gqcbkAqe~)UN^gXSv8&gwo z(dk25L1l8e;FCX+rcE)g7T$X#W7Ditsb0oVo;>-s!SPQ{O{^UcD>P%a9lxXdr)fUaA(%_IY$=- z{7~BBJu%`|UdO$Q{~7!;4{3xwO4;qT_p_7GY(<-}%`qp;CqDTd@yYMalH#C?A2#`( zY`-yka_yz0M>pEJ6PUK8T>Aq{zSFiZi$1K7*(TI_^GKPBY@A=V&VsTXJ03;3*>OMY z+ygEV%h!1qPX7ITnW)4S8QVpyHw_i86ihT+d&KSiNjrN`nY(hye}?xJR=48vIJW&Y zKYL=IXW+&&uB@9CGH1q}l=DAeS;ki>$*{`9eZiCdC$%q6i(fiYf0uh(RA@)Sf~5K0 zyGw6Qo%beXzPyXTjWye~j2C=;@J88h;kS+d88*C4>AtMrGm*P@@?C4gifaoNzU5Q9 zQQfWKpU|(q)P39X=C%rVzT^2yJ3feMEjl1&Rli^CqLb{#@3$pqER#9md#f<+h(_3b zm-=LtA77(q9Xa%w?||yfX$jn-if%U|<`kN_lxG|MoAoGJOC=(lyG%c2%VL3t4o7X; z%g&!zA;v1YpzVzyI3)i(;4C~A=g9Lh{69lV*-I7)pY`b~KmP6jWyHyEMWS?{urPgP%*DcqE;wcS_H=%JZ>(w?O=Gvw?M7h@j1 zmort4xVv^Nyzw?=zI=6LSePB#jKY6seUAPPI4sK0+5fja*BVqwMX_OjnV*=8C$g)=BTS ziPJPsv_0fVy<&Im_Wer>-bMPBod9Rss-Oaml$cDLS*?N-+*ca@$~tH|lhI7>bEMFW z#Ep?}pUjsBRUY@O=4TroidNv0`_^f$yh||ca&^^BzW&bjxfiYld@tx%UwXoBQgXj* zhgQM2*{z!XYm16HPgL!5jEz@Vw|+u+_zCURPeiYN;(GOywKS(`*EYx4XoYoaCxnNc z&@{5--db^T^Lp`qMuEL8O-ZSX)tRS1c)cQV`&pw%=dKeS??9pREBelgEnnT;j=WdN z^6s`xJ)AuKS>M}Jd=bXwvu2fj@0~qyPl$lQwMR>CmN}{%xU6sH9P)Zas@8Yoluf53 zvUj*o{_w#oAFuTcJeI!jpTB+MMFZiP&(+ z--G>Dq?vCs%YoTX?RNUF3w}N2*HgO*f4Y`f!Zz~ANL9QYku+m#A6Fn0#@s+=lJm_!ko26^%K7>^@dGp=RLs0ym3*F(8L(lA#)`YmcK;b7Ua^$+&SYL?g7-mH_oC{{>aoL?%npFQD--Aaz1P9DZ7jrx60P9AI6+gDuVD)Z6ju%}Sc zH@igLGZKZ1Jl`0-SE<|N^jN7Ua$(u*Zr&wa!VFtCbSyZnyqx>|hJ})reZBH;XXWym zZ!{=8QFV|%sZ3T#WUjrKr00#*kzrB>4igM=*yf#d+L9cr;O8dkaOTZRrPsz%22bAT z**34dF;RZo@tK}Hn|XgzUyye@aZR7Uf@ktXcAH z|EsqqZPI`ILBq*{NW;va4i&=&aHolxkb1RoKu`L_x{GC@`^P%4Gp%V-r)S!p4b{7H+!e5R^1|Q22gMR!4yw_}BTs7XkWi&u<~ zaNn*i(TY7g%$0ovQg?EFeZ045Wku$??zOpQ$&%LglM`n$_ouJOE^k{Ta#Z-#wD|(j z3*5wdW%nN5*R{(uTEVyNaBj}da^A&tQy;#|E_M^$dVQiqNn7hI>+3b$F5CRNt}K^6 zb^UJcWud!Qr&wJ-wa9Mk!qcfSHzt0Hp6Pn5Wkq{bjO%}f(8Z~ol3Cfoak;XKxjIgl z9u<0OxLkKp$_$}XCfi-^na_@1rKH)uBKh`$J<4{_OKcxn0{2ZCUp;yw~9AHjiBHubPp^dNSr%Z*P}3 zjMfs_o_~19hiuvE?q>cytCVI`=}s*wT9TUNc0w)g+|*Y)R;_3;uPnKC|K>M=Tl**9%RF8f zrNyDK*5K*3z>|eB-5b)RyZS9$=VZh@TzV^D%UVNkkBO7Z47Vz_-BOw0(siqiW2MX8 z#MS(|n_NOH-uX5v+jnZ2RZJ6I8qD-)!|DgTyB~9>R|=nZ`K@cOF?;P4b$wx8)qGCb z)35d|-LyK`M>feTr_6P0?3t3a7eBq5c9?Zi!|zSOK&oxORhGF9VKm$`A}u$EiO>aUczYVNW1>2bgPH;f;#my}L&_@^6pJLQR4 zd&G*%!}6tv3i+G$buq z*)Np6#WKTwbxU}(^7@`7x0dhPCe(1RtS0^TgafMxZv(_MOIyWDn7XIZ*TyHZohs%Mgkwu0xO;_!t%YTNwEgi-wD??dhW#%g{+nt!Mbgb|4%x#UA)Z+pkYN{=apPBc$ z^U~?n+bfT}Ouc%0&!dt}uioA(w2CY(dv7sUXV>oXIeyb(V|SlZ_tsl?_qp)W>ET09 zgIST1yIbeATcLSQla_vVyjW=Q?Oa-s%k|sryn7x@*63Q~rM>h>tY$vr`LB<^Zu=nf zpCQgZnq*#ROuJp@m&aeXrG?b=+8&dYeh@yxYx%WE`x}+c@=K1BZXmf1p^iR@euv4t zhjZqNRz`<}h>FB%Trk7{VsY@SbXZ7}$ zJXj?k{$$HxkKcUO)AbD7xSG2jKJ)){t71;O%DQ8T`Bu$w!Z-2)?SiWoO?|SRqc*yr z{VHzi_|^Xmdv`d$y7ft5Qs%|9oloMAnBRzcv2^LNt~1kAv^SO6RarKvdYs%Rl(AID zJn5uQ|D1HYgImfw^DOI&mj-=HKkfQ-Gh?mP)N!L<(*6FYu``VwD#acvu`WDo7+Vnnf8G%=%0IJKEqS}C#BO|{<2ST+jZTz z{j)Xew@gEE$ja?Y|C;!kaujtNeh<+H=4D}7MHcGTDe*}<>N$C{x4IMY!7S9Y<3h~ zRrvDyn~V8x)|I)Pa-R|^dhPhuWye$(>DunfW%}H=pRM-KO{>$ny#gTA=^g2}Oj@0xUDNi9 z_tkYjE6v`8-Ui7DXC`kvxX|?+n^u$8)#n|F7ilSQ2An=0iWVp@uG;Uc4Ad}wQWn?=1Yh^yR9NDta!D4x=f+J?xu-$ zKFnv2_J?0w9DT$k(|h`kFG__kw*~jBcqqHE~dnqNAX_Oebs+k4P^N9@ln*XB&)Ty-gDf%l3> zTFYeiRE3>-Z77{{Rn*|Z)XOecpKVEXo3yd*alEUhSGCS9Ls@CJ^A?<;3)bpAd=}09 z#yNMn%aoS(qn8(Vd)+oTpq$fi!PPW!UZwa)-nVm~7uEgwzGu!Hr1_{?pfvE?`xKDK6jiL zqxCRQM^9v1;N}ODc1($8lv(EDFBn>A9_MYwt-8cqV}Vv?(7LWNl?@NH1(G)DS-mt` z8g=i&_6-j{>V{pKTPoMPv6c7OyGIyr) zoApbW927LuUNbptkI92=?9wV`XZ1PNw!E1>36h>SJvd(Wt5vH@YerVcx+w<>eRTdA zu}1E!;Zt4|y>!7vk*uw8+T07;nxc#w7VK+1cJA{|`?~5oA&=C9f41gKTEEM8!fDq` zLG6lnVsc&Y=au{}TeW)CCHaZBlozkMtUROKq9n*yyzs%b&c(5d_iPG`o)~lWV$fb+ zO&4FAX&g5%h4;OCDrLGmR(!*qpKmu@a?-xOt|08~``Oj5mD;fjDsw0QoHM_+@1&KG zi*)!T-=kT3H!?j+j+Icld^>SUo?=Y8nL_iz&~ooL^6t7zJPVJVyxzbVIBj$C&ULHS zS+7rus%U+c6DD5b6=!^>UNd)R;mj$w@+QQwn5>sG%WXb+k#pMX!mSB;y(Jel(`J{e zyA*Dl)Z4j1t6|QJ#I#rq!_I4hf{Vl2)-K9eE^005@_ErMyVFd!Uhc}BIXBc|)#A5X zZVH{VI9)lRkKxj^Tvo2Hp`oTX*DPd=48OQE;r4`8P0mp-eYvJZ9=PMlx90-$*?r5D zv`mkL+UycLv#Cj`w~2{El~rTbZq+B7Z9eHgl76$vZH>UD6RzH?c5E}foAFRjqOx$y zpC=WYWhcFTbNTeGD?uF^t6i^5y|^^&u;_P@X-oF5IFY9`X%)x1S!(^J9YI?pgMvj@ zeNVo=x2e!x(SANLJ|b3fTjmrpLQ`MmsgN>z^7l3mS(oJX$yXXwtI@`o*U zVtbC_abB^TPgy6;tmL;@xocJS=F1Tsw}a-bE4=9AwL0|MH^mbfQkBo-r>r_DdnKUs zsMey(UWsqFnBO~l-&06sm(o^;a1(`(w-UCU4pKTbasIi<+dZ^8D>Z#e5))HT{8nw4 zw4VF6?L|M?FK?r?x?kR6pLWxJ=E?6jZu>o(`1kw1VDGI8#1@Gz`a7+B?#bVu?|qt8m?|mvH+RyD%X#VPCf9SM?yfELi=PVd(I)>@ zJ5*NJHI;aO&x`+b>8#D;zTLB;58M=cD)#o)FCDL|pHv0&)``Ai_~3qGYBV@1_9vU3 zSNf;8?}T)bd~|~@m*^d7sS74WKMQ7HYaY>)& z5`AQKWoT*U#ttryo|PIMvxK+HeV;bDThsQh*iHMSMbnD1eRn(Ty>;DxGA!tzmC8nx zC_Vl1KSQv6fi8Pu{JJyQ*2UjT?}kr)8i|xrpw8R7dCxol`}4m4UFiR-wSJmd`$mxo zP0?;oFYn&rbhl=;`e#eK-?H=G%xsxrSZ1{-sq5G@n0pY|#?LvO9v zu6)hlv(fg#8a94sau^RC5zz>Ja98k}cGIWi%vWn?*RR^x_@6=eKE#RlQ&_)b^}BL9 z&UW=)5vTRIfBMbL1&0hZZiZcm&E3Vd_U(;}{-PpJeZpp~-86S!mX^aKlY^n0T(6cM z*|RHn+L7cCr^yPFKCD<@X6wDU`rpO=KR4EYYP!g}nIT}>>F%19P2#6E)f-QKzwu^x zOwY+(jlAPLi%Svahx#j0Wb0Qu-+py_?axPz^wDq|se}BHOzZLSI;eKlUB(pxX z--Q=ajh;R?y>OXd>klN{q%-eavfuap4W!+;4U*3OGi5Vq?Nqqnk_m^t?KR)Lxcs(1RLiF2zs^3K(!J9; z;7nTKlZWBcwrq{MY58>0bc@P8*V3h4Jq(|=&F<&foUr^iv+v$6t!{m`cIh)SmY^GF z?m6%K8uWR~@nYYyHRTU^e9ZMsylQsb+v@rwn(aGdl+M%py00QbpFdn9eRKy~r_8c7 z*?!uVo0d2l?AUJXGfDSt=-rIXx0PIkwCAoiJGn@)=-rkmCu=3H6H#d%lGZDaSC{rq z6?2iDJ?Fq@)!93r>|J(N!J~Q8d)-fAUXPZoQhjaEbE2t#Y4NF?SzRAv??(3aDsfE9 zHQss6H>>L9u8WBg>ko0<2#L*@^0RPn_JKbt&6VaX7t{4#AN#8FGUlw+>0^g`uWk1T zf9U%8Pou|FmSEA)t2y_4`<1olbsdqrHZNSP`Ryj{K%)}HN41Yj_I7lpR_UCX;;T5h zRO8(;r7cm(ecg%LDtG=fFrGh~_v@s&{lVhT(UOsB?|- zH#GY+zcUBF?Ti=Z)qM0R>aSO*OhJ@UjE}%o*6j7XRc}hY^iEA~|Ic9gzS6sA;j#Fy zwwZb!na5|Qy?(;0_qxC%{?ehxDQ!2GK2*6jUqM~QFn8lok7*s#c28b>>eT6|xQ@Hg z{-4*f-%gj;nJFZ#Fuh~x*$Z>FyVl(fPkJ(y^`iToKii@&8u|5DSI?hzI%1~UuH7KU zuVtQlS8w0>Gxy$1wXgMc&!27zQuExq9wZ|CWp-dxY}?{5A9_R=1cweLUu-u=tD=c4~9m#H3S^;zu-*LO{G-}L&W$(AK%-wm7p?6d#5 zMuDk;X^NxBBGt`pEiMnc6&SWCDMhL39B~us*`&c7yEz6_Mc;k=VRNtSf^gH{?9Tq@lU5;PnEya zD-~o>&s~2tJ4MioE1_drvWks+r0iA~VO9pkP^Tv`!ujA9Pw$p@nez9mYbzdTy;=6+ zK~w#nMOU5AFFF(wxGJo5srhxII(HSBTX!c<5!KRJe^!1@-H~ls7D?U}cTHFBh)LOX zee;HC)_GewH%{=Irp33OZC>`hDYv(R3U_Gf`AzflrljAp{{2a8Iie@><1?QKtUa{U zW%^`Rf2;getG2jY+7|X;N1%~aLa{r$N|EW2`Q8^3dIcvYPPm|abLy0XO~OJNNiRk7 z8^oqOx*L9R`^i7&{P!JCy>_d1yYJFn4;mM((AO7TqINoI|TvrN20*3bJ?x&63Noqx&9mP>c0TbNvr&i(Xp-Fn?w zy^;%4+b%URuimu!=+U(MbIet2Rz1sg>$Cc-v zuj&n~g=Y4>G*oCT&f^SfU3F&igI>D@T@RG5z0CG~>oJujP;1q$wV`{iIfx!K(K+8x zyUkI=QRJYYX<1C^MCVCfy#}lc=BO^XAM%v}32dEeT3(WX+y8K-$wFEU=;(l4c`U3t9O=E2-cY?FnSFPc~Ta2=@2 zbTjY4uGQ(T-xqu5b8R}3n$xSV8no)sGR=_Bw~BO_Z=9Ps!_85S_o7$OKBIe4MUTA| z?M1JhPkGalW}WPI+Pr9ru0{6aEd>?VOx9d@&N)T)WUy4IsE*T;Wh>RZ;&iod_shOl z(LdL%P`mb9+Hv=`H_OGMeJTzwwtTj?e|~j<>oUiT6)y8Xw#?e!D1JG`#Y-u}<(3Ik zm!$17k)922+g3MKu2}ut_c6GVhEz7+{whg-J!{9s>Z_Tm_PJxNg^$GU!%m{h?DOYW z%1oZjHTjP8IoqYm=AZZM@l1PkOnPnK)}x-KtJZD3b@J4rAN$PBw8Lw>mu&yfaP?b0 zFSsoQ>!36J5_0~lwEyy^W1$sy_%ELFTeZbBR8&f+(oW1tbdT0lSKp_1rb}Egs@5(m zY4~{kyVAbzV%^NXU1m2_FA5$MG;2xoV9*Rzic*TaG$nkgN5%c3)(W@P4a=2O&3nL2 zKuA00_V2>YN;gtj)Qwl{QEwIIs^_X-THbc6k5gI0GkW5U$8n~=G?(VA@YCtcn^xq~ zbm`$Ai^)N`Sq~*vFVkVm)C%v+n6f3qH;Jc-H{9#fdlWDHXGlN)pP}}`mrdD!tyOMz zNeBhHmS{!!`H5|_dh*FlaI5v-b+2NyJ}tko`@oZ$S>EBohDPR9HC_D&G+h%@i&(u}R*4y>l z&Z>H7K8MA+ZA!?xrMG3Kzb+|o5LqdiCFq;AtyuG^i2tP`p)QTBZqiq7)rVf&o!qxZ zdGX|RJLm1$J>65BEBns+t>)8qf=8;%=W6#hg@&E;78f_Tr8R5CDvis&?p~ETlS1Rz zPORgSDQ7uZ@_@^H`k7hN4nV7#3o9Wx|GmQWzmCF}Zg>7In;@HKA#60~#wQtvyUS$P zW*?1O{&U;gtulgt7OLjCr}tJ|f3a-0#^i3L;H7gWDs0(NQ|G7h=(hDVNq3PszI|*Z zOAn|XsT3{zl5Yuae!fW$nZGycqP&T`Yi3$^N~1EbwvJkM6W7Y9cN?R)3M0RkK0C;} zTuSD&xu?FCZfMrlrMjxeW5nl8C_m|es{x$(u0J1YY#oS(S@VZifV3R>Z~WbI(0+o>$S6)zUK6>r+%*<&I-T zS9*`F*J{dRamn@xYVNvp*5+_wWa;v&*B&XYoBi>B09&A*=U+2N%@8kfe4OxDL+Qs-PtOFd;}y6&av&o6KN zykBh(W??+ivz24n)@aKqpSsjvT5`IIL@nlhm21E1b?j!|Etl+-f)5=q+hzDre@4Kx zvl|X5=WH`~5DtO{F|;q}$gh!JW_iH0)Yolm-rNnf@<|c0ITLQ1I0^Y?ZrL&8iN^6= zu|aoTFP`GqH}&=bw$SL7o5Gu9gpP&^7s*v!Kf4#)e}PqTe0A?)lKvIEjhnJbn&a{X zcazkveY5m_y4qjfVm{X-ciE+nk{K==Qah6tN?0E<%<{iC{Zed<=k|H)I88ZcuQgJ! zy|6OKUQJ_O>ODyF96EB-@<}@K%8iF}^R2e-xvBM`lHGmrrb;=%6$Y|@b!=SzUiho} zO?7tS1h<*FdL4W%zMCh>7fPjW+2a;9>C(K4qc@B0g~u9RJfbnraoHD?-sY#jHx}<( zsaWs3(p_0?+M~zj$L&py3)Ze(zP0QfOK?Wo zt}dQ*ua4#Z{~5y1rYWcMzPX@~E)zAeXx&$EL!$54F`LB#Dsj7KsvqUs6S8)eaH16Z zt?(Hp*4JA_O_mzOUif$`*pqep)fLATT$fMvS$R+@=Fm5rDzPIeO1GQBJy^YqpYBoG z^<%9~)0P_>FPCW98Q-Z_j9DzF;WbrMt7DJO-C&F6(=MCyO~Pjv1RU9MG543U>QptM z(4SIn8ingG#d;?6%49Gv4Hr_q=C$i;+3QLD7MarKs;{@~jC$v=XIJLQz2J7qzJt3K zE%#Dlc&Qq?NPXG)Z&TTCs^-jAz3#QlX2r^vn^wBTsJuxH(dx?6Uv<4ZeA-FX=eJV3 zl%9KBWR{E8?ww_E^W+4lq^+(#A0O|1n((;eRsGUj(Z810TK;NoO%bxoU9;rT{km_G zuT-xrTeYYvc*8rtt`terrMrzhbVZN;y`aBmUpBKZ6R6~8^iop0V>H8NU5od}+uTz` zinbWJUO)Qs9;E)i8N@EPRxMR-ub9Q&9 zuAto!Z*U)NpR2u!v*M(ecT0D=x=J+da`{=XV%e_SMpqxJMxV2JbmgvYiuc;G_g(?& zAq8TGJtwVYsd??4E|)p&nXU7rHOsh4T<+ZhjeOjlDyr4J>PW9^n&$f7$D{>Sj;&nX zD|E!;bD!X(*Bfg6mo@*LQUv zPh0GkE19@t7lYNdkBZ${e>&R>9K7DLAGi9X{$;aaa$D}SwikWh!Kn?}Y<;5VaAL_+ z)?NPsmPRK}v@86Sbv?IJ_eC$z!j!ObrS7<*`5Oh770x*`uNz5^{UW&bQBE3#LY; zy6PL<6A_IwT^j!H_A{ipiMM~kf={qiFgs1}x!&Pw7+truUggQw{|s$He-oela+$;O z#3zTxJtHzjsEJ{U%NvhV8y>Ei*~P?X#$Im0u_sDoqPD;5tVsv&r(WEndUET`NfEWr zK9>hMpH+K4b@!dDd0jUoGX%Fag3ARI&z;#X{4XV?f8qiESE@G|N;*&Km0PS?`aR|o z|JREt#X5Csxjmj7JGFiPQGMwj!Th=tTm@VWTzq3YCKS8f^RGC`_*ARgZFO@^=h1EL zsx!ksCG%;Q8tV z^y1;mXrIF6`6oqYMtlz}_TavCYF1tTw7<*Q>QgseUeUWZB9cb{u*>UH<;e*5L)pKbr%Z@=9B>Gtn^_xgIm|mXz=~m~&MVn8(xwU+Q&TMV1?Yw() zpL{F)dTxJe=P}7O%@0qMOu4JCsb?LQ>N@#WSi_(23NCvKi|)6Zn`Q6ax^%a2viCan zDdBPlEgo_wSgaJfD0H#jWws~lxf_*EDz(u0?{|tTAk1c~_ie|K2J3irXN=L|Amq}ZE#P)4nasFFP`%BL$Or5Xp zZGT+=d+&yL%^v_=v68+kH-=;l)Z_T|MOwpCi>?nz%e#W%22+REDfwG;=Pb(R!g1 z8rPc-dWX%p&7<>V#iht>iwh=BueEAKRj+t{etUnyFU8Vn?@!bU>^fck#I7SYb@wNE z7rjk)fATL9kIYzf`=gAw%&vzyL2ok)rtQ7lD`@i#m*TuX?H9S%Y_D^E(RwXXQ^C#o(LqJ{f*X~rEid%@j1 zDWKufij|2HA0-mpR&`v?Fj+TSC$?2SS?g-#S=FQQsuKk@I#-=D<2P8a-s)9cZuTxy zJ-g^~kN*r|@zVGxTlp;uw%xGkyQ3xg)MVM*@cOHHFXdmIevFGuG6~}iKI)*~yL(A~ zz&^8g6aTHjO-|$LG3&ADU8o`UzCbnP_{-q4c`v13oqn8i&3D>0kGEa#U#)qtWKYJn z)NP+`^X$-cu1;LEa=om!%a%%`lbw?!L>$#yrUcfNp1z)a+8gQ#SC%uD^NP)uG(`6v z6b+YO>~Fh!N&RY&bMTR~3q#wkOxhm8&7X^3`NG-PIf9g5R&ES&xx4wpy=R^|#_Nnu z?oj+ZRcOnW6VG*01K96r}p-SfGDk{7hRW& zW=FlcnD^7?+Q}QYrCw#6jo%w<`YkwY?}{8xl`C6U869YtR`FFa)WW7@>8!u<3Xuv$ z>+_C;y}f!+q-CWh`GVa(zoo-lyA|&C8xF?vp$=@%8lcOh0D?7q{)U zx_zlEDJ`m2&e7%Jy%kGM6Q3ThYP)SNcvAmaz#Xpz?>tuffBKzs`C}B*IOp=-P+JJ9qc(vDqEzW3|A6gH4<@Fk}0Mm`WXvXX!@os$O)geYm5%FzWG} zTSv~WuH0NIZK4<&Q!#Bv(4F9 zxPD@r^a0Ju)6FE0NKO5u>ZSKm^HEl;b#R#G9A8oHd#9G)&hX#A#u zW3A_kUS4MP06Bzq$90#f?F0bxE{~Psy*`Sv`jfZ~g4$;;ItPy8Zr0 z;`7@NtR82$*tu?I-8gg4@uKL?TmKo_yR&>wq;9{dtGi3XXtD@dfDoA+ips>eRI7%^LA&|d(nz*3pXon)O(uu z{Fd|XCu>)Hag+1D{^D`Qj!RR&xaPdjkgp?4c+iAzvN=hnhIcYROAg{mIw4*7QD zer^MM-&PerTf4a{(p$YAUCHp85^p+DCY4ibb!mxi*p6j;%9dSR`oJVm<*~P!l7v}! z(?`wNs9>&75!8K@SXmh%%PScL6&Va2 z0}~Yt3L6C+CSLpyuyEtSj|mTbq%rLb$ttQ?l6?NUb`&R&sZ-D~nEIAQlJiNkKZ zem2=2ug>S}sXD;G#C6?Jg~eE9?hP6BRsCxu)xWt;_uVG@`qg14CxhhG9k*vc=I&Yk zu;~Jm^qRcS-;J^lHq7@A6Te_99Jk`P{DRF^SG3t}Z~IZyxq$({z@EBe8ca_I-~WT zjL#WYO-1QIi+nTPC7w=Jo?Vx2)O=TT(qZ1M_V%7p=&deEyB4_sYru_-nQ|_@b zYqP=O+HHm*k{2fM@?2y2wPw*K4Xz{N%Y6LgG}6q|FB}SG)DrUI-TA0rnZZRjug!Xg zRQ~Z#3ecawET-4fIEmpjO2GeV6^wfM=y%+`c4xh3pczC#-PsT!(QM)0a z>x9W+W9D+D`JMaZO@g2MPv?rU41mZ(l@+f@HjNM~KYs8;n#sBp?q>b3y}e-yyx8Bu;@>*3xUFgk0HFjXoMEd2f2pC9cPyPOwUoT7O!TD34KkfOm-d-EZQ2$U2;)AK?85$F>x3Z+v zT$QNE$f*-sZh!sw-^#RUTn+xtz+iNdDr~jdX@NYFYTDDyx`VOw$t-E z4(DZA2?swAJLYZ3|8!&0+o$tZcqC6x;hVA~`$AAY$D8S#OpDn!Z1#V5|9s;lBbyuh zF3Rt2l8ml!xAiG8sH~rO=kT7#HYX3aKfb?f;cK_*r!#pdi3wbpv3zA^Icw|Y%y&I92E{_s-3>E1qnulcIS+W1b8cFpIcLrD2C0X#fe=};-2DyYQH*ioZ46U-K;V++#-;?1$Iro}(%9B67{12p>x=f2DP8twKA-D*`Lx|D=-|_T>gk<9US?~z zl`eQ$lDc_ycgj*TcD)^%Tdb05)-JBlY*78ED&CN1I%(1UE5dBy4%fV*GMDT<#JjBW zz&hy+l@OEf7o?Q!?KgjPcw#8=C`SKHn6OULN{Pclu?(V1YCRPKMJ9Sa>78=;b4Y@` zL(j3LUye$4sL38SZxMfZp)|O{XA6rp%bjn>ty6nfUgTmuF}3-w`O71{D@rfQCn_LfpMUd1K>8+ML2CPqhLy`Auec>hrae=56!ud7ukMs> zvpMIoghfxxwoUo+bJ_}pK$Zo0V!wC1leLXIpuWwJ)uipv#h2YLrDslhx=h%sG#xM>;jQ8XwMlYCE>eIilh$LFM^!+)c1On}e98*vInKaR( zDs{T1%Mo0OkDVrlwZ!vzH_Z;dw4%fI`$5BrNBARCo-CQluTnX&mb-5C@03ga zrT!QDWb6uA=e$ewkTsP%EX0?;g!}QlNb5=0EB*>gEpxO#5xf4SkCghfoKwxqSLX`_>%)?&f=RlDo{q&mD4tYnw#BuvTsjPFcD3o_$ag)8a+TnI7K` z_tbdMld)VviN|5jmHkUhipm}DByaUt<#Jb9HT%t`J}aH0S9Giu51I*GXjNL4%)IDB z$KHl@C)MrZpP4-SBDQF8z^gqne_pXg96x%?<@B-*43Z6kNxbR5wAB>6uZJ-GXYg8d zY2`t;8H^>G7q#{nDlqe0s(+rg(po_;ezn%8eJSCx`d8AV!gV+g{$ekOc%If9TlvwuJTW@;9r~ zBmXl9>|1d)>V1bt+QZ!pvnTS4Puu_X+g9c^VH%?HJC7UR*3>wAy64@~*usSkOm{8? zUrFizqNlJq_=Z~u_k#VwS}sm0=icb5&DJ$Hlu70~GxzHPyB|zd8O94HMo&F4`#|Fp z7k7u#_Z6M;trsv~+ITH(@>M>!M;kYv*B37EIq>!q!@R5l=B%e*I7RC^e{st@6|ldb z_kNwJ+GVjjt3qd97ue?a^?Typ;&S)pcW1@t8h75CX8QPMT(Y>-4%tGM%f0?bj?7-} zo}l?MW43c)jO`ay1NM~-Nek!o7?mmRoRc`)Etqeezs!gUJhy-@GW_xAR?r zW5?Hd_g&rHe*QS-=04ZuR?P7QV(ScT<7ydioL^9SJLkf~w;`)`yo!DLBGq<7;{}To z2Cj}z_3~<2kG=D_$rrbJ>#Lu-%F6p^i|@~u*}X!f@#fr1lN>nj9$)qOpz3ksKmQi> znYRSyu)i?8Ta|D?g@y6Lf$!_jy9&;GvOIp4qr3mvX73wr(<_%Na#{1&o8;R5NPPXD z!R@vD>MP3g>y{s5t&*&gYt#JC;6FW6e0TE$?eCG^GD6WGpB|8uH$nk?VB<2LgIUQRp!WBtwjp6!!5XW_gb3WT4H_rDeq!4Pq|WYg%Hst zb9Xu4sO-zsxIO95t{0t?{xSYMZ!b^~;H&y8S*6OjNkgYCFa2c3#s<&F>zvd)URxMH zbG3is^+&a?)OhzC5C6=A_cB?exe_Oz4o>o8Jhk)g3Gq35P9Ohxa9%54dHoKiIvmf%GA=MKl<}A#?cJC9<8C-$6Ot))iZ5Yc+Pm?uI`;LedDmVphjKs`No;k_X``&OpM=uG9#u* znv?yqXr06a->f9>C&?e~Z!nJNu`ek6&v1R^1}2sr(NU%sxdJpgI44K6g}Lf|Vbo8s z+5FGn{&?1{)k?b}$|^(GLL6>wc}Sq~)K0M?{*B^IwbP#m1giO; znWTMTlKXsx(A2Puf6NkuRo_fR>=q3 zX+}Gl1$sPI(a%cp+wrPM==g*)30AJ_!}=@TnBo$&w_5tFKJ_EESxuLF*`|qimfn*K zVi(!w;W2UUWcgsn#Djl7c};J=E7~dJsmJm)?mvUVfmSn)_vSC>?DQ3Cn;|W{ypzAs zYt~Li$DY;ORi=NtAMm20TVZP0V+of_TUX_Lnk76{{@|S7T>Gb}DJNB@Eo&~k(3Lu6 z$-~25B2Qg9Z=dNdIZ`3C?mfHDiozQ&uG^{Ky1w+=%maZHFeguqUre`X9Ne9crTt0&&LL z{s|Xzmu;FmtG4raD_?Aepw>>q*yhdMi|#jbfZ|*PDaPxBx`2x-}%4zMYgZIDdw@`8=Ju0 zEU)J07XrIQd$d~kwtYQ#)wak`sk$ayY5qZhxl%tQHhk>+D(0j-v(+}^>(6Zy>(wUy z`(tEqkI|rQ?z-%K{M}sL6O=;F`enR%^y1~&s~-r*_Kt+^_2#^M?A!uj~v^#gt5g!%A@EyLv8x{vs=1P+!KB(J$J*qKZ@-= zm&50&bbbiX+w32(e@FkuB8iILL%ARPBRKfh$MnA`Y;ftrv@ev+$bvwwpP# zLMB+7M=CrlUy*ynN$$0*#63}F1~%p@wddNWHV9v0kDr*bl<%Zq^a-xu2Y_AL|R5y3q3b(iq9SKgVXx{^ZDL5XJp^!imT|0er&q7iCL1 zsr2$HEaYC-Gud!4ThA-W<#UuTu1sgj@vGUwoRXUJrZ%yDKW~NnE>BVKNjX~2A54vx zlKsyhaPi8H9Bn3D#^XKNzh52lo1p2Ee|$!xtihKu@7XU@)Hg^mc=QH}Fct{yt(v(n zvFJxhrUPruRPl(tTTWC9bjmtsGf)3g-20XJKZEIGp&(9G#=GqMToQK*Kk{A3SZi~v zEkaCYcDL}u4UQye1e~! z|9rQ?);WuJGgV10xnRF3Q0r^N&VbH?(d$;9*UXKiO!+}JV zG7FWh^XoLWMHagIa~-rg;&-n|aLx!={S00X~kaYBdd+dwf-^YZbnB{NNC3XI{1I#J_`%t3Jz=u)IB<*s?H} zFZA;)UxSSYn?>&$zb@Ii_I9Hz^OY~Bb?yX2%x>{qpJ#SAn&n2UwRPHET1y9WZs+}^6UhnIc{k^H{$?IZoTy;Yw?S7|E>vaDSA zL;tv7bdt59q()AQ0@n<62Jv7QpN*Y!)DAU>NV=&qDc^V;pD#FB&1YswUs5LXRqlOq z|Af_iW*WJd<<6NWw9IFw(Zd;!STH3#)Exe5u*{;6Tn% zt7Wby?ZN~F1xlTbx4X>wc0#!K3g@i~pBUpmTcTzqD_9DcPKfJW9-@7CeObD`tHqOp zy?;$SJUSTf9!-5v5x~}{qA*G0Lvz(d3m)y73)?PS&{V%r{^w;}Y@`Ty2wB((bO*B+%t^==FXLcb=xd zj%qU^lZ7-q=al#4@Y@x?C~|f>iyQ1BVB<>)7SLAR=M$HNyS7V-4&*FVo5rm ziWohf6iyE0xvcDWP1VCjancbt8IehTmlAeZAD_W1eVMmMY11zC>RAF0&E4Ase>n(* zZenOTWuCxeCYErM(_!{x_g1G?rT2O9n{`N2>hh!y+jw**rsTHaJWuS7e&VWE*^rDaws; zfyIYL0Zq0Y%U4>TaH%^N^2^5V-71e+5;N@D!uL9SWIA?0_`-pHhHWB>N=dE@UV1WU zwyH1g>~TAKt9O08))YzEW`zp($r8&MW^k!=G|K%j&}PwPd>FX)q~w8RTE~jtu^G*G zX-v-4Z!7+KtLT`Jyh_^igD3ghGV^R&)Re8JZV)p}>3RHHBhap48mrI`zctKm4x8FK zu5qZTtUB0|skppOQgxot#y8WaCuvCJ6)#e;o>uI*RKqTbuQYF>rcTAxJ6Gza?L4tD z;rqm(-{t=qrj<_oB;0s`w`M);I8z4D0bc@>JXI!ns!ZTyU}6L@AlylwEKD9OFg8e> zfssXk6U2ZCDlj=Jz}O&hArA%yuu)J!4+SBZf(8!o#&aIz>W1(Kn*~UMIc`|Kpd$u$y0#|su3mv4!{XeD?kbm z-h`?ITR~6(R58c|A+V1?Aqf!#`CVlKI3&S>3IYhzpw0jV6htwI#NkaO6R%b;}{W6J@ zVUni;1K1Z0oGOz%7{JQFCV3T z64+QFkU3CCg5uXvr3tP8WGpE4f?^ZmBS(It37V_|d_lZ4fL6bF`SLSm%a~(|J-+D5pRcQC^ebKC| z6Sz+bJMNfhkx+G3p+R!NE`jH(j~YD)T`D6s|7Yks(=D=-H%Pd4G+IunaIo2b!8!3S zYnG{6UU<&+gS~Up-ZrF7-e$T`q2U{QcEF6dRBk(ss2K~~mZ!!1W$!v~)lhC6v#h}M z#2Qr_o#UU~zs+!46_v>&+*!O<_riyUYj0}{qKzc3T?-ZVabTL1d4xw$(O_${{{@}~ zB~@Yh4*BlV3kDn))-Al*-dpTi#pU>B=?0I>n$DpUO50YjH(U#{U}_G$Cbw|T%n*fH z=M;U{FH~1H?GJjvymF`A4M8oVOtxdUWzRP}EPwi2E?|a%$y^h*1KzSpTOC@bc3Zf1 z>}~JU`fKQ-p`5sDcGfnR63Zw`k@|ERmy&|fJK*B z!ll2=YRnNj)o@oQsnPP$q!JM!rqWp_u2iqw>eeKsvDD~e$O4YeSuDYO4y^n*g;DVw z*Dm(Gkz9$t7Aq+VxJMuUu;Hji$OXAvzKQQ7n1U9_oqe3q!_6w_wP;D&{6!C6Id6X7 zyx_pv9J`y_M75Ujn;t(K&l>6{_54dR8;^uR!og;oloRJ!afJ?0lYgv?| zmP6XF0H~JmHk}2c$Cd=Ie0e}|L7 zOzbhp7I9W8uCCa^)u41dn9sP4J9^`;T%kZo{p1BVzRhGl-gM%@R@>du^Cvq;b#xiG z?mWUIDH7_ni2VxJwxx`>Hs31yKG&+`<>i%|uP^u8u(FZWwY{wM?}lJ27Ry@=daHll zvs%to#j?YBhuU-PZ})q&AFzfhd&)velk_}1K& z!c08c7vHJ>e0X+m`a}0WM=q+W%WH-F)5CuDI`RCc#Secv`r*&U z8W`um-u)n9E=zlz+{a+4yxUhpf<2GzHI+$;@MUwPoM&{SszH<`TE&1vfwg=}gF zEjr8Dt|R{Ni`svN%p+DjGG7{1R6`wB7+t!Ocb$#l?DhGP91mHV9kdtezI*l1%jBS_ zUCni4R%ML|!E$Erd~LdJ3@q9V zvxBeYy30p5o`1fl+Q)A}Fk{w9fm=Ny4R<_C9!c{=n;pKVJgwA$m0`h>>H6zBAMmQ) z7meBU;&{1p@~&MH2Y6g=dZbQZWtQ1J-*Ijh1 z(dlv#<Wi2d>|V&;np3fPs;PDs_kFoHAqk-@jt+cr8!8jZ7P4?I z`SP%zdza=RG3Jd?t@>dJl^0sXI$~pGjrO%nOm=v9C*ya~q2@i!P8Vh|IJLSogfiR) z``Bes<;ThSZm}sE!o}H>+3jBDX{2(Rh!natF>vi#f1^s$^^O*cW|CRg*3f+a4YTqe z6!tJU?`igWzwdeLS-to7mmi-gJ>7V2K2v>}rb)_q!@Ui)Jr`>XcAq@gesk{hIJ2Lx z_$SL5De*jbHqkUuCGhCV8=YAS85d*Nk`5TYi|T<}uh@wCtVSF>P2J(>aWL1v z;HP72h*#*+iivY$9$aMX*qV5m-M?p^p+d&@3+#z&?@qn;x&3OE#gQdP@>$CtSmZsi z;J6>1?z4!y=)nZhv+DzG#Scx)it35lQ#V0LcE*lFxrU78+BKJ060&byv}{?~S(b9( z1J?_aRRRnQJS;6DTX-25cp0tyf_e_^pCPvPb_T<)nx4*O^XgUy9)BglQt`6C;1*`-BL%kHvz?#ma#iezc?kr#8spoxJr(}_gvoGx(SMo_1Cm2H`S&l%&hxy z`Cq^p54EyD<{s_oJ70SD6^Q-F%~dd%(RXGFle*70Py74zXSUD$UB6gh?jhL^zt*}- zOnH*rOdAasIlS>o zoU_X9Veb*SmibzWTeMbvWu0j!{i8b7mgl;uZ$lhU$o^1Ryzcxvea2<;`9DALcjcB? zZu}b6XWMLI^KWK@d*6)jCN_UxUHtRyctW9xx5*akHhwz_tIMbl43HoqS8(gv@V;Kf!_j{xevvVA@%pdr98~N6kp`+1^ZM_99hCR_djhTB^Z(X_e)~di|R(sWZjMx9v ze#kf_GTMY!u}tB1Ly8=)N|BQC=P#U^>Gw}L@N0JnTDZ=NeqJT}Od;CY*tNhWWf#L4 zr$zH+H&^%;th>F{&h-1)U5<{tceVcc+$vciP`+IMWY2w-Z|7yN?|(S!)vZh0SGZh1 z{X1E1io|@0yKC2;2<~^=Yqa>zs|VhFS`(Ktygl1^F@SH=VTKJ{p-RWTlpQOdcED5F zvsLVH)kJVbAaAzOqu=vL2s1(DsM%sP9gHuqtUd-wO!B_lMclW?1Q|>i z7Z@J8y6Wlf%o9fngzv9-{9*&|`>Cy;dbA&?%DP5GGc1tcX6>w+V%Rg`#GG$4y7F3g zbe$Hpj9sa{bzuX8+^ky$jsFhhbSvudStZ$&vTr+A`}*Pzjs+f3?Fo(Pt3IZ9D6QJX zaJT65w*w;1$GW;^u6Q0eO=R!Q%2dtJ@XKvB%O~C~o9>zscYJ@~F^wH{9V@<>tc+q_ ze$0G{lce(o!4$@i?UTIb-(wY7di8a}g+eiJFN>^vUWvI5H!nq`#27SXw_j~{I2FOu zHY5Jis#U9|hK675a_l+~%eDSMI0w72SCW?DqFqYX>ujDlO6<-Sw&rI!`0#l8`GES& zhx_Wk+OltPxAf)|C|J<3OzYdMO|uoZh@|WLOxrox)!Bh*^<&0&%O3AD=*{??(wP^% zY=IO51E2beFxx2>E-4RYPmk0)(0O)a;H0U~r_XC!+*7$tTWE^f<^0Od6#`2wj=c_F zs-QVx?(Y86=e8JVy4(DyxWICtu)s&ZQsSh=ETNBO?^nGk%z0|Vac3F}#|%CzEtzMl zlnmeJyLQ4~tuc1kGMVQ+ZrRiJsC(qfMyGuL5 z%SmLd+SL1OlXrivzQR?B4GCJxBQ#nLW6> zl}DiLMV7@c8{SVFm7H6oloX^Yjw<0ju zkh;QxMK;wJR?0PL_pUtHz+_=`SHg|gCPA$sZ~ew+yScva^1i)QQXujAM48(7Pt!x( z`xbnzcD1v=DPzld_8&*fOF@?pkG$4~E%Acw#wqKjnMEh=&tqS8YH_ae z7QO4YByLRCY48?ylwz3krBo)V&10+T@)o;XBX*91atB&iSDg1(YEE0`6TKnFBuMTH z+k4wW(O9v7lMAIY%@zf8aSH5K3F~5UslCnJ82IieL(%Sr1(sh#3pVsNXl+Xnz7>0< zkIi$7ST^gECL-D%(>#$znyk~HEfR(gX`J| zMsBID#v8Af3d?7A#jMZV{^0GYf@64aUEi? z_K_4hsO)shH=?KUqM$poYSU!TjXw=c)b*!&r!fj7h3#0dl%civ%4>;DM|lb?6@qM* zHH80EaLwT54LN3OmZ?_^t&*!+^?&Dn>%R;k+Z#`fWS|^looKw`qskEiy6+hdBdq3t~ z4{g|Y@4(F_n+@Vz^Ooyx-LCV2VRiGLYbF=#3wQkVYP7w^pPiU)t_xvMy}pkpOoiu3#UnrroV=3re=iBpniMPzc?=NL%WjVcE1B(lISr z?YT=VIlLLpb#kg|@4Bq+cByTJLviVjm+hB0*$&y2e$h5NvbIFYVD3e)ewMT&lm96E z`|-_6XI^uc*i*@rJFml4!>$BxtrqzH=jaQaOpOyE3_dNUmjyP9=uK(kOPCfQt&z{S zaN_2DPR=4`j9jq^i_g71&a^^Yu4UelyS$8kF3*LIZ;*==5YXtDYvlI#i_iIAArpS{ zeJH;t^X^%d^>;X$V{HYUyxBXXLkzMjs6`=w(a;T z`-6dj;k(kte<2e}vTvs|T=~$i?4Yz`UHA&c3kDY*1?AjTKb+gTOGCgUW7fe3^RKkM z@Q^%lkGNH~ns`~2g*G=F+``26_lhXP)8d4N))xT=-|j2@VwAILzQg5qK>hcf zx|45GXBaSs#xj&2t#sS8;%An&&9uI(q}88Gna-3=3b^&YwLMUv<4Eo8Le_WoIa7aM z2%01!?&ibtD$C;NjAntNGkyCwKF_J*?q>*@a8on&=%ih0^UgTkVDdO)+9Rf)@aNCg zvM1*abnfSJKIDQyO^1 zwyg8*TPo`|t;kO)b#v<-&Y3Ne{(DuIW~ct(+OYi6O#SAU8k2Y!PW;_h|7BBF;%BMT z=?+bKD?I;Avpyo~^vURgTde49rmCd|m)1?=bc{JNxhtW5G5fX5);B9}Ccij#jQ4jC zLuG+$nv<*EYawwd$6v|MvKTjnpS~u@+OlEw2f3nPtIZ8e2Q!qiD;;M%&|A&Go~U}k zStQY9SFFvAO$%JtNk>b4Kf1Hb?E6Zidc6s6=Gfc1YsTBeoKjj;&^_zMpEH5{8w*xu znY?2W`m?{Kyz}qqG9h2#sWsq$^~f+4D5{8t`xpJTI6IM`|}Ep~KPd4gdb#w)^|r zTdnuP>NS-@y;qA%+k*4&`Z$QND5xDg=*jzN+Mi;UY1)-rCNA5lbL05Nh>Zu=DHQNA zJWAjb`TH<;D#$(b|h@bU~8~u?+J^t?s_0Th4q&B-Q|9Bt*W)N zG#4F>&RV$q&gJEPb5*&SXE{k%e(W}Vt2fuGA4%fb~x!6!v)_L%y=yK(POp}Y(G`ECmeyu2a zYb-oP%_+e!W3BMn(_aESI9D!x(ff_zrxWLcc`rB5Gg`N!yl(bHhP4GDI|7;>ebyBT zzU9ZKQ&8f;b?b7|*?{w%f=~bUZ?V|3L%^!>>co=9wmK7o2Wh#ShuGI|b#$4+#jq{= z=At9IjgP)($GlfIS*$dB+5sksCqWMz3*?wTe7NrNSZ1;)?~>j_3k81OkB(rCO%Uz9 zk+W_>_w+n9U$%RvWM-^7l4{i*mG;E@o7c)2S$pQ){;T`gQDwJubEAb~%3dD3>Spx8v3~WrtH=Tlv^Om4yo4voLRQ zI{W#JK-5Cv43QWS_BqT`Jv~=BeeGgeH)m@|GiRy-)26+O3tJLSP7IjTDrIs1%#k?@ z7^^qmcynwu|75lwuNGN9H(TQL`rw8DmRZ@i4>ATU;b!p4WS`92^wYEMhoyqp<)%hA zwgv_!2H{(Oou_>16k2L+_Q3E2gQ>sPz0Z$t|Cv2G%*=b!VOh()tI~7*PcU3?P+(wT zzOlq0kx9v>zo+oF=?jlAwksCF7IP0@uH@+2c6P7sqzM56D`qHh%<{S4AUa2bY4IT$ z!AUz@gdG?dAKw;xqA6vj%AlOC`>^9#v)wHckn6pET?ET8)BP7dd)eubHmfxjEu*p9y1phJrf3=QNJcgI!aLu4t59^msFa zBfsv@vZZ~0w3)Xj6@TvT{5gx?Ir$my={?**X6gz58TS5Lu$bk6lFmv|F2M%>OOs~s k&(7P*wA67LbN+t@J*Jk$OA7cG{QknjV9kE%Kg0i<0E?C$n*aa+ literal 0 HcmV?d00001 diff --git a/doc/src/lammps.book b/doc/src/lammps.book index ef5a4275df..3c856bde19 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -569,6 +569,7 @@ pair_charmm.html pair_class2.html pair_colloid.html pair_comb.html +pair_cosine_squared.html pair_coul.html pair_coul_diel.html pair_coul_shield.html diff --git a/doc/src/pair_cosine_squared.txt b/doc/src/pair_cosine_squared.txt new file mode 100644 index 0000000000..ee629d867f --- /dev/null +++ b/doc/src/pair_cosine_squared.txt @@ -0,0 +1,95 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Commands_all.html) + +:line + +pair_style cosine/squared command :h3 + +[Syntax:] + +pair_style cosine/squared cutoff :pre + +cutoff = global cutoff for cosine-squared interactions (distance units) :ul + +pair_coeff i j eps sigma +pair_coeff i j eps sigma cutoff +pair_coeff i j eps sigma wca +pair_coeff i j eps sigma cutoff wca :pre + +i,j = a particle type +eps = interaction strength, i.e. the depth of the potential minimum (energy units) +sigma = distance of the potential minimum from 0 +cutoff = the cutoff distance for this pair type, if different from global (distance units) +wca = if specified a Weeks-Chandler-Andersen potential (with eps strength and minimum at sigma) is added, otherwise not :ul + +[Examples:] + +pair_style cosine/squared 3.0 +pair_coeff * * 1.0 1.3 +pair_coeff 1 3 1.0 1.3 2.0 +pair_coeff 1 3 1.0 1.3 wca +pair_coeff 1 3 1.0 1.3 2.0 wca :pre + +[Description:] + +Style {cosine/squared} computes a potential of the form + +:c,image(Eqs/pair_cosine_squared.jpg) + +between two point particles, where (sigma, -epsilon) is the location of the (rightmost) minimum of the potential, as explained in the syntax section above. + +This potential was first used in \[1\] for a coarse-grained lipid membrane model. +It is generally very useful as a non-specific interaction potential because it is fully adjustable in depth and width while joining the minimum at (sigma, -epsilon) and zero at (cutoff, 0) smoothly, requiring no shifting and causing no related artifacts, tail energy calculations etc. This evidently requires {cutoff} to be larger than {sigma}. + +If the {wca} option is used then a Weeks-Chandler-Andersen potential \[2\] is added to the above specified cosine-squared potential, specifically the following: + +:c,image(Eqs/pair_cosine_squared_wca.jpg) + +In this case, and this case only, the {sigma} parameter can be equal to {cutoff} (sigma = cutoff) which will result in ONLY the WCA potential being used (and print a warning), so the minimum will be attained at (sigma, 0). This is a convenience feature that enables a purely repulsive potential to be used without a need to define an additional pair style and use the hybrid styles. + +The energy and force of this pair style for parameters epsilon = 1.0, sigma = 1.0, cutoff = 2.5, with and without the WCA potential, are shown in the graphs below: + +:c,image(JPG/pair_cosine_squared_graphs.jpg) + +:line + +There are currently no accelerated versions of this potential, although this should be relatively easy to implement on the basis of the code for the accelerated versions of similar styles (e.g. lj/cut) and anyone needing them is encouraged to do so. + +:line + +[Mixing, shift, table, tail correction, restart, rRESPA info]: + +Mixing is not supported for this style. + +The {shift}, {table} and {tail} options are not relevant for this style. + +This pair style writes its information to "binary restart +files"_restart.html, so pair_style and pair_coeff commands do not need +to be specified in an input script that reads a restart file. + +These pair styles can only be used via the {pair} keyword of the +"run_style respa"_run_style.html command. They do not support the +{inner}, {middle}, {outer} keywords. + +:line + +[Restrictions:] + +The {cosine/squared} style is part of the "USER-MISC" package. It is only +enabled if LAMMPS is build with that package. See the "Build +package"_Build_package.html doc page for more info. + +[Related commands:] + +"pair_coeff"_pair_coeff.html, +"pair_style lj/cut"_pair_lj.html + +[Default:] none + +:link(CKD,http://doi.org/10.1103/PhysRevE.72.011506) +\[1\] "Cooke, Kremer and Deserno, Phys. Rev. E, 72, 011506 (2005)"_CKD +:link(WCA,http://doi.org/10.1063/1.1674820) +\[2\] "Weeks, Chandler and Andersen, J. Chem. Phys., 54, 5237 (1971)"_WCA diff --git a/doc/src/pair_style.txt b/doc/src/pair_style.txt index 8a35e5a467..1b8e6d46ec 100644 --- a/doc/src/pair_style.txt +++ b/doc/src/pair_style.txt @@ -129,6 +129,7 @@ accelerated styles exist. "colloid"_pair_colloid.html - integrated colloidal potential "comb"_pair_comb.html - charge-optimized many-body (COMB) potential "comb3"_pair_comb.html - charge-optimized many-body (COMB3) potential +"cosine/squared"_pair_cosine_squared.html - Cooke-Kremer-Deserno membrane model potential "coul/cut"_pair_coul.html - cutoff Coulombic potential "coul/cut/soft"_pair_fep_soft.html - Coulombic potential with a soft core "coul/debye"_pair_coul.html - cutoff Coulombic potential with Debye screening diff --git a/doc/src/pairs.txt b/doc/src/pairs.txt index 2f63f18bad..f36a87dea3 100644 --- a/doc/src/pairs.txt +++ b/doc/src/pairs.txt @@ -24,6 +24,7 @@ Pair Styles :h1 pair_class2 pair_colloid pair_comb + pair_cosine_squared pair_coul pair_coul_diel pair_coul_shield -- GitLab From d90d2316d1061230145b37ff61322b4b7f5945da Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 9 Aug 2019 11:11:48 -0400 Subject: [PATCH 440/469] small tweak on include file list --- src/USER-MISC/pair_cosine_squared.cpp | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/USER-MISC/pair_cosine_squared.cpp b/src/USER-MISC/pair_cosine_squared.cpp index 4c8d738cee..8307f0715e 100644 --- a/src/USER-MISC/pair_cosine_squared.cpp +++ b/src/USER-MISC/pair_cosine_squared.cpp @@ -14,11 +14,10 @@ Contributing authors: Eugen Rozic (University College London) ------------------------------------------------------------------------- */ +#include "pair_cosine_squared.h" #include -#include #include #include -#include "pair_cosine_squared.h" #include "atom.h" #include "comm.h" #include "force.h" -- GitLab From 11f1ba220b9bb1fa33e4f125a8b0f8a1ae521670 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 9 Aug 2019 15:30:55 -0400 Subject: [PATCH 441/469] fix typo --- doc/src/fix.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/fix.txt b/doc/src/fix.txt index 409fde3503..e5036d5a73 100644 --- a/doc/src/fix.txt +++ b/doc/src/fix.txt @@ -244,7 +244,7 @@ accelerated styles exist. "mscg"_fix_mscg.html - apply MSCG method for force-matching to generate coarse grain models "msst"_fix_msst.html - multi-scale shock technique (MSST) integration "mvv/dpd"_fix_mvv_dpd.html - DPD using the modified velocity-Verlet integration algorithm -"mvv/edpd"_fix_mvv_dpd.html - constant energy DPD using the modified velocity-Verlet algrithm +"mvv/edpd"_fix_mvv_dpd.html - constant energy DPD using the modified velocity-Verlet algorithm "mvv/tdpd"_fix_mvv_dpd.html - constant temperature DPD using the modified velocity-Verlet algorithm "neb"_fix_neb.html - nudged elastic band (NEB) spring forces "nph"_fix_nh.html - constant NPH time integration via Nose/Hoover -- GitLab From 5f442d7b641cb697681ce70751be905b0d481afb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 9 Aug 2019 15:31:22 -0400 Subject: [PATCH 442/469] add a couple of false positives --- doc/utils/sphinx-config/false_positives.txt | 2 ++ 1 file changed, 2 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 67252659bb..1d836c9235 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -421,6 +421,7 @@ coreshell cornflowerblue cornsilk corotate +corotation corotational correlator cosineshifted @@ -2991,6 +2992,7 @@ Waltham wavepacket wB Wbody +wca webpage Weckner WeinanE -- GitLab From 18725ce060d122622f78e44e6f87070ac8f3d1ee Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 9 Aug 2019 15:42:32 -0400 Subject: [PATCH 443/469] reformat documentation to match typical LAMMPS conventions, change links --- doc/src/pair_cosine_squared.txt | 45 +++++++++++++-------- doc/utils/sphinx-config/false_positives.txt | 1 + 2 files changed, 30 insertions(+), 16 deletions(-) diff --git a/doc/src/pair_cosine_squared.txt b/doc/src/pair_cosine_squared.txt index ee629d867f..f60e33f70d 100644 --- a/doc/src/pair_cosine_squared.txt +++ b/doc/src/pair_cosine_squared.txt @@ -39,27 +39,39 @@ Style {cosine/squared} computes a potential of the form :c,image(Eqs/pair_cosine_squared.jpg) -between two point particles, where (sigma, -epsilon) is the location of the (rightmost) minimum of the potential, as explained in the syntax section above. - -This potential was first used in \[1\] for a coarse-grained lipid membrane model. -It is generally very useful as a non-specific interaction potential because it is fully adjustable in depth and width while joining the minimum at (sigma, -epsilon) and zero at (cutoff, 0) smoothly, requiring no shifting and causing no related artifacts, tail energy calculations etc. This evidently requires {cutoff} to be larger than {sigma}. - -If the {wca} option is used then a Weeks-Chandler-Andersen potential \[2\] is added to the above specified cosine-squared potential, specifically the following: +between two point particles, where (sigma, -epsilon) is the location of +the (rightmost) minimum of the potential, as explained in the syntax +section above. + +This potential was first used in (Cooke)_#CKD for a coarse-grained lipid +membrane model. It is generally very useful as a non-specific +interaction potential because it is fully adjustable in depth and width +while joining the minimum at (sigma, -epsilon) and zero at (cutoff, 0) +smoothly, requiring no shifting and causing no related artifacts, tail +energy calculations etc. This evidently requires {cutoff} to be larger +than {sigma}. + +If the {wca} option is used then a Weeks-Chandler-Andersen potential +(Weeks)_#WCA is added to the above specified cosine-squared potential, +specifically the following: :c,image(Eqs/pair_cosine_squared_wca.jpg) -In this case, and this case only, the {sigma} parameter can be equal to {cutoff} (sigma = cutoff) which will result in ONLY the WCA potential being used (and print a warning), so the minimum will be attained at (sigma, 0). This is a convenience feature that enables a purely repulsive potential to be used without a need to define an additional pair style and use the hybrid styles. +In this case, and this case only, the {sigma} parameter can be equal to +{cutoff} (sigma = cutoff) which will result in ONLY the WCA potential +being used (and print a warning), so the minimum will be attained at +(sigma, 0). This is a convenience feature that enables a purely +repulsive potential to be used without a need to define an additional +pair style and use the hybrid styles. -The energy and force of this pair style for parameters epsilon = 1.0, sigma = 1.0, cutoff = 2.5, with and without the WCA potential, are shown in the graphs below: +The energy and force of this pair style for parameters epsilon = 1.0, +sigma = 1.0, cutoff = 2.5, with and without the WCA potential, are shown +in the graphs below: :c,image(JPG/pair_cosine_squared_graphs.jpg) :line -There are currently no accelerated versions of this potential, although this should be relatively easy to implement on the basis of the code for the accelerated versions of similar styles (e.g. lj/cut) and anyone needing them is encouraged to do so. - -:line - [Mixing, shift, table, tail correction, restart, rRESPA info]: Mixing is not supported for this style. @@ -89,7 +101,8 @@ package"_Build_package.html doc page for more info. [Default:] none -:link(CKD,http://doi.org/10.1103/PhysRevE.72.011506) -\[1\] "Cooke, Kremer and Deserno, Phys. Rev. E, 72, 011506 (2005)"_CKD -:link(WCA,http://doi.org/10.1063/1.1674820) -\[2\] "Weeks, Chandler and Andersen, J. Chem. Phys., 54, 5237 (1971)"_WCA +:link(CKD) +[(Cooke)] "Cooke, Kremer and Deserno, Phys. Rev. E, 72, 011506 (2005)" + +:link(WCA) +[(Weeks)] "Weeks, Chandler and Andersen, J. Chem. Phys., 54, 5237 (1971)" diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 1d836c9235..a829060bfe 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -356,6 +356,7 @@ Cii Cij cis civ +CKD Clang clearstore Cleary -- GitLab From 42239bf480fa02e3c173fb7298577883345d7368 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 9 Aug 2019 15:51:49 -0400 Subject: [PATCH 444/469] update USER-MISC README --- src/USER-MISC/README | 1 + 1 file changed, 1 insertion(+) diff --git a/src/USER-MISC/README b/src/USER-MISC/README index 59ea453058..592e38697d 100644 --- a/src/USER-MISC/README +++ b/src/USER-MISC/README @@ -69,6 +69,7 @@ improper_style ring, Georgios Vogiatzis, gvog at chemeng.ntua.gr, 25 May 12 improper_style distance, Paolo Raiteri, p.raiteri at curtin.edu.au, 2 Dec 15 pair_style agni, Axel Kohlmeyer, akohlmey at gmail.com, 9 Nov 16 pair_style buck/mdf, Paolo Raiteri, p.raiteri at curtin.edu.au, 2 Dec 15 +pair_style cosine/squared, Eugen Rozic, eugen.rozic.17 at ucl.ac.uk, 9 Aug 19 pair_style coul/diel, Axel Kohlmeyer, akohlmey at gmail.com, 1 Dec 11 pair_style coul/shield, Wengen Ouyang (Tel Aviv University), w.g.ouyang at gmail dot com, 30 Mar 18 pair_style dipole/sf, Mario Orsi, orsimario at gmail.com, 8 Aug 11 -- GitLab From fa6cf0fa8fd93f0794463d7bd5e8066e7b6cfd40 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 9 Aug 2019 16:00:02 -0400 Subject: [PATCH 445/469] reduce compiler warnings --- src/USER-MISC/pair_cosine_squared.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/USER-MISC/pair_cosine_squared.cpp b/src/USER-MISC/pair_cosine_squared.cpp index 8307f0715e..4544a6db43 100644 --- a/src/USER-MISC/pair_cosine_squared.cpp +++ b/src/USER-MISC/pair_cosine_squared.cpp @@ -453,8 +453,8 @@ void PairCosineSquared::compute(int eflag, int vflag) it is called only if rsq < cutsq[itype][jtype], no need to check that ------------------------------------------------------------------------- */ -double PairCosineSquared::single(int i, int j, int itype, int jtype, double rsq, - double factor_coul, double factor_lj, +double PairCosineSquared::single(int /* i */, int /* j */, int itype, int jtype, double rsq, + double /* factor_coul */, double factor_lj, double &fforce) { double r, r2inv, r6inv, cosone, force, energy; -- GitLab From ff09c191493a1ebd6ec87159c25d1ab64749c8e7 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Tue, 13 Aug 2019 00:10:50 +0200 Subject: [PATCH 446/469] documentation for fix_wall_region morse --- doc/src/fix_wall_region.txt | 32 ++++++++++++++++++++++---------- 1 file changed, 22 insertions(+), 10 deletions(-) diff --git a/doc/src/fix_wall_region.txt b/doc/src/fix_wall_region.txt index 559a2f0d89..2ae73e8217 100644 --- a/doc/src/fix_wall_region.txt +++ b/doc/src/fix_wall_region.txt @@ -10,19 +10,23 @@ fix wall/region command :h3 [Syntax:] -fix ID group-ID wall/region region-ID style epsilon sigma cutoff :pre - -ID, group-ID are documented in "fix"_fix.html command -wall/region = style name of this fix command -region-ID = region whose boundary will act as wall -style = {lj93} or {lj126} or {lj1043} or {colloid} or {harmonic} -epsilon = strength factor for wall-particle interaction (energy or energy/distance^2 units) -sigma = size factor for wall-particle interaction (distance units) -cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :ul +fix ID group-ID wall/region region-ID style epsilon sigma cutoff args ... :pre + +ID, group-ID are documented in "fix"_fix.html command :ulb,l +wall/region = style name of this fix command :l +region-ID = region whose boundary will act as wall :l +style = {lj93} or {lj126} or {lj1043} or {morse} or {colloid} or {harmonic} :l +epsilon = strength factor for wall-particle interaction (energy or energy/distance^2 units) :l +sigma = size factor for wall-particle interaction (distance units) :l +cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :l +args = :l + alpha (width parameter), if style = {morse} + {none}, if style = {lj93/lj126/lj1043/colloid/harmonic} :pre [Examples:] -fix wall all wall/region mySphere lj93 1.0 1.0 2.5 :pre +fix wall all wall/region mySphere lj93 1.0 1.0 2.5 +fix wall all wall/region box_top morse 1.0 1.0 3.0 1.5 :pre [Description:] @@ -116,6 +120,12 @@ For style {wall/lj1043}, the energy E is given by the 10/4/3 potential: :c,image(Eqs/fix_wall_lj1043.jpg) +for style {wall/morse}, the energy E is given by the Morse potential: + +:c,image(Eqs/pair_morse.jpg) + +where {r_0 = sigma} and {D_0 = epsilon}. + For style {colloid}, the energy E is given by an integrated form of the "pair_style colloid"_pair_colloid.html potential: @@ -179,7 +189,9 @@ option for this fix. "fix wall/lj93"_fix_wall.html, "fix wall/lj126"_fix_wall.html, +"fix wall/lj1043"_fix_wall.html, "fix wall/colloid"_fix_wall.html, +"fix wall/harmonic"_fix_wall.html, "fix wall/gran"_fix_wall_gran.html [Default:] none -- GitLab From 47533bc5260c7959c15393e0ec66d466ed0267a6 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Tue, 13 Aug 2019 00:31:03 +0200 Subject: [PATCH 447/469] Update fix_wall_region.txt --- doc/src/fix_wall_region.txt | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/src/fix_wall_region.txt b/doc/src/fix_wall_region.txt index 2ae73e8217..8d3b6aebae 100644 --- a/doc/src/fix_wall_region.txt +++ b/doc/src/fix_wall_region.txt @@ -22,6 +22,7 @@ cutoff = distance from wall at which wall-particle interaction is cut off (dista args = :l alpha (width parameter), if style = {morse} {none}, if style = {lj93/lj126/lj1043/colloid/harmonic} :pre +:ule [Examples:] @@ -120,7 +121,7 @@ For style {wall/lj1043}, the energy E is given by the 10/4/3 potential: :c,image(Eqs/fix_wall_lj1043.jpg) -for style {wall/morse}, the energy E is given by the Morse potential: +For style {wall/morse}, the energy E is given by the Morse potential: :c,image(Eqs/pair_morse.jpg) -- GitLab From e4e2342641a42dea2eec7c941f8f3d45c4fff525 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 13 Aug 2019 11:01:14 -0400 Subject: [PATCH 448/469] no need to include mpi.h in headers that include pointers.h (directly or indirectly) --- src/comm_tiled.h | 1 - src/irregular.h | 1 - src/rcb.h | 1 - src/read_dump.h | 1 - 4 files changed, 4 deletions(-) diff --git a/src/comm_tiled.h b/src/comm_tiled.h index 4ceba44d4c..679be195aa 100644 --- a/src/comm_tiled.h +++ b/src/comm_tiled.h @@ -14,7 +14,6 @@ #ifndef LMP_COMM_TILED_H #define LMP_COMM_TILED_H -#include #include "comm.h" namespace LAMMPS_NS { diff --git a/src/irregular.h b/src/irregular.h index 7a3613b4e1..01fe40c46b 100644 --- a/src/irregular.h +++ b/src/irregular.h @@ -14,7 +14,6 @@ #ifndef LMP_IRREGULAR_H #define LMP_IRREGULAR_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/rcb.h b/src/rcb.h index f65ee2388a..555c4142b5 100644 --- a/src/rcb.h +++ b/src/rcb.h @@ -14,7 +14,6 @@ #ifndef LAMMPS_RCB_H #define LAMMPS_RCB_H -#include #include "pointers.h" namespace LAMMPS_NS { diff --git a/src/read_dump.h b/src/read_dump.h index 6fb4f11ed1..66c05cc445 100644 --- a/src/read_dump.h +++ b/src/read_dump.h @@ -22,7 +22,6 @@ CommandStyle(read_dump,ReadDump) #ifndef LMP_READ_DUMP_H #define LMP_READ_DUMP_H -#include #include "pointers.h" namespace LAMMPS_NS { -- GitLab From 259176c590f241445d13ffe011143fed9f41f00a Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Wed, 14 Aug 2019 17:16:10 -0600 Subject: [PATCH 449/469] Add user-agent setting to kim_query curl command --- src/KIM/kim_query.cpp | 6 ++++++ 1 file changed, 6 insertions(+) diff --git a/src/KIM/kim_query.cpp b/src/KIM/kim_query.cpp index cddc81c333..8ceefeceaf 100644 --- a/src/KIM/kim_query.cpp +++ b/src/KIM/kim_query.cpp @@ -64,6 +64,8 @@ #include "input.h" #include "modify.h" #include "variable.h" +#include "version.h" +#include "info.h" #include "fix_store_kim.h" #if defined(LMP_KIM_CURL) @@ -242,6 +244,10 @@ char *do_query(char *qfunction, char * model_name, int narg, char **arg, curl_easy_setopt(handle, CURLOPT_SSL_VERIFYPEER, 0L); curl_easy_setopt(handle, CURLOPT_SSL_VERIFYHOST, 0L); #endif + std::string user_agent = std::string("kim_query--LAMMPS/") + + LAMMPS_VERSION + + " (" + Info::get_os_info() + ")"; + curl_easy_setopt(handle, CURLOPT_USERAGENT, user_agent.c_str()); curl_easy_setopt(handle, CURLOPT_URL, url.c_str()); curl_easy_setopt(handle, CURLOPT_FOLLOWLOCATION, 1L); -- GitLab From edbd525bcb19ac1bce446eaf056ff4354268b2d2 Mon Sep 17 00:00:00 2001 From: Christoph Junghans Date: Wed, 14 Aug 2019 17:16:43 -0600 Subject: [PATCH 450/469] cmake: install chain.x as well --- cmake/CMakeLists.txt | 1 + 1 file changed, 1 insertion(+) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index e961fe25d3..91fb930be2 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -589,6 +589,7 @@ if(BUILD_TOOLS) enable_language(Fortran) add_executable(chain.x ${LAMMPS_TOOLS_DIR}/chain.f) target_link_libraries(chain.x ${CMAKE_Fortran_IMPLICIT_LINK_LIBRARIES}) + install(TARGETS chain.x DESTINATION ${CMAKE_INSTALL_BINDIR}) endif() enable_language(C) -- GitLab From 578bcf0fb0d22842f360352acd0f2d696bde8822 Mon Sep 17 00:00:00 2001 From: "Dan S. Bolintineanu" Date: Fri, 16 Aug 2019 01:19:08 -0600 Subject: [PATCH 451/469] Fixes normal force calculation bug in fix wall granular, allows twisting to be used without rolling in fix/wall/gran --- src/GRANULAR/fix_wall_gran.cpp | 6 ++++-- 1 file changed, 4 insertions(+), 2 deletions(-) diff --git a/src/GRANULAR/fix_wall_gran.cpp b/src/GRANULAR/fix_wall_gran.cpp index 8513fc702b..15c8c7519c 100644 --- a/src/GRANULAR/fix_wall_gran.cpp +++ b/src/GRANULAR/fix_wall_gran.cpp @@ -1149,11 +1149,11 @@ void FixWallGran::granular(double rsq, double dx, double dy, double dz, else{ knfac = E; //Hooke a = sqrt(dR); + Fne = knfac*delta; if (normal_model != HOOKE) { Fne *= a; knfac *= a; } - Fne = knfac*delta; if (normal_model == DMT) Fne -= 4*MY_PI*normal_coeffs[3]*Reff; } @@ -1294,10 +1294,12 @@ void FixWallGran::granular(double rsq, double dx, double dy, double dz, // rolling resistance //**************************************** - if (roll_model != ROLL_NONE) { + if (roll_model != ROLL_NONE || twist_model != NONE) { relrot1 = omega[0]; relrot2 = omega[1]; relrot3 = omega[2]; + } + if (roll_model != ROLL_NONE){ // rolling velocity, see eq. 31 of Wang et al, Particuology v 23, p 49 (2015) // This is different from the Marshall papers, -- GitLab From 42711245a2a8601ed8efeb59b8be2e060992861f Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Fri, 16 Aug 2019 10:08:23 -0600 Subject: [PATCH 452/469] bump kim-api to 2.1.3 --- cmake/Modules/Packages/KIM.cmake | 4 ++-- lib/kim/Install.py | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/cmake/Modules/Packages/KIM.cmake b/cmake/Modules/Packages/KIM.cmake index 31586bfbe0..43f95125c8 100644 --- a/cmake/Modules/Packages/KIM.cmake +++ b/cmake/Modules/Packages/KIM.cmake @@ -28,8 +28,8 @@ if(PKG_KIM) message(FATAL_ERROR "Compiling the KIM-API library requires a Fortran compiler") endif() ExternalProject_Add(kim_build - URL https://s3.openkim.org/kim-api/kim-api-2.1.2.txz - URL_MD5 6ac52e14ef52967fc7858220b208cba5 + URL https://s3.openkim.org/kim-api/kim-api-2.1.3.txz + URL_MD5 6ee829a1bbba5f8b9874c88c4c4ebff8 BINARY_DIR build CMAKE_ARGS -DCMAKE_C_COMPILER=${CMAKE_C_COMPILER} -DCMAKE_CXX_COMPILER=${CMAKE_CXX_COMPILER} diff --git a/lib/kim/Install.py b/lib/kim/Install.py index 836b5ba205..2a70a720af 100644 --- a/lib/kim/Install.py +++ b/lib/kim/Install.py @@ -18,7 +18,7 @@ parser = ArgumentParser(prog='Install.py', # settings thisdir = fullpath('.') -version = "kim-api-2.1.2" +version = "kim-api-2.1.3" # help message -- GitLab From b72215fe026ecf4944c161bda578f8323bca7c8f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 16 Aug 2019 12:43:37 -0400 Subject: [PATCH 453/469] add support for automated checksumming of downloaded sources to kim api conventional build --- lib/kim/Install.py | 36 ++++++++++++++++++++++++++---------- 1 file changed, 26 insertions(+), 10 deletions(-) diff --git a/lib/kim/Install.py b/lib/kim/Install.py index 2a70a720af..33d0071dde 100644 --- a/lib/kim/Install.py +++ b/lib/kim/Install.py @@ -10,7 +10,7 @@ import sys, os, subprocess, shutil from argparse import ArgumentParser sys.path.append('..') -from install_helpers import fullpath, geturl +from install_helpers import fullpath, geturl, checkmd5sum parser = ArgumentParser(prog='Install.py', description="LAMMPS library build wrapper script") @@ -18,7 +18,15 @@ parser = ArgumentParser(prog='Install.py', # settings thisdir = fullpath('.') -version = "kim-api-2.1.3" +version = "2.1.3" + +# known checksums for different KIM-API versions. used to validate the download. +checksums = { \ + '2.1.2' : '6ac52e14ef52967fc7858220b208cba5', \ + '2.1.3' : '6ee829a1bbba5f8b9874c88c4c4ebff8', \ + } + + # help message @@ -50,7 +58,7 @@ pgroup.add_argument("-n", "--nobuild", action="store_true", help="use the previously downloaded and compiled base KIM API.") pgroup.add_argument("-p", "--path", help="specify location of existing KIM API installation.") -parser.add_argument("-v", "--version", default=version, +parser.add_argument("-v", "--version", default=version, choices=checksums.keys(), help="set version of KIM API library to download and build (default: %s)" % version) parser.add_argument("-a", "--add", help="add single KIM model or model driver. If adding 'everything', then all available OpenKIM models are added (may take a long time)") @@ -73,6 +81,7 @@ if addflag and addmodelname == "everything": everythingflag = True buildflag = True verboseflag = args.verbose +version = args.version if pathflag: buildflag = False @@ -81,7 +90,7 @@ if pathflag: sys.exit("KIM API path %s does not exist" % kimdir) kimdir = fullpath(kimdir) -url = "https://s3.openkim.org/kim-api/%s.txz" % version +url = "https://s3.openkim.org/kim-api/kim-api-%s.txz" % version # set KIM API directory @@ -115,21 +124,28 @@ if buildflag: # download entire kim-api tarball print("Downloading kim-api tarball ...") - geturl(url, "%s/%s.txz" % (thisdir, version)) + filename = "kim-api-%s.txz" % version + geturl(url, "%s/%s" % (thisdir, filename)) + + # verify downloaded archive integrity via md5 checksum, if known. + if version in checksums: + if not checkmd5sum(checksums[version], filename): + sys.exit("Checksum for KIM-API library does not match") + print("Unpacking kim-api tarball ...") - cmd = 'cd "%s"; rm -rf "%s"; tar -xJvf %s.txz' % (thisdir, version, version) + cmd = 'cd "%s"; rm -rf "kim-api-%s"; tar -xJvf %s' % (thisdir, version, filename) subprocess.check_output(cmd, stderr=subprocess.STDOUT, shell=True) # configure kim-api print("Configuring kim-api ...") - cmd = 'cd "%s/%s" && mkdir build && cd build && cmake .. -DCMAKE_INSTALL_PREFIX="%s" -DCMAKE_BUILD_TYPE=Release' % (thisdir,version,kimdir) + cmd = 'cd "%s/kim-api-%s" && mkdir build && cd build && cmake .. -DCMAKE_INSTALL_PREFIX="%s" -DCMAKE_BUILD_TYPE=Release' % (thisdir,version,kimdir) txt = subprocess.check_output(cmd,stderr=subprocess.STDOUT,shell=True) if verboseflag: print(txt.decode("UTF-8")) # build kim-api print("Building kim-api ...") - cmd = 'cd "%s/%s/build" && make -j2' % (thisdir, version) + cmd = 'cd "%s/kim-api-%s/build" && make -j2' % (thisdir, version) txt = subprocess.check_output(cmd, stderr=subprocess.STDOUT, shell=True) if verboseflag: print(txt.decode("UTF-8")) @@ -137,7 +153,7 @@ if buildflag: # install kim-api print("Installing kim-api ...") - cmd = 'cd "%s/%s/build" && make -j2 install' % (thisdir, version) + cmd = 'cd "%s/kim-api-%s/build" && make -j2 install' % (thisdir, version) txt = subprocess.check_output(cmd, stderr=subprocess.STDOUT, shell=True) if verboseflag: print(txt.decode("UTF-8")) @@ -145,7 +161,7 @@ if buildflag: # remove source files print("Removing kim-api source and build files ...") - cmd = 'cd "%s"; rm -rf %s; rm -rf %s.txz' % (thisdir, version, version) + cmd = 'cd "%s"; rm -rf kim-api-%s; rm -rf kim-api-%s.txz' % (thisdir, version, version) subprocess.check_output(cmd, stderr=subprocess.STDOUT, shell=True) # add all OpenKIM models, if desired -- GitLab From a0f49f27d9d7387a7df4a95c86250e53b4ec8eda Mon Sep 17 00:00:00 2001 From: Andrew Schultz Date: Mon, 19 Aug 2019 18:15:19 -0400 Subject: [PATCH 454/469] Final tweaks to HMA documentation --- doc/src/compute_hma.txt | 28 +++++++++++++++------------- 1 file changed, 15 insertions(+), 13 deletions(-) diff --git a/doc/src/compute_hma.txt b/doc/src/compute_hma.txt index 863ee86159..4ab355abd7 100644 --- a/doc/src/compute_hma.txt +++ b/doc/src/compute_hma.txt @@ -49,11 +49,11 @@ decorrelation time. HMA should not be used if atoms are expected to diffuse. It is also restricted to simulations in the NVT ensemble. While this compute may be -used with any potential in LAMMPS, it may not provide efficiency improvements -for potentials that do not go to 0 smoothly at the truncation distance; +used with any potential in LAMMPS, it will provide inaccurate results +for potentials that do not go to 0 at the truncation distance; "pair_lj_smooth_linear"_pair_lj_smooth_linear.html and Ewald summation should work fine, while "pair_lj"_pair_lj.html will perform poorly unless -the cutoff is very large. Furthermore, computation of the heat capacity with +the potential is shifted (via "pair_modify"_pair_modify.html shift) or the cutoff is large. Furthermore, computation of the heat capacity with this compute is restricted to those that implement the single_hessian method in Pair. Implementing single_hessian in additional pair styles is simple. Please contact Andrew Schultz (ajs42 at buffalo.edu) and David Kofke (kofke at @@ -69,10 +69,11 @@ by noise produced by the already-known harmonic behavior. A detailed description of this method can be found in ("Moustafa"_#hma-Moustafa). The potential energy is computed by the formula: \begin\{equation\} -\left< U\right>_\{HMA\} = \frac\{d(N-1)\}\{2\beta\} + \left< U + \frac\{1\}\{2\} F\bullet\Delta r \right> +\left< U\right>_\{HMA\} = \frac\{d\}\{2\} (N-1) k_B T + \left< U + \frac\{1\}\{2\} F\bullet\Delta r \right> \end\{equation\} -where \(N\) is the number of atoms in the system, \(\beta\) is the reciprocal of the thermodynamic temperature, \(d\) is the +where \(N\) is the number of atoms in the system, \(k_B\) is Boltzmann's +constant, \(T\) is the temperature, \(d\) is the dimensionality of the system (2 or 3 for 2d/3d), \(F\bullet\Delta r\) is the sum of dot products of the atomic force vectors and displacement (from lattice sites) vectors, and \(U\) is the sum of pair, bond, angle, dihedral, improper, kspace (long-range), and fix energies. @@ -84,18 +85,18 @@ The pressure is computed by the formula: \end\{equation\} where \(\rho\) is the number density of the system, \(\Delta \hat P\) is the -difference between the harmonic and lattice pressure, and \(P_\{vir\}\) is +difference between the harmonic and lattice pressure, \(P_\{vir\}\) is the virial pressure computed as the sum of pair, bond, angle, dihedral, improper, kspace (long-range), and fix contributions to the force on each -atom. Although the method will work for any value of \(\Delta \hat P\) +atom, and \(k_B=1/k_B T\). Although the method will work for any value of \(\Delta \hat P\) specified (use pressure "units"_units.html), the precision of the resultant pressure is sensitive to \(\Delta \hat P\); the precision tends to be best when \(\Delta \hat P\) is the actual the difference between the lattice pressure and harmonic pressure. \begin\{equation\} -\left_\{HMA\} = \frac\{d k_B (N-1)\}\{2\} + \beta \left( \left< -U_\{HMA\}^2 \right> - \left^2 \right)/T + \frac\{1\}\{4 T\} +\left_\{HMA\} = \frac\{d\}\{2\} (N-1) k_B + \frac\{1\}\{k_B T^2\} \left( \left< +U_\{HMA\}^2 \right> - \left^2 \right) + \frac\{1\}\{4 T\} \left< F\bullet\Delta r + \Delta r \bullet \Phi \bullet \Delta r \right> \end\{equation\} @@ -111,7 +112,8 @@ digits. thermo_modify format float '%22.15e' :pre The {anharmonic} keyword will instruct the compute to return anharmonic -properties rather than the full properties (lattice, harmonic and anharmonic). +properties rather than the full properties, which include lattice, harmonic +and anharmonic contributions. When using this keyword, the compute must be first active (it must be included via a "thermo_style custom"_thermo_style.html command) while the atoms are still at their lattice sites (before equilibration). @@ -149,7 +151,7 @@ properties fluctuate less than the corresponding conventional properties. [Output info:] This compute calculates a global vector that includes the n properties -requested as arguments to the command (the potential energy, pressure or heat +requested as arguments to the command (the potential energy, pressure and/or heat capacity). The elements of the vector can be accessed by indices 1-n by any command that uses global vector values as input. See the "Howto output"_Howto_output.html doc page for an overview of LAMMPS output options. @@ -159,8 +161,8 @@ scalar value will be in energy "units"_units.html. [Restrictions:] -This compute is part of the USER-MISC package. It is only -enabled if LAMMPS was built with that package. See the "Build +This compute is part of the USER-MISC package. It is enabled only +if LAMMPS was built with that package. See the "Build package"_Build_package.html doc page for more info. Usage restricted to canonical (NVT) ensemble simulation only. -- GitLab From 3d9e737a19e7829d8880cd2fb87850f873a15b54 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 11:27:29 -0400 Subject: [PATCH 455/469] change order of morse style wall potential parameters to be consistent with pair morse and bond morse --- doc/src/fix_wall_region.txt | 35 ++++++++++++++++++----------------- src/fix_wall_region.cpp | 26 ++++++++++++++++---------- 2 files changed, 34 insertions(+), 27 deletions(-) diff --git a/doc/src/fix_wall_region.txt b/doc/src/fix_wall_region.txt index 8d3b6aebae..9807f5717d 100644 --- a/doc/src/fix_wall_region.txt +++ b/doc/src/fix_wall_region.txt @@ -10,24 +10,24 @@ fix wall/region command :h3 [Syntax:] -fix ID group-ID wall/region region-ID style epsilon sigma cutoff args ... :pre +fix ID group-ID wall/region region-ID style args ... cutoff :pre ID, group-ID are documented in "fix"_fix.html command :ulb,l wall/region = style name of this fix command :l region-ID = region whose boundary will act as wall :l style = {lj93} or {lj126} or {lj1043} or {morse} or {colloid} or {harmonic} :l -epsilon = strength factor for wall-particle interaction (energy or energy/distance^2 units) :l -sigma = size factor for wall-particle interaction (distance units) :l -cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :l args = :l - alpha (width parameter), if style = {morse} - {none}, if style = {lj93/lj126/lj1043/colloid/harmonic} :pre + epsilon = strength factor for wall-particle interaction (energy or energy/distance^2 units) + alpha (width parameter), only if style = {morse} + sigma = size factor for wall-particle interaction (distance units) :pre +cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :l :ule [Examples:] fix wall all wall/region mySphere lj93 1.0 1.0 2.5 -fix wall all wall/region box_top morse 1.0 1.0 3.0 1.5 :pre +fix wall all wall/region mySphere harmonic 1.0 0.0 2.5 +fix wall all wall/region box_top morse 1.0 1.0 1.5 3.0 :pre [Description:] @@ -121,27 +121,28 @@ For style {wall/lj1043}, the energy E is given by the 10/4/3 potential: :c,image(Eqs/fix_wall_lj1043.jpg) -For style {wall/morse}, the energy E is given by the Morse potential: - -:c,image(Eqs/pair_morse.jpg) - -where {r_0 = sigma} and {D_0 = epsilon}. - For style {colloid}, the energy E is given by an integrated form of the "pair_style colloid"_pair_colloid.html potential: :c,image(Eqs/fix_wall_colloid.jpg) For style {wall/harmonic}, the energy E is given by a harmonic spring -potential: +potential (the distance parameter is ignored): :c,image(Eqs/fix_wall_harmonic.jpg) +For style {wall/morse}, the energy E is given by the Morse potential: + +:c,image(Eqs/pair_morse.jpg) + +Unlike other styles, this requires three parameters ({D_0}, {alpha}, {r_0} +in this order) instead of two like for the other wall styles. + In all cases, {r} is the distance from the particle to the region surface, and Rc is the {cutoff} distance at which the particle and -surface no longer interact. The energy of the wall potential is -shifted so that the wall-particle interaction energy is 0.0 at the -cutoff distance. +surface no longer interact. The cutoff is always the last argument. +The energy of the wall potential is shifted so that the wall-particle +interaction energy is 0.0 at the cutoff distance. For a full description of these wall styles, see fix_style "wall"_fix_wall.html diff --git a/src/fix_wall_region.cpp b/src/fix_wall_region.cpp index cab5c37a45..70bde90d2b 100644 --- a/src/fix_wall_region.cpp +++ b/src/fix_wall_region.cpp @@ -28,7 +28,7 @@ using namespace LAMMPS_NS; using namespace FixConst; using namespace MathConst; -enum{LJ93,LJ126,LJ1043,MORSE,COLLOID,HARMONIC}; +enum{LJ93,LJ126,LJ1043,COLLOID,HARMONIC,MORSE}; /* ---------------------------------------------------------------------- */ @@ -60,25 +60,31 @@ FixWallRegion::FixWallRegion(LAMMPS *lmp, int narg, char **arg) : if (strcmp(arg[4],"lj93") == 0) style = LJ93; else if (strcmp(arg[4],"lj126") == 0) style = LJ126; else if (strcmp(arg[4],"lj1043") == 0) style = LJ1043; - else if (strcmp(arg[4],"morse") == 0) style = MORSE; else if (strcmp(arg[4],"colloid") == 0) style = COLLOID; else if (strcmp(arg[4],"harmonic") == 0) style = HARMONIC; + else if (strcmp(arg[4],"morse") == 0) style = MORSE; else error->all(FLERR,"Illegal fix wall/region command"); if (style != COLLOID) dynamic_group_allow = 1; - epsilon = force->numeric(FLERR,arg[5]); - sigma = force->numeric(FLERR,arg[6]); - cutoff = force->numeric(FLERR,arg[7]); - if (style == MORSE) { if (narg != 9) error->all(FLERR,"Illegal fix wall/region command"); - else - alpha = force->numeric(FLERR,arg[8]); - } else if (narg != 8) + + epsilon = force->numeric(FLERR,arg[5]); + alpha = force->numeric(FLERR,arg[6]); + sigma = force->numeric(FLERR,arg[7]); + cutoff = force->numeric(FLERR,arg[8]); + + } else { + if (narg != 8) error->all(FLERR,"Illegal fix wall/region command"); + epsilon = force->numeric(FLERR,arg[5]); + sigma = force->numeric(FLERR,arg[6]); + cutoff = force->numeric(FLERR,arg[7]); + } + if (cutoff <= 0.0) error->all(FLERR,"Fix wall/region cutoff <= 0.0"); eflag = 0; @@ -297,7 +303,7 @@ void FixWallRegion::post_force(int vflag) /* ---------------------------------------------------------------------- */ -void FixWallRegion::post_force_respa(int vflag, int ilevel, int iloop) +void FixWallRegion::post_force_respa(int vflag, int ilevel, int /* iloop */) { if (ilevel == ilevel_respa) post_force(vflag); } -- GitLab From 88ff8ce2d7942ce9e01d934fbaed9f4ef4905548 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 12:05:14 -0400 Subject: [PATCH 456/469] fix spelling issues in docs --- doc/src/fix.txt | 2 +- doc/utils/sphinx-config/false_positives.txt | 1 + 2 files changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/src/fix.txt b/doc/src/fix.txt index 409fde3503..e5036d5a73 100644 --- a/doc/src/fix.txt +++ b/doc/src/fix.txt @@ -244,7 +244,7 @@ accelerated styles exist. "mscg"_fix_mscg.html - apply MSCG method for force-matching to generate coarse grain models "msst"_fix_msst.html - multi-scale shock technique (MSST) integration "mvv/dpd"_fix_mvv_dpd.html - DPD using the modified velocity-Verlet integration algorithm -"mvv/edpd"_fix_mvv_dpd.html - constant energy DPD using the modified velocity-Verlet algrithm +"mvv/edpd"_fix_mvv_dpd.html - constant energy DPD using the modified velocity-Verlet algorithm "mvv/tdpd"_fix_mvv_dpd.html - constant temperature DPD using the modified velocity-Verlet algorithm "neb"_fix_neb.html - nudged elastic band (NEB) spring forces "nph"_fix_nh.html - constant NPH time integration via Nose/Hoover diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 67252659bb..012c377ba5 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -421,6 +421,7 @@ coreshell cornflowerblue cornsilk corotate +corotation corotational correlator cosineshifted -- GitLab From 2b42428d28605f33ebea01acb1eade08006a5a44 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 20 Aug 2019 14:04:49 -0600 Subject: [PATCH 457/469] Extend lib interface to set fix external callback This allows creating a callback in Python and attaching it to a fix external instance. --- examples/COUPLE/python/example.py | 36 ++++++++++++++++++++ examples/COUPLE/python/in.fix_external | 23 +++++++++++++ python/lammps.py | 46 ++++++++++++++++++++++++-- src/library.cpp | 30 +++++++++++++++++ src/library.h | 8 +++++ 5 files changed, 141 insertions(+), 2 deletions(-) create mode 100644 examples/COUPLE/python/example.py create mode 100644 examples/COUPLE/python/in.fix_external diff --git a/examples/COUPLE/python/example.py b/examples/COUPLE/python/example.py new file mode 100644 index 0000000000..6a3c978822 --- /dev/null +++ b/examples/COUPLE/python/example.py @@ -0,0 +1,36 @@ +# this example requires the LAMMPS Python package (lammps.py) to be installed +# and LAMMPS to be loadable as shared library in LD_LIBRARY_PATH + +import lammps + +def callback(caller, ntimestep, nlocal, tag, x, fext): + """ + This callback receives a caller object that was setup when registering the callback + + In addition to timestep and number of local atoms, the tag and x arrays are passed as + NumPy arrays. The fext array is a force array allocated for fix external, which + can be used to apply forces to all atoms. Simply update the value in the array, + it will be directly written into the LAMMPS C arrays + """ + print("Data passed by caller (optional)", caller) + print("Timestep:", ntimestep) + print("Number of Atoms:", nlocal) + print("Atom Tags:", tag) + print("Atom Positions:", x) + print("Force Additions:", fext) + fext.fill(1.0) + print("Force additions after update:", fext) + print("="*40) + +L = lammps.lammps() +L.file("in.lammps") + +# you can pass an arbitrary Python object to the callback every time it is called +# this can be useful if you need more state information such as the LAMMPS ptr to +# make additional library calls +custom_object = ["Some data", L] + +L.set_fix_external_callback("2", callback, custom_object) +L.command("run 100") + + diff --git a/examples/COUPLE/python/in.fix_external b/examples/COUPLE/python/in.fix_external new file mode 100644 index 0000000000..f222717c1a --- /dev/null +++ b/examples/COUPLE/python/in.fix_external @@ -0,0 +1,23 @@ +# LAMMPS input for coupling LAMMPS with Python via fix external + +units metal +dimension 3 +atom_style atomic +atom_modify sort 0 0.0 + +lattice diamond 5.43 +region box block 0 1 0 1 0 1 +create_box 1 box +create_atoms 1 box +mass 1 28.08 + +velocity all create 300.0 87293 loop geom + +fix 1 all nve +fix 2 all external pf/callback 1 1 + +#dump 2 all image 25 image.*.jpg type type & +# axes yes 0.8 0.02 view 60 -30 +#dump_modify 2 pad 3 + +thermo 1 diff --git a/python/lammps.py b/python/lammps.py index 9b3790f2db..36cf2d2fdd 100644 --- a/python/lammps.py +++ b/python/lammps.py @@ -219,6 +219,12 @@ class lammps(object): self.c_imageint = get_ctypes_int(self.extract_setting("imageint")) self._installed_packages = None + # add way to insert Python callback for fix external + self.callback = {} + self.FIX_EXTERNAL_CALLBACK_FUNC = CFUNCTYPE(None, c_void_p, self.c_bigint, c_int, POINTER(self.c_tagint), POINTER(POINTER(c_double)), POINTER(POINTER(c_double))) + self.lib.lammps_set_fix_external_callback.argtypes = [c_void_p, c_char_p, self.FIX_EXTERNAL_CALLBACK_FUNC, c_void_p] + self.lib.lammps_set_fix_external_callback.restype = None + # shut-down LAMMPS instance def __del__(self): @@ -602,6 +608,42 @@ class lammps(object): self._installed_packages.append(sb.value.decode()) return self._installed_packages + def set_fix_external_callback(self, fix_name, callback, caller=None): + import numpy as np + def _ctype_to_numpy_int(ctype_int): + if ctype_int == c_int32: + return np.int32 + elif ctype_int == c_int64: + return np.int64 + return np.intc + + def callback_wrapper(caller_ptr, ntimestep, nlocal, tag_ptr, x_ptr, fext_ptr): + if cast(caller_ptr,POINTER(py_object)).contents: + pyCallerObj = cast(caller_ptr,POINTER(py_object)).contents.value + else: + pyCallerObj = None + + tptr = cast(tag_ptr, POINTER(self.c_tagint * nlocal)) + tag = np.frombuffer(tptr.contents, dtype=_ctype_to_numpy_int(self.c_tagint)) + tag.shape = (nlocal) + + xptr = cast(x_ptr[0], POINTER(c_double * nlocal * 3)) + x = np.frombuffer(xptr.contents) + x.shape = (nlocal, 3) + + fptr = cast(fext_ptr[0], POINTER(c_double * nlocal * 3)) + f = np.frombuffer(fptr.contents) + f.shape = (nlocal, 3) + + callback(pyCallerObj, ntimestep, nlocal, tag, x, f) + + cFunc = self.FIX_EXTERNAL_CALLBACK_FUNC(callback_wrapper) + cCaller = cast(pointer(py_object(caller)), c_void_p) + + self.callback[fix_name] = { 'function': cFunc, 'caller': caller } + + self.lib.lammps_set_fix_external_callback(self.lmp, fix_name.encode(), cFunc, cCaller) + # ------------------------------------------------------------------------- # ------------------------------------------------------------------------- # ------------------------------------------------------------------------- @@ -872,8 +914,8 @@ class PyLammps(object): output = self.__getattr__('run')(*args, **kwargs) if(lammps.has_mpi4py): - output = self.lmp.comm.bcast(output, root=0) - + output = self.lmp.comm.bcast(output, root=0) + self.runs += get_thermo_data(output) return output diff --git a/src/library.cpp b/src/library.cpp index 30b7c7c7ce..4e265f2cd2 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -37,6 +37,7 @@ #include "error.h" #include "force.h" #include "info.h" +#include "fix_external.h" #if defined(LAMMPS_EXCEPTIONS) #include "exceptions.h" @@ -1605,6 +1606,35 @@ void lammps_create_atoms(void *ptr, int n, tagint *id, int *type, END_CAPTURE } +void lammps_set_fix_external_callback(void *ptr, char *id, FixExternalFnPtr callback_ptr, void * caller) +{ + LAMMPS *lmp = (LAMMPS *) ptr; + FixExternal::FnPtr callback = (FixExternal::FnPtr) callback_ptr; + + BEGIN_CAPTURE + { + int ifix = lmp->modify->find_fix(id); + if (ifix < 0) { + char str[50]; + sprintf(str, "Can not find fix with ID '%s'!", id); + lmp->error->all(FLERR,str); + } + + Fix *fix = lmp->modify->fix[ifix]; + + if (strcmp("external",fix->style) != 0){ + char str[50]; + sprintf(str, "Fix '%s' is not of style external!", id); + lmp->error->all(FLERR,str); + } + + FixExternal * fext = (FixExternal*) fix; + fext->set_callback(callback, caller); + } + END_CAPTURE +} + + // ---------------------------------------------------------------------- // library API functions for accessing LAMMPS configuration // ---------------------------------------------------------------------- diff --git a/src/library.h b/src/library.h index 8b03bb3621..59b68b9502 100644 --- a/src/library.h +++ b/src/library.h @@ -58,6 +58,14 @@ void lammps_gather_atoms_subset(void *, char *, int, int, int, int *, void *); void lammps_scatter_atoms(void *, char *, int, int, void *); void lammps_scatter_atoms_subset(void *, char *, int, int, int, int *, void *); +#ifdef LAMMPS_BIGBIG +typedef void (*FixExternalFnPtr)(void *, int64_t, int, int64_t *, double **, double **); +void lammps_set_fix_external_callback(void *, char *, FixExternalFnPtr, void*); +#else +typedef void (*FixExternalFnPtr)(void *, int, int, int *, double **, double **); +void lammps_set_fix_external_callback(void *, char *, FixExternalFnPtr, void*); +#endif + int lammps_config_has_package(char * package_name); int lammps_config_package_count(); int lammps_config_package_name(int index, char * buffer, int max_size); -- GitLab From 7beb2a53f2c4142bc0bba00130fd7e76a56152d3 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 20 Aug 2019 14:12:14 -0600 Subject: [PATCH 458/469] Add missing comment --- src/library.cpp | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/src/library.cpp b/src/library.cpp index 4e265f2cd2..7cf0e0f01f 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -1606,6 +1606,11 @@ void lammps_create_atoms(void *ptr, int n, tagint *id, int *type, END_CAPTURE } +/* ---------------------------------------------------------------------- + find fix external with given ID and set the callback function + and caller pointer +------------------------------------------------------------------------- */ + void lammps_set_fix_external_callback(void *ptr, char *id, FixExternalFnPtr callback_ptr, void * caller) { LAMMPS *lmp = (LAMMPS *) ptr; -- GitLab From b5a79f9616457a5257970388506ae53232e03841 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 16:50:49 -0400 Subject: [PATCH 459/469] update fix wall/region docs as requested by @sjplimp (i hope) --- doc/src/fix_wall_region.txt | 9 ++++++--- 1 file changed, 6 insertions(+), 3 deletions(-) diff --git a/doc/src/fix_wall_region.txt b/doc/src/fix_wall_region.txt index 9807f5717d..702ca8e694 100644 --- a/doc/src/fix_wall_region.txt +++ b/doc/src/fix_wall_region.txt @@ -15,11 +15,14 @@ fix ID group-ID wall/region region-ID style args ... cutoff :pre ID, group-ID are documented in "fix"_fix.html command :ulb,l wall/region = style name of this fix command :l region-ID = region whose boundary will act as wall :l -style = {lj93} or {lj126} or {lj1043} or {morse} or {colloid} or {harmonic} :l -args = :l +style = {lj93} or {lj126} or {lj1043} or {colloid} or {harmonic} or {morse} :l +args for styles {lj93} or {lj126} or {lj1043} or {colloid} or {harmonic} = :l epsilon = strength factor for wall-particle interaction (energy or energy/distance^2 units) - alpha (width parameter), only if style = {morse} sigma = size factor for wall-particle interaction (distance units) :pre +args for style {morse} = :l + D_0 = depth of the potential (energy units) + alpha = width parameter (1/distance units) + r_0 = distance of the potential minimum from wall position (distance units) :pre cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :l :ule -- GitLab From f4254cba0986bb4dc65244e1c2d51df273e5e9ee Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 20 Aug 2019 16:47:43 -0600 Subject: [PATCH 460/469] Use snprintf instead of sprintf --- src/library.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/library.cpp b/src/library.cpp index 7cf0e0f01f..54497970ad 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -1596,7 +1596,7 @@ void lammps_create_atoms(void *ptr, int n, tagint *id, int *type, if (lmp->atom->natoms != natoms_prev + n) { char str[128]; - sprintf(str,"Library warning in lammps_create_atoms, " + snprintf(str, 128, "Library warning in lammps_create_atoms, " "invalid total atoms " BIGINT_FORMAT " " BIGINT_FORMAT, lmp->atom->natoms,natoms_prev+n); if (lmp->comm->me == 0) @@ -1621,7 +1621,7 @@ void lammps_set_fix_external_callback(void *ptr, char *id, FixExternalFnPtr call int ifix = lmp->modify->find_fix(id); if (ifix < 0) { char str[50]; - sprintf(str, "Can not find fix with ID '%s'!", id); + snprintf(str, 50, "Can not find fix with ID '%s'!", id); lmp->error->all(FLERR,str); } @@ -1629,7 +1629,7 @@ void lammps_set_fix_external_callback(void *ptr, char *id, FixExternalFnPtr call if (strcmp("external",fix->style) != 0){ char str[50]; - sprintf(str, "Fix '%s' is not of style external!", id); + snprintf(str, 50, "Fix '%s' is not of style external!", id); lmp->error->all(FLERR,str); } -- GitLab From 9b703c66751dd5b3e170e4b97aac6d6aba544b3c Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 20 Aug 2019 16:54:37 -0600 Subject: [PATCH 461/469] Fix file name --- examples/COUPLE/python/example.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/COUPLE/python/example.py b/examples/COUPLE/python/example.py index 6a3c978822..ea268fe1ca 100644 --- a/examples/COUPLE/python/example.py +++ b/examples/COUPLE/python/example.py @@ -23,7 +23,7 @@ def callback(caller, ntimestep, nlocal, tag, x, fext): print("="*40) L = lammps.lammps() -L.file("in.lammps") +L.file("in.fix_external") # you can pass an arbitrary Python object to the callback every time it is called # this can be useful if you need more state information such as the LAMMPS ptr to -- GitLab From b79e5401d408805b04e183591ab95c2d26311740 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 20 Aug 2019 16:55:36 -0600 Subject: [PATCH 462/469] Increase string buffer size to 128 --- src/library.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/library.cpp b/src/library.cpp index 54497970ad..6f283ea4da 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -1620,16 +1620,16 @@ void lammps_set_fix_external_callback(void *ptr, char *id, FixExternalFnPtr call { int ifix = lmp->modify->find_fix(id); if (ifix < 0) { - char str[50]; - snprintf(str, 50, "Can not find fix with ID '%s'!", id); + char str[128]; + snprintf(str, 128, "Can not find fix with ID '%s'!", id); lmp->error->all(FLERR,str); } Fix *fix = lmp->modify->fix[ifix]; if (strcmp("external",fix->style) != 0){ - char str[50]; - snprintf(str, 50, "Fix '%s' is not of style external!", id); + char str[128]; + snprintf(str, 128, "Fix '%s' is not of style external!", id); lmp->error->all(FLERR,str); } -- GitLab From 6b1df0729870fdc7622146b27da8a8721790e5a4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 19:24:22 -0400 Subject: [PATCH 463/469] compute HMA style name should be lowercase --- examples/USER/misc/hma/hma.in | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/USER/misc/hma/hma.in b/examples/USER/misc/hma/hma.in index 50c6dd96fb..96f2ca1f2a 100644 --- a/examples/USER/misc/hma/hma.in +++ b/examples/USER/misc/hma/hma.in @@ -23,7 +23,7 @@ compute u all pe compute p all pressure NULL pair -compute hma all HMA settemp u p 9.579586686264458 cv +compute hma all hma settemp u p 9.579586686264458 cv timestep 0.005 -- GitLab From 14b93f91e2a739cce040d1d3d8e92c9938c9b805 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 19:25:19 -0400 Subject: [PATCH 464/469] Compute HMA style name should be lowercase (and match the docs) --- src/USER-MISC/compute_hma.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/USER-MISC/compute_hma.h b/src/USER-MISC/compute_hma.h index 44906b53a1..233e8bbe57 100644 --- a/src/USER-MISC/compute_hma.h +++ b/src/USER-MISC/compute_hma.h @@ -13,7 +13,7 @@ #ifdef COMPUTE_CLASS -ComputeStyle(HMA,ComputeHMA) +ComputeStyle(hma,ComputeHMA) #else -- GitLab From fffe2eb958d6da8acf99e554b82bc944b294d0c6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 19:26:26 -0400 Subject: [PATCH 465/469] Silence compiler warning --- src/pair_lj_smooth_linear.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 9dcee2362e..b6dae6524a 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -349,7 +349,7 @@ double PairLJSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, } double PairLJSmoothLinear::single_hessian(int /*i*/, int /*j*/, int itype, int jtype, double rsq, - double delr[3], double factor_coul, double factor_lj, + double delr[3], double /*factor_coul*/, double factor_lj, double &fforce, double d2u[6]) { double r2inv,r6inv,forcelj,philj,r,rinv; -- GitLab From 91a80c3c213acfb526a79522dfdd2ee58fca600c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 19:28:03 -0400 Subject: [PATCH 466/469] Silence another compiler warning --- src/pair_lj_smooth_linear.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index b6dae6524a..bc2904c262 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -328,7 +328,7 @@ void PairLJSmoothLinear::read_restart_settings(FILE *fp) double PairLJSmoothLinear::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq, - double factor_coul, double factor_lj, + double /*factor_coul*/, double factor_lj, double &fforce) { double r2inv,r6inv,forcelj,philj,r,rinv; -- GitLab From 6a584672e853005bf7e2040343049dc835e9430f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 13:29:09 -0400 Subject: [PATCH 467/469] implement fix wall/morse based on fix wall/region and fix wall/harmonic --- doc/src/fix_wall.txt | 22 +++++++++-- src/fix_wall.cpp | 14 +++++++ src/fix_wall.h | 6 +-- src/fix_wall_morse.cpp | 87 ++++++++++++++++++++++++++++++++++++++++++ src/fix_wall_morse.h | 49 ++++++++++++++++++++++++ 5 files changed, 172 insertions(+), 6 deletions(-) create mode 100644 src/fix_wall_morse.cpp create mode 100644 src/fix_wall_morse.h diff --git a/doc/src/fix_wall.txt b/doc/src/fix_wall.txt index 162e32c68c..b8e380fb16 100644 --- a/doc/src/fix_wall.txt +++ b/doc/src/fix_wall.txt @@ -12,22 +12,25 @@ fix wall/lj126 command :h3 fix wall/lj1043 command :h3 fix wall/colloid command :h3 fix wall/harmonic command :h3 +fix wall/morse command :h3 [Syntax:] fix ID group-ID style face args ... keyword value ... :pre ID, group-ID are documented in "fix"_fix.html command :ulb,l -style = {wall/lj93} or {wall/lj126} or {wall/lj1043} or {wall/colloid} or {wall/harmonic} :l +style = {wall/lj93} or {wall/lj126} or {wall/lj1043} or {wall/colloid} or {wall/harmonic} or {wall/morse} :l one or more face/arg pairs may be appended :l face = {xlo} or {xhi} or {ylo} or {yhi} or {zlo} or {zhi} :l - args = coord epsilon sigma cutoff + args = coord epsilon \[alpha\] sigma cutoff coord = position of wall = EDGE or constant or variable EDGE = current lo or hi edge of simulation box constant = number like 0.0 or -30.0 (distance units) variable = "equal-style variable"_variable.html like v_x or v_wiggle epsilon = strength factor for wall-particle interaction (energy or energy/distance^2 units) epsilon can be a variable (see below) + alpha = width factor for wall-particle interaction (1/distance units) + [only] for {wall/morse}. alpha can be a variable (see below) sigma = size factor for wall-particle interaction (distance units) sigma can be a variable (see below) cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :pre @@ -48,6 +51,7 @@ keyword = {units} or {fld} :l fix wallhi all wall/lj93 xlo -1.0 1.0 1.0 2.5 units box fix wallhi all wall/lj93 xhi EDGE 1.0 1.0 2.5 +fix wallhi all wall/morse xhi EDGE 1.0 1.0 1.0 2.5 units box fix wallhi all wall/lj126 v_wiggle 23.2 1.0 1.0 2.5 fix zwalls all wall/colloid zlo 0.0 1.0 1.0 0.858 zhi 40.0 1.0 1.0 0.858 :pre @@ -80,6 +84,10 @@ potential: :c,image(Eqs/fix_wall_harmonic.jpg) +For style {wall/morse}, the energy E is given by a Morse potential: + +:c,image(Eqs/pair_morse.jpg) + In all cases, {r} is the distance from the particle to the wall at position {coord}, and Rc is the {cutoff} distance at which the particle and wall no longer interact. The energy of the wall @@ -147,7 +155,15 @@ constant K, and has units (energy/distance^2). The input parameter spring is at the {cutoff}. This is a repulsive-only spring since the interaction is truncated at the {cutoff} -For any wall, the {epsilon} and/or {sigma} parameter can be specified +For the {wall/morse} style, one additional parameter {alpha} is required. +Thus the parameters are in this order: {epsilon} as the depth of the +Morse potential (D_0), {alpha} as the width parameter of the Morse +potential, and {sigma} the location of the minimum (r_0) +the wall. {D_0} has energy units, {alpha} inverse distance units, and +{r_0} distance units. + +For any wall, the {epsilon} and/or {sigma} and/or {alpha} parameter can +be specified as an "equal-style variable"_variable.html, in which case it should be specified as v_name, where name is the variable name. As with a variable wall position, the variable is evaluated each timestep and diff --git a/src/fix_wall.cpp b/src/fix_wall.cpp index 8ceafb4bfc..a30b14c231 100644 --- a/src/fix_wall.cpp +++ b/src/fix_wall.cpp @@ -23,6 +23,7 @@ #include "respa.h" #include "error.h" #include "force.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace FixConst; @@ -99,6 +100,19 @@ FixWall::FixWall(LAMMPS *lmp, int narg, char **arg) : estyle[nwall] = CONSTANT; } + if (utils::strmatch(style,"^wall/morse")) { + if (strstr(arg[iarg+3],"v_") == arg[iarg+3]) { + int n = strlen(&arg[iarg+3][2]) + 1; + astr[nwall] = new char[n]; + strcpy(astr[nwall],&arg[iarg+3][2]); + astyle[nwall] = VARIABLE; + } else { + alpha[nwall] = force->numeric(FLERR,arg[iarg+3]); + astyle[nwall] = CONSTANT; + } + ++iarg; + } + if (strstr(arg[iarg+3],"v_") == arg[iarg+3]) { int n = strlen(&arg[iarg+3][2]) + 1; sstr[nwall] = new char[n]; diff --git a/src/fix_wall.h b/src/fix_wall.h index 82634c349f..b2bdc2e27c 100644 --- a/src/fix_wall.h +++ b/src/fix_wall.h @@ -45,12 +45,12 @@ class FixWall : public Fix { virtual void wall_particle(int, int, double) = 0; protected: - double epsilon[6],sigma[6],cutoff[6]; + double epsilon[6],sigma[6],alpha[6],cutoff[6]; double ewall[7],ewall_all[7]; double xscale,yscale,zscale; - int estyle[6],sstyle[6],wstyle[6]; + int estyle[6],sstyle[6],astyle[6],wstyle[6]; int eindex[6],sindex[6]; - char *estr[6],*sstr[6]; + char *estr[6],*sstr[6],*astr[6]; int varflag; // 1 if any wall position,epsilon,sigma is a var int eflag; // per-wall flag for energy summation int ilevel_respa; diff --git a/src/fix_wall_morse.cpp b/src/fix_wall_morse.cpp new file mode 100644 index 0000000000..f854341e11 --- /dev/null +++ b/src/fix_wall_morse.cpp @@ -0,0 +1,87 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "fix_wall_morse.h" +#include +#include "atom.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + +/* ---------------------------------------------------------------------- */ + +FixWallMorse::FixWallMorse(LAMMPS *lmp, int narg, char **arg) : + FixWall(lmp, narg, arg) +{ + dynamic_group_allow = 1; +} + +/* ---------------------------------------------------------------------- */ + +void FixWallMorse::precompute(int m) +{ + coeff1[m] = 2.0 * epsilon[m] * alpha[m]; + const double alpha_dr = -alpha[m] * (cutoff[m] - sigma[m]); + offset[m] = epsilon[m] * (exp(2.0*alpha_dr) - 2.0*exp(alpha_dr)); +} + +/* ---------------------------------------------------------------------- + interaction of all particles in group with a wall + m = index of wall coeffs + which = xlo,xhi,ylo,yhi,zlo,zhi + error if any particle is on or behind wall +------------------------------------------------------------------------- */ + +void FixWallMorse::wall_particle(int m, int which, double coord) +{ + double delta,fwall; + double vn; + + double **x = atom->x; + double **f = atom->f; + int *mask = atom->mask; + int nlocal = atom->nlocal; + + int dim = which / 2; + int side = which % 2; + if (side == 0) side = -1; + + int onflag = 0; + + for (int i = 0; i < nlocal; i++) { + if (mask[i] & groupbit) { + if (side < 0) delta = x[i][dim] - coord; + else delta = coord - x[i][dim]; + if (delta >= cutoff[m]) continue; + if (delta <= 0.0) { + onflag = 1; + continue; + } + double dr = delta - sigma[m]; + double dexp = exp(-alpha[m] * dr); + fwall = side * coeff1[m] * (dexp*dexp - dexp) / delta; + ewall[0] += epsilon[m] * (dexp*dexp - 2.0*dexp) - offset[m]; + f[i][dim] -= fwall; + ewall[m+1] += fwall; + + if (evflag) { + if (side < 0) vn = -fwall*delta; + else vn = fwall*delta; + v_tally(dim, i, vn); + } + } + } + + if (onflag) error->one(FLERR,"Particle on or inside fix wall surface"); +} diff --git a/src/fix_wall_morse.h b/src/fix_wall_morse.h new file mode 100644 index 0000000000..a7359e9cde --- /dev/null +++ b/src/fix_wall_morse.h @@ -0,0 +1,49 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS + +FixStyle(wall/morse,FixWallMorse) + +#else + +#ifndef LMP_FIX_WALL_MORSE_H +#define LMP_FIX_WALL_MORSE_H + +#include "fix_wall.h" + +namespace LAMMPS_NS { + +class FixWallMorse : public FixWall { + public: + FixWallMorse(class LAMMPS *, int, char **); + void precompute(int); + void wall_particle(int, int, double); + + private: + double coeff1[6],offset[6]; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Particle on or inside fix wall surface + +Particles must be "exterior" to the wall in order for energy/force to +be calculated. + +*/ -- GitLab From aac557a98f72d366695b19f5dd39264f6baa68b8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 20 Aug 2019 13:33:36 -0400 Subject: [PATCH 468/469] integrate fix wall/morse docs properly into manual --- doc/src/Commands_fix.txt | 1 + doc/src/Howto_walls.txt | 11 ++++++----- doc/src/fix.txt | 1 + 3 files changed, 8 insertions(+), 5 deletions(-) diff --git a/doc/src/Commands_fix.txt b/doc/src/Commands_fix.txt index d2d781d4b2..cfd2bcf2ef 100644 --- a/doc/src/Commands_fix.txt +++ b/doc/src/Commands_fix.txt @@ -232,6 +232,7 @@ OPT. "wall/lj1043"_fix_wall.html, "wall/lj126"_fix_wall.html, "wall/lj93 (k)"_fix_wall.html, +"wall/morse"_fix_wall.html, "wall/piston"_fix_wall_piston.html, "wall/reflect (k)"_fix_wall_reflect.html, "wall/region"_fix_wall_region.html, diff --git a/doc/src/Howto_walls.txt b/doc/src/Howto_walls.txt index 7522118582..4e4f0c5d6f 100644 --- a/doc/src/Howto_walls.txt +++ b/doc/src/Howto_walls.txt @@ -59,14 +59,15 @@ granular particles; all the other commands create smooth walls. "fix wall/lj126"_fix_wall.html - flat walls, with Lennard-Jones 12/6 potential "fix wall/colloid"_fix_wall.html - flat walls, with "pair_style colloid"_pair_colloid.html potential "fix wall/harmonic"_fix_wall.html - flat walls, with repulsive harmonic spring potential +"fix wall/morse"_fix_wall.html - flat walls, with Morse potential "fix wall/region"_fix_wall_region.html - use region surface as wall "fix wall/gran"_fix_wall_gran.html - flat or curved walls with "pair_style granular"_pair_gran.html potential :ul -The {lj93}, {lj126}, {colloid}, and {harmonic} styles all allow the -flat walls to move with a constant velocity, or oscillate in time. -The "fix wall/region"_fix_wall_region.html command offers the most -generality, since the region surface is treated as a wall, and the -geometry of the region can be a simple primitive volume (e.g. a +The {lj93}, {lj126}, {colloid}, {harmonic}, and {morse} styles all +allow the flat walls to move with a constant velocity, or oscillate in +time. The "fix wall/region"_fix_wall_region.html command offers the +most generality, since the region surface is treated as a wall, and +the geometry of the region can be a simple primitive volume (e.g. a sphere, or cube, or plane), or a complex volume made from the union and intersection of primitive volumes. "Regions"_region.html can also specify a volume "interior" or "exterior" to the specified primitive diff --git a/doc/src/fix.txt b/doc/src/fix.txt index e5036d5a73..1dd9cc9f1b 100644 --- a/doc/src/fix.txt +++ b/doc/src/fix.txt @@ -371,6 +371,7 @@ accelerated styles exist. "wall/lj1043"_fix_wall.html - Lennard-Jones 10-4-3 wall "wall/lj126"_fix_wall.html - Lennard-Jones 12-6 wall "wall/lj93"_fix_wall.html - Lennard-Jones 9-3 wall +"wall/morse"_fix_wall.html - Morse potential wall "wall/piston"_fix_wall_piston.html - moving reflective piston wall "wall/reflect"_fix_wall_reflect.html - reflecting wall(s) "wall/region"_fix_wall_region.html - use region surface as wall -- GitLab From ad83f0e2e36d6658bccc9524ca0c196efc6fe3e8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 21 Aug 2019 17:12:04 -0400 Subject: [PATCH 469/469] update docs to add morse in a similar style to fix wall/region --- doc/src/fix_wall.txt | 28 +++++++++++++++++++--------- 1 file changed, 19 insertions(+), 9 deletions(-) diff --git a/doc/src/fix_wall.txt b/doc/src/fix_wall.txt index b8e380fb16..7868bacf04 100644 --- a/doc/src/fix_wall.txt +++ b/doc/src/fix_wall.txt @@ -22,18 +22,30 @@ ID, group-ID are documented in "fix"_fix.html command :ulb,l style = {wall/lj93} or {wall/lj126} or {wall/lj1043} or {wall/colloid} or {wall/harmonic} or {wall/morse} :l one or more face/arg pairs may be appended :l face = {xlo} or {xhi} or {ylo} or {yhi} or {zlo} or {zhi} :l - args = coord epsilon \[alpha\] sigma cutoff + args for styles {lj93} or {lj126} or {lj1043} or {colloid} or {harmonic} :l + args = coord epsilon sigma cutoff coord = position of wall = EDGE or constant or variable EDGE = current lo or hi edge of simulation box constant = number like 0.0 or -30.0 (distance units) variable = "equal-style variable"_variable.html like v_x or v_wiggle epsilon = strength factor for wall-particle interaction (energy or energy/distance^2 units) epsilon can be a variable (see below) - alpha = width factor for wall-particle interaction (1/distance units) - [only] for {wall/morse}. alpha can be a variable (see below) sigma = size factor for wall-particle interaction (distance units) sigma can be a variable (see below) cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :pre + args for style {morse} :l + args = coord D_0 alpha r_0 cutoff + coord = position of wall = EDGE or constant or variable + EDGE = current lo or hi edge of simulation box + constant = number like 0.0 or -30.0 (distance units) + variable = "equal-style variable"_variable.html like v_x or v_wiggle + D_0 = depth of the potential (energy units) + D_0 can be a variable (see below) + alpha = width factor for wall-particle interaction (1/distance units) + alpha can be a variable (see below) + r_0 = distance of the potential minimum from the face of region (distance units) + r_0 can be a variable (see below) + cutoff = distance from wall at which wall-particle interaction is cut off (distance units) :pre zero or more keyword/value pairs may be appended :l keyword = {units} or {fld} :l {units} value = {lattice} or {box} @@ -155,12 +167,10 @@ constant K, and has units (energy/distance^2). The input parameter spring is at the {cutoff}. This is a repulsive-only spring since the interaction is truncated at the {cutoff} -For the {wall/morse} style, one additional parameter {alpha} is required. -Thus the parameters are in this order: {epsilon} as the depth of the -Morse potential (D_0), {alpha} as the width parameter of the Morse -potential, and {sigma} the location of the minimum (r_0) -the wall. {D_0} has energy units, {alpha} inverse distance units, and -{r_0} distance units. +For the {wall/morse} style, the three parameters are in this order: +{D_0} the depth of the potential, {alpha} the width parameter, and +{r_0} the location of the minimum. {D_0} has energy units, {alpha} +inverse distance units, and {r_0} distance units. For any wall, the {epsilon} and/or {sigma} and/or {alpha} parameter can be specified -- GitLab

Q`C?0hrw3lw4%`{i618v2*VCKsA9Q!V zYUcT{$n{Oe|8Db8{vwIZnSaIK#a7qxAAcBe<*W4^-SabV-Ff>eIeu>O(=W@-RE6$` z9iCl3g-aqw<;^Ae_|SyLDQ6x`Hk!Y(`{A~|lkdDY+M`+cV(snwv-#8={@2+Eyf_g3 zA$$fy{oP%*jtAA)5BtJ*l;6Z>m9nzW~HfG<>i#MHcW)aJaSc~U-wb^=3bw1UeTX{Y??AY8Rhgk0(dD1k$F;QZ^ z#`3jK*rsZl#YVmMh^VhQ-JC-RWPf`IKu#g;W2j zx2IOWzqPMO?2Y^>cenG&m2+j5uz1OBYW_Rn&4%^s)}30HQ}*;b|Fujv$&+iXY`tR^ z%zNR+5@f9YbkYe!X>)#^Wyg+g`~51w%vNLNio&Z)r)F-D?|rt=PviM}M}vBq-8${J zH|0#S%U9%&C~i9MZ4@MW)^6uCwYJq$S|{H$Z+|q$ejfAErVH%Le>R(FPS1^=?pj=R zZ?{(8*A2JSHK((wFJJt4TX^_MTc)eO&6KRZ+RnG$A3mpRZg!~F_;TXK zT?uX}D+jA%d(NNg}I+I8G_vWL+ixJUa1H<#jW)ewO*C z3=g>1x2jbfxU;3TN8^ifO+y;P?K3NXZM4q$kQ={C>B@q4y_aj76mvTTpEXM)Wu2UG z;_aM;=O=pU2irE+b*J|Tvt{utoqJg%-7@fu=^x`u?Qd4u9a*Qn#=~NJ@$RN~lX4=H zbfYb$cApn;*%KnHCgp2!k&{1TnajM0Qv%A zK6bsk-Qto3=j&JD^K}#0j>lRxzB5i`&2V{9va4vi7iSvVe*5|bNl(-2*X$6n+hFjX@(l>7VVJIWfxuNGk$8{T?o>|8qwmiDX>dI$XyYkY?pHUoVpCy=SZc;rn zV|j{Pw#ngbOE}(gb}{K|aLMib@jOPv^|{_7*M@(GJf7Vyxn6bNV9tr3EJ1ht*;b}m zl=;rkF5sEXEK~Gy)hAvyli31ugHq~m%xj->FyexA3j5pFPIIbX23;|ZdHT)w_VgV; zD*76Y1^ln4_6H{`?BvwnC;j%I@as+TOx=10cM5nFPo8;JHEZXa+rKQPoZxRh*Yh!S zxn=mA2ETii(>h`Wd1Pj19atC}dEH{0eObjbg+-nTyVmm^-!((`>6I(f6R#Z)TvY!^ z=u-WyCq}uU{_X9Obn9)T0p3g5~=CiQ@B~GcGkCnU?4=wqA?pwuVfr(3a_Fa7-W67Y;m+W(9f$s96;>hj0=TH9N zJ+Y=}<i=3DISN< zI$J6&b@tFoTI=+40oQw>-g|2r&n4gUpTftv_2}|j9;UCQ#h**>yWZRWY~@se^Y^o* zi+5#J9M!myesaT%;5lj%|G%&_|C_OEMw#n>*FRGyi0!%4Rb6J%-&OxRx9g;gRMfxO zU906p%q8crRZZF$|LyrEJHyh{dS>0k6PMo3Si8DnPn^}4eO?Wz+=6%ZTA#nF)_GX+ ziOJ#lU!-;hJYKiguao~rbI{+5CM$&;wBoZT`G+cOJU>k`sH*jydhG6@wSoomU@oXL+PtGuh%{hPOI%2T!=RfVL*oR>Fm*?LbXBK%IU^^Se_ zgmlEWx5%7!puOupWz?6p22RDAsRje}Fyw_N|cxTpPm*pJSg&huwkf61TRTB^jodp3XF zs?6!>j^{Qtow%dN^^(g<%Y*sC)||QP&ju~(i`jX&zQ#4CUipsZ)))oHvtk|rpU*yg zF>%WL57QGZctlQaPFTwMd~xN5QvZl34~{Q?POb}{cd7K0JNInWu0H9+{cn~Q9zDZp zG}q#1AisX%jlw?XebFp;lrvjqR`vCpK1!B2ELK={ypy4``RJKf{+x`@7^YRWnF{NB z<}bMO?W4UYV_dzn&@(*-2FK_93tk(1pS0w?&7J!JUnaHhKl^|4!}<2RjaPk=l?yHX zZFf^W!0GIx`7#~(vK^d1zA;*GiU_@W#1;7K#UtFN-9uC|ENV zd^KTMKWmfpDy7KlVzOBW?mJt%gj+gXzPU!mO7Hu`2^Mj4RVVD&)~`_b_WZhFrhC7Y zr7rJxcQctFSjpA?x*{O!g;4w9dX_egJvxOuI@8VH-A>@CknLS~*mLzvX=T1cn-A>l zI8ms!prAm0v(rPyW$XK_g|jX^DCn~1Jo&WqMCg2$lV9ceC%vAmu=8Jiza`^-o8p3Xs{S6x9mBanR?D*3z{H+2VwG^?(qF<6|2Q>t z>=P4KN)}2awQBpOWL=wGJWrU{v+{MG?_)s;aqd;?_0Ij{exy2;b-G|Hi}3WuEEZ8F zQCKL#Iibzz=Ts4K@ke*dQvYL{->I@`;)=GIIZ3!&UX%WQ}8#k=<(Q?D=m`;6UecW(T}n{Rv0?d!d6AHV9drNm%rLOXxm=x;&xnfVL{3I zD_@s!X|H{Ccj3M1zZcwmccbiZcWrn`wLOneVwmCFsh-|jo*iD3;rsgOmRYAb-L{l8 z-|)@Ta$OSC%%Z4b&U@LVKEsmZ?z1;0M|Nm@tczY>=eF`@ke6f6Jl&ZJTqZB$zrPD9 z*{63u@YMIE^{>nxvaS7CzTLOhrbg23dv^WhDR(#C+@5$Pp06~z^lH=UpX<3lM9s*k zzq40=cI%SQ2JW5u@A-T=rRCC?-51Ym(mK>TvvL2NZ&CXe_f$$-B=Y!5+^?+{j!oz= zHmNw!w6KZC$mY44=MvG)Pc=+gdgplQvIe_+ypsKY%`Xndxv!<`|5hG6u&iJHLy-Av zv+WC(wjAmz+2DC`o6Mg*x!Hf7h&Ep@xpwE=pR=>`+FE*Z6h8-ezAx&nfXwdqfn} z&nk%X@_f9SEnz#|{D+BlkHVDI)jv%`O|CZZZ3>N8r5pZaQn_fN<@ZN=sliu;k{8W9 zyDm0eo9~Qv^1;qjw(ly^*)fGlTj%ON^ory#yW(42IQfNwg`v%>4eR*6Zu=8n$n9sh z?)05M_0t4Tzxi&XN|D-PV(IcX%JWz{thZ?5NhZ zYxerZd_L3D*LrF%GPFGT_?x5($Z$Z8{$cp z_3>f9Z@+0%Xeyr0xb1R{a)`@!mKOpSO?Ldb{~THjrwcB-HQhH{ z^#3_up0!KG(wKB>r6bFo*ZfGD;#M-_{mBU7yyhbpy2YHmuIEaYE#0wNjzR5l_dnYh zCYO@r(>1$PFTC7r=oDPOWWgeZ#Z!OOZaCQ)u~@C4rR|HUkoJp(8C|hAr`G#cTwHFl zPa;d#>A(}=9W&>225h)-Z6(L|cV~|_Ew~Z2dULC=!qnq_Eal}hEa!wMSj|28P|_pn z`Th-MJPQjioaO$n#}M#IO~&-&R{P}+e@|J?EB1a8k&;)G_K5A+-kqoCIQ`*!9LZ|5 zcsiHm$t!=0Pq<_S2@2V~^4DU%_9U(8asAwhlV8bCyKEB6ckW>Gh1WTH%|~1hrzA<# zS028S%=370;)R+Z9hV-%`h&}RwoXXS%ZY!tsP6fwA@5@0_TJ;ZU(vxRHBKndcSbTTRA=@oJuaI~zSG#XP;%IFI*y(2a)*kr%n^ z#P=G^(pb=>zA^aOlubvXY}jtp{~Km0{q5D< z30lUFCkgSEdq>2vozz-o-qqNtWA*j*8M~}QF(u&zD?IBN1y#=QJeYQ@Y(h|1{mv7G zM;x`jW_?`#Bz5X%-7f|{`!Z^6H(v3u=CaLEsFo_5bDHPxq}1anr_QCMA2_l`-lXK; zOS!&D%PSTiySDL+e%8_x`m-v0o1#nSGjz>Q{5PY?Ut|f#v9~Ww%vZ8?KA*NhJm6nK z(rxSC#>@ZCy!`LJWo~_G+vTwS2V16Ai>$Qmh)vsi^}qbn1$M!F^&(FVZVFkrRcv}F zoUx$dn9WL?fX9(v?yD_V50R5pt;=}z-{G>f`KtNmg=~4A_v36or7v&)FkdlUXye{f zY4V5HUEH-L=PxT)apm>c)S2wgEtmQglcqVE%=|U`>MEO(qrV%U{}(mhRewY7wAt=i z%>ElPz3w|U22VL>-}XA6|La+;pREhCR~_E==96B-<;EvwS3j?R>RWiHOx-K3)MSpw ztShn_E{=OY_6hz{5EVDQ+LEdH*35ZNuSyNy z(hC##XEz>j`n3N>*#4=n?{$eB=i51<{@g{w8*fj1F5xkY5R6mrFicbZ;*eln_LS=n zTeZv#XI}U0jH2iHuhz}Dpt+JuWZ$9>Q#<1Y%Vy@Unay?b*S$k$mdu*>XOijE?*@-F z4>f%I>s%T9>vf%IInRQ%x5Q(AGK9a_6C}A#AZllE%tEQ^S=Gztd^yz?@YBaWwUc`e zgY?Pzz8kL=sLs14Ty{@vcY@5Kw|oo5d6YnmsijED!tWZLwCx3 z*GU>njr3&PzP>M%@U7@!XFAlkl~G{DH#zM+?7x+{?CO(c4>z(2pHSzwiz`}lZ1Id5 zquyB?`0stKSQGX=W|{D^Rx7)X8x~;$!$B()A(+$w9ut|#|8It{B_hUN`vJmE-e1>`R}?r+ZVcu_4$5W z8h%_Y@#q1o#N;*q>nEu%mPuB=yZOmETZv^4Sks@LED^V`o0Xow)K}F)TkWj zIL)wlzF@);*P4wkvp&|BgsqnAufM2!?7Q#Zt@cI|-Fvv^so$C_|9&OQ4nGH3`TK2; zEw30X5&h%qul=LRc%kq!`-lHuSje4o`tUJRY7R^HwHAND8Fg7x&BYB=e=>fW{CZub z$g&yfheSSW_*ACdK9XF2Dz$RnwADNIuU2A-NMTaHBOqG)FoMf>1*gP;RHd)mUx)u^ zWi8KFR0FjOMHr1BgSzI%;FjU^J@G8O^}LJ<972mvIrb%oFWqFZYGq7{yv5x&na6TA z9d%v&@%nRH9hHNO>0828zjZ2b?2*l9j*r>@uQNAqcX~_7qT|e%7%3L$Fg{#6k=bnrC(K7MlM!T|4@6*q!@m#d$_P?UP*TwBOr0fedI&@ir z;dO7l{pFTfp>|A;6*hXe%pE;^Ca`c+aCokDs>%-YcopapGH0h~Jy+mlfr%=4to#?7 zw2$;)Fcc@N16SEICiTUtOR(?}=6A3DY-G%BdW)SQZ+wq}^4T*W9X_ zSyHZbOX)~m&mG;L-ya?{2t1{$X`OuF@5&9wqVI=Yt6%Z?m%t-!Q5U;}GshQtoN_OX zx?r?w_P06VPxFr+TvYXbgSor$WwY9Q(|!L6#RZGX&c1d=JbIeT`|^&g&5yOzL_&5X z8_r=)o$%zjcj$r=BhjZHCfHkon|&dx1^;y{YX?tp_Sf zcz-7dxF275Z}GXedp0UcygA6j(tGdWzC~|O|GKv3z4T|>>sl@hxy9RppDDT(&lEh8 z>?&mT`OuX0bIkPI(v^4)lo@#+NS82=KXohd+A_K2hKWYsTFZ_kU&$}GSr}+OrM9k_ zUF^QedJBnNf3BTVbgB9G`~7`k-YNA9yC<-vBq{8BCHDL4#G?oIS;o)Wwc@wvZ!fp* z-1B!8RT$2B9NRSW|ECAfqx-ZTKHxc(m9%7M1n(=;#j8JWFy?4BkrSQp{p?O|p$X?6 zzxynpasJ`7(apAstgCBMYQ`j^LiivpoYjwFs*Up`EpaQ-eQlP3$!<9|<%HlJHkQ@pt}S-k$)bnnnb*4KASZQs4YW7aa; zDW(YdrIQs+RwI!E#FK-LI~858aQgJpa)r|8sNp zxtwUf^lfi;FS24=Th90?KQ;aC^fZon`|~7wyM9~OFr0VPKKp;< zoMm%&%XVqwiocIHpRJeP>m;!3?&le|Z~wgb_-T8ynRPDrWcEW56;Jc;c&_7QoZQHu za6Dl~#pyF26J1m}%_T3M;mq6`+d89V!J(rW%aohLIG38LD(^Hne7cxhu;tT}#_4l} zUj-ZNG84DlmE=EfQl3+U$DYkPcguH3dS3o=@8_YMqhQYddRCeDZ;DHd zzGpaIP3iHGyfgj!nMZ(kA|(pihckU5W|mUD2wl^H;0zScgBHqW#k> ztEe$QG_>oV{wmKPCClG)Hg8!!Yu$@qub;&y*U5V=luURK>{l3-&C~PoUuj{>uI=}t zm!5n4RmhAbU&ityd$E?E=#yoK`2FhZ^Iq+%xX*rBi;?x}l#gb)oI-N~H~8E2F{*I%QYpzaKS}UsZQ7DPW0a`=)b?=Lx#o@%D$k4t_ROii6uV zjK4nAbmQZkw6&ScJe-Ftqm5FuqHk1eo#uFYV)y&5f9npUDfs6myYl;#CC7DbckYy& z;<;E$XTz62Ap-5z^_nW*bguk5JujA4y63a`Iu2{){)=L$K z@bF91rtve0x31E8@M~ta=Q;O}kJrf?b>`f=?6&5&a6o{t#)V3$*!g!#!sjh~b*yH? z2IFn3re55=NqU2G{oAZ>F1LhCXI^`=anH4*>+jxq_FwZ`?d5yYksDZ?X35*V^Rtpt ziM;aC&Q$D9XVJNOgOrqA7nj;UDf?)-UQ5|YwDfTA%c%$0orTw|)-o>4+_i3t=g})A zFPe^8Y&-w-iQO~XC1>K@HRhK3^!y09a^>nY*YDGs9#2cXDEMQ$O@!gW`b`V>^ZYHo z?cM0(zieMX*4>MB;X2WM?Z2(;r~fYCcMzC$q`&;s6otZNf4+Q`TB)NSe&a<#;C1uq z-S7Svz4@PY#OFb+<1&4o2HVATGp;OZ3*A{6^JdYaHJ%p)jJ+?Md9ZEPn$zoE-hLMJ?(7lY&-d0`sMXx!aC^w~YZ`THzif7HF&IL~zE1Qp|#@+JquzAc~lY=QO3Yr(}k_w;;7H5PL@e|F)vqDcYo zOA8M8*8iL)k+;P-WA;N6%eH|1Ax+19+`pHdx?LRHoa4MMRLD?okLKrd3}x57=6%=X zcSyN;e|BcN!@+fC!U3MgjGiRid=a+%;^UpBQ@oN^$#<6ip71^C;)Bjl^GjQ=EbYsX zn6X=`_+wIynBTdQ6t%wYT<_v`&0Mz+Ec=jL$f z9a&rodtHOC&FFnT?NRf$i0!$7C3Z*MXIPn}_n1U3%0Jw5{qV1%#0=->GI8ZuZCqEi zr(`Bbna`LVw_@h~+Y=hzU5x!H@$ta%r4>TerwZg}ZGQRb(3`V+k0uFDf7TU#|NWc; z+vd+czfQDD!#Z{WTYtTTa!r?Pd2U^0DC_&zEPU?OnGG+*_O|amB-$jb_P6HYx;I^0 z-)-zT_`bNh-A!fV&CpkZ;?0XHr3x6=o9t&iQFpewb#Bcoy#vqRzBDxIxx0ArOsn(z zlJlMHkN-Qere2;$%=(ySnPNxM#$NFi(TqjAR?hmn{$L)z>c)_M zWW73P`|!K4>lKkX>koau@?iT_qwt?|P9L4(@a=P8c;U(A2c!44f6ic0pIVf*{>^3) zg)h$0uj9EM7P$Y8PS)`4&I*qYr_ep=>4G<_q2qHPsEx&kS#ag`r~R+UH7|oh8YKz z9I2f%fjPjsM)=otm9Qx(0yF3TyMAO!`sRAybqa@h{_b7mvBr+`fxh1b8=8xX>ckjOc_vqX|AG&w{@YZ~}vD?~dx%`=ZGgcjW|NK**W1UCvo8OIU7NuuB z;)CmV)_sd-UCjAmI{2_H6O-uz|Cu%TjN!-k8W~u^E>F6jFMX1??s~jo|66Bw=W{&m zEIkZ6m+Z5C5XIstcT1}BgXOD(8A(g0)p#`i`S^Foy{W4IFIa60xvFn`>uJ$`#hrgn zNM2dLbO2$KnC&_#&A{tK*bQauZa`xHG7S?0h+N5skJt0bMR&>CLtd$2B zgmpiN)Sa=#;f!d#Fz*!Ubs>8e8Qlx~*r%n(A?aDSG~rRdP@Jxo@WJX8rH4d?KXT@2 zzso)v997G7HjD2RQ{=HFKU^5r2PR}y>`suCd=Sbdb}4635Ht7VLXD?kf5W(QPO3{4 zG4Zr^`RqG0&H3ET#!#O-0TG^hM`k?mT4^Wf)1!VX>V&Ctar3-e^$p7%`vs;s*&Uq4 zvSYJF+R-H&_bVkn`W9%D$`-BF?j$+OwEd8-uLzs&(d+9>r*LKe+|(_R(&LmVpw?E9 z-4nhg;ELd*vclEcQ^ZWmIr1c9)FR3@stIou$|^dZeb_}nY-QUihILvC#kTKx*mWR0 zYsaMxT-QTo*Uw_}d?U>5w4r{Ns*aKR>#Y6H}T@%2eOjp z8hn}YbE;I-sXW8OM_LuHcU(G>(BUR0F1elK1<&f-9(9g~w;x=Ufaw2|Nikilsg2r9zJ??xxc)ce%u}X=iT0m zjSQl7KD-XI^fQh6ntwgXR5oSIicdryh>Z8)$(B63QN_q+4))9v>~&(lkHcfb5S z|Gq%m=F1M3!}Xc>9=M-UWwSq`ZSi6Q+jaly6|ZE^J%0AF=P&t)5Y5%{92F`HUdumX z^gS%gJC)6F$Er!Zw7>vGlxy>Ol{A|3AENFXr6&duOLTRPnjL$Bysv z_s#21Z-~0}`+v>MhsR##Z$9}&RLpR9gkIBgJsZ23`{wFC3!k38*>(DkUEcLGYi;cR zCjK*>^F#Yc{o`9dnB$78I@1N0{#~rEulFpV^pa}Q@kgCIq^n^MJh>zNMjB^%l*gqCRL zsg})8?KVyC*!$+sS3RHlIs50cA2}p{?%Di0`@Mh4%-TQgkE{JxZ}$7w)30xm{{8IF zJ3hDJ6hp9AWaFuvi4TwFu1Nd8&nkA_dHtl$pOzjIHeQ<`BCNo0Fs*Znv61$f$+k|} zIZM9ZeqLkQz5ZGF>7zeiHU(?#Hs+CZ%{=!#VyUs^!)(!X$<8@%;w-vX$BS3|xMgx= zH}hf72~7cE1$|xm7o3+jluW4Kzu1Q1S&8NUKg;jyJr9rH7klpC&$N9O6h9WOmDx-k8R;IA2r#mg5L zojkm#_f+Uv!@KT$uZu#0bRHaD#5JKZB-2x~s!e9{=_v;i7AMK&Cj1WEIW1ZH7f*ds z)r2~^WovkoZarAUJ1r_%M#I6X`IxoN*ATr!m-34Pz5SmmiTKD~_jq}HUiXscN-uYM zY?05MKF1`*a!T6=)%BZXJi8tK+n+0vn-}|fva<3YOX*Frw`2?)9_6xB{;d4?aklz& z*=6Q=BAK$iQ}x*M9XGr6l(su)9q*aOT52OyuT#pp@cXnEaY;tfTTj<*s$XZoZ+BKy zD`3*Xh8t~J{@*f%ia%Y`uS#x~QwpmwZCTQh^E>w0PG6VvCW2a0`7f&yTJHw!5xwCo z_UX;-7ll1L6u&#jmv}F;3ff#~>3Q*jao?%J&RcFrxooDF#PF2N$oR8%C!=id>(inO zwJKxyrq=iLbqMacuuA+h)2VgrZ!YaR+i!AfQ?Aitx6@_Lll@cOwpyQA@pk2z6*Xro zZW%B6## z%CCpyF9vzOf2%3y(dmDtY1)%Au`jY$kEb{;E>h?IR_n0;>@u@I?|w7A{>`*IZp(Ys z`2H*Xcls;kYnx46bM8H<*D@?w_tjyim)0rHFYeCkgg&mflGh4f`{2vYEa^FaLyk31 z&pMdCa@(gMSH>w%4g6mH5Y@~t2>SX~>7uh`ChPL@OJ)|oODD;*hb){rd5@RwPY2zK zZ@znrE;p4gEwG$2IV__}J=bxwwtVh8-{)LhV)o44oM&dWUYM}p9-FaI?f?37CO0nk z^T-D`=A2SI*wp*?MP3M>+U8qsPgmv3PU<-&s@s1kJVDBS{T;32H?5OiX1%%fX+@Bm zwP&u3ihA!E6D@b%sZ(s6`22RR@7b-)zI=o2^Nzf|EtOupTLRD5)bBU9bu&z#GC%a& z6YJZH{{3h5*RK9^V5fF;)#@LGpTDm7TYqD^_1{Zt%)95C#P{!%_qPA`YsdBDd+n~( zPI0{|#q?;ImY3MefSTK0Ij?KFmxS`4*v>qsF@O7koA1lAj-L4Oq3!Jztqfgn>knnG zxI*{O-Nk#gZhNqHbdKu!Z^3&zmiYW<|GkoVQ=)UJ^rpYpa^5U|;(2{rmd>-Z_S>rr zZ{Jy!X>*HjXXxdFk+)Y>a-5sT?;ElC6Ch!09pK0>C|E-|mGGQiDbMSZ>vzdu8{Hmbe;V)LK+?2q;;&3Rm`a|Be zm3MF5DoTC+?8kwL3Z2rOAwNExd2)TZH2*#}smwVcr#yeU2r)Fe+3(MLaP}>~{EejR zdlq%yZPMHKet!M_+ON;{ig3GiE}NyBx4nCce$XmT(GOcAYht(-c@%wq`R#uGz2zq> z5)OHu3Z8L{Z}qGCLsN3^iG}`LxbENkx*6x@7*5)#^XJ32w5bNWV#0j`XU!I!UJ{vm zck|ufZF}y>rqzDsJw0t|^ogxGv6l<4dwT2t+St&q%QQY;GdXg3*|9BaC4^nL zc19Ftq;xL+cunZg&rk0H*4BUe?>j?5WTEFb9pNc+3>*a?tdZZ}>#NyWKf$O+q2)+g zqJr?$7RTK;`hq4kYW(e}*=x3ZTjA`&H&1hJJ~_T&|DKPzS2sJ-4 zyly1-6!2v&&Jap;>#=iX_wDdm#xZ@D`u??jzBxkkgywzI-q+{5Mab)xqxQ6hmaWoJ zv){5`u-SfHqEv(R_{)beEdb6ClP*$30_G7A! z{r!TSXZYt9&Ubx0FIVF3Y+jS7%MwDTh~mVE!=EbJDV`Q_oAoudmR%H^U!MquuxZ}S&rE-(I9!rVRUcy&#~{*Ej+H%{4zkIGZG7#@t3oyApO z*~;c8{x$DmT-}d7?lUAq3x40+9`sfHH!v#Qe$7iW74 zJMFAVx{&O&T;$8Ug&(|4(|q*`!-d3>^}RH+4oPO@>_7YKM$RHXHsxln#Z}@RMl(BE zbox@XJ{wJpSDL(0xwDIH(TfLVb@eCD$Ucr_T-mds=Wn3XsdYk=_PBX)y8QC_d_T#e zIA2~=Wbvnd!QhU1^K{pxFXy}Z6!-7-y40g_PE4EgUf)Z`NnNKWY_Sx5YAwyBY|P!T zW7gRNFG4Gf%Y9=x(sowA;p&l^pUc9jEZ=3EaoPDH$BmRjMNbo={)h5+AHIIfba3L@9c(#~RVxledWp<-OP1b0b=w;sO{pd4tr%wZh;~fQVYs02XvN!w#jmdN zJQK?MBxoEwWy#be7waI0^SjKyYs_L+S8`(zR1=YVu!Ql!fhN&CSHp98L~9$q_HW@K(Z-2R|qCVR)tkY`sdmY#pkwc4dw zA=vP0WuI1+SB{x1g73^coEL-a@Abn*H`AipS&G)OOt}GI9|9vAtU)s@05=QOE%2ws5Pm7 zC1^O|=l;o&;s=$_GhKJqXkgi=Q^F<4X22F`72qrRnWM*`ZRxCq@9#DoOyBCpa<#eE zb+MFimqW>1x6kzck)IX}z;eKqS^vox{{U z@Dt;KSxZWOzL>wiXHtJUgL|}i$Eou<@<)zruJ;W1e=g_qy9?(sdM3>%QhK2>$vNZu z72f;@dFPjT*0piY-?w>X6YuT7?F(2Qu6f?G-kC}2&h=yazlB}gkst1JM6or$vG(NB z$n9dL9rxD$_+P00y*gau%IQt3`hPC`aWvtDZ{usyAz-f(Mz%Zu)U>Q}0ta~1UtJdQ z`;yL&##`63WnF#zcJjPTxHkEV;VUi07d>ZYT+&ccOmYa+S^Td4!lSj-56V*t8Sl;g zmR;Y~6c91np8qxL*^Vnkj~M?&Z~fSC#&pNsgBv53Wm>KL`C4GYd>3<{x9cYxtH*qE zUVAhveC>r5KB>`DVz2&umK(lq?@7l+^W^)c`g$%nt`K_e+-vs@&u;BGHkn(!!hFg7 z#;g78CFkq3=3hK8Wy6D0nU<65C)8-znI@M=?_PKA??Yj+k>Hu5F9T4=ju0cGw%VDEO5MlckTAeYCd*wQJt8==XnL zg<4*g$T^$sKj*SDhvwRw5xKq}`j_3f5yiv9@j-m+iGPx!(yn?NwV$}X46t9#cdqaC z0r!sE{>{^(E8iIXP0VR1+W7hN$%*f7GPxM(dDZv&-#t)r%S!)L-P=X7F+Y|}t6WjQ z{r%W=rgyScmMw+{Vy=IY@O!X2*+=}NL&W|InaA&DGo6?f_(77XW}{D=(S|)SYVe?MAv|NYB#1?u+<&YH}LxP7r}iPt%%qgy(bZ>|*NkMb*R zwfZIb=I%TF2R<*Pu3meX{bzRj_6xIiA78g_*W~I_+gqXC7c@^66s-T+ks4|5Ds8pa z;Le)H;te@@s}JpPw<_Pjad48!kv%4#jT3~=F)T88w>m?*_{J{7dNZp8>AZIwQAu~_ zCFE45U#q;{vhv%%c!%SGfB&(Yg0=Gy9focXRnv{{Ks zTjc6(>--uR+;@N3v7$03s@SDjIP1;y&}VvcS{9ksHK&H|cK`mc`&HxAiL-fhoFAOg zzmsxe%8V(B$AZn(C-`hETl%p+rzH2p#it(Ir@mXjsI|L5o9+DykGj^TW<)(`8-rPsKyA?dA@l3DSV41(jlbdDx!E_txWy{@D!!`yzxby2mrNp$K zyVZBx+Oi>~^JZ1h_j$XDKlW-WWbW`Oz1rz4mDl-z>#??C-P0M{LtJ7X>WaF2eOUi5 zYsbDhd-|rSS;{h%B~q)AEz_g*h~&K z6KrDd)|(@!8b5(;;m=DYH*Q!|Hu4%@kD4ufL?Yf%pmTHf3pshuTYb6D`J@)UpK`sy z^vuE1BmB!Nm>xZR6dCHNc<}n;MP1*IChbsQU7hgv?A9Zbm}WAb@n7%3)v{N{^emUe zB7H^YvkYe~6z420uFp@~J~N4lUE|yl?!u6U8s&ffLVvbJ^h)F|^wFPW!8Un<#^yKc zOIo`)A4sMx;&jq`cj94|(Tn-p*VnOLcyV$yxY@~QK0WXQt0<%K^o7x^n$zu1u&~yf z3G90w{zHQ~dz${a@n(n0`Z`fwL z>YZ&H4j(M@Ei{-C8hEXG?~b*z{;c=wFVB`@^IaYPX<@TeqF9^Nc23Xt$+yhfcoWi@ zPrNZNGdZZywestEo9ya~QzPFdpIo?Tnc3Evd+VbP_n-J(*!)21m8N&(%-0{+K3#SG zf{Ct-X|v^%%RkgEYTXa0pP}s2z1x~&zG7p`67JpoPRIKclO~@mk6Z5`0$`u6xD}!GEI(6eDNh)P5$ANz^ZMce=l6SCFr(@otGTgq;^38^&y{Ik`aBWwoeFjO?-rVjDs)>Uanrzb}w#mRY-PR$ri0vh#!j zw%_i8#+?^-RJ6p}*)UrBhuG_RZZ7+~Nuk%id&~N`%rBbh#dEJsWZUPWASsyR?$U4b z=Ada%(*8dmv$R#kzlQxk9rnxa(!Q#t^>d?FezW|;oVodxpstqi&q*767zNgy;k|wT z^t$rJ-}I+W-+$*cJ4@1Y-w=t1EoTp3xb|nwt69gh^cL=$v|C!+F-(NZC`GN-L_KuP zlZ)~58fSH^>a}6L++)7H_txJGXwCy-m`O-+Sit@+nTswyQ4vGON2` zW>SMgec#SJ#nkTef4$=c9~mYkmV`RqlZa~n?q8|rSG#R(k7{V+xmAuo4CR+RI+6A$ zd{xBHQ#uK=UM@L(YFfghomp>Y#y#d(s&y$n{eNUhWwe(4XF0Q`!^gzp|Jhtko-}Kh zD*LaBtcv;!D`RVC-Ks}3UP@ffzmzGXH(w=Za@Fx*4h-ydD&^=5QkzH;@-1u5^<|o}7Y> zu#@uA2~m=v%&%ML?bH8#nE6jZj>@HR!IeA(i8Ji&{nu6^;oRib}w@YcGU+p{OJ zOz0F7FgoZXIyqax$Ww7;oW(Th>cWmmFD`QMt?x|u#^E*3@qnPJ@v{Xf#~2x^UloZQ zmc8+8roGJvO}2M+Kc2*K1sv*#o?-aa(-wZo|0-|Iys-2zj}d#*;|u(cpHJ@BoZ_$f}Sk)5c z)qL-Ru20+q^VzE`XZ}6G&X={dZ2j~4b5j=EneIIPCgv&6QIDlIm4fr+|LUB1Qs{H( zR^7$(3pYzHkMGb>%Ab2>8-K`I!K2y5^53UL-p;<&$&**X&DouF_Gf*8IeYmjpCi#1 zD?2p)ewXgLBU-yt^}WiG{LH9}%eM#}xA>lQlrca&`tzoE-+5PNg=;Mek5FgM&-`{a zVO4$neI1!eKJ9y){x)n_=~U`pU{LTn=Fi1FwWY7ydpT3yKF{vRfumzvpE>#IXoJvqH@YHs3B$!o%!wyavd zui(RiQz9$wbg#Rvy?oj0Q)}N<9cHvpczh&A?XdA}{pK$*_a>ZqvQ6@pQuh9y=?ziW zJNSM|Jq?&{8GOuSgN>o=C-X&?UHfEbA78%4zK3Tu*OlOPxwk9p4qu&dAe!r=^Bf+& znN3=1o@cz8ShY_!)eG6$yUWl0m(e0WYk_>^{99@FyVhOKpYUB|3B#{5YnsL{^DBT_Ap8 z+pd2fG1DmDP(v{;xc6HBevj?gtOWx7|+ux^~oOr$T(|pS+!+-~`geP;>iNu+Ge)R8apg=j?V{{QlZ=V0wjH znoIBzF3ZWRjzOz$78QT{lx`D!@U(uKM4?*x`nMO(u5oBG+7W$zpY?C|vbT-X)H<~7 zpHI(A4N}ow+;jNSj7so^W19zW?b0MX?#xS690={wO%VH+FwY){>baR~PJG zG^5w8ahYeG)4?l$)lw|?Ke)DH5hv@(3B^41MlMZ1US9e1HOEkj?e+2J+=ssWv9~ni zaGr5T(_-RdXSwH(?IoiOB$rC66)APjjV3T-c{_Kx&Zzj5@zu)^pW1Fef zQ5O4F&Z0?u6{{9=_7~;Z70gl$Z}53xka6p{yz_KF#`iamSDrgQ`NheeH~y!&C*-&G zK3n`kvbg?ahf~Bw3&TB|`%g@EYOp!#enZfkl{0|jr;OnV_s*wBex8ru2D@H2(;@AsN;o@-TC+Y66L2R%vbq5D|)iM zV`|kBjvpC}Hzj_**)BhiQ_uK(OZB$X3hJtYtua~;nYb+KC(T^BbuCMY%4yys212a8 z6P>bR75t-IiuN9!oU+8*XyUxTEBH5Q^e8M^>YDh7gDbc};HytjfU?7N<$GciE(;1g z%QXDJxK8CxGobEYxYl+SR;{Gu&~@EqESj;VDgub3e#*jlTPkFyuKzN zM(OzDOLGOf=T6&q^KrfN8u!liDu<7x{7QSznlv{-+<96JL$#%Fb&2dzp9}8i8z&pg zxXZioi>5&L9Hx!$GFO#5==`h@cwi+vD9qFCe;mpY(8E~e_qvd1$it`R021*Ai zdX(1kZe;T8e-wW|BzJ1E=&=A_xsa7h4g^kK5%g0$9t0AIzF^lP5q{@Ya(Y zC&ui|&&nwBWmQ^)=K#-}QZ(7dKbfaQ(F1%S`vbtht%9{ln)u zXI{VET79KI_TBAmx8B|9zrAdAdFkf*uU}?$=v|0p?p(Hd*WBN=SEtQ>b$Cse3G<66 zn-weUt^^j&>hn-Cnkleorq$1m2g^;)s+-uR`7*}NDg2Yjqj0!MwQl~a8535lk$ru$ zlD8#NwKuzQi>ts_kMCWqcdd`EUQkhSG4w;$Q}(sZVNY{Gsu%oeK9p^umCwkMxXk}ckmSq0CA(hRzHa6`deNnD<>`UhVWePiO9;&NZV`!i=X<9v&wacr*lPuIs?TCq;lGW0HM{fi!9v0r=_ zTeE93jFmKk)y$M9c^F;#CE&@nHF|ZEPVa`GjiHsl6Pu!bZ@e!3e}TEw=fiw1KiBG* zKFc@0xFleSem?u+Zcfn&OFcGaPQH*Bu;59yH#!V2VHC(TD#b~ zCi*mp+~Cfhu(|ry)$7p{OqDDCneybuU!Pka{Qi!qPfDJ2J+I03Ym?TUKe}g*Qf?UA zid_j>O$_4KnpAGwT>tyhiw(y1ANTCZ;pucZ-lMTQZ~w}9bM#r1#im>rn|!{X~ybz%Wkd@_d7T}?&9xtpZup8{JvTz z8&hvFIbnlg@a=6SCj~P_xV*%so)%fj$Q@r^7Q1tkmDKkmk)Lv_{l4tkxo!HY&)1^Y zNvoIa_^S7C=F!igsVrM~Ypz7w=UvZvwRCrV*tXrPR(t=?x@q!u)xBxE6W(rry6HU2 z#M^pH*e3?87CU16kLiSgZ`%Q-q;G~nJx^}Rpa~!Y4}Q z_McR|V0qqRQw>Mx(FJ?A*Kc?lzi#$Z{l3Pcy=CUilMGgN3ftXpdflj+UO2NYU`=1x z{-cRe&po5$H~k7+uyn?KwI8axGg~E0J@&~zT_j&%vMKZP=5J!pb8k6joj89?MOj>4 z(#o4>E^pgDhRSpM>vL}X%iOx=Y|ZIQyZ^Tbb42k<)z3bDtm=hyO_IXwS^Lj)T`1u@ ze8BAX+3PmkT#jHz|Ly!DRc#-;1;&7nD$!FFaPjVhS;nd*_bj11rnsmJg;+X2*YeeQb-xjKmloE*bG(HhfZc2izSWzc1b1 zE&k)Qr9{csXIpnVxSe$qkuAOLGx1VrsKffXx}X2pg;m=Yo8PaiGpo*YFL22z-(|n1 z{`LI$o6kBFH%8qox*77OEOlL;LFk3aKMuDpDN__koS?8U-DPD*+s+T198NQs6Sf^) z-llg%z;v>#G4I4R@@2-Uo_o*P<cpmQcbxyA8`DVp*;%S>a*ezxi(H{~RHr#4)JI+w>cen4$nyca4w{uPnUv@F^NS#E3&EB)Q zo7Zl$o?woYlhCR<`%f_@o4G!j~=WM_FiR?4%Wh;LCsHO7JV!=DN>L&lavH!N| z_OrWoerw&5n{{*9-1n=3Hy^lR6KllJ_{R6n!ri&C;alTc`NA`v{$g9e+41#~^L#s% z8<#Xoe!tRt`;ApfPfaDz;GjRdqKj*#eys|Vco6~e#y8YJgMa9{_Tb?ajZT@waUiA0VxoWa0#=>zoYnR0v@Tw}e zJn?AT#^`(`gqh7J=+(lTTV94m-WTuay7zs4ZM|QHp?lwkn+7Q@=kJ^RzGhqa$-MkQ zvFw!8xzdT|b`LcVzT1@>Ru(?VFlk>|^R%V$A8uW%FHU?pZw_bX^OSehi$7?nFqP{U zBwTk3v0fQ}h2Q?)lcb#m|MR=c`(~8|zq|8n%4*x$zGk}O9V7vfC&3Rlfap^6ZR)U&r&meA}Y9VY~0+Rez?Ql$o`2vD&+u z8S=nx)LxAnKb?CATs{Q8R1+gGjADNb-udy~HXoJI4FW&gqt zX2>jkY{P$0Y@c%4XBI)3e?OKi?ziLEZSh;*F2`dFxT`ol-~+1&v!SK=bir;$&HA$u zp8dDYMD{%omw4gYe2gbtm$6I9TX@S0MUG|D)oe3VZiy**2M7Ai`t!>!Zd3_5*X;NY)I`RVsD{VlU1FU9x!-oLs2-|R_?g-n4ZcuCXi z2_hS(R4@GP*K*#KZw>W{>y1KEZg3R1SVphq^oq<{`YlXL)L668NO6zU2H|;q z#Zx>5HD^q(SKRnH&Er5}di33^-`3u-DE`{~*U04d-4)*>)=FNqF5bcH+$0`WtnT<= zl|7H|_Eu3QX>(8OH|F0mzaD<@!e75*%R9{}VcF6a*<@@B# z@BaVndH+&(-|~Vs{ELQKiW%K;c$LuR%E(%WS!sdp;Yb2j>9A4&FVe@i#;6HP_ zo~Lr>1+1+SRhC6a{Ef)WL$-6S zBngM|_A(xR!FtJufA2GIS@9m<2Nxm)uEu*U<*Q!#=JboFF@Ih>6tVwxRCS-6S)OkP zUs~b*3uUXAB6k!nH!&Cfw}R~ii~pa^uidRRqI1ubA6xYP?h^}{C9Ef*w3<{e--UX;x3F>&@G5th|$>c?hsa~N-U$a*+Ar{Gy~vhJrt z7KcvmdU{W=>dk&hcZrP^Z#!0AHS%MThnV>BEb^#N5u=z4y(rj9TB|$Md9LYl~jv zv3IHsy}zb@pPl@#!=(}qPcP0c*W6)#-RZ&qOsk`(lR5b=KaB5KqILV#g=toGNwc3$ zs66gaE$!)>8i&m*6h1&xa$W~ zO5rKHcU6Dxe66V1YnpzfF>0dP)x-w5q6?iF_iQs6+siLGDAxDzcs4$tI@|E%?m1Vq zctwId7Su?74z=ewV6|ZK+zka2q&cO-i`pu@jJZ#+ozMBu6ZqiB1~J}Cmwfl#Hof|e zrBP|eV*Zu$OZPX(iyWVJMoHI!XW6+u99-?9=bZjI1-fm%y>i>c*$R&r?oGeDV&j~d z51O8M?k`W@!tZ~i;KJHN+4YxY^Y4X}{aGU8wsO`b-_Tn7hJ&XAtC*)&{A2|4g& zL_CYr)pCuM=Hlxq6BFH6y5a!ui+J{)hdSD`9bc6|~B6{++!xb}zrzUvCfe z%SoR%Lx9(P-B-m)52vj&3Rz-)VEWs<>+UO;1uxcleX?`o+OLwAk6wG|TAFbusLnG? zfv52E%BSCJykD{GFZI^im+vmMgQLh;{bptf%RF{AtDPtQ6h6IeFLCAUv!<>i3~z2& z?0y=&n0@gv&tFUBpImrdFT{EI0k`SF8gbA1&HM9~x_Kp(succL?>fSGXtvM~kMPw2 z&#zYhZfQGwnRNrRv-h^NmHE?{Hu3h_y^sFOEONN7)8kH!%>?7V4-?e4xJc`YoP)Vz1U;l;fKve`Hht>!oM^&)zqw>Dj48)4C+n&IYl?WK8__{6Y79 z)_r!Yd-MEwyXS2F{Zi}F)!^M%YkTgU-#hWK%EcBF9=BalcP-9*)Xs65b>-s!vql;= zj)}9Y);DWyFG@7p){!>nqQt1V@f2y~e^Qg)zc=-+8JBI&*^3?rxzE+%5d8_$nU0=m(#hv-{ zubeG;=cHrP!#uXJLZRKe9Du>3~+NySxqyhRGD^o}G6&FG(N z`)K3s8^norZKuRN%@`MOTEp~|YXJCSSNlM8!pa{k||I`gMK!z}+J8~!IR z;kfpvtnz)mV*Yx;>5dX?!psH+#^CjiOvWbQ5#Q+_`dL}(Z<`72JHI~QYTS}2?qib` z_D;QZtMrkL)=IC`^zTW}4=mK^OzpMs4(dC;-|j90hmgpMnVxEz@+rNe1HoaQ7ec6;dxp_I^;qA^s?Fpj07d)$v-X47K>h{pY z+pe+ZvtP|9kL#`rpY!xeqW+udyC*KTp1?6x^VRL$!TKw>dxS1#eP1bGS^rZl@bPK^ z%|y-ipK155`EllFpEZ3L714RhZwuG)Cxwf4?$huW@@SQHwpx}aydPeIwRv5^eE52yRt#{!O`bu zU;p~Xc3)IOPIxY>cih@*O&6bo<=u|!)nAfgKBxXa`!@alYR=rnYBlvY!;i|% zPKvC5;(oh4_*VYu$VmV)yG1V~dIx58w04@9i3D&M-a^=DRTOVEwMWE!jfVsU7ZzGK>E8Jw5#1 zV$an8gAQ*OqpE!?j>c|Idb#P|O#ho!rJtQ^@35}FcB#ei+MU?Y;~(BOGr4*$(hrNa zVd4K49dqu;ovF?zmi!8wa8>2;C%)WBFf`P>v$_7(-oyUl z86sJ4op-RLpFc3~(zz=6+uDjor^OaWRtDb+?k(iD=gphBWk>6M<~;H2i3O8XjK1u# zzv4E@Cm|~`L}LxZi6h3Vr8r8U5u z!;4uq*}LWa`lE7u#@lm#pNe_-A2{v&e!e4ZrQr#)R3B3ggQ^0-;$5kYd7(MsGo~#~ zzRM%c_<|=-iTBQ&CfPl+SETVN)&Ft4c1*I_#zFt_O(Q9f1K(3P>tFbC{$3XHVVRS+ z`hlFUNhYsfdi36VUlQJM$$-0Q>a<{mUdHo^9?P6}6*0c9n}1&7wf}ZktMu;f^+(@- zPTxE2x!v8P-=BTosr&iyQ+0L5tF!EXJaKt*a;Ac!;?w0tlWr=VZ~kGuedPjyxwRW= z>gDaZo^IW%|w_YFhy3KmB z@0BvPXOVg9|Ic5wEN8j;%nN>wOFoz|Rq`&|wNaRHv*(QYk@ppK*>XC4cJQ2;HQDLK zyp|aGj9#NFOX8cj+}$=Zv-4+g&V2DSyz=2LL;KD3x;&qE9GOzKA$iv|KJl*`Pp^Jl zA-yl>^f|LLYlDspUd!d2nQ~8Y;sHk$fggW2JmRvra?*24_Kyu83tFFxHvh9TTxd4c z^6-*}a&M;g8+Ql_eMpaQJp3*9p6Ks??&Xm^@@~OLg(rGG`&oOnY+=v$j(MN%HLbYm za=Apov4n#?LOG}Y^gg+QjO>`A)*B1D)3$Huoxg8i)E-k~mBc$|USuy=S0BAwM(ci# z&rDT&i?cjCqI9(Oafz>MytGisA-yx{+?)3n;Rj8+i`j9l)I%= z=L*imnKN9jXik2fV|Yu`o?Tk%MC!q7KFV|c8E5J8?R@({epQB_PJ~;)X@-gGA6}d$ zzdPLUKZ~FHikV5rkJz$m-k&hP!?R8)U5j7XSMqVfF`bHg|Fyb4tvj91cg{=RN02?n z^|#itKsLcbj|;DUF&xy{HGQtcjru32i)PQ~yPGn9MW>1Sq+iX)z3Z~gGdH}U$9KzVB=}a*}wMP%cmRHl>MIl zt7U4a`m$}xaWY*I8&fros#f`3eo#`&8Mw<=#4YePV;&n%mUqGTyrAoIysX!nJUq3e zz9ntR`ll!3#IJ@2?#bDyGi%qjx{~I9_N^8Bwia8jZ~vOL&`-@w@@A=tP4n*4Gi-L> zN%2b1l>hzAcc*DPGs{B$TEk$sM^5#6a-10vkG3&yKl?-DuGe8Ly%}cZcfZ*!IPA=8 z#lGSoLlcW*^O>e)-~7%vX-D#uPudl07qu)25;#qImZ4>TV-8&t8`9jLqfcJs~K|9_vk`kDRafmEvt3oGXxW1GQrNnI|1 zIm9Vz+MlCr|LQHw9?ZRLe1XySU-HchjEX;6_!9b;Gyhop`ne@f;^kzH`W?sn&z@S# zY1ej+gKQFdLmF3uu-oI=u4b3rsD}|dj zaEY;*O%*tL^|57xKJ(X9tsFD?=l$k?9B*GgvdBk8Ir5agd-$}6AAh6^#kyZQHeJ9; zPg&%`ez93gZY}h?kZ>~mdiZ`O&$Daxf?HG)28PC%6Y7R02Gb9Uv1-=ejf~E}Z6;E8 ze!aj3amg8yaW1h;Zx(uAPdXeR(i+Z_{e3~i79E#qHWTx1{rM#uw`2z2+=^&}CAFO= z9v?1#Ufwt5^U>YgRaQNf?0d!GzJB@h{_f46!)-c2!zLbEB3xY?Gmb6d5$8~MShB&H3H&4lb`c6Esv6?$7!A_U!rnw}a&km#uwq zs<)usW^ZwImY>8U&&2clM2aj;qOX354G5ei9X)s1QK>V@oPFDuM!gp8l+M(gdf}9H z;LW#J#eZ*(>R+~@c4Ldslx2$}bl-+v?wY{JdE<=s8~0s(xT8j1D7!1`(Vh)qA-y3>PxH6^Im6+S_}FFx zfAqJupX=^?y~f7wyoJxU>se&i0*?ct7yM_0{?vZ4X^z=Bi+$I`<7#$Z?5|sqqS0>Y zW-(vyvHO{gBK7C)Y?`{)u4q{xqr0>0&7-@or(a}0JW;`k_jrd--@aGu>WfxM^)d(C zyk^wQC3Iy1_x}erOOH*kT-qW0?##j|)j8WDIJGR6vu*x1F-85T{HOJE*YP~gIK>~J zep0OE^R%M2V>=Z@D z7keIOS*>)5^!4OfdChDY`>I;^#%6yR-w$jPcy6&Q{C9QN8*5d&)!hOb5`Vn>cd`{9 z&vNzE7@YN?G_e+XvGlr8ZpRHqL*!C1Jh$OmUgR z0jK}Y=YLv1JJWZ)*2b(eYnGWy8QJPqWnA_*-g0y4yi+{qec!8?WC!wAnHX&=E7fjV z^;hQSL$3v9T%QVd#CX`wyd05VvbcD!`>V}dFXz9hVfy=hQLiEAFP;gzRR3>s_`+h+ zSiSPsS?SM0O3ld&)BOCzkN5Y+Ozzpmcb{3RXri67_~zxM6YFiA#k-f68dkRHO-fk$ z>$3CPHtR!oelK|*>CwtR%fFN7a(SO^#)5cJla%{*CL;IkOy<<(GxRa5y>s>*dwDnOLi{7SIlS+agKDK)mfT*S<#hZ1oM-!^ zKb@&LGRL^@(xJc7je_sbaQb&|-p`nJh$#VFSW6lhT4E`zO)X5PPh7~TQGYkWyZE*l zXdU(o4PWIp2F{=o{<$WZR&Nz2XWG^-WAA8D@zHEhb+rEXJvPD7E9JqFvf6?wK}MYo z{BPd1$L`(n=cR1qo89RjllFIr-|xSluRnip#opD*gn{51X zUTu>x_ht1AMNT#?zU5|7)tfXd}`QnTP z@%17mPx_@ozSPe&^Ouu+H_x0=dE({cZFZgwC*+wG5;*;9`i?AHF-ec3lk3$Herf=E2*poN0@q)@pW7uV3%6N5uU4x5c+t9lm+{HeacE{<*lzK#1*wRuXV_}Z~64j zMKSgbts9>9+V4H=YV7eKI`?Gwx8t8RN^4V7i_SmrDK(#d>T{O%!|f8i@q0~c6pCZA zN@^E>2~^TKe^Iz1f9a!ZOHN!meks?{tU%o)N#*d|_nN7bWhMO7w~Gp%ovaullheLv zj+>-p^E-i0tS$AaR_`iaKe%so;jT>0S;sQt>21p8!cTwBVE81G@mzCO+C{aQte>>k z_WVfDbK14Ea>{{I6PgyM+h0plJ1IYhqbhRRBEy>KYVP$pGM{&e#|D&5JaCnFk@e+U z9Xy?fYK1-5AMN|Tb!I20*U8K&#}-SU^)=r8Z}QB%U!rv(^&)F^3hR|tFNmA>*=OUr zoTaB%Y%o(l@UA*qsEn&sqG6yPi&olak6@(VC8%{EKmMqTnu%!25 z*4&FcKGGULQpG&WYX8cpN%N~stJhk?EB|BT%2xGQ`IbY%Gftn=+5MG6ZhG(4i^A># z8?R`eoOs}Uz>S5IUA`_0U-~ulMCfdpPxUqX(-Jo689g{=vuH!Rf>-#bTTi`KJY#tG zMQ+8XOA>`SH5}G&woE+xdei!yg4-YSv~53>e|X`QwXT1CJ(Rf~pM7b`f0+MH_?E;H zp?ZUOmR~tr*Rh88Guxkh`$4#GOJ?AwJJm-Y3&#g)A6~Y~rhEF#NwZbFIQGhmr3&<= zguG>+Fg>N@CTBAGYIiA7mEi^;7l zkwMvd-?VK{JdHFM+BCku+W9_m%I?%7b9?-hPlT80q+3;rCE&hqJLtXnzw zq65D!J@7Fy_OcwydWM&mn)K>zISiJ3bq}y4Ky z%>=3+cjdPf{ytJa}{pL2g)j}(N)%E*M zy8FV@tt2fb=hwE2b6+e9xXj+au=?$Fo;ZdVwl%NalkWfCyIJW#Tr6+uv%6MSRrfAh zu3avBcgn=s+YjBc@vE@CwqxDRZ}nFhzrT;vJ-S8j!M$6Zn}p)NiY;8TuOeV^={J%2 z(_PE?uW`G$F20?|;jnt`Y5Dhs#kwt0?^b@dE2)nxi9gR}RWLdGnf$uS>mFY}ZF@79 z=`O2XL-V@UeD?>pv(BhnH;eO!go*}P)JauLVo^~#s<5qvUoV>b{l3t#dFdq?3PuLz;BnUavr)JEq|JqDuZMpq z{N8%@(b5x4Y-}|*PqLlRW7{S_Nun|!&8lsK@X3iL-1-mt?+4rF^s4k<+2nRgrNgmn zjhess>!L2(N8N>PP6i@ew=y)uoeib^Zx(PJTi)|AWlzRyAC3&+*)97j40p~xzsy6D z^O}M~|ke?Am{d!Q+F`q==sW zHHVUHs^83=^YQLu&S2LY0ZI#acy0tftn%sP?Aws&^+Kgz^DW0RiS% zSMn@wKI+oCcfsU~ossSeb7U7k_SHC`6c9LJk-?(QC8rYel_n%UO-Q;@p6*kxT3i0- zu+c8-*%2Z(ahhHGti>mDWC@E+-lI2TuBYLPcPT+yw?3++_D?M~Sed|k(n7`ED)a)Q z)uCl?tj;9OXzFul+rY*wQ7x*+Co6g_u-5U~a;F6o6Qubfmrr_lW39}^z+90q%eM(C zk2{tmTwWBw{Y|L9FX5@*=Li$)858Cu)t71Zvv{5N>s_HT+1i!U%JHm6(@DX0{Tb)( z&UR9kj7Supk#tRP&E&aU?j={&%sJfk=o5!+de`SQ$rnXxlfO*TymwH6aYKcSXq$xX zOSz*F0Z$pyIjes0En;O~VcX*>qrUQ`NZ&5zM0SRYhHn~Tx3?}M{vO~3py$1>~Q-M_ou)crS@ z`7iy-o>^z}Z~bIv&oA9?@;_%^eq8;6cgI&$-j35h+pdsvbmjEU(8YcCBDb0*B}mU|6Ti6XddU67A&3nYj@?xr23Zsq9>(4J2vV4zh+|p?~Cy{ z@4t7%A})M+_wC#CxkVqil)6952z{QkCPi-A>3h>G_Q$iXH zIxc1V=lUkMT@t#LDcYaRip8Jn9y+zyZU2tnrH$?H&(8a^>#jX-k9xZBJ@LlVn=YSG z-RAJPV~v?rmB^W|Z@%q+{B!!x_uaGgA3uHb{V3>U z%}4EpEpE1mO!IP7=)b>Y-szLM)lQ;Ur(9Bg9em0z<@v?H_s<1S`m}`C$rWa_e*XNU zvWIV)leT@oL9xL8=bt`{&Uy9x_k%gt&nu^{j@kbGbH@{zpo%p2_=T(b_VHh>w6$&c zqY(eCzE3VT%=9m-%wDF~e{1A7eEwzGomyA$*~yIcUzmRQtQkKH#C9vPUt{SrS2^q< zBj}Rvp_k|%@F#I+$C1N@5q(`(Z>4(h&CA%zCOheK#QEtDYxg#n^Xs>FofqQT`FQ3J ztJQIfPe;qtHiza}i<+s|_!BRg|}5W$T{UUau{R)o%};^ubPk(YftC2W~w-+|wXkT(_=fM^o_U zhjtdv&$c@xa;9&7w3lPE=11e_hecP-`|-}P^j^)0H#)C-qkKE&G?&)1KDy2PTKJJ% zLi(i%hl{Gb#k-a^wA8;4{Qb30uW|Q=H^CPlT~7H`^y}lczefLTESFZRHtPLg6gs0( zd5_z3@|UW4Y0~Edq^IP3H7X93RQBBWK z4r*3@C2N-HxNYQJT2=I#&gGSl{Qx~-n_Ac);fxQ4~>Y``Uj z8R4HletDK>vwvpA^G{_fCtOZkdZ^a{b5?N6utX?gfvVX30g9yvol^IyVuKjeq-@7C_?-Iert^?|C` zjo(5a+}O3Krgmj~-@YsQA7!S$c~$QE$+@XiGS_aIjz0Uer>~2S94xx9zT<>KzvRER zf-_VM;8TN|Y)}Av}r(y2|p3{o?t;hEiNBafmR&;HBw<3Cb_TAFOZO5NPS-sO; zY_9cu`RsKyu|lUWs%~s4o{{&3Gv({SqQik<+U#i@p3!E_JP#jjm=l+`JaOZ?J?GN- zTV@O9r7P6@V)rf5%ZU#7F8WVExM@Mo&4BOU8J>642kO^*4dXIMZqN9BV}H`_ zqUzxUtk8Kjc@l>MFN9XoI^z+&p(1+$#~U(Ji%&|N8^I`ejv#%YJpTJL;! z-}Bw?PJIgzTc0>%^Mb&w>(*`gQgZE?@k8^Q{WmV)up5Y4-{M6{#w6p&2cY9W~tTBwy4hbIJQva zra7m3liY)|d4JE^^)=rU`X6-5{QI62exXy>y;&KxyI(FjnD0y2i&J?&_w+w<5O=<< zc=tk=g70CA_)Z322bTp?ggFI56e`-b6mFCFy>RXK_LkEN^h1_fS>F$v|J{b~&W^C~ zD#zYO#X(|ye!mtu);pe6=8ZnRS*EH=vij~@OKv`6+Xs7&W!LO1+4cTm#>0OKpH+So zE;zbeD9>Bm`%sL^>FTY#Q4v$fP&CG^ZKAj=GJB(?#y?x3;Q1=MEpD@z`KQ;QLDyHG&VME8_~ z#~JrupO#oN|4BL(tI%@P)1{*0v-AUZZWqC(cNIIg$hPRVe2!pq=b60tX;9f*HfFQ7 zj&J!U4D!({Zr3yY<+yTyAw%qw<<#`rS9{*-?bYX0RNL9jG$U`RZQu;oxcI+IbMBe+ z+r8TJ=8Su+#(}bauT*pQZ>d@=%ULWX6IZUDE6iDJ*RiPP&6aoJ9yJ{bo*k+&bDV>? z&c`zzd;MU?k&`T+PHQUIcb~Yo=U(H*SMMZU+``1=mAvnGYORZ@mwCIb>AumlT$xGS z4oVa2WzQ(uawhjg|7SJ0|LIV`F=O>VU73$!Cy8hNm2Ug#y@)5h;mph*=UZp~Ki(kZ zocnU}_3aUJR8I<(@yi(8x%DYSNbg4C8~J%D|2?hDvuDgJvXTnE$#$FTv9p?{$>n3_ zXMfw5UXMzfn1W!9FIR5gW%usWWntWS?){Iu z#t{aQmdhtQC2l{cd+KnG(WCU6NA)*-w%#$(r)g{H^6e2$eDe+WCG9l2YVfcokZZ@3 zhTjUZNj+l0Ne63_4yJdq?whQ1JtS;LyJbW0$EHc<>Zd=*g|9G5u{ra(Vr5uxc>Roo zu0RX1h;W-8(X)~%M?EX7`e$}?iGLAl^$NinldiA=z*_(dctl9tcqLGh!v$nMNt$V_oxZa*C533fK>pLxI z!G!e%EuSWA+*EjdiHVxqLEl}=FSTZdPu2{tzwmN$ws8XE44u{UFE#6Z`DBzKiO42GF;;bdYAcWMZ0=#mA!$)ix88D1?)Y%RR@AECb!8N%qrI^unAo- zZIhu{#mdvm)*PS3#;~XVmf(!r2NSOqMoblH>0%cQlsP`xD(&29q>TboqSW{cCWCGQh(y->>IUmR||VW%h!M1+`3(n^{DxM zt$m#=TNlnasc}0>_hS##x-m~ooR%RLG8=R=yCx&sV;#-#1ta?-+7wfkRnENJ zGp`K76aKi0&-TE+paPkrlab~6;)#B3fYl`YASuwptVcftD2@>uH~_LT`&uW+TsU2O4uRglAy;cjAaMn{^kR zp0y_A-xgF@bfqgR?awyLbK+3~#kwDMiv3u-Zs+x_GhXgmzVwovpt0NRDvrw`#x1hN zsr6isdC#TCCP&FGm1e*D;rq*E&Gh4K2bYLH(Or4Gm3#B#gB~{{SF61AS3BCZ91D1Uce@p{!J5%YB>+x-F$(viIuMMEhiC?Ngq7&OWpXZUXX;)AB*9Udj?E7gPy8Y(ot8bUTO%f8C z6S>;O;9>5edG*uwo?j~-_AJdoaaJSCr_{xXUTNuJr)#3GmLFTT-{6_&d)|Gz4r}&b z+bXv!)y((b&bfc>r0?ej-7mc^y1#e-P6x*mm!H&@Z~rgUDbA#{WWS+`^!psvhyOdi zg|j}HRn>g-*ZeiJ-THLd|4h9nvSP|!cd7f2ug_-P&z|_}aQ~)vmD$@QtQih3+_g^Y z_@;dhc4=pd?@m2?NF>^)U=~l$g#hu>_Sfs`|G$d&PMu{4o&sSuFg69R0Ax0`w1l)S z_e$REdu;ZpcHg1?yo5C!Q&uc)v^gW0vq750k-7TJlg4Q`@|3J>Cf&I_cl~`WG0o1r zvg$JPo8q$V@8QaOHMi=X#l-xr`uw;i?Q^F3ql({-VddfV)_RX}ubO`kkI8wOFhAA3dtbJk ztcSU$ZN7F?N$qxN?VD%Ve}Ci9->vyczsKDAobtgVr$zQ&ja|N*`GM94paO8;QVn$wx~Y4(dOX>9j{GC829o$6bzjBl<$#We{j7-inNnj z#gR*rA!Vf;vh~`Fl;)kxx~lT}xZk#2QqCHinT{Nh`4Vn>x3!?jAlR_DQ0gkb!d!)Y zCf%Eg+Ct{uF<-^TX*6l6+{^t|yv!@kW=OZ({W`h!{yTx!Y10h^H!iyKCPIjF^|9o| zQ5H+Gg8t>&&zXJML%Q11YQeo(7b>E9&fhvC5y{qN%4{8>?)gr-{(}GCCF|CgdCtt+ zfA1yR+Ko?czx3-Zvy4&w8P-;w@OkX0qW+r3n zmWLVbOBc%ivt4bTF2laQahU}pL)FC>VgBFdO?<-fEnH2q(@?i_cA#Rwsg4yUZf+Ti zt+!U2UP!C=uKs*BbI&rfL#sd6zdb7|*e5U zU<WlI^0_MWKU6k@Xwb zhFowpusA6ExaFt*f~P7cw{2QydW+BQshjDJ?2zW}gPZm4tn_~+dE@2BjPMh-O%v)( z)OY8ahF%tCvsj*5oUy>U`|d*K#cMm64lB>?+!^>vGFNeGK#9NOhg%sT3&b^dNB-R8 zBOb~1<-;kt3O$a^YkDR{>}a?=UoGJcTVRbzeLM3f{p1s&r#qE7W%U;}Op@Avb!yDs z9jZ+!6IdQhU4C+@OMn}X%tfZRTV(=Qyl|ak|L~?&e$Xb3=S$!3EpkwOW+`wud3D6y zggHxd#iQ2W_%^XjWA&p`Ej}?5R?e8a?4{uG@Wl-(=ffU8wVJ{0@W?gH!Y`{J<7TTW zFW(f^pWP?x_1iV(&w2bSTtIS)gle^5q?qVQ;Y0sEo=?#7bzJo5_QsR%F0fQSsXX#| zy6_*pvn`CDzC^sX4&`6)?K#Wz*cDPihL`QPB+IJwxw2~OJ@R~BvzC9=?(nNu_zxyE zHd~5Kf8B2~|8@W2#|p7A6*q0d0%y1`6}Z#UcU#xo&x~lM0 zAVTK%vyHE#-zFJFe2FW+l=>_*EF$OcQjgr?17}62bru+OZdWU`@i`T9(tEbkLsr%6 zN8%Xs`~F&FJ)XNGT3gt1>*7?_9eT+fGcH|Em0bEUCzGFrS+pyCQ>B@9v8d7BGt=B` z9&Ucxa$!l}#B~=pEckXUquwA{T~qb%;)hoaO4MT3U(ix4&|mjImF?tWqyF$^JCl!j z@l4?hoZ+!ucte(^{W7D$3TZ@c8S&5Gcu_ zzTP=1eZty`N7oOYUuE}G?5euB>Vyg*hIKc-RX3ge%zNeOg}0KIiWaP35bqSK&$IkF zXNl5+6DD5V3_6R}2+UKe?QUS!aem+LIA7(ig3*dOXIZrfQ$~*!*r)+3tJT{l# z;ZN(I=z77>RP5;IX`Y(N|HF2 zlbusNzutJC&!@XB3+}XWUk+RH)9TRdT4CP8#)}tnW}L~E;$?7u zo6W5#d%%XPX&Ya4&z$^z=l<$y2>g>{ zZ)5JBu_T~({V&BuoyEy3g!ih2&Xzj4SI=p-~DdJ9OgN zn)Cy?tva{LJkK0_FFLDak0hUT)Ssrw+jXzx{nI(;V);Dw(ARFsr6D(7e7E3Q(%H8` zOy`2c@}G6DCniZRcw4W*Zom<6;D^wY2?&OMBSNA>Wek|$! z<;AgeVJq(KF>?^pHYhwVx}R_9URnJGc>?LJ=Xc8~Jw03^tE2x}L-6LM?D~l1-%s-1 zP2sN+-@8()bj}KQH=ggu9$$FeTt55cyF2cyytWt5es3qJ0xe5c-Djo`h-qqlCp%0A#?Jx0v(fb!1oV2Yy zd|Ffgt-eJ$clkHEt#9}GR2I~HbXCSahWgWvuP!<^7Pm^Joo-OS@$(fw|8a%Oaq6!R zaf&?)h}Yge&%JEZy1P9$Du3j>7YI9Vr}4(8aZ3D;H6L>S*UF(Y~ zt-U%w7nDc<8HC`#(BQe z3ZA&dN4VV*oVG~a`ldyGrjbYb=@R#Q+P}Ue?fdh5;OoB!Sg%~#VRp1;r9t1Zx6f_q6_9o2nkF^J`p6ugU(hJGZ#zr;)H$e(l@mmKG1< zwdD(Y<7ystM+-uTPyRQDL zzjV#{^47Ayr@!eRQ0`vR;T`DpL~&7X)4VH39+j5cNX^(A_VU%?sAbxl?_~r!NppnW z4=Hy~o*1&m@2Ya|-H&tT{*2_fI!ku4eC9mc*}HDqo4sv(AzGU?O<;KiXJymV_3yV| zEz}L~cMf(wJdvmC+s8Z7*@=;R?y0zLyLE5&%NK0*S6%-u>ASo{R|^DN`N`9Fcp z{-1AZd+^c6_T3>19y}=LJk#W0e;E7b z%KaajjiS5$6;#*1+g;zZ{O#L|ny0FR)|_p2;o|i%+RuMNu5Cg`B@6DvX7TX9 znQ7a`zEXS;COM>~0H_If+lciZDsriVmYZLJSqnY7{ei)l;u zct2M0{L^#&?#mjribd1=yDw{)H$56$-A|PRb z#P6b$EvhU}Gg7R-L?lkzwy5%8yp@zJD4&Ri18b zN_d-bX1e3DU5i+rtc>3He$||!ywbzR`MfT$IsJEO@$?OO61~Lg{<#}FZPGiLb=UuE z&pCT3=j*Wr29a#4zi&Kz#r|g5lmZX+%*IW|&R1n(HQVRa=Cr?3_AQ*0@^Z#c5AL(| z56geQE0US@d7|Y!2flI+)|j^6$MmkgEPqjT{M$#y*|Fy}u62U-f-zfHFxMU$<~TT>$Ov@&aGEJ>;IaCzoWXL zGu7=T`&yavnX$40Z#(AH^gb4EPu%eIfSg~7iTjoIYUbkV^F86d+Om2JZH>;j{Mk^K zx8m{E*wfkdhH8ZgDcjf`ygH99YY%dlVh!WCWIcT~U=JNUm}b(kH@+17Sm zAxBuu@00;^!h&^c4qvudUY{P9dwfk4v&G%8zmKKPJrK7!{fqbIouw(0C**pa?b0wT zaevDY{p;|8T?ZDr8oYdA@mZE-%GC$aze=^|)@`17?WNwsGq-2Y%WF`5$PrQS-QwNdFNzh~XSPQFg7-o}Fmw-l7G$^7vv$cWLS z=9CNh87H(7#4qCU5W%hx_ z_g89{9TD^D^~ew@=48)ehzvh-MEXMAmr2aL-zPEOH!jF}#oh8?qPxO}@6(l;sx^MB z?>LsqaXGQRWrFp!2ECP2{<1dQiD7+^F>US4{_ArdUlqL7y;^yld1dsWb*EEj)Ue$z zwSK;@CvMJ%>UY*#UbeR}TYvu`dTg4W827T$1tlzXTh4AiYCXTLU|xamxtgm@Z>`(U zfB5!8JLSfUkRwO`ynVKC{kiqO-d)l=HCfHTcIDzBJKqS=LFP zNpHCh>z!X`P7cOn$n&=l>J-RXL{l-Y(aM2A2w3B`e!cCnl|*HBEkM zNMusYLx+e*U6mI+xTM6B*OVn_hJ8?Qf z{Bg|*l?^7gUmq@eR+aZvPo}=X!bJVZssj0I+QC=9yVMrx`Gst}Qo7>iM%nc|KW5E7 zni<%#?SZk%p6|V`C3WWW7%Fz??%|lfa9#N0V|FVKc6UU#^ygmYj;@Hk(#o8iv+Hk? z-vaATA8b#_>dy}8$h;|-w@O2j{a>Tno<;q)-W+(g_URlKp~uG8_u1`D;6K}XzrM>( zt|sxfa(}`;|79=EPKn+h@+ZB}~+qW+lP(T1(zJH&|3NHevXINf2L^QgbrEG> zk8W!2`FVst)52wUTUO1d>HSPOFJ~|wn)uIb?O}DF9jE?F8-I<_0=IysuM}eyV=^_F z{&5zgX8qRa+mmkZ5UicQ{zA0I?L!Za-Oih%b$p|_XX^Gz6`!`mg$IhbC5gJ8VtG3A z=6e6fPF+(Js%ALO<7hf-*W2v2*l}y#`+tA^H{CcTz2}DBheyl*{d&H8_U-<}EeaA# zEmXUA|8||UV2W$E#Bz?}7dLh4cF?W&y2fiu@FGE!QUQNGBqR(hiN?=>doTi=SjT6^3%wsV#48E3gW*U#Rw`PbvD zb3sfuT=5vAb4!2jGtU*|U1E{Kn_;)vv#WOFrNxII7d|cJ3{!Gts$~B^r}{1aXX>A>-K+fg zy4A|B9$B{2qJpynpKQ=DVG}JfIkiW3e$Mghi@$o=YCec9`|!2+*vdQa4y8RUOMkpy zEB)4bzaa5sYtOy^`mTtp^P6-D_G(6~({(%ceD}SJ8SlQdOwM?6X%+jPC--blY8Ahg zjjrDM>gC>BdlraKn3l6t)Diz_=o}CO_ zmAa&~L`{m>?VHQNe;U!(n>Ki#6PV7^narXpo1MLIno0M;IQFAF%9GsYu8BN%s=Z41 z-v*w;2dW-Sh_;rrarvS1?~k)g)LGlKMjJW4(#4Bb?J{01B;{TiQW#*mneEW?xGh=& ztAGEhS5VNn(p&pg+3O>>8aB<>Jh+Y3uWZA|b%EznVruWb&(`X`zWm+r8W;;05!pz&x7ws?w0*fSZ{d^Dti1=yuJk3`zkZ2(=V#rL3DWKz z1@AiVuqb!sKGHtwV)K#d_GIgpzbc>BSpVAFap$I()rnpWuFDsMcLugBI$^bL&ZBGW zS?Av}i2k`IzH_s0$%NBaudhBKyi>7WB2D?_JovmE}JtG(xg^=&Wq z{XBfyEA{IlyA(>_A9{DB@icdi{|A9@wRfu?mv5WMSEtD9wR5?!?sCCHN94LUot$!z zJJ0`v!1w%bizob&y5e#Ab;au0$3NwG%j!IK+5ezD)k(1bjiA=-b8W{dYV)L!(_D7pTrJrg99n%DD??Jtu$*xE^P)>14qaC2ey~Ke z%1U?B3Gf17 zixQnVk1nw1oqs6seU7vAmGzq~ZVRz@%bfFDxcsyHV;RFqUoyXlblVkFi?#1~u2c5# zkyYRHu~f7fcSjewJmj-GXYh_6zdf>ILU-=REMfmoZDJ%Qp3t zPwn^awI6qCoO->a^59!f=|}t6W4@k#8hY!Qvvo#ujvANkMYqW!N3W>;`n@uEj`)qf zt%7gPyN15$uil*Y)&HYb$1IVzIf|z_v(j%rUtq@edBbvJ*3kQ(lkSPuv)cLvyk_3E zyo}>_@wXSvw{Cv3T)`_WQgtgc!zIw=?R!h2Kw#yY%XU*NQUEb4TlG=tNkJl}6 zmKBdtRg!7E=J(>_Qg*+*LX!aJghLvf_jaA~@aQ?TLElpGn@;h2rm#g14V+QR;i)cmL1;2RR6{kA$~o$r$o+!rI*Q}{tV zI%8$GfFeik?4;zVRVh{aQ5R2Ww;mRG=P~_8+SK}A6IO7oo-8qGP3~Ilc_DAhCb9Ic zk`Mb@@oJ&w)wW|h>cYOR*y4L~{p;kdCuccbuhXu*`YcSm+u8blW31(jP>&WTeJ0X3)C)Z80$iS_i&U&V86=V<0 z{iXl#wbJCf-LZc|!cw13e&h8lF=uy`^2HS;;$pHo!Z*}*O)@K(TcDDt_1vFZ^xT<3 z`GxXbzPmRU)`+~9P??&kzpc1_?RkNZ!888xTO7H0FvI*;L5Wg@!GU0n4X;n9a&aCP zymRYNyODq<#~};J^A~^b$~v0-`VTW>`1}pO@A8FR-M;Tv&6=BBeBvK>+laS^^)8oQ zSQK3P=J!F@kW&FyX4kJsHH_Q4OycgJt7$e{E!+Z+h-q_N(A@m_^rDFZZ@B)mvT!op zT?B3vG8>q|=2=ZGr!Q<`)u{&!ioFg$qkCtS>vzY}5Y4Hl1#(QJ92U#V&-#4#u73U0-O2y8?#Pxue0Tii&u{OpmfNd* z^lMwh!M$_0^_woI6*{+46BQ3hXk2}le^CCcWB=EJ&EcLBHG3u|E_i*he$T$2zwgE; zR9MN+(-dqMRyOQvs@^vgZkd}ou`9`=Z^Ztou^y*qmDE`95(pZ6_u4y*mkcX!OTEjh=Z_~_ho z(N(5*N{`E$*8Th_s-q{``TEN-CKU;V#P~qP=F3i()Q!4!)z5s85QjB)()8_5{*dkmU<7e*q;lk~p>o(gy zHeVy_IF6waNn&pkfrYcKXjVUa|Z)@H*KySAS8XP|&gs54B&Z}83F__bL{U6=P`g*QWZ&m$QniOVlN6c&6lIdW9-{WZTI zmp{GW^}BEAvv}F&A|cPng&v1OIgF&<1|I!*$fRSDbzY2>f$?^hC467D7&Knp`gi)V z8NOQ>dqlpoPy09dZTq(yFN^(S&sVPGk?%Cq@@q2BudkRXvi0rjyt};h`3#FztdosZMGdB1}1ZS#D+&r2<;-+iVr+be5V7lGH)C}Aw?X>|tnm^@d6!z|1;}XtL zY9LxK9MfFtd$ILbY(eAlCntYj<7U`?&)|jTNr4}qAF6XM|8V)T_ED~km|bFr-@8X! zrZTiHPHj?4&pAHH?YWjk!n}xy4HLa}Z1enAl&oKJBIL}&h?S}iinpgO@(^<6WIn#( z>9x1&m-ptnZ&2_ku+u%GW5I4dUHJF1iRwyy%Xz*SE7t2C{=M`2qPw$$jdO2gXB!>v z-I>brR(r?R*$W~yRX6R4hBq`bbJG98U6ZRebI(~A zPAz>S<}J2i#R_9n*Lu<87kC`HSC-FRF8TMw>L)i9)jc14s(F>Kb>S>$Lmu;%m90u% zcLnC`O5c!npm0vDYHvZFx_ zZ~752Gyka_T{)#M*(T@f_xxNCyS1%;<(BA-7tGI!_T(FLFV<~Qn5guXSu*Ivl6sk^ zEA@hQn!P$;b~^7e@2$%xrkB>9o*^C}zEgZ{wVc-1X)~WXJqynG7=A1Mu4|dIbi&R| z6W5Rmty<)VY0xw+mq3^EOLaIC^F-h8uR7E|DOialG!_W1sd3Ze7)+ocmyMV(`d<=#(9{hD1jLA}~0FwSMm)o**}mR#AS znGtXCX+|!WdbWaEw^K{zH&rvoU9M zMXMj0$~@h$HLBrK!`V;E_bPfBSv>i2`+M8(ZEJZOCf18r9}a%{@WsbZ1=SWcdp{XG z*{T$qse(4{E8BXQyCH1V9XAHM4^2{xRfVa33Uf?vX#Oc+71DU~ zK}4KCz|y zGEen3$HgjZcb6Z%lymK7&~%mbuy^5nfvjS8f}Jlv-uzUl@ZB=4nbnqjGA|@|9h$;( zZ)W0xRh$AlIhfX-3=o+X^zfSXH0Sp-c}(}s7dvkIe4AAEF_}I6JB4@EM}OT@wRoGM zg~6Ha3^|*16FM8XO;?}Y&6~PGaoS(L{hnLS3jg3wX?VK!!F=i8m2)#Cc^a2qK6~+l zmrPVg_;jU3`5}TkPP}k9`ty?6vY)@iYtCrBpYQA)loT1YS4Ph_GBxnNJg1B6%{$kg znf^V#PfF$bLe2EaYxOx!p5gu1@O@MLJRhG^PD={ENqoA0#%Je=rB!Up1kantNBodK z>m9D~gYA=3bSuiS(zSU@AMEOAjeH(;@_nK1=i997Ugj^K zv*Bf=VvdPl{JY3}n>Wl+5=v zdMZ3+SKWp~;_W;Vx5N}%W=>`Am92ALSDR@R^iNu}Zo;Pn+zWe_f0S2hc=S&|@YflR zmZ#UP-#B$I+;{)GZ2yz(Dvz=pJxcF?p72JfWQLIx`=OJU_RD_gzU2|Wwc*w4(7L1D zFGDmWpEPhDNWJ({jW_C__#^-F_5XM?t&D5HjYJ6p3j@sa2#k%)rVDm6YSl}}_TS#| z(RTkK2RXm)V^(z?OQtO1pRU9i^rh=?>HVtO3Awk#vb@_=(l>v9ZGCv5UHHEnDzo1# zWaXKmq49oW0Yj(}-uJ2$yy6{|=%x#;9WtDMPuEa%1*@u<6+LlMp z4vycu^~%(zk#mTz6ueZTepX9uT6K3pi0{mT30 z#I{XO&+gCv&sIIRSaOxd!oND*caKXiY}&FXP>Z9GYl7md$%%SBix0=FoUn1my>2JI z{j)98>w8$=H)=3=ZG2#U?8v#W^^Hz*SbslWcaGsu;rz=5x%OADL@8fbbZ7ZicFP4e z3Yrf(y_volznQ(7;iST(1*a13UI~sla`4`@+ex7p6K1VnVSe`V-P)-?-|f;U6Xm@# zH8OYQ^&I(4H~ewx+p^;UFaNe}Gwb)?j-1gF{i~znSDpV2 zo!AnGOGj(Ecy}mHny8`RIqAsW6P_|#>yo=}7Cb)sKH!R(`^lAmva^5PzkNl2gWjp7 zUz=4+E&JANvfUT?M5Q#4p(#duw$a^ihNj^AyDE>KjuMgSd%AFi&R4SwGBfMXe>!_* zomVvD9xlPQmH%z@wttxPtloClVdtnvlcHGKH$})!cL;aqcoA{ua?kvGd$R8Z^E}-1 zfT8p3sk1#&`}fr|UMSJHld$;Wh1T1Zt?!j0vjUdb+)Y2-HEsWvsFJ*`)A~Z4-4Co^ z{J8W-Q5l;{)K||{9gE7Zy|mT{i2C_I%=7^xN8EIUU2!MhZL0Ft-4w90UOXbI{vEeJ z@2jSA9X*yC)n}W|y{fPfNxi$`TkBb$w?`$XNM27=`Wj$n$H1dm5+GXLt;;-Z^QNoX zQ$$-O!ltQhIn-4A?WOJ4rW@i{qJCVz81QRj*T2nw3f5!_9KFhWF+MNQ^nJz}rit0U zTqjmd;yjTRw)obip0b6EX0u9I)UUkYDp+3sdF5I@k@h3DLXNfdC#Jp3EBF5^J^S`1 zL#C!1-Bo34WOLrUzOpRTfivpyw@-%JeWJdv-zW!dUjKLX8Ww9;fxT6wTzVILe|ARN zNv+~5o2mFGQ+<+ETIG4=M7tNQcbWe_>((hf$Isrb)nO|hS`fuK(X;T0tiihAo2s5` zn|q7?)W6)oZ2RGGo;2S)flbe+JTP3;Xu4DB`@fB@5*j8OqxEMyZFzStGDU2U^MSr= zO*QKig4>$Z*9L#wr~mG^-Mo$qDx40b7p|GKul_ejR<#LRm>N{r%<16Zy0+-?n1mcCK;k;R}Ob>i2ZUxVjt+qH6c>_Z>! z7Kd|k4VU?+3SQ`NdUkl`^vOBqiB}eV?dSX@$+7QAL*42A;NQ+3g2!jdC}|inWcoGV zN&l(h>w6-(u6M=B^YuboH^%hOxNlh4v1>x&lISh(Hi=s7>ipX9Bg$^!BAX+2yQF@z zCDdsg_!%~td(#Bf^K-uaJ$$rTHB_SbGmn|UH38<1#;vd1!_Ip+e>q??@79vKWl}|) zzh7j%+27t~!}xap+P0c!Z09mPgn#Tg^0@BP1<~`Vi_RX7J6iE)L-^*-o%ODy1M zZ(_QiI^TKEGpE%T8sv|r-~LXVzo+v3 z*Kaqh{B?oHLh+Y@+Id;$BR!m@OU~VVUhlcY?M`;U6@jhCpWj^GS^Mga;Q@x{4pNII zXxG1qm@lLw%)~C=`_FRU%ZDcou6fR1qJFM_V%I({p+{aSF=4M8>ksYsWO4m+#=?i| zR`Lf=R@SYJlM5foteN=#`uT2;&i|%=d)8m_|GMU@utRy~=3oi8`_oRVmzG3n?ypO+ zy{1XcvPAvcGe@jxUQb|=*uub5dzeo*t@RD(b(qfaov;S z#tA1*XKs7ZWg^Xf@A$I$c_&s0D*Y_nub?yY_$2@PqKAIee^@txrRAvN<*ErwS6up= z=w8mU(f`40HE;Ry>6bnA#d(EuUgh0OaFahXMW~S3>EPt!t}}0n)VgH+c(CGsmX;e^ z-{}|CvM)BBoP1T{{pHFhOPD>TG87)>68>SbVeKoshvn|}H8cCK9J-sf@TEd0OaUoCUqjX-y(U!2|eXF*$dxH+3Zu!#|)%8{W{`(#Oro?=7yH$OJ zMQ5GVtBH@NPHVhxcK7V_)tXk0C8w-AcUL^>pFfwOdFk6N=O=mv%XS@mC0ws|nYZ+A z?n^uAS+$4RHqV-FVQa|4TTQC5*#;k$M`)tRPpfw|Cad#nD1sg;|yi>U7L zTX}pAw}OvN%460~GgnVpVqKh2d6_+4?IDk$s87n*iFxgArgh#s)$x?&}==<4j)!t~STz4N6n6{+0V z^xoiKG4q|`k8l6Vnsr~AzTPr6+?Qkdji(iz2WKuwK5%`@k$O2V0hdnC6%W5SIxVqt z@7TA{-ZZ>(Vx?Hpl}S&R{O~AqD>>HV^j?PZpX#lD>|Zu^dL3I6wQP54^o7$rJ8Y-`-ge&@2}eMt}`iX+2IHk=hq*;UB0x7>+JRV$v?b1(p=W3aDG;_3CxrK zG5=Eh*3)Lu;rH78SD(2Wv7XVIZ`r10_tc6X#hriofBO9Ufs1twjtAIRRtnX|>FTWwoO0Ndo9kbU_%!Y+7LB`4zD*CVdBn2?zbtGi`aKVHnmFau=Uj7Q!)o{s%I+C+{wM} z?k|yc?{zgt-deqU(zUi*aS}`8bm7jM4+VXbVXFT9?J~rm}h!o@qz7~!iyg{cAdRCWfRAjww8OCE@g@sFQy`NW9_VsB6E(g-wB z{k~G0B_&+?b>gm~xMjNx7u@0hvCzYGNqyrd*X>*9+DSBr_8gj_>dg4Ab@8mZeD42? zv_kKw@v(}fcCmkCF0-7?*W3D4(y~fLn7?`rp-pRe@&QRDpJ06D)!k#d|H&QCpNb0gIQ1mkad_x;aZd6DF-!pSQ7do{!CA?W4vQ`+MH# zPcfRix7F9_uuHtnN!=s=P7A09Yu2%anD>0S&sgHKmhJORg||01iT#PmIplHL(c$6Q z`4-u)4|H-bbzhd}Q~zP!%EJkl9bVj1S?Vin?zC9TD?i?{_GEMO)lFyjNR?EV)N}dP zug%!a+|jQJ0-+7rTkiKhl`!<^_ug|vV6DhJda;|`lZ#u2#qa4|Eyd~sy21x z=~O!LtE~T-A~ENq+@ro-KMiKQW4Qag=H2~w{9FIOxjx(aWXb=q>EDag4eEb%20nTJ zoo)FPix8)zyNohCHfBb0K9$wKAMLljx4syb3DFvaZk7@8OvL-r$Gg`UFpI=o<+ zc;+#u4=N2lw`VRZGjm!v+wUhdc+a`Mo*!|T$kgc$TT@W1)~ z)=58X|6iv?Zxh=V=e8`~{`dXrt8b1<3%au?_nLNw&GxwDk<@F@e$%STeE)$N&z==* ziwJ6b{x!6$V6n>i)2yPO7uU~^H;??aUHV>1yV}Xk{GM~Cwnp#TQ@sE8syksP&%L)a zc{$bo?D{=_U-s9=UCa1b_f1^Hq z4;Q`rL>FmA3AM3Y-^(Ulx$cjz$mSPQNG1{{1`zm~0L_MF42L33GIjyi1@ zJK`M8zUY_AspOlxMB5G6C7UIl3W$A}e~R;yhH|l#TO3c|62~Vuebt`?mO0J)dr9fM zo?6_e9SZdg`wf4+`Of%jP0Y^1({cB7*KO9`yl$7Q=SEhg;&{Cc2NJ zU{`T!NMVtk$niLUbEUeX{|t%q;oK*mhklyw`Fhi*UZmX2Ac=DBWGa18cfP&)d9X}^Bs*}T`&4|?ed3fHP`7c057{K|V4 zclP?}%hKZ2r|ZVv4m-bTZSO5%S%0>yEq(hv@3BJvt;+3nYc}mNYn^>% z>HpH>Uh@}t#}|uC(4QIeU9RP+YfPMXl@0MY}6$?*k`^ z%I5j-OJDaoVBxRln|JM=m)A^pA-TD{Z@C};y&2!$6Sgh)wMth?x)b}wiM{vR{z%Ma zW-ByNQa#-yb=2V|L+p!|ugWJ*KS`Z+wOsMt1rbAExufy#+V*y-Cz%|5Sa{g}P)3)M z>;Gh@dg1fO($zQp405`iGq3OBg5LCxhkMwZ&;5LUc)C+tpM$ZPr(c zYdlY@yN2CP|9b4%>0==UMZYJWyR70r+h%2SMDqs~;jQ`KO-nnU|MWh{oFUUIsC(ieAfipx%aYfN{~yII22)hQwV zAxl{>@xzN2ZLjjpna>7V(gKK8wy;P?b2}N6;tX`02pnOZF$fqc5Uj2MG zW(Cf!sGVikJ5MiXl(#ZBI2SKj!0P?( zn`fZFI@d*+jw@JB>h1L3Z}@lHYCq?zX7Ta+_y4x;Ia&WK*~pPgG12YHzUnou3gv_Uwk&?*Xe{=b8qfs{I9_udsAlBrb4OP+x``t4UHIY&P`J)uYNq^ks*JHyfxA5e?;bCXl_&pzA4n51bMa1`a zu=%#r=X9j}V@(gNddGY=qh7vN-{=40n|!(Dh4;T5%DP|P#$3+*cUO%;ed+sBOYzmy zuFldhoAu(Zf7r`cckf<3AI{TalGu5oSm}X6dXgVgWG|Gn+%_w)^pvy6I&06aW*^rydT#+FP{4#bDIjA zBiAAsr@F(I79M6=t31x<@|&#{Iqvh^zw6f9N{hMeyUR3Q-`;k+ZS5)z*8t9Qrt@AD z=C1GZu#9>%-(sbC62}zA#Uit+W718d7HA)Ff7+bnRlhn~TP1Lh#OCSuqo&+6KlE?Kd*{dv$;xzgV|Gk@%!(qvnzCCT>g4-OmXSIzMs$MLW;?M zkr=HbGSkg$lI5D#MZOBum~1yaZE}BO)Ca=}N&@LR^*chuc8Yxa;~=`WL$OZGT(-gc zderkR9(@x|eCm0Ul*rs75qaQj^?SYcZyg>Shc+l?JZjtH-TZoMT;kcY8`&2{><-J{ zqkb@T>b&p>)*B{mJH1QqDi-#>S1`P@+~@epNB3SCn{WDbI`(=Hlvzy1BZ;(%qV%TeK_ zjQR(s&1dG=z`bbZp`8*>rvGR5YdX!PcPaYxyqH%t$21&;4824Ry`-JAX6N0Edpl#* z($BXTPJGCW*%tV+dHXEc7fsAN4AQ$*cHi)tcHBk(vR;jY-A9`r1%>siF7LCNH$lJo zjC-n`>$Wz>#3MI;N0c4kcJRk$VTFmx**pCT3~oKqzRxr<=4`&qg(9ywU+W#EF*^tQPoeHHGt9+s>9(2Y39t{CKOEe(hFQRGh4=nx(Kk;x|IXO*TI&2It{!QZlkycU9KYcSpQ~J8 z%zDs$ed99W&MkNN(i!%2PxjlVvM1Gb!>o#J(h{b9Y}k#rN=BW4O4F%k;dTUa{NDto{Gl`c|I1yqo_rOGCiK$2q^e?Pn~0 zeIr((X;tomRsIju>pWi8Jusz67v&Uj>ngU zl&6--*flr4+m>tay5BZAFmvmNFbg){$F9jsq6%NPG;X}yAM|xm$D^=-_iq)xmnQ^I z)Y`L_TPLE`TV!7x!%dx>w>%T;7jlIkdUw8ewbNqLdxunK-BaJd#J273x-72=JF{J5 zzfa36PkAH!>hpu+D+EGX3&cWx%{s_+{N720Z`mdtS1#GVjNbU0_nGbW)b#M}w$Jaq zIlndA{^8x*VpmxCLzCZM>Z@AS=B}<^`~U3h=<6Gnm3hgpe-W>9*>Zxs{w>EUTZcotU1WvFx8kfA6bumrbUsKV3Qw?0Rru(j)23e>*2{oZ6D|W?v51 zmi_$ys#!WJ)t9mEJP~H`N=Vl%mG`%48t>e|GoAGwoBz};Hr6xa)OjB9?ZzX$%cmV` zat^2K-EMhvpFh>uBJ}n8iE46e6AzZ1|0l6|E(f2`$%y9`Enn*%hZkE0vPq@878E)} zvtRz2Ef$y5-oIw|tBiYXvFolG$*gKOw0fI)J?>-CqSm;yw%fmQ4yxKj*v+2Rbi6C) z-?s(2Es^zA^#%RX4XciAp7`2l>5n&uE}1J|$})VovUX19oHP5Eop5F3o0zvcbLR2z zhXE4P=4~+l{$J?T$DQW!yH>sBUe|SAtxD;L1y5tZ@8wr*KG^O)b3yL!l-;YECvgRw zlwWt^u>GY4>G7A&2+m*mh;z}IA2LplmpiK*JHBaM6~9(Pt=;^-{`yl5Ki09n3ub%w zjp@Uk>Xr?yQRN>*XFJbLPx$_?d;jk}FQU4)@N2(#8Tq>O%1^mJ_2Fed9?gtg;CN1M z-aE%H32o}hf7gbuNO~3 znrw#9OTU+jt)1H^Z92YuD}R=0 zwVSA|)uJu0Pp;>8Xvpzg{Lv@ZtUcuCB_+oR3XTl&2mU?#cD(+?-MN*b@7|R?e5e2K z_qT6X&EJP?n!Hfskkh-o^Sc)b1d6@iv_T+|Y0Bky$pwpjO|MMf_-=Rp_x<<&)r&q` z^4T(zt+*&+;?8=`!z(VQ)pw-I^?a9-j!e*VzI#{jV$at~`IQfNa@yL?|1Fs7;Phyx zz{;SB%$-YL+;_V>_sh%nPk9=N|q!Mdz5vJr0gtR5W1F)bd4)&jK3nd5eBnneigUv%ER2@1M^X;{duy;B#Sd8%xqM$n_qZEJJ{J^5zuD{AaL7}$KiK)A{~ zN2a^P``sOWS2@wX!g!kO$&C2}?n)0{j>6~<_u{CVt;Si73Hh!G+&^&ah zesX0A`;RTt7j6~YEV+eyM|!@@^m`3zIU0v29M+yw5}K@X^A@9Te9i;6`KMP(hF>!0 zpXI8=x!2VtaffE}&NTvGoiv!#c_#B}bS-(ZyWQ<>=8i0B<%QR$wMnj-Sbs(`+>J>j zUFF521_=&jk8cK>X57=)5lXl2j^W(wakx7E#g~0DxAv{pPUtn>FXxmhvRq0#&)Qe4P#wy4^z?{{6+9EW*V{jS;uN^JF*=AiLFC9$5L>!P^Z!+C9`>B}0IPYE^UZLq%Ld_%D(MO9f) z)LMA**@>dl>;*4sKK8F(%5=EtpK0!z%imb$NvA8Ry7o`u71^eharMvKjguj+Z$POYCTk@9ao=zxT1&7p;kLiyxQ!x8yx#bv@r?Ji|q= zUN%IpTt|3f+{RB*8^s;`qW=jg^w;yB5Egu1w6yc-teq2P&SAEU`}*R|F>CRA_7+dt zdUOPZ^4@%(#F}x)Y`#d-%^cT48NTVwahoeLk9V7V?5cM&7MgNguD0UC3dI zf8L(Fqrm5C;eBsgG4sj|pWX95c>FLj-*DB3-&5(lYvV{_NMTXIwK=ev!%{hE_&H&nBtw^Nu*O+bxvcXmZ9adGTpBH>G~=rA&<>oO4z; zAHKjJaH%-;uHgBX3$<_WGFrkWd9fD;B%J?@2Yh6>Mn48e`4RI7sk=+H$SQ}IoEscnq=C(gH!L;TOIOR>Z0*^yz+)0^mEdCttT^o#CC*K2G{mSR45AXka!FdOhWQ<%rLv7|1kD1RIZoIGbozI+*&Q#Y`u($U0nMYF%Z%-9V z>@K%rSMT8{oR?JZR?mS)|DkHQY!bVYqiW9LA%7sB2(FO z@A{^F<~8%n<^8DIxJBTU|BOI7`HPP0qxxNerUcmg-~+ZU&^ zn0ApdIfSRVBashcBv8#ir!9uVEA`K12kf8DI#=?1oc-cS6! zdTMOK&+GQh_nb3L93qnr2fsVR!gTYHPr;Jq`ZLsDGqStat=Y0r%H5KyDC6wQjlFj# zYy7xz{Y-P}yEv!M4Tdgx^<;nG{FKqH_s&5c`x8G0U+&}M4 z!sl(WEzh~GSbD>TabN8DL(5Kc&Nr=0<$7HwnsmtOaKiksi4RZoX#D(mDAaW8J4G?h&D+;DYLrxDc-%Q# zv-YuJkouNqX07S{LUV59KIE2fdo1OCU{Z1v@5haW4<5-|$($&ev(tbhGIV{H^B?n5 zOx|%0x`&m7cP9M${C4$!1}{VRpV0P|p&|H4H6}AN&>m2&`l!hKJ0}F|uCITf%>Hr9 z@07{ABUtPfxr&`U^pWdB^HzS5_Qi?Qock&x!s=>Q?V7zjdRofq1576`PdJ+tT6#4+ zym(&xp4!7rufO%MU1#L2ldF%9n`3JqZj{iY;`Q-Cl6;0-#w-D?$byaB_u40IsMwr3 z<Xi+p5V~^(B?h}zWea`By z+(~+NiZR?3Nh@yuTa|rjO?9EwRM&mh>u2j6-#&l7dzNDB@s{R<@3#(K(lHHm@iGnA zv(7wvT}H&!xqCHMt$9AOWRhgdwW){bsO{4zi;{aHm%;hWzNOk>CE-95AU6M z_33fjYJ=RGU!OfDSA^^@cy-$HWLS_}$dM*pVV9FfChc3bTJQgrzYp#Sd^TUAmb8ge z%YY-kcv}niG5t+C_N6aFUvB$ScsOImwAy?B9vJ5-ajbae5_`3D=JKiG(^O+Rs^-4G zyzfm|(Vpl_b3CjTExz}DuaV4D!9{G6x!3ANmaki(z5ZXIQ_BVB$NS%#M+<7cPTRxq zI5)z=;)2fBzb`|~V_$3N@_o4U(80y%%q64Or$v_DN}nEb(ac=H&bj#Ff}MPCj^3Vs zzUg}#2UDNmHVz>knN>H8A57vfI3F|RvcguyB-Zk;8yFAB8*pvQYvw+D-e9MwPh0r* zcj6E7Z`2?9>YLc|Fe|Tq_MeFS8BYEyFL1ORtqqocJ9VpMoW!yZE}I2~XC|eYRFu z$=NS*%TmK7;mLB6`x;MV%9^UEzxUha%ym)8WcE*{rPIqc$}LigYxO(yqoJT>f;!I( zB`vwfJKA{7rY$eLyj(ATmE)-n+q1lDa+ypch2{G-OFU1fS+q(&j!c+v>vrtM$KFZ{if%THBTX}`kxSA^~3PNhPo}T^b+AIcEvE!1v4lKA@8pxZ!_^+RDq0j6^ zd$xM-&uig||MS`O-K-l+yA5Z|ZR(zTZF%QU!_t^_Y`M2;?$1tG^6;!;d5UDcNdKZ& z?y|wZi5&t5*Cq(?n$t319Cq zY{=8wwn;pEXD!Q|?-R6NKb!IXO;>Jr!;%$ct*tlK`FqEAHE+=Wyk>KVS|-y37J09N z#-BUtk4{-x@?%xLL3~42z(<3qsT{X!sx}*Dv`pW9dvd464wC~%R2SRFrJ5E2dhB&*V4&yXWbNTG6jF= zUTgG0>6>!fg|<(Bc<29{aYNV1F#GP!lP!XYSFRtP@O05kei6aKPo|$4t=`J~dGdN? zsEbHAzdUE$&K-rG3Z<3@nC_H(Fm9Nkcc1ae`g@%!T^vt8oz}H|K1-$ZPrdj5*r+N_ z&hiJp-%Yrkb}Z#{+SK}k??07(+qpSb)bdL0&f>$5KAdZqf7iLqVdg5OUh zu8*qsw%DV+>+otxi?9nRf`U_Qm5kDgn>I#Q{i(UISKn*TtPEb|x3*rWIyTBk||G=7^ItRE>8neig-$BO&QH(EDOS+%{)Us) z_jIf6|F_%K%i6rFAGzi8xt47xn;as1_NUT(x!>EO)3&VSFXMhI@#BV$5indCMz z7v2)L$nf*x?J*x0`WFf@9Jb;}V$0hr5j^4W)Eb3ji>eLMav!a@c5-?)o65)Fl>6LU zdh6A1AD!ayvBUUOx3ACPi|6KBJ}#UY_Ta>cciHX*fBt_?i7HHA_IJkg(r111uA5Cc zR8cwSp6#9kXS{r~uAg1E;*#F?Dwo-Xxf%Xa^41J4XWl(1|F*q*Gygj0w8n;Y6Wkfw zxnwq~oajq`U%&hy-#o|pz6z`?=53!OINH}3{doH(zW&{eI>itd&cF)~6!c#{J1PAA zcWCgGUna7*PJOw5ZyBf2yxsc_=QK)QS0Jn)*NW9s=snfrF8z{^tV6!r#a|z^!5p?mnpk>W>$8~sSMu0hlhWKacR^qy|qnPsW3ih zWAl^?p69GRPMUm)zU$l9zUjvW6|tCDnbMy&#}!J0R?S;r-6XaA%bjTz6P~_4zM#+N zT(wBVyR5*)hO50qXNw7b=X2AL%I3fAHS0~xgNgIi6%RC=coDI9?@0x-wjX&n6C_LK zr#4$N``0Z$@LBDF#00yux88E)t*dW0?_R#_-q%R;vk|k_^R2w&&Z0W~@q|gjGtL^W zN$%p$`ffd&_s-s*2@JLJ=QKC|bl7;%Kf2;v2g~oqA}N_WlNS~5Un`pKZW*#FuUji# z>&f2hD>s=Vw>hL>~2fIr%2jJp0oY|B|jB5@O5kt_jH3 zs8?L-$*`@3g?aCNbJKPqHQ~GnSB2V}GJ5-e%shQ`yPjq3mCVm;%+hZqFkiUSx7p-R z`%jgEx#7EyNqz{KzCE;7=hCN{{EMUI0)^JAH$=*~y*?pvIMN|JbzkV#xDUpMUN)cl zbK*mDzrTx+V72uOO}X4EgQuq_6uw`%S=0M==c`HeLGRUs6=a@EK3iX~S@WqQ>%ZmJ zX{Rz#9h6}Da7xP@3?r&uLKg#_07M*{O|CjUESHVBJ z?p>X?U){Hgub#19ct-ry+UHX)%=q;5!{`0A)8cD?&QFy2EOV>(NZ}j1j!#FmC&>Tj zjybnGmMb+crMP7J4PFjj2}45*1p|frq%1BQ8~A-xhQ`K_CTb+?UfK(bc};Zml{B~A zZde!FCgyCEBWIRyw>jx@ADinb70Y+uUYBbGUB6Hmd;7qpubxY4N-Fg3A20T>pa1uZ zGH2LRNxm>fzJ2-g@1Hw2FaCppf`sN84})knFGa0Lg^f-YE#}=1zMqtiJ=gtYo!6%~ zN5AynwEp4tWq-Y(OyDYqWZl1ImbS|$`ILyoFR%J|=FE>JyDonF`gh7F&pGQ}YtDP( zx9e~1Jn>e)r0pwtl{67>6Rwa<$4_I(^H?B9FFMH(6fa9DQVQrL4`#yWPDzKGJP z4COBiV||rWH%9lI@bGLrjc$MXmk<6NJ%g>v3i6s8L zdcgJ(_o~u-iQs344Y7m!A`dd0L^q2G1H(WUrI65W7V-+s_-tj@Jtcm&P`e((p;WO)b zk3`kmtM0gG>h+#)iG)xt&-+hCD}^?nJrG{=$V4S!<;-81m( z*DTREl6#Hw*p1yC!qRIuC71IGChvPA-K4I!`{u82QZmvD9_g{qKRru*e$O;RRTURb z`Bp*uaMw*2*bNr7uD)Cno`o;O*SqG zgT5%;6!!@;&u(T4JK{PuMccYKQv9#fqAF7t%LN*zmo01AaedKI|J9ss%70eW-RCpj ze8EZo^$drO`nVsvV#M4!w0AD<7N7BLcg2O?-o_LCB8w&@EnfH3X#JM!3|wawa<^_* z*;#&ERN|Q0P6m+*1EEOfg4&)3?<5jiF8Ti1F1`NrFN4G%Q^b`&nI7-mvH0eN$WsUI zzPn&_uW&_6N^nt6R?XIR@2*{Som8c5q!_^a(eAh3+I5-12DuUSKMmOC?_$)n_~82J zBX5Tw*Ynop7dHJX`uS~p-Ih&1!sOF0cW%qK+UYwOn?I6s6*;>+c3(2T{bfrulaYeq4u|e$F?apJNLwW>oe4Xcm^fbB=spVF zY@XJ=jI}v2W{2dKXUjIJeKgZMTq#?&Gxls*%8oVvexE&3I&ZnvIlp^GPfkDmIE#&Q z-FA*2U)^R`>#Zm-ne*h`%%@XjuQV7miwX2>YHu(QGF3RUfVpKRFJmHW-lx)6b@lto z;?GMf?E1c}?8^4MbGI7XWe@r+d;M-GBQ-(_K$u#u5z{*{Ys4>KJU;$&QB(CYH!Uoh`YhZnnV-rQgRKRq1M?Kdzoo+zLu zU}RdLrZZ)JW$hNvRmrNIob1>0|3lxJ zM@0uVf8`O}e%*M<3yW2mGdDe6!fLD{q2R3F#%Qr!+<%AG+q07wOkJCOEcmHeW}#C` z(FI3~t<_wQS8n|qBNY%?;VKT+)B**8>X-O+t-!pE&!;a<_)+?wF4k zbS7?eF?0&I(au=eJNxL-uRH-}>(U$cChO+%lxmtNPkSJ=^qSK29hu=bmhO0`t+%wT zK`2)1?OCs)m1)KsH3erSa&KASGK1MGHQIX1jZ{J7GFN70N1nAF7v`=ND^~5WSyUUQ8d3153{?FE+c)wW*Cv5w_t=w}cg$KGJ0F+Imx#&Gqyf zzUhTC7|NV3Url=L$+%W(c1&sLR72J)flc-W^(N07juv{)G4p3g+Ok*tVA!oSoW65r znHH|MxO=9ddS|6j!U}_#cTf9qPu=_X@7{OSVE$G ze0*>C`fc3LUOi-UKDfUo@^8TwtH`t8zVGILe_yc9&tIlApHF7*q5XT`6&S|v{9Ain z_Rtx@xC_T@>RIB1E{sZ;}dk+RTkzv)F(4_wP5CZ=QU;TmPNK1Gl!j z-JjfjN;bLVa~#^_`ys(DK4Ht_(kaHZQByV_>-{;J#a`S&{Rd)3B2 zCehm>4;_EE{_gE}XAQS<2fqAc=}nve$IZ(*-f?82ge1oy&!%5qo1zU? z{+LzLlHgHyTHg!W{F9mB|gqK5R?=r#C@)yVWl#u8n00c{?Yh@2NZ_ zv`Xrrki16io}$^$Oz$@8_Q%R@@wg#d`oH4;wSW75rf#*`|6|>2y>tII|GKI_&A$Bk z>7)A%kGg)ZEZY}#X8&EGJ>{!8t~wc<3#r-mBxY0ndAG?%cZ{El2Yfs@(fNSHLGmoNA#x9)SSUCcjiXZ@7l?lYICa3wJBI~1Z}TI72as8`MN7*+=nf^q?o+{Zj!7bi#z44)WZ>tPg1=O!FbUX+xTOG7K z*fr?u#WRNlW%wrUTw(6iAau#&YhG-d;Lpy2g)efe7lyN$ecYC7QXeH*$F?V@WapvN z5wVY2Dg>Dxs@>k?xR!%!!VUEoLXD|c4O1n3J7zGoZ#=v9MecUbET@^v`n2PA_IN%F zZW7OCQR57oxOgLnj^KmfhrW~KcR1<3f3i_i|NaUo1LL=1-4WZFPVEoA@GUY=?O12T z@dbIZQ?|!nezbUV6z}%UQ7ilF&u8uQPuuCAw)A`i2>GYE{&L$N92|82MR!w>nr=(3 zZD6{}g$Sm~1fAI;Axl??HtoyUF=<9X#OJA6lbZECek?AXX%Ms2;kC%_i>iiRnmSK2 zVwauK403dI=oQX-&2pf-sVStfNbJ1(3!}MOJ*(Q+Oq=pz>YF7B)uO9)59-xtRC`J4 zT%N*xbelqfiW^V=20`&Dsk!dFOBPJA7PX44`FH>1r}O8#@28!<-hKM#^2tx%3un3T zs7<+bt~2+D`=^_HwHqpCy|insv;Mv1SL!Jp_E}TA-#&L%hNqL=4B)i=p*t#WsboFDM-`o@?Q zd^@{cTy`3{P3T>BH9c~|+SxyXBck4K*kZS^Y`yL2mA0oZ&U>11zNqBVt{8_Hj~?BI z4I8%ntvCP7d-{UQ(|@ux75Ou_JxkULUlnmSJa}LD)b!OqnUXk55?nWg@6dC~*`!?2 zvVF-%*V2svT6@;5)=`|5^{tdKsJKHpr1H|r1#gYxmj`TfO-fB?@$c05DZuqczmSVU6&*OgM4?H_XKa}RwT$E0?d%#o{v_H5$AmN}Pvl3h5ynP4c-hbsi z%K1$|^Tb+|lkVfUo8KM(edg`^-i}X)Ytj;K7?nNDuQ5-a9q{W-bvyI#T)y>{ZH})4 z-RJ#hpYqzm7SdocG%^OylQ3IYC_uJ)v`+HQZZQyP{r;~@r}W|6+0zY|mIVH4Sm#xE zy-YCcnCHfG3ohP|Uw!hy0f%r)^P1;(3Qnx6s$RN8Qb>i@@l%c6`_(DmRah5tNSUf$ zotMGuQ@ALAx$EaLwf8TZ@6O)%HS(OwvS2qu)3+Jsq^7;K2Epajrr}+pv@R%vJr<9VFO9Bn^!$v2^4ujSN9ysI{HrDN7@(h^30a*(qTH_3NrH zTq|LAp0Rl5Ihs~2-_P!CL* z7`ope4dz z_bSiiUNB=y(V`#a>&*if{n(ZB@;1+|?9+|Qs%>{P-n{rLfp4!g-?7^5zm%VQdRwP;+*=cNbPD+#oUml2XI!PHFlV5_%%iI{*pebGE}1Wr{c`w&?~690 z`edg{)dffV7X6LP<`&zMeC%Op=*!0e_e@LX`_GoRYW&LX#1;Xaui}+=XS@nuB($0P zxz6d&=eMS%wa>FENw85)>|wpiv#E0O`(`PRNj*=!MfY6YU6j*y^l$U^^FnGn%P-&l zy=(uKowC=Q*UyffVEuO6nX5;3uiy2nW1euzjAcH@>gPSIE;+9h|61zLdTvdxCpu5> zIZS2y{xa{2U-_=JB^{3IB>eY^&wQ}3@K8&DFmHto%Q<7dtzJwkmvh{T%T+qa-LWw9 zX?V!4dq=WrfAO|2yM1oEKy2n=?lUveeV%nk?Cg1|Gn+}tdv9UFB{t)l)tgoxYs(1k zN}FMx(CK`0$Nbd#3}b=a52pBhFi^LDV}7lnSWNsUlZMwL?vF9s7fV)G3)<~(ys9Is za?MoAdh+Cgq`UlgBY2bD_owZA_nx!*cCSmkpTqRC>LF|HS-pC-FXwyM{EDQ#`Pm|y zwQeu8+!ats ze1X@tP7vG2xb{%w?Opo=&P|D0YxR%OTE#ztu2uc66f2$>F2-I+TXuRyG)mM)Yx`SF|Kw*O71@4nb~ukRPz-E(g%KA);hl{r~+ zD@*dp!!4;R{j0=`wdV9VEt%{Rzkts*^Tw5P9(g&B3lndj%u_kkBw&*{<99>6)gji> z`nzrGgbfbIn{eD{W-s|8IZbELjL#GNlvmv`_Wag=^kb^tmEHWy)*Jr&{d$*TTk7Qv zkH4M!JK^2xNsr#-Wik{j-nF=}{uO&|#kP)@lY$uD^(;8$WH#TS;cWKHs`OdMa)ela zGVAsPH+xV1F*$JJi@T?4J9pkpO*3cKOIgUSIFV;_{q`b{GlEmx3)+&yg|l4SWH%Nn z`9%LZ=qrEf|EzU#e(%mZMpyeVd)_@&)EXQSwmq-@=FTs&M>Vxw%)&b}b6W$hX$F4q z|9UNKD))pt{l^!-FS zI_>SIGi+zPPufvG)uMT^`)#)Vl6%`jjq~O^{rMLauy5BdzPDCEqWdrSw3bS&z3kiZ zkzd6($l;Yy^`gWR3-@asxxX@Thw-wDsnSoLa?EEubM*0nJ6rr8y*KVxXQ()6^e%el z{P(6eLK!Yq$~0*kbWb?n{Gjq93zN7`*wN1dKYseOtkl??sVJkWexhDOCuPnafx4w< z1ugE*W>#floO78oGuYN*_olNxh6{Y<)jvw*RWGPK6Fz~rrss$RuiuTNvfUvKlWK3& z`dpfF;?qpc2(`W1cLVNxuyn1;v);$MvFS&c(E$%VNmb#C&El*9X~+I*a+MqkTEVti zAXZJ-BTPJmW376K^~xi&83fnW&puQm6C`}2VLog1v@b86s&)#kQCNAeC4}>zu=j@j z%d0}>zUp2PTsP0^XwcmK-ba>P?D!MzsWxrB*5qvq7f!C+RaaZ|_k}C#F+S6cZ+XnB zw?&rb^*XPaRQ6!^3Eh9evPW6DIR2Y|-F@pK?*pdZ*`KfdSO3#}$E^1GJqh>V{7&im z<(4(;xfE>VV?WPwmz&gV@~a~w8vlh%sW#tM zykWh}!m7rL2bmbWUidO>xXE$4XKu?W4NtyT zd@_H5q0)|{!3*twEA6#$ae zy$djZr}o6)2m1!qJ(jDJ{<(-XrB)vM^oMf;^Y)a;S%2l<{L$R-d1rs`q?1Z>ZOyb^ z`f8j%ALEr!ufnFnyk*LgM>}__1!moqI{x@g#-UW1Ia_SIxgWpW%bmX5z3TTp)A-G4 z$JlqP#Qo2hcarp>rdZ`p z#b0kLEau47itdVHdwKKFA3<*MIZHkNOljR{{IRfL)}`h8>$}f{AMsgwl8cM;w8+)6 z??z8D_wBCzXum<=&SY@KK3%nxRdl;AH>)i-PtxYs=lk>j@o&46@c=BzWN0=$@B^y| zlY#m4gJP_j^?M~^`)`|lvfY2E-z;F`q7~=2X-xPw%b8CjK!okx!%OUIU8-;1n&dZS zb76gLx`lF7(3YEb)yn-Bop@MN|LOJL_4`kpy||Cd{J8IqpUeOM+fe`Y>ui;KCn8o@ z^qT!Xtk!Loxy(f{b$0FEpXbf)vKsLme#^gX%QDM%O&XlrQ-k}v>pzujJ$C7SB>(r^ z-17Zz|FdRX?&Wb66cf7GHd~>~RnGg+FDd;KZ|{m^-oE@y%Fk-$sW!9sCe3AcPiEN3 zMp<34o|$7WVQrAMt>F9>zJ_H- zwfW~gUzK~WHL+w5i-w7p=2VaRM@>uKoIbeatof3DlbBb^f}Rq>Ps-OAo3@^GowJnT zr9wdH;jNdmPb8@ZP3@g<-`K;5m2n%FsgumL6|A00OS+y5nLMqWnlz|8nA~I~d{WSbV`H28gat-3pDyWpvh&ybQ*t^6FG{DX8fKXNUGkqrve10FG zOU3bq+7cai?kH>Vn?Y}noD84y_K4sMZA;I{hrM@Z&2HSEX7}XX>3?_3mPK9mw)uQ> zcX0IIgPuEOgcbi^m)e~0*|7He^=#`eOEcNDBUY&h1zLQ6czwC>^KarJQs0x$IlNpm z+wr>c-c`0{&+7fv&i}NIIekC3UGmm0k+-WKxpfIV;d2P=O!;=tHPDDzX{%SDO6Tg? zM@m>F?mUjBAIC5MzEm3QscbHhok6UN%g)ZIAsQtb^qFeRXRoC00hZKBY zwKA4Fajy$h+A-7S|Als;KZTBITeZ?>oQe;)7ITSHD5Kw??W6U^V>U}0V<&t5oBsO7 zLLZUNSeuPR+GeJb@ptn-H&!=qfD3+G#jE5}U9xmdD}qam)mUhv8P z#LDkRA#2yGBrI^ zrTk*Ag~#?EDQc)XdF9)!xCBNU>$t*)xBBXZR=R0g^S{|-ny@_OhgjiWb^rGIcs1Dx z`WdU=DyU5Ks5-y#dDYhEGqz4Yvo5u)?RU|FsflixpBj5VwJ=Q(3HPopKeKyhX!ooh zxu-ilHo3mPV{I#2K4W`!LA~DMCvlSxU22>mwQI`HLhk2(vtsvOJ>SsvFkR$AWxf6C zY)_6wPwM@z1>`r#&$s@QI8F6`Yr>&ZZ5zJ6GGINcyXy1ht)}jCPtR=s*YEv0|&_QR80P6fk%9!AbUA_tV3lsAu`>eTtS`c5CsZj@_m)&TBHZXvsgg(l=Y= z_>SNt>(1yYw-VA5^UJSYx_Ef+%6IM`CQ4k@x>NjwRBM?^v>Xn{DQa+wqHh=T4td zIs29z-)a+yS4(5#m()^{I_J0c?@D00t`sc`zYB$=j#eix)}Z@M}&xbw#{$#d_j zKTI~?`|myLsxzgv2JJynKi-w8aIEDh{Ji{KbdJ}djV~SZ_FO*1FDZBB#2tB!fKZOW z&?B3#*vwx3r)I~OQm$XOg;m}-JmA??8L4sMLd{EC+4_gq8hm$Miss|^@ldy+p3`dD zW8t+E{&;lz3q0Sp&q=OiZ`bO~X1hzyPm#?sLd5qHw^ek@$x zr*T^Bvbl_GiDgXHzK~1H&Dggbaon7lz+J^&tmkN4=J)D-Oxr>=%c=h+Bo zKYpR_%MdZ++8%Wo+kcGj4pzo&P}wLQo>BiWJ2~Y9F_C z?z))v(3_TAv0*;PxZU=ro)6DXUfsRale6w_h4Ir>d8@f!P28RDw(rtYA=Up}PWf6E z7OPwrf8Vw4?gWOdA9i^QUr%-NFIJOof4QV_@&EEfp)Y+v>fdTO7S(_3{qtD*oeKx!8&95;IVuw#^89|VwoH)IUe%j1OVg5No@V%-B`2pi zJ)ibu#~1HwO-DcJa?bx~6=ZfkTAMAh@?XijwU=&pODzn(v%^IzsXVl+hS#jkb;@Bu zx1FzF{k~Ysz<2cC{?tg3t=2pEofW_E^=!#54E@{*#CVBi8*^CAuNoX}rwAE(d1 zA8}-7M&=@o^8OPBYd9^_)WUvqe7XGZYP^%-`FwB-Lc-9}2y-;U*vJUno|r!211n2C z=%DQP>t{r#Y0Gsn{0Mmz;^}v7X~?9YHETaPUTSnsDvNxU>{PU6_s_2{-OPVTomnS4 zb*{5tv%7GH$*%o%32}G-eTd6>_e;CJc>725`~Ca#^Vi4SZMo?7BktAmq~huuM~Z}h zuYAsaLEB7z`}1Sn2`EsX!{-JLF<^G<% zjq--PG4=cYzMk69``5R8`@&=V_u~($O;kU-#`gDKkM_#@oxA&gg9K8Pc(bIi5?M;6MZ1WA9dRUlus_iCL zowqHY4k@TkOsN-rmuYrxUcr332V-d?fvZe^qWy_#wZi|+}muBz4E zo9e!Y?>VE=hG!bvwD()bybqZ%sh)3zf#S`X3pXvF_@-iw*A-Uh>z@=#Bj2cY@~gM~ z&RMYYUy04OyBBU3`W~(fd%C>q%F#1hrnQza1RFWCSW>56;Jow0G+?Y{nW7okmG z{FpP0*VQE}WTqByzf^e`V-*=3*e{7Z$h|=rF&S)FIgP@5>{rdja)T$A3N8BsaA}Y2vgAs^1wdmFKN- z(x27$V=BAHHTDPtwyKWs+{A6qqZi*6+OkP9i+_o-*0IGZ-l~efZX9apNe=6_nE9-T z^EOCFnOw`ETL-|BW#Ae8q4A5Md2LrK7sbl?%e7ZPD<7Px*B_ZQ~b7)*syQu z8!z@H&7C`?Vdcm0BkuB>enq^zC)&N_Qt-+jyA)nt$lQCm_uV?zO?w|-;Fz#Q!`<@R zbW4GaA5y;5n5bNAUwScLinsOu@`C}7jvjpRF8|~sr-QS6-tJr;w(yC7#|?#>cf z(hhcKUUpYId|+aG(T?Z-(;k}C^I0Cs?8xXio_a3v!1eoLDH9CYUv9j5`Nm9lqDe(&xW6lU*q{D0VH^5GeUUVP2z7k8$lI=?Vl9;LA6#<%^8 z6L)M{$Xa>z%F_uu@$zxzb} zgP#}F^8L>~IAZs3WrFOVc_$hAp8fX`Jo2*Jh@*b(ix-=80@>JSbIwW3v^pJjacU!D z;*Yh(eQTNJAN3i;9C)@zD9Cp2F$Zl2QRl_t0?VGSC}Vo`W$&{1hUO;sc`<*uUY@^k z;v3t?b^nU0zv^#`-#Ah0Q;3pTBhwvb$LC+K9zS3IZ&`z9!M6v`C!K9pTx;I7H)ZS3 zg0KGTKIy#oS{ldlsw4a4j9%7*9E~3F0iu?UM?PChJ@Klzbb{IKZmH}PK_%5mUsGel zB+LDrGf(LUW(cTGyv)41uddD4 zE6FyV&73v~^&-pI=Zao2%wXUDJkeRIFOm63tKKwcj{GB^qZT~6!0pI+Kr8rXsaFH1 z;~b66Vgb8K5>odqT(0*0|E9lkr@Z1fJ!D{F5w*=eEb#t(%~!q_*<%mO*gI+-O0mi% z7f$|LTfOScQI6!UAJs++U+4vN{k6}U`SrhtL$X=1_?+VI+=cc0YFP^v*w_?!bLM>4 zP~;W)6eO9S8nIE_d*g}6XYS3g{ITKZ)|Lm=3VNT{M9yP9!hLTd|BctlZQdqNv;Z=eoS@6Of#+E%=Jqh9pV zz;|negw3|v_@FhG=?gWi>*w;HIijVssF$xS``?t*%CMQHFQ?upd+=W2uA$}RCv#5D zf9{iXX6BI@#*(v2r?s#I2Wc$RIVliqq~RfO#%Rb?K@AK~mER8FeaJKR9?TtbFbEWsJzosy`URtxO?lq5hoG$ralhxDU%|64N^a?ehPR>qK54(j-u6hC zm$R?kbZ@5!@20&{Uy|1>V^uWNY?hpSY)<`^;uy8`m`g$-O`P*=6JJ>@RQ47!JYrtN zV^i;P!pK|R|M#jl?{9isy_UhuVj#KlsBPfH^GC%bwgjr%iSAv%!gzbxRLN~={F(yW zn~nLK-zT7vBPr;D+%sZ2_5|W;YsVtM(=khM^Tb_AgT2$gShoC&hf^80UO;47qDV@00 zo4>-SYRAN+Z!+w2le=Aa8?CPJZhkW9;3*TUSq2x*Szh`1a@i}V_ko?io6Fc@1Y}i= z-LE;!`XHCHu%_hML!mwMls^ZoK9kI4>3^Jw?^oHX+%@%kU#v0Ma(&LhV40Jv#GSuv z;(5G3`?c-zd0Z|(pS|TZwMd^X_DEIzT0irz)+V=q(;EA;-gz~@xFEk?#9IHFk#c!L z&wZ&MbKcvQukY}#*clr=r^rCx`aw!b`Om1|>K&2UM%=}Dt4@7z+qNO~OI{q0a?G-C z-ub&u#jbIkHYcqmrk@1>R`i75RhnMPqo{~kOL376QOA!DNx z_T$YuA9sa2KO?JmJ#$(tX2$ll-ckAmE2H`eALZcs4CxOFqV)maoWqN>46jM13RNqr z{O7jKOw|pfd+fJvm-8_0}9-Q-n6Q88+>nRYc zdvV6ExRM_7WgCkL$1u%?eE%I3z9#&ys_S#l;L!YZ=OD9di|+A zS~^R)Y|4|m<|<8kJ)aKMn@{a8kW}-`Z5!2RTfwRT@XShl(K znv1HQS^qp#8hc;nM_!)KcIoX~YbgW%RRTBauRs1TIHO^Y)FhqmpgG@}U3VY%5)Ty? z>ejNbH)vcN_wf?{_obe~Y2J4p-ii#h)&2iC;krrxq0B7rvNxLH{<0NK+!x);au+F< zRLHVkH(r(VZQ08`#uJh)e(swc=)KIFd9s(vF7Z_3c=ao)32GP9+*}RCKbrpQKK0K! zYiaw3!g_^xmmt&i9*a3Fem^q5CiXqaQ71nB^uD`0zxg_JE<1H+@olB%mut7!mxjDO z^;S4mM*mdqA$I+))WXjC?@3$#uq<2=yw1>#k#DEk>*Y6gM*J@ike=_H%XEF-je6I* zPpu`5MlRtCj_qcB%5mo8QKy&smyTAv4Por~;P07e@M&3$zER@616MwH{@Emz(6_GP zZ-UQc9wk<>iD~*j6b${jA5b|p?mUZYF-;xdocB}x7J?e1nYFj>ry zynXZ3yH150IVQjE^464o{uE!cRet@Ato=!=<)1y@ZXO7Bh%voq8bMOjtcHdk_kZ@*t&G~<@FcT#)zdb1em zw45D2AyERx^=JBAmR$>t?n@57*!`4k;jzx^(`wjuOMTOpy0LcS(`)x^n&%ho)7vfk z_icw@IJWG#E!pGM|6U=>D_K&>(8CyZa(YO*M08->L<_Y|Jt`<#?yy8 zoh=_dn9iwDQN>!A&-&+hp^>XCi(2iBS9#B;&8n(u+OzCgipBIrW{q9borCkDuW%fB znDJ}f%2jog)Hv@^Z>H9OmeDv@<$?{qbFktM1lz`S-6~bY}4Y_li`s;DQ6m9xTIQM zn3@tKc*VNu(W&E8)NF*c`AE~2up0j<* zeD9YQ!=o9kzl{zpEnts_dQVPIxy3H0_TlcKC*9iOPEbH2(;)}pX^aFPlH!6?ipwBP4$`k<8EcYa7%FH z=bCaYDz<)FYlGLhJAXpC6$m`Lt)OzR_>E=31s9S2=B~o0cUJsQSMazXGBd?z#v0#~ ze+mPa%~w11r(XAzz2Gd%BWVmD4m?_DBJkA6lr`K#}RS#96vks40Y_@jqb$UJH;%gP}boZ}! zbUr+K_R2iE^MmM;Qcu2hK1&bCa2&Y$@zq!9ZMP1(pSac#U-k7~gWSZ^I}4rOzPfsK zf3B-&fSEG0xbloo8n+8h)JG*9;|e=*^zzO&v&JP35%K#LN<9|HNL%oU?ZtA@Wv+#47fKrNQ-$F#sBx2?+`IvwQ{4~*8o$$-k0SEY{J%D zw~2rM{>9&KcS5h%^orIC`RW9ns51WNnzL{E3C2C_p;KiqZrHlSEMndKwyHx?;`URN zYZsh7aAcjN!sKPg*z5AEOAd2<`gb9Oz5aFmp(jnDzCP{0loNMGgsc!P6bffMR{j=Ki5}A_ zXRWOxXU`Mqk=oq(i0N7BjJBeD_0@F}uRgN;w_fv?>G!^O{a;N?L=D$B2)QopX7e)V z{mWUcU%$e`D^ZfaKBw^D=BX2ANoN^o`7hrkbEZq`#iQ4i8Fv38!v1d4v~JJY!4ajo z+wgjOaNKpS_zm^}+s;;~^zgSQ%4J76-dx*yEbQ32oojx$MEkqmu8I>sBK6H;>g3F` zoo7BC>dBH~`L!m!woQMtUG;@v`-zh2VO!5`c%M|I6?CEA`JjDZ;QS4@56GIAS^N3F zJbU)r;gT2MYu#J2F6q__|6X{DM^3 zPX#j1-DYz}<#{jQqee`SPFr3fxndWIk{%ugyLArph}t z(zjo5apN@a=2x4u*3_#<%#H|OEs=4iX{&yn_3pNU2i!SrEspzq5$Ts&#nTYk*7^fH~jn7_{YN?Azx>~`z7aeJoTS!KV& zUTNy&hX;g3IOi_<{D(T&7i^+60JtJq7X z9!p`IwuJHBuGu%A+r9PKU&${m!`b$xooeG zi5z=-lyOFCK~RXwq3BZWT}gZ`)T2s&$Riu zX11qH2`x1{E`MxJ+_UHB(H%Kn3H!=3zvuiNCrx5>4Bs@}Z#mN4hGFIOL5kvY9`Ugnmyt}7U~bj<<}%+|`h@pSxqyr<{$29E=rzH&Lq z>G$hTYVjJryU+FNQ^0dh1slH3j14#Wet8{^@|v>h--|ysA3a(#jrZlBPRw|9@YlU# zcB?n7P5bK@Zc`^4`g9G$Q|4g78y;tzTd#4qUW@SFQ6%3L+56h(X4ccla`JO7Pt4f>+le_S=qux>f!6uW>r(y-Q9h!^2zhpAu zesOBr-wvjodPdx$YtJz7y3gx&Ssus!tghJk^^KLjOLo+}3E^DjHJ5Fbtl>>qdB%I=tR>wW!$zK>-LF4F~Lj95iy>^{0=@si0Fe=>}#r`@dI|H*WTy87ci zf>kg2O-^SVI>J@)w5;`F;zpmm-(11ob6%f2zSi=4y4g<0Ag?{U43Al~Nd-Om)m ziHS>kqQ;p+79Iyn#ddK;bA)J$m^~An5KtkW)FXB{<$Afmt=Zdd@}2$ZQ9OOgr4+{= zkt<&%d0Z@KRLgaIWzfEO;msX(>3Zq%-7KPk++XaxL*`x8JYS)_@pr(j4bhht>z=I1 zF1N~9yI^(J8B>RE>tigAU+t(ivN3Ctx$ODy+nsIenP#>|ssCv{65Kgc_wLsNUlwdT z&eH9CGS+sguk|gj&U7Wg2HhK1i|>TwU2P39-@c}#T&dvDMoGnso8G>;kZjJs>64&k zeT>CErYYx7R`0tfQ~zPVP0cC)f^U}Mjk$-z5~c^t>Uq5Ah$9=%){|#mJ`$5l`IBCPdF zt0!3UuVLTtzV=;Np1J#qf4zbSXMNV))+Y16(quXFvt!pkmsx#z{`X)cKg*Igah;xR zr{2egiR`?qTXQ(*n9q!42Ik!P%Nd!b?Y%VZ@=FH4`R>ly=h7U?>)$@>iz{ECd^e++ z``)RAFP%5H%ZTsXr^w;6xT;%e(QZN32$c}6*|qC7?PRvO-ImuAq;SRTOxlA<$BL~Z zZ=CyASNKk=xW?^#=)>H7RX!_Te+st0CBIP3_S;?8yZVC0yH%u5sY!46ap{|lmEwWh zj$dxwb6Go6C2WV0j*`%_oP*2ig(o@~9g$29nqPsP3;+OvXRpI9MX!_c}FC+Zly>Co7 z^N`tR#@YuDCat@$J5z#bfpg(2MK;N)2h5AZKQpB@86KM;VEJuE8@tdf@1;t?e%I?2 z=0+djyq)hO-d>>@<p5@9f>=D~n%T)V8~3Rh&G(=e)*_t@|a)b(XCX>SWpZJjcq<><2F6`U$%wH8YUc z9E4=nl%;B)OYLNwU173o|G!-uk@B&grI0m zas7=aoZhLsPA+P4HT?3%{Qb73yZ>tb|NSCbGfCh6p^#nu$p=#f|9vy_-1go(cDi-! z>xU1&`7OD)&Gvw?<~C>RDW;{ex88-N-S+xw@vBO9&T=2IL%pl2f2{~qxIg{w;oMm{ zH{Z^k^7GrjC3iYX@80W5`R!=#{%X~&U$)<-$exYg`rP~WinI-nLsOmg%gTB-hF520 z{(g3Q`uaIJvAyLxZk(N4AAL_Y$F7q*DkYY0SMD$IGW(*P@-q!2eZ6kIuG5(9)mkQ3 z{pydFNyMQYQxj#!ipIp`K-1*hFzCU2SufbPF-YU7fzi+Bt{hD`o-Z%g5 zmh2bLy3y|T$g+FW9Zt>Kkh9gHybpdg3SK_JY4mAR#It?vwbonG3#tTj`(v%+4s@#O zZ+rf!(Q0LDg;zUM+R`uxL zjyG?9^m%@KmE8BdGtSS$TINeAGHmk-ydOE0MPlOq{<=3;Bm+1E+pe{q|F=l1w!+~9 z*GeNM?stFMAk8|ZawRh}UGYy!|%N=_gyJkc7cb)nN%Qb}5E~$uczVwjFF8PuC zqv2M@%i}V~=TvdsHxrsB+8KP_U3+rAQCP~vubDF!n$P^aaKkXTMcDl+@PfEcuX;c>n*tr*jUMm0EubV@+M3^V#6qiv7E`&9ch;eMsWw zp#we7X6-%ZT({9EU$35Pn!5Jqf1VvFxexB`>e}~|ibJP6JiHWls zWZV@FJGm#pCek%l>13tfi)rGw%gm?jG7Mwho9w@hQUA=n4eR&nyl9s{_Gn7##vgku zrfsPCW|drK!0snD!{Ld}<3Bfjeru|Q)TbOx58i7X_@v)ZX@T$0GaYuWzuu*&NpAal zI3ms9L5;-Lj%ib#d#{ZXsM)7`KDD$-wIua%61UDi{%Y3rKqKA%0^7bT?Yb25Q6ra6 zjm?tzb&-&S&3caZmev^y8rkOmdD$_?{p4o>%l^mdZTtKylTRrfSfuT7?x|AG!}l{d zl)ltE>%4ByTXSLih0=!${$JJZXj6Hnq~hV{9NFK~STyhL>NNjeTLZ@hBJ5W+O9Yf% z_o<3MVLqOFe%h%cO-mQ3oL5+DTK80`;6ks$MDFzct9$sT%ubbduvY8((yv-0aBXqK ztc{D5e!Co+ZalAh`R5rH^?t{=1h~2XD@khvsa?8rzy5%-=Jw;eWaZS&)D0bX+uRQO z85n;wi*bR+ztRuL(az8vkThdik&mAxQy$MaxMq^d-8E-^ zT)O!2d?e$AHJ@%woj!T%yVFazZ9OP@TfJD7d;3DwpEBJ4-4*IZCo$9qE4W?TUSqv< z!?OMfVHS7Xni+0=>A0J&dF@r&W^q@u=ga%&&Xt_IJlik#nMtF(RNIz=Sw3D?OXoIm zXxgQ(ao6nCX^NZi@6$nt-6vKSFerH)t}IcxwB_56jGxcG2)Tz8T<%j>yR)(8a>+^e z8SfTz%(X2~KQDXt_%iqJvYfA`*49^NntuJfcFX0rVmEtCb6zalB5kKp`h2O$y{P)k zvtmr4GQ!gsQ#brcxRA0l@x}eE#~5T362;S4ucW3O>YuG(vt*K|;l){(uIvr?!x6wL z-#=YJ#ADidvEL7utQM}lYIZD}lR4DAE2C%fq1z9yY<>JOg_Z4gw5G^Xzbo(mSa0p* zs-M7trFS`nw*cK%pxUOc{q^|0Ap`cUtgr1)ir@xxd zS@!!rmr5;XlqO0~WM5rrGyneKjR)>nn{2#z<@w8M;l62`t;{)Owrp?<(){q? z?cP+U-C^wy-?`l5Q`&n^J8PyfTVwhULl5>p5>?vuDN7RfPdt zb$7f`yIxir^!mlRBc@k*R-|g}ydv{k`(pyv)S?Z$o-eJ?oc!{Mo3MXEnAx|_x(QK| z25Wb#FlObI^QhGKbl$d>bG`VjH_(?ohU?1XtU!qgF^v4#y^Wy_Lag`Z-^gaKUOdII zWY3DU`nO}HslzgC-<;l}&Y(8Z$5Gv z76eTwR5yOZmun!-@VZ;=nOU5kKhMrx{KmHxH*Cn-ST3v3&U3We;26IV$I&YLIV(CN zc)S?c?+3frYicL_FDs*Ozfq!Pp>9j%W(*mdb?#&YL(msORdR~TE_W4IdiMjbU!Jv$px*+>+RVe zs4KDDvTv^P@s9A)=)dWqGS4h4at=+>sN2J#cu}BBMKIj8gDvd8QVLhlER)mqU6F@` z)^asYYqNPjXM>ZX+wPe^)n^tG@UD|Md#CI$6;= zxi6Jc_C2M47b{AeP4pD@cQtS{n(F1(Uw^mO$Lmj`&HIq&@fu&seu#=Hl$Y+;pIeq# zp7H#RfB4e!4RuVGtQqwel~@^Ouij+k!+#;F_#Nx+{R}%p^>FwZ>Iuv~*{^~-R z*NI!}n;tM3ZRFXc)YViRvGS@)g!~Sl@5SM!mu8&(S5`kec%Ibhm*1qUI`}#EY-L)s zHhb^uEt+LbGd8K7J5?a|;zs`|Auj8HSfQhVUxXJp_FZ+T*{dFy?7DIFQm4lS-6xY% z>jnQV>$;M_p|fs%Uhm{%Nql}=W`>&9uWC-XC$x0gAC>wQe^TZ-OuJ?L#Qw;V?ipfz zmP<8D118HEn;hVuu6J0x_*=N#vMJ~4oU5DKUa{AjO%MHXa^;rG%v-n3Uc@u~Qt9UK z#bz`5Sv?-Sc0QrZWfsp6bMVBg2dv(%um1iHKXdlzll)cLwm}?!kA0l_v~{!8qn%j{ zzPUS-;-{LPEJ|`SY^>+@k~WV2Q{Pn|IO)KmOFKh+jPA7CPph0R6R5G9-Fn9V=?~j8 zSMB^V-SHpeJf#^WmWPjDNa0vAyLAHdpVzb7Y-XNfvNo*=ShbMXz3g}IRrc~Vch!C{ z_~xW;YS#X2%C~c)M8$&i_j6aoU+PehNxvCiFM%~&kK6Wb z_!{K)b=vfdc7`R#L{zPcZ{NQ8tV`uzy+!FN`>kL1#p|5(8POx7M z*pT#3ZhEqxdwuD|1Ib|tbrQ~c6K?scT$=pr-M?r1^^b(@2Y2C^4UJ4E3aIg0nj0Y< z8DctpVKl3DePFTlPF~QNp~=4sL^vB*ZhlNrdw!*S?n_@|Ke<~~pB~(pwR+jQlC4j( zZ|#)7&p*X%qsr;s6R)3i=6RcRGT)Km4?|v$i{1_i&lufr=DSW@ZF#g}i}lUIt=cj% zlhj_p>G`2W^#9@boC-jhHM^!sE5m!LnO0YVHrkQhClT9-# zJE6*S(!s_FIid~R+UcLKzfjq<@bsIOvk`*Jri;u{@hjTgsiq!v=9+}7*3B)e^jhz{ z6PvEFO?{R39HnO(XEk{o8pGGzT{yve6&t_v!C;;u!RgMMvZu!OZS~yY_O`Qrmcq*3 z9@j$(cWU&Dg?t)C&r~Syj*Jz{q^;%|?qN_fPow1_Ea*;EZ zCCxB!$hGs}xDZt|Yt9^>W$*w0K7Gdbe%wEs**^Z$yRYVK+_hOEjpgUhlq$R3(f97h zoqcz0;=Of$O?Jb=G0e_!AK z$M;+5TK&~%7QJ`*d3GgT^?$bfdU*F$k*T%i%zgIt(jT9{x^(pA%WU!Zhxb#e*c#qF zIpTYMLzq&g?K8yNj>nzy93UtYtx$d?v0JxJA3UN*0}#?XU^U? zzcy;;`2@b3OYM@x|61+#iPsnN?kU@NZfaY4`mJRKGxzQOU%w-3|9_kKKgC9W>nf{l zcjq>@^Iw)vjGKg2xrU9!SF-tF8MC$XZV!P`nAY-^aR*3bTVZ|6(?)8D<@ zxBk5Q^3${Hr*H3mU$-x^ZqJ^dx%+m^tF@Ya|4d!J+pVZWm-e^(?lN#%VW+@WEh^Y8 z=Xhbg#?q?po;ugm{xznP>ZjKh&X3jip7!k9+>aUhkGH%}J#*Y$e%sMR@9j%F{x%v< z%WIHhm7m~SEt-5HVyAfIgu|8(9=^&^XL0ekQ*lP}%(SH1d%HN_uAklVcr)|$=c(*D z4E&p&SM5vMp7WdN6KXsgc(r7n1L;srflE2)GZf8m*8aia^ zFw1XyIqjvq+l#OcdyXfIedmAL_i}R0+?Vogui460Gq~NkYFgzYXOIwVUi8BFTa!=6 z{0O<;Tf2Yvmsb?+i>dhbG4X^QKZoMk%~N&iO)H$%sT?Ud7bZH9zffTBj^Eeyt2I@Y zHp=Z@T5%$|e2PlszZ1+Nsy}qTJW5IInKMzo@XjBestk0d=F zXW?Mwm7+4HUh|ccMcqqM{OnrKI|O~XmMX#J;?6ROr8tXSB|N{kVWGpR3I`RI`2wuj z3Qeht>IK-DZ!Tx8%?Refgw#rSCby_n3FTyV$wH&Z#2X!cH*t-V)irIv(mJvsXX!yWpoW_rlYSm%zwr z?uFi%lsjjZ?F-6Qu6+GkV6%UO*w)zSt@dphdlI(QZ)hzvO0qhjQc)g~{zF#Ks7hf@ zdU*Ygtmv;DCwaFtJnWF=d-S65VWy11N%7Sk?XNmm+O#LBnVnklMs2-UG*NSV3?oTUr#MBm7{(jA~HA|A8>zkAO8q4*Mv@4id z9X4IFlyTRRKlbTyj$!mf-@7znu7^NsqQx|cV~3lTyjgscxi0(L2A|1N z+ZdES=T6s1I<7w@ywmc+;fnY_gK)#`KE*+gBIr&fj(U)5c4tOY4rZO!q5oP*OI( zxzlaGlA^@}S%2+G3SV#DRN`v-l~G^mZ9Q2%LL|qa=X!y%Erah)ur}K-@f{0?wX~2 z?W{6Wge}rJ_ifvpJH?4N>cblUH}{@@|NOu9`{bQh-x^(8m7F(6P_nG6(8_S4wCWdzQY(cG2m)o z%A3$DD+)vYUduSbr<4495yQdO{U^3+yqDP)e4tbR?Wx;>^KLy$oXZj|*^t0$I92_i zP0t5G>2Sd(`pSD}*Iuz>5OlFIs^25QXkBpNw^M-5`Ox2omZ;5_kYj$W;JkPZ)6J9m zv%i(~G-YYtST4aR%3&@v>uoUCh4l_EIoguvckm=xM0Z`=o2LsO zb(n6KYarxiV{k)f+c~+n*Q$aHiscq`2)@l;9(RTKY}}xTmgIY;+}1^3{qn&#Kuu zO0T^4(7Ai-dZ62px5iyhm^T&p9n*fa{j8B-Xl`cgoi&@*6}|mzl=9>fcghhzTj57b zZdC?-eCurUap9qb0WZ1glP62mAH1^S#gf_|$27J%U0#;C{=Nv8I={qP<+vkuSx2-| zvoA&zSs$>7e*bFw|1;~u|4VG1$aZhh#;FBeTD%h*Q)J#Q4ixD4B06`=f98{czR*)f zjG#wXFq%&n=w{TazZ&V;f9II!zSrSjbniCIR*H=2RcM^oNblIu=nw^`?t&Y$-nzo{QvL{HnA1G&n+`0er-8W|1p`>*d_MW z@!h-5@~o?<6>t4K_wWhMzZZhyW~5YBykI%#@o{n8nbQmJy#0HjwfB7JJ%0DYcYhtZ z|4)heeogi9-pj?ut2e%9$;&A}|MX9S-{$Y34^~**dt>{w#qrdV`&UEr<$kYEZJo8A zBgy@sbV_io#o9dWknY(1Cyg$D`4w=Yp4;w?P5J8XgC+6nH>!pDJ-JytYuD-DHP733 zXx%x*=RW!AQa!78dyAd7uS;2FsB6Ay*N=wRCETCyy-NMLO7|qR_rPMzC zGhcYk*);v{@dn$UhpWufFf{q#kaMy$@yLreht_&F?KZe$wcGZ?g(9Vc?Wek$AHKgZ z^Kw9e^>oWR$pG`UFMXzRYTC-|`*CC81>F}jUe1gB`OUq4XSVr`*$3x-ocQijrTASX zVVkYB2}d<|tzYoI`gVJFCa?d;Z5J3?PexsSzCS}yqvzt*XD(IGcOQBiHb3>kDb`u+ zldr1Ym9cUve;OC}Qb#)KuJlfqW$Y8*{%PqvS?{E`-tNte%|8-t?}jYBy)UhBzVCVF zhIy-Ax4*G9VYm5;uBq_O6R^W*Qix9oqB*pQ`J+-&2i~R-bVhQH6JI+ z7hOu2k+hrr)v9&hF0`He%okVOEa`A^Jxj9O)aX8!+UUwJ!f%5WE?0LSVovxXv|w$> zf|=#!GyYDw719tKx5+ks=Y3O#%=aC-fRS^d{KGKv-44PNFR3m#f86tC?&yyt*u-GxYAvG}!>YmbyNiSB)2!tDKV zvu31tTHV8(15&@t&g)G6y)Ey8*xT8@+Hv2mT)T9tWMX5`w`umvugxfxoEu$xCh`3K zb+Pd~I~Ond@YpYWX+zh8@Ac39z6V@yt=||_buYbb{v)HSpY=AciZ7WqIlAs(^s&C# zKgu4Pi$-ZLQm^%6yZXD)IwfP*1HWa~%@S+>ltf>PJ-;}#w`O+{d%~{k56r)@FR=YI zV}^I%ovo+0+HPi0UF|S8WvAm}wr-~g_?hNSa-Pc#b36<{>NnpUChK;j`RT1U*V~@;D`GG>)n0$@)A5Q!TqkC;w0!LRaJD_* zYUmR&!;T617A{VbhgIe_F4jDSPG|boSJv6cbeVBW#lFYw4-Y-){HxWXk@aFWV=tR?(cNshqZb?|I_q@ZijwP# z-*O>M;lhDqrlNMD^}QN>C(IQyvp3G2x7JCT=YfpQzCd2nN0#!Ni>$ftu71cngYBg0 zH;pNKjn*ggu%4WDb54@9(6Neku`R1tu72#{?L6~E)|r?C>sRh-Oxi!gMtg^%DRY2$!fUR5r3oq9s?(_7!mfpzZA zQF|t^?ylT*hU?Vq9d(H<-n&G%ZDF&iFW)G6=hLe?8HXWikrpbHkJM z?nG;G@@t0AY;C`=T|#+hCHpVWM22%OU!CC1{(6Tw;B|IH_$R3=?1($Ts-D{c4%O_?YL=lgqDjDRs~wCruvPgt~8aQl?0wq1p%xTN*Zo%yl)wg=bhnAN2-IlgB1#K?$ToaOcN zqs+A>A!56f!{=YCj}>w_63;xhlC{5z`=IZ?AFd08ou0mubn9D~k-dfGm_O5ot@lL( zUmVeI39A#Zni#ad{DXGDn{F%lWgD;V{QYIdtD{!#Rx2fwCI#*D?OR}ansejn!wvGw z++DatPjf8aamLSOujWji!p85$cMg2N;57fJ$7J29r&dOO7JqtH_w4+7&MO%kq|$R) zS>!iX{AejSHTPg=k+4zLYqPtouakc@tDgDsd6tyJF+un9vkxWh&R8?^-_xUOWojN) zJ-pi46e$1UskXY~uD3t$b&L1ccXy|M4Or_m`P1AR^8H6HISYB3vbrYicVD$5xqDOP z1pcG1oeysc<>J2L9e!?}21g+8%lP`KYabj4=v!)7WNUGM^K0%USB%wDBsedq&&lS9 z(O-J_`2A=u&kqY!kH$vuoiye@TPJfORc*Sc2QTjnMRU6+Q&ky5@?I}H8_w-ia5d>q zuV7=Ni0rPvEByqHCb0jU7~O59(4+EXvG*TY_1b4b6Q=!|DE(NT`;+rV{yL5m{eNBW z)Enun>X{fCqu+4M@tmB#Vx7L%5~k*4o~y;Hax$V1&no#RNZ$ zv-;b>tzy)$QO*31u;72mxx90(8#RiCTXk`7TD)h=LU!T6B}~HK_@`v59`s@?(O57i zBQn*XRJ-eG|EaC+XT94a4)Sh`U2Lqwxym7zQ?$hfqd?hRP^*1yy~&%2FwkLj?GBsgw8qbt zvodJD*`kP0H7kw;ja%OlKxUX?w(aG4jxr9bdkGpRx635zWs>)B*ue1auaWiVv*wG%%kS^)FJJyKa*OrbMR()v zf9~5?{q0fithbLebQT-kyDM9sy5;m@qaL9ZS9kLt>~~u7d;Yt9bDtkz+1dSgL%mP% zL$wyA=@%Zmt=^X}7cXu4Xo`6L=8~NyYKKf_wa?2uQT5%#XVR7aiq`J8{7St{)z?BQ zzW&k`eU~`dKL2gdDTB#})+bg>PqBO=kX|@L?8DT=SyN0t`CgCudvV_r<_2lg^y% zU#IV}&s%qDaoFm8tF-P$m)`&Iv;OY!zy-5B>-+V$zw2-B|7-U>_Ik$Eymzk5;nB5g z`?Ip%oVA<%{iN%RnD|G5{j;k-Xl(a<^<851!7tZJ-ah-eS?SEDJNkdl3i3@}`k^ZA zNRZG4b6&UHovRn;-?lyObWopHcWTzEm4Q1%O}{vYXU2Z^$~BJ(dHjX>*SqgZTx$E( zbSJW`3M;r$zt!N2H8>-(jz9x$N1eHOjg2N@U;hdkV6~ zYp-4*tKWA2;;dy0ldhWfu3NKi4m&#wLMNHo9Ui@&n^kLDmhI>|9EIKT79)0o_NPCr? z`gO8EaEro{^G-gG-2XfX`+eR}jlWyxH_x#rg)^pq{Lgt}$$sWzF^zAwJF-1nVieod zBf{C-BQlAHIZEclj&*%jGAHU!xNNxT*q_;Jx@zGm9v+Knjf}VJdoFpjs~a2$Id*VC zsPEh33wK{gaOGu|m?pJmzG$agu>B3i`GRkrl-v`#-k862QcEVI);<1T8FqP#a-Xy^ zxc58^{4_~GY+uUe0EOn2D}(%*BkiVm-d|W?8opzZ&gTcB>leOYzTRZ+-k?!*zdo!n zH~Q))IgOoPzlF~^!pgbjj!lrM!%gXcq6{JN<=>lmX%E;Hx^`J47`+x;Ng?ZdRL z1N$FFAKIXO$a(2|2BDV|!&h&6Ayg52;7Rpmt=;|1MdlZ-$=1ey*4`yx+QV_si1*z$ zhQG4<b?3qeg`)vYnQ8gEAIH#H|u?++5Tzw^?M&|P?&pJZr$Fp1s1!k^QuH|X{V+- zoPUzT5h^@iOYh{)2Li71SIvHLt)%Wgiz({~=i8aBN>hG2%eV%9_lK465{V>?G(Qv_E;lKuIQwN zmC)0+v`(d-uE^L6EZbAw%*zVfKRtu%!-2~N7R5)imE?Dyv3Vk#s*v}BO>c){=9KMK z`np#Px9w0*`FE99`ShfE1L2p?HE-7ID;Ry}<@6MMrnG;ezz&|<2U+#ASN7!Wy64l8 z^tp8RH@6als>GV@;pdfY?!7Pg{IBTF6`nggcI-4?C>!0hf12HuXNztN?wOoa9CgI~ z@t<2MUJ9nKIe%R~#mx3L@Oti{*?a51i~Ws$akoSxWs{lw@f`;~GwGb0m#9#GU5UeT zL&FKj2+niUWae;W^+s=dk~POV*}1{mnd8}?7VZaU9E793H$)iinU?8pTM(jpV=`yI zU&zd;&!>;1?o!e-zBJEH!|F(6#Hra9{c=|fxgGSbY+B@^yy$qerqe9z&Ogz!CQRR~ z#jw7AeoL20xGd8b@`!Yb;*>x+EY?%y)xdGjcu$73@8ORp`{D$5>w=$Hw~ zGqp4*FbK%_bm#l7=~vsx7Kp=CfOf zE?oLRqP}2v-rfnPHJ9u(|5)=-Yo*<{Rgcyg|6C`NvLsro@%dJ^+_pD|UC+q+v#2;G zFRGtaZoB=wUW!y#MW5Y)*H`ZzUY0-ARU$r<-MD1Ca;^NiHVr1TtGkXLn7hE{`#-`TJJI z!=Bu1K96mJ9ai$cLk~MZ;6)x;J zw}F%I-h#!~nK#uN6s?|gIQ7j3m!-?Jev8f6`APS}W(Bo?&#zZ;9x}VJ{?QTHvbC|- z++rL*Obz}p{rKt%z2^qJvjq3AIJ*4Hf{Ba#1Z{YZMWqW|uxOmid*z&Bfla&ojTbTJ zrlqADO$k@}?%wog|G^jbwoe~)*PIlaBf07C;dx!#UQ4I`c*3p3^Vhguu#7#_?uLir z4UfD}EGgT&S!7i;W4KrIrEy9ooV+uU(PVDyi>3a5H7`s!ele!fe$$4Jrwld4o3!e( z)MJvj%@s}Be6;p*5}yOx=3j}XoGe>+o$=6o?xEKi;Pc|!v{{Y|6J9b$&4`n3V9z~k zFDs}K&S-Gu-NAP!9#5a~Et9`&LA`<47q)Zr4x5$NX`V^GvdZ!MPZfQJ_FEFacdQgk zo#9zId0X|j>ATbS7hDl~|7ZutW|4iHc)Tlizxwp%u>Zw%ZGHjeA66fIcaV4Q8x?Jz z&AbWK}&(?z3)edDRH}cHC%D8G_&c+j#-qR{y zKd*OtzH;NuRUe-hcrz3RwYmPA%{0MNMs4Pw`5X*$;%A(G)6Lqj?4Z#DlZ1UCau5G1 zZVNudG;3Ml=KoWbcvA}(%N;A?TD15MLsx-3yNc_I;(d>0)9U&2uUsgxTR6e(Jzsu@ zbi(1QcQ3nK4*DH+H@5GHtDX7InNy5anir-R=pC#%QJ-)AZI=;8Im@AWCDR?R|1#;i z*Ob_|MCjpViIa0ydnY-~Y`JMKCbP2X{nrO~>Yg$E=9{tmlWbmX6_1nXclTr2?^b=i z_;ik??93fKl4Uy*3M*_BdYKMZt4-yYf53y~?!6eF#bN)umc%uC@FeH6eV-FhcAoQo z_qJ7aEc+8yO}y__FHnCVZVJ zvpzHL2)^H&cFtFCyO}PBc*4{}iZLH2UcX&+NUlQu@B6kQ=INd<&DSi-S=W;1TG6dC z<@$fCbMM~k7PK-R$yok5&4QmTYRb(?KOPw`EBxT>|K=QP9miK0YoU~*Iof~c+_?Sq zzf+y9IWr%3Vp{4>?vs!H@Gsc&@8$D5)t^t;e0?RcFR6rmkJ!u~SL&uuDVX{1OXHTO z0?T)AKXvDs9PFpvS4V zWoM6{udZNV4GM9ed_!E2MXq6c{*}+W!}ou>x^6#b*zV8`zpnrI^X}cVpWPnoDh`A! z`0*-lw^#78ls#TdN1FuFx~|SHE!)4hw)*?!v;5`e^>+$xNUpJXQ{OqGONm+YP-xu! zJ(bdHxFUXMiW;oEbhWv0P57ivmqRO}_U`+6{?c5Teu0x;E^U(hvhFlnZ}{Q98}|hZ zr+pGRr*h$6nerlrZFkxZ{`$L?M#-?YrYbHJ1zLnE)r(l`VpY_`!?Y77==x3<(_ulm}yCWIv{iJHj%*x-k94@Khv({`=UVOxJ zhh52A-TrIuPan!y-}?U7L&<$hU*|@LzFpgKjem>Wy7%&&>sar;%cwYEWl?b){b*l-4P3a@6oP*|IqBP)cgw_FZNs)TYTFh%3k?% zl}7vDjKWm+!%q1Zbv7rPUN};HXIiMct<;9fZ}l=St0eB1NBSMJ`Etz9{XHw!{#zX9 zTx5jh_HzsRDm?3Ri}X)f;Mh9-Nk$vrGwugHBCnrC+?T#~tmbas%b!J`{iP(B7d*Uh z>2uuW&kJ_v-mbs8>xa<&Wo>up;i@z@&y;r-m_Sx@k*L(L` zzwS+X(08n>Cu7!&WgnY^R9^4Nu~m)&_H$&pi3= z#upPSGv~;Q28-SAMSbU)-JmvaUHPt)Z!;GpE?E26a;fdo_RZB->g#jYyYnY$nrN7- zubFTqVbS#Uar^$=)0!wJwhD> zq*E$sMskuV%)V(;ub#Z0v0uHu#(bUdJn7Y2{_e94Yc1y0b1!N8(6;%3&veTr;*9^J zpT)%Io@?M<$Yf}vEvM+I@mbC&w5wU{y^(aiVcE97{I~Kh=|ug!mF{u%ciU>!z}SIdqE~y({l?>WlIHx z^esIf#$3;|^N{n+XbqqBY8UplEr_}B#BQ}tmKy(o>ThN8$0l@l9x++BL!n7gNuYNg zXX))s>r1_78Rgzq+fUiLvS`hfMcW_G75eOJfAM$j!g;&rM1KobpI})!Q{|-b`VHEJ z=1;YfKfJ%KwtM}t?{e#2E$_^}`|aB|nKhf!z4OG2LLTlYC!gPFI%l*(d97+zMtb;83+zkmEX; zwD6zYbtT4&GiGmgdMSF~O@Mxs^}V$}&YXUl%PUiu_iNL)@5j&G+B?s%r}*5H7jut1 ze!Vpdio48_I=enLiX1uEmR5@SvKY9qa!D8KQL))SSFkC z^2X%CM@=6~45nYqwl9%vW9u;DZ#x_7`1;GY4D;N~OQOODsxx;yzAjQPHSJqofxVc_ zO~!(2N1v|{TsL8@&w<+?UQ9kAc7Br0w^Z)F-&(~SsWw)XPwc+mR{D{aayItH!+OOX z7qr@$SY9RWR^B4k60nc;;qH9LG^WzSDfhqeE()}~v6ab%cV0HPJI4vG*ad<;=NC(d zt@t~i!>>;7V5^Xj@Xt&Z@uX^9={&Dp+mHCtB zlb*Gyd$rgaMl2MQYuH!yb5_EvZL6P`2Qo+9s5y95c1h{1Ag;vSSBi8@j#zCrmfRbc zHKC%H*L{8N^pwqhu7Tg$wW>=#K5LMj$`l!Q(;`@A_vbU2*G?9CdRu53_)1OlVg9cF z)?nK?^?ECnplS2Cw(gEzabBKZjQ_fl2p?nPG-Y+EHqAdm?nkFAc3rLe*jGTI!spkl zP4|E6JX^l|+^w+b7WbujI~D}COT&YO9NS9WS?(!}*&E$Y3B z3n#|RV}DzH=w>Dn>8zR~`=eBWfz3Uu{h6S@0p3z!krn0KB z)nqBlJo}`b3vwLFuGcwiX-xdPC#p=+{;Ta8H{Q5Tv#NWa^`@-f5wM--sr&l7Pv*^h zy=AIeQ`M`JhVEi!%h}R3WBg=|E4ihlSzgQA@klJ|_WjSXHNe-sHaew!p^J0f-RA z6oZdxA4*fpj}K`NtG_!{Quo)_jkcEVvv~VCkJOfgo?OcI#K(1u z>+9z{cM>)`XNgzJZ}8}O>s+LmVP1Rx+0x!mAM&bGe>k2_`RS12ukA1GccNlXiY1R{ zAt&Rmb9>vY8jh(6JA_F*Ho0N3g^j)bMTvhV*Pbai-W)OG{b@b>hCpKQ{nt{zTxZJ{ zHW%0LK6h12>Q0{N+}9>4+rH!;H3`IjZziFJ)pWEo>Q&9Ph_iX3!zpM*0=SI{Uyq8+)+A(Ld*(W=Z(;jEn z2&dO<-}+>ofvjK1pDnwa=IHwTsrPGAgF zeimleW%t*n2ld=Nzh1oXxlWh6`LD#66K1Gxw5hF9I6OC5*htZRf&H|;gZdH+%g-b+ z_)CVw@p0H+^^@3izJ8ZfOo3m1vfI`Y>E{8jR%UOIv;5Jg@F=0HwBX#q3cu?=Qr%+Q zE%$c>o;qYP>!iuNPUbgijTe8shUt()&>eOK0*b3{%o^GkdK-LwB07>}4sfO{d5M&<@sPWLe}HJo1P$)Z&sz5ekw!MgkL58b7E zMJMgb4-lE{YvyrLEVHVM!S|EG?N1vwZF(~GiEZ_#*S~qwSIjOgJO6Bi_eeYFe2zH4v&wXVLd_WPsL=80P_o$?M{6<&TkG$(AMm#yf7w;O&{ z{w+8)yJquO-!1R_wh6A^{AyqQoflj8yq%TvzijbUtM^fAI;)&Fp11m`^Z2;k>Q`KM zm!8>ZnDw`A@!`^YDc_xTt^b%BekHW-LEqiS&#v#@-*mj>%;NRE;%au=5+ZeGy0s@u zne_I_o}52@*~MF*7yr}=+|jkyBut0r{P*yE)7^YNbqDS9F_{?ofYo!uExwj}Y0|&y zU;YX`zFXtd{Pxu-)ihTut#y(8b0orq}1*81{=H1`tOXjQnCM%v_Jj9VIk&; z;{4AuBs&&tFV(i{+FAMd=DuW0cCBwyW_IngO%)HA?XaHzC#zD{&(^+EEM2W0vboov zT&*pi^ibLU_ru!Sy;E3aEo!H3&GYg&aO3Xf?Dg0Gx!jo87U!O)zH`o%*`Id3U$@4T zd-rv%PiHp#U$m<}amAG2dk+#8%-Yv=eZB1THRXYCR0WRsD16^g{FXuC2`{e?^$zDOWK$aZ7J{`Lusa*GMn_Rj4D?#MVQRL%Gu2sJR;~Z89=G%L&BRdkK5ik~t$e0BZQE8>)GOBKzn?N)Jcv(5 zajnkj_nFNvOkc-dGjYAQ#bp`sCB_Pxzy>Krmx8@{=;|a_ldn0 zo7QPpJZ4zc_jJcq&MU5G6ILCUGpawJ(AFjLTX=Cy;$Nptbs1fKJ$CDV>|M>u>d#j_ zsgvdKf$l~3WL{;L?=0&sn_QvgS8e%^Pk7BP*9F(&WWF(}ck3MO6g@QQYTm_GcR8Uy zM;9zGPb`ZSJjVX-mwf5;-LVm>EV0{;Eb)7&Ry9LrLRI70+y%l_Gr4A%-a61$AGmN+ z{jUXUCpm=gIJirwGV1JB*7%HHV)uS9?cQ$C()og+$2D6{=6Czs`$iwa?~2<<_?2|r zlkeIz#qxWB*CFY{=W_JqtZuCPt#4o~tTz`Mg;9&@Ns3R0*A3$q0r)^o0r9IiM?IY zGM(qr$+hhZZ$?h7pBJObC&2UT{HDDD)t&Et-kkdN-`e9%3h#4jj0=^@!?HTXCKz-^ z{{QgZ{Eq7iciA59E6F>3?o3o)QdnBtz*P1#SWd;{+2m99*Z!)o`h3>fvrjDA!Cjsu za;oQ@naNL1n0fwQafFqd)5(v0vda&bo@q)*)Nv!1X!KTR?#+4JxGYWbb4!kXtI!@UiT%wbFR z6K!l=zQD2U?upN~3CqK>DrZUm-Q2r)YLZ^QPN-{8tN^c=NyX)V3xd7xO-Pa9Z@Xk7 zEq^Za{O|Vaf3>ssE>G2INYtG@ss5(n=Cr65uCg5w-}-K~&vZHYK+f4!TI_zK=&{+~ zTo2ZC<=(bU5;)$zwSq^!=+l(QK(5lGhkff@+#)0Y9C-bl)z++v_uBpPU_ODZiY5%q zGV@yO?)>qo-IN{PT<+zt_Sf-4g7cDgXYjs^^gh;dVpHP$t%^1_Q{FsH;@j}z?*mxS#uY3C-k2)Y%#oM6q2b4S zZf=}~M97@_ZdY;J!0Mtzwzw{L}SVf@Byq7f)C@t|C; z(X%&gI~v#muQ)tz5RUvx1NI`7R}E*q z=7`gsrB{-CxAOPR&E3X1@p`j1%s+HfkZ_u#EYldR&?HilPl0!LZT3vQLKTqu7w#WwN862baQYb&&JBGNOa-8Al) zwYAZMdHJXMD7%>^Zx8?2?k%h+YVdOHjzu3l3+IXzb4ee)8}fJFDUGgqHxJrX3d$5e zIX=0$GmR(P;;Z1*6A^je^6V}7$JTy+xN9y_py$GwS?0WtB&7#$J1w?+@1QB^U#N|7W20G-(2*XcxL= z-mv!30zSq~^KIm7{{Gke@oWC2RULV3$Jp)ov|h!|HW%V8I{$Fl3irK7lIQQ*)zl{y zv?+7NL>GZ&|6U~eNBnnEny##Q`{Gj3DPgwfeoQTx*(NZ3=MxFNtNv-JP4YS06gzk2 z{C*L%tp8cs8Slya=cF+l=;}D6{YMKt7Dg?cb>>&r{`2~C69O|{f3sNiY1Z~`IrXoCreBxsTm9PT{HmizTZ%T_ zF#l<|d)nQc`lUx@j~?R=sW0lU+`XeCpf}s%{*5nRo!YkTXwC?-*=1dLY391u-8a-? z9PfumI=FeiGw0md9kir1&m#C|%UX`ucelOo9k4hz$8GuFy_YYWM%v3RpOMsY=&eha z{l`UN*E^;*OH?a1vEI0I|GU_$S6a3oYTPE3t~otPyCJ5SXMSXTv!qYW>2IgZayH2KvVt5bwO3I7sz z*?95ww0Iddh0{-?^}g_$iM^=5a#v3E@$UcA>>qH8NL3|VU39Le`q%E2EqZaQ^t841 zwRQI3t~-YK2U@jn41B?%kGcyK19O?kV$*?8k+?)|8mE#mjOwoYV?pklevvFDyoH(YtY z-c31B%I5ZJ-aQ>T=Sx*)HRNA0^l3UTwX>`D$DuwBm)#jnak~{7I#@59dc^$fg8AO8 zkDs_j%|9j?9y)JkAIJGD>1~X7)yrjFA7%A#)<4{ybAIaj8S82qc3xxL@@J|;(iw&h z_RN5A0pYM6h4tl5$$!;yeu|!I7il@YifPHlZO;NiuE$h8ZOY%)`cXc&XTHZ*%WXan zO0Qp$)YgfUd*O6_YsTt% zRXYS{HdQ8_t}r^d|96#6t^dXYWio6(v}9#!UUztKu2ALTo^@FH!@?Wfu9K&K%GF)A zOz`9i%Z%-RzVoDRe11kZ`uMSSgOZ<*dB1*}DfE!hA%sCj`E32xRaKi-ng#KnEV}UM z&w-g@x&~Z5QOn-u7+6H+?X>Z)*A@(LC{mY-iI3*yaN~M6G5^1wi;JXv!nbR@LD31v zroT8H^*`cGg?!fqm*-nP9cZ>zoD^ll!4=7)wdH=i^v>2fe|_8jUtVx${{LfQ=icv@ zx-s9hU-|%NE_>DKoXtJG^)b8?tTk^Xg`YC%c-a&i855P|^YYiy69q!4|2MU457)If ze%SnASKhreUPA?K`xDc7J^#${{+LiE^L)*&qNhi~OXN#6H}BPGiI({*tA9XWso1o) zA~Qv$_^F<&hSsBU?Y$q@6lZ4cKW-uQY*KgZKNaq-gFesZxtwv!WZA@aFhMBi|Gb3n z632uW<-d>nBc5_$J!CHclaa-A##=1H%qB+0(a|G^yJ*?SCFlf*lk*I>*IwVf9>OIbE7MMEwiidnK?6^ zIpcB6+JuQdf|=>R+0NaVws-cT&F91C*Vctk`1|oWlO* zrAo)we`NBTlrHk`O!;~J3*A>LCCe}MoVZh;=oq0>b9_ceL&Mpwjy{V4e(uM0zG%mYzc;BAe1qY-yr0}zJZ-|Ls@HshtcUbL;-_}uU z%Fi3#P2ckNSK4by)80S+Nh-M}XSre-W@Rih`F(!z%N_MTiJI&?uaz_|eRsjm|INb< z#VgEjr`5;Hw=J`tvi9woQ`@W>*En7`n0x2b^>yV+6`~Ul+?bYmS1E7f`hQ7Jl7&{= zoGz9-eKp%#b*J2^y@A5t-ma89#&_-B?dwGnyHv|g(>#2Twf~#*9I2oO+ zTytXGXLrMm$Nd*%@+ZGy*mEMo(9r#v!za(=Ncy#acge=!*{~% z#4r7?5qb0ZpYB`Pc7^LmKxnXBz|_k%d-;z$@*khKJTH6yytb+hYcJXH1E*9Ps~rZJbDVxk>Y!vp$ERxnyzR5)^WU8AssD3kG{`h|Y? z6qvUdHho}G+QrK!$LQ(ODd4|`VeUnlRnIccF|H5YZr@a7)ze&So;By;#=Ge%eY3Y~ z@=u-3`r(dw{@n?7Qbt#jZLV&sT(x~~{05sh2Tm*!DBkw&^}~qpS0IoqsoL zlorp?U&eegbY|F*sOvr28{$N+^j$u2#mQ4>^?^MMSB;%(Cq?mzsGh%{Z(8;^OPcH3 z8&$g%wF3V=-m$DPoLaSW>Z4a-|EzK&7^X}T>k4WO2(e!A>bOXtiqGP39qk?Ej0ZYB zG`(iNtUozDb58g6wHH-n_RQ36pYHiM;DwI?uN#vs@A8cQ^Bgvv(dg!D^O=3iq@bN` zx@yCoBkmqIUdLz}tEyjOzwF}v;NZjKS9ENGwdS#D!6{bAeU8%DE~;;y&Z->7c0cdWI#X!MBBc4E=&LmA65Hd@?g^4%dR^qNtU zal=jB#7^6YBY*DLuBhZ+A^gBz)4U<-!}&(XDMd$qxF@-C88@x&l@mO>{x$Q=E9{2c z2RIygxdr%t$fj$G)hj$GV`LVY`N`>qO6KVmGp5!By+~i@lO;Ft>7^YtSL83SO>p1- zKf?6HnugBIi6=cxpQJoG!yu#(py@iHWeM-}5T0#k)EDkpl>6iN%Xey96(&si#Qo~+ z->;K8z63D|JN%6~>!4C;mK*Z!xMg(R zorbH2G<*3fJ|4fWUss^Xx$6;AlS4;iqq^~jP2pGn9o>F^@>Marrr@bh3)YykmF%Cy z<-$^UZQZ`gkK03vy0sIVro|jcVAK=@}2&XV;ioutb4t$E$Wxl$88!Cu8Fn0rq%XycJ7#AJeB9)gKCLC2eUcj ztl9!CnC@oVyJr1fP*-XAQ+S5)uEzp~u^f{E9sS(Y&&WLzQsYWF^*(Ih>B-j(X4{pw z*6UaLNEAOckYuaa(R1|RgATVPzH?X-r+B~h*lRbfmNVl0>{CaxE~G!=tB7;pVO4u{ zbj#kwuHBp)X1$xj^TASMolUFE<~xt~%*kXqadMJbWLnO(sqbGN(UVxsU>LkmEr)G? z=V60y%TKwjxe&OEe`zg``WZdV$%Z~ko>IZC)9yLcuh8K*xj42eU*TTzL_x8iHv_rO zU6SB2epo5v`|az;D}0UtT!Q^#uk}w|HgMp{xxX*D$KEv8+Ch2$_LpDG{qH_#n4dMf z>$q7G+x(@qAskQBIE|}9o{LpJRng?$%J8b}+lPM>Rk&XiEMxw5ELZZ|v8zpgLrs_c z`g^SEdbS0p^zr(8%giU}H}2+LXTkW;X}#rn{LYlE8)4>qe zgTjrc-Mi}b{5Sh96k~}Mk$=)Pp_}`z%&PlkN|l8R%cJkiFMRfAn(^nKXHK>_T5*K+ z%=fQ*I>&DQ+JyL>9XCJlFTa=ev+K}G=M0{+_m*CNANwxn*C(5vul4t~)ynaU1Z5ws zE%;pWX0=`1_hvTpnx|?eS(YrWp@H^~Qu+%wafi0EatcS3aaD)S z%+!0l_}%MEOSYRVW7AH~_^^pBRMtYg=htq5d0)H@{hl((3%^*+JyTROPf+KdU*5jX zQ#My3C!Kp)`}ULRy)&HojxEOZ4G+bSl*CV8>#Xx-&Vi*bZ>N_ZUijGOp^Y=s%IB}d zWA}J&|Mw_@S=-|D`oNEZTFcm?KJ;FGAjK5bqrudlwofg=#^HP|7i;UOA}zZM^*<~< zH}s!PQQNO$xc|;|hYwOS^_FKBPv(x8u}oGtVF-NKrTTWR$r zhk4Q;eokERTVD5nE3;UdQE3t1!Om-0h2J!~wp>%<5#aQnTQ}KTVdu$}t9%4xcjQ<` z{eE}j>*ceadT(`|_0~PrD#`n_$TjRqj%3Yo!79Gx6J}(4I?UUt&$`sDf8*`164mW4 zr}#e_=eZb*K9~HGdf=a)|HI4WQXlG7C;!@Yp?>0;+G$QA7Ey)A9+h^@P`J^gmr?21 zGi}Qe@BF4~=ZYuSPkVd8GSA2-Us89%q?jGQ9a}VWk1yQjc74woIdi9q{@a@03zojU zRx#h=tc1^-91V%%NrgLiPq4edZn+r?$NfWq|6-;hk?XJA{^v(*6sRDUNZ^o!H zySHhxPFna+-Q+;&{y$B=X~luf3uWf4W0EUKl)W{xNiuuxg~QH)Z^xS-`d#v*%l~*o(v-jFf0U%p zGsvmaFf{wv*|B2PiTV6r;*H&Ya*20HFY}Ji4$8_`GwYeTX?HvqV^LwGC54`;^r?ir8rP*sI4Xxf;*gtg-n_(;1`V)xqwr@g|i{iw|+~ zdVR4-G@Hq_*K8&iZ**ka{6jV(bt@-q{cyOMne}w8@YG|MlFlFAEFWdJWu3&AH9=mk z>_?c^{wj|6(!b%(yPu!aRvnM3XuKnkRCcW~@cMc-gETXC-qq*6%}rL7T*}FOqJHI; zs~R^pe05Z}AG??KWvAw|CiWjX$G2^Jd;Idk zP4~F>-At)^H~FPZ!NtRgrzDwdCo8f%Q~YrCjCFl8L-XaDi2+^j@;~`VhMAiCzpt+s zHs(C7!ozGbLFvTP;Q6P|pXV=Va^MMlsiyJgK;86{>z5ZFRpNS{wApjF=IdDw{Assu zd}7nl6A-A_{a|?!ELJx;|77$3 z=KaLcYa`2s`jt6n6)U`sCv)fTbD4JA$e87J>9#o&8;$dB%(Y^54?N`eoBj5dt{yAb zw#()34hN@CdMI|!)W>APo^xj#*f<>BG3 z$9R4o<~m?BGnL`AV_NEOV`blo9VW>-iAyT2`_}Z8cPY;=y;pym``-2?s~KM1yO!K8 zzP7N*H7(`azkAub8C(*xj%P`{HjMocF{9ypTE|AO;`_d8LHd_8Sd+KMNB;Ze=b(_L z-uq>Hr1aPCr=J+YnkVRuO3&z$JzGV6cTS(xU2zTlrCq{lcR$k-`;kHzHwN~@$5ZOXD< zm#8$d<}psW{h;KX!5Jg*y1D*B;t40dKJvQqvvy6uvG>N`)$CKm>)&o_oKRDL_J-5d z+pBvQX5G4G=#bdW`Qc^JDu%#scV9jb>wXu|w1VGm=X_TYt&%uh)jP5N@xS*@%X|Gb z<79L5v-tHsMvZ<^1Wx4H-`LQ-Vslrnx>OBfAH~3@1UbNSD$&yF6+mHEg z?8w&5U&^G&_{ihN?j3FJCmVikTE@9xU1WXH-YrkQi#MMACuwQ?SKKL>DX{s#g^*^~ zv-O=9Omu2`l|u}sTTbk(GTzycf4?>dD`{v1;>+!W+U1=t+I_vp$wX}U|p+}TN zkMo~da*EOTmH2wue%p;F*8X@B)Ts7%f>2|{EDwf2-&I@Ey^9_8_I1fi_%E@tIKi}g zVO!rv>Bx_>6j_&VN=PsD3pQ*l-gQT{Vf(+MCH1mQR%h$^Vi%^hUysfA=4Jc8S=CYD z!^_>suN z;GEgz$!&L3sB_NG5D~Lo7pF;GdU5G!4bvZ|9*r5l9Rb zRg^`C?|Y%-AX9m^QRm=QiFhl6GRFPumru4n+I;);6V4;{FRt1c@88eD8g6k^=aGTL znM3;-zt7XL2F*N+Fd3RockE{oVKkloaTcRy{nJSJIls{sp;8k5c2g$5sZd?MMr-O` zQCSsv1C_Ei!FHL?3$H%8zFeANzW3T|aoS~}ek=#rF8uw??Q^=FGNEO>RR=5$l>!{0yBr_bE1X&k(*@7Ff7V_SVPU+H!?A3pkBdcpOzne%eX z=Nx*o_*-$%+wHf0uY7K$A3b?z?5cBsylDs@c^*axzg{I$*&-=&e z)V=aT$>!uHjhPlR?Inu$v4!ntSL2`ldXGWxeADKx`ank~!9zLL-8tn87aZhH2w$Ob z!8Q9;5VJ;1CBxnRJqPn8woH8;{yXe>-K12RdaES`8C@dZ&X<0j7u07Hd1|kG{;ta> zSEX+|XQ%bF)#i@Rp-)!(qnU<7i-Oy&u&p9g=>h%r{m+BGK@DFJ`>y)VV`}eWJG(UJ>+-E@ z4=k|wGGl)I=H7$f5`?_xY&o{owC+Hu&+5(IEBz~P?T}xo7u0WURnHPJA&$ApRd8Ys zL(;ZBRsO3}Y=#=wu^!vUaw)0x*vMf{fk1Zd7e|$REx(OikF>XWYRivXUgtdPVFZ? z9;oE5SiV5#$HLq@FFdEu{HDfTe|M@wA}4E3PQh~RBfWXA4j(hEtEw!Gm+m@pvLTLZ zj`DSjo%}nz=eXFIrmTKtvBUb=%ZnRBpZK2NpvQH+-~vOs+;o|@CxsbngbtfpXgz9k zRImOP@$GPjhE{djh5h$u{VB+ipW@)z5WChZ;j1$153Tr?S~tZ{p=g3EMaNzI*ER?9`-|?t{~3H>xRly3E}!EUNlI z!R1S0hH1!A6(%0_kXyye?k<1hSAF3Aw$;(=L+Vd)yg2kK3jL%=6Ank4QodpV_v>e$k;Pn#b~tkI$CBw`X4* zs~pR;kJp*&?)-fyY&L7tpXZ1Dl0ABE2J778{8(`?r1Zo79!{ zyC?nd63)@rx7M;~09dRL0uU; z?82|1Ax{~XZro>a=kE@?doO-|Xekf>;j7&1v~dY)@>_KyZfc?F2ApB za-i{>myQ~QM)(gNFCgBVe!SUiSHxz7v$~QCBEC-Fm&EZiA&pqTHX%h7nP2g%_FK36izH>auvirf;Kp(1l$_0Xh(Jdw|n zC$t#wGA#aBVZ1O&{nqm0T&dTy!i@9}1^o1H*l3n@cwvLhgo_pHSkrf$-)^n>Yc;Rh z-o)h9manh0TE2*2naSY0eVN_UZ+rsB?@s(bLwdD@!lUMg_i8_89jjl)TvL>|UgP^V zhTrEFnSWV(#^+lR$DRqZ?z)}LPhok{VjndBQQ)r-{ujn9#bUv=_rkU&UssJ^?C`Fs zpf}axfs@iSE18*6k>M^1uX|dQswQZP9y-u+N-ZrRgW+Bwx80Q|1sXdV^Zq>VOE#_4 zI1u=KlVX#6{GPhM&(i&G?$Xz*pYvMjf4_Zf0nd5$nwCV*59@W4b1tar>@j~k*Kpp1 zpIg25Pn6hMa9+7!j)$fDQnP|6_HX^DuOD;X?(2c@ z^k>)k`2Ie6^h+bBb{*Gr_5%&q=T5Pk_26&%OSXHJrkVu?nfDx>yT$+bcRPvlrxLe*ZGo_Z zPvp&fAfGk&>9c>V4=?lozI5lI@`X}fiP=Vb*Vx4doRCZX@xyt4{8>4M&yTBgaxdL_ z@o{a|M&&1~Luwx$csAjC66dG=EA*~hx7u)VMsAQ*{gLDDGPkzx(!RyYzFNqA&I!Zl z!_#+M^|iT~@5QU+)zTrB>Lb&i>Lc?t)#uLqtc`mm*uR&kr^x(fv2kO!FwdK`FZcKU zzswGA-d%l|o|*IV!7;U+%wOiDDh8hSieGj>V8?vkpn0!nF8O!UJaUi5qZ2!`4!%}M zxt0Fv#{8-ui`Q+c*UODP&b4ro-T%gG6IdK>vz}QvCHUlu&s80VJF9=XOT?7_da&@$ z>3d!eKR&q0^-Y>rZ|2(2KE;X2MpxI_d#dG>bt^AYG1zZc(AmuLCoaeJ&m@ZqR?{^{ zSv%4W+Ixwm%JY0lm7hDU*5KY2hUm+`j0M?iWH~-Y8^!N;JsH9A?W=n96rOy;fMW*J z&eZ(Q7A@?aa8|R}(0ZZ@&tADuBjsQJp1s=tGIN(9xb4PhG(GSGs|d5H5qO!PX1(O; zNw;@=e7F9BZphUx?}q&6BI~cO^EK-{J@bm(HOl}M6DM8Q49-i*PhVf|Wz%R{WOGk9 zoNr}_FYm_;lMCcBlORUq7TfOgtOtGF!G?vYYd; zzxzeTCL^vC^NxROZe>lltE_ALZPP`QHC2wx7ejxCnV9?(SQ@Cz7tO|yY<=NToXl$7 z{-*w*uM7wFHJZEHNc4#v-o1a{M)RmU{(EKEzW4lX-DjS0bQ-AX=*@gFUMKbAoJ~8< z9I`mySnuQ<}lGlPVfY&(qiOiUn?psScHBK0C}(5Q z#J?(6)a${?jP{*hI9Zou#Ls14Y2|A@wfXDL>mI$kny)i1cjVrjam8pb5Bn#LwBJMX%II{fV(^+Nel@iRRVlO>;LW^Inn!M(#Rvq`dh5v(NyFVw0)VFCEzFQ#M zTDS9km)dRR6rg6;Df-A6&OdYHLNd%@?kHDy+QozMP)HX%)ChRc7MBxVgVi<+5@smpQL0 z=jD|>lmGe4d8?9R4gG(U9~?R-{L4iFwN}XpS_f4L6K~3nfV>V~xg3ed>Z#;SN=)#=(bD{o`Qad?k+h#JpzN#Q4 zA15E0|2BDox+C8wx3`Hh$7jx${Oik`6#7unN7U1BMe#PsFA(vLjt?AeoZaXWQY1f}- zSJvx0Czmd5-L`&(jN$5O%38KkTFHLX818rOy2~KAaQ%spq&#O;p0rnN#`Vkd47Oy6 z?r!2^tDZEoP>!v0_q$hnGqzbQkGaa5tYh)UXs6T?UB9&jx|c*hRWWAP_O2=Zw0hU7 zy*$C&;-4Jrc*c48h>z3+;nz!hS8i~6qd4iI&7R=XZaRGn#r`JFUe?&UtLUJ|T9d9X z{TuCseuVNFSbk6V_jSQ@k)_7wd0dVc>Nzz|d^jl{tuD96YZiN7$?Fr7ZfrW8bMsSJ z=~~-;;&GapjNezkR6c*fMBTq&&97(2mzwYJG`(bSF6chznuwZri~l~q^eX>Ck%iIG zZvt!kbF3T9)4EN*CPvTLWR>RWz}EeL$`OWBNfRQk_C#EIWXB@pds^+*L9RVVuKYhH zQ_x&g&vc{mjiwo|`+pYJ*oY0ky0a($JGO_Xg=NA#vk>)nbK*)k3j9}>ZOLV9neeOc z+v>}nB?-yeQ!Sd;yvU2&_p@@k+cs6x%DJ99bAQB5Oqkie;Etcnqsx*NUtYap2xEzO zGGWi>%DK#T-rD7hUv9f&zUEB1e)0U+-e#*%}xFF`XOb%Niyp(kAFUeX;T+i&A)y6%FZ>{R`?jNSpR6|!+9a`RA;2E zqlNkOnd=rtUTU_jU$8#>v(OpSj+rfNbMDGDId(GVqjt^u`nYdy%ZrlzK0e-C9m%8kTT1y_wfY*LLu)kt zYww->rGAxm)!xUS*9w2oHJlxDk$LK~8RvFgk~ubk``TU!hvR3{9Q!27*PJNKka}b> zLER%JuwOIAbc@yLSqJKb&xt?fIdsE`vwhL+z?5z8KWA*(`kU1;_fvoK%ZjWZ3(Z}Q zm#1*ld#<-%@!&}4>vt`h-+8_??t2t|ii!Kg=5wLE=Ue93vd_8~m)M(rz){&?@#~h_ z)BlY2cCr~y-}I>QN}{P3!x2+EJL!f`uB$72dllSN;^oRO?YwlCGgUzP#~M+^*@;)% zk3873Nz>8%)FcDB4z9bZeH(uIn2M#9o_J}*y-)hL+>!blQqw!CCLh~Y+u}Z_@6nC5 zjo%udZaT1vzx|8Z*~h6{Z}X~X{I>R+Gu?0b!TGW0+|DQVnkativfu4mDYlEN`V@zh znbp;|CM~O1?RR`$r?uzr#m4qGx7^r@r7!r!ovzz@vva?uU9iJZHTD?^7ewA2`>s>e z@Gbr18l7hOFi|1xuuPwrXa7EVPx@`dw0E}6Ud=G2^GOoMt@e7if3@HIb==f3(&Vy0 z?yF@vMp0?bCQbUEYVUk5PGY{IrL}O*gM_sc!_r@DJuP&~EO(DzqUnx+_pjH9@2WiV zMqeR-Nkq@M+h)Og`M5vqv-Wp^FYFSLFfqciXT-`t2PBiqBA-o2p0xPtGf;bQe)HX{Rz)|@C3Zp;_yE65Eyh=M7o_~Jd`gQvIs*)E?eW3GnWkl@zaLxFmHmNa(_t$(q{L5YQ>{I{i z|0SLsVA(3vwDg!qy?Nuwh=U!?d2hC@xM${i@6nv~_gvDtti5LVRb7Z~nz24_#HS0P-i+4T{@ZE=lVVpzsQhBxUK)FA4c9u?hRsXkZr7G+?LKOC zu=nVsOuISdd+)Pf{}7NTczONBce5Vd0Nv?oZ{%}=@#FWB4S`JT+{bT}lx+J@fBy=5 z)R2SlzqIhHS9wsETX^5QD?(iHv|vo>o;E6=zvDXe=&+OHyIi{~5m zUXydsHe27dW~-&*pKmdT(=M@I@&2JM@^E+A60LpPY&Yfh^H`<7dQ}zRvM%nS()zs` z4(Vk!W~FRz3jf!A2%EJ2$STL+&ffBT{RC6ZG%=B?`npAy?^32jJm039x2mr4cy+59 z?}z8h=c=22UL0Ah>98W#{Xb*c?A-26FWxynpCX=nT_jrMmhi{;Oo8{C+ad?+ZO^@ibLP^5e8^V`$wa{u)0 zak=_X^Mvce_7~h1<=b0jcTT+g;@iFTxryhGp4H8iPAX|)?cIKJWp4KxC7s{FTMs|A z{UqEe#UpanLVv@>R+U*ZFC4UYKOXXxVg9?b!I!l)3<~*7Co39HSG-=oF(o>G>+BmT^#8NxC%+;50=hg^}re^7Qlv#4?Y8ifr3MW&2yS3i4Pp4pxn z#QW}1GDrB4M;Q$>7R=0b+E`L>Id+1Q*zu|+*BGu}Ia{v1p3Z!(aR034hh2tlT|PF4 zc_y|qZm=k7WbaO#mE!rTchYkGNAZzi`S?rPw$52bW1i zyk*?ScVa=xB!0trJQo^z4E--ouxV!7Sl76J!Lt`4WjwYYI&0?q-CHaeeqDTj499z$ z`X!CQ-j}EPC5bIvefQy`_W3`w+6^}d`!qM*u{?2Dt8-4xhtQo>^&i&u$ zB6jx3@x{}p&%DCT(44EP^D@>T;_3pX%n7y~G3pcEGrws)AjfoYrC^5BX{od+uP+oD z>1aE>lHbWZSMPR8LH4^7`h6M;aAN#V6Glay+XGXBL?`Ghxx+K%W`LwzKEy zd!0yQGTj>TyyjpmS0mF5wK#_VmKkSPJQldoC2>%@f8 zgE892lDntQRE^=@ta$Xml8L%x@DI5V~C zp6_Mdx>EeI`&7+dxl2n|>ZmDXrZol4i!PeVG$Cw$!bxS1I;Ed8RIdxoU|h8J@r;l6 zyiN&xKKZOFZ42Y6<>(jD;N8C+?{`k>(S;ZszNowI_x`H81LS_b*ya%Yv7u$ zc7?~B=|c9mXC9e$i_j=w~zhy@IUk(8;v8Ah9SwehOj)eW& zas9e+pXtK2s%IK@&Ue_$BPmnA;b|4m2DfhJPb|-MgyMU9CZ)6nJ$w2rw&S+Kk5fl= zm~Xrh7(&TA>9x3Z=faM<%`eo0@Ws=hC5$;M#i5 zcEyW(*A{14*S5TmcpDhA=Ju?r-O+0zcYF+f{EG9+Yr(BYABOzmx|PF_VL$b*f#QNg zbF>)#uJN3C&|PieqW+#MYhDN^RVvN&T;yIk&uaSF-=)j0avHhn>R!Ei(75;Fzt898 z?*DgVZCmi<+=YahCqH~O-|{kfGUN4f4X+>O)^hdUKdy^sieAlCvehhiOgAh#Q@cFW zsp0IOJMv3I>>h3P-Ke-zj5CEJNH5zbbox|=^&1yR=yo|?*eIg8X8mdr?-M3|r&HP& zYiBvLU!589CM_v&!!2Jcv8NUd_iw#Bca`-czZjF_(p#~$I%QWv)1srdUD4ADIB;zG zJ@KnX^`;3|>VNf0vrV7Z+1E@i?6Lab?eI2W2Oz7yjKs2cMI;i9v=SQ zt>m%cqrk2ATo_;Kxy*X=zfv_Ly!QAN_0aCw%U|#F`*C-Be$Ca3^;f%{=Y=?|S~lN+ zvFZ$CjN^?^y}v@+-gY@(`&#Qa;y6n1O=u`hIrk|5EbD!;O{Z;Un z?X}1O6V8u$kC;#A9}-jQTI9g`;PVlti%JiloILPce}&D@fQxJ#)06W)xa-}jTXyI3 z^8;e%=N?}zu%3ry`sO>ItyG@Qs9(9_ykzHJwXdtr3lwq9WKuHr-gU<4rBR%DO~DJ3 zP}c;>?Xhjn-+tx-E&F)8iQ!#(e3E!vzfmA(Fe&iy<4HQOGf2)@-6 zpW8Rj{8HNAeHJ3ByOu2bqP*u zmnL(DZoB<3S6%0^b(OMvgPuh96M>#wl~s!kywlTkV^hxG@z>eQ+sc^kocu^@Mfyu z=6e|gmsmVlR-L!yZ|sJLYqu_(-2Z@sed6Dnx9T7NxpCXyqWliS=ZpP~BJo|3FT5MA zcHFf+a=`T1?s5^Y=KE)hKFA;76@SIdad-Z9lNr%_4zK%@({-%ZX8&8YJG{MRf3woB zpR=&q|HgU4n;YzTjQYOc8}y$!X>OP?&Fb?H?RoES=(5dH>|SjuUHpFe{C73!(l@qz zfAYNiO&j~XBlS9){z`26Y`DGlK_uU`$v(f_>!%&Q>|Zag@*> z<5Rt-72mzz5NZDR^&ZPu>6u;|jJVB1u9a`AbX~vrUGtTl&pcvJ^la9UWO-3yW7inq z-}5h`dQLmbgpi(x)2bJXI<<1vKiFY3Gx6?qzb&ih%AAki{o!Y}_^VTMimwY;PFa`4 z96NQZ<=)u~&8>gruH1G?{oGt{v6(67uI2`Y9?o_xY54JF)%hQG4-dL2^v~PBO3Jmu zSxoM+;n~aak3~J4;tx+sUbEH1RwX!jP3`ZLrJsHoIriDT=RNgCQC+orO2&UL{>3}$ z6TMa+x8;fO-u3UtWSc)Ffw$J_`M3WIlndqG^*Mb5zdiTgFXFQ&^PIMy>ow_P#{%Bv zui`Akc79!~a{0y#E`~-w76nhH(&Y|e%8EZtg8tZxa&Fu=?a|@u$#(-1RX*|`eegSD z)*{so_ zS&LmxOIO*3^ZS-N37vjq|DrDav=`q-&z}4R3i|J|T`$hrw)%DVf2PX6XXbFF=A{&u z6s0ESf>`;}10>j3n2n4rCkm)dFIdCM%WP_73AxEQI$wIXVBPig50Za7O_Vt|L8pgd z=M_tK3wDkq=DjSH6LKHAtWesy%Y<`+{QZ25wX3)4tXImvb6{h7dHTtR1$y^+uD4I< zF}7>TvDqkev}Fm)#LhVRK$D4kg>sV4d37XyX!K|cetObvk2zz1>tP1-ITM{Kg!Z0X zDU{-MDN!k|px#bnYR~r=`ByzF?;YN8@wE=mz7qn=AJpks&F?yRk=IF3U}qnjSJOVt z2mXr|8|s}-<1sqesUhmiVW)YN&3ok(i8ISb#JvK~mF7luKK!FLATgBcHYy6P1IGo)_x5J!K<4WUXS>c3;Qr zZFEs}s&OK_Q>=2C+9W*@ro`}=Q0X5jix1=^otmnpHqBv%vh`uV5|I_%&6iD^T37CC z?40qTyFflE% z`+PN_V&lH3tFP~?ZLa5STmP(k_Qyxf&G&crAC7O^&lg|+;cJpXjs3p3nfx1yXYa9c z-^SV1tQi$AdpPnO&%Wu;-kjmlKl9=3pZcP_w)`{mr&Sai&5!)Kx$-NR=ZvArUT7-PnN&XkE zbw2vi@^MLzx}-zq_5Zc7oSMWL-M%H;R(fP-mu6kNxmgx#7qhqyI7C-Zh?tTARRk}Ma_FVYlmp^5)-y4e> z7jZGD9IksH=#Xv3{C498)_YYh8or0`@7GaV{qgB~@x|x2UoPyAlnl72^`oBqTqL_O zQ(N<5CdG<;&#^nw)+YHoEWKI-d9)OB+aQj5N1*wYa7&`#|} zvI{SVH%rFz+6kYXKdxjIjykwXbW&73Ly~y9%psn&4CO@<-g)*to^?(V-o9&2MLW%t z*z!(NhKW%}cBvc_^EURaD@sLsCh`7s=Y5wsk7Gq#mTK371%J8puVq?l8Qi!bE4=6R zd46T?OB#=sIM1B0HNd^#LX>pJp}8;GpGMg0Zt&<%aN)k2Rej2Bp?gi5$xLRB7P-wD z39ejMMY4bK%v-~fTenE=!^aI8`Qoovpa0PH@zC`8L$<5f5?!oYLKg(_uqJTN$XxEQ zf6e+;IvedHZMv3lq_XHv+fpkt=jy!h21eEYC+zk{=}#A4vF*6uMD+*uF2b$WmM`u% zRB;$Btee!HTk+@p*AC^he_n)M0~tMbloL5a(h zgA=<27qSG{rr9+KPI@-SN}{$+Tq*h}3y(|eVJ*39!mPUDHRAaV`B&ZcZaZC9xBZR6 zCtI#JeCH>Bdp4VKg3G0CVRojhlb`PuSu^*?(B{EAQF@W&O>^bnamE!LLA5b++Wil2y0X>Nv`FB?yDQJ6HyvMOv*<=j#q}_m zvZJql-bj8_Be&ko{C?Wv^OIjc{q8^c<(K@&C*|jd*@`_EOzo7bUYO%^p?BM7ZUx=! z3*02_SwSnVK!!8Cx*&UaUI9)TgU2ivGp6ldiZbC=v z6}4O1|2V8wz)rqbFVb9obcgJcR90U6`_9=Fq7ych z7_&|B;F7SG-1|LD+T8x(nl~RNmP#M}&%b&;&(`KQ&Tj?!n{VBc*~z~3>*E=`H+aig zzE(wauW4opkq&3fTG&w=I%j6$6?TQ#`@O4wFAwD5G%Cv}e&nbbeb<-mnMkG13!mrl z$GYpoKYx9bw&lmQ#SW}Lr2=;dYMgrZ|#&zb)(EExk7Xo@UI;yuf=~um9&3 z!8aaEzj12Azc0zRRJ7FQHt(hOUkAM>9)5VHz^?9ab?NWV@kgIo?0GQzaa(>}#i!rDz8zg% zu6Cc}oX+;7;_B@iYk~_-?`T_p_}TS0%~PH|o4>t&=Jx|^TLqgUlk1n%e`(sh=XY8E zDy?wY`+D`pcTuyX{xsHATxTu1&i8Ih_MNiu@Mh}^PdHs{Y_?rpc~6~nO6tiimo9%S z6$sGJ+;(ajkI&|tTt|Dhx%_&*PPYE;@{hAOIO~?bXwo#!{u|OJ`rkor5?KSgD5A-Ip@|m9Kp6|XP--|0rkn`g)-rxJ| z7T=w`{8^i*li%@s_a1vLJ#%lL+xd!Sd8O6op6^@z?faIJRdSgOm%iM6xT)ObYRKPS z4aa)3sJ-iFr_JE#T%`Wcamt1d8|9cUKXhYwylmlm_K-W#UHkS*Gd2qzVU{(!t+4g_ zl?g8%m;9;N9NK!y;YsY))zS$u{rx88E7~`%FE^i*F8;}7&ff#P<@*ig%_dt&RtW4#IH8zP!+zG|$v+r0KbcYXZ59MkY8H&#uU8U81@)XH2> z=W6*D#?Y=OyoXLLKeXtX&Az(_H@7$hdZk+5Sy2*p@x0u&47oqcUHL+tTb8dY{LOuD zy80a1+xmQ8Ij1$1CTyMeyg&DEWAV=Qw>EOR%R2DxSY_QFK6|V3*?V8_cDgN*eG_-b zCos)VrMStr+6)&G#;lM0v3Fe&>Iz5TF9+3MH@>jL<654|+l$lZ5+TWR$Y%@WP? zX^T3)w7tJ~aJso}5m&oz&7IG!CR=?qU5-noc-u%oWmAwgD+D*O-t-swg z`O=jwC6agUF6ETowV|xn;?EkU{h?(?H8-5R=sWwx_s6xpiaty&rXdaWZqM^v)EUJ+ zR}{ZleVBETF!TLcISo7R-v9leMSoYWy?xl*g|GO(h(7hP|9sTpveo$|9;{M^4%QFe z-@d+l!rXm*t1H!NIvq`ymhATF(Yn4yXW5Y(ER&2*&0VAMeAD;Sb7HyExaBx%CME6E zT36cg!X+k!cXL>t*pwBaUOH!&%(`6vb-9TC1g-h26*Dz^PX24LuR3YIig}Xp(q~ob zL9N>o4xP|Wo;M|b_0*J09UA85nwATbv;;d#-VsYd-+dD;0vUONQl9?l z-(GZRh2ZSz5r-E(yPLep$5Q53^uD4UKLWVh&xzb;wAU2Z5_x)RY0I_$yqB22DENH* z(o~Nl3Kgcruy{X-u+*@F4;dg-NYEwc{%O<2BoSEyEXKLe=H63&X8o9a#S+Q z+e7x<49Ubg{$1^}xW9hmy>d~# zhUgZjV`^Rr|I6ndI{5bW<&vlM4$~PHTJ1hiy~o$r!9H@$+6BBc~+N>)uQL@AJoUzF3_|RR9N+1b4BY1E!VIQ zO*cFRx(o7UYPDah3x+*f@k*9AD*S6pXUezy>*XC!c6^h#%Iq*l{lua}Prvkk+4^Q` z&WouGDp{$_FOJ?Uz8e0(Z!$x|r9{>HS67AUu9@XfAos2*Sn!juQhna^1jRi228D~- zKmUf_cu=TyAuzl6-Q5S)WihJ`1-Z^IuiZM|q9bxr`k^StecC(ggsxeNpWe`Sck_gv z&qcQ;_grcc%{teUu${Z;Yu^IPlnB}5)^oSC{%K0x7I0K)f5gU^f9!vk6u(`yK;f9y zvjeFwbU)X=R$9Gq`e)l7773X<^}Nd}y<|_%e6rc@zR*))MVsaM!J9bdHUFNieeW}m z(_WU@9do8$S~pATlYIei`E%hbOFs%8T-?z1)#^f^P(vvf)5Om3rr-7VuBVn&2Rlu; zbjvF1ql{PfSAjU5hRg3JPBXZZ(efj`pl_P}ef9&LFYOMnuRAc$=IKN?-M|yq?|dn% zza@P8eEeG8G(!<}3&A4x)Vh4n6Cq!IIOb{->SLq*WT8~`_o?>?B7~k37 zoHD!4Oq$@H5tgx)<-~=kN%E1qTqdZ`kW14LJhY(v`LbL7{AK_83J%vs$bCpX&g=Nv z18{Um5JJT)WdTNJU>XXrq(Z#;G4W7Zuj)1O$XTD`>6wQtMFk@FS;N_dZdp zM30>b|8{ol=h^(=&DVu?JIgrqHFp@V^Lh4i@mYu6-$T7$TZ<<=nNxQ%E5dbUn#8J^ zHx6IVb(k*D8@Bd~jhS9&E^o}de>_s1udS9G)qZl{^zOg-0<)Bto>CH3XV1U9yryAV zqT8k4>nd0LdQ$H=%eeOKRKxQX_pUzbxUplkkm_Vn&h(f2mK#28N)K)jF}i#~+;C#u z+0WP5Y|iY6VtxNx%%Hl|A^*hFt7-*-Wp7!{Ub0%c6j|$@U!QhG!ROum>m7{Dr5_}v zYmTj}W%FQbmq;w}wb;&Qtr0eXA^E7kBm1P9m0h=lsA{j9 z`J!7d+^F#Fg*~TRUCdck=HIKluKskIruO49gVL5m+Y0*{-}(4=owVn6cpu{RW)s)3 zT!WL*RV#d%5_{|2X2|~g#mDOOez#cd$BM{*Q&fuJV|TiM0TH!{NtyZ zVex#@M(d07=dcAGiZbL)+4Z!y#ZIkNEKPB1B!}*QbEj^l>7PARk501@l629&etyf! z=5Q0=?-#$W-_0$y$K7h8@w_uU&p*!+x)43)FHtM9TgyRg-|#mVAKk-@8}$e}A0gIx*?V%XQBJGnv~`o_SuX zf3@?`x$;usBg-v$0uJ(B{bBR?=;E38GiuOT>fev- zw?DlOzlB|Lre-^x2JjAI=sY zHn;D6{QB?N)8!j)ahx-n*Ln6|-sBU$hm4OY&yY3S&vyLn```8ZYL-9BR@!&-WXne# z)%sbdPnsON+^sQ!Jca0A-=zY<@dzWVE^UfWQD!%g?9Wy^$=qx|K zZdaqVvf6{^|Kzu@tlr>$;a&GzzatLipSEw`6*Jv#TD^|fA;($Wwg;|>E_C!h>9TC^ zg~uP`w*|58+W2c*#NIUV!lOch`DIEeTBlyjNDJNTv!rMT$JYarT}v%80~QAOz5Fos z^|b{z)_+jgU_RNV$#J8O-;0L*YYUZy#6DhZO6u*NyL{%y-z|qN9v_f8|LDMG-uR~C z2$8&thN~i$T)AVLSU+DXL*luUm6P3m`Mx=VuB+$#zP#St=mzVnS!^p8{aAff^q~!N zSKmpaX=f!K)cKnvE3mP#bch=(Cg0k5zsqF9^YGQ{mPXjDc)vCC?ZJl9!!y{|zO;&# zEmShtSFqM(*QTqn@fW82S@(k1SFz=qugZbyr#8p#JN49WxVpb|<0HrBg7NuMvho#$GgkUuwLL%`RinE_!+TS9NYjE=r>Zq~KLOHjA`(?@OP3v<0MJ}!jyQ9t-DWk@`Gdb$;*^-m-&DCcn znWogIuU;rtcyf|X3%|rp|8{};Gp(A>4?fT3*(82+o$=F~7LWO~bbXief1j$Cd(Uo) zL!z3K{2}%H)w_3nxM#C!t=(egssK9)pX#ZS2X56rDQ$gyysksiYIWp<#Hu|$JhPkq zCwRA=JoCIbIQvWKoWHNW9&?-zN|sAPG^bnr{d={h-gSvW-ibpuy1B2fl4RZ4!oU(D zbaiqpGfUB)?>v+Bo{M^)iWKpCw|QA!!&?n04ZB%vrx_<@FY9a1G2ichL{rAxYC&wN zoClN6l#?=T_pS&i)R(Nkwn)J%!h-c+*MFTklTV}{|3BgRvpYMD4sw2C{djWWy{x9yYKP#*z zonlyh+x6KGzLFM^!%81HteA|9B>%-92(*=#UZ~aFl)b8~Eo9E^BAo(xmow^%BRT3_ zk7X=4FQI8YvDNW%_|(;`E^6W@TI!?ypB33m5-}A#JV}?gR&?7I*+(o>CR~sdSDWA6 z{5vgn+3lu_aX@eLwV{HY^M3+k5lM z`U)Pl!$&XPX;6@T*0Zjl(zmhxY41h5=v5EDGVi;v+re1y%dYo{++XbUo~nJB)Uf3A zkyT+#<$6UL^{U;ee|%;>H1<38K==2y#kXUhwG^&cC>y--{DUjpLF|%E*Cw%AIUc-_ zz;ooF`0DWBB~57$qm5LaG{0PWIyKqzW<-i-L1qs7Qa5*v2`uvVdluh5DChcqS4GUX zKzV21Mcn;D6HH{cJ-vHj!+B;7jTy6EJzba>^-5BxLc&g{b7D`uT<4LDs=w8nOrLL8 zxt`9WtFI!vFQu&HbN!l)PWN`KWy?*}6`h*#JZC=t^S(mphmby8g?;tmP`fPQJeNZ)X4F|FMV1v!MLq(RzamKA(H0+5g$~bo$NE)AHw{>SpS) za&4TcS)?DhyJnG|?dC1_Bn*<*-G2D9szM;&f7iz|8TDzg)3(+Jw@1lLcv81E_KE8o z4fomr*RKow{s{k4&gXnM`M%Ji_bZpO=h^eFig^9ra?88GKVPzb9nV^&J%3H#*XgZq zR=ulukf_MmsPu9Fs=4d0njL2oZQ9JFbFydY%6iZK=g)o?)_+!yFx|El(&R8VhU{`S znZ7WZRkQwSly~uCGogLI!(VI*xjN(Ew@;Pr@dF9t6Poet1+m@+lty=tQf8777 zzx)Cd&$xWBSg3IS+}$m?OS_Ks&ekpMWY*X0UwWeONA_0jzN;G|j_V)xU%p&NtmSv< zt-E?V+N8HeEYY{Fl_04_(iu>-m_Csj>b^cYy?rkbqm3!y(yBAhn zjMncs8D{PZ+jvpP&r79n-qO#?yYFe=U8`^DxoGdYRdTakmv6ZEe&Noe-yBPK-EF!R zTDskD$xX@h4Hb{?P0!tXu~*)9%QN%dTW14a9P2D~DlHD)$$D>p^=>xPz&QD4y1p& z_$hhHuiWVC$Jw4$%=T2;vRLKTw%%x|FI)DzeLuD1s_OZOC0#}RfAbKUms7a8lB7IU{ZPOH{F*&L;5oiTH&|2y7&QTO7V)A9LB#da-w z{CvR+)2g>Su4&(~Kkqu{W6r+%>_t9Y%jZ9NJoDx~uCTDY7Q@ir)_V@I<;hCDd$Mq8 zPbFj9NsnHx^WW+{ChMI0oU-xwe75@?RA^+@5vh(6x8DwJ>wq+<%u8B{JM4XGoAj*eH^OtlJ$@MD$G7#vJe(F zk#9d-$f0?D(~KT<8SAHy7aW**+ng=f`IEwpjWwIjH7vNfY`3ZZV%A${Sh&Q5trniG z=stb;NrHCH9##v{M!yw%FEh<@E;z_uzW&3m$r5PL0t!_L6N zYlD0*SZ7LcPuzQ_=4@h-kf|7dUSX`bOK)64H-Wtig)$-k$v+qK-PrFn< zWB!vf0&2nvXJ;68L`2TzvS{7EblXZD;Rh2p>gQTctu(Srk~S9YNql;xRktEiylhj! zo(A{m(3J;IYm_w?1#$hEsUswJZ*Lj5a`cnFr5{e*+AUtRy8W-uv9RA~nZI+zo;k#K z@krf_Gf8FEK?gi6jk^saBV(OxPHG&<>8P8eR{xmy)J=n!`NwunIg_Tmd`SYM@&SFn z!=fE?g}Q13>>XMH_sU=0@L|6&)2&4QxH&SL*)1pin!q;YdEunKyoJq@ybF|moNJn2 z&+W0+j{l&G=Mux|%BLd^eYX9X_rvFpw~@nwY_*0to(xZggN<+ecBxs{)FV6V=95Qu zi=~R&ChRk)Z|;u}_IueAGSAj{>0_lr^Ye@^YwvOF;FB=kagV9~z-oJ0(S37nPpr&- zdt%S5C6?Ak70Mo8d_yf`7`fap9sN63Wl}*k=rW_|9Qoff-#T4u>u2~lRg2xWFrxnR zG^emhePlE%Y+YkUUyU@=a_%^nH2nGvx02d|47frjNjWm+>1Xh-?6`D=lB0#4qx5x z|Gn0UBQAo+OHPl?w)2h6#94C=d_6k*b+^BGT6T(SxKBsKhnk~~#T)jAM#lg7q#c?2 zP<4a;3HMD`*UCn%-(g(8KkMt`qxP{^bN8vusq&gR)pZ7Ut~Ku(ML9eE=a%bJzb*`3 zYPsa%dENTPm!FR-nziqlYRjK^ev!7~qn)gq8KNv&HovfPmJVK4(O_1c|M&Lcce_{= zKR76G*RzOoF8j?LBcPHdywjH7?f&+8HzH$Xh1uqpI$XZ0ePUCH^2r&(XX_{GED&%0 z8GUjZc4%Vxk7zQB2wQQr#cAZ%V)%Go$_5PFR zgL&KP-?%(c*>F8!;=T!d=h?3^u3gi;EJRHv;NfA$J)hZAQXZ)bDj6D@NtsMvsMM+1 z@I5O#MKH~N`kB0+7hV<>Do$7^@69~t*~0zVr)sa8{o3#6e%W%-%aw%|#Xl;2HC+=9 zeXp)Hmb$b-zo}Gnp325EPsFb*)%$zp=CX}h3=&tj@U5vYseKXET(+E}qUf65F}*zf zi5HVY{&pul`4%C6@9?&gM4s@ynIYxH-^1)3=BF~<+-xDOc3kki|NfB1pG&swN!#YW zS2S3ssZ5I7_S}~R*QI{HH2Bo9~HDLeiZ5bH*);q z|NGVLKZyqe=dc~Ge_MapG;tcE$fxHm$9Yy5`OES5r+NH~d8cio$7T4x$Lw@P1>2rk zcH8$=uP9ekl~A#foZE1`PUb~mYvA;kpVw77t#4@i%JsdMlV_f8j%190;zi{pYjdAX zWLMg|RY*{*-Qf5H!_)5eR^MLj_RDWBSDIvTcJpS=P7Ciy7oVW2PgA?FLGUYPFpZ@LY z@fJyMoWO7B`_9AzFpJtr1Z>iC@^{l%8>a1RUvX8j8ERZ*_=)j_HKib)( znr@vDZF{ixzl@)sef#CWeG`*-c^Kr~KDjog{P}-C$HCCa&?!}IcA21-;AY1Opa1jy zauV4BZL?W|r|6h1O-!dN{$$muf4og_-~06!0)sauFsX19$?n#QJpOIjDZO;tskS%l z3OqcTrYogRnsxKzdVh1N2iXRj`QNKfox{>}mhD1D&EHbz`SJUIP0Z)}yE&uyhRf{y z+J0+5>x#Ul3RCgnNH%XtmBI{ZtctPf1YGuzRaxt z@ZYO`Co-ZSM>b0+?BuYnY6EtU;m%;)#aVPGByi;IFfv+uJ%g!?ugE} z`_{hx=5^w&Y#m4J$8EO!%W|u#>b2gj{C=#q;N{nULDnai?faf(^-Am9^IKDn`W!CM zVXG?7SjiqzxN~oQA?FSIA19}{#>Qp+-YA{mug_Iq_2=X7{5fsaG0J*f$9>c+bzd!M zU$iT~YqI9==NbmLst+3rg!&v@FZ$P&W9I~h>Z8)n)!ZLR-2cL+{jw1;-x~e=ttfl^ zTK!%1a-00*ni>B#{Jr3NZnsR=6EWr5wcn2}l?yw};vU$fdU40h4POfjzUp{C`uWIt z6-&D0j|)q*7IOY+t=qMz(s}K(qFonbD+~)xT~66MYu}q5+lqs#^-DNUf45oA<-VjTtW%=KlHp^v;5G8{Q97n4%6^ z-ErR%mGNauRL;!FhbNxj(^FVg&(&Z4PI6hcY1lIP1Aq0F*Dbv}ssFnx`KKKGABg;G-2cW-I>d#RW2bXV&f zwxzw>wK%vqcEh3xvY;_*aJdp4i9sTT2fPX1QyYO#M~(fP05 zIP3fLPcM|F{`T6;JUfJ)Z^4OUkB^^QUi;yPs=-@9zs#I%E>#g3S?4v5SZzoWj^=R|2RuxVD#VZM_OiYTWh-DusSE#$H$KK3-7*fPPSOde>m&I(vlv*_5Hgz zd*$7A9v$*#G^o2ha~1zf=GmueuB3Oy&pGz5VfjZ1mJP8b2RBbm^;!1VY@2U}Ojebo z%Zxe7F^e7@sY|#F!!Jo%?Tdpn@*t~ANkwfxxmLo@lH!dxGWo*kE8@O*_{W4zO8?M#L3I4wq zzJ1r6pE!GUS6S$VXZ2z%Z&lK5{Qn$zC-6q6B(D5u{;n;rocFOEI~a02SyVE2`Vm9# zC$9qLTkpLt`{=mTE6y#PFRmVE`1|;BtmEnvGiD@wXm;4YVE!&!ot5@1l}i+bzp*do z?H7`;tY%+voa@^5M^XRXzxwyqzsj;|n0965k!FJ}ZUSxFUN#puE1#Lnf8>G6q$z*Z zUN|Z@T~hcaUR!aYETyw^ zEztkvIN_x;ems^y#bt;8bAJB;G*F*F&cP46sGXR*qUVV^UhE6T3@|KFrj<{r%( zK41GXA!??*j25Tnj1xyLDZV-RVCULJQsJAAxZ7C%$iBHgS3vyGvd2ybtXfhx-e7N6 z=-IC6^8V!mllotLCy$xW{r7j#Y@-uBo8}x9?q3o0c3FzHUfCKkp|aD}A5SV3COnbh zs5i^oReUvE>PCgRjisIV3%#PJ0TK@Cd|M|U@cJZiK)F{!Krepdv~_WRV=vCV#n!n| zw<|GM%IzK3WuCvmM>7re{T8p>sPQN?k-be}RdBkc+xq0_i`-iE!OqWne@~giT&=UP zUG6Re_x4ih7cR%Ete@%bcsw`wR?>T2UZ%fyEed&Rl?ty;`uJD(P~k$KeW#r3=O3SEd0pB%XG z@f{{ZNggqa4~2I1HShHA-rKY@D0$yBjg7T8FK90ky`VAi=&dc;3;0&$pH+!#$iJ-i z$CpvfK{Cw!jl(Rhfed^7!Eq7O+;#oF(+skF_ORin5)2{D* zcXfv4^q3>k^ElfUir1PzvqP0s#Dx1`9IZ@w9Nf!RMlD0vn1a+tKrMik3PKZ zm0bJ&8ddyLyuv(%;qm!7?~7*p|9$-H=KJ#ndIEfAO5!}9MOYtdo;QE`^5*&dZnL@W zHR?t(&G~rFYo3{$&#SZk=l?x@w|APV?Q*TBI`wDg=(?Q9(CpGonAWL%Y2t*awIL2+ zCsohfQ*W6lpt#ymPGizpJ{_6P)|Z#A@^xrFIlRp+G4`j3@cq89)+Ii!dQ8W;I1Rm% z!zc8}Ntr(5d~>-vQgjAK|IbrvZhp$*Dw6Ri5ii>-t#0q@dyq+StFX?u^5%T!w$`0T zJ@+&|IPkZgts(XCfvAIvl-yfaJ~{n1=9i>eh~OvxgHyJ1?b_k7wmry};f0%8L6y*) zJ8v)Zuk~Gfe6{Ps8bhAnTASTXZY1;G+qX!_cHgWG48QZ={8j!YEcf_nYVnG>uPlQe zY(APGpn3c9$wj)cRkwa~xGvR=4WA~yf~RBe+OL;o=5{piI{2u5z0hilhYQ>D95yHg zTv-?JAfKcCxABEdyUNTDyyg77@6^R4hvJl{a?5K(?~BUM+II8dQOD4dtIj=9@t(UR ze>_z@ocDI`VTYZ}{)#`AcmF8!EjO6C_JX6wg7!yki&pk>{*yW$XZA(K;K%ufL*)t5 z9&uIC0nQhr%-bJ&yswVf!B@YqX@XGD-lMEdE$=ogJfLfjvd!>ug-|Pbg=n?in3_JX@Bef&*rlg-)Wujnk|>|hxfS0vKJFqanx@< zuh+YgePz`Z#={Romg#hF6qvE0<@tQ2d0pRKicPsE@&~DQgl$NbCZ zpZH%RIEyo-o?-Iql_{%NKIvXrBOkSWQ(%SKS4|HGnWGJNKB_VAt?y#0a25F8;81VD z8WEwgd1`=1SkO#89VSns4@{y@LyS`AOs;-jU)QkCGpS*z4W9B zv3|?{pKiFmr02OZ=i`ME+#5~9rEMxT|9gD;bii`jn!_y`d_SyN-psrbY~uc>a+dJ( zZE_#=whMMl^ADQi5?N$WKKuBG_|^~gM+;OUj8)r&_jf-$^4_svlEjSZTmmvrInTY( zV(wECmK53%*^_ejKYLE)RK~PF{CUDN7D5{8mgeAwI+LY2 zFP;@#%u;BNWM(%o_+T>Wum$_pBdfyJOggpbN!icWpXKB=JFmW)ce0|#!m`uVZc_gJ zi2HZ;{fvCW_l)(vY+23s>py?recPR1=XGiBgEbFYZ`^%XUU`md>N}%21G&RKdw-i& zZQZ|XqLXXw^88oNR#;#D5__}$(UP8DjbiVAC)Zz?`%c|i`1nd$>4yD6fg4<1o6Q~v znB9G$aN6;5{2asOnIZbiu3s8i~_CpPb=JS@Xc-z{y9rH^4KQ}R=b;L`T3UINL_Qn!qH%6>h5~! zlT!j%zFu@>)$xs3({-2Y)h)-B+$&UO=4Ze9SjVk-)Yc=k%;m^j-&FM9De<3| zl9FF!fAM&Ixl`@kxi7lge<%taG%_qs*>|vMS^Y^VlXH<`=YPDL|0wT`qC|4^@rH9N zO4zJ&Hmaq|Jb9?_?$*Al_E}QhFCOk&`L1(Ta;2Kl>V49U+$P>u?9H|JxBZ>!<8bV5 zBg6ezPPv!b6J4IO%Y1XrjeGQU^FpTYsf@R#J!nu>QsuelHIt>lWm|&lB#$HF-!=O4 z*?0Xb>egCXe?uv6@z!vu?4Gk6({_hV7f)*UvXCh=sd&6Tb|#-zz@B~Ig-$=HlWcZ6 zJMG$z+db=U2!DTDw^bnXgz~JK)53Mvr?l;uU7?=Do?30zyP0#t@8A2(81(cabd%1p z+|b%+^;3Dxx?kU%Eob=VHOG1D{Vyp~7caLz{qY9he!0GM!|r;<`R4=P)k*nZ{*k=A z{cz>vw>uNKkJj5=zy96+^e>ZiCGmLP*Gq+TJng%`@;e*9x*cx6|6k_hj}8TM>Mf7y zZ?`}FO(lBqpZn?7#{-n?jvu!;RIk~;JS>0rEG7$4_4qm8`C8L|&UdtntZ~hn-*7ze zp zbH1};#ueKWijD1y|5@z2bI9P_46jRXRX#k*VV7FAJanmla^-caxVi&hxIW)ke_O9Q zxAe;u=?wyBuGl4HnceogDzk9H%|i{_*g5_Pq}==W%{R!H(=b3c()|9O!;Y~rNvjrG zF0{_hpm!$2pVOkGeB*e(G7En0wbtowb`=at7z! zK-ObI^X4{bc35)OZl7DTTD5)qQ5m@`;cOY5dQ%Ref>-W$dwHkL+0l`<_`dz)Yypon z@pH#kS?y-J+O_!hYMD1@r#cB-o)Vt?e9yuob8|AaPNqmRbA*_!T<)o5@9NlE7~y{S zQ;^8*N9Mh2dJi|1rfpcO7MqimeR&5%n(={u*J2Bv?+eK~aA42;n5{7rmUD>h?Ow5M z%EWf5ZR_0Yog<4m-W8W@pDvQ1y;QfYOCm(BK(GDS%ml|tAFc}h*>dGzxWJyJ3mr=D zL?<(bRZ1S&7#tg8KP|*$=llaLUu!cS@J+V$dsDh~+mmbYk5U;9p1x4WqY`$cZ$kt3 zv^_SgALaVP?mS(QdCX+K$s>-Qf1K+#EIMZ_AgEQdbiM4xcMbIuUo=eo{+VI-r_UQ6 zFs{frW^3Cxk>Rakl||IsM)}nY4}ObeYdU`E-TY@`sqWsM7E#NT#-^pGTo1qBcE%)e zCqw%dhr4-Y0v6tzDn#`Ud{gUxbt7N4M!5Lkrzc7#dv4mALZ| zM>FQC{%t>)QqnuCWzq?q&-GSJYIRB)Du!n*uD(luf3Ea(&C&cBtcL@GP5o4>0yf_} zxcA#(p9O!Ti%yE3K5}No*>{1A0yi&-XUQ^^&-!BG7WcV(g>&ZIFTHv>m#%JeZ#!&T zJ3T;NqVC-Fz!#po`Hh=i=Z1C`|5Uw|o{-_S)E0YGfJZX02Oxu5atz8&9*2 z{EVqQ&8nV!rle%!bg`V{d|@&jQGc9dey~3M<0P|i)8f7Q?a^v$&aYV3C{nQG0893h zgJA|@d%wMTxvSv!Z%6CrTYiWa9gh~25h<+KBBSD&999Ro0{RI+iPg2 zRnRQ{?m}*Sx6O)8H>s}sb-nr1!J45~nlZ1PWu&8q9$Cd6)o)HSmcIKX& zr+YAOMSacBo=M9u%_y3&_K7{?Oa0V;`Qp~=H~djK{rL5_!b8p946oVy$9K)m`dV{T zk!!(%fd9gx>{bf3$tHH*J^PBX6({m^+va=-O!ydn#`668bzXIg6FefeO=&$h<*5$m z@58QNm*u`|OS76}9T~9EbrGw|;_rUqY@2J=Z%yntq;KmfJqxCWB09&$b!k6SqRi)XXN3<(1`~Tk)bjd${f!(e% zYF^nstLhj6=loi?ub}?_$x9ydzUnyZC{762H2L=J1isY{5$(zAHFp<(eh_};+3LQI zNWIIYSw95J)HM6gz5AW{Qa|Pg|G5yu-4Z(#m+f{7czSKw$p-PI&8(sRikFTkH5C38 zp0S{6fmF4-Qf>OHu+!RHx$95P|7NoCM&wkb6HWJv-5*yMzCFdWVr6n^V14?Y=^V>0 zz1UmTCC>HOxA0)MNx#C`b?qlNDxd9;{UMuKo5=1nEpMHCu2l9^wq*}_baWEgw(5s| z`M3K3dllp5?@Jf9PL`XsFHh^kn_IDol3d=;cvOWsyrlgt1O+bG?hg;k&EHa9z2GeS zb05vw(Y6or+PJo#)p={YVkY~0|JW1tN2hLDyG+dEd+d>)Hw@&?u4UOKo9LkXab@M* zlY5WGthCIv3YRqAc;sOI%6Bc3gj(8OeG^olvidjI^i2oND@@oKys9>)Tw7OS>sXhy zvL*Di=A0${mdxg^OZu;0;ag~AJV?q{o8d(zoLh2i<@W1%0K-83IxNqn(zkFMsirXS_UDa8#^b>8;c82~J-NRTqBS(w0`b za^tKBmVZ)VFKQ*8?Y?&~=w{QtRi%H9^U6L^H}?`#IbAPe+?c$1j$ibKj}F08WPh|j zo6`Q|#?*y>rkAFrGdaA8emh}#-=_M#-#iX}UugJFPwS3+;X=dJpTc7IXfO9_(@&}2 z-gD!WrON3Pxh>yw)T=io@>}13kbZhy6W0!zbLSqPy~%&|#(+oV?Sf1Nd-A#7-k@(GW z+p1Zm@~V8NCvXMqeEQM)+gi8yrv2vk6 z!Qzlh$4%T{&t$aTwzTB`jJZGFY!+7$n*ZqG8rS{voEa^Cubj^_VS?Jk>tf3@Pn7Wg z`o+FnH}uQIBgeg7#3y+DZ!mUWR3tGg^6@gmHP;r*IGV1xBK@&_(5&941s5KF z_rLD-|6}%)s|W83=AD(9z4lwePU9WC>lHc{R$r z|Mm$%&`Jpp#(8GDf0{Kh?EYp|(7-FUTlmL@bB&9lgfNf$q- zxRYo1>iMCu{p-Cxzxwxl{+DMr_H&pY_ucWc`+r^i|3_DMtK54LAey+){Cm4^pvGj^ z**ZEQ63nUlf0|Zg|6a9vz4KkO_1pjN_^(~R#`AghrI@9zY}S|F@T=d>dA~@7=i9er ziCM?q#XH%1H$6s<4D`R(Ouh6>HhvgY&Jr+aiZC$44|Y4KD#FIRf% z+^1QyXFtBtbLr!fN$hQ98t09kZ%_-Ed`!z*Sbh1zH+^M4Zdd$F-Ecj0XIkr}T?L=3 zXSw};FDI@(|MjtHMKh&t-k4>uBU#e5aLFf|xKl4~ZE6YNTh>r-`lB~OyQj1HUsUc=4u|qE6`Vrt(R@2=Xvy{P(Aa?0jheLLGO zg*&3=dV5_K&)riXx4ER~`KE>okp`#p9-IqbB6R4p%E`?^p7~2Y?c3RR_*PryqDLzK zRt1O!v8DEG<$JfiQesO@bb;54k{!l7Z_3<#Gw1ejM z^-b#)$CXKUI8Abb-<@0iZDBXZmwT^Mt@#vgzF(E4QoQvyfA06&tFm7Dq|P+gv3MDJ zd#x*5*^nSwQz`o;Vz3_IABTUXK3@4ik zC;0jZu&K>=%@vh<{qWwizJszE`@Kp|9j|3k-!kLqoXn62=Z*>2YE$2-Ic<3&eyLtH zz^!ZA<^⋙_z!vJQr9q=DtucUlO+Afy1$r#SP61bJ!C3HT*xd9u@qY!}$Aj0vF4c zC!z5ZQ?%yKvAum|w*K)qI!r9~Kc|KMFBWfR_sSPAfA90}d9T5CIeW*#MI~Z7i%huo zS@V2}Sn151*(aT+xYJU|rR`r3i=@O!5#!4GW9Ncyv~J{^EBUlZ&G_=P&C^f5OnvZl zT@mYli<_ScEw-FkD=y>BC(5?};o`=>h5YePHy3wKnBThQ^$b;~q_FBxclO^QOHaPN z_Gp5F?Th@F!p)Bkd92^79ewa}AW!AA@2kUK-;L=sx4-mtKf{AVYi8Wbdih{6)1$h) zeMgTLzlmB=|M=4FXDhpw&$fU6(B2^|J%91^5QZJbsRtErf2+~5Ibok`x~0YXiLULL zsJ2F?H>ZxAZ)w~UkeT;S|ImSTx#z_mTsJ;JXPLsi?E zU6xN~PMEZcv)g%*U!=fn{%taO-A=L=QLPSp9-1ZXyt*l1NtaFi{)5NAFOYg~5OZT$ zRZM$+gWIQ!d5<0|`dSw-3s>p*y^QDzc6fY)dzrrYH=P|Zj0gYt&Y9~vTVu9n$rQ15 zMpHdgx%TlV2rwJ+9A5F>ZdZzv!lK z=wF>MIe6`<;-^1jgJUw>C8T^72{}CFF^T@-G_mc@!iV}tjm|xYSmNO9!MNx5zS)oC z#62c&xbAzyMX=&qg;S{AtPj76*!8B({?l;b!@mi94Koggx}3_H;lkLJS3e;)rrwg1 zx#?e!rI4_(lTt+KlfDINdM;0lSG4F)*c_>}w_W_voB(gV7l+IQ(q^vz_^Xpy;!t9T z%|7`yG^_39Jr4Vz39pYg3; z^d{!mv+eVGVvJmuocg-bfJgg#gSmFl=Z;tPet-TXece-DDfoXwK)Os-kkY}(Gv=Ro zHay!Kvq7uc`n#53*3UOqMc&V|^4=6NZc7Vz9934ZQ?sed=VIHh()d}L#nFm?r2fQ& zB*d-D-KpXJr*Bg7szooEm^Qu%;52*f|F%MGvU+&#k~RL@{8_^!_f9#>;rF(1w%Wm6 z>IRVux#}~R?ZOmeX8E-UEIlK($A!Z#HSNQWr-vRKJn+(u;lqq`srDk9w12PN!2UjM z!SbhDsy9j6`a5k=akv#JVq&vt!M#HormOg_x$cOa_j_9U+dJptG@@P|uL`uk=Jx9N z`ipP2%vahFwmIvYkIv7_X5aGS<8v-I2Q{0n&3N)cd*LpF$@LyP%!?gw9B=-hU8>IX zs6uqoxyw(xt=8(zSiQBD^JDU1R#p*a*%x94b{n#Ko2&a4Y!B<@Jf-82Sl@Nan8TzlgX*^T=`kLDx zb~+^#+xra!@qXo%Fb`+eo*dnoC`;*C@yLk+^OR~$IrtWAwt3T!CVx92%){h2a zYw|PtAM6b;*5H+#)4p!^E|D;e15vmBv8Hi7TxOlODihC&giZ(ENnUwP@FQScwr z2QzwtuCCNtG+Ta2%}NWl8xfYFhuc+C9ak}IJ;|w1x+&>ZWpeFF7Je?vc}kterBzO= zwrq*XJShCc`<78W&w2OnD{lubYq0GIa;k5S7m(6RTM)Rb=?mBTkmZp{*NXP9pF3^6 zNId^q=Sv4(yzH4W1+nK#%)-Knj|E49qHh+HqVZHHhzOPDu%_<$wc&*Crx-)e{QF>sd z-P8>YH|kGmtykVTL*Y!d#Z{gge{UrPW}SV`YJ11~TglWtHs7b(Xuki{8s1gG;iVRF zI8dasAn&ecaa>=^zm^H2|Giw88W@l7DKvXyE`CDgLi(ygZLzETG7Czc7#Vzj{ab4j zTYxqDHvh&Cci466xh`ow2tKkhaM2~Fe;?J(ignlRsQ)O>(&(382yU1&n;05{huN7e z%}u9IT*#$>$b9_LhwvvJskPHoQ3jP;rttChXFXhZFT2{R;*$rL#iDdq38 zyZeI8UsM9&#zsmxbE*R zHFKR@=9Tv^EoCJ$q)z4C`F?oioLT#Jv-TLx3P1j=B=arTe)-?t(Z*G6l6reMBJ%2L ze^_r=I6dcuPiMrk152MKXtg)btlKlkPJw%iqVF{6cX#@%m%0jxZ+S1SsqD6Y(xf1z zNw*UJyQ&#^w0Lagn@}GhcShpStm6emkIZUVlRTeeX z4QU&9ovs!+Qm)OpuGGs_@Qv1;b;%y5I4=lTb5zGa^Xi&E#oU8U@5|#}CP}`G>@8~_ zUff@}HAi2~BWfa3<~_Sv3+i5abT6vcxTeO)e{?OS4+E?y} zOttiXy3VwZIfd6kBEH=vyrEXJ{KiiC*()8VC5CTG<=MJ&R`5+W%>{3#HMA7$F-$f! zN&jMVkoj_i$5a15$1gVUcPX(hUoiiLPwzY(ub;0H7VhF{{&;QabvYHWouAD2*RS$^ zy}904cgrc6AIF#FzU0U@7Mu~>pCkOz6I)n$8vavjVr<=hPs zmZ79!E%$~i8z12?^VEZy!jo)vsrB0ACd^-m6gyiT?-z7I7O>Ksp`tL(orJ3sikHSLjk z{XQjzJ$AdbZl4P0vuIo=74z%LgD)41B<_nTG%z=8I_%rTI7!Sgl__Rjick8YITvp> zHM761l$kB)+)(O)D6x=X3CUS)O-tsW(^ZrRgrLOG0%!b0jiZMgClpIu?F2 zdeR)F!^ID|3${D6M_wplFOOLmuCjW6T5F!k>4y5{Pdg*KLT}ppntna}*mqXW$0srQ zvll!M5n@Vy7_8{Rnjyz<@GnEB)rn_@F=mcdikqkYXYsmFFT`r=JLQX2oYWaMc}cFE z1xs1qn_ZM!z)@pv$PwPfu{qhy@!yOYfmVwZdiAfpd+PD=_L(lL2cgQpC2tjX?zo&3 zx-Vt3*r}~z^-K?(xZRr+_*uQJ?-{LjdiGUjTJPEm2GiFZ=uuCaQ>r>SWhKM4l2YRX zt{2~2XineFd*5V@Y+v|Om)@6WSH7GxQ-^E&B)RwXJHAgnel<;LfG52b}$q^ z*ra&(RQ!sQK^k)|z0ePwyz|xRtMBt(cvUTrn{Z_6el@0593f95yQ zPRGiWi5<_con3w|Va00aI1T>d71L^6zaLDvwrXQ2So&;{2CVH#k*b;djmN_M2*;xt?=UBJBW~ni9>{Z>;kQf?yyeL7(*4Dc!2%Eh)5l-)iYSR_!m&h9@~e0#mo z3n!J$qJN+DpLCh%X_PgwdEOn@ZEVp+%O;u1vF z+lgD%dAU>SjMUkzSHcw?4;H*j-@+*OG3tt2w^HoMPbVW4PVbh?y4W3SDB11deqE_{ zo~3BfCI1=C1+q35J}r;43f!-APC`U0ZvKoF^%LUOM(kPY_3-gU9yOPFel8zdKTUY( z{5VE`piga%2cZeIVv#}|k8gcly2U@WaEFKB zmPHMQTh7LI50&rm2~0M$Zs4BLme%gYe)Oz|dWF;qpIgqXN7Ajd zV$&xEF{}OFna8uuEGfLcA#-oemP3C+7l#I$IZv3gH0zb?q2@J>V$Yi%OsmpP`OlEL z>!VS?bJen~OOK{?u)LddX!GltDhX_}#m^oInb>GCZBlArKkw(~xAZ&rMZ!-I6t9Pqt*(c!x8q@nDJ>Rl3rdnHg?)i0S!iM^0UBkU{-g%$i_k`Am*zDaO z;i>yUZki6uyH6LsZ(Z-ZkVWG9)LS>^$E;-Q>3j4)xP0Hy{K@nGY*~|{^W{!i{mvIG z$F~(fouI9@^0t?#&5q?oD`I)i%`=~PMgK_9>8+od&=21< zd5dOS@fKc*ZMq%>^ZyI^smdKHlQ}=*g!)6B75e_StR^=b?AcJpq+e1#eb(`e^M4Iy zT7CJpWa_2(WuH@jUFJ0rvAHf5=;CyK?V0IoKOdGkBmT|v`JK7d|Dv|$%nyBi-@tCO zw1{`X`;+zDZL5mC|HK~*h~{{eJ=0O_fUM%CSr`AZ8Pz_Sppa`e)1z;}4Uu1)_dRu1 ze6CTQE}Xw1m?OLQ?^E}S?q8Vf7d6)}KO%b1g5#0Ck7_;Jj33Eo{`|bB_LuAOo{5Q? z3y*8wmNqxJ`+1|?U7nQJQOlJ&H>F=Ll~B86ym^JzkJ(GM%{2KCn!V%6?g#dqV)gew zJm0*O={oQ7nCAS}psPP`IGC#+rz8>Go5Sr{RrBYH#P*f<)@#K zWznubD|vg;?QLIc_dE69lH@)%mEo?5@mk^S?|O{$_5|DCsC*D~q07`&OXca;Z?CKQ z7~;gE^55<_DeU-x;d$ND%d6+dZ@%hV?HF#Zz3bQQ4}V@?J$hN(Yn_Dh%AlIkta#3%Y4H^?mpEI|IhH|WLMy%OH&lfcHJtdNIs-o-#I-{vLJ9{Ufbb3 z`|Y9Wv#;&H(p&%Tl^Xwp%Gj;3*PPRPd5=%f*e#pTurm1WwDNzit5;<#@b$@j+$N~X za^XeB>rKy&mD$hb%dg+{=GZpFydIU1Zy%OtW#11zrM;V#=gea*D}NWk3X5yG(J|A- z@}qNI7Ij=o+M3v;At`d{s^c`X^|RkPiBEl-!`5w~bB&g;#4UInv1`#jyoUe+)5+ReAoD(5|Q>jQ&V8ZP9J z?|Ylv6zbx2)p<{D7vE0<8-tW1R?-)L=nGdKm~DJX^N$O|2HUMhEvsw;8lFAie0tn_ z-GK#B>owFgJ-0+@tUCEG_w%~ErY(U#<2HNug?b4YOLz%dObedi+b}b+f^S*2eWj`H z+R!W|hm5@<#xJZ>yjpwHST4x*O#7M zrJ=`f;rzAvZtC()(GNO}mRe3M*|OrUUYD|irOK+~7oYhSzUkW4b!mQvll%3$o!yG< zsgsrzf3KHg3V7nB+nG?aU~6X_=M=rXn#PN-E9JK;;tXp*Kl>` z)%PD{4d43s{`%jx(F^;w`|pu0=2i65W9FN+H>K!Z$PPoRsVPZ&vtKpem-mag?Y->U zgNUi0b?-P`pM9XCGi6rDVLxL-co$e}u`jos6Sbv2;jGNn7-x-jtIyWw1SfA$SIE)5 zmjC?(Yu%THEDM(3dA!@3`#iTyWm|n^_{rOMMeJbzrhQE^1)9taD(uO>cndgKO#mW%rJjyk_Nk z)qa6@k4U?~uf*qHSBviuuzR&w_P6`($lDbP8|%I{-#@e2NM4jl{z67xVE)D~2BWDy zXC6B@H5@UkSQl)XV6kjIKhkM{0bTkG<$Z0q*G#z3VrdzX9>`> zo)xBn$*Kaprxq}nS|}>2Lyz8??i+KWtPBm}JTf5oiMo!Lq zHAR_DyE%$4CS>0IRv~&TFnexDy`DkvrO@KdpStHS+*b9xLC8pdMa>1L(*iOvn_he~ z&WU*at?vnwj?jh5^Sp`;(vvQ@-rS&DR*}MfE≥lezIutwT2wR(aGsTy-r%g=Mvw zvuT*avrRL*BM-K1{ch1wzc1$fcBP15w+f>h?veMuT{tJAyhAm_HOXVsgwOM?{ry`X z%F{TdrFZJ%mlc0xm|PF0{?xgt^kYKK#Z2C#kGAPTEcBnq z&OJA0yM>H*^@bP8m({Z7Pu+dC?%C|)QbtMPDNpAoq(-fI1?<)w0!7mtZ#-uvHm z{yQ2<%iix+lwP2z^8fb3jbc|+u3ovkyn`{VrRBz9+Zo2cyXDvG)$y)79Tp>{@&1gL zLu{Ty?azmg?&_CpZS8Mp@mTQWTBF>8Jsxwbr>r&?|IefQUF2cK)PllO3!eloSK)Y; z^0vY5$dlOu^?H(F(E7Q-txhqg+&iZ(Z^_&@VfD;Yp~>qe7w^2s_oV-drhxr6`y&Ci zj}sGjT$onW`fc`%lnFZBGXz=+JzAvwgpNLcHHY1gbB|iaSEG7Pw#YY0d^3b5>d6`` zEapgSvwHIThU|_#>laN-6KLXgTP)106?KVsD^pQNu1rKb$E2mxXSb+5zbKiKgVEO;_6whkQn%^gsQqE+ZbD4g=TWk?`>C)%U7h4_k z=AQiadJ%VX$e$B04#|tghWz4Pbh4&2IzPun!IwExxM0qXBQD9y9?v@8!uxmTg>KvWX#%S` zSLl02+6OhrRjJ&5yW3IV-S?|{+?NyY-`zR6H}`w#&fJB?$C|`u+1{|cwMYBTnggYe zpT=&v@`Opp+Ba?Pp`T%luL8}!MVg&o@bm4-FCmXO7Jj^Z)#2XOw|Q&dM#o(!>w0FN z{m=O{^VE%!71@8Y1?O$WIsiOyVVB!9Rt$Ki6o%>OKF-Ag*S?9?tV z-1({4eOmoDlZUG|9ydCjTTv|5-OYcZN&3T`){U39_4au$)G(iN{@3B{&#j$fSTCqw z6tw(s>|N})3vW!Hx)lHY;XU{C+{FSe=Y$Mj#xB;$7JoAByRFL;x1gHHA16|5-mFdf z!z$u9J7JRlGvkXAdWN(2Ke%9Y=4HVn&RKhIUC;f|ED*ZseNp{vhD}?Kvn4sDZ$DDK zdtsi5b@G!l8JxHGe`!2XYUA*KW16 zw7=%mkz#m-YyV+|ilztb^_6WF?cHnkWdHtAy5a7=d)sQgW_n2d-(?uiRl9M;;Vu7f zO8$S6yy55BBWuNW$WPf(a@xM{h^ffAh+Ed3tM&i${z*=qJ$v_x8ykat_Rqbt{D-`V z?X(4Le-mB$OQ(5VT5nkPr$23d+`hW6O8@vpE^Yr=)+E2tUZZU3a+Ux8l9t!GnEVnI zlb5KUoS0|%`}dr_#;>za+D-Vd;Lq1JdB5&H)n_$iTN5XlG0AE1)Fs9W86W?1A1Ife z4{b-9LXOg6HZ(DWj0xY3JUQvMnZVxP+9g*)A`QwWozwg{>FEToqrp#|=PKBB>{H^^PJ%d^JMvuT0PRFw>F2Zc_^*vvpKcs#F;H>Yu&KoR^S(1pOE@2Sa`6g0n<-iw`ZoIO&f1r08~*XkQ(${$ zz0`Hr zbd+n=Ur=@nY+~_Dv;8RjR4w9go_XrV zjmzqvmMvNF?bw&1{o5XI&AMf!|9$P>JezgU^EVCHxK;Rapae^I+GJ!^c} z=@MbYy>^4z$~!X{(k}&@HuWv&xco(A?mxu^E=Br{i%!hZEoo?cuCKuwaHN*$M}g*D!wQHF9#kN%#cq*t%9 zuJ&Eb)8o0;5w#_|IgePRO}?-=fW@*7u%-*Z!gS?}+rPhL~H#pZe~XI|K@QoF3bUe14x z>V#hP-hS!Y&IQ6Om!oFSe)xD(jBZX+X?0gY#L6hi^L{H_gUllfeyY`MeEi_Eb;;HQ zPow`AYj^A3K6^uRqKfkpW$onSBG2oUE`NDc_1W`P5>Hqr-vd7>x8|htPQPzDuq^g| z-S+fS*FpAMdhr#dt0KW9GBe8Bf=+FHoo2Vd@#n_QT*0}z zN7e4HpV~UR(L2G{wkq=G4_5!fah2EZYu99Oad^~!y;J5R(9jXe&zv3lHY9p>63^Ya zr@n7X?L7Kn&4DtNl@>d@=5*iU;Zo;b>i)h`N5f>LQu$@?K&Q!?(~eoXHC=MwnK5^1 z)-0=(x&NO{@LW||nj^!!;#isXrMgb}RE^1b{7=L;Tna3&XS((5Yt+_!{YwE%-b*5m z*-TM$mh*ZlTVJ8!8ZvL=<2Uy>r*%9qNm`t6j@69oS?|Wc85RkP6)L9n8X2^Hexhh+ zy795F5Qp{!mEXVGcZ8ey9$8ad>J{MIX%PMSUFN(*6YZ7L@1^U`71*&mz3-++ArouY zeDzg5oEl}BQ#S1r^{?$I-|eonN_?jB+q?zW#q#{rUKt!WtY)rv3>ML;ZC=myV(P<= z82cX0>nq;6A9wqD;#A*`JN~<(J6^UjH7RE;S1-F>yWK1LUBg^05s$_9{8$dI7ntR< z%W1K+>pczoDccv%k!=vU*_wU(!HWlr?(MbkohtSqFjk{BHna0f-Y4y@W_y?2S)b-+ zw+1wNo!&I>L~qgO)2qr@jO(WsR6aIL_*EkDQ13@c_7!P~lD!N8H)^BB9!xJwdupn2 zTVs{frJDG!UFu~OJ-r{~hTPZ4+hH`}$p+EXF>zWsSh6m;4LnJI}qat}5D$ zO^t0HOWl@_U)nqs?tR?6X0d&Ow6RZG<(*ygTpLUIU1ZtLBp>+o$E{p<|3%&Idh^#8 zvUC;7uDCa(O(~f1ttfrj+lR9fp7<`2+#Djk`i)*?RkVd&`hSDF`#(B{KYx0$hQoYG z%Y2rj8MX^LPE4>`UG?W3qfyB#)yf6^-{%YdEj2#O$DF%0d8LcI@tsPxPUE-lx}UY~ zOMYN-AmMy@=dmDdRhc<@Pfp%n9kzGQ4voxuxhJnLoXRo_liL3%pvTqh#Kmtvc37Lf zlXWz2Qg%3=+faDxeAh4Umvvjcx8^OIEixx;b^oO06Sa6{(}T{PHoL}pb-AYR-B(uv zYpo?Vt}(eLvWoMzgys9j&%IYKbDQU^sQWf+k+eWoJe$no@UAbr6F34tTkPb2G*v!O zz24+a+m(9Tqa91WJpA+R`{Q@9tNA8}$`}898yAr*d@epkaeLa6lk*}J&sje1cgeb6 z(^j>3-ao5{Z-3OS6Xq}YVm`m`Y1yr-oMIg1|GDb5VjaJ{Y- z|Nd%PYyJbsV+sA9T@Un0wi{%27OSbJ3X-?Fwl6<)Dkyz9$t>QHcD$e=Hud;29#0wX z%d2O4++PL<5ZtAaVp)E9YdzQyCvziLaN zq3?pU21g^8yhW^`S*yhA85@g>s;Z2Be>lBgJnvi4&X~3SY46wDuf6@FnKHNp?(-|?%tK1C5`^!{5rWnqA*kYCAtn-AI zv$@NosNzq4&)>t>zkYvz{qxsHUrN3`yes)|{^y;GZ@!-17gzsa|KyvuuNK|C^IvR3 z!nxUo_aCj4tgQUZ%BV2$m*^9|gw)@x3w{5}xlB?}*%mJFs$P zpUZ8Fe%jfaPhb7{%QT^I^Jeq>yKfFZdVTAz%~`hA^w0Cf)Hh$>P`xoGK3B-@o%x2? zwd?fHi-*r%bHDEQ=|`WB{<&KJYIXLHGag*7$_nLX`;XiW=-CyRb7SA3BWthCuw8pC zhxIO(Q*4Ltk7HYsnN^r}g-LFj@H~rEt)fLSDDud@PsRS4W&Z7;wK)TSYN*P zsrNRCzE4w@eF^DmdSm>_{rpmm#q)}7>}KXQf4G&49!^YlA&qZ~TAP9-4d=dSg0 z@z<^Oru+ZY)YjDrI zmyo~FW=(y>ny6D7ltkCqzWBFcQBK$WiUlTw3Z$nW18V#=yH;qM_-V6CO z+!(_*^EPCCZEf4Kxazm#;_YjjkF!0hi@V|cG;ecRx&QXdJKsKST|9BkQ-PCOk0+c_ zlvCLGXKR*wx7^~KRo1j@?t;uWPOq5!Z~c)pWtwIjRC|I;AtZlxwWaj7 z%Wp+83;+H0ol~=GM!c{4^+ok7w&xy`j!s~10y@eEWu=NVM*Nu3@L{0^97|P zbrV+p%#3Y%B%fnknC-pEk9(p)!s#b^jNT?bX(^W)dS>+~+?>W36PjHcG+l+!+~w)M zjjmb}uP10uu2x}OZECgh>TR*Ikd*w}D>;rGoOexe;}4#klHeTi)?3HE?cL^6|864B zye=Mn$&1om-ZIiFCmwq{|C%yu;N&u&mD@HSWnSj!*(9$ zEH=KM4VpI&p5N$m@Z2=DHP0Wk9n{e4h}oiCFD<{p$8bSahU~rf3qI&Rdn1q|^6Z=F z?L=jvMLgPWuEDYMc6`5?I#bxh$)|np650E*{9U@rTbvKGFMK?^c3OvPV%AZk!_sqd zns4x#Gfw$!W_C|!n*C9Ml3li97ZUQVZ5LL#NuSgR6Fu6^X)pZO%v)+rM#|^C>ocBj zIT?OZS)|_4#A%{n*Aa~qzk1pet9KSI@3xY<-^us!?(gr(ANHEAo12v1l54Te_{~~@ z-4k{lh@GJKL~n}T70>Mg8>TQwKUm2jQCN{N-_h!36^qtk$xt<7aP9{Jo)BziUl&-0FuL*I&KkW)Y;$_4lvTyZ6@%>h~Xuv%1YSx2a&c!W~VH za;`&jn+oJ-{yuTX{h8gSFB5-j+t_^7wpqX=$=&p1{_0e*PlARDVciuzKL7td|M_%( z*y--ioXxkpHqPBwzBuQ*>c_uswnF7fR~StHsDBGx-7O;h^7yNpobT6KZ!78l^Q&K! zfg>kw?eo)Lr?ecLWq7;vUVa-D{8Rj!X16cq&8Ip#f>Q1IdP zw=-KVUAF!5N$v3Z<)@zBQ>)WgY+zB(e_9l}bK3cTfBr2GPbz-#?#HtY4`;t$_U-lW z-RJlB9_oFd^LXZsJMYaq@2J=$+q493td!kTv)uprsho17M~y#{e&7DfzdUOJ`ngJ014HAw1OmaP8%wv?`H@H=(66K*kZjfLL@EQvVQBOo4$oxj9kuy$n<5s-COgx zqcw0#TFh%<4$(rnIqRlRwA>IW_|*67iralJx;E9np6()eG34ygEgEuxo+o$oUoEiH zKN<2$efEyM1<^Uq^6o00zqag3{AUY`$!qU$pPR_}IP%#?y`TP-*H0Brle>0z z*NkP$v|k_AXg$9AU%y|e-L!R=r^=VDo9pp0D|deVl=;3-wp`wPP^##y{l(=w`x7EX zJfGVM?%*#!shL*)Qp}9`x%}x{8RdW9hAnA)`73Pt1i>1+);JF3g&k-A3ihl{5)J9& z{&ssJGvDC{3$MIT-BM=sccbQt__8Z}b2U4*uh+ZzB|1v zEqX_3U(uGdlcqd;%go-MIs8`U)u-_63eolbFvq^ z<5!$j+&HUD`qKmBIUP->H_BxCxm}knU4Qn$v$l2W%kp2dHNSECY#UWvnPqWQWS)^F z%eyz{)b#Hc=oMeOD0sf7CeN?v-4q4Zja$=`*rx~@aZB{R>%Z2QG>KvNW)=&pm)fOr zXFM#gw9ek-U9q*~vq9=MC9Zpp^(s@;jW=nWy7pvm;p}J8rK^{nzWpgNMlbvQRz~JK zjNaul-uzf*o3rBc}t6BG6OSR~=N_@_0 z@y?{$a@MRWKi4<=%GwJA7TD&jNM6d3QlfnzKgU)%h+}Ps>z$`F%|E5_FWqgq$XKmj z*i_BMr}&=I0+GpuW|K;fWkyJRnY&9RJ33)w{h_w)nP!1Kr!y))tev6Fn8GpLbmH`P zCOgc&HCpdBoH4iNu(I9L$yeXLhzh^HuB5c?CPQT zV%Etq|EizKXWyHL(~aEI#KA4{~EU3F&4OUYKQUcZ5>eh1e^F5ySJKBPzp zs-13OE;lfCN_~@D!7RiXDsv}4xT^BtmX*5~nr`90dC>U!70Y`QN(&5lVw!!PRG(+N zG3iKy{_1@?0_mj-tYVhTotseEu3^f$E3#Hx;4>8FnL<|VYA_49fkY9`2(Had9gnGez1OS z|Dv##b)gb_Tzz%l?7OsipKeBTsmPKU5oh)@Ti8~fN|%q+Rb6tRqOqSl>E%NwQ@}hc1DJa z*OoTTi|)Db=$ot4!_4`gcksUxs%?;aVqyEJ%}`qG%}wiDs*=J#;y;@UY_6@S`d_NV z_kBX0fSu3Fht(~`W=k8{u6}x-^sjV7#iN(Xtu5adc+Fq`P-&{e7Ooxjdz$+HedkoI z(XzQ4`8=)u`pnJ8RDycSUgj+j-Y2awS@-|993I=yr$^)0>{kr7iDFq*8`i$kdwOD0 zV0LjvTi>&fn~!h%68TXu(~V)m>5vy6S3SSylxg*Ip}F!Ro-cPN_t+b}{IpxdZF2t2 zD|1-mLmPIqA1(|_&^s$6x5w$;lxK%(S6=JgEp9uNPrN(4!oz3!PTjM5ExO)Hd2^F5 z=ub~gDbmp1RVq?ztdzno^GyC$_sUgwMPAh@*#7_Dw=!8Wk|iiipZjEM@B6u@B4+LQ z;c@MJ|Mc(W^-N}|1&WXg)^z&8cg!NweYUac)IW`iEWWctu#wV? z63#9AYrO4d?u}>q-{;+rwXZHzo$Pz$(440ipZ!XkyxI5ErwN=D+UD<@zRx+`9l!3s z+1f_dk7`|q>SMg}#9M57A9l~Jy*<-0et+HP{?+ym7hOI(Sx02%{M*^Jg(p?Hz5dQK zyf@?E7T(@1=HE_mEZgL}{kFiz$@YJCBucgSoc_Ihe$k!>PRoj?^;&Pf?)u}v%Gu>* zZkujg<=vM)DYy5P@8-p|A;DEnq2+sDzFd3l@IKw@8FISYcRtbKu1^%%4hhjq3ZIxon=Cl(akNrIh3;u`x%HE8)5EB8G310`3X3>9{2R2`w$X zJ)`N}#g}z2rewC6K1oh+?f6pv@x*_NYx(T8Kdff$PkESWQqP*V{I~Ir#3wp;yj`dF zhkOa2&zHM+|Gq`lcK`H6{$4$PF@%40)sd7F5ntl3mwprwPj@_jGyL)w5vQ7YwsDu& zhOWNrY$$qW=JEQDbVs>!O>;W~+u5nywv@x4lgv?RjzNc{FBTffwVg= zcV{K;pAq&Zbo1gI8Mb@_7vabqJtiz2n>8weGq3*k53s)QYX0{=5wnTzk_JriPf8}% z$GO<>N7;zB)C=z^W=d6fleb;*keAJa<*d#hxYwO*y1h3q1C#EgCLuoyAykF>HTafn>vzr92G6iV+`nE$okr+F6h)-sAhpQDFwh7Oihzj=pZX zd-ZTbc5W}*;(wo}weJ>Q*4OjpoXN{L?$cK|azt2JU+kP`ajvo;_b6k$NAX*kfU?Bi z0JdAV#EwN|{|nn=;Ck_J_P+Y~e)Hxj{&ycpmVGJ9|1fRGH4Cvk-_V_^?=pfoX9UeY zcI8wp>)Kamx6Ru4JmTMV*A~0dCHz}=MQ>&c{i#r>hwBbd|tcO`e2&w zTn7DDij0$DdSu_ctX#cX%jVeH%C7>>*KAmS)n~sJC~U1~lE~Apy76PF)@CV}q#)Hf zcP--hR!RFX7F%skXt-(1vrzXzLta&E^W-hh9K27fa_0t5oD@@)H~rZIVTX z20Mkmy~Ss;VA=JJl0L2~C#5)+YdO5NE&L*Q<`)N>-J+P{O)mS3DhE*CL{8ks7)_Brm zFMH?Ro6Q~E-gVX;&UX3@^W8)0MK)A3*-Yd{a8J6oI7?%}h5Gr+w%u^Lq{N$SnY(J$ z+gIE2t|f(Q^nXdT*z_*u{f~m}_Lf>6^#QH>-kAP~Hx1<%t+?kIICt~xpuLg_700w@ zzw2S0ZGR)9!a+IWKch#Bj%S~sTkvO|CXFe|s(W|b;myb_4Nl&EGRNBZn#scx(@&cx zoKa1fwxv^i-Mw9Jf0x~u;OzTB=U6MK&`dH#;;@31|0V^`=D=|cw!EoV^hy8E|lbA%T6nYSiae0<+`F;>+l*zw_?-rHhSRCd&bd`TW-&DB{ z&s{S%SX$Yo`*@$1c~<5!Q7<9R%Zg$0fwP^ed23C@cFpp6mi^*ZOxnGLev{>P)gLF<;`dWxiGCD>G!J<{ADeQ_F_R{bmE0?&X$oA<9)yjEh+ z_v2_p&`wELR@EJ)(I1#*?J1s?r5&Ny&t_YC{?4wM-iCGhC(ik{RdD&ew?(Pa1SB{+uXSf8ku~54XdQj{Na1&%Gej8@BuM-R45QsEU8* z-FE6cF^aqv_@sCK?w2=}8vPZw`F#3Un0wsh%yP~b-jglrB^LPYk}vLaOpfclS^m44 zmv#2EdCBju-QSY8aUK(==E0(W56&0Ia?Lc{B|Fnnf#vF-Acv)FhgTmAsCsqrU37`y z_AfzOxBWa8lYih_!TW~uQZLW6*?Mr_@jA_7Q)}gL=U_wrVFgeA+f60$wZ%8KKa8-; zwtJ{4ks7v?sYraLgXxMOplkH|&5z|~}_a(=z zb}qlSXj827kAQ$x-kpxmj?TDcBr%_D!px8d4_CWcR>=HQG51|LJ8`GwDY*(pO)>cm zo{jM(kEIIAzf9y|dlxwEmadxYm)cO4R+FboggOsdJiD=teczpWgQYcwFFCJ%-Ta?H z_i?%kxM{|0Y6#ip$Yf~%IZg0tl=tM@$3Q2LeBcP{G+;aMVBsp6DHdLHw06g=I(zaQ zqe_}*gu;OYwrMls=f8V7?_l!AOKwG4Q@IUiq?h~K@5}peyS?1L^KN9l@Y{2{Gro)e z|MU2;`Tc!UZ~D0;N={As{$YpqX@hfZHKbZ|y3+&DrbE*026+ zFZYj)yZh%M6V7DD-M2*ZGu*_^rl%xM^E7|VzvuX)0?B2U&UbA0J1Dtw_Q%K9Xm@$KH3MY?mA9!jp&k*;uHuHlH3s;Bj&jFOJ+vjs%6*PcCYT6_xG&H z^=I)@GppY1rP`lnOt%ug@%O&7UTA(yuLxBI*!vqPIR{gR`3zwrH;<>nlI zHK_g7mRV7Wo2kpSGR{OIib?~()!Nfsat}lCC*%~!n<>co#*2PS%IfA z7~GHAZczL>V_wxOx7W|urn}u;mArY!XC~jj{ndi3)5_o7olqikJaJaKcA);<+lM~d zyuP<*bLZOJv+I_vK>ON^9MTh()!dVN)=UUc#_EtQ=rx+~Xg>b4li*?(kA9t7RG_V(8m;oX7? zKTln63*Wc(`470#>`%?Rg-O1)fb!mrRd`sBXf@aRJmuF50wpq z=bd{lGs&ezvMaytbNwsDYc(e8w=0#-YVZ8AD|+kkv$>VmlCGOCIBxFzu5AkIUw3P* zzg6BVQialtV_Z%Zt@eAhKs0LE^sL(%o2PiM^*g&YY3-|HuLXT7Ci_?=zti3y+<*1P zEYa54EcMSG+)`Taa&nq6LrCzEykph&%r$W(y6pqYPjXtqo|7S>hZHax9+y9 zf5gtWuq!;GznfWS`ZoCs)p-mupSEP!tXOp^QEjH7+aWy_&gws+i#i_n^k~lBw%}!o z&CP8}-8>BSGxr5deOlig5~&yZ)3e2=E45|Hq$gMT-+y#`#&6*e_-Dc!P2=amvU-=U zR7+1`+u?Cqg|SRTd~cG3tV#EWl9!ApT4kiWbA~85i513$gcizd99g zkWYYN;et3e+k5LT>)$@ixQpSbH2d0$Tgv*&u6s_Dm=Lh0aiVeyQ_8^$_1b}f7Hb>k zby@X^3Ky`Qy;yv7lAYM0mOD3#=bc-;xORI2x3v3p$AghqSH!u>{F$2L@B1LZA-k$I z!nCN&_CAL|$=UXAcY=K%%EztFwl8a&9y#+sF`sv*43m__{&k^yQ%$uuCja@WaD1L^ z|A{5GCqy!CAC}8_F1f%{IA71lIKEz@_Qfm9tovCVA?qc+T=|;ziCaKfbCT!n_Fr#( zUc4xK=aoOZGxvAK8Icg5<>6;l6TChtO=%F_$7GcFJ6Nq#SU&0PW6+OX-M`>| zIQ!HyT$*$B{4ZV>%edv_G?C|`cdZcTQAve`pZ>FQ+OpctzL62|Uy-NEFz3WU$Mp%$ z^-M2a^QVWH?Mp3w-qBp(p7tVoUe!a1-1Ip2*=HQTE8T4=zh#-ccw4MlV5ui>Um;VD z^~xg?ZoE03%(|%TpkkWxwt^|mh0BFLnx?k%RjX*`oOzV<-sI5iN>)L5)Nk{wszsBL+ ze>FrWMNV3hIPHXMiGsAtO_2u$-wl75A8}+=n0YK_#qLGz*16r%8Qg(6zb2{bYg(*0 zGo3ZOZu-d?#sO*+v|?|-t9bmX!W_pt9sUYFN)jo>urW{MYf8qt>U-u&U-a> zd+8|7T$sqK_+WO>i(?nN^9!#cS{dT z2Zl-tPYFs|yZ3SIOT)WUYD>FU-CmpfM)g4VUKXVz@BAy951z`XoiUyD`5%kqchO=x zS3^E#x4JUC*th6z!M(u8vI%YV^P5dXZVI^vyp>(qpER5QXsS%ewuq%)7M+mRFXDZ% zd{e27Xk)JEX_Ez7i7$q7v<*qab<|i=V_aj884`$Nr>76OU*LW z+1OL!A)NVGv*+(E^A_1_6AH_?3(rLcy?eFwLWJz(bnl&qc(h7&uj%YO`*c!tMg9J; z@+_I1i|uEvdYKc^uH0v{O0hUk?mbUUy84<-2A5Uab`*=gwpsp0^So|F%kc+`j+%to zh<_2VceywJ@y)9nUTz5D=$lw>ASb)W?dexdcRTN6Z*F$H?l{Gi!@uUFTFr-|CqI=} zSf6?SdsgIyFLTUdVuS3&C!F>TDi8j7=CZRuz0MIXk*p6Dv2P9b#x3PteR}JKE3xm? zYfh&v=y6zg^0du%2CKiKGPnPIxwr7uZtX6`)VWnb-+1_XAAQ@ zxxanVPyV+d7L}3P{;XWjcJgyP?+w3u2YthuBh|Z37gs+0lzlY4`?rz!YOikBX#%e5 zr6-s?f_Dm>+Qpzzp3$>WUS;W%M-gV>(*Kz3u10Tuz_aPdu1yZ~fS9%7 zIs>UKPhb2oe)^&#PH~~am-_cv|4&>OI`yM}a`P%NzB7_dVbZ(a2fUBE^TX3*u2RtT z*>88SX2z-<31NLya)`5Jm3Gp{#V_5qYFs>P&#R+T_$_kFOTV`fySw_#>*JT1>4lywTJ^X4o@^7Wy}y3O@w@|PMe`@^IL8{7pZ4%TVNXJmzQA+Gwa>nA zyqk7wQdPQo{Cq93(uHlCjUSr|NuLzf*AhFKboHTT+5SDhZg2mSbbqgh-Z$}+M{id@ zeZ5*-U%#~Kpm3VdVf}UM^nHpZsC++SOP5;)|5T`Q7JB$*mgZ9S&iA)hZGYW+;pD3QAE(Y< z^?G(~v`lTibE@M}eov)G!NrO*1#d3c^=b0zooCu+_dMOOns>U7w)3KRv(kL~FYEts zSjsOnQcGk$+;?p2(J9q89lndFX8PA|thfDfcW-?0jnfZvc843jmN*$?cjnvo{C!pC z_e*1Ca!Zn=M9=&_7AOAPdH;-(8OHPZ&$9%dd{mRXOu*9H$oPa|J=@7g1z#(6?C;iO z{C~o&*iV}4D#y7ZyImLM<*ptsbCtKxTN*JfB}K|MVwv{sS69M)Wo?-X9)|GF+J8_q zZ;4U;>SwdOo-Yr2+N{3ooRH0m6|Yv^3$A{4_(sc9(ZdRJWgfZ{mZW5rRtHZtH(Bt?8e_Ni> zlP2K#*s^S|ZE4QlK()x&M?AjV*)1^(qI*RU)bpyooG<9 zBY0t0{_D>#FMLrc(0R9F(^sx@bMFT71|E31VpnnDihrr?q7AikJd4f>O>Q?^D4fK& z&2fW;$!(5WnM$AmR z&bdF#du(pt{?FafKP8E?io;6z1*@V}lbjjHmkrN&SeDA{(POcF^ZT8C{)$Ho{Mym> zGZ^yaJ{libd~>elv5bhO=vjvZv-|UYJzsEpUxVzn`!_e`-_oCb_;>xHw~ri@6Q)#J zor+z%G;Zs*8H)tZ@u_#-IN3Z`|88xi)P}`3%eJXzmfX|ZvWxx1IvqY&m(TLa(Tw%U zo=J9nGr0~KPX5pMXhr?m37YmyGp}F2Xu0Rg=L71go>p;5_wVmmVZQjgbFag}HCDHO z`}>M0m|i~Fanx6KcF(G2o==lfI_irqM4KHC4!&&~e|7Kt+dpS1#v9+WHQ)Uz<29ez z6M=)gHWlX=PgQynxh*};{q5I$Zk|f_#0suur^KHduCu%$e%(h!Ic%!y?c3|L7Tpe> z@KVw)SHEn6&&R-m4~yWv2+-z43O2!W7vX7u(g$ z>R*2@%)Z?x^*c*9NM>bN#l012(ye9lq?es_@t>=G^X}7~dKVWbWuMz@dE}w3v#`io z)!W*62flTGcqh0{Mq&A+3mT%uCQbJ^q#AoZ3&=Ph?Qr{$+2_`y@lUkUlw;dA=C}I- zubMQ)2wFYcuK6Wj_wHs3|HyfXv3VPJ%vHJLzT-)~oXyqspKmSH|8n!t-EBLrozir& zwi4XKelf0Yt(};oL5S3WpGmXp>@%|WZ~RnnZ(=NKo^jDJqw~+>wzZr;ZX?4N@{Dm_ zlc@E46Pfd|{#$1!>9(!Tn0Lux>Ea{&Sq<}l|7&{{9WC}eZ_?TtwI_jx99g#Ajf+h! zGcs9mGkQkNV@(&x&0ub-bSnvH55y zUS09{14BsK&5W0e?zvu1k}!YlQ~PCGQcT}R?`=)7-_6&SUM+cP_hafLPlbuh7s^yt z32s!4&&+zXXwIC|OP3y)!L;aFxNxG)owdPxKh2NjSYXr2a7{rvySAQX2j`zxQD45@ zb5^>pcvHluXzLlfQlZWLNlvGp20mptq~>jtJ4w3s6e zj(g{?OY`--5EYxlm2=eOu-G#5dIn$fKIIi_)k_$S65K=eH`VM^5dECqSlurrWK{K0 zbG_8|ZMW`!30${c_`|F8J+J=VT3Pq6aFu@Ie$PYo(&v@iSG{)LU9x=9mf7d#b(IyZ zlYO%4_@fJdjWQj66-Wih>{-qC?}^m6<)0rMYM%T#UN4&AN}$aNu}A#oD=SS-#y)bc z=TbEKReJTPh;-VHsg1&|es;4DcoKt48SZBcaUU5%j z1*2PN z)8oV&yVWP0FTKx;&@cJkFiRyxbVutyvAx?DhSnz+F@G`swQ0JPTJhH57s`<-CFHE(Y}tN9e9H?`rz>)DH|?Y*v=EXs*m zV(z>5^Gb&JPV*49lT2!{rY~>)T3E8_^j49OISuof4DUTyVkpGr`T7IT(@j%;Zk};J z^=U8%)3OM$>Ge-~{J+()9ZvrkelBKbbk^dn%@yjij8cvj_^VI2ygzsKUFYnQdG;{@ zdUxdZRWA;h_+Yb@LgSLo{p;#nwr>_$VRz-|tM2R5Lkdl@9hzs_xKF9=PsVX_Or-N^3R1k^|!v27OyLJt^Phm zy|Kg1mVe#nmtS&P1wvLXo1gb=oyEb{7!}0{B0YDO-TE4MOG$Xz>%cRAPpEt{3|JYu za|xeT^#}O|C*B*iPd9tMSo-4l=~=h*E^XNKm5EnrY5giTUhCKU!>@;k)x`uqUi16& zjOqn_&cXjA&i1QTRO`Ll+4T8iJ;%qBM$>#BU2I_a%~Tn}op^gna+o_vWnH4MQ<=O*d=jhw+WBlknh-hY=5 zSS-BQxZf;SKK|*3*-wpLx?P*ZxueVZOG&#`3iEm=wez3-6+eFVSerBDjPwqV%jtXS zZ`a>l(A*sL-}~qin}oT_|K7`gaL^NYe^hzDkJpVE7w7xzU2gCr_u~8I|6LQ6_I#<) zxcXpAM7VO>Pyc`M+*~#(HhypB%d6KdtG7J!aG$@G%lh7UqzZVsE1& z`)|7m)y%Y|(|SNu7fI8`JlCCOThze{+@Q>iC3rTUI&0K3dqczIKg0M75x3qle#|*&;LLe^GwZSrUhmt$$LLcpYvX_eiL9G9nqu9;Z`{3M(@6Q<(B>xYg!D0<_I(U zeC`vDtF|anIKBB-rN^CyCo@X&m$>fIHcx%MD(LExP-%78QvvL;o$QS@z7#Fz>;Va|G=Ve@%5`Rr&q)* zJ6$u~oG3g0TTQ2N8Q#^0dQ+a%{pGUzhwCh5DAZ>6y{jE2DOlEYJ<( z)B5$ED`j?QY|*6_vj)eFGd3>wc=Y?`#vjwtYS!$vQ#@n0MQpd4^M>ndPhVU0hOH%j z&7J$3JC089H9AqG-r!=%Yzrk7ffc`QtzOqE->}5Y+OuSe9evvOf9|VIzj|4eC#lCu_wGUQ)ly0xm7_$|XZ!hiO>2`EFF5Wt(Win_t$I3z4ws2o5JaM zsrzv##}2L|M<0m)*{5j55~g-QXJJulebWrDvRy_R3;&)vaR0N*oUht-n;xDzq1jQ= zWpzee$i0+d+OGZ1S9n|wy}aW6HDtpXm?Z1KiZ?RB|1Oj8<{$)(N~IizNn&M-xtK`)m>vP=Q z7bGl5TH_$IiJ6u6cT9uy>_tt-O};IYBB;RTJj?R`% z*ZbC-`fH>gberKK^Ri%-Sg+0Zs8bZ7pemwoxW?>zl_ZF+(Cb%C18=J$`c>ZdG;DYH|1 zeNAwZ$c0n;CVs#6HNbS=>R#qwS5I^IDjVkM?(e;)96n3v?u4m}%dTt{R7pJZolUZL z+D)^owhXs3%lor6K9*;uO1*SQex)v9SIDsFb;zafz00p&x#9gN(eUZ?`hzl8cs3gd zudAG(J||Y-YUQp^3pTEO?Q%?A=B(1EzlW}WU7(X|y*GQ?q}BeyVbmQE6T9eyE0gxUS!2BY)7G!{J74SGmd(gB%V`X}JzM*H`2!QpBlUJEHQyB6 zo|pcuf0^`d$JLu$b03&jXKPIAls9a)T9hGNdO}KWQX|{@Z2gb5*K$smzI8tTUTD!^la=r40!1~CA=imF!nGzga{L92F`sr^yU1{UuDTn90 zat&L*>dujc51s_rJm9Neq#q-f)hE37&ckCzSDrayzG%@Ihkh$wUd`g#oCo{dHz;qn z65g=BH01C~rqj@(ytKMEtWG#Itp*p?% zPbL&**2_KP&SuNFC_X@5E4oaZs-_4VH+`&Bn( z%HG+r=j0V(hwUYkefXyReH5M>T6*-1LgMdL^JmTJU}L(Z`LosT+>ZJO#=?9*d-ML( zJWE$oT<)g&=vCtNTMs|-|NS~)<{RU=nP(JVhCZLG*_IU7`Q-gWAM5&ZjcgD0Edn|& zwTlYw9rksATUiVcu^e zyL4$X>vHyjSLMIX>~HocuaJ)rP&CY$Hpe`I>-W_Am*RfLAB)Kk()gx+r}+$PW6;ve zZ#o0seOEYqU4h4JL5buECce5|Q9UhF;t%eY2?_{hn;E&mTkqhdmxa|8e^UF;%~Wgk z`S!5Us_oe2clVFjb((~6dU8#=v~|kS8)o|J_5ZQoT*$oyyd*)=)Wkr+Kp{UVi_6A_ zOW!9oFTEr~!O+aW7;@ys)yUZV+h!uQ=ht6Y+<;@6x% zr>`U@(4#UvsuEsMRL#5gSU@bdo6x?|MmS}rW+J^I2?_-GIlduw5V^sjYek=b<>+ys*_OuS%}W*0O%FMrY6RM?9^2 z?@T{sQSY%ZYqx6c+jFHJ3<*mQE?mQ6c*s>j?5onhkD8rS)vRRwuo}h_l{U?Lo(3oykITEG*}FuxHnQ z>3pQ|Y;&URDc^q^mRUFn)}PwYx6fwPYv)aYtD_|AugA_ilc-&r^))h3$1Zhy`t z7E*JkS-<*yaY@cByEG?jrYa=t>_ z{$%t|<;vG4zb7P4s@I&Gby?=|{QG*9EIU(0i}pp7FL<-Lq*P<`wi8Th8}d$Whz^uE z^R^=F_DkQjm(o8N^NC9aWjIKfu}tvLC@M;_pPaq=+IENh^<9To9r?RzdP-reS!GuI z`YE+(N7eF!p1Qr|+o33HC*Ucg=y{aon5RGk`*+DV?C~W`qEbaQarf$1ymGxMk{NWj zN-)2^?DGE4oKHGj_U7M9S-Edsy5#dK5}HEY*V`U9oSnli?XtyaT4T?|+k*S~xo@g1 zm6Y$>=Or(9q(n^LEB9`i0&MN+_&klMC&Sh;o z%XoO=6Xlo(Eut#NRNkMPYqIN(dc9Ti!aIczwOJ27`lQG5PBw}$h4J)_i(LPfZh541 zdg}TvA)Y(kA2082_3*GNXeAoDLpx{_X&MB@<#}?{bT65!O ze*NC54>sTYxbI@Gx8jGby5{l=`K}-L$QiRrU=j9Gr%O?%SU$ot6s zd3)1|jN?%)CMpT{H?b?`SczX4{tE8RxStdPK_hzun+vcD*cgo~U0p zqwu3+PO4UFoWaXjb{%!@*eKn<=lzVZ{<)1z)vCtzTUt*Zyx{t(IEm@*$_j-`r{qj| z`_7vQC1>!f%qqR!e_bu}#+Qq4LQ}n>>kUm3SMohx@-6OL!HQpV=Dn$761;fcuTLw( zN_Sx*M~{nJ{H2-qLuQ7}e{)vx+@XVv&t5;5Zdm2h-|4VAx#;G^o4dCz2}li|ACT#r z?{?^=*@-PHdLPw)+sOUGr&uni?Z|WU=haIme-YCP-?no8BHjI3r(;x)E{97+Yt8={n0(!P^z@)(>(qKqAU^b-I6Os>pC%=w|i68#SQd+N)-$E3vYEbaW37H)9tgZZ&v zyS8dQNSc2nq%C){^%^hhX=x|dY4~QFIu!)%d?PQu?sB7PU7gnw2gRxJz0JicZ89_8 zOmism(fycPdvt>fQ-GZ1HS;TF{x43h_%V5ga#M0}+5v}4vU<-JNA6#9{vY!N_dPM- z8i(1`)EqLfV+>gYxBZ+o+b0&rlH~^-*jV_#)i+)a`||hk>i-PPv92@0T9`~sr$5Z( zRG-cf#>vZQH2wW7M(z5u(Yg83=0gA8#UJc{+g{|!*RJ0xc)<5jOrv(f4ZAzu0x}}* zy{%S3eo>~D3ikizEu7{ha$EaooNM@!OKYZi+gZz;Gd5nb_IsFQ>fZ7nCzK`>t>lQS z^itaJD57P-qHZOZsZIin_R^=79txgTGTf#7xL@IBsQH8o*6BM_Y{We4-BOxFo|^wW zvCd}pl+D_j+RvM8qK#^FeIqJ!`kW;7s`?L|BGrc_lq-+EN$p|DZP!U&vcQ5FcFXEUDmd8XD(+P6uKvct zo4>8t8L=<#^w)Ux%l3V<;?q8xKmO^>JU=1Mv_7*gciz4&PamzYl#k!~N>yyB+Lz}( z*BBK}TFV;NyPu29-R!?; z@2TkJ+|FMUZq2UiQTyl}5$TkCB<}Xq)fW#gXMU-^@muSOumyWI{_y*|;M>v#=U5|W zKdgFmi#2kSlu1#9_!hRSI~T+SR0jzxl7H)YgRiam=sO8H4-U`gH5%+kBCT0EMTNFZ zZCUZ#;O^?V>915*Tug2#uD|-{@%;ZzCe0I6vlNfL{PgTuXzq_c$-f^hlHL0F@#ANo z{+xOAI%`SJ=Pxcd)qlKSVL8|Lw$Ud|Zx8XX+IdMYy{GKn#qiTx4Ow`^VWQUrfL09{NSb>&nvwJ2zjH@n5{~rJP>zmIDV=7l_%Y&Wqzb z7;-S|U})p22dfW+a)d@`KD}xX)_8)eruRZ;bD!rU(ZzFH-YaI_JGk=6aS08k#roHK zcoSScZcCcjz;MhYz?Xl@YESEH=|5)l&)Jygz+TV3)gWiq1M3NQ6?!~peej*PrE|Bz zlZJ>51DZk2oDYJJ;9WRTvhtL;08RyqbJ7@Jx zdXc+d1XIoAE~|QHuvrKRD&Wxv$xj+ILz`AMWZ+H zyj!<>4Xc2|g8AI)ipraR?c;hGG}Tn7Ld$SpoJ#ZR#oCiw7%sIOUy(XVp!LPw#QM`J zq9MAIzck${o+hoKIP-Uop55y?j}j-}=~{WZu-fqL&NE^1*Px&A$`-|CGP2mFSyzrg5)7`^sXwy%WC0)F&jbTywB(7ngMK6~o(y!){!gu}dgg zf5pKsnmCf|ww7wvnp#OieWO8ros zt^2O@r^bI(t#2=}-Kqb|J3;O6ONFmXyHaE0UmY)sR-N?lv}4=cEVkLabDi2c+qO6# z?nuqOWT*9B`fAJEEH-{U;fP(KY7;)Q^Xm$quxy_ce%iCc&m;6jQ2EW-@;heC<2hW? zyUk;-Zim9sH8L{(ebL_y1pl@?jO}sF%Y0C=x_e{N$B_d z;gd_rMtWhcUW$Hap2i;Uyi%?a;7Rr@t6I) z%RRL@ZLUM;htLOFA$0{)tCobODH9c|?gD~Hw**lMIx^?ajQ|gaT6_+CRGA38^^zqzEo;B%Ue~EhA$NKtd zi}iw4in|wP9`8MTw#|?A(}~HS`FIVJA07N9ZS~@cf>GP+YejLT(b;P*A35O?(Vp;q zUP4a5d2yD{qF-|+1f^(PzJD~!@XRGB6VlDo z_djRwj{NB@(5vrKtTq`J$w%%fFT%oi{)2^tZp8_RiV5cy_QQSF!$zx0|~h=l*fz+4xMSQB+B`@PXZn zloz+tOIr&T-uJup`f0Z9Ow;G*{pbDt=J98F*oA4$*1vYumK)!>BDJ{Ia!db&391|% zt2J&(%`LNhCeuDUh}*b3<#Z*h=3|8g%Y|mSRz%)6UmU*q=bsYG*nGV|{NE2}C_q}6 zW+u}aZ?Ooo7#bT`LKcBV7tgj3sXM>^!N$2a16l;8A6HpxecSW0&!fBNwru9_n%J4< zkd!*{$nV$T5|gBqdRULt-KgDU-1fQl`HMSK`9IIjPEcJfeB4Xt_^&^&KG)QJN^G;? zt}y#jbA6Wn+5=nvaNJU0xMs7hZr|^@N1wd>8~<5fUw@_f0#+I8BBg+R4?}XPS9&f!<%ctnnM~7|rxymI^?tgAG_m%m5 zszR%O6@C7B0qsOxChey=uV*UM_XpoG4W6@U&xGquIxjCf7G%qx{&2acoAu%^^DVV6{9B^A zvtOJkSjJk`DBDz^#J{@Lw4qXQ>ek)oBr0E>T=`{PtLcMon`4tomWmozWbpmhSfP@d zSGz=~{#n2AtSo;<3%BR@C&xCfmiTd&rTy~mb9eSD_)OxQ6#rm``u>$d?*-nZO7@!1 zP)*sA&vM|7xfmWRk&9N@FL@yaA3 zsCA*4lv!Ni(e>x`-KtqXoY|`+xaUOUx11R3g67Tz*@^Y*7v61lTCAH=A+pp`dApYT z`JG2H(<}Ryr7$*R|32~d!^!ZQ3LEY&kery?*=wh}%+mj4`}MacFT9?-H)_VTL!#o6elP7GpTF?h^VCE&p81hA(R$%7a#sXa z99@tVVQsbb#1e;Z8#}h}2D&~D<1(EudsX?_>p3NSZTDQx1#n*$`r-HV?@@1tUTd!O zAAvn`H+~)1&b}=@U*}5BoT)D+6bBlVEiX{rB@tL{d(_fKQ7jOui9<@>5qrbt2wj2 z%{-WKoR|I04s)J;k4#hU(J zX1aCkzOBy8&`lTiObS)`cO=u%O?Q9w*YYhpRGxBcU4Lxdd0@|E0aoj3g}aNVUHtjo z^jiI{O#y;8Y!f6b9ppQ6*&S}n>{{NDhIZ$CV(MC0E*83m#873!P zVSlHcxWH7* zJ#X#*m*O1L+}g_2VsmG*?CdxH%D!)xkNWxc)nnN!O*zZ58<%Cj=U;z)_08L@nHd4> z>)tu#ZoL-65tEX&?H!ZsXaAbFw^>h4&i(f6_bdN@8%qBeY+~HRt5=`(|Azc-_p}NB zS7z&6IAtz>|NNHx=_jt}3*4&zzhw8yA40bocJ-BU@+Ks07kSwp>6g^MkNf7k`KB-4 zUA#IkQvJ;0?I-VkjbXWX ze$Wk#CkG}^WZutJ^g!;(4rRsDaf_-HiZ{Jd47QbXT;evr^NjkdzwuZ7FQqqa%G-Bp z)xYo4!^$Qc53rfw@W3Hmp(Xw)p{OPdnEPiy(ueJj?m`J(BpBllxAdgyOyNPM`^ zsQw_+iNd2Yf2@pHFK!WW2@Vv{3@&JS6vBRSzQ?)+v-l@lW-L16XlwjD<-xP%UgFob zn77Vin9W{Ow_~B5a^UL^d7i1VMT*{se`xV3-D16QuV(#;A1Ak0&3E~pKcUhwLhaI# z*oKD1=2kbEm0ybHKi_!YI+VAlZO@k#Y|9ik$Idue$immCxNy z*?mrVzKZke>SqC;Rpz`=_|dcAg2951wqHLjsjW7?kmosF~%Gf7a#n3VtT(D+}jg4bxow#r?Y=1Z%DarWp4RpN?XW1wmZw) z`;KN#mtfv*srqJLe(|15WjvOXb`&oSTWrUZ`&NJER#&&_SG<$z!vnQNf_+q(nFu%s0{MQ#&m3P!iwES7m8^AS1yWTk=VZrO(j|H;N zDka#%b5rlHS~(>$+q-KnCy)D)ongtl4bH6;UU&CeW7X`X_ip!j|FRM6JKuMT(WUL6 z;5weHxo@|9uk>YeD)|$1rlMFu!~as8(&OCL9{ZGo{%&OxC98Fs@2>yj<0vSu_&Dy* ztiKu@i~ov$%WF3l&8c`-ey+d1_gt9!_MLvGc7-yB@0?a4=NqjiyLGmK`(L#)+MiPP zzN_acydwUpPN=&#?9nEl%`12=AO9lT`*Y&1?Z;zF`-`7$KRT^X{@vq?>lWQ=+mI{N zelK0f^=*0nZrQ`{|2oYT;cMV~#c^R$ikIq}5_yB?do|S`?M|%zzfGH|vs)|Cl%-zq z=D)|2mu_EJrzm$IcWUfh5hu+xe2SF|a>N%G_XWJVXe6>oPImhj$EBhxdzcsX7EN64 zTKBZ_=(Y|IzrW`>e{cVvlVEv%2CtWnxnb(T^Y@ZBo)MqAL8@WShK6V6_FV>1&rHr% z=_{q=3FJC^32;YdIsGm9dRtj;>J~E<^Yl80dLt#F&k`K^PfpKaF?nr!()+N|4lj#C z7Y_AY)DE4vZ2f{D+YNVlue9&pFSd8Nb!1;x-IRcp@so0;E;2q+XnY`d_npbFs%r1& zolfl;FC+FYYhR=?PhEntT@UnKdIz14Gb3vYPeL_xokG^VaR(@6>epMqzaZh%GXLNNy=DHz4GHHLi9~G5WOKXbq$cUMR_$s)kko6HDKW>acw0->WG|d@ zWJmkA04?dJX-%_+g=(TuH-f(x) zkw4*WdMiB7^6009#!N5Nm&(gsCf?oZlNP(t_vBGMxh%eW`emniR?p6Gyzs{DkTRD} zz>%8zj-c(!6YunPw8j1D*fHzt8HJEpn#TDmlGPy#8n^IVG|AY0+~jhQu}YQ$Lyn8o zzRz2>MY@eJZFbng4+!jWBw$4FYSnL z7B*EPX6Fw-dwsV%_C}4UUFFv5-;clEt$!z%C-;BHUz3`DKSlrj|39(doMChpBg;`Y zCC;NMnXL1tezMfaFaLk!uWC7bd_u^P4ZkaJb zYsI%26Ypes3La!``Bs0ko?ZIsnj5N5{z+I%KAJ#KmGoG z(|K8+e_UK#*nIYJ_;2&wv(J7$8$Z7`x!&$);{N@6{~t~(cBqiwU%&bP!}^E2f22MC z|LNx4Z}Z=;%eSkp{`>Ck+rRq%v;QRifA@Cz^7NlvyTev9{N23a=k5Fd8=IO|E!>!R zKTq!7zS^I!xdY>Z`Z+nX$`(F|ln#2u&i(&K-T$wj|9-8@_W$!H^Vsp#uP2zt+wuJ@ z{!_lSa?|dc{k&C8Y>O4L`R4jB*dy{$zo7n4&7VU*I{Wm?{$AdFclGn=9LF0re_wgt z*mGmw{r2hdd5OG;-keh5R&T=j#;I`OE(N_6+-FB5~4W^K+sx6X3+vp1-WnK8yY(~8bMnRU{1a<kAXhthG%qj*Gc`xts3rgw-*`#GIqhqU_4W z4U2bXvaMQ>wwBc?KqY~(r9>x8KXA=P%la2A-geCm)6AKJqSjoi@K1C2=ja$C-Lk3j zAt#HJ@3}2P94#!LH2NF^-~MUtc;OMY!Zxrq{LqAG73M&dzF^J8iB5j&GyF9^M@?)@ zlX|&zQL~I(<2gZr3l3dVw#p(}Q>ES!8~>6UJm%>9W!ys^{W?4;@M(k>^sf z&z^QqPkeIBFx$o@UGqawRHbpivL9PSW0W)FPV!jIR9u|#uz1d^Gdxok2gO~N4=`I4 zQda+iFPU z)8CZi>I&pCF&eNcJXp*wpz)?PB~@UDWw>pl!|anKYLU-Wm8VqXFe^Gw?k$xx zU482TpPf_sCRN?Y-8oqi35-uxuysFaE9TquY{uP>Gfe_NeY)-FF}rNV*S8xgV{NBz z_TJT?IzeIbg_HF{W{Z;JP73`Eu+Uif^T3ZSmmD>+mab(@+T`-?1b2|%G>;739cx&U ztV(V&+T6^Ze0b&QQxe;EP4f2HJ<&C3cG=M~W$mWcR8@g?VSl$t&psA?y6`aVOXZc4 zRA+-p+j`gD6}ZYKlI~y-e?XV>=fyZFzr2|jUp&1Q#&nU-)B5p(gZ1C|Hp@@?=JBjX zEwecG&xOmn+20<|R9}4A+I;%MZF`&(xF_iM|GRL!B1x8G+HzgTjJ`!CS?xvqyvJTV zSNNhDzgJb{tQ<>hjQn1+==|LLW6A3_33UXyDL)lH9aQ?oWV7&TSH}r^KP`TIWK&Og zU20v@&Xfol#|f$}bxell8)HQ3U7X6K9y_YEFiqc3zChk^LyQpf?cZnLeD<32@4-?N z>kU&_n}zv0bS-#vHVW%JoBjFmDOKA^k~=;6FP{oxIhOJH@+sBgDe4^3;nNNsXEC&1 zmlA8FQ*b9ag6XbFOhJ#L*7u)`Q>1IR7_PrkH>3XC z3HLMF;zu9IO$@N?o@0}gm#{M>|E*l$1)tRyPAUr}slN77Q1kwA<%+JMwP~yn%jtzF zKdwxHJdX#Zq>~ z)Kzmg7hmSSa?a3f>&&+yHtENgb%*(H{Lx~*s6Or%Px*#cf%(%+3%RV4J2t7fz6@}X z+1YJXVP1*3T(?#lfcodbZp=tF*Z|crOEo^dqU; zHyqEL^Zm+nd*Z_hq5iiUl`Df|)2;VZ-TZLP<7(XAXYJd?H?Ww7tiRPiO+n^V=6F)+Kd(2W|?dES}e(#FIRnP-dwroRgCotCEsTH z|1&VR-N(_QFMr!T)J-UQspY z@*I!8s*;mC558^Z=<&?mpZPWL&KrJlp=)v-9NdBH{Exii|8af))YP?0{vY0SjrsCd z^NnlXUQbb*x5_xY+cd+wvy^NQ}`Jx49?J(9^U?AvZ} zJbKRKdR^?|R1lu~cerex!tK-qA!WlTkA;Nw#@28*sB>iE} z#z%p3?=uu^oMWwXfz_hxo7b`>&v;aRxIEdMYo&jF_eOK0Z`ysrZ`lF`&zq%AZwM&N znleAJ!SbBk%sz>K-1F^nMIcRa3quRYD1`-Nl;UZWXYp+_k$u0zKg>9Hg~w4Srmu7R z662REw#_P;^^#F6k&AOXLxSl4-%Z^~UTnOMEUV9bQHfN$|NFh*(JXm$Wq;?7;$AY)c6&eixQyKPdkY$j$C^Fl)aeaOh-@&WfXQh%zRbcN1F&3Gm9eOXh;-|1aUh%+4;=so@2e^42-td|nvDme!{_9>X?wTZ({nviV zx@%6`&3Z$ygQwM9KZoZqhw-5U-|Mau8eA&HA{7 zH~4b}+?Ai^{CmUkWpi@Z52?%j6-T|R4Evnd{|&wxl=(Yd&9xyp*hP5u^!gsQ_WTzY zs}r5G>|V;}{#c;+cCW$B$H9MccU3J|U)Sup>lxdL^;IQ`XE@7Cg#*Pb9P9hs)E=dt zQ%mO!XFOYLC%@=@i!UGB)HwMY3*USC7A4hppZJuawm{Kpp38A_t|%L>M~5eCn9SZ^ z8gl;f-Bkh})!tL?tG~$GddySTKQT%;`NfO=Gj3k(uWlaqK0f>Es&lV-3g^^ly$sL% z%Mw)?lGwa<%kxl|i!Xk)+PwB^NZ16^U7O!r{nqfN{v9*3+!ou1vI`vyj@c%i z6`S?QQ@=j^mvRc0EVy>tWN|^QwZY%|u%s&Rgp*Vfjp>Qe@@iH8(Os z_o{d37V5Q`AIa`o{ywGAF4AXexWudJ*O#1I&6;Jk$fxAQ4)68JYpp(P30u5M@#N$U zV)yF>@{B9X9%jssEs;>mmsz;#_RE&HXD>y5TPZ7{#=f?Tw|>)t+^hY%LVs@L?VEY= z9{25w|3n{WO>bdyE0vHnTxITYk28A1$uf>Thu>~E8(n&=(__~59j8ukNpdhQxSuZZ z(&D>^!QH4$Vp|W)J{EemCjN2KSBsl5TCYx>NiE@C&7^Su(7nlvEd7%%3%jqWUEyZE zYTy1ja{BA)?!DOhKTb8tslIX|`+-s)QGG>Ewx+v}rWp7wzZ}q-P-C@2gyERijIuVx@GQn#AU1;v=pnJ(wp-TAm4M>=02Bz=ZAxXJmHl)!4HgTf_7HV2he%xqRJoFFxCO8{5z zYZZ}ag>&12QWd@jwDinh7BGeT-9i@Ej#zevWhoUq1k=rIo*r=J@y~uRtL+NY_N4R6 zgd#o|OfcENSNn)DTPo^xy=F+(GVK*hp5^)9EM76^?XEbdwaboNvkdtyEOgCjb7AAZ z?Dfp9PTqG*7=BD^zgES+cE&Z8r57R=YJ0XkJ)N@tDMRlKrUtzkot`ous*F~$Db8SA zBBt_s!iGma%>K-FtJJXg-$ zo7NQF$D-)z@s^S)RQj&hjo?{Ia39ThCrmNbYaGa`x@pvrpgF*YD(>{(QdO zUHdyR_iFxLKm6nOdi&a6=g&Uf{rkNAz1q6z4`O;C?*v~RDLsGqZSIaeoYUXGzkjd&^yv@n@pgZH>jnKxuK4zb z?LWW5LCsm3!bg*)g%!Vv(93DO;Z@nhEPp~VziUP80uCJ+f7c~)lRuqQnUcIM*2?pM z0!U!b6l0&y)(R;lQ+## zzuuw4l)2;9YxQg<$=11SWxgRsM*b5{9KW5~*uAXKPNJ-Hg5XOPwsmYx$-kzG86A&0 z|H$BPh~pHGr-qw#PJ9Zo>U23~_N1_Cj>>`=N$ST{JGCWJ!&(Zg{m(o-aIL;4=5wUl z#$5j+Yj3i#P3pTT?>o>G{Tq(&$kChYlzP)|rx5=I+eP6WsPJGI;>UHi66FNN6%BVls ztmpEj+6WHYhss4(m!kcI6c&etzn<(;?-+M+-Uq>%>l~Vbbiytb2%Y#O;N^G8MfnY@ z_CJ@Gi#>#N5Bikp*mobgGcUmXneF;FWopkShb6u1zP5NOS8cq;rdeU<7X~be?qFfH zP~~3uA(TVJQHaT{?$v{p$0u%Z_S;^hzUk$y;|IOhYAAO|Jk{aqak%KTT5`5R!PJOV z4MO!jk9Bkvssnc%pVn@CfOEOa>Um}rT9=m3X_m?0Kf9_>D$8BU+e7WFyKfht{dY40)M&}yC$jW-L6B6ycc}xF>HogfEx_xeifqP!=eaWqg z8B@!|+HB)0Tl{vXrp+N$&Yv8ID8 ztLD<+h-=IEV!I`ccU+mVkxkBcM&YNI{<212JeqH8TYi06SKjU7*x8pJuf3EVoHzCL zqbYLxWy0ocN_)Fc=JcbG{Y;z{$B$I1Z`AXXUB&r^N!#zB@lzi4MEAmD`6^;p<`)S0 z_VGOC-QD~B(UhC@Op(sjp>wj_p9#5KtXds6r>XEzK={#>&XQ+7Sat`?*-k&YQrS|$ ztJmhxYbV!jHc64C{oNSL~!v%ZN=~% zU5AuwW^6taA^PUVWRpNM`_!$Pa>@#`=SPJtU+1*w!Lw-|7Mv*&JL~7UCaK+A9Fe7L zV0@LUWNf9&8rR{i@q;tB&w~zl}+_KLC`*bdw?qlkVTz1=Y&8ZUiNgr$uoi3T@u5-Gi zebNjy!_y^sf~$>UvyZcXj9m6vqJH11%d)FlBj>+LYpQ06pZcD9l>+Y3*JU*(J4l(_GZ;N54+Z~1q>`uhBLfBw4zb}@1LYee<(-|w?+`My8&MD~Y0 zJL~r_+`GHHUEi!~`M1jIclzJs?d$hQuiyH1>;Aice_U>V|89Tl!c}a%CoBs0{rey} z-)z0&?N;Zr@db|!52V)|`*Ba?MC%);!o>YMc3p@O5WmuD$6A(x0iV1&adqNq<#6|P zeKE2-t%^#)0<)FP-RtxE?#S%4EGmBT?8MoLAQ3TlOc>^l3E%bIk=!>${`AY1tE|ofBd;^fqu`ZGG0XV}YK9ktG!7o_OE?Y6gejr5hz;;zfo=76Ar- zIO>&_+Dz5H`uMil;@Azn8>8;0-PEMe7aIW|v++ys5ZYr~Rzbp6o|r z8{f?G*vG^<=jH5L^MjsicBuueGrk@3rds#^`<%}URk}()X06~5syt(Md(#1zjlmHc-@k$N zVBY}=A2s!TPwMzzetjLbKkAJ91mWq*FOKk)y!*aBUu@gqx)CV{pSkuH864ljg` zw<|V8)Nd}b>zyeSY58-{k6`^}?cK5RJN7Mi4n6(vhMuHi{a-;Vqq0}#pMOvMocT(~ z!Y%RZZ@%5UHl_!conU5ZFZDRNm_1NUOR&+D5J zWY;jBH9u-Sulo#JU%jov-h~HzH<<0P6V!`mv6+?>yC8noOSddm?PW(sc?Ie#QBns`448s zs_@xPzH`9H`eXezpQ%e;U2}K-CC__Xr7VGkNhD^QEVIGdi}^ZApAIS2XFYl!`gm8v zqysYkc8)23Y*xxebgdDvJU_KD@50uTS^p12AAI}t!tw))fA}1lS6y}3$H2OEw{PLs zzEVMhgHkL-(>|_deRuHl*Q_N$dXcB(-Wsi4rM{OZ`oA}?)5Y^_LETGM9eU1{@_R;} zgxpS@=Q{oC&ujMlHs8#yvWBbic~W(~?5hT`%YW5(+27c3dg;xt$N87;%$`shR$%#D zaQYvQ>jGZ{HQ#+Q?q0d>TI9DsQL>rgzrX0jN+&d#-o9EhTXD0?UGHsPU&B0M#ACflJIZ; zCrztonk>HWbh+S$mHu2uMfT6+&ot<0=(oLm^Nn=#m)l2Flht1D`Z{C7r$77D{vLaC zbHTNX*{0d@mvR+sbvcahWR`t=UA4K(H`H>8L#V1i zx^%{g*4zN5@~w`%vsUv)Y23=a;QZEX=aLJX&uWTjJhXEAG1uyD!V$NiH|8}RQk_jF zZynpyRNwDocBpk(vYg(RG;uHfnJ3<@(0rm(=Du{o&b~mt$dlJr@N7x?9>%#dZ1?s@ zoK;fa9|;QeTW2M#+9t(eu)NTnUni%0i%3N7$6Fc&zGmy69_W?KHepj{yQAh9WX@;8 zJBfWigSbl%`&zb%cF(pdq;6RARpFTGDqGgfyAroGGo67GnC8>cHb81iF$FjWNj*g|H|7g$J|fdyl{i5vv=*;C)1Do;Brik@R4QYKD_Ff zAzMhnwG*@E1uQC*?hrn?gLjAK_Co1@YLah6*SJ|(XzXxF-Ed)t(Tuiw#o4_lW_0(@ z$vT*IY{s0)8xOrZtCOr3b~@;IOw6gHCcAIG+Ief%*(Gykzbp%`De(F>qwDGnp3=*S z?MwZ&lRZm{tE-EDeV8AA?%|hD|NcFE`RvQT*Y@*|-LL=q^51>)>TT@nd_M5L zy!`U~^8It-YL|RGe)i?vpPz$&%n0tfP_G-%J?Csx@tX(o+DDaSFUPgrzFkly?|0w6 zrh;Sn^@sfX@BDo&ll?Eb;^QN>|NrZG9;BaPQ@ZY!8J8|fM0KV-+mmo&uiM3%2|5x!?b_!| z-H$%1SBa3hsA}H#L5JN?saU5#|3h)%48)=;*M>u(G5>!%7F24@~FkT`F@Xm->F2Ky+H`l!z#nf12~zUE9T^1W@KxOGzh zLziVoW0jV7Of!FOb4N9`t3!p|FsW@_oC43s6RmgDl}hbB6mLCJifYqHkgxqH5SyfC z*~V?$uW4%}WZ<8iAhYy^AxF#ZqnS(YKNH_r>cG`n(5fO67WCRtVS~gHM!P2+cUiuf zBycOa`*zITSue}lB+$L_^qRw#$=#|OCDfkG*ec)LC@AqjRN?Op9;c?Pr26JwzMiKE zW*Kc+)3~K41j(v*uH=i5dbEFqvm?*(b6H2N-^@5)_;dw_IO`vcqu(AsTX|qQkL**? z#EiQWg-Zq7%072D`TkMrVG+&Mwp;aP#*q^h3AcY8Hk@TpvP7`{#{b9FyocwN1x|2? zJjnFN=6G5t>i^^ zhAa*}&MGbaMCbv7S^QClgHcZ(e9+`nTw}MJLs8{#EI*UsWUFJ(+~!ZV^4uU=uX%h$ zi*eGCcTxI12`YbgUT+ra+|{C|*CBLm`b+N@k8Z88DDZhvq<`?#vUYKO#@MZ&o*D)o zZr*YIf^A3swF~7>TXgc8iXAVowH@`&nR20=S2|BJ%qhL-^bNg*r{D3-UMrCxuSg}Z0p(p&iX zpWGqu7w;6edB3P(Ej%Oi%T;E!YRS!b85VcjLo2$KdxI`IDlD_u)A#<-jWv(oa~?Ws z=>0;kcdgK`by=3lZBs8yycnBwERFN86x%D+lItC3g?^dxT=9CLbH4Lm8t-2zwp$NG zCb;cz%c&RL;Q9Uha+yOu%gq$0#5-5yZmn3Q@JDaXzki4Aot6enwkUw^7r@h-OE3}ef#q8?(Hq>&zCp)t&d}?YOFV3ZqEPRKl!A2*OxH0v*z1`CmQ|R z5ScG8Z@1r`xz1v5?O(Myc60XIw)*dXdLsJ49?QKrL+FU&TL*|Cda`r^ev4 z_U8jm{VruieAa>17d0%^UjOyzpZZckVAB`n^vA6wnI3udW^wBp8Ks4`ZO-mXT>ZX? zH?iXWQ>C7@$4;+PxW$s#EAGPWUCDbS?Rjc^X2urghI^HYxdPrd-|cy$-FMW#^7`Sq zPt&d^pZ{}v?$T1*8|TjZr0=}>^@iw?l4;kzW|S08o9){lYv_}CCh5Pcg!IvWYktcw zp2&4PM1OgPS@z%En-c4f@f)1K9+2F^@6oZ64&mJtFv`}(tc#P`u zyUrHQ8aI8C+X~vY1zB?)HsKZHICyTp|K$W-j)&THUf;e5M&yJTDYBXh)GzI?l2e`^ zp`F1M|9FB$63hQr6Dqp*UUsZm5v)B~VfKQ+v(izXS?Px14ln+#^f`9U>Fv`AGfx#T zHD8nI6W#PoJR3rd7W-GPZoShY;vM4`nO$q+imv^2;7syuM*=w=Mmf;!O6Q4QKh7bQhet zwZCrlE-6oij^y)pjCW&ezO3Ch_Ow z(_?O5;4n;9Y-ZoBUMK9fb0;e|@8yac=TcMSn)Y5&`my%pY4%;AQKGKXw*8EG@!6;4+ZH{p-((lDchv*6*-9(_b}cuGe7bUTce7gj!7EMoy0zJU zD?fB;i;Aq;YPSBA+7Z?bD?k2Q)}_(IDD3uHZ#7f7!{!ICK4xZLaCV$|LF%gHp5<5P ze9reVRupqO#A!b%=w-f>gl6xDY?fy8qJqK=X`6o~x~X61v&f8Cz?O07t@`!Hx?Aht zO6Ks2hqd)IukHvaeq8I?^NVX&>lCXW?m^RLKYuP07xqfS;@e?y&$yq8&s8k0&5TjB z^W@c=ChE%C{9)_Cm$pvddkrT(i@f>Bi&^2&ssHP`SNREW8m)i#G9vxt0ow~Hv0IDz z^sYYhe3%~;w7|w@V(jLX@1M_M?d+c|+3zg3vfl24^!tttk(w6$2?vw*)}~6`FW24i zCMNqzbOn!ec1pXQWvB7(vim=3|iiBiX_SN9xTyXJ1uy)8kdJePHOzb!7F~7oUE8diGc&!iZ^JYyJo6 z+CDw8GX33A`M2IZGK}tJ5@nuju#x%H$L=5-ldK16PRdm=)?X^t=p3`_FWquDU~j|1 z2kVan?3tz;V!~J@ZoyaV|1AD$N!CNPA20d@Ei7AtoRg=x)+c;8qHm=u=)0#Q`MlU$ zWnV?dDc)Va8yx%&JUssAVd2Iz;gS(ys&01Y?p=>``}|v`!I;%%v*+YeGr4s_6#-h- zJmCg1E!uagtYUmu^!%07e{e?5@F34)>r>+T2mb{xC}~{b?)YdE0dY4@n$ zewOQH&Y4^Oah8|NoL=I|@aTkGL-3TlYZ@;ef7nvd^Hgu%UAg2h?}ENbG)Nh3GdtX) z%hRUgs&l!^cxU(37iSk3GEY%vUorFJnb}u3I6k-(%v*Bx*4)hxg2S$R#@27uZDMCq z+QI0Mwf_UlvBXQ~We&ScyKrXeZU2QSCtBx)>17wZ)N=bFv-V%N!uHf#C%E|&yb>m8fUE_>}+_6N!D4vGQaUo8}g-gz|e!j_w} z&Ry_V_{>s1!G4o!@7v|6F>g%nZRvZwk+N07F%-qE#O$`?;R6tI-p5ij&r`*A0eQKba`6^#o`b)KA`u3vC6 znK%EnjcZ!dGBkIo9uHA)StVvh2^;W zGTCyQ`qP!?cSNP0{})?xt>ffu!EO6r{90Aj@`<&JT_xjm^W)S_a#IBFSWW+!$x^Xw z)#V<)@W|g0x|zH@mlc+9m1wLIPLXjEdZp~F&#dCm?{WLoYNz>457ta?nzKg5)adO@ ztG2F(4s9iOz6R}0TyV#Fjk(JkmUg9sj5j?t$kra!x0qf(uSjnp%bSxIc0USye<&zW z>!G)+WNXmt>mgk!ZzuP1*zLGocw>^x68mT3Yn$RZ*&dt}J?Rv2nn!*&Uml)U7O^CR{moP=xXJS&z?VQy6G04U5uL6;~Udoh_HedkkJJ7Cl#Wk?Xqk!5yu$cxSU#n<}fV zK57)5{`8XQW{YQ&LY$xbZCB##F}0NGePe2Q>^Hwc))X;)i*vct7Z=puxUQF+*;(vi zcKFgIPFcTP&g)YGc5h7KZ}WwM$!Z-=g(j8py2b|kj8`A=8~-OlS=0%aJv^3toys*c;qV+i!%q* z)@lWuP|XzIaqqQe=Z)t)7L1h+m+HOR1X_caJh=OCUZ28)T{#;+cWjz_g8znWkM$Y8 z8;_3fZPDOrm1H`%)iP+J!V2p(J6T)5FkMU1(r<_p476dH?O!&f<;4NvgJ0F^<6^>8 z72+#**#BDTUmEtW({|3955{sA=a!b+tc*SS&BQ$9$l`sH+h!HSGMk=0)v6w|qfJSs z-t%l~$;LBt@7lIh>c=FWN*Blv3GYpA()<$m&Cg7<_1|t=*VBD#3O;6u-fzlSyuFEI z+B*GP#|!po|5(3MG(_U{gKq0p3=$LA>T(S`Oh1O`Oq}y7^y%UDYtI_Y-o19d{=wN= zT-Kmd@G0A_U2(jxsurACq~yDN!=@t>_ugnd826_BP|m$x<%1@bL4Hl!HqSZt*z14& zXA5z6!5k4MPS?Y6@%?*6z1NkjXn66va!&vEmwc}+_=>9LXDR-SQ}{@bNLEdjFLRqB2fXZ`XcvEr<*7M_3YZ~En;lla@v=xPd=plYvsBX530`=W-2|d>zNtx zKIBEW=h;2q&ff@WU$=N#o!FJjo33(v7w$P%Q|~e1MB`(}Xp#RVbCOyeOkGo6n)PWiCUH}L1Z$-A>&``*gSI_0O<(89!; z=KX(BfkJtwE>{@mi6eW{nvBZ=Z_7-yYSLnPR21>FMBvW3y>e6h0!>y}IUYZ?Dr%R! znzG))loMsMKDFD+`Mb}4p!H<8{B$`7U4h#F=MA?_vf^EH`1`T1>7He;%$d$ciZuOb z%x|+YU$p%A-?ncXzX@1}=MKV*K5eWdnD^5zF1x3+Btc%RBmH zW$kfwe_^|wHD7INE52W5PgZYIw>*FJ$-}})r#w%6ZpnV3t3LmR`ow>BfB!zrvQGb$ znP!pBe>r4xO1;(PpbhiQi?92brvGo;clC`*U;L5hhfN-@$(!c7Mf~a{9{J@vQ%*QYXoJl^}<>85~uXm;JsLxg_c))J)v_tSbbAZkBY26tU=G>M)s`lJdZL@REr@$P$ z7UnkLpSQ1XD9*a+>$v>wM_;3>)e|gJx8Ey0o3>G5bBg-X?C1k)JHN^K&hX4QH0k@? z>N#9|%!U2Y@gb~>R`R;p@cm_+T~_Bfw{&lbYW>=F!xrb*&oKmh-KaNR@y61L zwy!QUF}(Xz{Bni)ch~NV>b*C(|0LXUwfj~!vA#uorDxH~YK#2!^*fh$io8x#TgE73 z^|dte@pt>ZJ!~78_Vh>?I2$z|Il*Mea!fy!jdzX5<>oUAn`ART$*cO-FJZpqVdpjL z{)1!z-}fKt->gYW@6Ddi{N|cm5Z4)IueUZ;pBsYAdiO9MZiv3%o~M|-Bf-47(fb%{ zh>%7~e8JlpEHPUx&Q0IsaDIJB(Y{6Lj{Od^md5X1b@$PU$lpw+xwc;HjFQnebldKq z5fD#SF_3!p`mhe4=fN2zvqkc{rpsl__;uLf@VaIGcbB+oJ|V(p({d27AqsZ`tDJjFTlmQ)x#KK;~* zXWHuP@A6YR8ngnp=Gp4s&5{1R;a}apdj8Px)f4J3Y?{uyp!=iz>WwE#4jC);zuf73 zh?VPW*eZ|3k>QskqSqv!st?q8@L$}6e@U==%%z-{x7U3v4q=&{pCUO^)hygrS7D+J z^X5NIVS&s?4V_l$_!imv=*;Sz5V~W6;&z9wvzaz3GdHaAF_xU$nDI>GVw%^DBU-jS z+S>cn59d^>yH{?P{~4847G-jJhN8)W;+LN6lb)=xvC_OGeo>h#^laXrq}KXL#wBql zJ7s>!2Oe>%XFJGiu+!pWgVwbr4pR@O2-z==y(8g*2PaMXz(<@ z_*m3brRL^Q<#pd@7VrEZu*YO^Awxm8sJ0s84A~H_8)Bs#H9bEbJE^V+J!-tIe@9bv z5NG~Xy{_j4u8hC`w9d2UZH|j?o}%^tKzsJ0*SDRnMICV9eW%5Fw)e}yt>?oc9vph{ zQX;)RXg0^*`kM~^ia-3;Xe<_4Hc6&8s4n`16VtR#)0>WLf&aZ0zetv1eX-@|oa`|UFOar|8HAU zc&6J|Y?FP%{<6EOI9_-AdXbq87JTn?Gk(9?ExPraR=sf9bp6`cM*-76F&Dix(WwtU ze8~3T8zG1D9CLO~4^UFxV0n&XuE%7#G{J>sJrja5Q(C6ns@os1_4t?W6PsKPw|;M6 zO`F0RzVJh~?Em!(zUe*_3#r<*zwpq5(7mfxl*-*br|`Q;zODJ(4gHH<|1DZ(&c1fh zqocN>Po!$gx!ZQS^{z!Np;=KZTRD4OHvIZtx*{&ky_h4UPdSmV;6$L$_lBB?ox3_i z+d8bH6cidJ`N)QKyxH57EzPuQ%gxyE)*9vuUuNhDsIgC+EXR~}yw#E6xZ4Ds-#eHL zHs16Ol-S*~?cVq6D<@bsGxY`>y85a#jD5LyiM=_m@kK??`uekzWjkb-uWS)7;|y=)cCv)5<3&k zpM1Q(P3PLhhxMr&Gf!6Sk8sQ_t^a#v1=pE%Mj96`I6XQ1`*>pNh2~QYw~wA;Fc&S8 zpK@rKVke*K`Bf^m2lf`8ICg3+v+UG>ja3?du5T)ym(``>$gsHJ?z>q`OHNJt)hx8| z+rLu>?lnxdV3@;lYu$?At5?s2&k%4t7m#=>UcctK!)rUUqr&^1SNt=ynV7lncl45d z@>Y{3aCNRf{p3WeYuc+&L(cD_a$TLwjjN{K{rmW1?{Ci~%Osbporrh6o-p@Gq>uH@ zfT|dqJ-^v|{O%M(S`-%M#uEk91S~BPi(-w94J|=u#Awz>d-qH46x{bZ{KJeGjeTAG z2?+ z7LQk_JWf^#@HsKl!E|FN(^(G{zcRIS{{yoxbbYyx#1j`l2j zRT>2Xmb|i_P_H-dJ=g3hKh`Z=x#W0XwCdhTJ{(hdL=6=yTQ_k|lKQ3bB<$tXET_3I zOoeA%I?R7j^wR2k4WgG;A3QSShik9evO|eiQj*GyO69ztthkuU;{1X+N9DQ4&alZf zA$!t-9tdO=tEsxLG|8W|f+yNQbG3lt(h#ZktCKu+o4kt8bu6AyFJ&j(k*lo8;Bhm= zok2F}T1B)k^L`$RR-@2`8u2Qm_1#;uyHIAvgTKrs9-8@^Wn&8wgA?anQSd5 zr?6dPN^>h}@nBN(GJ5iynN9hqHcOT3l)`|OFHV?ygwMMEQgCwZf(}P5c1>v>wHY$f zA7e}+o18eMlqU-8)0lIs{@DlDWO?4l8h#?{rAk&;oSpJQQ-){jk`NBn;3W=AncAX^ z+88vL7F|kO#c0~c93wh+&kTp94*WGOPrOw1H#W$bUROV{bVBU>1=34Zzi9Ub_)6;w za4u_{Q^n75dB#GYtHs+ae_0uFxvrVFC|@D`u*w22kB?HzCNO2a*j=R4u%|wAWon1k zg(#*I%q)H0op(3-pUGA0VB63nF|*&d&`@DMcjiSo=La!cJX}wlGPtT8q`+{|b&Y1; zx^-r^&Hw*-dMsyt-Jgo;?Kk)R`?TG<_TS_7{{J^}>UaG8a{27??R;?uV)N_w|2_Qe zX7qag*>6|R{$Bn}_ef^zu{oQ18<}*>R@N(ubK5fB3ob5A-M0Shx8t|Xx2OHS^XJ+0 z^7{Q7SN^+ZQ@QEje{F+@tCwaa*KE6x?2>OQa&~!!HmO#WF?t+aHltoh#gsEBaYfte9TRw#RZfUX zoK`oFJu{&5fqt@3tsINqB89B}N`VSp@kcX@D)`L9xp!BlZma)yI{sngjMj)}d*t{3 z`Sba!!=Jm?cgx4$-@AMF&Rw_mRertn_}jm^A8)7o_trQ4H@hvqUH<)+Fn8Wk}vMo?D>7>%j%ES zeSbc`o$miW-_DWU2uSWXm3XvFXP-LhWLBFH_&vEJ?YtlY`+ zzT2!Pum`XOuwSqWxXbW|;Sj?k2DYbG8rL0n@|`LTSl3)6J>~X-J8VzQH0rl^e){Tl z>+!;kGnUU0^myQ*%+$4_`fHqCvNNNgT$EX{fZ)SG{W(t@ul20&WaIw-GS^|-M5A2x z^B&vp2#VFj8Xw^{T3&MAd8OH<Swizh8ittc%yr^-lpTmiBs=I_*br(Q4*GJ+?|jj9_6?-qje#x z;xajJ>%(0>EnOzFMGG7F+zc5DeWf1BW-ZbBY2;H;()UH4O_ArlM$uYl-MJIm+ZWqq zxi0nb*b-1ZQ>43B>f|0*+3YL%GN<<+UH?*Za%;H>=S{vMyA47~kA!&tr0n70W)j=6 zu3qrrnuHYrElj#+J*>E%1nR4_OC`RGd6X4kawq!Q$xhCRPa@d#5?wDl>=IQypmLz+ zw3^5rL661GR&QRX&IsuJAScIFX`t#fx8XC-3C`6^P8&>AXgrhZeeC0*qjuVyO%E@* z=8Dha^{@RBle{&ClY2{emG6o!`&HAm!%`V1&ep51N^4@>yzbS!q$J<`&V;ILa%N+(yCJBYdM{Lt!I>N>|`4kmrwj+QlEZb z?%>-g$5JL__&j4LUzL=hh~A~SZd1fcLf@M#N}2sgGPc{jp>2u3l3Ganmzm22O=a_! z3nps|oR<`-PyY68PG_g%1BY`CJfe}S?VDYHq|bgT(-jkD?c8Oex9-w>w-)0ki@t83 ze(8+qlSIv4_9e;xu3x=6XWQRhvu-oqj|tx%_+?w%m!kg*nF|>*8H^evck(RYTM&NY zPE^FkU%VxgCT>l0o!2cfZPv4$>eGd~Ton1KJ zco}Zo#N(dTTX1tixZ$NE$=>x!l~+U9MESU6D%dzfvw2Pi3vjzXTeK$XyW&344-H=W zsn;xH9;}m6sI?4goo?#gJ4N^VDd%T=OY*85cpAIU{yb5aGVyOu-|tuHsU^ER&b+vj zxrC>!;?qMDC7F5t=_T47tPca0ePIy1>1s12*2bZvsbt4oHy_De;h!WsR_u+a=bZ1- zGgb1rq=@BRy}8bU>o&dp{3Acr?EaK92Q0tvygu5#`}NuA_d8xQGt4(m+N-O0<3PGd zYSok{)xYOoFRGg$TECw!ZUW!sw>>_43gRbMzioWJQ^}lDCh?fo3Dr>@pCh*k+) zqxbdp8RO`UFY_%wKInf@ed(d6*;4nzmnTQn`(<+95!PSV^f{W-~9lznNY>Ma=)HhJp>BDQ~}$TIk$9o4xV|ns!ya_YG6` z>`*+Bf3rSXz`XO~(R(i!DmH|kJFgJ1>Xh89DN7E$s`8e%yv1Z+xnQbP=F(ew_lv9h zb_*pLzGhumy~X2{Q$F|URrkCu#4j&%EWRnmms|L;V}|eJFe&rz%gcU-K3jFEaoeXA z7aFgzr*65w%Dv3?mQvMIpH7+l?5lR?GOX*C+kRhY>z5lESzooDKlY8*jen<3mso#$ z@}+s%q*)$5A@bR^vr?=*6SwbH-d^@VJF8ax`-iiAdb*_v7xkW6)$YDuvZ-6z*{wX} z|6}pV5~AN#zHo-6Z)2Z(d6f@Av)twyab>H&ci`keT09`+l*YBkp+t-#fnu1nmB><5q0;Guz9PkIHPEyXbJ9{_~jAa?|Vo>h1NI zZ+DEt{G{joqEI>EhZ^AvUA&k6={T-5H~n1a#pSXyLoY`LT3xpOyDfNr(lo8W<@U#y z7?kTfmwadDjkUNxd3pQE%ZE}Y>wNZowtV4=eJ`Fa(+TNM{J6bi&b0iddHbyX_}72; z6jr_~#{d1-5!nr!7Obxgdi*n7RCa#(CHwktcXruJ65{tipV|HF<{pi00?(dLoUUE3 z`SQJt{Lkn|eY?M@R@Q~t-2ePjPkid^f39vbeoEPF>MxA%>or*aao?Bx@?-8Z%YQYq zRr*w&Q}nIX(tWx4t+=tFMY`#xDK}&|ejL~z9O;)Rf9=1&&wu?hj%}}aFE6#SGl@NU z(kE@fs`{d~msM385_heeXA=AE!`fxmSLT}>bG7^Fu9cOw^UaLM1_u*&ZJd51Yf^Vn zwb|9YYu=NWuj8+na@#p?*X2vONtv4-?=yKh^E=;k=Erh2da0XC3QZr*?bw*V>&T6h zH{az>&ujN)Ej2%NCeKmKbDmUX>E{1x!Y=dPolZP^IQmPtQGNT2=P%{ntBJmR-(mew zKFIG5zs7R89JzgO*6eUvSf2Vge$v~NO{EKGexA_v`)XsW$+PZ8)m@Rh(|k{*UfQ&d zb7P;%npgRouT8D$ziwLUnSN@WxXbicnpfYuiN!AV{apLA?%%S*TMs|}{&V&^!N=Qc zzxMd{3%s0L@4H<*@|$-Td;P1G{MH*&za=yuy*bG$digrZ{mXuLpL(|E&5j;+Vc|n- z7*2QC`}6F7UGceGHqZ7|-}h$D-g_m|DQo;+?3**aS=sM}(X-ll(~p`iv98~4u0MH! zp?>8qZ`p^{1sjZct@YddY-dcrS#+c{Q|`2g$FaNG=ZeZc{e3b$;>ULJ%lW2v`Swfq zE#Ck7`qyXi>ks~z1@160SsG7YIEhV6(AX5VveZby(9*!bczR(by9le1fq|jH^oNt! zwCh#wZ+hRon}1#J?%meS{O|aBckkxqdH0U5dAIS7-M=54d+@IR{=N5aET7-|eSWvT z)uP>YTZ^8W8;4(8wW>o+JuG0ExYF~lGFP(XYQLdymNVNb#J_I zeY3`wVLtPjHw90gXo;P>cHsYFPMMuj7cQPWbZ**n`(yQs`W&2}pEpiwJ2$^rMMjrF z$U&LG*u0^0cKg)c_NlA~4jno3F}|&=&xXO0JGt0-fvLmII~Oj>ak%ScrN4iek(l=G z4D*laycbv!o-hU&Z82v*!4#|8u#G`nojcmNVP~uGfpcfY9^|B_zhyDlV#@eua$n2b z#gY>q)>r*pf7m~>Uajx{yG}-h{6ub+8IjdDX4mg3U}Lb~dt)Y(kG(9TkM5fP=_Yv& z?g|Gk9C>2Apx*sM|Gby>RsVy`|H%B+c1`v9>%VNxmoNX%ec%7{=X_3MhA9o#9GsWe z@3}RLL6-5{Glzx^dl!Cu&d+_|)**?E*I)dd8rC~RFL+!(^|AfRf69mI&mB2;h;e~Y zdD*t-i76(3*RPP6<0F~Vc&_Kl{HtQyO$E1Z-pF{%%KD(8F{6)8&s;_~2V?GNi(~aM zD=Tg=GoE1(Uhr~%P4rleH%jzPaFO^l)5*4SLQVeU-f14j?CeE2!vPLxOY-~Aag{`pPa zWV)5P;J7?CS7(s^zQ66?%CG;Yi2Ucd_GG@&<_*O))2>~-z})w8 z^YX|WHyPv3Fm(I-zhhYNd%2l%^V+$epNll??cRL;d6wm&`oEX`)~sQ0dsy%HclHg2 z9;NzD*#jECrdu%dB>h)3OJi7kCH~izDZjnvPy1Bg$$enO2l=FQMuSyr^p_zR5~C4B#1N_R`E ze`)OZdH}ns@Q@{V(db^la>2{P=m_kM*)oH_!jq{lD}j zQ{y{_T=jrp&?o@v1wb-If@CT=tdt)KIG%F4&jCp?#vtiP(< z>=rCnxAcVN_k3lwc|2!J!moZhbMlgpUtfu@rRy9HW^LhEjV!mtZ3}I`#;P8WXcsO` zc-M1@@zbGiZ27mA)SB0)9B%ebUi*FHt_4j;7)$ZmL zysw^L-en`Q_-NP*&3aX_MZ5dncfVRxnxf>XX<2u=Frzi@qUsfi*qEwkvm>Y1xIZ}e z``{}3S@ml!xJn(lSh4N$hA9i;oAqRPI#@R3O1)F`O$g|%y7TtS>#6IfK3nTzon^#n zf0M0I%~pUtKmALp_DGu19Q&a_MY$UM&r z6W`=N{Q84?UdJ>6C83Fb-->*5+}ppr<$@^B@u$A$O5D~uJdT^MJ>{#CuJt_Lr|W-m zeGyRpy?bunv-(-H?n`zY*!_5_qW!Ce-%5Me=$~J|Rzqo0AE-%{Vx@2~B zcOTDRPv>X*4^});yvcUK?O#m){+S z9uw9*6T&4`HO?DfUgA_TZ^i}X?+JqSk~=c~{|m}GHP_drV&#lgE4+?JulqPf(nID` z=oD_g#kW&0N%1Y(_IMG~e*1IBPZgBv*q!I$WK}p){y}#24Yf~AVjRNH#QFH^S5I>7 zT^?L0wcqr}e2{LC@UR)bzcd@7?ozkMRlZ_O?0` zg`?&H+tVHfxV_Zjx;UjsaeZK!O8E1gT|xf;i=+zmtMA{O{_IEOi*HVqJNEDBzAUx& z=%GZuee!Y)OorKu1l$iiTU2mzL8xex+x&X(q@zVggW|5;%6-mWnDqEsp!H+@RX=MY zr^?%(QOnuOz&CM6qVtN%w;v0_Jyx%;o~aY?He<)$rRPpsFn`*m%NLdya#MHf%fMFW zPq(7(xP57TGV!O>Cr8gT-bF19FV=8|8MGH4dwR&>c#y~*&Y-W;#1GuCGPrte=SuZI z&I^SC9@R%4f8JjCom;QC>*RTv`|Eppx0Jg7GxDq}mDumR)!XqftL}D-ZJR%bB>YUA zYgc6O-nZs-<{Hk=D=!qatvn{+%X75#W|-BF$fHuO@;=Ez0$*nATGA&JF74=}fAhfE zjGZB@Var0#xGu7Bi>|TycPabmJy*~5E}P}dQUx<_Bvo9kH<;&M9S z+9Nv_^_5&$CSUV9pUrAVu%K9thPBX4>6Pv^w7Ij@( ze|M439VP!9iT15|m5((R<>}5}cdgX6ykl$RqVQ$M(+Z8+UY`B3;fWSUgiu}a(u=)X zZ>GB}zFnwN@g&7G`BZ)4SEZ|KI`?0nP=7VLW%v5xQh^=6CoXpUe8oCDIFMJ&AAeaKa8Wq8>rl$3M?%@VPh|ZvliN5ste)$1_nl9_ z&$}MK*4#2zz4dToSPUQIig4k=Kk`v2^?eHp+3dQe2$?Bve^of;)0?|qN2dgZS*?lT z{gV4DQKVyf&?}kk2^G`lN(Z#a?R}8CIgRD6!X5VLkXh4R)Dza8m&z-sE-L*XJoU=a zY1W@?)1SS}KXs{lORm+%`Rfwzo(TI^R3ob)*FJ~mgZ$^bM87)+Cr(X~@9ox8nBXv{ zM^3iB&?#oiq>1Ks;g1YT_r8C*c)9&l#TA?UJ9pN1{+#ar)a=yuXF2Om9^Sc)oxO)u zHzerH>3aqrL@N$|RK3}tDOT~Mf^U98)#vS7J=DLiD_QYjVrSYG8_kElH80P1|6-ey ze6FO)DfzYmzh~j@KxrP14}YWXo9dp3JTalCMSOq%>iGK913#5_uohipt|{B_T|jNs z2^qalZv*(0GfzJ*Vw-m9Q_1z6A07quT-iNma*|Rsi==>1#F5v+QU%ACUN@TmQ(avz zJ})YrpFd8$B_RIhn4oTxlcN+ce;M{$@}Ry*1pYK!ElOM+gk39R(jEs zs>3sb+8eFgUw~IYp z=Dwx5sqOwrzJL6>``#-4>0+Jpp?aUvjIdLe`xeG+y7n`ObN$~P`MYY^c8cWpv?u2N z{IR9T@-C-w-POhyJ3LjYZ=ZL%JiBRX!lgrRWdBI+_SRchGR4Q~zR+#8`kmTIk_;Cr zmmXPGCh2VPS&jMn!`F@vo1=YBCw)m_Vo8!PyR`4|TJFwZb^9X0lYeuycJ6=Xa&oWz zJ{J?CyHfWZG=HZbop14@yrjd~TFvO6n{*Y2*+Q=8hwh!3TEKBraqSNUmp7ND`U`zK zRBofPV{z8ey0)uqm1`7uR(yRa^sBc1_ljjPGn)=@FZ`Idh(o*AdR~#lUDGtZL(M|XlIL^6+YO_7j`2&s;nddL=;d>(fqBo2GCxt5yfgotSCyKIDg}96Zkime_PZr$ zae|!bw6GIx$8MZ@$Rr`EjsmMPr4&~R@8yr4a zM7WC^O&6J7?{4@mL-N4{`4_eb8(yz*WG(y z{!SzI$#OdbSdtZ(6Xn+LI=~g#RiIUQJ!o@BtM<=HQ*Lq#$9Wzs)UcaU=)Yt?_s0M0 z9>_O7`>|KcA>i!qe(8=mKUi|TFN=%2&7LJ7e}esw^1a$`RQ6W6{^8FZ@1xo2>TJ^WOO|R_xcQ0&^P$Wr+Bi#JdI^)CyC=WMT9jt6aRsDEB z%}L^8`R?+7=aDAg>-VR=_2#=6m!6!@Uisk6MU72!P1iG&3!UZpU1ciu+@$3~-g6@c zy^i}(OPPp2@myT&nC?NWI1XVRslB-SfB zX3<8`B+^~-!OC+T|rov*Lj{U}|5D|QvT=+0XSS~GakH7CWI@BWc8XWNCF=CePm z%$QxcQgiC=yJ1UM_Uy}?xnfyjN7FC0`-kG$Lmzypp7y@OGwRmt%Ih-K;6ZhpJx(wkYgf7*E4J`%kyXm4(#ll(QV zHd$Nk(eI-VZuEQnVQ=ZlecYVzbh}Ks{9^Z;Ei3P>SS(%jBXG{oj-tSK$CioLXgP;J zD7j;vf6aQOr3dS&E@3|o?}=OjyghTiilsglEK#|6?T=x+bKm-&^|@Zdfw-4F9fn}g&!_GP7FnTw+w!xfA;mm#^gDS52V*G(3UZ~=M}%letXXfgN&9nD5qFNIU((y662WUBw|(bN{?p^7uH?cOuypRXfTI=js&}dj z$sMV;d;O+pUc?{0EeAdv?OyPbd3B%B@x2e5e)s$FzwXg#Zh13(cU_I$-}n8T(V_Pb z?e$sGWm4zX84>AxW7**&Pgd{K*{QKDM(3i}EA@l!CzM`KT>oiuM7ICI%ZJX_dmp;+ zMET3VMMtVWu3nURLZjkmh+A9n0(Z+>OWku;ZsN5T`1!d0RQqN{=SNQE#?A91rd%xf zeb86WJ8i9UdYZsFjfNeaH`k}~bC&AgD!9AspDv&4d##%H3v8M6xBFDD)HC#nVoAOsrI+nvi|-uQ@u|`f9@6h2{;}m^K{~3)u!vQCXweLLFy58+ERqdjk%Ra-KZ?aVHEZD5}%(!g# z{PWKjue?}the_eaea37xGcC=UUyr8ul`h{|6XBG-|Noh7l8%8I7Gg=v_4#s5+MzGc zD>;-r-*D*%qe1X1<+n_^RUP6=UP8a~AmfuCkMncNR;JkzoHM`TG5r z_L51>+5i7cUp4dgHC5633SF0q-zZPE;#l66z1PNebDsapRGWQ?i<72%<#sOpw)NZX zb#GTC_^NL)`Of|#F@3R`_>FWf!T+b~C+KfrIj~cG1DnB384ka$wQ}NUI>y~$!v#e{P_OE>UOF8_fr+VP`-@Cp0{&afP23Pv+dXN#Yx{^=r z`LFuBdkwqmuCyu$=-*C#Q=p=!^3qqJOql(t-HJ~~9$GzIV5T>%lkMY1t>YF`{ABM> zEB?1nSBGm#U|E8*li_LoW6$bjb<3~3So~F1MdkcdZ@&mGgMY3$$_A0xv^?;=*FCSMk>&T>6@rs{6& zTd#BOo4xn{U?4oByYB>_x$VIrxVl3UAifI!JE)EAFH{~&OYX(mbU)lv}4j)Qc0}-(p%$v z|IYn!=j>{0P2roLT`k)y-Ct}jTxH&UZtdLT-}&dRXI^O}^kYs^Wq)h@sTp4-KJ;GQ zaQl9LtJ>iUd&H(heRsRqWU)PV-vjq=?KUwipU>q?ymaS_c-pg+H+3uPb$5xaIF|Y| znBlJek~HBjsY~|<@9pQio>INaX!4m;OdG2g9-e$J=M>jXwtw%q+pM1EPmTWi_+BK( zn$W5aRuh4YS)$!iW%D}idmC*xNd0Quc%Y^xyv5R3ZhOc3H6oK4`(*Z1ToRuxzQjXm z&M(%GJzv`7(!^x@rT(TDXNkW%Jfr@FM80Ccy}hotvi6oATUIyVwY1@urhDSk>xCs zt@~}SZ0h?{#uCUcqLEnVnQO9m@#94%8|t*RvY7I&?!VdpDMYhdb0_cez5j1a?~HKn zuU}j6m*ZB{%2adxz5fL@zV9fj+&JTROX=gTEx%ag&7K55H884~c73yJNn3Va^j_<> zvaRo3`tzj(lGB=JOqu*j_1{x9fu@V|*KTFGJ@>u(s@r{Em9PH((j%I-sz31ZN{%OS z&)sTe4mm85U_VuABhvDEdiO%#U*B|;FD$%zMnU;ReeIp^|{q}O>l)sm5 z-(UXlXL+5!&Dw)*Jdw|1LuZ{`H&yv){z*>O)$9-1A|EN2hMw<|NL=#7$Y$NwiOaa& z9a1PMZ`%B1iL^_cidYuEB)+>dfxq}8YldEi{*m7p7@LZuFbgC z_=Mxz-k(pHpQ-r0T;8!pe}C44y4u#T8~+P(9F8do-$?MgT&gVUF+tVr&(3|)8Vh}l zyXH0Ou*`m5`dp@gH7qT=p!Mi}hSQbv`Y+3P1uaoe&|71x&NI*E@kTB07t0@SEiatD zG)lhU+usSVz6DuK*m!gE+bNYZj@^G*f5%7WX_ME&gTVUZj&BOoW!YI}AW(y8E z?6?&;!6PzDBZaqik4F2_7khI|-lv$Wow|BBDU~Jv+n4lnsuraa7j3-ul2`chS4YXu zU$W}gXsx&^TeB)JD0d&1)G4D61zmA7^WQng$xhAuvol63DJKHII=6GIp@8gXf|6O0MNeuhvUhaDO^eTm-gH~IQ zKdfuabv{4iSfLy9s;?PqpS4Nydi+0oLTvr4eH<009GB}Qm9`vpkCVC8u{Znr} z@2>K-4XKkRrOhiyQ~CK;Io(BaQuoPKyUym6Hr?_qi`SXhaw==lf>+H(!Tzsz8044p zGejx;-2P>vtVHL**Vb9*_B2NP+QyZ_`dk0yde15MHY{1%Ij<+gK6jTch=dem*igk%wD~y#H2X$!Eu#@ z6dR^6ysl9W* zp1C;5vaR~0q5D1WUtF&Qn71F#{o+-yFqQFnnzv}-J{GR+ZI7akFZ!pV8PxXfL~pCa zjPLHV&n!CWbt7SFuh`znYBe*r=KBQfKH9&MRZ>~JZJtB%(-|LEr$@{2{Q2~~cg2(| zmOI|?a`y?V+P`(HeUu^@Hfuv;X#1;ry+T{v&)a|cKA*omdYiwGj_ZPmKdtNdRz%dD*9Ic>pre0|@`^(}c1YXW-8XZ(1$U2tDl##+JZkzZ8skb zpCz=cWa0t8n~HzTdgCu<+U~#Jd0~@06aW5m$4(Y!c9pP(aewGvB5|@b`uE{TtrxSp zx763O9~AKt`BAgfe%8_ZtK@&pWIf)?W7Jr2MA&SaQOSn=7anU)n*Zn7f`8GC{wsB4 zq|RpV?g`y2()M;+#)R(owft2jOfIhd!51@v&))u5Rhw>K|KQxM{%1M+LOyL|&wRVb zNbTL1(}}zPNp1BOp7oSbQ*pkEr2oH-?^F$R6NTjqXV-H?>#p*&x>_?`j{UAvT)nsH zVmrO04Vxc#l#uP#s1K)em`*ke|9c}kA#=~KkAgX(3PDb) zA7*^GoT|iT!v6NQPf$HDjN*2YyUWEOy^n$70mI*YepD&#RMq-+w*&y6)=4C5ECaTSSsVFWh+hdfFnL zM#lg_6H_a9wTpYiGPA38Y}y(-tt{=j+`492&qsWx>$)d@byJuZ;+)@AAGSl%`ts%r zhdJ^KEX*CP@A3D$EQ;U9erAU)=P&lY^p&et)SEwfV5#0~q&sz`$rbe|lc>8+Ia|b< zn>jY~JV{>O)}n2i5u5n)-2cB@Z!Xl9xK~v1Ha(bk*Mc=GE8IOJGZ$%ppHsK%y4L${ z?#jJd%(l=Y) zvHsqAL+MnjET)&v-`8ADSeUA;^J!`Rk_jy5)@b|K&zrb$(wqX_I)%c|soVT>E_-Gi zzWCotF+yu%&CMsj8Xr|IE&RRe)VoW?d$qdusxc)#Q$5YHeZ^L+1q7|^lH=ek)h(8UfVkum^OV6RZ z>`%6`{jP@5?c4{$mBw!OV;8lU7M$hFxwhw-&Z*OwVBoW($d>TFO3$~ z6xjGNeD!%%drA4V$lco+zdoP;UjJIZZbErV>om<*+Kb-!r&=o6t}$@(JnIr3Qqht2 zxmb9Pl^h$>`E3S16^9mG)Ah}It03Wh+M_^D=;CCZa`DOU{IjOcdiQAIysOy(KPFwx zsG8;U@g3*ZAmg7~Ca;@uzRknvqX65PYYXN1whGK~-%u>GPU(55)|@9&(@)3+{ZUS- z|H3)1BJn`VMYk$C84hZyhF zklOtfwUZ=bVx@QdZhmKYkog*?-GZpc@~T%>+5C3bJu>Bw@^;l9*PB+a+V*DBM*H)P z?Pi%-}TFO%kGo=w1di*Y?%3m(aBdr``)8v=B@kq zBodeI$&gNTsQ*|c9o_!uIr7IXJymsQ7s8#RpxtfOG*e6=0GVxH= znj;(ctbM|-Bhq_7qWtzJ;q8y+pV<4LdN&s(j(Og?ioJEo{F>dO?*w~4%-VH6LZfDSQK;8E=d_^2^Gf9c8_%2)eD`*@RL;KA z$X9j|d51s0pKGK2=(>c@Oa7a(l`8pvSd%liMocu5*s3zm?@ZQ%#E~t39-sd` zF`DPYlc%pO8-3?)D0`l6v%hO=~fiZ%n=xIpITikyOs_4_h`!MHbwREC~K6UXfV* z;Y!1=!^t1p>%Xk{3(xA*^(@jbbPw~>OY?8vnxW{ zd`ptE8)A-kU#v>2Q!mTdqHtH`^H$y~&yUaIn#p~rvr4Q&DeJr;mxj)qE%Cwf`dgB}sRlLK#^ZajxE3d=12e|d$w%u=Cw7P!o*SZ;z zBEKqe4b#deIeYtp9w7t2pe_)pN%Jd@Wff4(-r%x$a3-o|UTg=<-_EO5=T-|oGMtE}gBMEzNV z<~?f+wL0rq>+DiR_CHKKA~0wFtTeeLJ)16NT~V!F{@2ao-TnxUtH+Ypi#I;IBsN!; z!?I&x_)7Qshtp@O>NA#=B?|rDJV(0sbNBRVdR1N4%X}L5=LrYBW_Y(K@UO!x_Opwo zUX!SpW9Ql?t~oJ}ZQ{da<-F1#53E(R;XP?kuW8H@aryZS1ulW(oOcx}6|MJVgR3+sFXO8Ta< z&M?@s>yMzk(5-y#+NHWiFGYlYKJ(;T7}J{mCgP{|kH>Fy^_o6@jTUy@>~Kl!XMW6` z?90rPTZ1d4tIGW97rf>-cR1I#yiq~^(B`Z+;hskx{xcHks&{pg3!e1A&a&`_d33P7 zO8U_`UbA-f&8(Dgr-Mfd( z^Mw_r6^Du}x^9^>DPmjo#=y^e3|6~3Z(cg{kwD{zpx=*b7PqGy|EV?quX>eiI9KqT zJE<%FoqK+3_a&**;T#H8^$t_zj5ChRJ$t)PxvXf{jT>)|W^dZyB4V;-j@LfL*?KHD zq&92Yr}0`dma33I4L7s$k*N@?E30I3D5Eb4HtK;5YYd%sp_E6;?G}azVz;>KY0G= z2N$b`KY7)BpSHd`Z|x#6E8+2H*E?78P8GB+^D(`3_+V6P<(I_e0a_AWHWI(jE&aTE z!nXUq1`juMJlFWGwr0(tds0^#=TBc58oxs~+-RCfbqoJN(>9r@0eRj!w>O<~W^`Qg zFiHO)n;^^1dFC?91K;hPt?)B7^VZb6`H}PMAN|?KzV6kVZ!Z>aetLUv-jDaCH@9i_ijA9qP5od;hQyA_Zsd=xHhHmg^L2us-%y>>$L2nPI-u0+GZ?i zc=o_y=5>xkla8-FmY9C)@ux-KJXxZKPLm>YQT| zPpst}n%TC6yOo*eKA83X&D&+7ovYWf%Ez3ynZ)i_{M+K>$2ax6LmH~0#OBAW>0ZnG zHR|>`gL}IbA~zj2|Iqr8|E>6+eTtJla=J;Jp2}6XQjTMC%*G`#_59__i_E8gul}~} z?@!;H(}nL}uly{&hS~RRbddMshM!L=rXG=-%MkR6V^+(I=su}CZa?38PTN)yy={Jf z?T&pB%R5dm%W57uv+u~9i+ZO6(?cIE@7}IF^+V{%U7-t}IBCzmC2e`Xx7xswU2Ufla7Tbupv%+Cda zcZ+!!@b$ku+5P@sO7O4QEI!r^_rl*aY3Rx69ZKy=Xm^a9G^JVnvXK742@}uV-qv8J zHNkUcccS-4&W0naPpOlt{<~raono&>?Y*#U`^@cLFB9i1z4_6`-u;Nq zM(G1N1~+t;Mwjmji7 zy2H)aH=paeN^DUQ@iAHaK?*!AlkDHlE8O}un@#tbFa1J!4v71wQRKJbQL zsr*iK?A4p8*Csp`_$hRmgSkpR@WokYf5|g57if5z_W%7cuc$?8R{dAct!wrarrw(4 z$S!&IM#kz$u^je;r!OTc^O!Vg=4SXf|2b)XWp|_ZlaqJ&yDz2edinL=EOYh)so%f7 z;gIxQ*naYoa(7Lb=&IKf7QeBa``6dbV)=aj#4XJhJ~>}b?QVZ&dDw32mBLF8UFR5e z*tzn*;+IUXa~0i?S5d9qN=L5w`p;R^PWrp9xht@$g6T8YihU9 zTmGg)hpGgQ7Cz_NBQ{}Il}mx-&%O8Vie((;-l`&SXy1CiJNB0@t<5`Hn$*8hk!i{S z>*>K65-CFUSNA&IHWrwgf5YR(#m7c2AIsjFJI>yBEBdtU15wwW62axFL2sin4lJHm zZ!DSJU6*h$Bx6yP@IM*5>;0c4UOidyEaQWBXpw1yH=F;_HtQ|>3R%R;_v$4$MmJ}> zXFTMtvNwClyVFTm*=Bw3F8=*(c;esI)^7~A zHeOykd1q3nHGlsbr^iz)T_&3@ceFmwbMtt4zI>#_&eu;ayFK{mrSQg6{m|>8$8ArCHs}b}v$Bc`M(k{p`BeDXvwiEO#Gi zr@E!2kXsch;DRbm*@&4RGO%jM$tbL`rxv@Dr_t{-&Z zI%5x4b}!U?%&K2i_xxD?hROAb_p+}g9h2Xd;q`5C?CQt$c@OrOT4+B=uU6M;nVrVE zFu`})x{2ObYHAt6EjVLe{ybY_$C%)w@3BlvMnPG4hV_!V39Hs$3xDa*b4cgTYro8> ziOk2pcrKZ}K4(?kzoiztSHG2*P`D#+t+3!f4_(dn=lfp>o{^P3xlEho6faN3lKPH( z=PZlK0=qu_;GQSmplW^L?LpaBOSjGzKKyNtU-JeZ?ZB^VQ_f#zwROCZG$BVgC-~Vu z=VKfvn%0&pT`uVgC_Z~5WcJ)Yk9K}G4z4YaeeXeYP0Fa#5!wH&-o?t$m!E}i!N!g0GRt2(uAHRW?Xcqz z^YxS^-vw4mMf|vRSZmpR?=`Ov^~%5ASf%@KL@BYbB^-HWL1x=fB;KJMr1KSCk z?e5N4{^d>Ip7RYFOZT|#E54v_UNX1JrDON})@yI4ZN9j9=e|i?wvRYj7?OG_&${nR z^f(vVf6&*a{_tb}x7(vSZ?NQl)mvZiuj`W3$AtS6=9ULfn=`HDt-tR*zUIH1CER|y zb-xHnmAL$(`qN{bmud{wa*n-YW9gx6g)o zan}p+cTJ2t9gn~N7}@y!6vvw+d2Y7J{*&ejN&bqjP>y%X+Hzac?aI@aJ(dP<<*Plq zBflG7N{+HHc>QJR`f#(GL6>*ceyz9me{}tR>&c6~d@Ik{`#id_h^Ldc?OW;gz5LUb zOk%e@)gu;Z)fMccv0Rb&^X&Rt7sFHBC)~=NE$}H)?>1X&(i7PRlOoL>kvr$bzqMNY zqiWW_DHA&PS!{Z(9$=T6RIZnb?bqBovxxF_m*K>taInM8eI zKaYXzv+N1k!QZ|ws5o$R>vTq2J-)zyYtMW^ zy-hZ2YU^F#TKaTcFY4}Y-FJNN&+5k-<%jQl<#}H9 zYN~wI8>TP)p7lvTUW)IUoAfd3=KkmR*L`phRggI_@#)%U3s>I!ImP$No!0bVp3U-2 zx77?XH9Zb&+uFiOo(vDffA?;d}@&X=)YyA_ky>tHW;=<=j$%Gyu#tE z52wUjqjR_ARF{4H=N+~5$E>X@IjR=_#hg%-R{tsvoC_9{&VcashOA5t};!OiqlM*H}A;pB_(2cXNoRIaQ zH;zC5Z=!J0=j@Q&Hytldt~UQFsdg*%P{Xes3*ycfZT@~J|Ek4fHV&0-d++RX6`jk= z)V8NtT9P$6bluJ%{wZdG*EsnEJ}0>~1x4D0ym(!4N@((o1&YxX>Ce^Mr}ww@MJU#P zJ^uS6x2vY>X0BO$W*@Gw9t=$U@Mfm=>4KhD@!PK5{d?h4kh+24SC_1wpCPj+=vW`! z6j(Sl)cD}rm{Tu*`)*>|-8uWX+&tz(d-E<`X!E$SV6w!~!_F!Bl2RY%ep^5No{Eou z|Lj|L_bQw$Dz>ygVRyqV!}xv5q@Q)kFCV#eF1}NLXZzVBb63>&mjqt=AatX5PPjW~ z{?1od+ERU=OL~;{D0|13Ew9U!UK%ERcvi+IoQ3fez}I}R%IModj0izhq~UMD=+Fid-n6ir}L^M zg;QFS@0!Y3)ms-VSf#PCr10jyr4~^^R-DVrYLCyo^GWHe^74fq<}ymvH4EOIcQ|f0 zbwmA=Kk~fp#^u|~S~+jqPO83rFua-T<<508-pexmsg;V`c|O)=QwaP0zI$_Im^qt` zgrdq9EBu(6=xTcYZ1^0DB#oIpZd-1L6&eVhv%bD;^?tSU!3@0hUjk;RZJl5mq_6H# zBi}o325a_l@r-2qSCY!#e}~Vn%3RHUWwRJ&YXVD+Nyp####z@?6*k>6n&T8FxN4t)ONek}Mx#f=4bLa%K0V^D7~3_2FJyi8CB<*YY!dtIw&cHBA<=TB^-@Ket)ktrnnhI>cLgqJ zmg?rV)N%w~HQ73+B+u@sc@;M&_vQPV1+$vEPYSPZFaMLc5!1y_Wr|@Z`?Q}6}8=B9?!3f zXDR|iCf7{;bu0ICZFA8h?S=Qb#51z~`90XQ;=0_L7vPN z+4p=}dYbC3WN$s)wf5NQbH@*@zbas|e%(FI%#sFH^J<~Mlkz+cbt=o0;$8};m8=sr z)mJ&RLHw`j)a@%|Z)7%$dL;3GQ+ug!OgdFt%TwflPu}dqhFgQA?hF2$^5B^|tIAWO zL&bA4&jolN6I$$bntN?lko2CZE)5?KuiI9Wvvt?;>rGP?n(MbMS9xCdS5V~{&nK5x z{KkKEc;{{Y=^(<*J3TouV{YPMMzwOS3-7e}*GC`8R($x4ZGCCk?eb8u)VqIP&Ab0c zZ|NNV0?sqvPxLG|y0r6IMA+o1r@yM&>)hSS)6t>(vMk=D{!d7)^qs}o+a?4#ZriMt zwoQM9n&m^kPQ`-Kcdz}@>d&8=wE5No*{OlEeYe;xzMSI!b>h8)0tH9ammhOezU36L z>E_HeRY4nbB9Cb-EmpQOV{m=&vv2nHzgpK^9KY(G@A#*>UGD5EiD>&O#w$nfa~S1r z;br@}da=~j2kV>CEh-#9l5{1=+CPL-NFar*OuZ@;;%w-z3IbN2IrZ>xSSeUPlXWYMw3 zFA8|8R6Nrg^%<@24D}K@x2*f8v-tfh4&%5Q2dOU~ ze4A!nKgqnR@r+KztV7GvrrOomtoSh5|J=uy`>#t*ZFOy)xkyadqH|Kc$HYHT9%t9&vMzj8JWH7S zYWm?iDS2MII<^>r{7?n=%6OIEX9_2zIUev@F+=CrLBliWiW!k&iBvCYt2zz?A@*Y zCM|pei>!jHR(W>ph4Ydf`@??DOS9P>C7_w{usF)e!6)g)%m=LBK3fK5B&2+uee_LJ zYuMK$zZYJ1uU}0oUi@s!T)h`*sR5=uxszmfU3wQO^C&|*ui#bojS0_ua@Y!7({^tY zm;9bEZ?E%X)5hI-UTZb$Rp-|+{RlgF^bVu&~ zz4_5;flrt^-+gpsj=Jd|7;;>7V(0>uUbmyC<9LkzWv$!JQ1kbq)y`AjSYo-Ne7Akh zb+%&Nd5?2h>%{BQnQW(yc669~ozKpbsJ-p}?$M52f{xWf5(!ybEqgBa+tiC*E4wvy zyWC6V3z8;`{gpS<1&xEJgt8}dF35giu9Ek!(P&c5B<yjB)A*dMc*R}oSa-Xvdz^1@= zOYYC9Uwd_}%EphnHGx0$SteBF{a)K#vBOg*HYy;0nbiYlr`fMkcp9fUu9Xl;-1J3Z zWAVkOFWQ3XKmHy*${MIK6J}K2FBu?KGws8KlW1`-%`*-SF z%l-bzl5tt&a?R9VH5>nH1z+Giex*JsJ3_hh$6keJnVS22i`Q)7n?Cj1*Qbsr`&}yyP9$z!L`|5WqERG^b?T^jlt>+in8#W&Nb6M;0syZge(8v8Yep8c0tI{WZda&BQJ6T}9 zfPU`mHPH%>%}Son-7c`}_M5))7jAbZHLgpWsxPQJyX1g0$6fOS=WaA))j!=Oq3!ZZ z{pv;2^oEHwCudtK7DapsGF#&_dv}*k6z}S2?g@qSyQjJSnYGIF^8=NOR%-X&8n?#P z9Jn#hY=TwIYr`p4wI5?PU6uJO);drEt0BzvGjn`PjN)b7)1-q?P~0wAS1DOEas?ll&H7 z5xc#{v@NsJ>5jf*<^k2;nxC#euNeZk-tpa*ZZ{4rMG>yK9Agr6ra1zU*qq8@XY+R_wJWozPtFYlTMrt z|M!qRS3g~xdm&3Y*6;5(fejKqsccH(`fm?zkonTFitTrwaoL&=yXxljD%B(uxZg`p z&N+NyQG>lk(Ym5z`?LSp9o}*Hmz6%WBskl|7=ccM)A9LKTzR(MMdVcMUO%|Lixwd4N8~&RQv3ag+k=}Y#qq%F!=^^AS@dhWR6OAJphJ##a5$)v3x{$$_HzxPlyDej6#dCLEY zT*j(WuPurfDmR;aHTbY@?~3AoLGu$f?`UU~?7hxzcdS1~cB(iZ>;9uDN{6~G&yJEU z`H)rmlkHLG9%sArg~s`nOI7<@PSs2B8=7vZW-nk-nAmNQ*sAhp${!`3l<0JwU(RiF zHpm(7`M|#?eU;$(xG#nZCzhyvnbOF`5R;mEsYxXKH&^P{FHgK9@~w8{Z_!inmD*7K zX!BX_2dio>9}0M>Q1@_6`WxxoX3mRw>HFVpfB0AFtentwzSby?y^Ggwp7#2o;^(f= z`U`yVCbP36o_EKWEMdKRnBl_fPv2hsD6o9BFni{Tnhue};`{z+H8`#|T&`TR@Ywd8 zB{8qI`ALRZyB|Drg3Z%o?f(g1|9oEXVE^8$YowLS1f9-ImzSCGB~3i%>_0Q6Ier@* zj30LId3(s$`F(h~zvmxz)6&$|sa~66HvW#d$i^gEfBSlV_I9H=s>{nP&sUm@tpBId zw(y$>r^NQ$jGP4POf3-Z$Q)01aZCSwIACuM)8h!m zw$k;bh7R26n$urMF5J25cfq#CY*(2rypyCPRzJ+RAf$Y}+SERA&ei%)P0ERnpSYMM zN4Wf%cEOMRm;Ll7`#;_~vcF#SkXnD+-oRbcG&7x#Bq{UQ9uSzze#P-`&J0)n=Id&! z<9{3%+<)=2vHBlrJL`$3%WoUE2`IJ)uWXw&$GABuf7_xCcbVz0L!Fy6e~Rw8U0UNk7yud8L!`N7k+B?TY&{*Pe^pYrydjKc1zOqZ1`F6_#`GvT18p!h*i zPtVfNf6JCAeiS?Wu>Hyf$-bX6OQmkv1eGa?hb{{~ZCLS>^N!GhN){!B9V$IB$yYDW zsBc~v)X*mqXP3n})yeJ$2cyics|UZg1uIBznzQDrf?09=~ zlHh_F_`w((RcFJ*=C(-AFi#ryrwAb*%Ri29ifNT35f{0DlJ^p zc<{1ho5X^-umQ*o ztIGAWN?xRYSasLCzV;^5+OXBiD`INh=EZH9cO*G$S*F*Wd1jL<_`m)LraX0$|r&ask!v-2V*b?9i^Uolm_oqO`OH5$FM7>-?;!}1|# z-nzC9l`qqGXfJp9y|VhVs!d+PF2UILH2J<3$tkyYe0E)ZYTtg-ZI71J-{S3i+h?rs zx9`^1a+3o;h12#F+5T_2C^>`W)~R1P?!o4X-sw~Lf|ZyZlz67Re)0E6(T^XDTR9HQ zSs#DzWzoH?vCWpr?8O~P>jZe7&#U@)>~6{5#|u}k=HGJX z_n#RKr@TFj4l|}7@zqUKU-o3#2QRLA-Hn%~yhxp_X39GCLSmG@RgYY6`7ftmE;A(T zL{g4knO*nPL+4$PaE9&u2A|UUt9_;mOgR{13TJ)G%zU8v$w5H-#CO5fT0Y_XT$o-* zA3i@de=^rnb?H#XMA?J4UTnG=X4o>zn2c|uRPly|C!caO?Ofd=wPAbUtI0LdDPE?E2j1&%v}pQe1JhZoL#c{JUOb4&dvNX=(`v0EA;FIf+S{E^s~qiWS-C4uQT6?&UEkyQ7BBv=@tV_& zI@{AX4b8$L<5{X_)L+`&eBs~8|1a;Tn5@|Q$Ydc$@NHqWiFO5B4_;jvwy4=+^^_%b z$FyBf9DIDkYk_5mgZ`BHM$5a>H$D!V{Ie%!@0Y^g;mqm>Uu%3Ri2c@J^C~OzrscPg z7jM-b&795QX?#=Uf8+U=wjbOKr59Z&6AfhXa_4;U`+@$U+v_UNe$9Gwyk7djgrC*d z%^PH*rrw;=IzeS?(*^4Xe9})$UZ1W^_$}~Mu+l2<4Bv}AjGscLKNtQNB=Tl;tJK1f z3f<}tO#E9n?2)S#sp5XEw!?kn%ih&4J5RLK9FIwnown=5^H~LoyVk7tyK9i|YjSKt z?q{{DKRCU!SPzt#~c^%|33f_P|L~ zySD93G2ogVa{2Db-CoVjy)oi@KAo7n#;bn8ulgL%xCae;0{`fnwCL*!XN&GWwW=xe z*RtTwUq4Gk=N;O1dagj}s=f*C-%h24B`P13>}8w~yF~O{t$|y|L^g|sZzi~RuX}fL z_vz|-hpTMmelltk>ZCrcn77&N^wj+do5Z_z3 zZIa^3V|$vbcZpv1_CF_`npbaR()pVdbjZzd`=s^F;Rnonf7d;`_I#Rj=gz`*gR48< z+Uakb`S#q$kohJxH~uVQ?ljmf)AweR(R-oCLK06bT*68gc5nTZ|1y3CuO73eN6_O< z{Oh$vN>8mnf2mb~rCzFeR`;~|K1%gVW+#cot`1>t{nYmQW!c{AuUGKQI%=B7+ud3a z823Ts#9|rimGdrC=FWHi5cN-@w`A1`qc=M9I%5{E==yzfj$y*zIV@9boEL06slX;1 z5vrn>VOXT|);az9{7%jCxgU5pZj2~DwBF~>DcQW853EDCl*iv$d901MzEy61O8Jsa zhCi6^EMuy8(Re>8aM6YLn=_BGUz5A^Q(*J79|!JO9+_yn{?{V@CW*?X9j{~FRqCCK z)7E*mbEfcJg~{q)EpE?o5M)vQs3=@4uT@ z_mnlSYE}ie{UX__2-A$o@2$?H8GPrgH{EU0zeOc8NZ0HOZ|0Zg$}fIjZPbzdm6yB;$5K47==zUg#C>7AqQNB*n69IV?a0(?SOzUt}U^DOep{h7`e zEA_-Czxd!Tvg6&uF6o^Sds%kvcbL*vTYLV0u+^?WF2xh#YOkYH&wz8eO|W6 znkzhVwZ|8YL`l!aGj4+3^34UUd^?^vPH;(OnEZQfc>VOBYd&V1)y944zVlc1J@46H zH=CZ$Y47_`;yY0?@z*7bzTGE0eFW}lo?aEd@LJz7fgDH8U$t%j8roh7)E#l(S+%yC zfuG-F#fA4R%^Tw$?Y*AKv|szB{huE%-cEUbE&b>IwmOH&LX8*f>MEz65qwkmOY+l% z=gI$eefw`O6|eJWM*ZCBd94w@t8L5*C(oW>vW-`RL+qfTW9R{gbVtKqKRWfo-KKFi zFP;DM@Rxg0CmZiB3w*Ox;KnJk#}PAy4304q#u1abH+dT_h%JN{}q4R=ilEwYxA$@xcDXMSFc?E>v(Cg{5A=X z=<8Lz4f(n+=2v8g=Nb05s(dQGqBeJVP2(h~6!zcj@nue>#n$JQs}EL|G(JfAzk~U| z#YDw79LM|8`@w%x}xQtyq>gPI;F%;oYQn?h3A^NQd9 zzi<66fv0l*%=5Fd&utY8nykIruydB9k3*2a24i7u;|cr<%x0|(a}~B7J9lhen2gUV z1#a=^WOs&;efaqmqD##P6@O=GB>uv(PkPd;D%*|jor=Nvp%rjQo>xW29<;)Z1O zO{3XPZ|Yx2{NLWNX3c+|AMYb=7hK6%DE9xyS)RfzKkO?v8UKBH>Z|^*|6&j4do%9Y zTKwyHdq?-m$&$t=&b0RZynp7&S|7&*^$C&(SaaBlSXP`o!F*=nZKe%>m&;`FRIoEO z%PgE~!aSpb;omJ|O%2%#_E{WH(%6~qMOj(j{=9L+pQq{nrq_4fJUK^_rzmY<^Rx(| z95ud;o0%Ku&Ycj^$Y8Af!fi%_&YA-rI`yqV-y4cjSZ6ez`QItpGgo%)9mXn$G=&MG z41Zoff4~0wg`gRZ2e!%WKP$TMDC-6f56|vb8HRt%eZOqqI78xy><31Ugruj>*b0~` z8ExLoVR&E9zbYr^Yy6Ui`u(!02c8KW*neX7&Kv);8Q1-PV}0Ou{TEr;2lt&do#rew zW!dw0Z}u+-zXh6KZtrziY zKTkhfUv@rT@64|YHvhNp`+54Ay_VD8|0dr5?|=UM-`x2B<2irsFK>1|b@bXd`Plj& z-}=8XJN!N`_#vM6$NXBw)SUFx*B|%)bcp?TIf(m<|D*r03R~@^Lyz5*IOQdhllXi4 ziBq1ZPRXV$%XylU#c5!^t(56+@VbxJlXBJ`P)O~Vd^P^LN{Na^0&6)cXpGt2elQ(Z6UfDBj@u#{3c6hK~PkHWw8C_f|0KOsZGTQ)qB~ zWuC;kVbAa08w@&^_6u4!xIQy~#IWJSKer2SKJ6DY*?lOVQ?9Sgn~E;}>s=62^3QEgfZneC zf>+M}$UnmPlu1@?!s4lu&*lqf7);(Ts4YEZGUt~Af1-I~dpj3zT*=E(^?R1}|7n~5 z>;8Y9@^@{+CBwhcg-(lSJLN3A`_-JYZ@)@e+5XIpObh3n{a4>`VakI0f(u$1{zkK{ z+y8}6?}Fz4w@k4!f98v8m=|kbw@>=Bv~7pQzlRK_8-K_OuG;?NwIsu@%Pd}3KAGpf zco$K1Bf9B8eS|}5SiOTr@N0X8E#J)Q9WqqwjGr~>-TbzG=dZQx*Ur8(Z@Fipvp=}d zDYDhFKI=Ru?<1C4rFKbwL?dg)w_AoLzHGhD*88`LH!PC zoc-38sY}ZWRIJ404?mf27W0sK!tIj9n>!3lN^e+m-3-|8|KRJ-o6V75ua>XO2-EV= zwL8Z?O|ag;{~})~*N3t+=|Ibpsj-y=UzCB{D5@(UQw)lhfaFRjm(f=|D>igJ3pCvg|1KIOA#Lq`Y&QP1-wEEL^jRfW#F z$f)!@`a4v!NzmFK&Di zxQFT2Qcu6%tt+%|Nnd#*a8zhZ+Lpw+S)roG1y;Xim>-jWDf`$6rJ+B4H7f4*DWA7*Udy$sDK1`~>>%>wetg8Fy6WVY(0{La#KsgTo++i-7Yy?CSV)0*$M zj+9t`m^7Pro|V;E<(&qHwsw2}OW`|zpEd2!xbwU~ltplzz2{Li zmhJOy2)^ml)_~`79lKFy};- z+c^!h`s&;S(p!02#YY7GvwJ;#nC0Zue5vu{#aA7d;+$*afA_rn!L6}eT z-Xm%{v8HByXpi8#PvWxIUvAj^d!6i_L*7-&1+RR>Ca1G5uUjU3(aYqnoK653kV_WIXa(JyLS!ONytQ+H6Pkgf8f_F4#{)o8!sPU8u3$y^-bmfe8Jd^{`^oqxh+RF@ozYA z_OZp>u=C~8`^+x;&gfpdvBH$qL))ojeL-r{E4ARLWq-HK;EbND^m+B&>LX3h#dUYg z$a#OjFZHixrzI)%J{xyq^jndixS zPtWah+!ZM4D%YOKePPE_^TTekTh$Zf&fY!4d~_M8;?)Y3G2g@t8V~vZ+|LiZfa$$-&-!mVm-qvy%-e>n*jPJ^R!&=bM35h2O=q z4G&zlZtXP-DW4S4y~8)rH+aRKUp!yurvAUp)}ViaS==U_U2XZKg#kQwf3k`nxMLf8 z%PsqNy|WE($|uX!r~VXbS?P+eo%ixBhu7h2otG{L1-<53I{(=2gLe!Imwiu)nQLXz z)N@TaGCO?k713$pnbl6&OVch%ZOM@e=KX6ntB?86^-%xg#+HmGvnQ`Kwhy~6z30fn zOCHzwoL3xUIioz`i<;~crs|;Ehkk0U|8?*9{3(UsxYW+qABg+R&ZD@uYou!P@lQ(M>mpY-3FY0cM~)k{4&XMFpTdn!FKzWtrc)7dPyInUSb z-N|iTy=%{#9tqdSn#<~EZFc|ry|Bk>(ze^JA%f2QvtDnzmG$Eg`zMuIpCV>|Oejrz zv!0trtVg@?Z`U8CU)%bwRI2t%ZQ0Few{)+hcDE~+_RQP%Z*08h&A+QO^CiRCBePPf zLK*MNT`T!DTi&QDoXPyA#Qra>$Be#gpKAGF@sj?78{e;aV({DEmFq)}j7fc}?vD)@ z=lS(6n7_x?+M#gz!h7N&Y+;F7<%R-MUJpOC%nVVNKYwsRzUdb+;TYXFTZ&`1{R&Fb z+!X5db;Gw^ejKrZh4+~m@2&$%Kc2?j+Geoh zqcMNr#1|z;H>qi@)7-L$q1M3cMH`opnpF_jWS*jK*A3e_DkBf?a*cRBZS%4(1#0)) zojl?KHe73V-m~iBq;38eM6cbswr?5>`@Q3Q7iMJrP4Q`EXV+PBT5(U`;!UT^ZdiyL zoei2f<=*P#pgKej|UkD ztoozaci{351$0PKep?uI~b0|XM&>x!=c*L0t_*Tp9yrn9CpdOsZ{+k{vubz!K?F{rt6yeEt~qaK)-CN za`^t@yIVeM&0m>%+)Ja&v!$Wl=KTh#tP7T6FL&-`%+`sXCaf8LA||;0-bq!DFAr}Y z|9MY_WzngdjLv;F$wJew>^vfVv*`W~#h$}^?pvuhK5c0?*vEGEiO7u8bF35EgKqB4 z$?Ub}5HkPm8YZ;p@fxGeMQg(kmmj&6V4#&N_1I@aiBif3;~kY3B8>Oi-?=Su=DAY( zt{+>c{o8T>8|$GXarXOK42`ee%Mz>iNxwMlq}Z$OtFPzWjNfk}@pYEk;rDYJ7PVZ@ z$g7pw_fvSEHp|DL`OSa&*N$9#TvV3vUW-N@TTaJD<7g z=k=Er)_zAsxNUYY)JivG%~GruNYIbm|oeear_A8R!)=G_Thf2Qa3 zWMx6GtHqPIJlOiHSN!znTOVIXIPDgjq~ST)j+eu0NrUv`=&F$E6}#VXELi1m>(uV} z%7a2}ijyT?NB*i8yT7?cma)I%;6c?rQ&vv%{_cI&h5d4N%>A6_2Junt@$9u(uS%v) z@HaeCzW8YH<##8wZk-FvP@c&vV|V|;71QZ`!ZQ0dcJ5nw&3^4K*LOS7P2S za?d4v4a)CWIxl7GgS0B9mPbq4n6gyvuLYT)jY0k!$voB;M z-tKJESLzh1`}Sj2&$Jj`uW7jvn)Ns1k{@>^xg25)e;-r7?}?0!(9;#!3hfsT)MzoZ z1bkR`ScShvs{HmNnbX{RcFoE1>;Juke?_aI6~9@>^9|qM-Z4p)-X$W=@m1{Gh6}Sf zViq2docK-r)+IB(b$OpWDsHyLEwl67s6OS4oy?9K9pc`SM<;r532e5o|7l_Qpju;E z{nEYLwBNj5`&jHyi^TmG##Vxpr~GtS$j+DOcyY${h2;m|{AT5`%oX`2KL1&vd*ltR z%@3?{R)1CR{bswTE1S8xSHNBUgV`~?HR7-5Zu-`^zkD-O{H9ASn;i=FCtY7DTKxO- z>owi8Y|r)F>B-T$z3}VtCw_@s%&kkqYya+kS>PXEpWl40Ch9<1#~HIncRG(Bong}y zxpVu?HP;`r9I`BVbXHVa_#}(PebL=wW#`fxqmC^964deUW%`a9_DA|#W_+CVH%Fk< z_`2JKqnC_&E1XVE`)I%82-n`Zi8E)E)gPbHsc)$#pLlB3rz%g$pGoc4lnkHWY%~7Y zmtOR$gJ)%rW-o93eOB&vnc2%tll~T*UeRHA%8}1;L&T%chi-OE&(J@tbzQAHMdYeNyd-=DzKFtS(q_9p2wq_jbyxb!l@RD5nQLdfX`P#+ba-b>&L~ z?d**~)6S~L_$;3q(za%?T(tK_&$h|8=gH_;u?OD~6)N1eCqrwyk9fV?8AImxE8Z=y zz5Q?1jeo^bs}$Bx=9!?))0A;I+9Qiq$*0(kYwMK;uEZLXeP_QP(ymQ!TI>3`ORj45 zcRz!w^?KKuSdCS}_CCrldMKF{KQnY+VYulnzMnVGUGNO~7IC=s!tEv_%YsBzovJj$ z{a2^nQLNOv@MYzcbdO-YbS>Y2`Wr8j&raOGfAhL9j@{Q|rtIcAJ>lhrj@gfkZr)t= z)~dmNXX%kR4MVM{Bh^LP8M5z6=dXJ!?Z~x0qU5p5KHpHc{!H^r@`qMkTs6Vwj-+eR ze)h6TgL0iaGlSJPOWjZAF*Wza|PyJWb z+rQhCtKz~rHO6iAd7JZmt0E0HevGd@SSWvph5N;{6JbAsVmGW&jkAwE8}ofu=C&4# z+UrrepUxIVy(x*1ug~2)-8sZF`=f}?@^vRJW`ubB%GS;6ubO;I<^6L*)|={4dHFqw zw{`Z+-R#@XCw!%R-_g6N&Ofhj?tA=c&w&|>Po1jQK03c-mEY}0cW$izvW&&Ve}3!X zMLX~Jq%QcCd}sOB#(cdO8&s!eJW9BKI-+p*{~eeAUsxHj?R}K|)uhP|-#;4u5T12p zwIJ7m7w6n6E?4BNi20k)Dv)Pxen|V$d8KEZ_xw_eUIeZe+tF!d`!>3Lz9@^-v8$*5 zo(L;p-ywfL_-JVT3d=)}A_eLgb~pTS9mGluPX$TA6bgPnXX(nRWZ&`Eu#V#184dpXP?uZ|xVlaQVs9Abj=|$6(FL^EY z1f4atDxSTc+j7~pl$`jG{6yKKQMxf}&EL#W2;UH%z?XYg%TAGQW2O})cvQzOznowHN&Q- zTo({!$>t`e0O!60Vnz6mhvv5Nnf2Z8Ln2DP?5;G$9cWvT% z#Gtlv^6d|Cty^7s=GwS%+x`oH+-kzdl#N^};y(`*sB_ z&!SGxciK{M-+z@nJ{b{GXBJcHCU$?qkRuNPCu!Gw&e~S6#H-7gnE3_?* zTEr6G+x}HB_(9y&w0Y*yd*icJMMLHqU+H%JyMmor&R}WN?zy=p;UV5;p5y1r~Mz4#%Lcm19g@p->Rzi6(#+!z+$w{GEimruV$ zwA}l4z4(5qb#4(aPe~4%Gv#O7H{V|#)zc6>IryUtTS!; ziqd_@&$NAi`?$SyGwbCe5sr*=_0;uOF@F25R&#CF{rB@)-W-|j@YB~U-AHohy!xcc zVUlGQf~OO5Rtfdwou97#=cm}xxeOyoJ6m?`?df-YHaxvB9TKi1m$;vg0Li{39BmbRM`hCnkJU6X$zO~7wtZo@VmZ6S+{r1sg#@;+c#&;Dgk}7XA2%)(_`Oz`dMGXw7;rK9{G`T z4-`K6*l}3F=ii}?>pq|6ux&fWobTr+A#m+a>Qe*j-%Uqi!oPOao61Ogo#EeNlYH`J zu@{g2&ktub1UM?27wq5@l7Hg-JNIPu{jcF#k2f6LHdU-9KImt*NZJ~uGfP>&$Lr6C zsEWQSAA9zlp3Lm?E!Pb?HIoXL_B zm%093`9kjK&-{C}FE4(x`=7P*bN83xYYlTVyce#QU_ZyoH{tN%DU#0n#r6dl&#E`& z&ir%sm)OazEt)eq7M(m%@$Sfxj-N5Je|&%J>AKA$;``%^C*11J z)s_|?U8eN;-YIVd^%BKxEdSX*?n#{ecT2>dZO!%fr}mY6{`N0+%fYa=H{aaZneNZq z-oDMDujQ?<%#Ge&mWtJTc1phbv3_5ewqr%+^aK2tx?kR!nQFg&gY@h3KTodHUlCz? z-?3<}So4wVADN82YEv_X7*|MlGH$ixSZ&zS^F}{>^5aKnC+4^Of;6y(+e@nf*9SMwQ^Yd&@P2csw z;(dvVM&EpI_qFTW_eaG|-hW)mn!Pk}u8&3;+a=Z=FHd9~cUfIgFB`?~f8W^g-uox> zjPnDv7hhKK*4PvNF8_p?F{jIhAB_d2cTJV{PkZ1z_Z@%I+ztO5>$5XsmADU|-@ZK{ zxkDi1`<6XfA!ccE&;3s=Sn~8l_+yzz(=}e~*wx;m)+c-a@q_M7zc*iUl6-e^=Ojmg zqiU=UhrZXgi0-!%TW6t`k$=tQe#E)A%LPt`=ji*EU7NY~=A^dYOS1Ma^J)Bb;B9-u ztJ^abFNR+Cm&^KY;?~vw+b1=ozWs1y&7+^~GVjhWu$$6uZ0`H){QerV_}%fnm3mJm z=d9bS#22c2AT=;}=Edz#-WR;l4-L2ecdjndqose|ui~EKL*7?*9G~g&lx6GVD|wIH zEcinezt8@rqFBG<{(*vfx7VKJ|KNX(DgHXwD@&F8&;1xJbRc#7%7bk(_fpuEHF6m^oPUE zmi)ct#m~N9G-cw{yGJ zFkg+^t|NY+!pc;va`UfQ{Sy2hpH|(~yl?UDQlJX&8TqxD%J(mZ{oCOt>?^xG-1^wp z#oiv`w#mOD=N*3|rnXD>jRh-z8P^XFy^qIMxhwpBe5-iB)bXR{>i&~2#mDP>nfE~; zKyBhZp2=1(_3N88A3kTg@ca4d!x=o!k9VHalPr>5E?IWxjNNaG=ku-^&-Z7xt5xF( z+bEf|QC(B!mBHq(OurQ$ncS>@`Y%BHr^4iE%}mnf{Z}1$-ZlQ7D6DPfv)1tUGK-#! zs?zQL6ZSB>+OwQYJzf)CckOebQ{}S8ny7<2V%m)zKHhe_Gj-eE`i)n&wBM0lety04 z%8=ysHNt;2LOA3~Ch7EZ1gpiTT`>=LpPDvDvsUEL-&>DZ{s~w}ocnh%LEUwgkEqz< z%)OgWfBLZTUu;jq=|w-MwfCRnUba5ocV>XI&!za5m#=HLNr=t3c;&+W+Z%P3>KaQH zy6tvqnyQi4c<|1J9NpWK-d);RAI=|B{34vY-q1}zW>IaM_7pXbi4y;KPs@ls{5|vH zVF_1NTS56{v#U zs)m!CF_YvcpA&od_}<=$iuctmr+#qXGU?8~_r}V55By?jKFfDe#;ELC!^Yb9)FaXL zeiNn4J|BHE^N!Vy=dZn0d$Yd=yjQp{IQ{#p=|w4aUk^T+@hz8WdVbaR*%GR=D-zQR zCap8;l{{h3-Z^K^s_wlpKeNgd=ommn2&$4>bsn! z-VAB~@42ox@mBQa&8byR{9z6IG|ThXo_}kw?xI4yZE=w4sUuHZ9172#6W(v~d*u=T zfb`{O_f|zO=6lx`cz5F^Mgh~QafLO7-Y$2(EPwU#IivN%+t)pk!|k=U-lz)pa_ZAG z5LdCbeiVBvzy6F@2LFkmD7Em0t?X0f`KLB(bIX`U1_X6n6qs7=_v`-8m-BP3JrQ|d z{rTWD@%5+l*4GQ&PLX(h-+0oFh+~KT^~6Q|v3xzz(Z%A|xkcJWA{W)7IFHU)m1O^yN>sk`i^>$ zN5-pdra0g4wUN8UouabsV#9^~tCkrsZI25Hn;vp^$Cjh>rffJLrqP+yc;?u&`C)HoG+pp3#y)kNnxN*&gb7ensL$(_+K4xj&dEw5* ztLJ1ypB(GoXs+&mfjRWV`Mqa|AMgcIYu9M6`hTNpSMa+c4~Zmc>U=w2lMAY zsc-paWoWx$R^F8QquCz~)4ruG6PSNqRPpQcFFQKp68iQ!$CRng7uQRVl-<2XB2GMD zPL9vJm#tfmPbpc{Q#k+D9xk7G@hZF>b1SENnu^@e@##{0AA6=_flQO%r_JUY3i`}X zUDi9dW8S6hFYX5JVNcKGsqrvdn~-9=hpn;SeE*yJx5Cm|m+bc4J11?_eqzaz-BkuZ zJTlk*OIojV=WoS);pX&<%B3o6(k~S(IoqrGV4BgoiB9t-^%)$GSdu8%o*H8wezAY? zk)_gKFYNzlQsb$b^3hb|P3MtcJav|dOQ-6r|9#KtqeHLXyw&1!c@Am?aojkvz43!u z*4axJ8v3do{44A4oEBNXL|Nlui|OCF*SBe=-k%ns^7+_8-p(oa_m7F0H?ON8#h4(7Tojt8X6Pq^bJE zc|*Bh&zaN}>(`#PJDQemwtVhZS5+p)q|lGcd5%uF$Dq6@|J~`|(<@Rgb{=-PRegA? z#F-iAHH)t0#P8p~`a{C=+qb7OH5{wgwCgE}xlqr2vg4?H;KuF7KgD)T{Q9}%p!vba zlD`5}ldk3+UiovLk4fRBE*S?so7`KE9{u!IvHW?_N0deT$p=S`)z|VYf>R!}y?xob z_(MUqSf}3;zTM(MuUxc$rO%1r_$}JJNNmD}4*fYxo||d$&(w?C;#K(JhQ?8o*>%3& zjrE~1Rj$|fU!1i{Ri*6jkJ#BPl@l9z@5HSyRZ}tDvgyg|6F$vS5BCL}T*;tinawu4 zb-s<%w#-Ch=BVT&ds=gH`wEg5$Z2Kz-hG_t7`cRlTeV^FzNafzsPDX%ax>#g4_l1Q zqgaOSEmn5X8a)4BpU!x&vMQ;feZOJ3!rnChlKP(d%Ey~CnS(BvcdY(5UE8Vp@vl<% zqhYpc*OxzfdZhOL%BL@?cTO*rm4Byc+fnjt-)_N~JQ5R=f^Yb~t=RccOkt}R+x{fZ zI`wA`)gc!{PcQ$Xk+iV!%%XstkZXHFe|#$5d}j(*efz(n<>hCtw3SQ>zCFiFed&a` zheUmX-^RRoqMchm|A22-`01z8!h-X5UFumPeQce;oF-rEin1AQlMOn3d(Nu4=CaN) zX05t%aPpg+l&_DcZ<1~^VRg9qWPRyM4f`)q8xG9=8nyY9V%q!P@~eP7C*n|>qQ~0$dg(1)$H}b`4SEe&Q_Nz zR@6;gmQ|H^t39GD|Bl(N#gZqJg?=a=i}JaWZ_+w(p5ClEnO)!FJYLGYY;9&qHQE2n zsIVz}i|>mk7J{7zTc143@@3K4H?^w2PFZ}>S*tD?;fE=0x5STmJeT;Z zAKQ9D-(}Wc!3RGN-$-MTk(k&ArR)fn}iYPt)uagIvYKC zkDf^WQJ1~&gP0ND_G#D8ocga~_2$2?6Mx?2&Dy^^`Jew@aBb4AxO3YQ-~M>ud-R#} znbk91ub$q)QoP0VyUiT&XIi(Tro~vSnjx`z?%}0L$9`zDZdN{OzQ$CwyWe@XOa9{P zb6-{$A2G5zf4;tOMO@_1&o<_dYtJ7_D?D{SpvE?4a_8$wA;M20zXnAlvQ*D+@(Hu7 zyT2t&Mfq}@&Q9?I8`fLjY(5-eU_V7cytB#TwU_l$g()YloDg>lxudfF+;-c;8y6o} zICf%zoiWG$y;r<_F4kgTAnCXP~z)_rel@b1%{eE%JPmHIP7xwDxID%YJ8yM6oVjd1U>yv-3@ zdc2=HKP+{dCziMTP?>GxoT^8%W-SZtwuWrB{uO1yp4lfE)4%I?h6R^%X2lB?la5o@ z9jv~*eYT+NzL03$Ri@XTZL_D#*1vU9b~Jx+LVIb=BBh*HF7XCm%r>pG*Ql_Jm;JNA z;mn@uKU4ni2w698j@!bImpnN$s>)X${rc!luW~Ezyl*ZAM_etPy#DjtQ-2nDGf%W8 z|6j};um9#-jx@Htn5i3k!Ztr@tLTBB^Zwp8T^{saQ1|iV-+S6rlv=m$blA?3zxV8w zdfDxhBJ`_|O}oJot*ax+Exj!{>g&g{-GUo?+dg-tHe6=yX~nH;Y!9yvJdhsC za!%#=g(NM@xK}~tyh&;&`#keM&E9eB(+=CrlD+<4LV4xa$=z<$6Ze(9AwSRPhtabA zx1R65eXi#Ab@fi|lb_bhJMX`$5wpbla5(e%%*&hVKb@X!@NVqfabS3f2 zg^Jx4lP&M|9B2^uyro&I(_Z9iG((>qbr7P>|SMy5Q5Fb%#D!e=}P(p=;@( zj}2?5%YQSG++B`3|PivVL3tN#I*R56Cqk(mNrLnOKwTB zTTp*C{m`#N8duG)>2SVWcR}o5M`*^2n;8Kc1P*>~i1_YW%lL1Zm7=g;@wXQ-J71~z zWH=;c8^u2=cM?^^#EzV1IXEjGDY@9X~Mme=%YV(_lSolE9CS}Gm) zy}o_sW-nM&ED|J3sP%>m+V_@t-wC#`}4MCdBQ5IWR}ieIdO7g z0{_0c>&`FtJyf3H^S3#E(ZWYwr_+8mLX6`#u}cbh$BWSSB5 z&#V1~TZ~!k+Dzwby0a2%{V#v^w!1dDp&*fWPV)P6^=q}yZq@X>(p<(eGhu$-o5!1Y zXVy6}b*WIDN!YZ>#n5)P|Fa60AP4k*pbqh}~iPOuqzIN3n@|o$K{+iu$nm@1WWYc~0^tZM9 z+)S~}!t+*c7N2sY-s8VOfRiwXjM&7?7hNCxr8{=ihTryd`|;}Or*E3G?21+`tBBWm zyTfK+ssl@4LS+B1tTwV1!`bFb}D<`=HW=^Viw5`j&-(E2P zhTgh$rx=$UnpOD1^se=i*$S&py_@j8c~b4AXSbzHb=(WFWv&$BD{1%0c^ z&Rgzvex4)i{UD6DC3N%V79lnb*7&52CIwr#xev3l)xTQYuEMy)?}g&reG50VhP=Kt z<1^R9O`;p41>co5P4arKx#Dc?KfU@I3&S7V;y!FVu5~+7?Tnbl>yy8YT)*^7g}4Sf zPgV*3dFBDjmV+J2d$PLi&V2dzM#NsGU-fvi{P!InW1?90sVyyRe_R~%>vv1zRL_Uy zC7Ua*eUJ5eS@^HAe{NyO)Ey6gJJ-q{nNqv>$7KF9a_hhMUCv6+n<}!zK;gZPt4hkA zrS-qnPj?C11>M?L_<-^CMB6>rUGq-arv0o;J??0g(~@5r`StM!rU&8MUli{?w)J!~ zgT-Z&uTgQCb+zx-t>HgErQ(%u!@R!@rJs@){y(?vkC@}peKYu$JH1R_{(I_$?(!^$ z%YTKB46=<{aSK$#Gfm z^k=EBt>+7Vq@3Eb*5yyC%KYz(G;20%>sl^9Sjl!V_(gT{>18TkbL!4!O|hIP6w~{3 z%Mbm6(43=-x3B3guYdmJoKl|HRhI0vpFg**;%p1?XxvrV``qd)$w+7Nb zw2~h96~x{AxmN5$NhyaC2OG!6x)8P87t8m3aB_7zm9*;xQ)E@z*7-5@ey-nVuyb6I znCtkaFk+Sd>jyWtO8ziErF!_5ji2_rA1VHkoJn_MrFEvRm%rbzC*tgyP5URj-r5`7 zUZa(9f6F!ozM^+Cgr~$^KH#;&Vsi4jEepP_?q9_-vHnPA@v*HQ+UKjD9xD6r(Ie_q z!J^m7{Fbrzw+D#2h`H$OmhUn8bnR$8qnOW*=x^N>6!2ydzhL6ZV*w&-Oq=V&?kg`;-Ikz1_-tC;R@A$4cie2!mV zo|n(gdRky%@R0G-#|-U@pSbqOO=|q_QgD%d{z@G^AA?-0SLqecGgwYnEo&*Wo9H#y zVeM@pmX?)^^}}YEeQ_`RCA#^2?oE|_H&;b#%e_yMsdq}@pZ|AW+V%*gnD5cIdsL^c z*U>pG{3d8Iuix^&E*=NG&gzDHGKbx~6Ju0;G{$Y-qHj(9*aU-?u|7*yPQQ7xl3=eb;~9_jsPiI^na9whNZ zB7QEM6;j4qbr_}UU+Fr{F_C?7V&5&XH>X0EAKRQcqwV%Vdlt=>mzw*ZIT}{CXe{yB zU*<4VllR@aGb?2ut~$|fa(k8A^Q{kWC}!uezUkLkV)XQhE7QX*Hrw2nnZ~Z^V6o-Q zcI{gqpK+(OnyYTou1Q~ZpHzFgElDcs%$9QtLe8;lyCeBq^I6HdV#}I({$C6>&hw5P zHjz}$>f59!6londqir7dyNR8>ea~kKzVP~xCat+w$0l7##j8K@m#vRh<+P`7*B73d z_WN^=r)u=EQuRuMIQP1yek^pXM6reNZ$ns{dlTSGwYG$1h#W0=YR`n11aLKWOJQ=fuIl-5ZiP z&K=JE+1DWvzrtqvi@ho9qQ`sblJH6Qn`S)`NEwa1AWdkKK5K8B~x*kb@}=) zt0Nf?o>@|sG-Zvz+cWh(2VG){6#aL_7rFSfJ=mO)FlF)H{QdFOeFr9bU(X4*oVP-{ zem;9skVxV58}3?jJ$HUyUH6Se`P#|MpTRC1?^Hf=hh=YhBR;Mkv*|6;vA&gE#1(D>BtKRrJ6(2M(d+vn`rntgux z;y3?`j%8%A{TC_Vh&Qjz4*hiPQ}mmPid&EFnZ3Mgdh`;<1Ivh;>c@K1PJL&N{=WR? z3z5vLGX1t;z3c0(xPD(Qw@}W%7^ZzklJnuszrNOX_JS+U%-r20w0PYIs}2UMmot{c zSNyJRw_g3l!tMln(Wh6I&x^hL1h;JytC@HE#pjxXmKWo_-kZ+ax3^T`fN`^}+^Y`D zD}o!INH9$Ne`xKrq~u@4n`a(c_TuiTpy%Ro-G>ERKfN~EvQYTaL&o}$udAai!YghH zD4X76H5dA;Z?{zNr2AI6KTdNiPVn`sN$8#5&*Gk3cq?v(^dNVf`KI52r&5&_?o~5OFBzQY z%voD^Ph!=J*Y5UCQ`DwD-cq}& z-XJKo=$ZIrE&=1i`xZX_%pg`a?Ud!Y7so2jCP>%`Xq@5JQJTs7MfhxDzoG4`2CeQl zyjBITYTK?Q=dL}r)%;v-&DAw8vR-R4>po`^ejS-GbAI&k!WBzT@7tv#&ULY~!9K)W zE%SuI-zOXwzs$L=wOzfp(0GY#a-Mqq_b;!Oe6g!vx2}No?n)lxX9+@1S*kiB|h$$_a+qUfeXU{*urD0-yi<25X^%-Vtec4p9()g9y z)T15me4aLmvb^57I3V;a*B_U444kWCOSrkR-ptlLbMHi{u*w53{S6rlmC~04?K-bn z|DZ8Do8buej(V}*^2e=u-|bR3Y+&?WSNY>&(H?WVNLAN6XJsz^za;LrDuh?-)qZ)i z+{!NJ$!C|D_eQNW0}jt@h^ZeEmXWwaIxcYgzRbCH>O7KfT+qW$N>vjxTgS zy$E%6xwO0afRC-BZ&;F2%*8qXT}sRzDE)o~K$aKqk z%ZHnJmt{n`<%8r&nGWv+vb?xZWH;o z++NU}Z}mm7rER+`7rSraV@;`_oPGDuO+5k&%R4> zllhv@HE6_Yg{9pT^(l^89FpmN%(r@ye&YIo8kK22%M8t0f|;z!POD!qm3!0bvc@wt zZ`FzS$rh)7vcFwca=q=E@^+82rca6`mT1Z{AeE2wB=%Qrtf6GT)%(Z zc;>1v3)j_KZ+~txZRg>U^DcRAZna@bY%aLE-ef#|7M zJh?Nn{!9%P)zVt7Y(BaBb#j|=$d@Y#iCeeZDu+CJ$#mw8w8H=TsrR;>ExGcFPuR}k z#dEVDuOo^93a59+*Xhctt#qraKihSQ{XgTB7>bJPVoo^&)F7)_E!N;N_YRAp35)NEtb$b!s9uhY1ZS8~y720M&wSmccN1eD< zoVs3Y&R4c{_T@7!zD9o)Ue)uN+hsO-BwJ4NDcjSK+_Ut6*PgGZXMDB(W%yN}<@65r zywfLc&3(ix^!d+&*6W|{>{?`MDs+9K_LCM(uX%ElOY(2&?yuk|HT3LLE>h+TZL^xT zC2R_7c;YQ5jX#qfhxwR3Tj})SgVyK5k8eZIyghyS;k@%tPXyK9T&gCv_lf`YRrQhF z3iT&tHQ$?T_Ssgv@9P(({wc~Y19T&z?wQYfVNfOYgw^M||1>jO^Oh~kLT}miUs2f8 zke->RG38xK)ztNuZf_L*xq2IC`C5jM)+xensvj0z-1b5`^480JpCXewznSq(wzz)w zb*S*J#1y^D&n_Pp?ve}sERuCb%BUxzJm;KV{o&yEebsXoT=&`=!>|9bY|RIb>hnTB zxtVso=(wHG&+BaXKz#OwM;V!EY~gpdYtFs%w(*2_oR8R4cD3b4=5IZlR%MrzcJP+s zvbXPae&$sfxtZuJy_>Lb`vM`YTg;a#*Z)1(e2{bTwq(;wZ|3kGwzofdEI}e6l#H)^T;=)&HQs)kyi?mu?@cenLsc)3byoYWNZMdfz z$vqRhH-|s&(-qGu&(wVGe*3-GWljd%ur&PS{PjhPX0XL}{?*Ak|7UMsBxTe4Y1*c1 z-1nJtZ@f*LRc3f^{;eaS9IKYL^@O#0UKY68{p#Da=MJT7ejcpfRe1N0$6}A7mzv^2 zhZe0lSref;D}GVz5%xG1D>)|heL8KD4=?U2smVLV$)u*$R-?zvSoLL%nc7s%SxTx? z1Mj^45F;BO^rW-**7=e>(GJ;fBKhx@rf_W4;yYc__f?juCiOUXhn<|MMQ>2(s-KpI zQ$Eelu+lyv@=7{}`384Fz5LAvAHmb_j0Mw5pK8RHZCa;tlDqEAty=jd#(Ifby$`w4 z|BC(1i#U*dS9Ka&u=S?zK70K)rW}5CS=z)n%Xqf#BG<}8YHKd?o7|KMdT+e+%EeLv z0hQmCI#*0Ky}Y%HVJ`S$mk+80< z`0js~e>s1qrcM096@2xZaA&d`Q_YH6M^zD{Se-iF<=u7-x zy`23?E*iBv_-*2&yDsiNDZ4Rz&7m2`r`3DSUvofzTGHM_%?lW8*Ea~3-%Q+YLRBNi?*KN!?W)7 zw#BzEve>_h&6+;{lE?ugUb@+4M%KC!!djl(MzrN2^f6%+0 z{oz8VKWiU(&kYj2%CB>7&95%b(nCqJkGF?aPutAgx8~xC-6d~lF*-8czwYxV$bMPm z;Tl7p!x8!wJMQe5{_0EA49WNM0bAE8eGD^P@R!p&r|#O^B`FU=Gx>hM-a6~3R`Cq} zrAxlX@qY`KT+H`N_-jy_ZN2XAS?>}g)+D`=+7kcftHWK{<$@B^_AHw4IZ&_i@HBbp zBS#+oy>-~iymemM$vs@tw3feHFWFU)^7`<{-G8Gk*Zp8`JsN&!R`Q(re;-%4NYwBe zJdB?rWcu-C`GdRT>jMo26b*#}^BsZQMCEi~GzsInUc1QlA>u zKhrI*TTuOhoNkq5q>kjJ6HBy@ybmqXTdcUrtMEa-#nW%ec^QS#3r^f|ei|K?*6>qt z`L)oq7Za|gOUX;E@_t^Fu-WkbLUHZgJ=@-f&QO^BanAqnh)22IH9viKecb-0#`RKJ z+JEhKrHZ?0n<8eg@2|?+^eUR;Ozzi9Klk|5m(5tn)t=`u>5riGw!_AP##{#q!lge% z>#f;Y{B7CX@<72AMj6e1jVM{wM)?<8^ya>P~u+-Lvu}H`9jfm(lNR zH~xLBseEtU-1&V4znc^%{q_oF+qZwmv$hun+jR`Z3YhCBuFUdwIli9%yu#1JAwAJ5 zXSM}5?A)^amq$!Tl0gXTH8x|%=6j~e=ifZIc6Y0;ZQ7STvGv^B=QKT?^7rG7mt~ty zCUv#4b8kD6HZ#Pq_*6vx@kcw@;v)GaykE%sY+!o-^S}ZL0j2}fmQ31m+2Wb9YU8F# zKfA?WORhZn^gs9dJgtWJuJ;(F=dKqDe_FQscJvhPlO-SIwPZJ*J@5Y4W!tJs+kGM4 zZL2RIV3T>W``{|=AbaEDXZ5=RJA5N%R#FNGCi|Nxr`FnQ`$sKjrCJPZ#u=F?OADUDVZb zCPVKUquX|Yitb(o(GybDGAF(sPq}Y>&!YAFn$n8DVI|9orhQ&t@Xx_)!}(|R@9OXL zT>7N#cDiV@tyAW@P;;jZ9XWGfs&^ST-M3z3`fH)&WYKGSY>OP<9(wyCTK3r5!|JZ* zCth|Csd~NOQ}~k|(?e>Kg+F=B{ySf0%FWmFx(uHmHE_v4v?0$>t#;)fzU@!G%sU@o zXQ9ivVROLt8@U#<&i;GVt$MOAs#PjDp!7t2(XX%55|`v{e%%;ds}oXV=j8RQct-xF z)WFd0$O!fBKa1ut7 z$I);4DvvpVUw3R*wqCNo?LF(2)~CyUZcO?5<3Q~EFNdZtO4zYkV6JL1!(M-*8_uF# zcR$W|%=%NGJ57gS?_QbI51|XrHcaRFwPZ@0nZ}zX7d>MZ@4Nn7P)c<%&l(QS>gg^0 zg45O%8#{~1~q^F2?EB}Rap6Bumuh$+o zl3QF+{8!;sO!$IXtW&MZj<0f1vaOyMGPU(dmZ2@*;-`TzG4*o!5sQ-^O}TRKyUgWl zt-BW#7hJ8HSp0x%fv^o{{_}%@ds#nt@})din!~l|ePj#k%jrxesWD1A)4TFdFf#YyT2q(^YPYPnIwGpfO4GW>Rjx+`9EWjLz~)Ts&`|J!Di+kuAOL@oCPBcjayy zO6`y<)Qi}(v;9}UoVtNf{jRRBHm-}m+~!`;l(b$fOtX4Y$)Y@`k6BOWg>}4nce3hL z_w(JpT+#-UbN_yfC~PBUZ(k}mZ}PwT`zx2# z?(Ey4BVI87(|M&3SA-c0t!z1zz@kYH{cH8Lo!!>+n-xja&oTmHu z$F<_$LEp9FKP_lf?)yGxSN7G4NuRAJ9QWP*R(fOD(j&};C9$4~F#*T9u5rDSpHTAa zrxZJ1&D_nK?{<~I{RIQ%&L@|p1UJ0%gzo-;k2urA7d|K|vJKetCTG=qmcstYCf|02i)?zGeW~BnM&`HaO_#li6Xh*G=*Lbw zR1-G4t&#iuhYb*t?9A13>7 zX*cEypM6!IQKNcu)tpOyvDP!qA3Y2d5elda3)$KC=T(XG&hp&*oPWyHjZfw&3N|#C zryrA6yQEsrxn@xdW6uPSO&z;$EllwKSf71CKwN7@aPowycN|sUowz0*^sw{*;_&9!2>`+py24reJ4@|~dOX~0=CN8nVu`Gt9g zT;gjuU&f`BHZ5$;zPir=SzpUz|Ojxj!MTN0Z;xb#y3^*>+dXU zuFGk^AaV1j5cgSw^YdSE9lLTkrN>?}ds+Q~Qx64>w)C9voBBXidFui;&(k+1Zhq_J z_IA_sm!Im}H~vz*d#(56rPGh{r=of z6J6{ACOr2@jSBB8k?vY$a_#uG6RVCtkehTYGNpH8^V}600*59Xx+~g9aO8{>0rPYeRUZJ(;Az=U)A6NhW7-=Zv;ZA(fq{C&qskT_tu_ zUDKgJ?w-Mo*^B2be7wrSHh$HKTMyJ;+>PT<=>06mUGS&CTj%|M4HmoalD7(9G5k6$@~^+nD6gBfQIW%F<%K|tqsBL@T`wsI zrb=-)$g6)^z2)3M4c70v(cpCR~ z-|3QjTY?R$1hR9g<&1-Ngysd58@Ckf`}#{TOr&>j>(&aey3e$tKOH=JxcRotO-uQmkx%Qhl&7>_75}6b{fJ$#NWZLZv651A+l{JA zc|pPFpB}t_=xfW)gPSi{dCqn$Uj6K2(^S5H(oaQ=B6DN5DQ`QgzG61lioy=1RpQD{?s2b$r{d23fz5)gnndxMtOD?YVdJ#FUoUc^L^J zegZt!L2q()cfP9SnCiamtjssI7YD8$I{9WpvE{}cyxn^h@7MoYQ=OYXH+!?|hm7SS z5(_uXuqdy&yy1Ar*SnXdb$>p3_f_}e%!H(D9f5u9+$)p(XBMjQGd(O9u*K_vUt<#V_6Wzdfj#m0EIY`iZA{OXBtStmkMlxXUND^2o%4XHRc2 zd@}vupZ`~;x=T3BwDHe2{#M_9KGd=xV6Us-VxX)yLglV!p+#OBTi31oy^8JYuc}w>|GPT>2r|bO7dlPbzkcyJMn>%|}1xNKFd~(|@bBv#B{`{*mDc($V{7eD6#CzQpJYHoD(`Sv8qwEp*b0m~;IpI7gjZeH#^;lkN^JG&+xt9f^t3L|HS&tV+wMX4^JcM;9N;$aeCmoYWL=XzHTFyDdYuRP4`nEA78&t$aaE+x(s8pJSG8u}S!o zu|nX9Lc70$WBJ13yP3u7W6#MYy6Q-$IyQD37Ax8HGSk8%cpamAR)^5bAemPTCtHt} zDQUFS$3JxBtnAmwNZQtLEW&&LJ(j+Mn->2IxE(On@$7GgS*3cHe!okt_)}lI>}1Qg zO_G;4=(N>*obzLYh@U*?-wS4$uhuopS3j^d=Y-tuf3`cbO&ONIT<>`Qv6`aEV^M{v zESqa@r^quuo;WuoH7&c(&g7%jooXxn{_u&jg^p{MrBv4k{7Knjm{XJ32Ons+@my*%sq@!5%&yNnxbw|y>i zR$F-SZ}iN2?YH%mg$}k}X>z%vrqLZ(Jg4RgYc6jjzZw5T3ntckYL?P-7p5@(DiRA? zvS7vsiNC3fSdtVb)K67BC@XJR`0B-drf-YuZ|0WhIj1ulSe<-)vcNp)`Ekv!+IN~S zIpv@C-&r%!vubLi*Ujz_-?z?82d;mAE8uu*H+#vIHR_vwvF){cvG~f{h}6LKI=>x% zX0`VIwVLul*qhf#=ii>JHfF{@IlZ$p%~$((Ri|W1&G9do8XS`9BFj{-{f=+rRL-{0 zDe(ywqDwd1GFJVQlwR~sx3gvS?h?Vz79Pegrp(GKaCp{xqtdTQVOGVKi!aWqDmqW} zY`wGGzKeg=7n|A#EnIt_^8Pb@wBI0Wp4`ch9hTaAql(Trm^BE0z4deHv03Jc0q+l} zDP1dIzJ2e_3wLK3CjA>_yEO9dO{w2}Ct-!igf}wl7QVTBQb+S?>ZBdz3d#DrSHy9x zTHfgW&i(hNxa4y?x*xMlaa;Cp{p{Hf!%vIk*j#Tnyduo<<;)|tkPx>kvW6i?>o-5p&YviAq742rY zs##JW(6LuSA+71R*^_etW#T37=e5sRvvE;Tei)TyZdKTm+FfP$BxTYKUi>h z-tSaN#@NjV{#B}dOgpJ)bhyycH=Qpam@iy7PctZMlh{d@Z)(#5mI!@oQ<%k49~Y_>$-;%>NO=BW9#SmO3Ftblzm=)*V`b~ zZGEXw;PjnNolDl9{uWaI+i#)O!~*5YBHMZ%d#}6VdpsU*jyyAgGyVuyanW;o#jcN1 z;!b9nCz9*^uG_3SelK>S<&izi_v~$+PMvhG$>e!i$I+eN!&;J+t{r+J!4e)hr#Rpw z>$i>DIqUj4u79gv*!#txrmd;}@^z7Lk^5B* z4$-MC}R9Y{&n59Ew`;aHD{1%{$p|mJCz&}s+hkjb>- z;Q8`@kNt7k?A*)leNI0=itgmR9ChVR?iPKoEjPW-G2ar^Q`qojN5cNwy+3y6ED_q) zwfX5(z0>{gR6kA#=(X-U7}C2*P498GOYyHWQ{UC!nmez^J=mb+-`gWCPHVqzEa((% z+PD3JykYLi*BqVkQv#K5bXV!R2DWl3PhEC6h9mbwaFhEj2}AjBHv}hV+kOn)lXtdt z;-8mnwv&y-7Ny>?`Vn}2*UoC)(uvRI_9SnQS&@DweMh^a=C%KvhUKg;7q3Y5deUQF z=TaOZwcG9Q_xkE%GMZWorhM0$BOaI}c)#XV-rKU;eu;UREZysKi)5QluAKI^L9XaK z$GNx8wGs`6Ifo8)^f`G=VBeJV^vByKL#_JT+{@P6>-#J+6_tMMHuJ7h*QAr1H(4FI zyzS1G*z+G!djC$E_`uTrXrI+HDa)U`f>tlNcJ{@^^bO1Px71CktUt$mG~NE_d-K?d zf6J5qh53oCeP#4_>Xg3 z{cj+~E1#HH&~mUmV{h8bcn!nU%ONhzj>;NQ&Y|kk8&#{`E2?JxH2iYw--?9{OcGOt zL;}{#sQWT$hwjDfGt)jfZ{Jd{+JD6ET(RIA9S>Dq??U-T;q^7iPtqBuDxd2tE_)mC zv9a;LWpS15fjxU0?!Dh1*S`4L9J#ix?7LT2?^wp7+wjh2f~@FmzIU=e=S1JWJ-s!4 z{<937?)Z}|1s!h;m$6&$cILfLl)K&U=yGeq)DI?Rj@qi3S1tD+I=d*{W79=7<@(3@aONS7JlK%{G~R;>#gKFlFB_FArt4C%ZzX-a2z9bNS>M zm#$t(I8&gvCBNmSzg6O{4u*Go4o2jBONqFAGv)q$ox`eAm+m>7yx{OOw)5t3u36iB z)0bCBXh|^YWoypbJ#n?;;kB_9$C!V8;NpsyR{zLiLZsfUQi~7uYYMvco_2orKPw}9 zQqEs9NpRM^k1`XNMEaeYQMNlXli#hAvD}E2dA`UZ#s93YHqcbbiVjzr^%e9d7lHfJp8P%V)C1PR?Ab{muduyPkN<2T`bO0 zXXOL0i1(i#g#SF^e`IQ>dR@&%pJnqN-LVq#Df;|o4aXK156<(_i(bu}5cu?nz$|9Z z0$c55Uc0^Oa*oFHKN)?#Cg=ZRR<~mki}AZ(ZyOgGEcnTgJ1zrUw z-@m$tb<3WGaWlm`zM1)^t@`Bs`e0#O%f4NTq2{LVZY8pwNjv+kZK~3;8+T(3xm(U2 z+vdy^wSTjT!z$H<5>tYN`%WFJe|2*i!(*q(FRPg&3;sRo5er(zIQfqKarIaIvw4DN z^t`sc-TF|nyXEQDAh{e9?}&Hxf42l@Gp?QPtC0Wgh^V+I`$hxS=69)onx|<$iZy%u ztMkh_-^-Q#YZ%fdht6mUd;I*GB4^OYcPp8S(v`BeFdUj?rSQ=s(MFlK@#48&+X++e z{rSJ;S#3vh(yMvzCT;675#il;JOB6gmi)#^HyVCeEbCPE4?p%K_NMfr<$rv-Co|MX zF6QyNr=VO|@%YI4to_|pDTiF1Z|Rx#{`G<8CyNSCwIykF-rD^3#pQqN9@S`vF|R2t zsWsrVyZdFC=&=B!H}fpLUq$aTzt8*fme%C*8dZbITxYg(J6J1!6wf+pZY;2ZH7wp| zpA~CNQIviArn#AObfUkiW?riObtL@Z*%R%2;q^y13bD0KaCw=@`Qo^t2Z!}x?ZrNV zk>?NlO_{4V>HT>Zqx!Bl%dSrsuSvUCW#AeovgL~Ak2zB(h@v zkKKdlsMie5G`CDdMKvRcUdYda7A zTzQJ?^_6X>Qr;nr9x3;wM5aegqz)>8XL7BbeX_i9>`B))XKN;r1M=CXg+ub`7l zLvBl(>6^rT$(kpfVZB^WTJ=SljO*s93(AGJuxP*8A}-p#g>}s{f%d$oS1s%cZJ*B; z{n8ku_m;(AOIB|D-??TJ<@xFj1-|@?FROdeRrmAr`c|v55ccI$JbL4QFG$!jN8tF6 z)ZHN)f8AQ2d8X^vYkPOwhf}BZ)aHHuE24V(nXFM5*XH0|6H3$Ui`!PkDir?IJE?Hd zPt0M*=7$ZfRWl~$P2IL+W9q>o$@IOt8`vzgs-zSo7Os1Gw48DAdX{D-J*gl21?nR& z$-iYko%qtb{_(8kO8P-A>r~aR3B0vGeYRx!^Ki$y-c^Y+^!cUtCrz;ObA2{tU#`7C z>oE(ft?ZEz9$z*0EEGEOv(lrggS|kd`A)&PnhSGJBy%R0i5yz?aPITARi9PAdH-%) z>gcDxg{;3?E!0BmsGtF}OI{%!( z9wpt%9w%GR*mw(u3+GZp6}n=CCBDpiY%@Revcft2w=OHr&d=RqT5j`-`S#m?ZCAqI zZM?_x^nSNeZMGhKGsr$3H$+aPkeJj7bl)u!!b&bzoe4lvH@&D5W2N|CW zGpSrryrJ!x<(P8qvil+Z@^h`iiw<3IPx6_#hM^{1=5IvYB|9_z>jm8*Td&tokM50M z`|^`C`_(`5e|p^5p>$fZu5bUmm!bl`(~fu_$@7)Emn|ll>AofT^Y^a*Z=d&;H5A{x z)TSXHJDETIl*_uO-FxntW?1ljtUb9;{Fu|7PX0ejuLj7Ml}IT)6tjSS{ z^6-fLGBdY(a_9Y@Qm5mpPlYYhbZiPwSgs>bkR~x}<-WcLlja+r`y{~mI#l(pMy0&P9G4te=ltMgp+X{8$}~pG^b2lQ>76p zzhIS+ z`)xs|Kfw-00sl0M_Z>Q|v^QzJ^D`Z7%S$gE9xFWvkLOzd?i>GBt|T19{j5!Xv8ugm)xMkD-~T@eiG0t~nl^i0$BkW% zvdsqnzkRso$9?1Dne(?MxqA4z*+1XhAt$c4B3S;Uw`P^C`M;$~*99-Pm+!BCQk;DA z9!KN>#!Uy#HE-~qT=f2a^gn5XHSLmb%yvG`>Wt`KTCx3D@z?t{F>UMepR`{8;b!_r zJFKXtf3o2;h9zDb44mBZH9w!buX%W8;IVh2y>quLI`#F>xu(Cj0^<(wuX3!FnLppu z?`Y0BxyHnP`!hWz@qVVCvZKXb{L&L+Y8Vg0Oo>ZW1ql}?A| zY9DZ_oP=Rc3+-wdrr>+9=5AzJSQ97p1+j)bmzNXhpo{_(&{ltVyw@;0k!g~fA&#hy6N=MUdm&t%Z2?<;U3K+~}){h?6p0xlM{ zk8>9MdcMQXSu8x<)#tr`PVDC=o9-%CwPvrF8EK;!J$d$%`uWQ@@0$2mS5xw>yz9L3 zHUT#E{e>=T1&^iv<4Bl0OI)p4Sm5QQV@oH>9)1@&we4oh+e?4jIXkyJw31Fat@zO3 z!^Z91)wdJoD`{WYt*UnIzS6b#D&}GpyjJP!()e`lZ8}k$F8X82dyN}*c}M)O&2&-i z5%PZ?B7aXcb&5`Uyr4sUNw=Kd#a&mvE?ZFY%b{|o=x*~FN0h(5bz8`OU*pHWON$%% z9KM{c%W%ljN$2EH_0T=g%Xwz2|B;gyi&F%P0&i{Jfw|(W0A|8hYqEr6Yuagr! z-Rircr}eV8t)Irbs9SSOs*Je(-^X3rP%*uRYyIP{Z4+Jpb%lSK$@?zh`>kz_(yAGo z!Z7J}#?E3w)w>Jlqg^qE~bF z_We=(l^r1(-(K8$;a?iLbIsS!m6M~V?a`}Wt`fTHo>AqbO(8sHCT|^ifBo3Gb>h05 zYgu1Uvu4GgQH(v3^G4abdKOQaZfDrbTLS*E^3N~+=+G(O4^SMjJGH0B-w|=Ra zg#7W^t3T@{O1HSH3OU}k+_F6DVeGXaoxg7vciZk2NwEEA@@#_k_Dkyw&p5L`@~c(x z-fML7M2pU8*WheP{l%plXa8QBGEG1#HZsYIbJ3^9BRi%s`b|*~O!>d``GFEqy{e)q zA2t|V>(r68yuxc}$t>o0({Y{P*DF$c*U7%;_4>8>+!_0$3btPFYmQFa&zI(-$#Tpn z%jTn$@aFDQQw39b&KKHcUDzpb_~N4-g)xPPVmba^P&WUWz3q+E8QnLF5(K}^eX|{W z-wKnZ$@C9T*+m5{O^gt?tyox^nocjwWEWvIG%z$Wn;y8IU88<0YlujcxS5Y;eP#hxR&49tzYOJmQzIyLT5i$;MbD7GxXNhm|#0izG5% zXxZWLAWy*i!1+mxs}k5xyuW0zaVEnpvw-RQIdo@;9+Ks0XL!d@y@K_~#i!?vUcD&9 z#C|80JwsEA`N|xHzIsXR|EUM~e%zH|=n($mzvKQrduB)3ddp^AodiC=1b6=xi%k!3 zW$`nvIH_5zWFzo~VZ-95{>~fra@W5(C;x`6?N;;I_dIp6vOE(eUtwr?uk|N(emASk ztCoU?C5^ZKubKEdea3FH(^gSlhh=0G`Z&bj%>O>Q@sOfedF}TnzieZy-Dm7x{QbVV z_KL+zubwy3iJiM+o~6^=Sj8@*{kiWH-qagrb1)rX7kMQ1;5oa)97X|tZs~RNIk(u( ztykFZal!w`IyU)y^%=qkUajNl;J?CE^u6`%Tc)yR27!X`j{fiSkJS6$P!KpEl-0;E z!+FiZz8nAD_BShr)z5wZjK95#fv2(j6EkCjz5V|`M*D(isGhla?{oa;c;#n7*QQ*) za5?RF>?ivrQ$)@%KRA2vEcb&4VvpFF9QM@gVPIse&uche&%CmE;eP#3?VA@Z7Ufa+ za=rGw)YtEG@78rUJpJCbf$5*Lw`iGqEJwrB_@&Z}KO4l#>mB}|uloP=(|`5P^8^2_ z_xgWd`sB`AxBowi{Acvz|Az$j6?>oOcU!;QrS$Ha18doKp1%LttGIt=mxn4$3kYxj zpDHT&V0Y<+k}ccn|1X~yAa1#W{Ya2(*M<#0y$$Ohp09g1%l3-kBEI6re>JfTG71VG z>UZpB-MnFUwPVb?l%L&Acix__4?blTbwH>amV>RWEm@As!nOzck z^wIkSgPxze#G`Yp1>y7f4{)&^|7UsGdSgMO?Ao&r6S%EU+;z@qHK=co`fu{HoAvL> ze^Srpo7kH-yjEx5dHSRIG4&tPzeTw}uGjs*f9K)5(m%%=|MN3F{KBtS^1MLZtHV?# zC!e#la1(p=zr&nG|4%C_$o)@ayvtg=tNNNuJ=^48k5}2;`LFsfwV__%|H{}8`;W-? z9LRqb?)-0Z>+|{<_H+KF{G06lqP~8H{q6JY51N{F>+_D)H#hG1ulUbe|6lz_`(2+l zPrLs?UY6~z&J**R?N>VNmvQW>&fg&rQ0?7eeMRV#e$Di2Z`a)~H!5lT7xdHrnSIli zg4X+2n|^%FxHI!_?Z2=25B$^xxZj*CoYCqrA-6Q(bL3K$sn*9&J(#@SM|;=GH8S@m z*MAVZ&Rx@^a;>Z9K;@6ll%Ra;gJ&k`oZfgu4j<3DXv$+pVeu)=bSYS{dEYy0b*8=P|;@@h|gxpgyCAl|n9$CXQ|)6ozQ6gtmaJiwvgGkpDI6f_G0Fex{|!;{NesRORr6yKdJt+-l_SgWtaAE zEZQ|y+}!3OpTmuvX$GGsu6($P*}js-=^*EloIZgmKS#D}yt&l@lB8$iKT8 z9ddl>C9P>*5?5B#EB5z%*}7NquGdGID#o)fHq|ioe%kjrzu+cQC6D#z=F2RLDy)o8 zw#e^Xwa;)`)Uhfq#Um%B_Z05VNmu+O*QWGA#8WWdulM!5xs0n#yc%NU~Hpc$xOh`#TNnqnvj;Z@y!@Y+n6K#Yv}Ac+RU# zIT7t}Y)9`&wHoFAi6Q$Q?BDz-yY%A}^9=8TM|W=P2KqhKcz)*no8Q)LCHF6Ft>&El zE;DcG{oU@)`5um?(dP5FiAYDYx~*263K6`56yWq z-6x{#n~R709cFRY()Cxrq;YKMI#EC8&)3TgjxR2!yvyIUU)O7o%T|xd(`!7e_Drt0 z=r!f>PrU`JCYPQ&6KXg;z$jDVu++A*EroAp>=8PBqQv#!sx@(e=X}M!-P?1aWcDG8 zqk-+UUmi`F@yoS)?L&=~PG2*6{Wf?tt=*aMuVL2x7X3#z9I{kqRg)!f%_L-U+MJWw%7S~O-ufV z-wU!=s#)$_Ws}3sQhABfpl^A(_|dqEPTPpwo%$uKtmZsCX8856Zh7NZuW0M=XNJC$ z7j5z{+iP6<^!uXB;{N=k|f8c>hhYoG9AhF*K8&WMY@Vj zp2;G5`1j|AiPOGE-wJbWliwD#^4H!p^F8tB9~|IZa(w6M=&$^``@GAamEJ%7UT3MU zv*q@vooe>wugi5V-`jd^+NOCX8?$(VluusPJ<6%}>o8t;8)P%Ax#K49lzwkKV|iPwcMGW&76hyHjtTnAG+9veR1fx^Z6T*!xH`{ifsJ z;@b5iA%z)T`mN?SG!7i<5-yT_$K zZN{o;zZrcKnxE|M5~|gXSM5Hn);cv~zK+0V&x5t+61>ms+V1e#w2d%tjp}{e}bOzg>Tam0dECP-$bl`Shf*+?2r0XZ&rPZk7BM zsoQh3@mJFB2jXr56XT}uYMU`OKew&7VK+WC+FONlEp#!O4?Fe?8-;$12+(HR|Kjbf$ff$n?3&NGt^OJz z){)Z4W7c)-s9HsY+y)J^#q)0pb$oKrZ(jT7^o6w4nuc*ZB62 ze5S|_u3Ett`{V-WU+dTDy3tjCRz&B~^t&DsMmO35UWTuoo)nPzhEv03#+z&G(jO$4 z7hk%wO>zU%ePiF%dve_;`#g~65B&O#`(0v|k5S*U2|L%A2}gA8#&yfj zS17M#jh+9(qcxJZGerTC(`)yRd`ymw(RPEdA!gho3^iCzss#aN@gcSg!rc zYg?ZLTDRS)kh7Yk8nN|A^4awJHHWxYh@?MlP5i)>PMeY00Q+>&}+@bZ>> zT8@8u4lUGFe42UeU3PKg@t2n-9gXxnv+Y>^yqGwxk8O9Y7u}pX^-aa3a8r#t>lc}E zy^~73eDSqujFv(A{H28q{&smC3p^wqhOXH{1Rrw@aQ({FyRMG-gVbWS`KF30yf#CBJX_ecAP^NEyqo`q^v36dBC;lw;5Q zZd3j-Veh+X_L0Sl^(K6}x3#1GX=+&S4yP?zKds-lzMC5wBE9O3-q9(NZq*rY@9j!I z>;1{|O#AkNN0k?&SW>H4Lii=`e5`uT&1qG>?M10?5z~@tE8PqA3N~SdmK753-ySl* zv|@#5a>*>su2W`ZAv+HTKlG|^H5cZ5{Owmo(MhhTy4_0xUd{W#E-0_rI{As`m+5`$ znx*PbTvw=mtI%5gT1p|ak!QO7)#R6kB7$t0{$D3vi{*&kwr~BSc9Rt;taZ0nzF1ul z>~{H><^mP3EK{YJZ~cqEJaM`;!}89RLb>*rRgw`k-=BV77+=5C_u7qs#Zm38n)R~- zWQ^MuKmMYXmwn;khmK^)?2Z3RgECC68tu%=Ry-gA6wNPY6=?niCRz)Z@v_%-dZ>UGdM&`qmoe7~Pnq_FPz|_WS7* zkM}%JUwd|2MCP^59gIph1I)zySF=8fm1dT#SBY6td%B_RiQ5Ca!{@Su*JbA|Q?1_9 z{VQam=<2WQTrw28_RN}ey-;Y||4*-uv+1mrnf&+2NyEn<#HGv`s$zR*uCI6eaPILV;p``@-lB@P z`r~EgZSsQFvt6lM(C2tEqQhYRb55cJYb#+e^}P53=!)6VtH9=g6A z)_1#aD+j18EPXG-V5uZ={LT&$o=0D87KZqm)}?^a5#VZ5T> zGNUCquxb5GhN1BXQ@1u_|XU^Gpqr!f5eO-Ym z%gSXX8aETCKi(AMx3p7YX<~ptg~GkO?%4|;3s+1!)4MmTe{EQH{yC-P`W6cQ6^8L! z4@aN8*~xzK&~cYlW_m(vSNSOzPXF-l&TMth_A@I*+pcG;in0E#STyJM*Eajs?6S3{ z8y8QG@LedQv~z}d*R@)c6CMgVyLUImYB$tR{y%a5JG-s_J{?yS_BEHPc-!`4Z&cCM z&4qIXk3RI&4~T7S_guE?$*~7F-tNhN`6_Z+klJ0_aF?cQxqD_F>}IX>HI90#l07fC z)$HEUGx=u@3#j_qY<@J8VYkn=a@FD~-Nh^|+s=ziv!o?(`*N*%_2Qh%!@?H-we1%w z-T#!CiPabFJukWFT0n>)zd_pkcfP&_c``EhoNc2d7ENxKoL3>VJM?I=R$7+n=A)(D zf)j4>*{u%UmcqTdI`iqQ8+YdaKY88pvF}vT-1hE2ji(m;6nMRCnceqC>Klvv^G<(I z&v+lt6J%z)dwxm7H?~ciO$)y+X7n_0d9?9G^2c3ILw`NKQEzcB_k2!r>1>Ijs~;Cm zN)-5*p8mgYZ|DxYjbHOhmwNfEP5WNH&ZB10S+h6F!F%s@9(=ltKe`}1?PR5TIEP{M ze`e!a9>eDX4e$7Ef2P%)-n-#4KN|~Y#ai|h)gJhe)X%VKjTW@V*D^7`@`sqQZi`Ki_oPNL3<(%zn-aDJ*&bO&HnxX%APt?*7 zgZUpcPKRbZ7Ro(fSsUOMQXv-*F6g;qMb5oLCok6&ycSQ{SX11edFt?vC-u=gIHD>e zZ>xvgsr@uf^n+jRs%7aOX7{!nobn-}q`kK0OuO*phT`M-aV$T+{EhjrIz5n8Bbjyg zo;7pLvfc}Y7=-B9^9q=(QTuVX=W$+RMSu3rFM5aX?`+W4Y~b0QF-bLgY3beL0zXzC z{l)TIB1H4*Z^88sZ#K<5ym{)c?0p6P^$R^_pYZ$W%RT$#nv`GN3Rc`XLbY4Au1MIb z(KPKPcel-=$CC2Tf6M=Pm%3a<`f9w&W|OMEi<6JWiO;B+f5#~`P;bp~#*ZI;ZtZHV zlD+BD6VRW_k-NuRr$54Xp^${SnZ>kg_Kxmxo$Eg4|5$TvTY%0PzyEpa^+Yr=Diy?>ooMvH9Kg%^WhTvT_B_EpFi~ZC8`5e9t!Z?R~S`20J-rjg?Or zq|LwRHSx*yXW1ocwpE3S<*%<;&a$^XrME(Q=ccJa^_%KduYYjWvsU=})Sa)_Ci3nx zMai34>l5v!>$v&lmPiUTsu^UME!yJs#~2%m&w)til3f86K&kn zliGbJ#$aA~hxYA*t3D@PIrZ5sf5F|Niw_0mJehTx9>y&=S{!s*Tvoj4okYZ(nf%|* z{*^S+nmNV5cR|fT*?OnkOXvN2Gv}?-T|D9QzCx!PWo{)$yw#U|Yf)o!;Y+C3sy5K_ zXOHBMf0)E@VG*mrKZS#{rY~Thyy`;hjQy|8IsRZUbDtep{cGbv(QlhfjCZ>( zI}zd5V_09?QMw zx~=er{OUD9lMeYDo;y!{U5=e$fcN{fo5|Yy%x(uAIF$F~@MquC63ci+H*7ih#xYY? z-|*VZdbX>5y==MZ1o-q5cR}me;_J6Lx+{5J zC}$q&OPa#1{JeC3{17F%oj+GNtnsh!4+x0#JkwTLnLZc3QA)GH?N zN6R!$sejsAw%;&*oKUuTmc^70{w*sNohsdKe|>xO$m*B%{BD79<}P-HpQWGtIJieq z**zim-;sHno(J_-iJsnj-diOsBy+jLd6w!E;{Sgyj;L)dUYD13OX%0^j@f$QJN0iL z^?rMz{rl>_JTKX-A`3+p@Ao)bw7|p8sQ=@%qMs*r7Urk7v&A1m&b z|JiHh(mY!|BIWf~Cc9l7lcvr-l)>1(c=E~T=TnrP#j%R?{BWv`_3A5oed#dk!DHTO z``)*_m3x=oW>$I3bhDyUFVo2bs}ha}s_9JBdHLKac{P{YsY`j;U9Szx6zg~ETiDv= zxF6`zlzX(=D$Tp!+9o|LEiO2%v@gXi$}u-`w)G~3GqWlWEWc<{$=^9=(Yb58Zv;=v z?hZ`4QEoO{z)hrRrAr&r#3f9+d+e5ERES1N&y;NoV4Q#J`(uTdk#~yTbZw6exFz^d zf7R#xS>J?B7VrLhi2I^L(y3RK_5af9Z{{SeSh+jceNM1<^6!NG^Yo@jtjsXo7<5j_ z_li}@=a)CW8_9D0hMES033U-E*D$TqG^5qISN0d7rx2%;cpzSl_Q{4pKSC~zY zjW|`mNb>4ZHG77fge;C_9m_ZR%0|eFtUK(X{-b!#p>THhlZlu0;~w0#YtmV}{aX+JFPpOcvUp2hRoqzl+t*^uYo z9>0#hy>7j$C~s@$tDX88p|(7i{R+Od-LsPWDY&YBHdFmYgI7sBJD)E1<~q0a)BcTL zs(#u9S3YM@+@F1JdEL~P=g!T%DResHZcChyOsTPoy3Nl*@zVL9Zx@}OwvgeDVugy1dfU-!FXqTf+AV)6ZLMVP{`k_??>=iZQr|TE-#7Q* zs;0A3->&;tB$W5)azXvpbbguD_j^^^*Ti1#bvb+OT=_%u_U@Tm1tdf+PjqNMF<<__ zfyT#)UsVv=jk)>8W}7mHh5a`L zJ4;ou{+27Xybq4P(w)`4&$mIwJfKCTHS$&Tvi`&q(cmWy zE-~BJ3P0z+yVZ>|-T%>-lgk&YD}A4E(DF`Uf5hqT`)_BQx3SF2~M-}~sB>G>|;^Ood4&w?*a{HgbE+B;F($Nps&3VRrYT#M2k3T^+r z{^!2eg2qA{+>M>`q<^`5*^vF(mnU9Vy1pQ0yAH!0%}*TP-l}Px=>Jx;BdPV7Z2Q~C z9vXM!mS3OpDt=Bz)LcC;lTw}umkYJm`fvDhWa+;fO}X=}cj(UA|1@{6=eM}qo4-yt zD}Lbqjt%!RzNItA3h1m&UUlqP!ITZgH;>GAcbVVb7~G@$%59O$&nKMUnZHCGGq_@1 zCTz?}3z5J#@Qm)6-wsZEa>4L?T;-|lcZ);Kg zv~ovVf4JKwk>X_0zqY{nRKs$S|uu^tN=|x$e`S^7$%Ml&+s> z_u3niqVMc1wSBg-`*ct5R|adCZ4Pdp9#%hlw$bw6WpBSKFXde`@$t3APYZkh33n-V zuCXl7vfN)Dvt>(`bac~!P5og}l1ferOoy}@^`A}oxXw_~d7kbh-MKevw`5Jbe)!Tc z`DNKJLJz*q5BAx$(XBpP+1_zYrY6Vz&EJo^Mhbra_+8|Vvb)dS+0%rxx{S8gExK~T z_T2Ha3%iZHL%&Q?dUR^TUY##N;aYdpYvcEp=yAT_^bW`azdEjl$rcCbrYg zK9TtPysd6%!uI&XV3xjyyH&1307y8iEzlPYgKJam*Xb^7#{reF@O zyS(3HGBy}&C`^B9_x|05Me2cqrxr~RzG!0`cu44Sb?1bxJ!Z*_+jT5u-nz_O$laNe zbt7~38@;Pddx*e$G@>gU^xueJxh{I}xlqN!(D*3P^3 zV%}RZj^NvNEb|t<$eAx0p{H?a;nhm#iQVGdGr4nq@!b#Us9E&nzH89*p9X!GHO$2A z6VDcIUOkadQ*y!8`>QwAPn`N!uw$=?;*0bD;mJ8)7VV|#jo-r1<#p@*fWTUBjacD3qbK&7N{^}}l%D}776c1(F|_{FsT$Ltk% z4!seYRlH6i;HB>72Xl_!)()}ty#LkF{F}})si1^v&)m9Wg+*^`uXJYI*=C~Bv4rnI z@psd|h6fks@kUPK7GvFd$MaSkbLl~D;qDyK&8Pl+-)HoV_n*y%t;?kr$!_Z_@L6~8 z@e)h-TQ9f#cC1r=bWE<+ap~*K$ge*mf7|vX?YE~ZKg2)AR2X9rK|1s;@l})qTt%~R7?QD-+m1|wzsJ`*9={hx0 zvx0jW4>j`taxeRIEvoaJic_tX(95SrUpvD>4&|O&@j6dZBKyko()rV0hCDY}Yy72C zckAyTTC?k0L!xsZs9NXDoK|4LFn#Z@NN-{3V+rq`D&NvIpThRzF<+9&#s-De>kDJJ zGw=89+h2R)rpm;pda4^^I=>f+hU=VKzGUye%|9&n&e_d0jmxoZ^^GWlrdZQ68+P;y zsry!4^;H*ViJuNe6lZ6K1zOB`ktJr z{w!9RTdN-~Dsnls<$K$%u{8kz0ru&8MVASnR-;ug-7WnJS;dQ__EM6&S@8^|k#E^k41T5vZwf zVouP<7hm7@M$NpVnfmjeuA0_6j;s{LGio2}?-{Jf)b@(Lzvffp+p~tbtA0Q9RfsBI ztFv!m)~kolPxA4$ySA*1a65KtpW~N_#^0a+KIIs7^u4LDmF2Cjh_8}IG%Yv}zdo5# z9dGH~$*WM?%eQ__28Z=jvzo?pOykM(?WI`q&rTv3r@Zd|U3U`R`{ai%eYb%5IBSmjQouZKu+$-SP5u7uE?Ld2wxH zbI{_@OY`Gyn17h?+xq0Qx2MC4%6=z(ocC?E^3TG{nu1Q9Mhhn$X<1qNVA47^r$3f& zHQuzlHuf4H+j6BrWnM*MX8jv4SNSfMH$VB0@$dNUuKGoPf7K7}>u=&(lCOG-zTxtZ zSUpMj;!|^$kOMCL5l725bb0f6FxwXP9eiz7;qJKmV{UTdjZfNpcr^nPE}px@a_7@l zp1-WA{eP3|TMxOJeX7j&xt5hB_vgD(-jQmTmEH<(&;2+mqYoeMl-~onjkXzv2Ap@_qbo zd-8I-YQFqA;*UEvm5KlP@$0Cw z<)Q9FJIu}WK6JcGT|NJMP~YSun_cvtUHCY)!<%o?VSyFSe3ca$2clUmXS+6SJbmXx z)Pvj2cO|*%CGLfV`HRcgBAt`;AMj> zmX_v*(*wC#HS2eVt_Mb%~6MnGKt^ zE!??5z`=tA<->7DuOp^$%Izs3nxMu<%X(C+>Vxmd9yPy@9BJkn5GU!wmek z3m6g=93o<(BAlW;I24prRKAJ}zSH9kV61d{!*GkKp}jyt!tua5p7O7S?G_eFftCM$ zaXi@cl#RpN)APgMGIot!4R;l{DM&a-x0JB#USM>qX#s=t4qcX>FF*Y`*8T4DSh9M{ zf(6s3PiHv6s>o1YKH>2*=K2c934ILA225|>ac*P&lO?%;xrp)q%~=eL)(1`qHvKr9 zz_H!Es`1W21`&qV8%>EEQ@YvD@V()4NM)DE%3v&sJ-EUCL{z=N4~BX^b_E@UKjk~@ z_tvvE9jLQz&dGhKw@zUOKg%pWT*n3(=vUHo9Z!3x9Ghu%zisHc}8A>{aBwVh~( z^$ju8a`}Vy`qw4dzBm2+Te_+Jz?(PqTN9r@)XLy#-ci|L8uIVS0)?h}19k%;1vM2_ zJv}uZhTV(@?rrO9+Ak#Wb4OFXbp7EK^>R#qVjiwzs1A{Sz|dhU@wNE?KjSAB<_YiQ z9x&{$m;P6+Bp}9i!!c(fgY*Vw7Pk-nB_cfA{y*;7RbSp=e!z)C)jqM|!us|5?IRb8 zq_MX<*8W@ge_xWL=~Z_xwo`lRxBb~3=*jtx_rqiHiA*27JGmKKT3e4Y3JE1OH2gny zk-6US-C7|D?Uy`-1c&4t(vupxb(+B`5HH z%m4XL|J{E2-~Z|UMStR3|LqrDS?REF|J#^)fq(X86S!GkeO6~)8pE%W#l7X>ir9v~ z`d3B%9DkM7{8m9u?|=4Hho*qr3pk1$G-t&}ggAJ7sppqz3TUoqe)~niBl@^~$Y=Jv zKiT&e2uMWm_ci>fN(_i|a{8a_tUGh9@hefs1xtS3W^sFaq5ku#Lpcx2_D}P5@sVLD zDrf&Gu;86ksSxuI&c)j<@xA#QeTKo2Q9`D(h;cy`55tYacRA}~*BGqwa}+pp@R)4M zYaX|~ZQoABx7gR`CjH;`w{T&-WTV5Bvv+0ReYH2>a$S(d;b^h=-PMor8;>wHnJIj) zXB67cXf6F>zk#4g+bOnx^Q{`{5B)#eI;&Hm>*s63AJW2tY#dg9s=5xoOEBlZV81ai z`@{5uM-P9Sf5;`kals1C|NPOP_`lePh+Jl6`t0!MuoI(PfXWfk(t62y@$OmbGGD81 zEofo?7tYV%7#{Mo!1_w_&(&tT_v^0Mxx>j;;D4`9*Qxif_#9V$de3lZMb0~g-S=02 z`o1O5S5ZNOwfW!GxAk8VUq5`;cj`y=#K1>CU;p`?%GSL1;5HWS%>~gj4VGU|d>g*C zizn{S?Zp<^ujdAGK4YGk)z;FMWM>dcN)aiZ)xYrfv(1@;(=GRG`ec?~pdecjwc=*Da@^mZroKzx6}|6yToRBCO*(ft zjYX<`(v8-l$}A@B*o~)+`$EsC3$4DtoSXf&PbCY z|9iW8r_6q-dHCF(B=Yn``0R7bj>ILmml@6}jHzdCdG8VacT)OUbf*w?A#G-C_QS<=nTK6SK4|4z5vty`bKHW2Ez&N6b4p z`&U_P@+;=MSO0Z}wVi&Q)ddB6e(&{bgJYjfY`XG?C3_F&ge?a;YR-9Nv+Fvu-;c41 zG0d3N({ku%vE}2{N3}kF*H3YdN(okNZkea&J7>Y_7xKp@U(FSI^}X)!Hopyp_JSe@ zH(xvRzUIk~B_Zvf6@yF|FO^Iv*t|N$PP9hJaQCeBUk+P*Fm%0HAAGvz_l@_3@#W{F z`#+x*d95t(xHxFnGA48R{Wa%re9SO-m*@8VNMbyD`m4V0&BtDIuMy^&oml!(@!E!@ zjMU&gH>96VbzG&9-0e6a>~|&iyz2MWzn6W^cR3_B-Dpwt!FAVm_gWoacVGL?ln{n; z56kC=mp074ddpEJs4l`~qFQ6U){%JC_X5poQqC@EiA))N-+Wo311itDzBwXj`=6gsekTq^Gt)$>c302@mx_lZcrdn zcXY|L^v_F|RM|9`GkLA4NoCd0jC=L;5clranfA>5Pq)f1KYP*6B557}j+RsRw?2*R zP5B#>E1MDU_2jBUPj8CdWcSFNk=FWd_eu*f-ugo`u3uii|NVtJQ-%K@B`kBbCg1$} z&->VfcBbolxm3>o4(iHudMs{P_iuLm{#Wb`4Y#vW1I}DIXY853MvLvvBF&Ub%)v)D z-FwA5vuc{_$PCWVPi`5oF7bf~>+dMlhy-4n);@g6K&a&Cb{C5Md?6|b~ z*oqbBzeJr_q_OdG#rFf(XP*8hB=PF6ZKLL|*bfUIZrC`_ZSUUs&mw+mG}+C0@p(n1 zZ}q{64;H5T|JmW{`1*V0GBMqpY;At{ME-j)jx_-H0v)I7q;b3Slf8@ z;*OB$e|!Ep)Y;ygnr`NEXmU!QTbZZ7gy4piezVpDESap5R?FnmYjkVf^ey$Dc^uv^ zju#TVwd%C&HHR2g6~n)oU2|1r?0x30cwu$&z<1T7H)sBx7k{M1bZ6J&Pe1>zb=rUC z4DZq_6aU_9c>V5Rt4&LX?eb4E&)2_ld;54{_~rE?YjS3)On#m4MJR91!jkzHOqKIp z=9Z>r_SJ=GosnXmbZXkd8ttlrtIt=P%%5Xum-1$ipb@q=Zsg|u%70zkY zCp5%AdGf%z_0LO_d(X=^E2zBK{&d>{!|)rsm!55V*>7AYdc^9fV#e{lHy!z+)#{ZD zTdwUaovZX}!rHf5laH?5xbT8rK;^WnKiB=?krzC6v3@1*CWcva9(t(F`w?t@Y4i6& z&Ax;8epjtzac(eOc2BT--)q%6f2PB!t9SoMt?u_J{JVI|-E{|b&sVBxrYp&RvUqij z-P3NJ(HE`v&&(K4`jxmJvJ}3g&XyP!s(sUJ->Xxf*1S>t_h4$0{F)@jG zZ|pYzvuiKeTiX@vuYcVUyw`kxbk6a}tK07$J#hb)%a)mTWzVyVytVZU#X6rN_EuHn)WT$Fh}!RzJjSM&b=@c6ddYPEcN>x&b{ z#<>oh;o`aRS$8)lTg4xI`fC~Mea*G|+!Oz;4b*z!)4b@}Uh(#=rWUW>{wuM{r@Yh8ZQgICjpMF&R zraCtx?p(Lv7N2nbmYu2}PCZgwvr)MAxMGe|&u9B4X|3NrPZVRz-?{vp_tt}t??<`l z>6?E`J{g|s;(eEGQYiUr%09p6VZZJIyv_TRJ< zcO8D|UVqo!Xt69YCdNgmZAO1XWQNVNyDKk---)-ot81cV;iSEDgK+(|Gx{a#*3`(q z-69kb*>Rjf_|wvr0rf|BoO>g7Ri>Un%lzv7x5pBM3=S!M()6ib88A<( z&Dr?n`nlFc&Tk_x*(_ci)$>haas9@S+8|Gv1uE*2ac=gj%ocLgyz6v5s?xqM%6H!1 z1mm-DJ*tz{{O-59r@t4K6yNzValZaB&e!QZw}ManHWHq;<=8b3IXRj6?;=+_oXXSn z@>?SKy?A=GOI75)fOS&tF~8FnFTH#Cr&^j&S%Q70%-;9Q#AOO9ji2iOHdf>Q`rW5~ z{fu?{z^Xeplc-{E^HT#2?c1Y~}v|FI_&3a=O&*Pb< zy)QqPpJZbF#&Y$Pgv7nAeH^086nTrT-FHdm*l_PFld$Eb%cT=vuLiqi`Ui}+z7;e*tTx6<2RuB*Bjv-Hf}wQrn{ZaQWCS~hR}aep_Dnb&uPtGh}UE}p5>C8TD@ zz5mkY<$oLEOOKgnTTIZe+jq0C_Iqn};7Zp=Uj5G}_q)99Exn(dd2Tn;Uj3^#>z*06 zh`#UVW)a!aS1-8FKT~gUq}=-u>9al?*RDP7#WQi~+IJh%7doatlYF^C;DF$rkB46N z8%?M=ymZ5c4>qT#-`KX)d7*#1^I=un{HIIjNS={KU zoFqRdGfimY``Ff)IKhhd=--I}6R)S})}QN=3KP6zaw~jE zqi*3oc=Sv zJMScZ*211Ie&%oE*h-6oddp{v33Psce1(_YQh$HJr-1vrX0l2yJnT2|yJT9@9Dml2 zPfokWyx8&C?bzG%(b;`L*Uh=s*Sssty=Idb|D}F)f`WEx=JoVbf+CL`)>Lkvcl*6Y z=%=u=JM8VlVy(A1_~}`_$hy~iwf6$PCjCo35!3f)-(02((`KLHig29ow#mM@ zoUM1RyY+*EckOH}CV+6E9EhQp!Cn*mL5Fa_PC# zys4+Rn6JANakc)AxP^U@oN@X@@uKTz3%16ki<=8&W$#zaSi`SeCjI3}#wy8uA#u0a zUM(=qv~{{tE%~zYhiZ`Wt@}OK<6b_seg5?PT0MP(x_NQSzg_*|)xXuZ_{~k@d#Ao> ze)ikI(z+)=HT)H;+>yRUMeo&)#|}z{uX@fmeJ5MJ6VI2EtJlv@t)F)$;B8INoCDPg zcR##3y6Y#ioAkpc$9lK1JJ;#PEp%qP_H1%wiAoKN{*5cA?3UODL|T|GoL+8w^y^HY z{H0f-Q^P0ca=(<73h6qqGh&BE!1X!Ti`Uezx}0#aX{q6#3VS0D$@fP(Zk3mwlB;L` z|F0y<>x{3#FX6x|`Kh4~Z??~=f4lv)c8)(2&xb+}=K^tN-P27c%u8J6yybRGFX(R< zI&jBf)8Dq>^I!k2`|NO5HF&?w+n1pW{>0Se?EJR!s(EIxm84gZ|Ff2YO*}c9c_rT% zs6JEqvm(g2tAcTFDX-+u8nMNTJQ^4hjhlW6d_Hs|>vd?xq&G_l}&4UnY0%P4Dja=zsWOeQ*Aou4C1+b}fqAXsSPR`ab`dfab+-ckVs* z)TLR6_ihZcKz+TWeoL+8scll5r7j$=$oG<7XFcCT{-u+Wz-Oa%zgX@cSTs3JiFsY| z{g?OD_sGvtwEp|{&{dJoDtC<-&n!`YIPF&B&TX4xE`5IR!|G@EhxFMZ{YI`cO_XJo zHk@KF>#jOo?x87?RMfL7h{1Ty0`9PHj=ulZf6Zc)=f0meuWE%&{b|oWB~FXS9J}65 zpCYtlu5Rw_jSIhrY!SiWd;YxDF>apjlh38hkxFU``H zaCEo$(W<8@sO0Yhn4|9r%*_n|OZq_2%YJPo7t|-FxeQ)ohXRL|Lo6#3%=yomZ*mFBNFxzlmu(;><4G-LRu5%LHUAD;W#49<& zO-l;z39Em(*`r#!dcoOeDfd@y>y)~>VZx2`hV^mjy}5$HnwGz}G<-^9xOpVB{<5Wj zrYjm`7aaL{J~DEZbEsy@8p_d?IgMCFDEum+3-jS+XJ_lTr=H$6ZEwl8;@6HBxL#^((~jL}x_7O?`hCZR16Mg+)S0#V zz=}@6u-9)-=JVy*FKK!8CX{_=N=#&GJyUIGGF|$bbqa7MNzuM z`YWcIhu5dB^>Lo#X6gGmOfvYwYP0LDLfeZfZ+u|Bt^N1C&*W3}QO{e`J9V$zlZ^Wz zZ|yB{_-a(x=8cve^Eb8Su2ehSYxg;SQe~5?mBW*tbN_Z#ZajA4(TOs#i3+NLjG=1u&z;j;gdZxv5I&-k=;qHK22QE%ycbLH-)hkd>v^}c`3 zqqya>AEm9IdU98Y$;^_%msLvjZ#M6g5!timjkk}HdzJ1t=J|3*I9Au*PTr&z%2E~f zkU#fDTD9NRJGnxR-&K@8?7e4}6}eYVFe+lW{xn@4c_r{9-#na?@9D>z(!Q z7pEu(@})lf&{tpFv^GHQ<3kJ4{`>0~vR58X&b}|Swp`?~aJJh6)#b;ZC)R6;?NohG zzOXG~*1m7kuNkio%GjB1^z-km(#O%+rRnQkPw zoBi^7PrtR<#9!-Qp7+nYJa9N(2 z{>sqrg+I;e52`5zKiPE4q<|~W>)(U+ZO&@)-Ak6g=oNQSi+*yC)BW6D-!#>?m&|KF zD}{Xj_Bv&eM*q6^-_4n}>8AT_)13ND#ytD<=g*HtKDPhf#4c1GbSBeST5sLGd2c>z zb{%Xpy>?|$Fl+IX{Cn={>x82l1(n6{-%FlfC?!v?VSNFwk zowDXQpSR+*OI=MG=Icf8@^>t3+{EWOS*DShNw~IPZ`rfgd|6ri$?|*>TyOV<>^i-p zV8`VHU*fb^>J|E);7KxTsjp_*Fy(wfcsa{Hvxui>5~YtY^lU#BXyLQ1fMfS}hI%ev zRk3f|r*9Fm+p;C>|FoTF&N_4*Yu0>Guq^I9mlxxMr>81sw5dl;OYXZc&&tn@!BYOB zr<+-_~1RzPxE&_~O^P4rgBa{B1sPw<4tSd$O$OvFUsF_e_wkubtGX zc%|jmUV~L(yUOoONq!dYEFCLaUU$P=^IL?Sj^^$Yyjd&cHU!-bIlsqcrlj-p{&R_| z53g^DIiull$j(kNJoDC?#JSmbqt3lGy}Ge~$G@E`oMx}`WB6#dxMtO9Y|q{r+{>3>`^+Ncd+o(Xr}VP_)!DKBDLpQ{`chQoy!5v*=M6sI z=hfIaNw{ABu{;Y0+oY3PHd=*UNe}KtpV3x$aXX{##lcDD@lIjKeg+-cGrfRK*I+@= zM59+_+MoCK*0%+g#C)&zx*UA-&f>@6M|@3mZD+oA*ZDogV(XRQkS8wNpKCt-V>GYR zp?MO=mn)OR71NX@rcJd7YMJ)zeaqBlqlKGJNHlNbS`+xVr9RNoWT~%7lnKx0jLip4 z%+}Nhw<+Xk?lM+gz4_Li9Y2d6_%?)leJr1+_U_cg&uyW5vSzU*p01X>w)4;Tvagd3 z((c^f$Gqaj?ui9z9l?9$eNwggBunB&-|=dfAM*12$euaB>3GkTh|Z5fL6^#R)Mr`b zy}fz<-umccdA&J4Wy+uH1@e@XU-eJd?p$xLt)^!B|JuQ-Y~A&jrp`U0Q-0~L+RZoL zlS@TrFHcNgwn9x{?sbkQ%oX?d9_zgSD>>Rw*EToA^?$^oJ-j(*PYU-^& z>Hc}Q_ts7IzdchtReshwt@;^T&g<@5r*v>aXG*H~%gF6{)^oW&-nQ6uD4@Uosaf^i z?QaXUH(i_m{<&}Us*IGWoc8e?iyxVMi*9F2EB<;VdH-GB6*_0*7M*9>XA&de?^*P2 z&w-AAJzse)fB(v_*k^b~FYW&!UlW%qhW6sF>rWn(o=A_nZWO=s$&uvQTpmT+C | zbzLmvV({hlM3MR(yXrPxHO+f@t*HN0(X{%#ov&8En8^CLX1Dk~f(O2dX2?yj zp6}Q7)YNy6`f~L{O0u)o&p!11NpIi(8pQ+cx0sqdo@juSn)XiVhGJQr#ZHRH${)wL>=J6-z{bLI|r6eO>tMFF5gyp7v zt-;>156AYtUz<0(R(7?BUjF6luYPaLmz=j{r%U~l?JB7S%tdcnCLEhPS&HO8?S$ktwLZG>4`yyuJe;=%s zzkk+0w1BmL0_Vfe{yRUreQca7KlAX0>6*paWgTmjZ*ck@PuG3qE5^NBwyFNekL>e7 zUr$P%-^cUx=d+(vF8nB{U*!Dy+mpU)dIvpDHs86qrs-zOl^&Nz&O4WU&wu{wXY8H5 zFXqoyIH-8H$yxl%^I)3(<@U1Os{-#^YEMDKc;x6&>^{U;T9!b|f2J3{LzcJ~{`k)+{ z2Zs*)to}Oh@So_p2Ty9Y8qVqbbmY3CycDw7v$Q1B{ z{ZJv7@v$q0k~w0ZmD-hiJ*TfQ6aADVY59zS^L*errey!6_4(D=A0@7A&0BeTbN-jd zEBwvf_q*J_wryv1-Ustg!z+SIedKDS)6&k^wY;K`csFN)Wno7}(rHK1p!&gKsSyG4I4;O{K&D7wCD8+Y2qm+F=7e9TtU9`Vdw z$JMUU=gj>eIN$h!$fsBJHEQoKy!&)AW_@&JM_xz5SI-FRslLCqR=)k;k#eh~Y)i58 zgy7|q{d4ky)&}kW@-1&e|DCTtByL?gz1DqEZRc)Fhwc7)hdp;rx@9?GL$~3FP(9v9 zY#JNRzPa$|>H(@>!)8d zXIADlwNf;3Rt?cF5}MssV{!4>5{*ksXVs-SZ@1^IJ7Ih~VrP6w|E~v+H8MNJBBy_w zyCLvt52LEt^p#21)T6gtl1~0txWrSw@z{>4(;uy;P5Co*`j35~i^Cu8$U15xSTyN# z?)SM*KDKOObJ`f2dOyzY?&238HBQAnKQPn1K1^)yoy$K0y~E~8zv@knVOt}_5ctw^ z%H-J}w^Xseip>#H-zd6dt#qC9^S>h1n;%>`t2nQS&8Oy4`Imzcz8gL{*Y=dVw=>C_ z%{0(lctuV1d|sFG`^V27-V)r)5&P+dLB&OzKt09N&EJ}LtxtBbYb^}l=3Q_9BmL@t;+y(E(+_4JnVYTuD!=^a z>}h&)8NWmXUvs{^@ZPV5sy8NB&EGzK@$O4vI;?#+ve%zA-G8ZFdu838X@U1X-BCMl zaJ5LUq(h_nN}G&9|2PHcDJ4CAfH3LHD_& z9gp9H96Dc7>Hgkz4u4qP^X+Fgw-$=8I@eu1*Jh`(lXcTcr73r(xIUZx`OTisGfe7( zPEFHa+qCKSi@vCk-|HQd-u{w*Eiz58F7mJ*&x@UQ{gH(;>Z}-luA0oXQL^V^`tCe& zUELQeW`6xpnyMci%l!QGhx)wgR{{4{uXq|&cFz6&oGRrXZ&ePf#Z8$Q_$Rum=F&!I zW0#8V-0t5ilL}@o(70_BZC%G+<-Kb0dYg~`KGz4lvedqI()fa+=+|8ahJ}_hz3)kH z4WDZl|1{g)pH)~UG&+dkyL|03vvu=6-uP0I`E>i0P31`oCYSDbZ)SUH*0#);Yq@%* zYK}_V-!BY$+O==0^2)4@SFPQ*1V<)wS;ZBs|C%3^8L>R-!uM_APeanQwO_(8#cv~{og{>d|%0G8YmPZa?_pPGtN$$7^Lv+PtUT1XV&RD zxjY*$aha{V%AULXkC4#{nYeqMTq)tczLAl7%XLgvoZZjyE9GvOruT%|IT0xrd4m@! z#BBLE=YQVgaHYZ#uHW_QS(U+}^;(bA_dN@BI($&frt131Y$v_9{~59r z%kE4Et;}PxG@bt8DZ8kUxuF4Kv7Mozp_wIkwH>RWk&&q-wiAj(CZC5iOTg?)3^R7_w0!xmh@Im$hqy>A&m9n+iU zuzP#YvSZsALMN;gy>RsNey4!Xk-K(Sd@wNDwR^X*#BEFChB-Pc87~;#h3VB#V-Q_n zeBmT-2HTIjMh*vW@ck&y=HU=wF!k1cUauMA_)PEJF+Ya`vkzQ5C6e*}&$CBa`D`Uj zds5j~c%5bxk!|?)-)P$J>5Q@u-XCT(FgExv{4W3f{l+zK{uh~qxZ{|BEN2gzyUB7?h?2S{`Zag{rVEj^PW|fwyjK}h2|J|Lx zdFAA(&E3Y$o2R~gFDF^wUTK|HSZy3QVXo|jdq*W7me(eQ`8izPUi>}fPxTJ7Zwlqr z@9UL|wX2Ok-_M<~)5>7g?P$wgOiPdc+g2&8_{Tksv4nAhv7uq%#!UoB6@-`+-w>*8W@fh~Gc6 zx>%s$cl^DsheA-vS08ydFtquPx^U(yx07zKA*GpO{14W z`s(}U+zs<)cD}4H$v>T%^|`FtVt?Q#ebEoO<^QY~@7Sw(;?4I-8#fd)^vs>pV=Fl0 z-i#xM&hdRntGn%Hyx@4e3Y&q^jpmqpF%0>4e=?nM^yAp?e(E4^g2;c}U)+WDMNAS; z|2xL4VQ{-zFYtZ#xgYi&+y^o~$$t?$`bGZBZhp7T_6o)gf`UBft%KkUzo1|~~&%95S=`ZumdpY;l-Lt=nA=>0#iJ=0*`(^uH%h!L<-TFKJ!~V9^SFfIYDNFvl)jxmoAM<~& zt5}$98*SumnL8Co%Wl%u3uw=rpeZujOpJkaMIA1&MMe>!! zUzxn0Ykcx8diL=|Ld=WK2N{OzYyzI=)t^gx;`dK!qUVo>2i0PSqu#9Dd{pSS!TYUo zOOHLe^SAHMTs}F$C%VUOm@M6XB5)PYyG7-Zo?q1dKT=nds%P79c4M8;{EK>*isfQ0 zGkIdvqL-)Uoir@E-{*GBVQs$0hnv4wx$$k`eHF}#A}ZaIBzXp5cKDeC@bSO4OM1Q-pv}DTPG)3JlrNX*_VIc zwB3hUc;eQ#yOsaA+tu<*tNHQQgW9(%|IP5Tn*L_;^xf8po0sQ)O6fG&&FQAyxi$09 zPQEfx7B4rISfTX1i-!tYb8OH5tyY{Fx>;)BOTJFy4~0KJ9NsN=xa*I)@t6AVV)9aQ z{y(GpS^Sh2J}W6Y)ceT^wNY!L{{`^`*-!m#{wPw;;;Ms z0-hc9Q2w?__U!$?E`9f!JzbA(F4O$qBmoSN>bb zonLOXTI9>l-{M&@p@#o+kM_Njc({E@YW?3`-|Jo`TWz+r@}8$G=e+eI@58UnjkBgC z?c&^gJRx$5#M$3(KkrGo(;~ajYajoqQt#?DIMDWNnYvM3eQm<&Q|r zxx>HXIPdvW+s|F9x=}mtxaEa)o`UlW)xMIk?p5*|VGL zVoJ|XxVzPQ|I)O&TjvvhE_!WbYHTxUSCGWrDY_Xym6bnj_Wbru`>l~6OC>|oO^1zv zDwYnKBAONXzJ-_fFwgIk2u)_0UDR_RJbv~hi*@_E^OOC` z1n2Y2%8b<)aGIybaUiws``QhTha6lDrrN2iK3}%|h@d*lHHFz(#+1U5!?#ziv^WGoti(vLCTKe_yX60%dd-D%R`raze)_*d6{ahE- zxASAB+f1DqJtwfl@`?S&$k@pmLczh6(~qAu?^(1XeBUa$6-=8~>^M>v+wUj*#$=O^ zUy1w=q5Ga8>>X#OH>M@u5}C^nr%qm*rB`N!u$N4Dn6O^y z@1%NBkM}R;3LU@l>2T1q!Yyl=76drEyvQk1IL)Vd@sGOJ(UY5E)>}{8x?S#cuO91# z<-9!|2WPDaUX{Kw;f;}8r$Fk;fYkD|i7Q!(E^a=$eTvA7iYNVhltUv`BSQjOEWQ+N zXL-5)8E?Usq!mnI{ds>?3nXN8FYkA}pDFz0p3O}*$@=gqJNtFDudJ}{nJyI?{{P0w zDbLrn-!wilY2ysTLiM|z&QiZ0-4VA~WHy;6O!pdZrjW^*#V|0xYd-q!!mbXDB^TYX~% zf1YHV-;CKAxl@ELWQQ}Ys#AV;!$YZ}-kmLM;+EZ?u4XILe~4aa!OR=JuwYyF#r7?n z7fyciG>Y*xEppf(KJ6mo%JZx1w;JZ2-EniFRg#T}4sUa}$-)3*gyHTJI=P6pf&Q_qTL*uKcSTW_`h8PVOs!cV@NwKp!kzFbxB##xcG zB~JD3hCBbA)8BY6`?(u$gr{@byOS(--HInB8SURA5xu#8$%=iiCbZYYu$_*WG+*OU zm*%amUg-;t(%l`b`c01?-}$m`YVi$+|7FV^of|th)}|P5IwmDkG;JZ9R+ZS+@2SEW zSARY=33-0^Vax5s>ppi!?@=mG^xKqn+qAK_+BM-cNBx&`A75J}2VC5C->~brU)G$g z75>{S%}*vxP1t_TwE6Xfj`p2PI)4~9?^b&soWa(yPFikzgv+^OZrg53PrEI1?$D!| ze0RRxSU%|!x8ngGxvoDG409jK{5;?95}Wt_dKAk!i>v2-`u`r^zx6;^Q{Yyogx1^j zVGeUo%}D4wXQOlRPQAp6npWNDe@i#Eh0I&`fa`PP@9SJz(&|-HmaAxeEqVX?nOae# zLQ#IXO61n-C-}HLHeNTlx%^bf^QjlSm%LDjSP`o3FeByf>%-F~6e?a&E}ehC#o%8+ zLk^QQ>!0feYs$)BJazrX^zL}_Rw3?*YS9{Jo=W6>74Hb%>{gtT<>{^73lN`I{b_lb6|UJ=nA2$?W(Qih`>j zW}SC`VyHc}hstAO;?hbzQ0Pjr}A9kc;44qt}9P& zr);~o{no=L7B!0hPlfTbtk2G3k(qY-?d6@mPgd{Ll5f0KaV`JH`r6J}M`yd8UQr(E z?smL>ro^OOS;;faGX&1gD_GQYzg~V~o8xpo^IZzW%)BR`EOAF_E;{?gLMhg$EK(zZNAp*lFh`X z-9IyALOOS~^j_UkdEVnsZ9i_;m2vFa_HwsK_XLltdi4v|g{SEi$mm=VH`tWvIr*DL zSsP2H?|%s{@k`~)Bn~|+d;K&@L_bA{NB$~*{?m&oRvYr3Z0T}*d8O8)qerQ>jHy}h zyI$VXvjGgUdIB>ezq(xI`Nb}AZ=cyu*A;@kf%#wGmdM{z;xAD-=Nitn%kI%$uC{+u zT1t9n^&StMwzakXr20w~V+*z{xt4izPoK(hYI~vCVbZ0+$pYqsmf!%dx%W2P_hfU;| zFh{tk!F+#ZxwojLsKcXu_osg|oAId8jEnX0#zz;Ap4rKu?ky5?@O1r_rOKPXXm-S2 z%D+>;^806Xg$FIFT^Z-rOcG$WDGI-Tnw)0hYe@PUda;m~) zS%EI!*;NAT@{Aw6s_d88x$gg^qxF3X3YmI;9SiRqyCp36UFOuy)#mS0soXDZm>vNwiTN}K& zey5-B+^rooV%zErr)P4$xwUoE}K%-~E18Nb#xq@|8s&Irr?jzjf{`6Y=x2ZfVRs z@ROINNmtR}>Gkh*yY(f%E8UnnZ><`yV;J{8nWaIFcHZGWG9hKhW|XTig_Ud*_RyTi zclhe%8HPV}_}{Oqn_hct+O{p1+^6qN4Ha6KyXB@Ecg&^h{{$ZYaJF06vCZ`O`nd~k zXRn=`f7m$SuR}?_mxhk-Zi60$aG(9PC6~{cs^>I4J{kV;$6Sl%S)QBue$~v5SKFnS zy~NG&^3mNkGt`*OrY3K)P@1!-ZRNAct8+y}o)iVl@QGTJ#-A!)HoJcr-&f}oC#Ou2 z`Lp4I;}4eQGaqd~)I3qZ{p<>Z$1StVw`O16F~4F?p=QF}j?9x!ejck&=(ud#FJ8W8 zr|6Qe3of(YNY;6NJ@Dn%NlNnHo^<#=+fe-?OIPIW${icp=eKLE%JwMyc=Y+96&0Ov z&NB-c9_~)Osr)bG{XXf}JPbMfoTt-P*A>}Kc4JMU3hX@)#JA>1 z)%%7At95y`S4)4nAn*9S^qZf>-yqk_9+t3^$GYD81@qR}uhfvMe0@dZP^y!mQedV+ z{pB*9cgts)ua%oD^~l2T=!6re>gGAg1vM*}1Q*RZygUB+`l4{(lTp53PiRZ?C!IXT zW$>HnSfhkr{0*_m&sy)<&Zu4M@!Hd_WOeHCtQL#R^J(l!-#cfnuE{Wc8osIN$J3ad ztEL`s{W8naJT+Zhbi&S4+HtYk<(HPv*L@nicGi{p=y3UaTov`!S6FX{R+ZX&T?yG$ zA94MzVMA16bw|-{hYu4ra!c&e-pv{K)Zt)dhs_QqvDhyq6E`)nALz_j9l2ns^T9O- zuKa$q;^}J1<^C=#u1~`JoMt4apN)Jnt>nz!xXh^%bp@Vj=h7Dn#yNbvr?Y$i9aG-8 zHK)B-=zI=Z6k0E*>mM8&a?^aVs^ykYi{r6f#s{~^@#!CLDtKRF`bNL?h;quUBgwjE zZ#Mlt#(%P6%ggmOe-~f8`scVG;~~?jCVQAd9FO-sFj%&@^k^v??;(#jna^?#xBKh< zJS5S4*(KPI)mrwc%#@(ulZ)_6@Y|c0>aOsKO8YA9{y)d3Pc`G-DbG3EChdILeQ(+d(_QRV zT^1>|=a$|2xj>BT%fmfiPk-It+_`2Vn({_3l$7 zPRU+*n3Y=fz-FJi@PodDRgW)Us&8iX)w5b+?VBUIlVcB;+Z@H+%+*;pepwypKL1L2 z&I8qrYtMcQ7B2Ig8jz(Do3{JQWy9Y4`Z`^2f`sqtmAD?vzy5d6jh$NW9?s5fesuLs zYg5X6lkc@m70#JO{uKE-i{G1E_J0l&TUK~{x@BSG)mvRhwx}&wP#ZWb$R{jv^}SP%J#W;;&S+>B`VV8E)$NK6!KO*uFiUs_y(>9+@!?SQrcLZOwg_j0zY4TmWO(@O z>t6<|?SF99OKhw;E0!K&X2GUozSBEje9e^wt4zP`IHczGYUy3M&{vaz$` z9*CyfMgC&yvApx9)~t=^J8NoNiA>6i-&F@v_Pf4G>(((Y`6`jVY&Z^=5<0 z`<|k?*Lj3hPh4A&wf&59u%k0~rF5BWfP98*cK-&Q?S>V{Z1j09@t1#&*%Y4eu5#ti z5}PJHaozP=wbu`&MaVnN;ocl7U}Rf<@`Qy`A2f6gxAI}cwQ} z`M6}3h}e^7?`LtF`^`Bj{pna$%@p~!9XUTeUuu^pyq^{Ps6YJ7wppteT5tQ>xbT3% zl_yJj?mSITwfW5H-2MK;p$9qrFTWJ8{T`<(A3yE(&AYdr`_3_3-zxvGroZEH!u6HT z!L6_B6YeDY8Aw;0ZA`hT=BTGDsr>TEyyL;5+&`t#8EVgl?77!E)3Wi<*I2a^{x7!w zQ}J?D>RdZ(i;LBw!_1KryXO0aFf%{!pDESP{H*tJ!R=->v0b+lzlA!#x~U%Y?nSMo zJ=?*vybp9Pe^0sisBW6r+Ro2ua#`HMeLnZEy!`lNf?&PTFSWx_<%TN_eV?>3ccv_9 zj>&Oe5_0!OMon> z%nl9PUyJU>&Ee#(|Kc6fcQ)y+US!MPRnF6;COzmeS;D+(QFTPYjykt8n_u(JaeH!D zZmpciG5z3cwx7LKY4?=w)c>`4d-VC_&ux3=9$Irab?Nqb|9a%MdNtW_AD!Y{5F5Tm zX;vA}cV)iKe-UTA zE!)a^p~iKMYAxTHrv5z(pQrUllzgw=x!v-C&hpCNlb)P1TA97xSuWIOw!r)FoU3zu zZYmfUE^2$uEh@N!tFU*G$91Xodi5P&{m*h}9e0?|8{ey^xu@pU#8sk#@2z-lJj_*z zy%G$)yLQW$*_mz=u(hfVHCn&YvnJ;< z^W7DyiSPU0jo+>xKihV}Xf5Mxqf_(dupK?QbxYB&5Vq*vMa!l{9lg8m z^DzdF3&-0}ES7lg8go;Czg{_f-t(z>O-#MK&!4YgzP4rI!{yjStV_IKANrK3A{)yIFyoUQs8j)(X+?kSfI1z%shv|eeZ>l&LCCwB8bdY5<3@$>(CZ`G<#^BF&0 zz3qnQ1Q}O@WeK%=>;Ebq-4(nvGJ5({_Ous1ZYc>iw(~!fU0>6D>p)IAfB6Dexm5!5 zIPWYz%)MRe&h5!ON_XymUM#pZ@HBf;$Q`3z>0R;7j2sUeyk_}NeV459rscx2@3NaJ zWi7HNtyPxc-dY!I#+|XU?do*zsnSMYvkLm=B_>aNw558PZFE4+K?dpiT_0{P+F9*( zPv&5GWv1f1Nvk%5UExo>C%y6Pu?$O%ryI|osdPHD#=!mXI}V@um3NPS3~au@DG~5# z!^w{Qamh)22DhHSwY?N|x;!rXl=F2i4p$%Z?%m$E9egHO|8_XJZS~}gr!SN4bjRp# z*&9&wt8iam;HDE{r8BtKZrktkKD(y=`Po-SiuOK@QIY;>ZVd<-wcK6TO z#}T~yV~?B4apn{!1ib$;byDG-l+C_1YBfi;dPf%I_yt?)&ue~Bqkoe_c7^+{;2XtH z>kSx#B%L?t%U_tscjsG%?{Y6jwaj?KJumo22-)-{`Wzl&kviNrG2VwWF&wl(V+bsU-gq``l^w2L6rIfS?hEGZQ zmQ03XHIHjt&l}pVnrnDK^T}pw*$XY=x7oz?>)zJOZ04AoukF#~^!M!lqx{mfs_jRr zuujw8PYN1)(jq_I^mtf%FetJRsS-7SAOq3>$NxCVorbj_N)H5^3}R>r{!x^ zoZpvRUh=oH@{an!b-HEC&$gaTP8KX^&T~*#omuiKS37*M;L}+_Uh$QM;uluTv2qAo zZn016NMS*8P5q~2@G2#p63^Q`)1A2^+Ia8adps&SnW+~ ztT#OlI317{)h2ad^Y!c-{?$t#)f-IB&se%f$j|ZS&xbA=3{HaYCiZZqGi|>1>eT)< zIyRjZ`l1)FNzIB>&3Ul*TIV;T*K4gV$9r1($}G|TVv}R0HEs3@gFU|2l@D&dD8#;X zk=MZ`ljn=a*-tZbKEVDniP?4nPu}g1hokl!`|ar7I`?}xU$D{nRnHQws}~tf;|+Un#^7XTwIKLY zUcglrw|Cq}URP@PJ20`~C zx~r#ds1I`q)jzKmrKNJQSAb~?(=ET45Z9**W17VOWp-~nmojmmR?CGOACh{D^29g4 zW1kt&&GF~aw`F$^Z*J{vzMCl+vOfF8i|NbSQ!5V7T~e91DrRZNYHhKlGpCi>td>4~ z^XqHpojb#)e5g0tqp`C;b4F0#EtPrplg}7=|1w;)?fS*ILl(?lmyUFB?NxO0+Q5F! z%<2(`qNb(z$vOM;9V|DUku1=?7j{8p_iz5J@V2M|!JAxahn{I4SKh(1b&|vjlS8TM zI!`u#EwONU8dqb!W8K9s$!?|GQu+QSUzgr~y8ifv)EgIt%9eLE*S`x|XS1VUOQG8D zbMS?q70(;ntk`ENEi<~gv+u?J%pKKdSMz5~ke>19g8wS7BQMr&pYZo-Ug?Lz@0lfs zo;`|8v{|BAQ`{I)Hs|ch``pjIc6xqWwD}J2)7x7;IksH+bm>Rh0j+~?74@?jm1Q<` ztq~>)11RfH!k%|e}5vStiHJak>5pDqp8A8MI8N~-dR}gE8Vlb(%S#T-CPFw z#!DYe_k;*d{XFf|rzcg~CSJjrVSdhEk{9|ZBscSkr=+W@@46RRy4-nv*~Ozp|IdEs zk2$r4Exzf@Lqqod(+{>;>KvIir#X0v?>^Q#&hFI6HCx{q$^PNV{ktHbW+kaM;#^!CZ;w|DV5h|P(WxG($2 zs_;nlY@3U!J6b>A0nKGy0iyk@%kR5x4_>-$K~n531F!W7Pc07lo1FQ%`BW*#-!B{rN4V_H9Mqis zdGSPnPYTvAkEZYG(bm6hyn*3sbBMCPQAqPPvuPolAF=3f+1nwYc`5E-0N+!U;NQh| zLiIN%&5c!;Y_4B&G;x~H#qIWGn!oQZyQ{JJ>X(Z%8q4;nUJ;iPJf=ALj@ZR-)z+sz zhhA8?^rFGsB{nyznVLUeoFE|K<1%6457CLbUshhaC}BJ6cu2{IXFG13c)H*u>->`u z?)IBQt5bPI|4xf(Tc8snCT%2Tc1_||`OhoIH{Lh&h%)BTy}A9#nSlCYTXpHCS#J-> zJnvY&N&R~7{w?2T8bsUP$VzcwUw)K((Z{Zcpb6`5xotf#t2|-WN7mUJU#11zd%RTg z;FgT~ZHvG8=H=X29^QMkIr5d{&Yxcd>fJemofdyIp7f=0ap$tSO1JaxCs@zAJts~` zMCk_WsY_nUU$y!TKAf`>g&zRQE2uxH^XhQJI*%$91+R|E=2l=b(7MiKFV9 z-|i_ny~V3|8ruGc9JWr(@rb(^eK zJ`WQ@RTs^j&bH@K%BI$`Gm2sj&1Uzg~k@^@nv&HU5j^Q;tQ%~d=nmS5jz{%V$))ko86w_Wd3 z-uXx*uit-{OK`THck$MQ$(~z(oz0Q#*UP+{!7dfL(}*XgaiK*|UD4i4XODEN1|MGY z=HHDMi|nr~tADAv{HUZ=U{Gqvh6C(rZakkk_oussZ{~jYsCzF%PEm@d3>Q|V~V_LW{sd>(WprqrnxblnV? za_i}q=pPp@Z?Rrx|A~KL#gx7s%Q$0H9qvrETsea&V*$sF&<9yDi`f6lXt+Me`QkXo zSV`~BberNJ^>FTxU5n0iH~imr!BX&nZr||FckZ1KdawMe zr=u-!Tc}k==0y2tdJA^M*86bz-Z{H$#Zghk6}(#~#Gd)ur>}bF;FU*jraB5oIi}6n zAbozd?(1ojGQFO7z7bKZyYXbk-|VY(vZoSs>eu~TEcE*MdCOfK^GepLmafrXKDncL z0u$%56JkbxPig#!&1e>^(Q;=q<(g;Q{*>e6wijFO-Cj8Tl}v8In=@wpizTNjeeFuF zDy(>6GOJZLefN|%dakbwj~fcv9692$c*S}Z3zf=c!Qv(hTYnhzOqqFb*Z#7#o2+%$ zJA-@bDBCZWpj>KpYZFTQ+FCwkVZMT@=vZg$%7 z^UK91&M<@R{~}6vX?jk&wD?HGt4T{XUoCBNUV5JWM_^w^*&{=-h}srj?KHi-xieLL zr_W#REm|C=ZgVM=w<4jgiL*ZM&YaiXLg!4+?W&!6)m(Ccv~_{NrEf>K)b|xTwtNU! z*EvV!ozx??Q*|?59aNv8u|4Q;m}I}pt(SjYWJFiZj8*|DtN?%R3xaNV})EBj}z`W7%yU2Rh zyEKNNkb;?Ar?Mc(Y^uLpeG^1$cBnFkxEZ*|SleOW(mLCHataC`Na-}`1Qv7C48a)ryJ zZgmPZ`W@Au=~JX*>2;=AHQU(GW^c{=2iWq zwZs4C^;e;KyH_N?EtUK3zH+bMot=k0cJbZ%W@zh_vu zd#$PMR7}IhZVKP-RPMedE8CY7d z@W}c*yeuBOzyDgL@nF3Si+P9M%(p6RQ}1tgWl!UZICe=sI6BHzX4xcN$tWX{$?AeJ z(}VKT3VV%r`zP0Yw+h|7M?kKi^5~q`OY@?7UsV-;yH$Twb!~0?d&RI{|4tZuds#M3 zP1#24SJH-4MhcsK8NS~0Pxr5PNDomGI^Q2=xAJ~sZQwF}?aQ9``E%Zq6U5-~6e7_tj-~BP;Q5(4qs+Jx~AsYvvPw{P6Mq3t~d2=gfII-$7Q|^1OkIlfn7f zzt^Ow*?w_6Ty`)djcd;&_6XNm?pt-VL{0Mo<)wdl{4v<+J9WmLUz~gLDtAnKwYet7 zpx%wu^Zb-PzGK_+rzcGmPTipF)O*LO=i+6_uma~2rJKReC)GdsaiZkZOH->URay1B z7rm=^ws6v;$2|$x+Ar7N2{(-p*vUw zvqk2%AKvquY4c6rzlZX!{Z-oEI8*sz`Q84{b^`Yzd6SNJ#61rBu;b)<@9mkB?ibMV>CdF5 zJyw@|l4@_3_h>IkvCVO)6WsEn=H9=Fv!~hlt?vK6#7uIV$loscTW0?+6rZ0|9d3{n zWc+kdi9A2&%=LnqhM(8y%Pi8=O{?5k8FXac<;!~gnSJ_#-5+F2KChL0_$BbJz0B=L z%c@Rz#n>u)w!D1P?&fy?LY?%b34-rV`rhBM>X7KdJvGf=O|C}&y1ja@gsSv9=M3*p z8avx-HqHFc?4f&Rx`PCp2(zUr^d#Uvyd0-^m@Q3Brh^X#zAMG?jDyi~`hrPpqT6pO zb6nwKwlswt1ibx-9>+gfCQCE$PKD_=eK`1-O)X79`x8W&jZH15Ph7~TQD0h;8WDYa zm+8B(B^JEz1Z0>*%FD}{SUeSWh-mAvHf3v0dE}=Vx5VM2lcGbR<~xzKvES}}pYwNa z?Yr-5wki)U#Bd8!twFv;#h|E?*4xDj`{a5pXB?~@UhbRqvJulKXdq7wH#$d z6XfbSDjxqeGyk+=PqkyILB0A9|DXr_H~3!t(77S}jI&@<@pm@+ zW{XDoxQc`K%IXpt`0t4S(fRRT^*>D<0biX*tR! z^a-pmK5*dq!TPd-Qe zZnMl<`}fy97cvGeetmzRe|^ixNp}Oc|G4mL>&iP?nXU1$o#|p)uljb{tljKz-O0Vz zb7`oT*yr-e6W%{Ntftzn<{I3)-11TOv`cJ)a~>AdSh4e6SfU!3y8li%hfI)d>Y9CK z$+fEt9J2(N7jrD$Z+idk=Sv3{rLNFhd-Uo}=OQngef>5U155d@GAEwx`=Y^AAFG_a z`Qz35+x_luTs`~ocDcI~u9i){bxzU#gm72O*<&jn{4|++^YX0FuEr|0d))VSmt>## zw&2^RDXJoy-^YFGfBZj6{^2au1B<-;7so3qELt?HOW@*{2{9!H7M`80{qutDSwkm< zeFwDJx7u!5|2^F+f_IgUR@$;pSC526-jCUpTQ4mxGy8p9gJrB$w5lub896z3Qb1x+`5?2TbD2*B0&hwRV-! zdS2IUS2CRHAMO8g>a*QNuN01)^6m2apG0q%?y!C+KaHlCrc&k${81b?fiU4@`kU>oubXtVn_D4J%`hH!`>KcjH-6~_}`>F2vz4~2d{frgWTRrR9vc2xG|9Sp!%cbKn zA3F~l^;U{Vh1V_Nb=vmoev{Ul;w4*;Z@t)iQ(DmedR5Kre4Ba4sy?j|s4?hhI5n-< zGXAm2*Tl=aLppbz-Vhs{*>`h`!1;u=KB=zHCoSI^e5=jcTUhms{G_@k>y?$N8f7!` zWF3R#wcQ^_$=nb6_%huizn+=#p7fR2o&FXdXMgnH|CY<|#LsW1W;Z^Wd-T=BUnw@S zKJDUDJc=62cP8f=Jz}}>jH7-ZpVk5oMc3l$$68eh0p0Zzj&L3deSc-|-??A%l;Q*5 z+DOFMFLTe$l3r&uZHn3X%P-IBUYZgooE)%6#d~{6z1D&i&(~!Cne1BGfAh1( zX1AKx(+Z2yW{bx!^Wkmg%N8$9x%L0@GjrRJHVok4WU)$U8G5SElxH zb;KyB+Qx-+grPsvkdPJ3lem7pUys z`}oSgZoY3_KJT4#BMN8YMkerrVTl`4p=VtF=wX_n;Ioa9sH-vu{U za>R*zTbNb3Jo&=A2cIW8-7C zH%>e|n|a@X)nke7?_See26H>j#kewGMi=b2o?a)PHmz*_*NLxI=oooFS+`Z)CWxaZ##GN`8(bcgpPp-1K zI`i@Ns5<|tmt|}FzNq+fy3_@=wR10A9BM6i|BAtez-Me>Jg>GDNJgq$JMp&r^d{SC zx5=K#Gmc3Yy!mVL^~+1X;`Jr--HaFxpBAvZzM*I1r!!juH10mg`cj)RV^(5T7Uzb; z5uAU^H~(F`DpSn#?Y{SI3H8bL2cMrfEbcyMqSGN63;%-s8%xW5SN!&P@4;q!eoxw4 zfmoHxKjr2p2DMyoUHqm|$Ma0hXANoBk32trud9gaIOX**udhyL{gqA4{U`S~%O=%+w+MDp7*FZ9=xgS@;%efzqV)}ve}*$Uii(X-u2wF zFCoUZg5J8NvLC9YDwfp?6-fMc(z~u-aAULl?WH#kx-~9JVYh9x|KhyvWv1fFu9QCk zQ=fkNu~t0tr_QPc(Ph)_sOih{-TKRNoZm}8`m1SIjYrmx2DX{={%tS0Z=E`Oqi~u2 zosJ`iOtP#W6yHl+<*VNE^>{#gU#JvIW_i8xs^vaX@o!G;;?++|>d#cjKlpz0-@VrQ zg*xkRSlfO7wo9xnRN$36lgiuGXIJ?@Yu;_qB`z)P*iG6u@^h{aw=FfF! zy>yDV@ykx$;QJ-M-dR%P=dXP$Ui{hCzu=^&+sQSFi!N;mTwG~4sp-sz0)unR5*&3? zB0pN6G^l^_d%1rm)85l{FV}KR+Wh-`*qbRoB=X*byFNcMwc{3dE5pySmF^o)Jx=fp zOf~ze@TX;i^qG(Auj+kW=sW3GYL%sKkZKE>FzXV-9`1SB!smn!dZ{yn-7pwWpV>bF{q773uh3ainre_e+h*8Fqgq zf}YR2-4+$RV17&7o~BH_Z_c-5j(vS7`lM`4X*bW+d4}J1zL_4*ng7bmI;g(M^pHOT ztFwW<;7`d)pGCd%(;mv-iagusS8!E*XHoY~v(sv7zuH!xo}b4*?Ycl#qiytb-%GEo zURbqz{ho8X>$>BiRqG#}`%&L=Vu$Y8g|fY$*dpvN{w?`hQRB5R&Q$nP@cxalXRU6n zdHKyK^5EIG-zqGtGfJoIxO}MoQ@GXs-un9N9S^S;o!#+i$=mOq2aC;5#y>Egr6g$n z+*EBxp}qD^yKM`;eqj@pyU_KV=N{{n&2Lr~2W1?4;~#(NflBM=J=P!G3}%S%|Ls`t z;M9xFVM5=23WdZQ`%j$mCG`LIdt1J4Sr+9tjaS%l<~P2DvwUiUD-E~rYyHcAPfnWL(>-NW84|KFwti3tudcl|IvnAXO`}6(IYdtG5)txZatajeE zkn0f>W}FmQm|HsG>Ku!`@y#k|%dwHB9B#l&Kq=HNQl!5UN;cx+JOmu0pT6!dBe` zn@x*%*W0P4Z*MofJpb{OKbLe}x6XKaXa4ep4JQsXt#F_GEW6$+e^JklRmUfP<&h5S zT=V0Ik-na3y=hwZFMqR$@*{Jmw*82;ke~S>FuUWAib1fQ@RjR7u4bmMJeBwRp_obE z$34vv_nVEcO%~KSy*$`$RnBsjotBH3nY3l**SD*Ss=STQX<_9p%@)1?VQc!vT$xyl zx3%l{`YAAlOuFW6ZMb}2{m!CQZzeqW6df?z*uAc?y~sZ_+?(M;J=-G@p?fFz)%Go1 zXFkzpu4LuU55Jeq{PNrW)~UOh zJ=;C=wsoEt$>d7^pZf6nj9Ui!zt=rxWt+c!?x*6#!W{h&%z9(kw z)GEKju{k?hm)>0Y`o<#-mq1aqU4~EWyX%%*)-aSWe49Fb?_zC}!@tDdRcV%l$>lF@ zJJ1!h#bkL@W)hG8bDb3rHYUD5eDC4=GqP`fzOsFus`F{m&uROol$6`9&~&(QK;`5S zwMt?3$=}!XGYaSKj>+mzh>`o06?oM6K-=N^hpvKAa~_E0t4~qTPA*k`yDG-Gds^1p zdnwEO=I?TQ^Y?mw-r{G!-F)p6%FZSny5{lM?&O_=4f+0V#m63< ze7$AcFVjc$yEoL%*_O}dueLPi&m4h=n@%rV@w`g@5tr^o9^pyr^Uabg;EskdrPO{$!ENQLQ7p zt0ek&23;1ZFnb--boF;ky)Tz@QlrOutxS7ghx*l?vp#)V>s4>OsMuP%*;1(Ut82#s z<4UI7mYL zG*(GvT2;?qS3a420aerFPYMK`3OfD3wl0==-ixIUYqNvW*x8)r<=xlssN8rbXsvpA z{RuA>h3$KCz9`Sjx$C*VKHuf{!~Pei(;cijHTU$N|G@PuTuMJceqG&SBeUBFHB@Fh z=crvc-Xgu&X4-zXd&^fm4BUt-Tw$B&3_55VXo45_KQIogr&b#u{$g6eJZ1voI(FbaNTwkB2 z%=dogy181$uVXZB@Eo(swk_lC{}VKGqy6*xmyfa+A2PmIZTn5j$K&RakiO!Rsc3g@W|QI?%fRUL zy!kelHcxu_|BGp%&eEB4c7DF|_JE)6{N8)23VNPbSFSsA^(e3d_wK#h)o-Veh40!vO0O~&hUPV zH>*Yuf7ouky`p-r)GV}TC0*hZaJ$$)heIa z{J6V#YmI4~Pu6>rfR(gCXY>D=LlO08iE_U@c zzn|F0n)l?6*>{7k6YRsHE!&Jw;WGS2q5nbQswKbUymyMD^! zbgh&ta!ZH`sm)mXu;CSf1c`xpH)uyy?3cC}w4<_BanbFKSi z=oh~vZk3uY8*B1Qv9qhUdtKC=yg9AI{Osao^?H*y`U0}r`I01DmY-d^>f~8XiwBig zPV9;_c)H=3mw{>5Z-sf2r+znle|FpXnw9QbJHI}UF;W&+Og3?vP+U04)IY3<{jt;q zE}85;_19hXqLmyKcPmTujb>)P)jXfFpW#?cifpT<=^V@bJ6*No)zu}A%ySL7dCKl? zo{rzzdBXKKe=q8p{V3G!Wksi7_n#A@8zk06%{Je+-eqcBu7`Y5O=wP>_`5%@Kd$z? zezPa*kkHkFb6rjRFK6Us^$3XV(0Xln?ULiwXL0Wj{Sn@@bcM>~mFkz3=2>l-m3sdE zg^v0kPbQq4;~(d`AX34&c=MS(ic%Vt5BpAw1#K#_w>~rDrCa?v(=^Z52fA2|?DtkZ z*AD%^PT!4ZYwLyEd!5W)hi%xw>eTrE&8o}Lp*Ty9%FdH4RyKfgJprS33kx;$GtcFoMi22y(iYBrzVk=s4;6263_tnM(r-oPI`_kS|2w5sE!U6X)6&?V6Z$Q4=d;)c$92D#`Gm?v-+sP|_l?HR z?MC_~L3Z<&6aVhBrk0>nE&w@#4*~TkMOv?^Pe%SiCM@(QnSZ z>jh!APd>iu>iD|*V9*rD#QpY$xA;05dYpf4|K;b)c;?!a&DZoED=h2}eE52^?@zJY zi#5&dTQ40vF1lOX*?-pz{(b9bZIYULa=}UGtmG_K4;|^v{%ud(mu)wjd9v*T`?2#n zla3s#?`aMERPVLFqB}5r(K?SE$_%gP|Ju5(_pIvAla@E{tT=G#@S}HHQ2{~BPgeHD z2ReW5nbh>{>G$Y)g@P>07EZtSdXx4_p~zY3lNCKZ*)!Jqlzec!-V*yOA=LHp$x`<+ z)wMlU)?NbT%-Z}K=1ohxme&@aJ=9;lQt4>Vynq<(Scfl`Msx1eCq$mJl#;7De%F7d zbrBEa?mM|6k!K$U3go1A&3yXczfprD-+TQDZc{Fsy7fMtV&yfdxBd5%gUm*YQss|- z=$5~{Z@$g$UFwWpik&Li)4s4e>Ask9{HV6st1X{<=$CHY zZvVC@wCnZHv#uV8LVQC5cqQv=^|iG)&cvAAo$t4wL*DV8nwsE}``49Uu)FN&WIUpj zGJAbN)CO54UttFx?tAW&FYgo7zMT2{ja6%4YI}=M`BROCn=g!=jE$_PA9Oq(C}lr! z!({8jtKw!DzgzRd^`Fw?X+dk&P1tt#j1r&J*~*=)wN>iEZq5zyF4FA<;-3}T>)#z} z+q$4>$qH^$rIUM2qK##=mQC7qP);HzC~JyX|IRr5l+)gPJ=KQ)7d~)}d$!XncB<0{ z!~3_i!nC)!O*dOocQ4#^{-Sqslh5^TJ2v_M<{PUMk1V|Q*z@(3najVsxh`YrC_Nco zajbH_ckptlZtfN5Du24)QmqInX*XMR{`{oN_3N)VtEmHMzQzxsPYPim<=9OAV=b~+K%bjwp zRTq?h(7n0Fd5xjFen;l97hwz*zkGL2>zjIIdA36wcl;x{iz_aQIxRW-=s1g5*V>Zo z77qt5g{Spfc2&20+ufvp#>H#f$vJ6%J$9u!Io$cWBUOayvf9^2l~-kB&vCEmb!161yCthl?4p$Gpa0Vee0(7E$b*F+pDXL-o;;#lxY=RjGKOU)%u5U} z%G`e%vS(A8?i&rimD6uMihGy;e+|d%O+Syx6{|AXCVbY}wXyy}{B#dfPu87NC$C$1 z)_I!C)xWnJy3<{&d8e`D3jCU_fBH(=nefRw&Nb!p>&D0WGyRhMc1G=j`_wRF?;`UC z`!0iIy}Ay~jZcGe`D2zzDwZ>6y-hTqAyUtIUdO_meq6yn)8`q^RQR?K4vXuG3 zxHDGnuWeR~0q?`5dyAKBY|WpN)_8}1+S;JkHAj8&teXoKA76}GPSUD~xE$31w?mMA7h{pJflY#f6+U%IwiUw$7YE7`ViX^V6H?R|BA zj+~3+I~}vQPaHQ3T+XPjlXgz@X0yT^w*>b-fvb`yJ)}3?71mTbtMKA)V_sIqGV7pg z^OzEw)PEl>=jJxQ6}FBwc>0o{+G4rS8_%uT)wWzkf7!qF8+E_mnbmjL;=P*IEy>n$ z$Nm|QmZ=xTy=FZaiE=lA(_vbJ6+Kl6Ug z^skR>syltY-k#L!_Pg|=OfZiWSAAGSVdGW%cA;-;ZrP;G-16CEvdV%$jsMrgB>wFF z_E@9rY{f)pfhX_S1j?I^D`cJU=xM!f9LG?a$kcn}Zm(om4dcAn*I~T^N`ddbrR_HN zIq`aDeMG>Ci~E;pCFgFm4GyT;Bf)p?KvG@S_JE>=2W)pK9gSVpm(M-J!?=Nhd zy6}9#(!(#=>-+X*EqS(ep8Nf0lW(m`-^kZL&*ts%nvd&l+%1|pe};kJ+NEFJn%Atl zk$y(4Fj3z3HGwm`t61zVqR^6M;0s{c`_y6=*8tl4s7#vfbW zr>3npICP(Bdav7-*D)H~bK=y$P5x8mxTkdK>l7~u*>lg;mv;ANpZ^^w?&_zs7r0{mkq`Ax2@nPwV#?IrR4J)|&fa$NFl|rmASa#%0-+2YY=> z;{QC84t{p|^P@3Xr3xnE8M?KW~3nw&7{_zK_s9qH$mZYUP(XL%#MW=g!ayK(zP z1(8&x2VQpFtgn+!?W?kDet-OW#6bZ!!^uHY!zTHjR$70(KPq+2?E7;%>m%zIe|ej` zZO+@)bw7CQPVoD?i%aqS=-u(p(T=m@sn%>rgt4!vwhjNbyuCsQfm*J)OtRS z+juP^oJVhw-OhPmxNa%GTmH)bsEgwV7vG$N{mm)v6RbGby;`&Vxz9J#)XS3Dl`K0X zd>`^0Qw-ibG3`I|{%G4wuGGAg;*z4&#OYoVY+THiX3*JHi!6>hPG(Cp=B<>&tM-yfGszB~E)oa=j@OJq-+tf6t4d*%)4nO(PU zGrpWDIirH1XxcV6y>njQwiSK5WAtUyGPP+9`-{pfii!l)gPj*F-8*-M;)N;f3-Yp< z1WZlYHf#W$&$jd72}Y%F^?Y)E)1HYrFic%F$;wn$_inxCKSM@|%0K>R(=s z-WLxKmab-x4z_-9U*P}szEjJVF)V1+JaFdHF%bo&^$UJF`!PAFDlX@mV6fG=)MyK% z#tw;_5mL-4I=#Mc=lHHRMag?=7weO4%8P(&Sdh@nJb%9&tv=V*+1zs2Ty*AH;9>|`}WL#ZbsPy zC$HSOaPr8pD>r}U&)C25|I2grS2=&&Uu9lWu;Js6>D&MAU-M6#&3nP-mA#V8GRCLx z&pCEr|IV|zZy!kfpE*^&EbSXZ+Oqo7zA-ZYmY=(N`6I)O z8M6)=p1R5We_1_Cz~B2D&wRM={;8h%=zm?7|JyJ8{@;J+|C1N>yN~>@fB(6@O{{$5 z#)-yT{#rBqzh~I6-}~4Fz7OT+8B!Sj>qv>;{y)8Y;o7CW$Nx{iTpzW1_CM*h8}{~| ztbbL9W(jV$Q8#e5bpUCdklUpsr`&-z#YkAJR@SHJt8Lpd!yC;!v=8yd{KZ+-sx-TE)|XR%pX zVbL$|5Bv50-(U6r`OkRc{H#}bSv=c!rR1NH&Y3#zr*K63Tx%Q6Rd?^7=CPA`6mV-r zP{@P$uq#M1HMT>y1}?%#gd4?eM##+_R78 zuFdI+T9CJ8!`tM}6^p#zevH}MqU`ee!2=~lkK`IQPs=B(vufT4`xpx-<-GYInAbMB zbM8jIpsuZ}-ie2{RO(k9;pDJ2beXxuI{MEHb$RaUQzd~8dnfAezGJ;V@R;M2%cFD-41D(_^^3%MS> z*iHH6gUXD6rtf<=JFg^5ZMmExH%)m^xGYG(-XnjA2XG^;$V zx@F3q#idgn`WeLcozZJj{OO@kxAO6sJ7JUe2=gR{J^8uN)LDJ~1O0qHd&f_|muYd= zi+@?iFk{{tj;Y*iOuaWX4cD+l9jv!hb=3Fv4BN{cvG?qclG!uYN5*>gUpu%<;aP|6;Q$?pvkFAF#f^*6}q@4C{phKXRU5<}+rwQMY@Z=fA70yB}|V z>n?EDf9;LmEotx9{J52C?8jO0zjLma+r>qSjcsQp&(`3cCGgjO^SnT}_ARRlZ}&|4 zU4M-I=(E{py~V0h_bmTd#`W9W>~U89pPvbnOqn$nyNQ@bndg1oQ};&lOj-GpmN`=! z1rAqaF(10pZ4|cMMZ3n1ahBEc<)$`92jguIoyzV}KWE9ewC=77ztSDKUu*gmP8s~O z-jKQATiNW$##xg@6>qJPzqOwCfw!l8eDz-o+p38A+pcPMoL|_=gYTDKy)@&%{!2Oy zLBUJezkPW6XYU2=f7jnlxErXR!JnAwwwi_O_t&$sTi*!WOM(_+2{v?qPZEUwyny3!|*PwN34^)!r@MRkKc~ zc!Jx$-%4q&Q@QJBZ@KP%{bb+a5)Gb10-4XJC&e@#D|xgoG10Eguj0?c%ilKqI(cmF z+@;ugZiq7-;dUB7x=%hY=y!f6|^!p|$Wx03(&lmNV%~p2X7Ve$B zO8E3#`>hvLoj*_g#q7+VZv89B%DuRYXTgbYoA%f6L_KX)oc36J@2r!%vm)9$|3vFE zhg#?TY&?FmLqR=zZ~mj)UCoosHRgxrId?WCZ~S`p-0G{1DSx_R{yf#2B5dN{^Kh}3 zs)@w%z5mQxW4uo#cU$kbo~Zi3vIVuNMd{bCdrcR&UeRRx;-nAr z`!!ocvzIlsmn~WQ_0~TP8_mUK{32>R<`eIpNnbqc@buK6<8PEz&-h)*S+#F!PVS6Z zVbO(?)@LSJ-3`}~G}_W<6+A0>0_%y(euqEoZvLj*(pf0f_IyIqYmwP5i}*Gj60Es# z@Zs4{M^_4%_SEMlx&7KJ@4odB$A}QNS)EFYxN2Smo|J$J@WB( zuW8Bo7kAdb*VI1m_1vlQxzCPH^*EaoJ-e1a&f7UzA>eMPh~3>M9)IRt{rXdJ=J$oa zUp;eeFmQRk$l4-L^LuNz<`T#GTCa9g-ntOK+fJmk=bTiDXm(@4+@%5int~-VUaiLK zg6E0&)mJ>q{^M{V<mLUFSN!VlHclXlG9opADck^YvQ&_r%w+YMKNy~N>O;U8{Q<>vCO*vzS>=SR!4f|Ekx&4ph`fyBd`to~s-y6$F?8x)2 z*SfbdZMWg7pcnH(qSPcstqw02IKFW2i`bU>caLspeRfNGc)MZ0?Ll4x(IC(3EPTfl zSDh7q+L0fg@6z;Xo-K=mO8@#84db?c_wEf2Pju8*Je|h#<=nJ8Q7dE4eiKw?xg8go z)wy*4nf{|oC%Xh&yHtOesu9rR!1T?;cuCK+E;`Z-djI)qE1Cn_6w864xF-@ z68qHsz6q;6{&DF`*UFa?o-JmUEa`Pm1vUrY@o?adl|SbGIQiR>&8|#0H*p6XU0M5f zrE74)7TZmm&T4EfW;gqwDZiip_VJnLrD|V15@~xU@@}baZqSSH>^7kY<+6L?B3^bOLU4Ogl4lm4H5fvKa$VXYUa(tEvHTI{19WE99Y0@k|yX} zchvBF?%m3*f4P#ThCh(^d$PXbwuoxklXWxsj$HdIEY*I^EKeZade)_jrlnUIk61sN zz59no`1qvp zY`aYDw0>mHERDLyyBgm!CvOx!G5;LLtMeCvm5cVxweXfOzvnGbu*3h|zf%%#Co1(l z7FT<(eCTS^V&A1MZeP0${9h+OSiGfXQvKhj-}g}?^79|#^{#?9+3I}nFPU|i^CV+Jl8fcd z#3K=}yG-n3KUTQ0il*fMcC*OalTowVo$Fc1JCB6@n>H^HWxZ9hVNK(*I=;~Jn)wZG zZKu;t>&(+xQO~d0+3#YjYhZMBLqfsnxR9GaiaJ+rG-W6cy83$w=R31K6Qp#EyKdA= zKK%0gGOMT>SKf0=fn5$pI_GX^W?8o%6f6z=QpnMxva+j~m-BU+e$w?6%r@2;Js{*_NEpuqkP-+9;WS@rDu*8cTppL*A8#!1D%LvGGn(tgkR zynDvlx1l9ED=k-9Z@ee(!rfpYbw7W_{>SEK+gFZSVD_Pt>Rz}<~`LlS{!y|`FKAZHZTk+5E zSmSu|s)xqA`rIbjkQqy(US*g33cBg{DOBl$#lFW;Hw9Lo(oZY0uI%TUEf|~eS4=@^_s$bnO5QGJFFdm;D&~5hG1VPU)TVGzIiZKIJe5KNr&1$Lf8Q#gyIDcM{-#&BIj zOdbX8V`uzz^z({|_RE^CW!;&V-sAoI^UpXQJ?6eC-#pg-UNk9mdwu$;GyUB96BW*P z9bVX77{?If5q;sl+_%V=%8%~cxbup=gJWNbVEy;E#?Mbo`f+yEBd2bo)6K!Fbz)M( zYz|A$eEw_SgIU)fU0(H3qnceM=C#hRo3Yc}4vCj8XK)cKe31VCLWaW=E46e1!@UYt zJB_Y9J>BED!DGILNwUHlmF~Xdtw#54W^EYtF zbMEh2r;^V2pt?BF^OB$Z*Qy}zUzb09(fG~e_UZd+^(p7qZCUrNzNMM(;iF^T|9|}y zSh(AWm*qk4y{C^%?dz|)HRP1bSW5irU3X-{!`pLgtc4%XM$9Ogh zt@p5d8j$X?wey_WjWETw@FiaLZLA-rnoZJR=DK%omEMA-MM8=0%nHv>Mf%R?pZM(A zkJZ1Y|5=>(MSN&35SFMbl$I-pqEo4hs*x`By zr<~+F=N1)yJ&|{iLBL8^@=xLn#quq0Bdo%H>`M@NYxpE=sYk@zbp?X=j?bG`w!tzf zT}kxPsnt_2tFzX#tUGw?KX2eW&O3Ly^)LQelUbbSQujkRdw18lZNF~*)q3~Pzd6uc z^KTuOWj(#a>7*DZVN`Oe%nz4~c|YFfWG2r13| zD`X*Y^Z0gQw{H`72-OQN?&Lf3_#ngfclv)Xt`<9b*>ys0?y6g=7aaQL3jO<#9pi4t zw)QT|)pQff_y)t-i>CH7x1Cze@Urjv{*Ae>m-zeaROYo|In1$V3(Kd1U#THVy7#ECl|re18W+j{onqqg^gsXyMCtX*N? z*U&ZT{lX2?BCV%=;CjCK!lQ}0k1VJ9ui5hVQgLK_%8o^$oRzAjtDIPBT%LZ{KiMqp zf7K|vTRmUr$F$weYp>OCoO{hv$Ri@B^{vTc6a#!84e{L1E*Nab5LqxbTS z`bRz!ZFU~f@V371?{oX&DLux>h^eWcziset(!00ZO}Rp3nN%1E!c7J@T(&Zm0d9yVcm|CT3L4&8tm9L$8Cx2suQ=?N-^c$`+MchW*60GTi@FW zS~VIkDz$ifU1i%#?Uyw=|L1MsDqdF=aJ}5`iMtuI>B0%FT=V`Z`CnN7=+R_`E0uR{ zRiBDd64fg`t#G!cei!GJT+ts!2Jc+f7tiY0c5(a4o149Kj?Lk6^UqbjTsienLeDy% z2`V3iI#LSRbUs=hUw2G$b@jHVzQ13tzGd_-rFRCaujiNd3N9x1m*_3O^`o^b#k!v< zlg}_mzWBxa*0|*fv$@_2RmdOnW7u|lUBXV*i3?Bfk$B+RHM6*H>4FdSN8gvqJ=*e0 z@pz-;o1+gGNx$|NbrRiRvvg0G{kP_}J?jIXH@rFX+G0kr<)N*%e)i{hR=janj|vQW zG@pA$^h?eK$I}y6sTED_W|8d7vbb!2#rLQ76TZ}r-9qcqUO$$2Fl(<#pwji7ud+&m zgt&eND8+qfHoph6c{@DDv=K0JS zde?S$DgAuZU3$Jd$@RjT(LErS2a&>is|l{lPU_!BRtnOoqhOm{ke;|=3EN`2IwveYec-O6bYI({Jk7)tyS+Pv)f%RBcr4tiCn$1b&gQ^a`+DK@hZR$f zUw*jvi%n;m%XA^f>vtwxIOF>zE;awF;u5J%8*j3)x;4(-_j>A)Ic&EdHHC}qD^lt2 zIh-ILd5%Z&=KIvYJ_3Os%tB)uwBMV)ja)pfv^BH#UHv(QtdhdcrkqozoiYm#_-0SO z^yt;}sYh;HtJr#6KiRKt=hWwUhj=n-Uu6H|sBh9qNP6UY(cz6;_18Po?c6;Rmzcz| z&X+9}Ev-)Jl$5MK7XIf1uj=#2=QX9(*EaLTrYySU^VIgvmZV>N-{wr;|8d>MM5)YE zepXzXGE1a?_C|--mnYb?Zs!z^&YHUV%C=%njbHu;nl&eFym&V2O)TS^oyxlQwO>EX z@%)?rrT5TJ0nd+iZV!)J{F?B@O(=_dX79>Ot>X{Ys?WHz{QWKQXj!+!^Hwui*5t)= zolE`kc5%Fl!VjaW$?xYZxnA`3K*NrIoopQ6mdeKKlx97&Pn`6}=={EV>EGsmyZ$=8 zU%bLA{-s;(-XG$^XX?%G>rXjbwP4D#FWovNAJ|*hFf#2~+jnic z6|*dG(WC?YnfIBio+Pr~+VP|E)AwC>dM>WM&pf?()dh(wpDx6;&pJGNt02q2nOW1g zo$PK{IKHoVpfoq&31uI6 z`6{Jg-NNq%v8N`f?Z3;kP;l~T>7yq$wCT@28FWipPW)}FkF(NQqSqI6HQn%@A^ys2?@_atu?fH4 zoJrA^tbdqnk^k^hM|kkNkkhAmTqCZpaAZ!Nm$h8naP9=Pnxp!gSsnSy%5>F^UJ#j- zUA#ls_8#ZyOZpR^+dX{vHNz%jhTU$d%v&?BdqrQ5eI(*@ts?HI{H=ETuhP@2948-e z%HtNC>|i$e=F7_p7aT%29K7%()04NwV)up}AA;r|`TbbAUZ;NkygmJ%M_C`;U3Sgh zY|F#c>4k{|t?8JE+0{FZ~6P`|y5cGB7I zIV^ldn_s`StU9!9R>@NP=GcBihwr`Y(k~*Fr#}qe|Gn$>6_&Wx?$5inbv!t_b9YDG zhBGg?FRC-^?MYc5c6GO6ee~Lg-ya1ya~ScioTO5w^L&xd*M@&3stIhXZtmNmXZ|8v zRsQUYwf@^O|2uyQT)-3ReL^azDQKp>xz6(2(>H59NWJ;iLSkp8@#oZekHh@`uJW{8 z)x+-2e4#C>D=aE`a;Nkj1*3`YCdw^poh`7pK~FgM)`x3%HS=>_(w$_}Y(Lctr>(lW zBgNs@+-1}L*8CG$@?mCnIP?00=Vz|u+}$uVE##JXv1Il64gcnqX)a9ud%jAumbXfHvx!bW z(?;7RCr>3_-MdKYyw2PkUtAVl?mzH}sk@+FU*y;pN8d9)eh1FYoKW;RdCrdRvsX2) zeq5<^*Q#UcriHrh$)8t*U1a$*VV-TcprPN>Z`{8-^-J>4c@{IQypb<8qj8c={<2Ep zWjcF{+2ig>tv6h3Aa}ZLqWhK;)`7b$%wyOV1Takd9M%3OR4?bP{EH7={Ljx#m?mkE zvE8NTuTlNA9h*aYzQjAS2*`c-p8YOkuli@H9q0PxTTG@YZmU)}SIEm3K1qz_{Kemg z5?0D>wx}~PU-&RI%45E0ag)T_a~6LliwE%gMF{V|I;Zu(*Z70a`dF%xV?({3mBjge z`rabtCC0zRPWn;7kwx`RecT5>?r>?)y>rcIRVsh!;li(9>sK256_9^^Hh8D=^}c)C zzqs<={AN>hv#agTvVYAXokB~M_|0d2bv*T@|^&nzL_YvO~L>2R=aIdNy}tyRC#|Ma(20~ z#^}qfsfOBt#~PZsP9>MspJaXZmBHwWNs7OJgqnTF53xf@a^hASuk14EN#S3R^Gis( z@I-`0tc6mA)v?t-EPFROUwY7Jsi=0S=tWw^?k`MsPqs0wFu5LfXqr=K-fX!!)fcA9 zcPjrp(5kTg)|RhsVspHt)~#pX9VYL~V0|Lui1oZ@lcxs7Cbb(l`DspG=T^V|UifWe zA>TtjmZx)yVvhT@|1yyHV4zUGZ@tT>n0x#4e5?=2A2yRv&)iV{^MF}Y%rDb9$Nnt3 zxY9ln!zHw(ukJYGATWNgualPdGV3SK9-F~HY6&0l2$X~lXr0}h<^TQV& z2?B|8Rv!^O^y;R7xUI<2DVnOTAAfyp*E#o8G5)Od#poHkO0ys4tQPq3QpNmyn8K?m zF*c6ud+1S1I`1>eY!=Mkk&%-mDCIeO&C+ z!yN{1{bwKe#@SI4GgEt6+EVM{_hls$^>|jSJ-BmG=(poH@(va=?m9lxa587+9kYFB zrEkYPU)*-r;5qk^$>m?3Z`XI96IVIsrTb%pTlpb-7m1YD@AbAXICWD0-Y$V7d!5+I zT~sFuuA6o0v5>f#^Va@Z?OG{OQ}WsyUK@*RepIZDE4Vn(tT9K2>#b&v)~@(cUp9g6 zRVNNTep0iRbL$0zTle40mrlI1`Dwbak-%4;xjNe)S+18lW6v)8X5PZOzjv0z*0j%g zUv$}Ot&`vBNmu^tyUkX=bJa8sm*4{CN@J5rvrdMTHZS{-XW4POZu7DWn^*Y#csgrY zKkvDTh1U}VxtZ==PKY;kR#H5dAIo=ggVBk7OvUw56FN^XRQx?6c;%|1a`t(KM?J+*>!3{a{Vm<}0jqm+J2(sD4d- zem>~&0sWLknLd;GzwUFIqwfFgC&N2O*7`Lu=@(wUzhrw|@?*vPy?i&#_H5vtU+_I| z$?w2fCpO)5>an|AHQ6!oz@1XBNssFewpkwg9@=as8Cqx&I)7Smq`S-7PR)J?K;iNmrL0)-njCSIWg5FMdD^q z>0QQmQ8lJbtUSi^nq1#sNI3g_qvK~m=~SCXM*5aBJ~q!;u)yG7-klVi6^F&9xFxOH zo_~1dm4nLjn>Zd@ysFp=M3y_$$+QdPct0I&yZ^7h3^Cx8VNi ziyv*QKarnSwW@l@0p2F>Z!g<#PB{LvE2=J0E;TzM&~;l;eeJlUDnsX_P;e`GF zJO6d`t(I3!_L=dAbK(@e>Q%0$KlW{kx|F)?1=kvm=1Yy+GebDvXKb)s_3$)H=jA)< zyLNQcPtNz;f4Aw&ZmazMW9;m%0=y?bhIdSOWO{ykMw@Q^{973c3m&@e;XRjqclKYG z^p`XG51Ma3+c>KuValQMqi;9I>b1H*c;dWci&*)W14`b_$C(!iIKTSr`TXSv`M#^? zGr8N|Ke5>nEfBfR_lvV<`@dsR;@THwj|C>3eGv8T4Bx_k3$n@@KN_wJ``~S?e&X9b z_svZrDXDdKPBU3sJ!0xlZhLu=>&?>`w^s#zhki$WUs~5}{KeGjK>fw#hV8EFe3hH+ zZch$qkA9SHuHj$x#rymIIx+2t9}D{)o|_+fK77TLnJ>ap?d>^(ZBEAZx`%%FEOGQg zeYMZWT;>1#`(2*Doe?_i7~}RsyPnx`Uln_lqLtK~C)_5@+W-6Biodr^>gsn?xGZS& zJ|Z0?X&|`oTX+?ViJ9q^wcSjeSvK`$O4Hm+Z@;^w`Re8Iu&Y1()qf^BD5u+Xo;$QA zskQE$TLC;R^H`m|{JGku9V0kPVQ zrH%Fd#o;OqasnZ9t>1;!wIzDyyNmyG?y!kk>zMoVFYl$km-9aN0wzVj%mQ8Gyj4mrPtmnMh%Bd>O6XubTD7B>OgME`xi298{7b^i-j#GC+_4U&?T+@3l zc3ODB!2*Rskl<@VPr3~qVxX)ZX~`6%m}&n-XEt0rt8Rh{bDHbriDr+VRk z*%h5VwK+BI4}vE6{!~1b&e$6rK4Go=!HLiMIRc+JJ4*c9VyAoZ?0TM4cYF8dxo%NS zIGAo*mp^9qwH6^s4Kf% zj9X_uep=M`n)&|6LWK&&OmDrIqi)7`kKBJAa&~I#A!CP`?{3;}oD{(K_-GD~R+;Sb zNu4JTf0`V1dtr!8wCK0&L#wB+$)3DXUhSM6uMX4G2`4N(b-y+&>A%AY)bJ-e&u4|dr3z9YSH%?h9IKwV|UfFMzjB>uu%XUT_ysmlPcelCMzkf?ycS~MO z*c`j=AXC8XuP^>o$OJ{jhp$loKJ)0pOU@fpOaJBj^$l*Ywn)kmVPlN)45(l{o9U$sjnY7Z{$vT@s>;9 zN%c$}`=h&|GU~6Je(%)hjkHO0NLW$NKjZt;;ENndul%_u-CiBq8q=Rv)w}$UW%o*} zt)HBKM4vhq*~ciQv zmbPiN6W-l^lJ$d`ZN>yG?rmLG)BEI)@>tHhRkdbPmx$pXflueTTq*^GT~BiHIj?Wg zi)yY~ZJ<9xC!}CUe$1-2S-Z5H+gKAOxId99ykA`~hj(7yv(-7lai($g>V7?nlB;X3 zPPI0(ext3ucF~{56^$IMrOE1RzDKN)Tf4`h{^OOZN*3<5m*d^bdRilj!Joa%B@0)4Y}k z9xquMskC|T-6Q?3a*wArq;lQYIyJZc;C-1d>+a6kS^Dhy+qFt&^_>Sz)_>L4*LvY0 z{{6pH@n?9~X^ zeR%Du#GlHlzuMRAd=q-5{iMJdos5m!oIGRRoxCygv%|iHtXBE@5?gU7(_cRS-npz(VB3@X3)Y)? zeVy}lTT4^t{!=@|&PpWwNm*T7cjwfeN9Bh&dosA5i|l7Bzu%py6lKhE_(DV}kG;{Q zfC*;1x3g z|DWc@BCG$cxF;o3b$!?Ie78-JF0(=k_Wcpa>pEnm#djp|w5h!5U*)W|x6X!y&6a-> zF?ZQ7tqJY*AwdZrzxv#~vhd3~FR{sL(NU)i3ok?%c)fJrmu$9fB5&0f*|$L!3G3ar z{fK)qL3H{AKK|7vsuA_xyBAs%{|!_46|gXA$MKB(_^g>e7g^K4Te-6DYF(|c;Qfh- zZW0HNg{o*y*3XjickrAi^{a%}*Kg~(OAY;xzD_^4?nTjBX6srJ<(AHdte?u9<)K$^ zx=Gx9)ab=^RsM+P`K23wh&6RdMQxctC(_^fo{#@~WXZ`ve?^<6w zZJ+X~dB=Lr&;GxjPMN(jp=o9pMP7hG!{)w=c^y1%SBXd7 z-TA=eO4qWZ3L^XecneQGw(v^i>2)zzw0>|sT({#9&(nF&kDn`HnIC;4L~+K>6>8ER z>!Tz1(_X~>Sn9AhV|nlcv(rYGP1bB-6|aAK=bv11!d^!koqdYNn*53D)>~Lwp4+Nc zmhrkq)AN#`iD-edmh>atRE=e4B6lB)G(X;%v@Wpn(+dGp#>`%h!ri5^FTW_IZeEr7 zF6$Nh+~e27*W5d>Izi%k*9RR9XV#frUnWkn>}ZMAS#9AbS6I1j@xmoCdxN^7Ebb(% zz9QRR&lboy<7SB&s~FS#HP)|~wS%Nj9iQt^aqU5Lf|fh;nbaLGl$Njkctz1qeBat5 zoq~sUi|&2V_rN1QzlvF8@~a3ob=56gI_$e)E+FKlB-+zW2WtiH`8{--A-}; zeby~FJjp=fBJ1VFRj+%e>d)Q1Q0ho_%&Sl751xyCUviiwvgodt)*kz5We0AZUHjf5 zTRS;6_^a7|{YcqQbxZ5t+t1a@>sj`F#<^V{*EjB;x~1ygca_2mPRCcSVfVb$6gBI` zy|w>i>SrY_U9VhvN8_1uo~~7E+F{juhpyWH57N5radU~R;=bE_4>;{lMyD1p{^QqI zZ=rj4U+lEVE%geA`O>C0?qoPtEA^5^cVuBK??TbayyaZ7Z)8JoJ5e=LyUnX9i_lVk0s@!Ct`c+j)U zwf^N-H?hiW+!n@$C zg<14+Ero@XHuWyH$;#OHO5u~n>UqYN_1c>^-~8dk-#D{lz5Bd-(;w~<=y%O~8_nLR z#_7bh${~rR|4_}^=&w8rVgnwRh88aDiWR=zoc6zHarVUZZ>GL^yLxu@oHbf^S8uzj zdZaOUQh#Xe*?rYN4t(C+uX`%(zQT=yO}%*!=f1qVTYLZBl=e+m3l^?pjyc+}nTX{QRw6 zN;(%ev#q>uFKI9JIGv@$NZ3O~FLBS_x}tAhnhw((!;FkB-sWQPtBZLTaGpKRWHLwN z|B3$t&h`JlWp^#}$7eBb;Z60Y?+UgAF7dO@x8&ZdF|(qcNt9P@<>Rzm&$TUXny1z| zEA5=xZnnT8qbcRtUf=5=(6Ce`U`vnF}= zDcNy;o_evs>fUjM)zg17+T8Oy_j&QfTW>vg%qv;=`O_vtn@4}QmO49^H`Pm@Xmtxu zC~ju#DQ<9@w(Qdl#k#__S(Q6DxUw`i#4Nq_M0I*h$lMbNtxe}w|IGxdi0*9&Su7&azd7H-PhGwWbobjqN76bGnWuG zFCGrDU5-X8R&3raz;o?vMexOrYxm9T`ScfW+bOf;`jMZ)>{)%AR!S^Bym)uTr@LC4 z1vz^dME;-AC|s;;xnV+N_hIqBPd_g1OICWRzH%M=?(@-h`)r%ae`m_Q{(hTr`P^;# zZHkkU=Eq07?~}eRuJ8Wb)Vl3ntiq>-Uz+ra*USCz(+_=iEjzY*{)2ZjY#72bOHZFw zjtZ~u@9q8eI`O{Zz3v&suGS_V@7a>elPB)jvUo@H`{L){e;Y=|z30`^GU#G{csfc) z^>U(-rq-`7+rBwH3J>0wsB}{|@J-~Nz+)XyKMdEERBd+ zv(WeF`||xCx*}$r*LZVEZ~wh{sq9MYZ!Bi|aQo+jfY$o?`5Erb=6+(eUv#b>ezA4u z`s1+*iG|CX`GOb4Z)!DD{I_LkVaAk2+jZXG_Sw;vIYDsOnYT-oJ0kv7NOte5WO=@O z>J>*Z-Xe{<|C&Pmd-m^LvUzsPyskG-QqAVfo234@?_fgk1-s-gp5pty={Ubr z^9eds_ii=M#yGo4=aSZ$dNgT&a&2 zL>4mf%-VTyd0WN9_U`W91~btQT8&A^CmQ!Gj=EbSu6U}?kzwAYyPsbt#y>W_BfDwE z>6U+`OV{q>o1D2OHEqYlL$Qm699Lg{bSN~`{C}#=E9R|U#lO!jlkE0<{&(r!&Qi?> zkK-*axK_nN!^R>TRx~ z_}T+^8SRgq`#j;t`6oZui%1F?udVy$6nE~_OT23J~V z+8*Pn&nom7TjRA=2ci$Zu&a_Z59W)L zO()li-O5UvvoAl=?3qFGkzSvm`Ngt()^cRs1Q z=imFHX$5Cu!lE@g2lMMg*tgDVIB=k-;`Oh@M>P=-6W)p_-<^h2b(SI&smi{jH@rZd@_IgJB}Apk&mt?L8oy<-!qNp?x9gKDPx|qFUUO};tnF6Qe;+=}>Q7Hyodn_UO+;`!f~>J_*w{pUzy-djBsQ&#!&w6MH5|-qBda z`|bGV{SKz{dIi&THeKK6WRxAfX4&i6xiJmS+3H8`?)x-1Ng-&qs;+@l`x-~qhwl!a zlfQpSzFz7|_YUu6rOi)&Sw>&2dD-}>Q|igey?x4GOlAtXDP7(n?9tyF-zpjs6DPK? zqd?YY+zq#{r$>$Yse02}pu_q%-Ml(}JtFS%@Xc8C@ejvx-ZGo> zE7#X4tpCpVaog0bCX<9bd$nRt@Wu;1=~MY^$!KstD{Z#ip|e3T$GVf{gUw8IHgP|_ z`sc$3kwu4dH^myV74^HT^ZhO_ z?CR9e>hZhh?ICt1W9oADrk5TsCm+^Jy;wVQN3rAUFK1o-pG$FlmM*c|Xf0v&&`C+u z``-2aYq$#)%C}6LP<`vRFke}$ym-y82nU|5>wOn|GpX%mVL(r{nB0cEy#1#xoYXxv{Yme8sk=;)O7lY8b((jv zeX9@kiCg5JtXxu^Sl6;B^?BSOwMp^YI9J8p4$C;MxmrYNR$Xk3p!v&LM)q#c1+MG< z=b8CGR&U+5_5St?_4#An8MH3jdK~1?RY{($Sp6yGdwG5B!}AIg)vvEBJ^ohhMxt0b z*X8FMQWsa396ZEexhmnveeX4g_q>)r@V?~0lg67D>R0F*Dc!s~%ayKsy7{*2hJTB_@2`y8u;ZE6gBMa$m-tvqbSiINqxA09(W%BazI0#s z_|V1oiSUJto2F;;>Sccx${##1`S?fSxgTHuKBkyi-6gy=NU`nDwfs5PE}rwBpTPN| z;PTIazqPy8Omep5o&zjgOUN=cry)E4%AC&B0mY`I1-nA~s0mERQj5y}hoxe&)N}HA`8;NkI(12+OU?5|qy<$UL-ONQ>dJAXP`rD6}-Z#-~H zEx02+x+3J4rhUl%z}a=8$9de3b~7YSnZo@aAV#=EIg zru80;s$H$~9rs3ZO@uGZ;h_y+!@g}j0eBmIDTpg{~3uJb_EMqmzRXxtWEpL zY@t~F&h>`f2f2C%+snms4+*_%(v7s$)4X)s=Gi+hYf5UL{k3ty zm+3!q9Jd4ozCC{L%7x~=pKiT(+j;Va&qm|rE$gPoRg~7Go-#Ch9Nlqj;)*kq6TE}C zuH5eLdU(H4pWXVWuJ&}fv`Y!@+grMChO(Q9A80e<*>TtGQoz+uFU0COlsS&hy`htA z<38hW9M6)t!1U|)Ira)@K6Aa*x#-!lD{uB5(-6M@_DFuo;wkl;_Z4wSy*|??95$y) zY|YNT`U|qJk7_OEzuEG${o|uPfu^1PKhpb(m|A&{uoxb7IK0%|Z~cCUS^85oHM0Xw z1?BX)&DXB|z1h}*L-*a6?mev^KGr`o6hWemTcN zd2`Ci$xe@6MKEuwvr~|d`?Zr4Tc>1S-*MD_Ui2-S*0;Nhd1Q1}zdpwQyRxwI)9H>6 zmaH4Ix=!(KSL{EnSKV~Nt|xh|(<%49#9*Ofxv5{g5}u^+PkZmd!=EE7waPqWW;_4- z9?l1zO)Z+=UGrq}EARHkbsJ8VTXA5b(*@c0elO}ng=_wHM%gTPb((#yYKPY;e%Z6$ zZg007)pL5(q#b8-{szlUlWRUxwW9*Q=Vps8l=48&^Yo@mEjkt?)*$p+zI4Q%cpHBbk%iwGi(0yimaD!TLylrr2)bgoU*cZMP z7Wv1x{PW3~^@dw4E1b<{b0%HrT-_>@&(_WV|8}6so!*WI_ikSMZGNgq?zjW1p3&|H zXI}gbtDd8;P!%I|mXCjGWaElNk2a5WI;rd}?IDla``Z>ga>#1iVRCcoA8U+FSWz$+k6NlGRCTyL1f1#q7{*e=txAOTuuTjlgV;5autmx?dZ`ZvS30*3pf<806 zZ%jLV+iTmKscM{t(-+$*I(SrNJ}6h7_BlOiuC%l4iMXQ^1$WJfpLI4p?yG;}zeRVH zA`%b3nyPT+M&!)yx@#)CUep)9cp3MP=h*ZK4trObeXUu=`cLr66oLF#mXGiGEn&Bh z7VpXZ@x8;(`OlKr{NHA8P0J?h#lL>ZTj{?wzs_Fe(nRm1XUvgnFP%Ee_osEwnJ=4L z43|u{`qnQ!=bB0QwR3s?H%~;JJ^9TbZr=AN2loBfsogvp|{X{zv-^~tzJy0Z%tfu zuZ}my?dtLC&z{=K72R)-`{{Y|__18a3kGf{bE5f@PObTn$2^g%K2P@_`(OT$i1%I| z)-f5H8>dZtS{TC5_C~`e$+|jr{+@>NtJmMF*H7<0_4dNm_Zz=9|9masbY|6S16GNa z1-~^H*-pG9w7<>hxS#8xIj1Y*cQ(CM`xce_D}U18{&%&JK^H5F)YB{k4)wOayxiwuojeaNzr)XWhMm2-AbfjV zxJ`8HgdKYCpG{3ac;Ka7$b|z2m6Kne<6R|M`_{r{f@9|UV;z(0SH9WlzjRi|&ywydxw@1ma$*VbP4*wfDY*7vc*_AdSXO1)w}qIrH#@2=ao>CkV1 z(~~29ZQxs$!&}IfyJ-Fmompn8A3onnEm18@eel5|LQq8EoU@|FJf;l`)IO|#yu9np z-vzJy)Bm=-|2LmOmhsWQ=={I+KbHUR*Vi|m&zgRy*-7_S{cE0CIdk7#4GO6|C0xBt z`MUY#F4Ie`#UHq5B!nK=GHa>kH=mjb-AQL3F*RP+zbZ6wh5h4qi8<8=LeIB}UtXQn ze*XH>h$y?{j>n%rAN5%(vpg=&@UU0%`uX!Ou9kSO^2_Pu=5{Z}H%`~5eG|C2yl!Rv z@#4knrXI8kopK^@;)RUu|22c7_y7C0^~}v4iGTAPzklpq`R=sq)=Sr=0>vJ3N1yMU z^+0p7gHG@XPn^`=)=*?B- z!@1XgKE7P{#zfjbd&gqu%Y{$)yViAt871GkIn`6aWQ)bbwJLXIkAj& z%{+%NtF4u1d0E)DZ=UWb!6wXTIbCo+yO@xfu>qI9PikIzNrsVvp{0>2_+9`JRwDxg zO9Sws7WHd(C6}b;ZdaSLBcJ0mAOLn$l$wa;mf;|EwLY~5g3QW&&l^Te%>rz{IK zF)U{MGj+4m8Ishtsr9j4W2h8&&gNEb*wQ+&bM0hK)dN?~2`2n~ z&wSv-xobBb&A&9~#lNI_PAf(p2ET7=ZesO!eeU%7y!jt^k>QQ6Os>wHIsfdKb>=Xn z^|5U`S6}@ghke5a(@kZD|I{1z7X|OGS50}J@%{RtXY1eT&)73}^5)4C7q{*;evlth znRv1O`OBQV2Y>u?)Vud*HOze(@11O|JiXrQ*YtP#XX4jxZfspEeBkDhyFcsaN3^Li zBy+1*XEXQj-}t}jrghXGZC-J8?&!_`Pc^VT$Vf_ikdc%7=*buHXZqjl@BUnG#rQw? zE8Dkk*W~_x+V*?;)%s@%58tFD<$AH7J@LhS*~HKHZ={KByYS`znXZ<#D`gudKD=L) zEdKldg`Kl3{;hTt`G1Dz>3tQRp0_z`Z5is1sV%$kWmDO?dS@n$f9E5X{jPWa^q;xw z|9pWz|6A_;w=Vi`?f(C=>c9Pa&;OT=x^nbZ)U^Z8-ZT8EKF;t@Pm($Mzu_`LsD!x(gxnGe@r)|?$J5qa~UGt=w+p=#TX z{omWPzvQoWeU-1IucxoztN%xv{!U-`=e}b>*tZS;XW#z6!tL0(ANKtJ5B&L)`JC^= zqSTbf3>SfT|Ds;_^YmhdP1>;K2! zXH!nfPD%fB{)L96^bM*1bGQ8$`Lo!psIcUZ_ow}02kx)>|M<`Po#uvx=7vpi(c6q4 z@on=t?Nh$)=n2_*BG+EMPyJ&klk|VLN0|mK>Z+fu ze(v`sZpM?zZ}_;9f2kVpySZKAgI)81O^I`++zyS<@X-klWRmASxZ^_4rX_i?&o>?U zsdf98tF3(atk7p#>1$Ze1SVhE6d_e8`1+doB(2tl9}kk2rDg2dxI>GXJ!w}{Tb9Us z9&2w|Gy9bs@-e5*G3D(i z*xBXS7#Vp_2dw)1LcPQMsL`~Df3|Wt6Q-PX`!fG&@U*F)4`(L`{K@p)80%r07Zm<` z$(j6!M2|3=)~r6*V% zz8Y))vVSEn$HH=fQ2Pl>xVHE1G5f7y6!g1RBR~B5nWgcSJ45R;j{J`O;XVJL-d^9h zlLsWEijUs<#{2S{wDGzJk@Z1!GsPvNdZj`iuUy)|v{=LcW2vTz=c6e*pYPhG9i40I znXc(`W2VRCRj$R}mBHUbIwgg}SMdMrye{sY&Kn|r9m&f(;sf6tL`Z1bkU(2uSe3DK-lV>hpT$F1gy6m}0 z>e8oWfz$eBUx&CRiB9HHww5kGc-HOr@&onJcV^GNQJE%uPsBjgZ@sXw)Z_WR#`CLQ z_Q)$F3r^c%vN__$>cBIbx30Oe=2~awzHGKP4U(_^T0MTa$jNL5`<<92wn0au+Kp$X zdev`o+~9vN&L^okC_BS8gI!XfENNBi*^5TyZ6%p3$BfsDM;y_U{%(7O)nIe^%U4Iv z+wbkNug|TV)Vf2Um*<&=O_);q?FxgxewIg>Ke9gilKkxO#!XYQ*2LAlRJ{6J+s7jy zaLMD7AtExCUp}t*&ZH#%DMdu6qHig~o~4PGGrA^5|2%v-N4>Ay{tACX%k7sTLY((Y zm)ie*7QOW9X2S=feKI9sUynu$_3ev{Z~NJx7R7WUf`4-TzSC!vlP=qO+E^uM&t7zU zz5UCwL(VagtgRWFW_Z6?zr^N;X5aPh>Sq-%nb_W~+{eoqz`=g;;`C1cAHNoTlzCof zr~m(isRQ>l)tcq3x|Yw>_G~lk*t6c&%kk}f{@VPUFS4wv&nB>JH7$AQJ@;6v<6_gh zqW5LFo}W5-JwVRv-i-RXZ~k+`zV26ueH|&D zTVNqaM!Br?&dWCS-{rbE9 zcuwzZk|b}@x&p3~dC!;5@tglwl4JU`JS)59>OW%mYHzlOEe<=xB7HoF>&?W6H=n0^ z>oa*C-h7M8N_yv+l#tRN9mR9yKnFH$cF@0 z-)-uzu*=9^^!ZQrv~}Oz4_(umKC5PG?w?(HWuC3&KVEQhrX2A8GkG7^o$h%%s;ycj z@0_WZypy+a%OiQ7fUCUaLi>a+eLLIrK`LJ=@v`gc{%5ziTCXe5%vSgsQr`NabDl2u z;>PWHpG3{-9td=sT{Y}opDknNbSr0fuHzRn9A8-kT!Q?=HM|^y*y9QZLrA$zVV4gZGsp%Q;dHTw2k0 z_oZ6Zvu5Rz$%$fp!HFW%Bl9;2)O=YQ?aIt;_$tiHC(da?#k23Xc3q!v?q~hJ{&?MO z;VEk`+o%=QHr1?}@ab>NS`mG@J@1_2j0{?n4}Hy8a`szg&C?VAmvMYxscf^kvo7#W za?Ydj=c*$ zGT3iu(RNsRvpbk^62ymq#EF6)_!AF(zmajlzT9P!lS@xn!H&lAL- zx4X;i-lEN@TOZ2*)WC3lWX$`BhB@LX?b7O+8(WR`Pe@r^d+%FE%v;a=m3I&F+-O?z zJnY*|f1!U*Bdt?{7MuRfyW73FUZtv-GiBlS4*gQC&9|b`?(pu>Um|T|vSQ8mV~j>W z9GE7a-XvU4qrOW42$k(LB0l;dwsu zX_e=<+dMMMH+!F5lOQH}{2p*|Q$t40H`q zJ{+P~t0T4at+wyeAg1-N-z#|i{cYne+++Cn%nG5K4JRU!r#Gzl5`Jby>iUrRU&Tr; ze6qALHvZrgR-Z7zVy4C2pv1_Jk6+a3o!jJAcp&6>c2d#NuRS8SXP)yp_9(N3xv*1DLCiZ0SNU)qU;U8yAeRDv#+NYeZ4I!=j zWA3%QyTT|qt#0!hp+!HN6TK7cHaH#QifYU0TwA|DqFV0j<;^Rc7QGex?D+C7`=>3X zRbj1~Gc*2P$-4HZcBQ3Q-^J|`ccbs@*g32J>BR%h!q>M<)(O43IomxNu`D<0H?+=8zf-yBTGF2t!TcxhE@`uTv^7qse?!hGF82Fh zoO4rFPTLXQbI3TyF*QQkMAU@grP+r27GF>PT&Mo=*qvyfo8HU;GF{gLdw(eOzDidM zeOI-4+MDOmA632lLmT ztKU<9*z(4Klxf#y)-F<?onX6)PZbHA<(vJIY z3;Q?kTCJI^zW=m_+aD$=UAC!S@>;a!+TP1DNB`CDsb5s%*O=WCm-Fb6ztB;q#h3aj zc?IS*HcYCKSpG8X_0Nr#=X;(O+-SLBm$xHe<(X&sJ)Q4PrTcPdFL~R#no(_)!yNlb zlZv|kdxRQYTylo-aLk7PGxu&*&)a{7ba`D4OGkxNn<_gyQM1Fc-|8Ey?+yVLV1H}jK-!nMbz^IVh9b+*Wx z_u=;A{Ii)#SLUs~aiU=1sr;gs5q~+a%<|RiH1VI%p0l|jH;a+WyMB$3vE{v*?+;AY zqzg90t(5ovx$yeoQ?*O0?z!5B{ZUA_5h^#*cPu@3#c*GE`9Y0?KI)n)6?sBVzUp}U zB+6fM2CIpE$>yRRjSr@^YCeBc&*>=Ubo9;7-Kk%)>lKzq9ARYdL)9O(l1I;)<<0_m}YrFHY`noFvV)+iEiyePyiQ#ms62D4#FkGF&iL1g3x+Ox@a+Eb0*mKi9~AewZY%mR zZ+mRGT6cAW>YjaD1U@Eku}D0dA!F?R_s_rHg~k2C^DH`6wj>%Ve%-8RWFPiKv#-7< zcbdTq|q(zGohHd%|>l$pN1Tz>1aar4*bOLs}k+^@S*pf_o^ z+a^hWZC?u|9-kBP=k}zmxnw^l6EGqm*jd27K^-@_TyHG$%{Eci&Gr73Y$;YuitbpUCFM_-sa@)SOU-JV z1$+0qrAmbUcyz~Ip26tj@{fh8hs^Er=fv6gX_OYPZeC=4Yu3d1-*0+fGrVJU@zhYFGEnR+V)x-Epg9QAMv$cWp*yU$bLXgy2~%ia>k4^2Wu}1+WtMW$IkOK%g>kzD-&Nm ztqJ+?=Wpffi;V@+5#6pjU7LF!xl9VYUe|cdXTtHTj|+cIvN}+I#h$~bVZT~qc*vrV zFSF!#ZwhjmbLbG8-nGdWXY?*CJk|Kv&ewO^@x-jqvmdr;1WvkmW$mBB%on96a~qB| zrXR`AdNa$#XT9k3!n=`J(wr{%h%mGTZ$p0xu@NoO}I2Vt-#y z9NRoIgFUtag%@XEEo-`$F@MQR5kmpLB>A}#X1f^|Z`R(IZFBeBf^Tast}0$PqkiIB z#)S!$0vxNGpKogs_#i&3V)2m~J>LtvbC=B(mFJn>!5g@(O=jPw7f00NoYgN|SH%~9 zk!${6_VO~L&)m=Pce*~PDpzr-zxPzTtrR20D1F@L)`9z~7dJb**f;S^b6xtt^ixN| zp8p^3PZ!Ee+pd# z=bk(HKWD4_G2*+s{n9(Rlw)N=xh~iC?)7!Q6w3C&mt*}u=j3JoS7gSY@vz_eZsyjA z05#w3(G%+@`OS9cTZL z+>?(@|No#-gxz>eg2Wqc<4VR`ongN`WtL3o_+zx_>69AnH62(qL z3;r5=HhGqwoo%nVaOaBI#*gO4&(h_4a7pL6WKr?ugY%R9=bo&KEGtL4i@ z%{Vjzo_sgHQlS5Cw)MZ1%}-)xzndyn^2y8k@$#?7YgbM9a_Y&usu0!L8LeyrF%OR% z4)1G|(cvwP>@Pj)RlmcS_W;)+hB7`=#Z6J)_cq$<)m||*QeB^>^`-X-pPTHYHnWCh zpJbQ2IL?>e=FjJKaqEvgw)I}Y%c|xbWc_}(?h6CY^MA2RW8-JvzNi+$|7xzsSE;fk z6&t)w!xLwiJWhV8#riL0;!}&eTDGjIC8iboi?k0-TdtH+_{I*3ic~JH3WV-@4CHpi9=o4#EMv5U6U0We=YTYoYz0F zy7KHL=C}7${g348PZDwXn`Nxdf0p5uV}W^V#?!0SlS);T8FIa(TeM`)l~z^Vu33?1 zUK2Zg$9X4yttZ|;kEXmioN;!wPh`i>X*}kQldSH4Oc&hMtjOfHX43DUS8o>n`sW)RDjvyv z;$%YJw!igOYrG=QRxI4yaVUG%vMtf#B~7e{pEC%vy?9WPnia)!;AiOr^ADRRWW9KG zk?p|qg$dbPpM1TtO~>gY-^;TbKC~oy#wMCY1exh<-dy_l{^@j$ty<0-CqIwdq#ZTWQXIf5#6 z0^Adw9)+^|lr2)~NZzF5gr;^j|US6QT;z7rO1Dy?BD=SmV)Q@Ve42k%^G&(fLV`uyu3x3;` zxjU!M+4-=!<5A!KKa1};*7I#PEVnrlCUZ&M?e6lBc5jF94W-8)=v~|}A>P-1T3(); zfiTzZppC~@MVO>Ewrx<5m9y6NJ9wftE6Vy}i`vKJ=-pD0hSr&89y%uu*Y8`o@Y)`^ zruJLY6HYgG$#d_{xS`u~gU_Q?AoWw`E3=ob^0)Ob|5zHto)Z@RQquFswY2&r22UCf ze~LeEEvbCPddu-@70WQ2^1aE1dA}~bkumCOs-2lO{o1U6{NgR;??OL&x}XBj-zBJ_gdg2Hy&+1gQhn|i-R zl&>!0-2c+xn=N0TZ-x^G_oH8u@oU6l>c48=h+~}M9QyY9yNN179Zko-tTJ1j$GeK{ z?)7V1?{mrS5^VIHb0Obor}I*tN9T`)vhJCywD*a@w#LwR0q1Yb5fNp4x549M-7VK6 z?zLi%*I1X#4E%RjQo{3A!xYoa>XP3}zC7_b)SZ$Wv~1U<1XsO+Y3lO>*si^6DVtRg z*qs$ozaxs@pg=?XWuKprw%l)P??#~`C-w!roHB#4CNlQ%kyjk%o)@NNyUhz!)HxQ) zr*vfDzFnJUZQ7`t$hGO^*7Y~vb_APSa~8KO=iNNNFx@Zi@*BIS7YuJPx_oXIoH+0D z%+D8sCk8fdW?vdSajVF)olhIWZ{<%zyKB zW#+8=v&HAB2x)n^&5NBSmgeqY^pGn=@xk)G2S->oo{Hhl>bP!v>DINm&tD(xzM5X4 z5qavQ5Uazq1v|NUKb`9eGzyT~y?cYh)YCG**?(N<*&DfhPx!3$?z(H!m$fho-~6V$ z@o;9S@pZ}8VBKnk&)4g{nw0`SSkJt0HRP}EH0@JmUHviI$2)mr<72*>RA*$!e``Cv zXa#4ca?j*ljLipZ7B@|BPvV?uA2I31lh6=Bt$ku`mtU4fD}LT2JZt6qD2Enxzw;Fj zH|y+@VlOP?6#c>@y-p*cdfO-CH8#`F@y=wKWLvl;hSMw6(B|0oWr?wM^@nfVTI{*) zP!`vgTz>Ye-LoDyacX52F*aufcS)`~yf5q9QWxoyQrBMlAK`ztMz!OzvgvjEL%p^g zqIQdqcYZNxJaJLY_BzMyt~$9J`ZLRuvPA;U&ki{^proyFr8nHyugL*XF~bN^Xa5ul1bIvvpyn zmu&ryk2Aj&#{AnA@l)hww$}_Z>x2axr{=8sH%FoTxW~F`&e9jRr=)B>I7h2NOd@E> zS-I<)@-t13u=!5pd${MRs_55)aW0WjQd87|W~I4bj_j=1`r*o@<^F%xitY4%)o@s0 zsmPC?bIv@NY0ko5`m6mE5>E2ev-> zDA+NlC2EZyn<9DDcDG__b-A(3JmV}guJ7&D54)cnD4c!8XVs#I z&YI01!?wr@pT8J>{;syG)w=6v?i}fl@o|uD4hflGrx@06k^FnMOMz2R-1h7cF{SV#XNgI)~$cG`C+A`)%SmM1eHR?JlOcp@jqU{#U)&4 z;xM~v*2jC_SFJTV!tNNgMDNJ_Nm2?EmL2juxPyK6Eqk$ND-WEjUdG2%pD&s!wA;4m z!h)=+yJLiEKUl<_d-Awf^@-7@nGJn4)0W(L+2i+hYQ0m?-Y4Hbl#4kB0$(ODZ^Ev9>^8>18$EF|TWnBN~Rb+#D7tv*-;_TTB<60Lmw zjGX(fJCOlfv;H#Zxp%E?X)CRf|7LV%yLoW7aj=f)p}IWDj%)QEdhQd}r<|NDQ?~H( zyZYk?I*qHRF0)h?KBqRr|-q0d@kw?+SJi!8jd^j7z3(;NKLrLt7z=W5Sg>^wQ_IFCS0Q)bud><-o= zXEwMRtaO$&RAt%JBgh)6vpeE|fL)|P*tv&ay&UUjs(dw@+x2+f* ziPG{vJK1-qprBvKo0t7e8}166blv7DywLOUwubHV%#AgdN;S&oRYP^?+Y4EZxNI9AS%YI-+^yV4_l z!SnO=5>||=#eBaw@7?b>X(Sjm_1@vA*=5zHdS_3#F57!Sa)H#E*S&kU&T1|_xcg7c z+r6qB(_U_P;LaQG)08RGx7?saujS3$bms4O3qiWZ5#d+O={yloz zy2Ewinont3DPOz!?T*}jx6aV=`=SeXUoLsFw(HIRj8o??8CZGVTC1GBhIF9K&k6H9|LvLl=b7_v*?k}5?lk}Q z4bu4-w{msll15{_5Z}|!|E_McDLnWrbkUuK4sUd(`yAEfWA(0@F7LX~Zk_k0d|Q7N zHu1)E`stxNsw(e!&VBGWT!C$W9CNqm1b-^48M^Y+g_ z=RY>8Y+7UMX>*h1(vfSHCPw~O*J!fub^h^6;#R>`2Fo{|p7#2tPxJOmK6riSdPiq^ zQQeQNlMbzDTVtaYc47UtZuau`zd4^MZdR3g-Td=XLH)FsK^`~aTfHA{mRb0q>$2>H zv_(JF5^seaSLP1lP zpC>X-eVx00Qf&5N#&|JLwR_9w9iBG-m)n*C>uvLG4u>!GD9kx|=lxtS0q)R?dMPFT z&Nf+xb#}d5De!A^XMOvM4f7UcS%0Y58enn1tl<0+-nGl0BxQatv0+X4QQgs2{9#(^ z$$eeFy3?!HKl!YawW2G|AV-Rg$H16Fibe0dd$3f%8=KD0MQTeHio^vMehIj9oVRZ= z_m(AF6i;`ndl*gqAl7lE5~ z>FWthyW~o&B=U-yGBUEP;xB%lR9nvyTGwUK=N*1~!rPiNuR7PuOYWAO8|-j7D2(gf z+-dX9B^NnL@4mRI|D;2rk}`*J@6oSG2iQwpU-t&@K0Qb0oX?wwyJyFy9-A`rY|x^N zdHL-vyB@7LFU`TMSi^OHhu+P7hx$1VxhBtD%sk2GfJ4P%q4Y9Aw^iGMe^0)|HRH~{ zkM+{CUdP%@6#BO$V%KxAJHK~K`1+LhLc*>2a@`-6%>QBGevbK^((Dx-A3PQd$tqY} zcS~wx%TDC^pc5d&-e;b~d|UIG-WApptn17RHu9YBIomJ8nu9BNR0P43mwIy z$wym$^_Q&|Ov_??Ai6jE)x~x3r=A7ZOyj&Kb@ZQI{gHEze|UW{{<~#i@0ax~hqm9} zmmjiclC?v?zvk5!J}*jm>NfRgn=6}1tH%q^K10(h2Pzuf!;U$}^p<7kWv)s}ylOUU z-}Bo0W&0~9Pj)}~?)E&H`*X#&1=s~wt$bZlV5j62dbO3CN1S`D#kNT=8JB;wU*z@j z-unC3UTBAGnDd3RerG@&v&1Du8~J@F>n1O#_@e%LMxs;r3r@-M-P^D9G_+lwY%3!3 zx9{2R$pMGjxBSq^l{%`bWTEZDmz*)@%B_il%&v2Gd-K14|FBHVraAHZnYG*Q>sL?V zxc_$51Ji}c%Yy3t#cb!tEM#h$6{=eeP+A_3FLP@4R}%YfpCC^LgTb zW^9O*nNcFIr?9&8N6ycaCwMY1Fssj)q_!pX#ho11^1Y_c9}Yg*ll8mpxh-qOp4mp7 z9LuV7R$8C;J(HK?ns4-fik9N?uKJ5y6aN2ee$kdIDbk?4P4AqMdDBr5GhU&KbMtRn zCelO*_}6tIF%PF$=x5vC%u) z;{4zXv&;oE4{O6VF4fPQ&s5giJmz2fdrKaV-a zyD2ioTMo4P_v|yMa|vm3VEz7LZA`mVrP`aTT$k4Fc;L7usCakv%7PTGIgz^~^=wxD zvA+E86px}oZDp$->uf@}5snxXb)@0<2s;^N$9tZ%e(?F?>) zKk|A~<(Cc3H)ojMIeF*(xr2(=;KBlYR`?ypdIa+sam&_l1 zS+l*$U5l^E)Ky%PFnZj4zQEc3+*9W>Ztql=PdAxbl9=(rSmdT*Vbi1h?#J!dH$SW} z<$pE1>in<0r{7m!^v3 zcPaDEzP+;T#+#Fimo(jZHY2|5;JCotJ(aGT1RjaxFz4~G>dD3i` zTr-~yk5B%J-QAz~)?D!9+Gf!-*>9UW4?WwhUCS78Uajhq^5yhgq52p7cMBHYdYrA) zY0k_Q`1{#<@w;boIIAr*BtBg@{6IoJqAx{z`cm^t_AjFj|2>+7~#Le!ahi~tg9eIDL)qXS6*Xww_WE z{8n5vp_k=HcXNB-0-oni10o;>V+RQ1?UqrTMXy6oEy#jAg& zKILmk)H`R?e`LO|aM$!rW#u`>jF-X}R9yCcEqKGd_pH^f5cAG2lIyvravCe-oGa~;|m&&=3VpnB!9)W<_-gISkM3_3I+@ygx44gRmc>^;=1 zYP#}{$!!+Mmhdh^_|m}?6kCMOsK z-ru|Tt)6{?9j}o98MQkj)%Vz_*x7yC!H}e|Ftph;8%~N7aJAbE_WYs z-#5wH=Ir9DQfgKo-HW$Rnp+cWc1&_cHT&k8ANvZtPi#q=JsVUzohK^=r15 zF^hO%xIp0xyWlrB{0l!W*dzVxSlfqL`RCQtl*}(T>utY3Z~u%d_46Z{M9cO6FUgf; zTP>Kjvis}0ONZN~6xU0>RmeZQcG>ad3Xl6&wjNz{%~$TjvFjV-|9XA2FUWaRw!8Jf zp~$Igb#mS{v~M(iIqkQU>%l`JPx(IuE2 z^!tr1*_XG!*T~>6JEfsnI_Gmu{re*tk4tyx$0$r`cgii|>iyI*^YxSIrkcMNz3X@O zm3wE_wz5*Xa(j$T$QGlwPgczJ*%%S~!e+NeK>VTS`M>9s>EgxF1 z$Om$6J-ybYvivXGkxf}KfgX!j&&|GUwtJyueUx;>Hy0bPgyel?v+rq>O zmiYcluWAlFIJ3-_+1P{OsdJo%sNAfpO^RV}Z#>S)|MY8a&#URaf?jnJ{1O)KcMjhX zEBK%Cb%9zPZuIq=54|K~Xr7n_p zTDtqn$;Wwe%DPL!zsP)yy5px_HTOt=0pqp}2ex&_ColefIKuNl{Vy(g?dGi8c4@_b zc#^kWh$*k=Q#6~V_ipK5_F4588j};k&*)iye_zsH7QnM<>W%*6ck-qCHsrmY`9b}M z7|;ElhRe$5k6g3c^CUNGVV$DgrQE5LFDvNeIX}32U0TNboB)&5R3*8%{h`Oq-y0@A z3@Nzbp+2|z%Or<+XVlk}pK7ds!?xPo_(>gq+Jm;OulxB;RgW`st%-doXuj!Fv{mkd zX8T6w{x^F~P4?D@zgT;nd(->{UrJ~7Khb#0n-?Z$tx|Z%MtOtZDX%r(zvo<2d?V}a zwK;U{*^R%fnx=^vZql>Ac5gx4mOHbARKyNe2k`rFGp;?l_wKB@;$a(qo-JpPK0z94*1 z*!=X`qAH{7*%gu#EpMHRxHwnh@O9T-sm6JS_DwP8cfFW2d78jZwKEUysrAm`n!Ws& z>(9-mm#f*^(-ORk8JB?xAdqA9$a-{XPju?!Ms@&SA5++9axv% z!Y}xj|LeK8em-;MgKk%FbnssEzk8L-QdF_?$%WHw(#pmx9WS32edA{Bh%H&oR-Rw} zMd$EO^-I~O>Q(eMq-Wi*Ve%~*jpaA=CHb<7oZF|Wq_WQyThd&DU7pFS6B(FJq z;OgJMYtr_0WyF6GH`=t7as7lP^Dl&PT&%oTllk$MyL<50yB#X?xD}!^@7`l5-g!DQ zq4e0^{8&x5RvxZnamjNx-l}8ssQeuDXD+X~$)$Lum5-Q>r41761Ls}v_33@WZ!3_q zLv6_-ljXM#J-f0(e1de|;RAEUxMv!zXchnR=ZW=8^9j7_`xK8zaG$A854^d~wNc8f z?EAgDtBa1CIZW}+zswYSUP?lQYvIBT#n$%U&MheaP<_vC|A*L$3l7Wtee_`CtHXu`@58EW2m8fl0!_nWbxk;r*+le7GzFv{8~Kc5zhhb+%H{A%Z=ViuhCsweL>>Y{k4I2 zE*{|xv|>M3bX)Cp*oPE@S+f?VesJ@NI+wz6_o(i#`)T2u&+MPE)0sEnSKw34H^1s9 z9r*Xdeci9fhY1YYSvJcOe`l-J&NGs~`1j7ln6QQkUzCM!aMfH8|D<&3*WV(>(8-Lo zzc}yOuT2)a{FWyq?o+q-sfl5GF1lr2P!8W)mnpuo>Sm^1Yv|Su8;!1}ty(uju_OA) z?Srend_8;d4aelUtBiL=h*?Tx<=Hy#Jb%f+_He!1_w*|(FPF*B6kX_`q&k6_jKe<-k6JX_8Gv9yW zLA9BDS?OZ2qRroIk4A4|nG_M?)+`;gX^y*t&}q2~-_NEs)iqDNFz@c}-={9el5oaP~j~gG3GIx>M^`wjcc4I@ztqIoe;Q%iu*m_r!FewI9CMdrk5BYJNTH&0LAS z@ekG4E`GBhaeuPC^&#aGinWRGqxE~b8=Yv`3s!h7_?sPKKWCwP4B6a#GC|;@8u_MqW=kCGo*R|0-PT!jVA&Ce$mHYvO`n(4^M(bU(zv&5f0cyn?~1Rhw;tQf zX=M7HVWv*S<2N#s8?N`1M?aL33E49xyP_qcRV_nke?eEbm{QFGRGShu$x z>UiB`GdHWZBWj7&3x|c5Z};5W{P6AEX(x8v=dKrK5L8(IVBONmY4cBG{83lN^G3FB+K*FXYZD`t_h8@ z>ECVY->0Y4^WS-xclPZ^R>t)?O*=C~&pcpxSUUZ9baGYn@tUH=JHF@Mc=KpGk704f zYQusl*`LkIQjI*%vEEdRnF(!Is?TA$|Cl?U6+G* z|4}h6cCIln5H6FS{-fDhmhskZUrvL9#{vERv{kY>XPip-Z8P7if*ZGYk4mQUB zG>$6w_Q;&jwPv2%t{eOz+&fO4I$!2+V}|$veajQoo}Dr4rDjf?p;2_amg{yt$$iUhfAz2mreVxzI)ug-mQ9S9%?F#5W(NqnDEZbj3r@7aBMYSE@X+czys({^}i z|1Y@o!6KO}@0r$Ur%tOquA^pYBVD@mw1eneWAkk>)orh3FI|nP4OpkQW2OCu`O~%u zWzPOroN4X)=vHgNKf`MWDzZx+pFeXt?N;m04R-Tp3)(EZIkD(c`<;tAOI(!eW0sz0 zx}TA589sx#e~;eJ8llAS`;TqS7+70=e!5p-X|Ss7U6<8LV^Os=CqKPQ-n4JYLVNX~ z3HS5c^kS|_=iYhcxK=&uUoEe7jDcOsm3zM$K2Dx-;=Q;0t4Xdmm=8Tr-R%Cl_C@35 zoBJ}uJmN*HriU%ec9dbvsBX@fy=ZjSVK2XY)<}UXOWv{E0lN7JCU_QL-x#WvpLpfRZJ}vJ8o?d`S$nYigTL% zfhy1bol5$2c6YJQo@>)5pJAKxAoKNvZm)HRlsvoDL?xH)yyJE`lVj_z$}cy6tS(e< zmp5O_UcbSripBq0zpqDq#AYAkkL;~ESM3XP=j4R6v!4noY!W-M=l5IN&6b}{d~ZKH z;FlYbxBqCDN!e$HFloWCho=G;pJXNp zT12PS?YVGa;@sQI1#t zmzO?<84>$5_Ps0ls`J_3SR*@UWq-xy#aE{7jAK)?Kd^6Oxbw0=!=7-#tA#QBmbcEz z_67Rp9549$;d9#>*Z*@CGFD88dm+nLG2v;a*V$uRCb38P2Tb=r!I6-?>C=OS!hQjr zIx4bD_le8ZtX%l$a#g+bXW_4hMY8tH&GS&d*kG;y-AeF!$F2r}bsJAvM0c!JwUDul z{5Z?5Kl0W0#g|q-j$5<;YO|0&zt8P!j!L(?Q&%4mj|rQ3^v_3$wnx8yDXeAoIr)8_ zkE5sDmaLDro-qEbw`P;_$)3C5&#b$4LX4+3cS`!kW!g$=hFDjg&bz#5V!d|rxd-be zdapU4yJ6*pZ7i~^ayGXE7yaNapZH54Q@!SjT%CHh9#3cHqF<(=(<5`3)+>IqOt|vz z^x7q#*}pV5N2)bCdF?$M(3rBSWs}c~SmUOt2|M=R5Sjd6JgU5U@#Nok`7L>cezf&B z-CwiTGwgR+f7$}3oEiM{r<{_$cV|Lhz22AjAg7*5uM`&6%LKjpe0TSPx6{*-&vusx z)%Nb5c4g_eyZVW}EpOOgD2vTbJ$j5aHi&0NpHk-$!-zDiI~vxN?PC2sDSrbq+@I&R z?+T4*KFqPJSmB|RzhtSU-&eDmBU|0tf8E}t!4-EaA-vOjuYB&YTgsmnHF2vZW&A#3 zFr(frJ=OlbaDTK!@Yk-GCDv)S4+OfO?&rY1(+K!3Dpo2K;q<4$N0Te#ffMf{)#rl2+W$kzAnDiSny5WPx;IBQWv8$@)h>KEBP^Psiw(>=W-(>FF*dJ0W6CSG{G$ELdZ!#M)_<o7TR6RB~$5Qicy- zD(*hp$XQh`BfQD;*RHxfPDkg;2Ij3Tk;`2yu=NCE>q+lVOZ=B5=%x$ZedMhJrEu-`EkJl&nW4Eodt}JIdwPW-1Jx{l94?Dzo^?P+->w<{6 zUD>{qpXBW@%=&XHRr9i+|FL=9-%hODl+LGmlzHFs<1_3ph_w6;{e6@F$<$hAx1Ca( zo@$-^vTn;g!P`P-ubwkXWB_+uQd{GlS4$3rjBF^408S3byT2{=H_3oFbBz zCz+i5XTx+(rv0u9?!Qm|c=1)CLtf^uQ;)xImh5$Bmbp_}P+^%QJtL+=&LgeYUS0pu zn)S2pEK>jWK<`7>S9=+s;F#SHB)$vQn@-;$z1~_+_4{>}GQ03iw=d>yNl4qRp2X)- zFS1?zEt6jD4(o|)w*Fd^!z$o)XGTkM;-cjhDKWoi*ee+_+&K;`gVXY_863<14M-{^W{t)`#yt`3IcenB|-)+s)p! zNq%nX*`J3GF4(+gwa$C~xX?*i_Vq;>OSafn6g_0yc=7IMjTdq}w~koV^Z)W+CzqUA z_)hGcRsH>{-FL4iq!g`4`&6g#EnoN7^d+($hYxj1|G#9YCwDC>b*lS@^EJ-W3ngDB zPI*_>6_TO)#i9Pw%uUT33$8QOsh{Ed`8YZ*Yjeu%#@r3Qh0VKW{`1pu_Bi}T`G=0@ ztcSVwb{koYPD;(+dE)Ak(3*7>@dpwn9)4P6#Fx7JT)oR|2^O_P-A`VceD_ovdw(Xb zU(6?WXU^}_{y~X#t+EZPe_K__m3?>a{}uJhMqKuNTxRCfk44KC)H9sf`0>PBtI+oT zCv#W2DD9u?>gimZsOQCa^BR|zfTV?diopDsuc;fw!P|TohS(0h8P9wvi3$0A4 zRZR-(SF6_49$V{tV_ALAFEhq%Yx7@yYc<^bf99uSzWf{h)`-7Xj}^48x0|_dXROcv z!qqR8dQDD-t;z^GapsVG@&6ke|4)=&-nD7&+xkha8Q;Dy_IBAO=fAFfi3P*4Nb{*% zif_#R(kLO_x#n~9ug;eo;i9ghyFZ?fl;0iK_Mj$o?cBvTXGcvwxY=Xhk8J@PPEIIp z{IWOp=K*%pen*M9H+Cdv=I3u|d3@66e}Dca1}#U^U9!QmF3xKT`6RUFg>7mNs)s zB@Hs&A62hEx2S1((XrdDiZ!hlJxb;+er;+gtNFxEuq^dcci^o!<{eVJtxg&n<1d-B z8qZky?0A>~Yw_}@Yu>!(xZcCHJ5zl98}(YB`2nBJ&#P~>VKlB+GfZ53_koqG$oJat znc)cn2g=rk>R1M^c%HYoxMRUh-`5=GzJK;dXt%D~eld9Ag$h1h^&p!$Ck^Z3(*v&@ zlxIHK@_dEF%`Jz&RH_B#Uy|VqOv+35y^s`Hs=Fp}!uuEXUnbo1{XRWw_1V>1_8ME+ zzS=9aoY(MISHc{xwDgmI`|9JDKWHssT&?2yy(y+W+`a3?zvMqLiyb7^Tddl)VHy7; zq1_!9j1nJeRxLVee)m^Zs@UCt$y2t!ce#??JULf1GicIbYIwfGk0G6 z{XDf(D_@2A9*W1d7l!T!y{SEX^kp@rCEtO{e1@OBN9&rEB;|WcXTR`c3$_wyIhL}neNoC_RaX`;Woc= z!NyGyDo3wudp*s5<cDH)dJ+3F~I$b|N1$+lRvpzOpDT$EK9IXzyzh~TNE)#XYW5Wm5 zoM^R}?T_u&7TDBZmX_}k_!b(w+_K6rbnzdTqn@7S3trrFt3Qx7FX~B$W7iFHo0NI+ z+naL>X4LT=cwj5@avO+C3{x zCnZ&D;~H@;Qcu|Q|{>-WEI)Qcu9O}*3`&vqqq z?)sE2XFKiY&(T-jaBk&ga@r>^GJPt0MD&H}+k}H6CrbyE{nW}l`tGxL(cJnvVPVrl zLe;l&CEBbRxQm3duNb?i&w9+C$M1MfXvY$c4PMLm=ev0<+*rh!oO!JxC;jxFXsxGg zJ3^%n>&$tz%RF{VXV|>L#dT^6<}Ktb-W&A(puw#>%L3N3FRO1oxqj1n>rB4lof|m& zTHjn`2tVSO0k@+XgeQ8ux1B+CAr#C0$|4`t?tpQ)0=timNMZwoF)g{BrLK zo>&>?L+o3FjVl*kzSfm*awF`yht%na>hu1kx>elXT|YV$VjcEs*6i!&a4s)#o!{Z| zW8nMVr50XR?1euq*4}wZ4mUbies^TstZI<$$L>r(|H8f5^A9?tJg6I}0ZM zPZX&!|NQm&1Z5H5nf1%%Zs&b*(VVfjXmfJ?<6ebbd-lc|U!Q!aW4Wr7%fd4A=q|%e zS2}+&8f~eZ{A$MfO#xaxHZS>oJSw~Ir#PtV6kX^O{HZ5ly5hDjN>Z?t#b{?fnQlTlamjp~d=o$TUk zH5Z0DZ~rPa=kYSlvYI{J`3-k&@f2USvi$Pr{wvLF+smbq#OQ=DNw7!oHb&w~2_YZ}51S$P<0nOUWU2@v5JRr!Tti^N62)q3Y!R zD>I`veq-~_DX?1qj^$G7QuFBL{xdQKc57a4(2puv|0huWGqcLUALp4|ZPkTxw^c2R zd8d<*|LN%J9W`HHZdz^?viY^n!zEq?>I}!eN%O8Ky!(HJIG=-GFvpU=ZV7AHv;7*j z|IV%#H86`YV1}EV}31N8h_9eMSMF6SmHIV6t+3_}sh# zhi40f1zUE>RF}_Exx}wsc2RC#+SRn>EL+2zD*3+aJ-8iQBq9{@G<=QJv_n_C?{WK0 zHoI#rn|#`6l|55^+o~NG>n`ziGu+a7l{zV6Ui7 z)!LsN5p&+3UvJ|6^ude^tqUYNoAq~}x|KcaRpA0DiF-^@mmlp2u}o8nIU=2M>Fu>p zmr~`KKj+H62|1awu766Lf@!byH$l#x|Fw(;3)PapNlndMDm44F8}D7)K&3i%y$4%d zb9=YV*}2(Iw`bd@dS?BeJ#q(sJP9fA&+lJ#M)vw?-pBHdZD#gA^iOrJc^SLjWlgk> z`Tf4Ui#{Hu(kr@hU0SaerCv$@QE_96zhT%0>mL^j_T25$d)?YNvy{vC?P8O)7lmf~ zS_dfge4an`%!LGfDZe)Ve+7Zc(R({TJv6y|Oz;2f_Aj$E6vxo$oO4!(uP`C( zx$I5y3i_;!$nEL5%^2Zf-rcC@}<0LF9 zx0hw#uJ;DB?iVEZsh>+o@%{4rW>5Vx%WHb|=R)+&O6Oz+z23-O_jFbT z4f9LPe11%fm^9&8_2~97e}PJFwyzgMs)su%#9&z3+9rX3~#n8DA)0OwXThy+W&aV?D^|n@? zYw{))KeyK>qi>k+l!;lKH{+?Bx#+IA(zBbqcf-{ufb3d({ z!6vlgK&Nra+~udMo`|Q~eA3_6pqS|XW?}i|U%l2L)&71=^CvTCJ+ocPX!Umu^EGA_ z>r)WEMi?*qK7p>Xl zcz$`keb=i6v5UhscD<_;*vI_RPr-S9q~j9ag6f8Ce6}ABU7nh~KAgKOh;@-$`>Bax zN3Oox>(4>Q*%3W_f8Dg3})p|7r#ZqenDES$FAk};N*b(;9qKix7K<*!cex%BbS z`$f&?lN-MBd3Z^b*aohtSDsK6v{f`d8kmw>(wrPc1wBV_jPgE6bhImyevPZr$)&lgH1L zBW7@WEn{aw#RPDyv~aiz`t-D#P zviI9fcRBsU?)l7HqSQ9O*2%NnY0|WrRU&zt6Q^Ei)BHVo?*%sIt2egFCc7r@oA|3< zY55!bd0(D={&(bAk-71?8D)|TR@?T)e2?pwUYea_$2cwTZEBsb`o-|DPg2|Xmg|-7 zDEqeR`pWrD7sP(-P>E3a+1h(HPrAFFN%NJwIqM7g-TZg9Ps}q-TP?NlU+?+l<@vvE zD?GDrZFuAv*|14+^*S*#(}Fy;2|QeOCpSJ=-B~YOEU#E%YVI;&_KH=rwzK`tOv%nT zHvf^4UHuI8gbJn)Hm*IFPW@Q_=+6Z92|07S)|#KVz;^$Puu@LbB^g%fy&Bge_i5D$ zK2tV~n{E1rQC*{`xiK|o|HO6i(?838IC`_N^3|WC$JnntU-osbzs`QYlHF1XOMOz3 z7GE!Ft5)6mvObuve4gXdKdqk2Roqmb`z;B(rMdt6p~Rz%?fa$ku19%WZaVVd-1QA} zZ*5&Tf%EFMQ*18}ut}bpdbWT1EA<@J`G&@lvnI?i`=8!iDR$HQ~Qk>0X#$J@JIU03P_877v;`xQT5k=Uoi=9m53R{D<1l|GX_^%mg`QrlhSZ%ThW zkh0|NuGwX2au(bEOu9H#>QMEB=|1Z({IlSndFZ-YTc()MJO8gcBsZUJQh3vHW7_Fi z51*_Q=saW`{9pC;9OJv?xo=+>-{$|Ce1EUM=;KK@W_vfhEnJen<$4t3g4X%JX5F9i z_%WNV)UCevLe3S=2Gajk`QPn!tbg!7Zc69Ru8mi{Jj73W9S~i>!MqSd*J z&wSF?y~#TB%9d)r*ziU9^BYD%WHv}>KB#=llpg89Tj|L_HDE6HH8VA=YN|O zRKNYCsdE3bxS+0vPYp#(dFc=3^S&xCj5=VVp}{WpRO6a#rFnDh54KebvP(}&|M|9i ze#go?e|XEIU+%s#KdPqh-?={zrdMa|es3JH(uTR~Xmp2O*_OBBANsTp2!=dW6`bBu zxp$Am?T0J>R&MWqxbg8?B?pb=Omf0(_h$-u&PrNc&l9-Ss6bvJTDiT+_}cxp&>eRz zTQ_bmYFgFTQr;vpVVQVj*ipYE=2btQ+8J9+72wI|G+pTl;W(&+UC_ z1y^mJuG)6_iH4HUbDk;9+Ke}gzAvtuBKw)|M`del(!!a$^aD8Al@r=lmKU*F9JKzif$@e$KOmB)x|WB}>!O5*{&XMBJXe zW9JHs8`>5Hr!TIa5xvWEx72OMeFkL~MMZ(>#mV8>>ss1 z#d|U@ez|_Ef4d?pkFQ{>5qm_$?U~FjqEojl6;)vjnZ)&q!LxY5&d=e3UU_O|*OoC@ zW(OB9=(aRHaOj|9!uR*A2d*$?r2X~Jtk>g-k2$2rklfI{c<0Km(`WBozH;YddjZ)4 z7w_D>ckAfW*OCcunKqP|vF)mx+qjzffK*1-^R#dNOz~yh?e(fpUcC9R_3%IL-%7zn z1%;)CrQ6C%SZiEEg(m+fpSLdT*t-8m$~OLMV&oHxw>~T5bN8R-%lI4OXT@J-T88q`&zp`n&tg#hbt4Gk5HaVAlO_%xu-LdFRrNn`h45*?n64 ztoV2P<)7!5GX2~Bs#jL_?Vf*6-+ovh`(K+qJ6ycjnw!lcZQA-7%httj)Lq+H(DVOG zx5b`$?gtNhCs{ITEl-hcDL|Et~p-&XxszxVwAsZoc{p7T3+-rTiw@JS6lYK zX=P;O>|0F#1DpTepI~|6&Hig2mfqg4l^`;4@}&t=m;JT(xm}+d_Ujc_xT(H-@qzz6 zOEljneA_SfKcKV2qJpXB#Z1c`j9+x-_{2~D_}Z#y^M;@Q{L0e>uyXe1&(k0MpT!nG z_5bl-@zW37xpVoBNM7m5gHz0psM%^C-pXg4UlHW9egAaH8jC9%w*U{irAJ5r?8T!*?Q|tX#{d8q))YmMHSA3=Bs;>UlQDCv7 zX40{hX+7tkHr+96;bWhC?BIOQRMF;1<{F1y`h}&>IPLz5A?W)d2A)mq?ke_|x3pE9 z(VL}-2|LhbJ#TXufj@MO=i8+DrM_b0{f?V0ml%GX{Y z{*L9{2etyW^%soq-SuE@RC&p_=4(e17X4Y$ zP|$Q?yU)4zjY6eM3YR6Chim-)yXX4}9~RB%Ek>_q-hCIv_`O$qWygJ0iIow?=a<;# z_k1?(-Fjn9RHf>*6(QF+H$MoKceyhq`rog|i7H}GbawmkiT`<5->JGTcf#9j9k#CE ze?NZD;s~|a*8B8h_^Kzn|8(3E;n7|d%V9a|d;gy4$&=cR(*>tWg>t(!PX6`PY1t&N z*;i*szu(TL?WegvQ?w`k1?!9AeQeE_LKob3UneOaJu^Cs>!?p&b)U=jU4^HLuUpi$ zhZQ%(syzL4kz?;Njr+1P&KdQ`j>cV`@~6=?lI6wU4}$A|*Q$q4R1ElZtf5xvmRds4 z&5qu?7Mo>kmW#0|hdU;?DbH`4oglih=S8~7Ek^yT`xxAe@|nB77mFzGx*_kqU6g%t zuC(9n^sWz+j(8k*m~(j=5N7` z2lvg2lelkvJe7^JiDCWg{YNw6KFM|5sYu`s$$u=`)qI(0x^c$YRoeNtqAqqmc{a7R zHjdZw^5vsXKAmogx%k$o&VK#d37<5R{kiHpGWp-Ep8d+D+NN{1;m0Q@>%NHS6&yA= zV)N{EX=}mfDaJyFt_elPM>C(#+F-g_Zjss2x37xa)4q)7J|Y zoV)Y3|4#j?vQn0;BFDpW|I_Bl2j$o8+-!gT%;a~`3tzl=n=8y`_0R3+wkXLr=Qo9V z`ldZ7lex6?_Vj0gCDQ*BL*E`U(`orw){>{TL)3s*$@+7zO!qGtGyfo-R}cPf+O$0& zK}I9%bp7H7)-h*a{(gC>VA%YwreBmuF}j&PO^fMO z)AYaM56}PF$g=Iriuk1Zyuw3=7=H!(-af`wqI-$4c}B0~-$jz!&MstrKY6z6{-+Y| zQe0Eimt?L8I?=?m;(EXgi+PKGa#R)FI~O%Eu z%~$9YF1*aUa(hYHfeZZx29M_-d;NR9 zL}Y@{o0WG(=KXoT`ShFY>g-!HVLCKj#ypf+ot=EGN^ zH8%QsJ8pk_Jb&2~-`vxFJATI2?c1@PW3S`6y~*pfKP{U)olAJ8>$3f!@{S@72V{e- zqwN+HAH91?z3;31J{Gwtz58cIZ%8{k=iuUd=KrtDg3{cDaO)-os_}x-;gc z@V+#xSgLL9&6!{HQrl|Z9>Mu?R`tyhiO~-Ktt;I$qBS~ZRq=mlKA03yx%G0`i9`I4 z)ERPBYy1_?aI$%?(6rOJ>&9~@^RBMMqsZk)70>_i-Cn;=CU>Dw+`6O3jf8r?^UjYC z{#UrjmF3$z+rmpe9(=}S}yNj-hbD!`5iGA zruNq^>y=;LHJf|KSK*B97MHyk(wAPV>AP}pec#%b2D1MX-=wJYESZ=3I{VD7rDmFY zqyqyp6SYnMp4MI&Ue7htq`$Q4zQe7{7Xm7McQ_tbd*sYzP~vB|*Ii67{m|2pNqsp9 zuJif=R&M<8@yZ)PXUXrD87DFheSOU_-^x5zvz`5I`mHn>6A#b3Ref_B9%L76DSGML zcbs9Oq)V0O{;+B3Qv|P>6sfTtk(OAMxl(~m@#PIx|6=p~U11U;vdQ(+jtiw`O?-Tf z$0N;sM~R8qOm>|Iy|yKtRnfPuOs`*5y6tx8*{LfIcbI>>y@)e+`8(TRCdSoI*B;IH zy_ip-S%+bcX=J-0#X-Nvfc4dW2=IMQlYbxx>s_yQcA<^2DyD{LClbz0rcE%k+ zvy3J?PLwWIS!%fVAnT-)%P!d;+Agqip3P$?3C^xpimh9CPZvaeRX?%*Q1r4R>=S?U z>nxneHhEpBj>RDl_j2Z}TQ80$zs#Gze)1>HN%f1~#&>J|-Tb4yF zj+rx?WG|_^2C}T1Et$5?>(QgxB|qfYicCXW?7!||cqC1UQwIa{Iw~1yG2uPZQ(X@{&K3e=BB`M3!WdU zZZ^#siWg?pvu-V7TNah+({!b@=G3|tUoLGHci8Ie!STI?QiD_ z%u1g(Q}kZlrzP?WnzK!3?`igJi)_2#Xs0{v&5hH`O8k`VeSLd8J$Ef}4_T&}@^d#w z*|i^y0SlW?YUb=eD(=%5|BUAqUv<~Suryr{Z@z5S4Qf5dt?IY*Pw!uPui1Y>iDh*3 z?gKUazUyw@3auW;?JJ5+eH^OJawoE3)~ zyZG;UJbwGEIrz*I8qO8ex5=9(hwh5En_jg#Mg7~|{1797eeaemFZ%a(vZ}I4Z_E2X zF86-u@90fsGZ&ncKE1wc!Py1M`yHyg@8$4Ri$$HjnaOgqsFV58>Ux8{|9eY1x%_@f zEc-F5|I?h@J$@%@x*ndtcGzWx*2k-9HV>VOrzm{To!+)xi~akOo4F4|Xa1|#+VFC( z-{eza`L`2Add}xM8ElB(`h-Vp<@RlVEaq6J-_rMxe&%NK&iF**>G$_^rt%jXypH?8 zeeTZ&+YlDxF9%*7)GX0-*PL>lYf_4X$5F+39nKAb@3;<@FkcN#&dFW7vSVAd(0Xl6 z6_Jf^et*3bk(+!=`*+1gfsiu~I3oTv?W@K#KL2u3XwT=@R%4w75h2*VN7FALY zXj!eyt6%;&lHb#Rec{0~z1Mhu|CX)Jzr^+T>4y{k8a6MtY|l*ES&^`Ef~8OD{O#A5 z-c?ZBwdJqm=HN|hCLfN8zrbociRa|MHpLUyW(3XRk#D_G-yl1`eE)HB5QYrSFUv?m52noqrKe^vTPMm)*^rV0c}8V}hqvo`p_M*~aSyFL|!*Z$JIG zq@(N1@;yI#`HjvQZCT{&^X_rVuaiw2_Ng-z72o_*SbW(J+n7 zsnSg>yS)8)X~uIQuGK&G`OQvFTe={`rHN&eg-XFrhWM$=%g?-Apmb;X2aTX70l)pY zF8uB32)B5WaZWDZ(5gjQ^{Re*aqY@to`YL@)ufI(u9m$c>3P(8yV>=(k@cNED%{aa z>Th}7-n+r#N9(@w3bVTPn`Mj(%$G)(HyL?X=_u`gedX4|-Lp>jaQsY}HNUoAZ;zL_ z9>29oP}`Jqzcp_p-EKL_6STyV`{*LeNr?;0e*P(3)#STMJN(~7#e-=*-<}5xnz`9+sT2^Kd-h-1m}i>rZl7oYmF7pZ{WA_8h*S7v@ctisQ{{ul&y< zwOL$INV(^?vMYC%{nRIyYj@1x-=c8k|B82Nze29R)y&OZUm$+v#~+)%Za>!xzG@FA z9n-q7@4}AI#Hllzb{jiw|MrA)pF&%MYkydn+u^Ts#hD^=WBSh@{Vy9EP`V^6-#lBa zdj@-bon+6$qr!KrOlvBxe!1NG`p2)6vvQ8!pHVf{cTdm1R;Kq4KTmlYCB(S!n%Z}# z5BWR?Y^o}Dvxj{0P?DQAdD%V7Ng9bAKf=2{1nC>Z#4b;`JK>G*kIc=teagzTtz%Ip}!_8_Zq8cdTC$1WAOMpXJWzo(wxcp-+l$0ZQFHvdDm_C zY0-SU3biyY>1!TuD(_QFO8)PB*Lq9w%78q{jybz{Pn~A7zcJ^2MXE#3yI)iCB<@+J zY<70%eKx1#63g7oS@kJ3pO02GIm?4A0*9j(IY^(&Wtbb0vtdCA**g=?w~nF)0)`J}Gnew3%P zG;;dt7tbgCxPRF~=JZx?X?Br0rHhZMhXu6Q%?Mj_G&j25DyAg)>_gGGur#sm*L^Qy zG-NHZ3ODorU-@mCt6}*{8PA!|pR}|UJrq@&JaI$tnMbSFCh}DuD7zYAD40GyfYD=< z7e7z^hMvEc#mn7V1me2$ua`;gm~z|4nyv8`@4AMn8*OLfPL`}--kP~hxa~@&j;n~+ zWj>|Az`G}vBV!xWLajMIOK<-_!n`at7`yA++DDYfyMHKX924?NG}Ti;gYX{et$$=asR6Uo2w>#eO1 zT3UOLW&fHK?6Q9DlTwr_cSEX#t;bn5pP#dn#+7x?e4V83?Vt;GE0=7(V> zpK^Zb-}|{_xr8ErM!n05iAGCn|5>@;IwRg`y>?y9z%Dwi# z>Mi4jx_$nodp66ZEjK@}y|YwA=A;Yz^q1+CUMfnt9Ku3-=Q*qk@ju>QFLq*s|AB3_ zRcahOKl$22Badg=Xe4hxRO)b~^oWC~|0BCKi+0x?G!^DQIcr1px+urZO=azC4xEqu zI{k#!@rx()YdZewyfx3cQ6%|b`-AM)k1pLT>scIPQxpE7gK-btq) zonPU1|B3w0!hKKfNR{eu-f}0~onNlE-fKbWQRAa$Id;UzS$mbr=*n&2{VP~g_(|q# z$%fx^*Uj|w@0*atpg809qPqJYMsexiEa%i5kPT9)(8`q9viW*cnV)p}MQH=$@aXS< zKd*Az{_k;3J^M_j=oWqD7sgy2Qr6!%k1%Db9m+d@E=S^S;WZ&!C;xfVH;9Ve7O(jC zLA74R%H#QzqP~on_&6 z&T6$T&*iT@kZzV{vB%jb z=6$-i)?U5uUOfMmHpdUCcCVu@39MM(CSG7DVz=?p{;;P%-kz;`UO#oiNzMA`L%l%` z6K+nu!p!#Hdv<|kePr^z<@^2iXeGXxkZzNq$n+|DT7L4?SmwXSLmrB}6N`g^ZJc;>1`3A-s}41msMT*xniZxcLBvUhwKYqyq_m* z-_3b{ntY{sOM}-ZTaT<%UE2k29!4uVR;CEoTI60b%{s9+@U7XonKt!0-c{*Vv&)T^ zT(5FI_3Bhyn@`l0La9ZC$A2haX<}FvzFj_j-ofyvm$EhO4xLH+cmChRwa31k-NP0k zUskJf>}dU|Ad!_5RKD8XWck0voUwwnsy^z<*SV4yb>*k*wtnvJ zMmEo>p}harUW?WECFp6mCqh#9Qhk3$LGsRUN24Giy`A{^McUhA z_tu6S+$`C{eN5XhZoiSd`;ybI8=5Q%_15ea-_?A|WX`=e>ujlEBR=;fB9qM+!rgz)rhT@Ys z3wCa=Y03W7T7T^14>m^gZiCAjJ0G0XIP(5p_w&47?@E@irmo6`Vds2rE%>>yL(HdE zCw-&*x!V;w4-dzsZFAqBVm!xORgd}Wyra(~+I00kT)CEMZ)?}lxFy(6-zPcz;P#vA z(|0gLT*}{A`ewhnfbrdvQh(>}6}a*ueOg-R=}*UAI9eXrZXJ8OKFaDzoIxLV&bwb6 zCh~KPv>zY8BHFrVZiV%l%o8uZr<^v)+^f=Aoiy$2iSnK1r+!uYG4I*`?RcEZW}I;FQ&sZW&cs5du;iES5;UWAGCi8`gFa!;p0P_immyx_x_(V zZ}O(EN7NUx)(hU0-GBMg^#e)ut4pLEY`EX7^tpGd@53Lv{HQ5>lCEy78S5LD&uwb$ z;xV5R{D@;&Xxd`eNx?1C)ek!#4Ci0bXPvTlO~EO*Uv-!FJydw_v9V8N-^>#3`(^Rx zKnSfVBO&_}@L2-HIX-Ya4ILhKK8{kfxR2x@m^>vnr)ER>3)jwu$vAu|EvAPXEcUc+RHE%$e>>p4PKz=kI^KR@o-M zH9PFRpMzTZ?@806pUN;Y&$e2AFy+p(hZBz0vmd-#=5uKG`NmF;p9df0EttP>=|+i1 zCWo}A%=y1SC&ORV*@ZR1{@c+#-|7`#2AF5qD~C(BY?Yhc%4prgVYf0S=KQ6lwzd<@ zh5z_5pJtQgH@g1j+2Y75{oVunG(MT-D12%Vl{Zk!bIto=m%ifJ$Ld9o59uc@4Lh)4 z@9F2~zkjPg%~EK!L^Mj>Q6(k2>dHFneH^7zf0WI$zxZt5n!j%k{yx0n=QdHTtOb`& z?I^Ca^-PFTGGh-HpQw^?VfpVpIk(y7#w?tDq)ocrVdcV4ZMoZCiM_wQ|H9|awXCb2 zY_pdAxxX;YVSizd_2yR_Pit)#$Vn8go>G5ED{@V^bB!rQ&i}k#=3-t6K zVk$RQ7h#nSPICL2+U;>Bwfj_|?oz1*Clfe!>{`E@#mew`$d3TUb?=o=Gz-2^b7Q_3 z?7r{%7j=c~pW9~E7MaWXupLh74KT~@De`75(Y`xjlD|l#&6{HNv)3gJB(L3cHQH$Y zrOZ+?h&^y(O6rW{3LoG4uw|P2gR1|%m6&p~U39I~O|Er0t$eeRVxFCG-L*eWSogR~ zn~CK<8Fy2M_t$23PJOGiBfn_n!zsIR>dO8L*MIboT)$fR7+>`(59ej(yLLGIzdmVl zZuB9h{Rd7RY;in&^R~zn-wK&e8!WLT~xe|cl&`S&$8~^F82BCm3~*HG5IJn^C#=+ z`xR67CqI%~Eh%@!J<@$oz)$Na{T81Gy*BmBHd|^bEuHa+@ofCDvsX^Kur*95S~``b z*uQAGbI!{cof!VoBR6?%U##a8n$BFmb*o~Jt9UO<7<-W0>Tt)3&bfA*ddnqD%vDzN z@T~Qg3STGp@(Ppg---)*xlL!+_5PS7_h3Wz3C+)<8-9x{nBsKFm@!w^_#Dg*)&^L)y`)*cf}+{k0#Azr`!+wR{xXFcKkQPH&9;Yux+vHy`zzxN*Y zX)1VWz08UEo7CjGHKA-e6T>y$&b^#c-4Xv}s?>#?kNvj=>_w+Iw}<>%dvMKa|MT-F z^;?8amS6N)&F_QNJIiCdE1kspH~IAD z0MA5&N1RQQ7W&_2;yL~F_yQ4*jqBv41I+H_np$+J{0rav_~NQNuPaowKEJ-Ozi+n3 zvtMu0C*O^gxwXargpq1JchlkLdlD|Noitps-F$ztFT{BL+AIoPM<{j8&v6CE8m|4;b+vQ;AJY{vW@Z1>rtB{To4Z?C-2oS1BMY))O~ z8I6BQg||KZWbbQrs*Bm^S}OhHmsR$z{Wf{;l(VmX{rRw&Iof7QlSKX{vShnl@ zqV1IhtHV0lRHua<-DrPFOImnl+@kHv_sX66E*#*0jcUD=Xe-+u3 zUthFbvSG9Ti#00IQv+vDnp17T&sq2=B;eQf9nXGs3&*b17Ce=ibN=!w8PRFKO`_}4 z-(Nk|ac+lHKf{t)KbCx+A~kW&`^Cyx^ zRd>tG{U!mY9?Go^|H^04p`3i_>_qcLJ(=wb-T98hUg*(LWx4G3X35Hql$#xke!h29 z;ImLz<5{m0VwjQsb>aFtm9|U&+4jcGJKgfRQ*qYEy#IT@2PAH8WNLhNw0^n5qCYjs z%h?S*6CX8BDeepR-}HKW_7v$k*Y>M5oN-kaU$9fqLsj>&*xLBgcM6;{YcJlED_j%h z+SGL<>tZqEzNiiNn)4Pk<*FW5nwpV&A^FD{#g}h3Gd@0cvOa3vhVzlO;q|RbO9i%F z_ENW3O^;s`rs%Wn#l|;L9eV{{`ZhN83SPM7Qe5#N%p^vZMSS}NG4>Q!oonffX7-)a zIg!8q=?}#+4c?W`fdYKqVG#=-W~dV3&JEB|2|e@IapvFH4WtfdG4Up=TU z`+33p?Pp6f=2@`Gh@ZWb$hNvVW6$CGMo>(EdFu&`5TJ^E*d%hi4N~~`Yc&7ZZ zGUoix_ z>v?!T|4hLq%b8d5j#nKMlbtR7IP#M84~@>SC&4-b3K^d~jOzC4rSImuv1aKlPR9dB z-FJ$K{9b$DOp%uG&PMl`ij6@UMyvI6>ZQ!jisT)<{I<;P0lxvGCCiZ?1~M1K)3ilT z-VpzHZff7Gh0jjz@Sn7}Lgb<1u}=bfPqn)*SfX`Lo?}w*%T`qae zYVCGC&dj~!ukO?(#z)TUT$Rsxn;R#!ZKD7BW%bcHTU0()dzz}%Fl^;GSkDt+CsFjK zwc$gB3^&&ty`6g`xp|-MSgz7Ld(~Ihx$Mg3fzr~5Zw-8G|TT8^1eY{{31 zFn6AmnP=9Uy3G}jbXv<$Ads7uxX8G^B70%s4o}U#627~9k1w}wZ8)q`Dp^&s!|vMJ zANpsLS`V<8y5}`*fq9~g>x#}R<;`# z)mJ1)oj-EQu6Luynu@;iITtj$_nA&ouvmR^|AjT~8dcVRUYt#x6`TFRE&NziL-v>?XsVfudi+Iwc_~i(`{2cj(t97%QtcEhl)6pL-F3nFZ1bnEtG%T z8+?dQdd9{2+@kXJiToS&60^E{%vV2o8qz+ycgnhYjle9oiNa#c)j{gPyp`vb4@-Ev zKFxUk|GA3xqn<0Ld(K&U9ywv+aNXePQtb)HIx1@~XMGBd7uQ$3=QnpoTbI+-9ElL= zYm;`Y`jUL%(C6Lz>po>0de2&a*Tr8);_pJm#zoV5F5B3g*~FMpoXp|&u{(*+-@wPj z`s$^y+`Vi8E9*NHrkXuJ9#waJ&0JGQQ;|5HuLm8yO?uv+x|=6@;xAuc?RU4O@ve=V zR!GKI*|OElYhsvj&eb+P=vY&Ozi?>jchltaZQO4z#eDRCuX9?d|I(#{@iii1(qEs< zO#J&v!sL8c=eJkutZuwd&yC19Zz%QWNvoHq-97d8H-;t8tNRq{H>Jt1kNPdRAUu>$ zj-7kah9I3YIuGNPc0|{x&wrxy+NAh;!tEBf8@Y1@}GO)2AoC-CcXbCfS%fyLKIl74r=*U431F(fz=c=ZR}fyTy;k)wjC6 zS}w9|h2xgTshR5cgg?uCJdv}ncMI44D0hpNYX*w<7x8WV)ACK}yZa^Q52hOqx~ZM| zzxv@{N2T7|9Y5Bl8OLs^Vu@3*T<2JM*2$|d!I5*${`9)M_1|qJH$MD+YnmnN-}^_I z*$w;oq!_*>?5GfaEED)({pX+imdGA`@@r#q{ZZB#`=WSNRef&FU)5|@lp83jboWtD zlI-P|i~a3oIM0R&GJoth;O~EI5}a@%Rop`AUxQ}4)SjOuVbf#|rL;zsnX{gsSkRqf z@}$#S=6}idU(bFX;uR0{eIsx_?~>KZzOU+S9uZ|+UnN+}pSD~n**1U2?hCy8WBQ)% zNt|GOMXdgHb7#q`mudRfeZ_U9MXXN>g zuPT#yF!ztwwEFp0-wyWue^k;g_;vGVGo8;p(Kanhw$|(Abo1WMNE4pvp&GmCE6@N+H68o=~d+=<2 z?&nllKapQ{aTl-O_EkH0G5<(*(9E6h+7w&L^jJPW7QMTyd8ZiL^3;_z+PYcl>2kLA z|F7I>$|%~t)n{*WjCIn>`>rMoN^EmA14ZrQcN~wr$*^dh^TNOdJX`OVztXI_@ynv{ z{IW^b+H!gVo3<%lGmT5F7kvKu#G4Qo<$jKJCX?Arwro#(?^-N=V8*FaAGywL$(#}D zU-$HA>+9`SuL~ZmDSBM>v0#f+?ct}7r)x@OBA1u9w#Q z!2aWHqo9YMtJ+FC$Bd;+T^r6w@BJbhes%S)@LKPAomIyczd5YLo^~LA!=-2S+m9q_ zU$=d0(tPDp(5m)j<`pY8l*%iL%O!4-(`Jfv!r^$NrSj_gWLZn33R(1%JMfh zZ+Uu9&DHc|jGUKt+^litBmq^G6Omn_%X281hd%*wjn+xlkT3PQtQQ+L=|HpU2;=cB` z2c1ho;}(i+Pueqa-3lAM84oVK%Btv&eS2p?;2DE|+u2*5uQO)f#IrOndcMI_PqsGk z{iPei?yJYslNXy#s1duXrF_v0s0*0vYLeSgn=zW&r);nlXA z3je!=>EC{u607DcEa+(Mc|dED$KIcrd)^TFo~X_!vr+%C!0Lvw*!+r`uC6U| z&y&mj-sH%=p1<|$;f=epJ61ja@O%E+N0&FQHHiMe|NrkjPu|iKCcQr&*DpN3^}(MS zHa+o;FT_4F&R!&An^yf>@75FDMG<#Ae_JjrpCuK)YR23-&y!!=m}YXmxaXVf<;`mK zv4!cUes7xkM8dH_M`3~bIbo9(yB^JBxY|(trp0LU*#&|^|ISQV^vHrGW}9z>=Z1S$ zx6)5-w)vjM^lrhixHVaO&ICWWt$i#jtG?aULGJCjFSl0sHwY^6Ro?r$Cv&HuUS`{y ztJS?~x^4S>*H|1r`8~e7Cp6Gyb;OE>3mWVamXAYxjQ2}zSJ|{9tLg6UrPKFa5k7I} zgV+12y>s(ZmQ|&;yR68Zp=AF>Hnv7n0eZB;iU8a51w3p z5^H@z^hM8}r`gXm7CFpX5d6K}^3I~oxfdJPpL%ej*@5%Gqexp%?gc9g17_v@jXr9c z?9aG#$^S!B{#-Z}_UDddJ%5aU)6#wClh&*C|CTs^xuWmmhAUdj&pq6pR3>rQ#Q)Z% zr@I7}_SDaaDP11?KgA=d(Q;mC?4~FBpL%^w>ZaSC|B;uvU9-V^!r!FyhV;)0J1+iu zBY5BDY|kIAuSN19t%vu0xRl*>Hz3#iYP)i6<*Mp@rVm=tN1yJCk-9i?2J@>K z{CiVaUwpOmv@ULTZ#u9(^ozr}hN-y<4gCVO`!jUh>M~otHpWf!zhdOrd769m>DFa$ zIG7G7qD%^<^Nfibi)`t7rALHyV>p~{piGnts)A%b62=~KG{D{%8m1r zQM1LLyaf_luf8ZTd$x5GM~8FUkEL_U=GTW-+)6z#W9wAr^-BEuU5m1w9L@jIvdT(p zUV^7mX7eeL`I?M9!t3wp%)Kk~VPWTA=lVDMd?T{c+5f5~PPy*zaTV`myKRpRij$i2 zA9dWjv(ovSh=kEC{s(o>IG7y&@Lhjh+Sp{Zt0g|`%X9Xn%VZpm3&qG>zt0}$VeOE0 zPGar%`n>8{Pxi#H&GFKyoPDQKvHsFJiO+Ad?pqx1eVu>L^T@w50z%s_9&=cyvZ=1V z#9@JJ{Etc7J!75bU0kwnMyKB2^I?i-|FTwmXDIP8I-<&UIDWZcv^?pp+@>WHnK)*?y19Sz#yzJdte7e*dEvTza6`rU zs6RJ2&7BUsJXh?zu(TrfMsZ%w;WLa%WlV=dUY7S(ychZIQg+tx>*7Z}hkq>!Qe`O% z3;gyZX;F`xMEKzXFGqv=1J^u$2L#vWZH{h~+rRsC^7O+qS8aB4+|6{oC1bJ93G0*< zlMcq8e|X7IMc$_J!_Cs8^>g>POt)Tjb7bFsYTk@?e8g?&|s6yKigHnELxq#InRsNe@KVBj{`*hG<{JLxm_cu*B(e$VHCTlPDS9n$ZvO>>ASEONkc+bwq zWj7m_*q-KG;=d$o<-vu`yQemW{`z=8D>P3t(Ov!SD-%A0qqkhX#XK#_{dOdze6yv+ zvYq<{=E@p}%nJI^{&TKxbLz`GIy=MFJ73ka967OR;+a!-&$Q^k>88; zi}pwf|K7*kocZXxOZeAXiB}tSgbuR^)wU(i3tUrv*Zt1*Rf4>1YBK)qpWYvDapwK* zoFDb@@ap%ylaEb%_T5x%=JB&aJyZR zMNQ+&jJ@?`2UQP=mrcC1(fwScEaTosQCh}dZ028mJhe$a#Z|5C*&F`ts%LIJdjF@Q zJ5KBfQ;%qt*fRd<^Ysp>dhs@t9DXeSv)SxIWTyYOl-wPWS`u?@ohIL!c(kis{r*3O zHbbvu!}Dtx%pH3?j!S7jX1S>(waiB-@7^a*MbS-cb5D4!s-L{}&8-73=0rR#UAtAJ zdsBHS^Tdiaf%tb^%qQaY-gsVdc~Z#zQ{s}>_i+0atrxzn{MxZ=>b?42hlQ>0xrEq* zg8W}EuIftQ_F3k;Ei7i+$1|P#wC))mlQ{A;Wa9SDPkxc^^`{PPiS2Cpn^I_%rlVx- z`SjrvHSc5xAFi9lOFqQcpOD!gF;&=N-K{$d&wTZY{lHc%E0jLz(S^7C7fLqvuh&-+ z3tN(@-@N&<^z9Gg-l^9FYnR+{PH+7nmh^0)_m!n^!bdvBierFWsFwIK)Rmx*LIT9@+llZ(s4TvIcKTjX-QT?=rfAynk^Ljhxw4cU$limrOI=DacC*z6+#>sc??ChxLaGE=J;-j;6 zA9$7frl|QI%d0ohbU!5~df=(hRaaJ*?x6aoYgJCBufK05fBVzd>rQS#aRQEqdcW>8Rem6p=LsA3GRQkO(=Zgoa))8Gc#)LB{#<}feqK3JsW?! z`TqW*QC~U1^yG@gE)OpMU(|8>=68`=W5K$zcNsp0wj$wM?qoz2uKZqnHu>|+)TNR+ ze7pVyyEyubFZe1q>wVYkhNMX^jtB0De-xs@an zmVw)C9+L%{@v$D0qH&Mxw;`Lic! z&x3zyM*k*O^$Q4YXllO`AbTrf%eRADA5^ZJnsN2e4Zev|EWRcmkH*M1)a!qAp5c9% z?eS-6?hLQE-H)cQ%o6$@a9q>ABH6^8M|;)o^>Z?UGd`Tsi^7Q8+6nUZK`-ve{)5-)2rJ%CHUxfevoh@d#G9F1&~Pa?_vfkgp-1hEHVFjYPL_Yv⊃ppwgCYexgW2G_jW zUuN|uV?#w``_}&KwmDwMcdbygBX{z@GY+|j7Ejud*d#iyqChZndHiyh#dpnva{mP7 zZ4$d2RW|9v-_^ozcS(eNm~nCOLZO9+CfM{IJkgexe2nLA_&3?BNg|Q~CzyrnOqTHI zaqTj;d9U+k);Fd`-5ue@uCIQui61|mmAbFrWXqzdKJ{T|R9DA&-`#)E@9?#EmxXtP z%GWUO+@~&lVzRbDYunbUQa zQ2%JY`B%$3F5!snbL+4CQ~aHC;nb}?j?2UECoO-ZbLJy|L};98f%lc?5A2q`U1d_u zxWeq2)S0(D-Wyh37y1^|_|T9?wZ{K$1z*jH)ao~1pS3|$ z>!*^lRo}Vuk0V_oPrBE72x=wWydCeC&;8h4HAIBH(P91q$2|!pRd+*D*NUw1&3Ynt z|J*CrA1|cV+Ly${JnfTeeb0NY@yMi^5107+cbIKhoA=?2uD5uZ=gKzwve3hORc-8F zPtLunfANg=yUHwosW;o#81~NSYVu;N_l(R@5B_16$g}QuxrN0|B3e1eWJC%kQwX{ob^1`_{=C<{Mg-{>o@`_m|d(gw3cE z*4R98M)XxHYu>Y&JJY^Je$sq0qsMoL@Ws@VOOsTYnuYxOe6{&rykES-aJ@kSr{jY4 zn==EKUx>WqcE{~vn(X|u`4ZI!vxVOCnJjQUSk%I>)+j%=0T({s>xxuyntc+{+oqIUlQG!jF+0xi_qJSE|rG*8TzE5gidP#XzNnBS}XDCgr<-&3y+ixdb*( z_E}_Mk*MK6rQ!LczzYAv-EL}Lfo#k(RvwIA8@$KBlkHP!))kiqud_@1b_jNgEoeWi zqbuscdVI?x$rTq2gr{&Z)U(%|OPJ7Tr}|Kk$AZD<;5(KECKiX8Cuhv@V7RI=O;z%Q zft1e`O<$g>R0F=uQ#}8U+D~C-TX{sW*&@)3@%t2R5go=oAq=0UJS^2Z7ZI?o5&#L zd$Fg-Z->)uqhpH8G&Gn4EDm_CWOB7RENR8eV>~C(;tZ=_z_h0QG7`+n%#$WM@ceyr z!pvK@FDB){3QqU`Gd&tZWzre!g$Wt%5E|JasCy(uOrh92GEX5DRw9RWamU6RDW^R$F zIwx9j;zDr)=aL1_W27w;Us$@E8Gngc@__f%!X~Z>P4l=LnB7F&4}?os9&BXgu@z^k zIC`O2@uTgR7>_G$^O$u?K22vj)b`(qL3{CmdIOR5k~Lm4ccvG_Hz)koyK}sJ_V;b| zpa0xoxctVpUf#KJ(+A;T?o_i)A1i-!zJDO`-;jI8y?yH$pFE5F%zuIFdF{MEuj7S_ z{uPI+Jh@pEXs>xKJap%(=~s`$?LYVY!;?2}S1vexH_@X$X^@V*lr>pBL@f+3LMa zoh9_qW@e9%oRxvkH-CCnP-v_@sl@5rtE7K&H_oa(Sv;R*BZK7j%F?haC+$xtS}OIQ z6#mpSXTtR-yq4oeQwv(=`~Ca-zPj=AlbfFp`^)coFh|UMc4XYwN0S$=*K(YfsmENh zr1N5+pj8cntZ0*R^}$N7c@ynV6f?Y3wcO_Lmos3m>hdQ%4AtxtYHu`6TmO2I*7bOX zy{GpmO%JX6x^zYQ(bBs;+99kL;-+4`npS74T{mI%)0~|R`#)Fa32v{yHsR50wfT&{ zu0J*BI8+quD3iBJiJeuT|MvXVx04bNe_~}a*1nc4J=b-o#)%~3{W_~kE1NGy9qJX0 zd>XoOL)ndqo0C|#=`Bw&y}jmS_@~m%Yr0=P@;c6*%{H%QLM#dvvVB z&Fhz(TK+WD&YJ7kk1*pkvjuOwb-&-mrK4JEIa}=h=}gCcjdzbG?a~vxZ1L_w>9>yG zM|UqiEZ#2geX_W7;qw6TnMaPYo2aTDK9u1y<=3qCmHqsOPsj&coc*WpO{|&O&$P>@ z)4P2e`qt;j$DjXaV{Ko{y>A}hPOcl3;lZD^*X4Q6tDouU&h9;Bwf)~xW-d2&#*O?; z@BQOs_y1?%m@}8xk)d0dyV0H zB+Ptr;F@+stJ7YtDzTPtiARn)m9JlPb!~*o`c+TM?Z52Jnsnm6;?*8rCo*0MZnfYm@J7@h>IUTxj$DK22u9qt=_zOIh znowOCI`#7+P4f%+&s5hiuesqj;oB=MdHMZye?BU+y!=yR@U$UsM^a0x?wfl|y8@+J zIrO(HHvK*DkMq08G=cPkzfP@PH*4$E*Vp3za-H6K{r$%GMe9%fdUW<-{l(M#*UIm{ z-{o>WQYmrne96zJ*R9UE@OAdu=BdSNAK!>e{qlD5Xa4^G6(vPwB}O74H^k%*oMSc9 z+;K3~QC2i^dEcyS+Ye54no%OjFKhkQVpF*3o*y5cJ-R#D{pznO+X$yg%=4C&ZRYg# z-d^YO)p_a51>)>GxC`nwEO^cM+}ZwKeaW92`MUqVynJ|cx%>LlKcA-6PSfu@Zf3c` zly!Q+hCf_g4->9xx%dX z+*y5N&+dxak8e^rnDf%x5)SNYp8Z3FKSqT=VSyo!Nn2uu{o>RHrpL7!JMNzG{=_xG zV(adD@f+J?a$g;qw#53o>h+KBlCR}i*A(qe4T?B$>>K;dxT|kooWK11c)g9)>d!|- zc3r)B{^v)AO;XnbDpH!BTbL|${B(NDsCE2DGr_dmF>Xl(@z&Y{t`F!-Q(MrCqMpt;$`#Z$bBpR*E<(l|F6FLd@hT%f$cx{ zd(Sst)!nk0Nnu8m!oDY~L;ccz{wbREc+*C`!sErYzG2%{BM;WUo)og(JLA3ifi+h5 z52OjD|JShAcpK_={@nffa(3S;%XiJ$A2;i9^W>x`K7}cnD;&PXNNTO_@|X9WMA@y2#9E!>w`6R($$gdNL#{!QBYYI5~4izthC(Z+7xM{C8H zSEU<%C@I`Jhe?n@_l2Uv*Q22u{r)9gdr=>mq~k5LYTFn8idQS<6uf&muRwBx`9rlQ zk?X^6U)iEl)=`;qs9523vn%`D;*>2Ox2|k***c~4XU66giJP9AyjdM1F{vlNnDx}9 z*i_YvYnE?fNmVhlS*3E}ag)t!>-+zO=6tB9`RwoOzq`Xar~BIhD~`1u|IdFcNpHRQ^Mr#*;_{l~-#L{p@-Qb} zIeh3Oi`>ted%Eobm1fho?maR)ps4RtX`_Fc|BJ=1UhZ3YTtw~ssjS%KrHACI=KMBX z8gRyL%H>~Wz4vEb{#RtPY=3pop2hRazk16`OxPH(|4w}U^ZGAk?t9;?5?}Z~;#u_9 zoBv+zc3*D&D>U5x=-woOh6_x;7`S(-&$AYrQOM-NDDeCBd%0(&Ur)<2aS2N%I5C|0 z$5!HZrR>XR>o2PV_TP)I|NbERc!MlgmYBqX!wdmm8+assJMGTqx&JU(&DkWvg`Gb( z_?PhS;#qrn_q_IgDl1)HFL8R<iTs6PNEler)04O>;A56*4GW6>iMF!z^J|(Q?&P z@Ag?!L8;}JFIfDG?s;v`bZcXdI``%cyar-njMMBE@Z2rb*qnU9FHB0*QB?Ji^QEFE zf0B>Sn7f8Yn?*En^0PPFTXJ*Q_b1PjG}TWN{cF2sSMvJnrhylKE1x*?-f=_yXWN5* zOK)(l;lCZv`N#B> zgl7KofA!8gT+`m(qqD^HW}RlL{oLZtGk>;zI^SEfW73(>B`U=Sk2Kr;UK#W2;q}e$ zg8w!NJ$-mdPVTMk<+vT+PHnAzpXlZDD&b@O%?Us9^Mn@vseQY?o>lLU_1F+sPFjqfbNm^YrBrGN>NtJX0v-_a`mk2WA-aIzdD2(-0fa?kNs4H@rQR8k7>W! zX3ig~D#e@E+qU03m+hEq-=Q(ZcdcbKQ5PgzTA}^fol@PWaL*;(WJM!n5ied;d1> z@L$#TV3KJ|j>SPA;WO5;hhiU3(EFpgbLwQvRsAO~CRv{~nNt5n<@T|q#{bXz+G>ky z95TChc+Lpm>YGv&d{cWLc)E3tF)1Rh&k5Y=N`Khrl(`9Q$T>UF9ji zW+`URHhFFK^4uGZxLV&?TYYDh&Mwi>&bsus48m@aeVu)JP3~!*KDI@cUd5Y4`X4DA zuD3AJ<2PLX_UW42rz2nNe(`x*?!7g)_dGrsDDcb5GTYknb;+j)k^ZC$*`c==Ms9aL zzGzWH$G(OwZ)cU>E>+QbwPDTr=*`=rH~Vc*tDW1wRd(h^!<@x!d%m6wUKr_Wp=Dqk zb^7+cvo9hz7HyN2_;1g$>ytEBYF~*abUz6;HYQ8+=?^nG)%h)rj1fI_ z3zO*w#aK1#d!r-!-)s@8n;$>X{n^8Y@2rX{67LvQrYSoVh%XFWW_?-sh2O7bm(wr* z`4Js@^UaZyF`R~Z*B`AH3%|+7k!L)OQ_py{@xhv7tu6ZvriuOA!PIz4;tJJ|0w3~U`bo+7{j#rVTa(1UiLJ`GuN0lCv>n?>~Ng1U}iye zLK+{B;eo><5?PK+XM~(yNgH^3C^SbpNzHDIbYk=~@XlCiY~U@yX2vLgV|rucA*KKW zZ;Ki1n_Hg0VE&PPlsBSYb>^f8(go6Im{&jXYd&wJ*}x&@$@w{9LI~502lB1m4D-J| zC|AkkD=^M%-N6{Wq_xt()oKR28Gm+TlG?$zeAyliy=&=Si_&dY1fNM3S6Gb?vQ)r@bOd6LUskWID=D;^D0^6 znkSyv^N`2gh&kmCo12LLgl5Gx=U6P{+t?1D_2AfG>?1F6Na#$FPk~!!VgQdw(S*Y~ zjwUk7Y|aH7)45Cw&ZwO&Fl}IztZ)06Hsku8!YkdD?1lywEmv8hxSZQ(pPa~cCh~EC zm~d!Cl!UU9^_~elF#MoE4A1Q}ZqQrX2T)DE8T3rq4dVuW8}Cw){`aRz&$M ze3u@)XX#(>{dHRRwoiC8r>^#A>Jl&CRTWFJCd~V|dE)$=YnPVpFnJ#tKmF{|rJtPa z>+4S(jxYZzdS%a}&7z8BkGqnxUB%YTU^)L|0oSGSSkY^11E$8UYWm=}Dr8C4ly@bS z6DLiZY;t>2nVv&aY5B_2KLe*5&)yZXM7#C$OV8;yu83MyJ6K*ewY-+PrPo256 zWuL7ar~yjMCFCnf{F3tQ)I! zi`z3MtEM3^9pW%5^rNksnmw3rvWK0#mc&|G9r}pw0 zCn9~?Tz9Fao{FlsbamXMn<>aRZKXzsCfA{yS6z!H98q1S!Lf0rc2}pzQ5PS>hk4%O z{jVl_TvfNLoSk1a+uhn>Ng2cZn)Bf`_dP#P*?#j$ZrU~Dv+folF&gX>Vi%p<5pe5g zQ?N%G@6F>Y=WZ&^I=Gon=HxF81|7kMmH*G(%FjvXI((%jeXsea>Ghp9_D2?ezRs|| zIGjJfV0usZ>|3ALSkE@_4YDoBI<`4Z#=EU@e%6s-`FUF(diY+M6r8cF&F1y-jk7NN z)_eG8<>_;?a-QVR_V}{$@T^{wey`6HxMQ#6%y@G6pjNEU@;aOBAO8bKTWq@tqkvdAEFpAeHWkK_tsL=Kx^N!%PVKDS~BZj$$YEr z^*(zuPCrd-^A?n!?c9Dm)bXs;@d%M^)4I-?bjBK#o)^`PeapjIf6D);>hJUF^Y1&o zoAmF^Xba z3%7D^;NH2V^}gBl_RC)@T->WaEq#7)*L_jZuEkFG?7NOmIaej7cDVdH`z1FcyCpUA z!>@jQ?Eb|fZ@+ssZA8o`=SKbYJC<=W z|48PG)9yRIsekGRE#IX9o}$ZsOV|GhpIpvela;gbZuWgLYtLpkr7&$qwl*VXj$ z)F<To)EcsK}zLfJ@6zh_W0^gSG%KK&?>#va_Ubg;V zyvOvI48sF)r3e)8+@JX_93%vxMg-&PgE9CG}6qr%eCA@??k4=WV7UbNAdzeEj%x zh56an*;@}kd8nlptAC+&LdV|c)Am)geX0E!@@Dp*j+IJrMQ1N^FQ2miA? zQZ1PopF3tWY$Y(S3MN|C;D=_Pkr5* z*|8sk|2}(d9dUA5twCOF@>@3Mq^+6Zw%0>HYEQec>umq}LeB@Kg+?Mz7p}M`wtL$# zlS_qCjiz(SL=kqsCK4!anC+_~Kzx$q}@#r%- zJCn-&t)*{P9zO0k)BjBQskUqf|EgcR)_vQN{-K?jRj#=&>ihmIzr+=byx8pP#;YH$;ryCe5c<7hl0iYsoJrA} zjUPyA&779KdVl7t{Sy@LEr>nMTRgRX^G&(-uF2;4^SpZcJ%i?bOe;K?cWnBX`}4ZQ zoG>JpNg}eybEjgaPx(IJT<-8@@b3Tp&b)SEHb?`|LgMZ@T zb)3somwis!er!k5zfxrp+a($sBUt7Kx4mGwTp(QJT*$fXq1l5!L7j&)x6Wv@p7lKE zD#Ia>&+DZV?2dYyz5l4$1#-nke(PO;1ChV}mb%rUy0C3j6;AAIrPtjo4F zf+dxky?L6H58hO5)O(nhxqpI7#4UZ1*ygX3F5K-u+h*C3ueK?ZFLv(S2))$K2^)lK z*QPMdS$_M&Bn3&qUyD9O$gT5rtiF6g*ZD(fZc5yZ4^zyS@6swiZ*6t>aiBY|`R0jk z>a(p^Y%I8td2ya%{Y|$%vwS|+-&Mz!w>clrLoxmMqN-7L!~A(H?1 z9C;15q7_niSzLnnpDvw!(1I^^|LlXz>tagYh%@wU;y!KFbR>8)&-D7hif8=?4nEs( zsNI;2yW|LSWNt3Y^~9}lBD)K(PRwSVaeQ~p3loF*pBYVwto(D^mL785!D73j{aa#T zLH3S6Z;wnp)~b4B^M!ylvT<(S4b^-47CfphdLnn{?LAkU8?t+RnGT1#uQM^IDeV2@ zdbQC|)UVL$g?sRo=602L%T#<@>lvqaS#9-fl5XaV(Y~=^&!&a%%7WYc)YRr|Dp}jL zY=hdSjARf0V8!W&9(Q;pU*4`9EHzun{HKTf^7gkEe7!Cl_M8#bbxWWB?vfQByF4by zolLd5U+{KfF6%tSpB!?(I#(M!p0ao)NB44ngT!-;BD&7PCX36@mz;ZeN;z6;j+%S@ zPl3*5%VaFQg01_?I+nSAKf&UgKKTTTuY7cm$DzYp-M5KWeA$tGbwU+LVQxySU5OEIjNM zBGbF{*jzr{b+((<9$0+YBSed*maj|b#G=Jc>+2&*rgW{@G{?@MW#hJ{xQ~|`k4|;p zW@6FZcS+E~Tb^yv-HhGqIW8W0vBF}DnC#NUS-BU#9eG+2Q=Jms*xt8EDdgn`?-Gu4 z3m3<u>hjxqIw8TFAfs)9>TU{-05LtM)#1y8P)^4o6R`_PR*N3&hRXcPw6p zbJC5LFY8X8f6jRM(xup1tHTd}Ewq`YTl+}z-U=tVs^tCkGV(V+{=XMdAo~9HqFdtC zuRKl{$jmCLuRnKi;unUM;$m#;yI%V}%T=bE z;qi2pS0;L{JI~8&oZS<-*zZ(p+G?N0=`AJF^CG3TF3dS>Eu3BZa>2*Yi~_mk+g4nb z*?sr#?p;4;pIYs+Sw?pGlKc_-`#&Imdsw}^SHigc6~@~Lr1{G>$h#3S7l8+H}zfY%vnKITkp+0G*kSK z$;=rcA1Ad>c==Cp|ADi;eF|lwXaBBTxVSO;xy1Gkk(#-$V@w1N1%FrNjW8GamZ_V2 z>#lEMV{Lp`u8hpexDSyjU;Z!tqN*R~S8erb$=YQ-&%@RTYyTO?`)IG ztgh~URIw+&Ti9aSt8Fpgt_APif2lrw+n=ggMyZ;fazErfJGC#M^r=(wld`ys49qO1 z7ng7*GFnc*TEeN!X<=Y!Xkuz;Vm6(zlv4_ct5V7tVPUDD5t16A;FDRFs$gVbXrZZ) zU65FkQJk8nP?lO$oSC1eV5VoRXQ0VtX9uzjVug|EL;-0@6JsuYx6GpA5(N{a{=1>2 z<@AY)Y?}3RBX9TJHWR45zy3k;o%V=5lN|*VeB-*7Lnh|d?KS8YM|Nb(rvtQ zW3v;d+S;xaDVL(#rzLrD@L5ht^O||%oIz@PoI{KGM)BiY9x&;i-(r;UvMKZQ#O`N4 zzcqrm(*lelCP}W_V83>Tpj2tb*`6M)t%+`tDeHBOZyhV^lYE?9KTlFzaz>M+{^FxE zk3LD@Oxt-di@{V|CavC>YtmbvYr>AE>{r*(10V3T!5wUDtiLBNjVhi0df%UH#?XRJv)r4u4yT=Ovt}?g zTV`*%X;%JJ?6I)rs$Kcg2X@R$KD+R~d=K@5y+|e3XdCLDEAEPl_SnBQeby}}k&*a%3ob}dh&97I2RV7h=2k)+H)QCI4G(#ca zL1_QYny8n;7b^q8Zmr6^_4RwZY?<}LP3zs4oOfB4 zaX!nvKV6r%%+TpP`+VCQ?Ky|?#J-t-eO|=n?y|fwvXa^E!^6ohzkDbSUfDa)lXKr>_wH48t6I2TWG?30rW`C{Inlr5xM5^%Y4H8B)kV?U zX5?GFoVAT>!zp&FdEGiyG3zP{p3K^lKihu8QI|`0TS7Ol3oDGDrP8o8Zrgi#tq4B7 z-4W+S&nRy`l-xaE-YNc(oQY)5wm-t<*H3C?m&@{P4=b+!p1ZT|NUPAt%=EJX3^AW; zjPiGH*jrzGEB6D-xfM3cXZM}cdi(8aX3erYyO^)k%eU7lZTo%a?mhF|JLVSmYTYv8 za}$-Siq+J4)bGWHmTiA}_iyfx)%;(jv=6mfMzimh^Y_W&;*d|P@cJnEHZ#UcE9}SW z=QWJwtCoM1oWmqMxBjK{9-+OPw{h)po7owz|Do%Id)ygS;V1qs=cJx-D4SZpGrc6W zyJ7O29SsvMB)u_yuvvJ1Yrt|N9mC&|r!7w&zS}9vW%aiHd7aKW{~wO+6FB!fO*7u# zb@hs7{l){#jH^AZ1mw1ZAAXs|hX z?vd0qP6n+5xmlAc=N$RG&g7iVLVf;8ac7eBI4?znBzCzN&53tYWtbC}W@o2%X|o#Z zfmIX3mI%aTtlOdB$^ZM1%8N;A!lv~*l_v6;oK#|cuqia|+*lZ~f~ z%-pF|?K1P@h9B+0j-BpsE9%7ZJ@{!wO zx@4QzYZ;EiOKbUB6pbYv3$JgpVSjXRMQ~R7p2-KpRgW{D`V~_(;mxKargblt9JDwT zSO46hFbouZeCDjz59ci@&e${KhfLRZHN|3$cMlIeyRc*8 z=j=mYU(T5CR^M1)Bb4G6b;qqT@8QwC&Dyh_H|p$MDqL>4Zgb^Eox_iI>fF)0bTPd3 zw#M0%6Sp;Vx3k6eoYfT+PcF_ra&*%ZvCi()kKyij>ebxuJk8^I?Dp~0yfrrS`abTe ztSjo{>)zpOJ=OVf;`1Vnd5_|r1lXL~yK~u{xp|_OUud5?yJ7t)CFi;w>BSSBKOQ>n z%XjqfpFd1CZXaF5Z|x^^@ zzdQpI$u=Huwv7dwb+caBhLpZ=X^i(d-=_b${@i_obWhvP4=RTycRY5MlyEt7-tWIB zR}F`1eD#WW`!*Lhp{Jfx)B}$fOPmUxaL`!tc)!W{cdO4XRbnT-(p`CP(hkq>uIp20o_`(e zCA7?AhEihJskI%`g5tk?oxQgwD9Ck{$jYE4UV%qN1uq}{zmr$3{PK_Jmm9-{mV3@w zHY+>H{Qr&m!pw;omlk+7tMRsVWozsg6c;-=UBmFm?G+-YyKDFG%9`}-zviS-S^sZO zJ%7&6Wp7UBZr&NWkKImop0)Ghr~K`5_0v1_jCZs>Hve}``v36>?`M@p{JX@OB{%o| zsofji#_fwawB@~>Si+wzHNRhpsy`MEi1@dG|Lf}$(@#Ep;F$KGX;GJeGN>T{AIXQc zIxH0o6hN&58yhbDkjjG8>F&*(g7roQ<_57``oWo1p!S8i0hfNbLbRcRv4UYNmwr%w zeu;vSftk62fkF_MzGq%qK8R}p<+>oSUMV-8W}m8xS6|}Sy&pn zfPj;o0$wFTE-o%kcCqlu1rrNX$nrncTj4z_cO#E|v^2hJYdrh=?H{$#vy0DJKEEQJ z^|@|#`BpJ;iAX0kiHUjwn7>jUI!F({9rOlMkF&v{6U-H^rmmzqee?e-KZlk2Uag$B{nec9=T4kB;bCiKWMnnT&F$H*;H_@%$CiKVR+SK~ zu6NIw|4hQ<$UWiPt8cbUyJ57^cGhD9#cfeJ+n=eN5s22_=3T6IM#x%sTX3=28NuC( z+nkH_&Is>T-4*mBK`zNr_(rA@*QX>F8DdTknBe^_c`WYTMs>xZm1nkHTBX*Taz zD;~XA@_)wU8)_RZLSvqYZTy?G+T=0Y_D)%`?$aITZYq|AB@`pV)OgFa9N`E*f;)Phz{C4i7?MLrj+`}<_S@K=OjT=s-?oiqm zk~8mFXhwHy`=PY!4|d(~+Gsh;{K2w_FSQXS?a@i>N7FLzwOJ<><|n@2UEu#_#|@sd zzdty<*%Ptkm~%z^8eOx6KRM*OkM4DivTa5Cpd1%J-B% zs^78rACKYO8u+V!^`m#9=QsT=KcbTUe5Kmg z-`q##I$ut=d;Ued`(?+uWZ!kK>;1FuRoLn+^ZzY#yWT%1=uNF}-uv{VciWx&_xZeB zFYsC6watYoseeP0(<)lKQ<9s8nZP1?KP_YCvS!}TC#irWI-EL)cH{=HDN;<4Qz5#??5fp2z! zgoG#0k=^&+``bUpjW2$0TbA-(UZ`3_E&bP|z4b0Szy5VCOL_0FUj4ag$?Fr__ocj_ zFYx)$iT&$0TRyl1a2c3tQE??&zvkIHMlj4-- z{)qhZSvzU^k#iZxTDKp4WcMikm~Xszcl~dRrINB{cPF2n*Y2dQXKwX-+6?yG=PhX* zrS3X=q_;~c-52iuU+rVe^U2}Ox`>kC8QD?qu3ftDy(3M+Smw7%uTPDA(d$a7%vzOg zhd!N`k&)cWb;xpJ^kvWK_o^EA`##wEw~S}cn)_x4wST>}s4(0=mu3Cq?ZyYaf4t54 z@T%6jUVKl%{d4W*35+@|t{Wt#9SEurzt@~P;b2h&qjsX`nl{r7V%H8<-C&ST6wYDR zfBmm}N?mUGo!e>VvYyYkUXGl2>3ywMSx&p`2H~=Uc{iA=6XoBuGZzT(9Za-fa(^fx z(=J>fmHWA6^D5GgMVGoKl&g~rT6Q8$>=?SM;UTWmY)CPb|fh# zUFX6=cTs-t!&A-)MexXdu&i7qaiY*q^sxE4l}Q(lS&FU>nXFm+u5ym0TV78{q2EzU z(dQw10ylbXHCU=&zo(;l=gKZ~&p(TIOna(Xn;QHkbxGGmExA=UmM6{9;=9Ka9rWwm z`r`-B1mt?WoG<56toEZ0y_GwbJet(yt);gzPV#o2LsOtcGn>gm*2e~nlMR^D4(ZHb|EzfI zF}K2*0`=b7pU#E9ZnE6XIep>h*|Hs}6JDKpn$uyp;mx_^_U6;f0?Z!GlebNDzg@4r zf3I%u-}Cj-M@o7FcD;9ETm8nC!~Nl|`V#S^9jRw-^~#nXNm{jmBdKWvOH$MZv1iLR z*8g*f`MX=7xVa)#cl%bMo}c&Ew3&Xn!54RY{rm2Ywd1_6u(5xhZkiYtmE|ZO^bt zYgCF>-ah?yrJ=FanmgrHfD9QmN3*HNMR(d*Gv!(}&>w3QS)!iCl^@u@U3 zohH|3e0kH7RL|3srm5sCKh5rNVbZgw$_lxj z2*-Iw@0%1oIpNFwzBl{kNv-x3J$9?nFk{Iv|35w^=}noA)n+qzw%l*-ymDi|G2cw? zG?v`phHpv+C-U_hmkQ*oF+aQBt?;c%Zp-w;ToIffDw(Vt}w)EJ`{$uu0+^-Xv zb6R{iNUpfhSwH#I=dv@)%bm|G`hLjMg3mhm@vW^EnP--NcRn+N-`VC;(xGapq*>Ks zNk!FiNnX{0J}I}$AG&1O+!0pa%agV__ww~`yatZB+7n976j(=_zHfGq|E)M9ew%z_ zWa@9u8Q$CGH%g}bW}RWaE%Rn?`kI@u=5qVK2R**(@2b3OkQCD$1>cP)7_X^r(fDf_)9{{$cIj=8in zfBL@ItkRWNmxh&dzi57ErVu&(&fU2Vd-Oi;I`Vpzd&%`B$Moy%{QOVr-QC3{A3LeE zzi`GSH@WA^ano(?PG0$OpY_`Z(5eB%bwkI?HK#koHd@&tD~;Ev2Ojd zwtV?9{(UmbCoS7rvMw`nzE|)6zg2G*l=!}!Rlmr5-%SwE2MR{F&9=!SE^N-wK z*Ne8QmCGJBFS_pK{PpaWIiEjT^xgTIYY=_raoy59-6uT3PYGERw@Gl3*Cxp;x^dbWd*bHLTEG3M{-clkMYlQk9DekrOL6`8=1a$3H!oQ5 z@t1){@*X=bSOK%{KxoEc(;a-%6Y{g_J_r}GE`P`~r?tK~&tTm@rWlnMd^b1?L(Lzk zJt^SMJ1kqlGd=jTvV8aD`>oX<804CExvo1f<$dE`fw`YW<{d1qU`%WaKV^2#+~a_B z^M(VHul#x8@kWCAo`k{S21&NZ1{0%_r5_21N%-7;GGDl$6gbN1xIX)Ah;+CQ4^C~`og zzUbC_AKI3nm8|eoWntva#Yqnnbb8mgme8aN}Sv`f% zd5jV!FgEi@q#RIa4u6%X46cPf*hu*7e$sB=wU^UvA){|b<0Z#B)va}Zd}Pd}pB=E7 z;j{Lpy|neSL)IG@#11LdNAP$jSf24;tNQw}xc9@@4YiA{BK%oH^}ojT(RE1?ApKo`xk@imFD#f zbARMsaaeqy(q^k)y#b#cXCOzf*7M4aSx;|X*|klXuQTYm>y9^J>u+|||L$F@5p$2> z=_zhYji9(4yk3*V-!(NoX;m*U-72@P$M`;b=t=JPhm)agk+c^-UHk9Y7JWa~@XU7B z_l$ee?VK}M&b=)3)4x(bD{6h6@i`;yt^bs^yb0WYTyXEt1MIeTFFrc<^HhR;9+k(3OU$$&7b6Jt~ z%74kY`M6n5{>zUA$JzHPZ?M@~_fP$C(~kw^9lt(0EDP)ptvcQ)S#{-o;C}bN_by)f zb@lPb+m{b$?LA#!x7F_7-WvybY|~!Eg3Z*=v-;;gW$n)e_2NgfE`3|{#b$2r{2!Ao zxbwd(%8@P2dVJER?ikbF_LWy{g^t@cEk7V;yY0nB*M8lq^;g!pD;(75ab%u#q3OfH z$ya`zu|IO~vB6)VpRZ&%s3kM8I1m2Og+mh@hkc(;sf?C zsB`?=^o#W?H#G$Q1`%msJ;=_T-2wk2vudAKeEIwI%CGD8y}EW9KNdV_ZsO;{$#`~D zIHB#4@@jlS+WGkx8eUmZDW5{7A~4$VBj z_GZk7K+DZv6h3zvZ+@WgInlU2`1R?UrV}+iC$5+qsm?#+Y;P=fA|%cDw4Kp>TjR$^ z&P*}<{M78TqH=J|xf-ieHK}LJ8uGhmhKkKx?>$q>KW*ClpA%;1vO9k}Gr{&YE8Fdv z2g{z_ocEUbG?NkY;WGyeK0i6nBWA4JaAx}{pT7#huTM|;vMHecSLvT#>x-T0L9grW zk0rh4`LSrmOuLkQ!s%?YW;Uj!Eto0Eof3Y4L1S~A!e$Sp&lk-$=cw)G6!T2sa+>*+ zd8YsKnUSe!PaU3}oNvo;-`SY?@R=N?Y91py|EO3r}WhF8wV=K1}d^ULyU@vG-o z&aa$*++zZQ6Kv1_(0}Q*^8fX!=gif6&sRuC*G%~Ac#hpt{t28B_^W$*eGlhPh3Cz4 z_&?3i{{WHyII)qx$nHeul*<~+qwVy!o?2VT$}`E>L++^jqo>#Oo~S<*xnQIo>9=W4 z%Fev={L4RHG%gh5dd6~sbHed0^B5}kRB=u?&i-8@s zWF>W1zpis0v;N$>-?QZ7(%FAc`*}T<|B;o`yX@n?=gHYRz5kz2Pg*@u?b+Yb9Mj83 z`dl|&^%9E#9l1A_)^O1uC+Te>y3VwMfb#uP&x|VxC{mY`*0u zlQO-Ge2?B*98n{z-KTOnWR2rwpWuy;G^Wiz8Z{?E#qIRUh&JKZhchheT~BKo z`AsbB>IvSc)!q{$ddxC>z38{>sTB)*r0@~XUj{_++WNPD%2+YK z-Nqzk^FkY`Q;UfsT)n0*ERn35$7k!`9(}22=GvFl(Lc16|FgR=R^P@P-YYIiEGnre VN=@T3GczzVH0DxOb@g}S0stYef3^Ss delta 333608 zcmZp=sIh;Q+5`(;LoR)v)V%bP38_a0+W|49o~H`;?@Oj8?gSDnfsh4|oV^dd@Uh#G^V( zMfeZ%g2O&OjP+s(79Fg&x%XBGa&Y|>VHRnta1lvNn-Cf=R#aegRi+h+YkU z2d7d?b;goA3~5pZ4=X&Aze%jnbZ)49=$XfoFnjkz#)s{3(?uR`{;9`(Df-78_K8eW zjTKeRl}v>AbX5g8OeXLPDhS&dDLEbFRcPldNN{s$l6L63QTRh8iF5u$X+d@$#tDz- zajQt%{5&ziqry^Kfwz8!oL}AX;D#^7N)t41wsyyO)-k7MEctlIecuueWi|fZE9u`B zh`IGyu~wc@ZegzfJ45uyOy_G0wAMJ?N;whbdN1Y4!E_ZrH^v&bXDLUn35&^G=AWOU zV|DFfLTZDZWbvz@Ys(XUHQs4u{-*l+6uY1i>r5sAqu#$qZ*TwdtnJ>O`t9<%dv`7n z-+E3edG+;w-c{f8K0f-sx2$?`e!QJk;1}WZ8pW&hG&ZkY{q^zXRQtbs*KG+_eLE#M z`ff&eeY)rFSz*2Z{*;wfR+c))f4RH1^yf;~=KSZ|qGtQP7AX&|4L5!Dx^wE{*-K*& zo}T%vsd4kRn_GF;`mTI^yi-Cg{>9dn^*&n}3sX-zSNm2!?TMp8^wu9Ld-#nZJK$MaYnfW}(ld+7 zW_p=c$(2>`|6XOV;CcM!+}TM*zdBzCml#Za?3Q}A=Ze4TI^$0Z@9ObCtC$}4wruHq z%}*=2uI-AMfBw+>E56&=v>tdFgtJY4)E%EQRe$A<({t}KTfN(f9%3_PtP8GK7C7BnYZ8it(W(F zF1N^$$mcuxu*CMn_ZYLHtn959lMkkvANWz0t{pL_)jVJ&FUOngJBOQ_8fSV;zI#0_ ze$Q{w%{;tGckg_?&bDD`(dGG~$?@^RR+4kH>W<%V=Hh+l&>I*dD)nYb{o1z`?3WBa z?9GKfLr5oN!3HWxa-W&f5BlCV#c|j&+I4F5k;k zUmW=QnxuuP%Ex=Bon!6S`nWCL^j=YJt{TVnoAZ-B>ylq`bv=)2&Az{7X5FrviR@Rb zKUbs#>zQk~Y}QY{xPw_L*o^=2j1Bc`v$=M^+QDa9p4sfoEDR(?_zm$9ko z=2|v0#(Jf+PS&c_UzKG+f!R3~O&ZrDW*qVQDO0e9leseY*iKs(&Brq`UcNpr%i%wb z*L5>r%6@ypBlDE(9v6H%+#@2bc~ilj*`%>IAn(K$y?xK#?t7mQlzS*MF?3Sm?C-x< z)iQ5Oe7H*E^u7&J|B51`bC_8~vJ~PcT~Ln;|G6&P=E|b_OHaa2CnERAxv3ZGyEQ7;a?C2dW8PrQ?S+_-3+ z_Wa$i`r4=0{4vn5;j^>*?e(YHw6d;e!KLdaM>F*exZ`rwTcg^Q->P@ozyE%ei#GI3nx3c4iX|R1>^r}Wm zwp-<~=d`~6`~E!bU7p71es1ooXZ4S^%;USmz!GODYa!eb+qU}Ty^2SS3~uk&AD5FT zjQq2w@2BrigTF$3Q8!g*tl)pDvL#hBeG$8ucfz4n4>!a;&ai1@=~0qg*8MB&iP2N* z>xZUgv;MleYO7!6q0}8~rbV_J#eD2JT~fT#Uzla0c+ZKl7a7u4{kuAn(jO^q-4J)7 zURN<>^`EMeva){*qdpdQKD(j3`1b5aVJ9;4bDuq)XgyEh>$dwRSlJIwsFaPd;n{Ob z<=1w$&&}&36LQ%^`RW-Np6}$@9HBDR_R?(??)@du`OIx<8 ztkGegq46Gt#Sd<2y#JgtH+^bg*N=!#^JHs2<=(D;xUpCGjiH~puz!hNrn*6l`Uc^+ z2+hvPJN>4fR_))k!{+9YKwA29ypHUIgxLeb^c9{-5gv`V3= zCbxapXjFWi{`Q}cM)}IKN%CiQoGer?oYm@i#oXfagYV*p+PCxENtg7vqm;JmS>VP+ zYO6Llz1`rnqkhNLrn0Ep>*RI{Hc0Fg3AFvx{*h(ngT5&{!Vk$bU3594w%WjV^@VJ? zkh)!uZt_0gdgtV-nCRLW-V@hfz9+uaq(W#0`@_{sBA341&EQn9jLVRH;{^m`}Z z{;lKx$K{+wO}D?s^#1hn`J6g0k7=In4@KP|`)o4wSK@Z^ zFYA7v1wj`QJMYf8Gh0^R8tkImz=4W@f$83N!MWkt29IGdpYk5)Nw-=8KI-`rd50-{jxzw>#Hz@ud3X zRV{P#1oE8A)rxjrzPZppo@+G^^WB(73etru?r2S!&ONU+tZ8?{-Z__=ZLa|LUCxd+3mdG|`>C}irW&1kT-nIUtANTa;p$GSvH>5G_7bySs zeYHfu!HqNJKi*yEBjy(Ae=6bAs>FF0yq@h7-BvGXxOD!%Y3two4!gB+wvpY*@bH?9 zOqO=lBk7&2##@u6ODBDL`lf>Y%9JTFW)iP9sjSM&Pg?3^Hd{4KSBT|JK#FX{2aWg79^EUEkOruPl=t%lHoQXdB? zz4hA{DXg@Xt1tEMPuE)iRa0(a_`hwNcvueqn0@2J_L!y5E_{f2w$U%cL(wQVTbCFxdkbaI;i%!cmG{OYe>UFC}F3N2Ot+2eihOTjgzUhZW^8Q$`CN)^IR zvGTuUTb)kDnnuj=pA{#r7i%&*OX|esf^)xZvzV{ReTrqc8MmR{d`YEBSoTB>4qm0- zsmFcz>kXRj)nzT8=gqSx$@#5Km`QEy*Rb4G-*Tfl&dNDEJ}JC%`N1*UmazEkHp&;L zzPw>CQ9Ik_wsgb+;n`6|bnse;#+}Y0*m&LhjYUN06Zsd;($>eN*7c4aU zl9AtzGfBy;{WD%0-pHPlQok!LrqlY-)d{bT+n!+RxtMt~g7 zpH^=Cf86KihPx-DO*hN4n6kb(Ir~n*f4vRQXHH&{|Mr6X+8IlpJUU!mQoH)!s--oy zicuX?-rrg5{^fwjHfg2uIDP`|G>O`i4Pf#k4;iH(unw_e;Ykd8(%pEu-rYP`A!VDu=iRl(e0VmoTRxfgYlBM~ zV{L0FdtE$t?}i`K%u64uojD|RX7wYFOga7KXJ@`!y|lw_dDZ`|@8sMoXT7{}ZTa5I zb^j;Vt+i_8yUe-o>O4;k(f3Calg{eyJ>0XoZu_Ghm9OgBQopncaL76+{HyKzJ+Hm+ z>;Kx=IkguI<>DUC`Q*28W7y^VM^p0Uti0RjJ^n1ez3;Zm=AYS&ifnp3EB?Jd_icl` z{{27v+Kf}qOQ^q6i55ketzMlCYg=*MGu&4pSQ(PUe|;D z!Gn2>TQ1eN^=!=0l|28QIr89NrO0eHAL&OflD>V9dzGK>{QAUFF2?3~wCBCg<<5ya z@--uR%>p{^xOJVmui16YXUb&}*@8LBnm-!PJytTPZk+gOf(`%8kF3Ye6lwH38VmOb zi2qpZ;Hq`ZeaV$5|Bwqi41Q=bM6&N=*d+KuxG~4VhUun7{f5rwSv8C)tADC1M4uOT zD9d5>nRsqTCtFKNMc=X5mj?ryCw~d>NfBGfe=uBon}|fz=Ia7=27y-l7-Cg_sGm6ZE30Bz1k2i+7G?8{9j$FI z+C(Y;#qY0iYAq6&}t%f_?zWuB9s zwQrgD-Cvu$H}A`Obx7pWo+aVy)%4HZ{$#)7=9cYO*8IM@tKL#5-MrBL{+E^WmRtS} zi`$-B8$0!D#FE=C`(pKfWo`Ai5`Mbm!q-gK`KPyO>5H$FZvG(M@wn*QOYfWK_|wi7 zg?_u5x^=~`+Z!Kj;Iw-!c=7AiH8BB^_0zj=ud8~q(^8NByN>P;w_4xS`#STVWpeN2 zv~mi6Wj4{*cmAcf)0fTdXI-rm{CTE)`PFHsUCxSbeW|r|<-DayDslO}zN!0tO3xo$ zeI@Mdo>>=DH?MoHdS;&K*FBFq@_6*sPwl=EXZm&%3$vTf%O#Nqw)ZV~oU>P>T`_K& zY!H)p{q@|Fb|!0#VEUB^xiAx?8v^Zr!g}#fx;WWL`dZ z>G4MXL+=^-{1rdcUk{xfv8k`!AX}`txIy;h`SuAn_m`_$Usu;)xy#{yL)BvT_um0s zC82MBoLTGcdtH9bt+Z)Y(;lk#aN3pE?moBE+gop+CD;1;cLLp9JFd-p>?Yoz+Y!^P@Sl%racj>X*g?N3Twtv@8e+*o)R#LrQZtwCIuGmG_qWre~OWx&Q z(vooPL+-27KXYUCR^Q~4diC~l|G_%9ySaC#o9}K}S^sFpy-9oGL;vn-%iGP8zWe`F zv2Ny!{#R~Sb?XcEe0x}5QgdP1Ri?>F-w!+N?D2nh{;0FzdbwqfJ8~-n_D^}cX=S2g zw@AimuB#S)hjQ+o-u&$PjrklmcV1lXXqmhyEA#uonfYmtfA4txG?km#>(wdMDYuVW zZr=L$iL(Aoo4x$5Mk1M!-<7#;u6J7BUiEC(fk~e-jTO&tTTrg!{^5>!SG{Jvcz58< z_lrJ9{fQ1$&)8KQ@gwcjxsNv4KK1(^wq`|aiA&a+_jSYDHBry5rm|SvJN^8(@f~-a zZ@k|$PRsu3yKPf-Ijnfr^3|*4#7-u1#sAazbe%KmNml;s(?;SaWDe$*?tG@l?!Rh! z;--7)htF&=v`);;+;}`g?DLgN>1#~)Ecjo~`>1LAuBLmJzifGBZ*c12!<4GJ-CicO z;c?4Pep#~ecjDd47AF=wPx)n6dRA)ZP2SlLA6~m{vi{WLXKi{cc@`^AxPMJ#>X;^b z*^lS1(VxG^|9yOKUs$7*Un{twe%3#B^4I7_5b}A&77*T zT-{wI{^9-ll&UU90sh}p%pcv@ncsH0I$h@I5AN^39)I_~_l8flJ~oNJU-|Yo^9o~Y zZ`)Xh$=8>g*!r8>es8ixV1;zDDDI@<7kh#aom{-!^g-B z^9r|)JE!ifx|8=|-^PLq)ke0_@!t-Y`#8^6yPW*ye6V$ds+~{$%zsw4J0~0#Hxr*( z{4iCqK&sSn@zc%Q^^~R*1&YQ=l~^x&FZv-Z>!vohG?%r^t9s|e0=qIj5sTY)C!OBT zZw+g8_;zx^0#?h#-12`Xt9<$A!4hABL61YO+*^4=gWWWR!}Z9NCoGq)y)M-HZGNIEzM^hv3ilGt{i)h( zj2`=(x%c^M)B>-w`hwi`Yn37cCb`+p+>rLa>P5tlhf^h1xfyFmM!Y=6Vt9VShOoq6 z0w;vJ-%3ssUtKFWSAO}X<1JHzMA=?%bA3JKVdnmV8J{L98)(-|Kh13Q`%0Ski6b48 z9-3E+g|2lBa9FZKd0~3MiH45QX+6TN2c8{s*|DPR$>RBq{HL^%J~!~X9(-RP$~(>N zefg8*d5!$~ZGZf%9x+~PoUbuulC{vL^A0BxY!ApC^oZPXfMuiHk678_YW?!XPYvFC zCUe()&)tyVz4Z9$zm}8SlR_W-_dKxathL1A4LTK@C!76>JSE$0zUoebSzlsBbv(yb z?fK~|%5o-8G^q)Bn0eyEwrvLY-g&$@w^8~(v$?SMbj&`uiK)f(#@md-OlF4D86UA~ z*1wI8EnaLUQhR>=hsA#x9GxC5&YzvLY3{jYXLF1$&&>O+(EMfv_X*J?>F?LW8(Mk` z-#k#see^*nxjN~?&gsSHZNLBe^6j*##M#fn=_c})i~Y|k2h`7rpPDL?T3dz-w)tIr}2 z>_4A5r94SsqkcVuM!~&GhHZ-SZ=B_lcB{|--se@=Fr)V=gshm#)H&Bi;My?3f-lNR5!pS)Ay=A4OZynP-r{CECv*!|G{RV(9q|AkKU*ygd~nx4+mFuj+H z>VDNSeVoDJw#+m9Sc^u*^+k6}>whob6W?6twkSW;-OD9s>L!-DZX2{)t?VV>X?5;WBAr%FNBWQ5R$_{#Pz4tm?eDt2mi){iZyfj+~ZeE0-N# z1g~i3Wh~+X}lHm}) z@cwqwBimL#TyJWqY83jnQ2Lwe=?AkvDRp;FJS%uUDQxS+x!ha|7G1NN9r6P%o|2kd zI8kWord$utzXj)n*KXJnEGVge(%{0BCvFn6r$4K25|5hq^v(Qtdj*{SZ2M3hGWA2r zREuPl_^TX`8BMqDsakgHx%Iu&tQYKY7H%IVh8~VNDivM1dXnJe)|AvY`=)PMdieIP z9j8C_Ui$w!gy*>Q78iBzJI*x`q7$@K0&3s1Z}tvW`=>QyL1yZgt$A}h)I)3U_uM{b zcKq;zwLjOaSnpG>SJ)zT{I$@Gshn5krcYJKpLc=z{Q}9GjAnKWIpNKJy>qQYZ%pfZ zFzwG_3I5{Ewu&G4IT($8o-5AOW$Dj|oAjMu_%y3(r$**v@4z+NRd(%}(&u?bWdD;@ ze&&ni98G6m=;`9*I99xN;wPswtK#-YbJf^a{CuC6o9?H)r}uB#)B4jfL3cU6uFAKn z-smi9yTbi~XX5$V;#KRf$85OBzCqLd`Tp7;i#{t(*9m>QCL`OS(!D(8+_Eyx!;5z% zHZxDYwnaNUWKzYvw1E+kMhcPflfa)2`on&QjfL3A29ASAC(BD0uRFb0>36kH#+c1urDGUZ3?aS5ITB zR8L>|+rx{S1Z6ee_GJE27Suf7(uKMcw zX@$Lwl}_IOqsp!LKemhSdByVWSD4zB6C3sxh`tP2acb$@mN`qhig!DdS3qYpT9ACOeD`#W#>)rrir<{_gx{E^((=5Q|ex=YhlxR#TOpGbAMak>P2A* zv+lfWd0hW?|NM!z&G$Ut0w154>`1`{35_v2a69m3? zc0B*Gw&&ov!k1Muyt03Od9?42X+*9d^6xX-n?`tXB)w!O-F zz2aft(@E!9J$GyN9{N6a;Rl0*(q>KHgEx1`zZU&_)yU15)wjBh_18abvFv%(3uYMD zJMI>%@wyg$KSD8F@kR;L)Cal`HBPsEPP^zr2xEGjQQ#zu9Lj zVsym1?;f?=dhgEO^n2@K1M;5-zEAt}Z%^c!`yLMs9hn4+@;84~de<80AS72g`^@hL zpPzOGdi|Y#T6Fpqf9b35WFx-&uAV;MY(GPP{e|QyDkh0->|euTCPWyd6yBHTGYwd0 z!T%?3y;VyeUvZ4ltJS9xcT4T}jaOXo;c{7&xz*vLZ?*rtQl0#7dUM{VAby^{>IKFM z^8M3RX$a`Nc3NKhFz;OSAGu$PBqFpA3%OP~o!PeXbf-r9vUeqMl4pBY=_mxLta#-d zms+`%c~||6U%B@(H^p$C`nz3p(Yn`<3QsOwKTAw-Zr-VHrw$m-IL0MnEW%T^dDkTl zTbqY{Rx(}7KeDx+C_4G4>SW9R8O$xS&*YcfHr3i*W@vu38|Y7 zb$S_A*_~B>SARX!pIfG@q2c^8|4gUCga@Km-MxOU%MVFkva(+LhKlPL8Wv@SnR@=IXm;+=rfRt=+=P z9J}KB8yl8)d1Ck2y;a_P6OiRwx$4c%U~x6U7U8mkhdd6hGf3i5=U!0DxPmcDuOKxy z=7XTT9~vPgJOAoQ{>~Y~?K>9m>NST6d9uD@>RYpa&&gh0)t3FS zleB&pz2g${3@*sJs&GDF-e;bqLrHv3rsY|ezwL5waX)xv!c?uhd!O|_-;-bSduFt& z6VI2k(Q{LT=j~qhj{lAQtHuWoi+1g*xjvnLSLXYWt;MG}_Dw44vu8fded2KayDxcR zDPo)xLeHHzQ{QpsTW3Cx{giK2OS=xoMY31zjr{XArl&H-K&Vk+lBdv-jnk)f^Uq%~ z{h-<&Va`c6tfMYn;(l{GX#IzG;`KXaJ!evA zZCcJ=#*`6u$ibfX;jHqVT7J`cHx`{-7JSyP{QC1V4^&rZ|LVJKw*H^3e!=hGe)2NL zKbq@{%l~o7#Y|@cE>uVL=E0#~y-r{H=;^*{JsL>VJ7R)HB zcm9;2!uHzMuczMe9=&O0>YudXcx!oLV2hK@FINF4-n&YlLQ)wsgWb5@CN#}GC;Bt5 zbL%-h-&jM>GloKU42x`*n3S>u%{^Rxo)S+EF|2ar==)dyDa%38Tz%TqKUypO za^G`pn9Mgt;D+*=dZu%K&Khm&Gd4UpbJ0iFES{&|lbt3#aY=pWyzY5oMeB;iyDyaO z)o7Wu*}#RR*Ijhk&FZS3UI$WyT9RJzu@^LP39Gf6-LjbV^HxdDfdg%NYN?wKYS#50 ze!*pBA@+N>`jM{_s(Kl(r)|D)b=_@$bGMC3lU%NZI!IJlU>csD zaxCD3kKTQ8KQEq0)+l$#~Vnin%{j{Vo_z(RY!^KX8TXL~ebo z$kxKc%GU~SxEmk1w>!LEiA`z4k^9_9`}03$G;L!)bM|gf!2j>Jr#~yM{eLJ@a_#?{ z(hK6njo;qeY5Ogw_gt^~Z{F}S#l}oFEQlUwim<8L8 zk8eKdc|0?ee*HdQKR^HeeSZ6gQx=rCEqixTB4sg$l`$V{r&^~{nad5a zRdklq10OI8Z!h1^IE6$0_?!9f@BL+ZB--zfMXlxZi-*{RS&U4LjUbg`Wc2#mW9y()L{F&e~Nzl-w>`p``x86ppHXE_iO*}vtg|Fc3qHP8nRVy-h=J? z-}OncXVq>Gd}y`0%D05~a{2K~0tfS@{nvdx#(katyG72eCXbE-(erP!g}*=LB)&!U zvFKvc%VoT4KWx0W>+GvVmKRg*&M(`w^k?(B(%HEmlUD1-r@sEF#1phD;QE%?1~J`d zud&xB=6Rk8Sl51k**dw5l1q`X*V=32FMj_Uc-_QF)1&xbOmUn@=Z(*7S6}+iUH8y0 zfAg;e?@#?oEwf^_pMK7EDu=#g`L0ki;Z5eV((O(KG|igulK0*8)!#NOI{4e%eD!?Y zK!rUQf_RoOr5|wf*HPcTkL47H$TAy2*RGbIE3On7$JXB#&Xmx~PPuk0;>)>`NcV6S zx6RtWIyo*+eDmUxlSY$*ghpQfE?d(Ryrsv=r@orpUC#4tZr?5KncoiyZ=3gtbwy<+ zkG)AL`}rqdnia(C&KO*-UpRC3ydzS7N@sU0?P#iauu0!OciX}#ulKBcx9OV2U;oaC zUh7ZKN|=Jn<25HT)tl_!aq+Xw_2+uGLuVb?<(zoYw)gX-mHLYU3zuc9|BjJ!E%~;j zpkZR|weY(~HP1OGsWMsG{q>i>x36^G!IbXTHNtD01U>UNNxoJntUB79kjQ4{V`Uq& zsl-#$#&Xu57-t&cY)5-*9>PCp$#k zm-L?$vSgps;-WbB}f&lL&`pSwNXi z{ZE^7$_Edeeo@Re{W|OI43<3R_dB-)_N{mzQE^4U?{uHzsX3ct`UPjItKaQqT)?XQ z^t=20s)}7b@p3!bf|Obn9`(ft@Cnw)Zg*R^Aas`~&!;mlawDZZmv`>d2n^rN zyQAR#%`N;ppXVm`bSpOT>ql&Fj&F;NVO3dQQFguQ^1+oqV%9YLjP_ly<;+&5i7bl+ z->zR$m}tSS;PPjN0_)-frswuCJ&_PzcX)AxJ*x=|YtfRf>t`eDugfGS?Rt3qd<#?N zrv?xe0CR4z&?SXbFXJeVUvD*<9 z|IZ4CR44BDIQL08q3B*@xhK;m&p$_R_#S4gojjq!)_I>?GXI+Ap@+km<=1$~#09HJ zT;IcEVROmgP2jahA0@<29CNMzG4Bv-%^c~HZ*88N|5jM~h(!Fl*><7#lgMI`E1A=m z9!TBc$)38TXc^B8*(r?9+GpoX5VZcK7gdq)y*_=>O>_Pfi|H`o*E*x?z5=&6MljzckOwM(N0~`sPpe z=_$KxIz6{xjnP?!1jeasCw_~^ZNIbm_e1{@*ZQQ0{IBn8PhOOMVKnQmsqfO0lNY;g z;>ZsFyp%=eqWs72jmG9_Lz^w#i-odQvA=#+y!n3pz2b@(BH_1@?Bx%O@k zHE}6+p0e#FYrXbZ&*@US`U!;yrRSA`SCl5Nb6|hI zuey(QonD-I?mHXP*pjXL7Jv4;IiaE8*rBsJM{DgTW+SeA5hGarRKf#1&K8cV(7-{6FP`-SiLntJ0>27MH{x`i);%c8Nj3`9{{v@*{LF-Xq{0sm;KLR-lTUm z_qN@vk55*)So-gQm&Qibb<6&}zS{Qj#iGgY^j3NGZ7x`FZuhdM-ww~?SO2<`rJf@x zyDa{#*6Jg|^Sb`!gwI@i_~=Z||J$DFJv~4DXwgZrN{Pl7S@+AcPS&mc_&PrSPt)~( zb8GLb^rih54N!?I5mIn6pK~cA>xSw?)BP8{EKC;`Fv+{f`IZW)S%&Epd_t)sp=c!$hB3NLty6>uxz=P^HB1ivR zS2+`Sl8w2(&c)@fMa+IT*&A1wr%7$N6#Vn}h5x?OUyEZks(}KgJiK@Adii)A`d++iS0^<`SE=_3rfAjSJ`8c)3y4 z{9bwEA1^1hWkC~FIOodfUW>nb?+?FqwsK&}jO`du(a~mWHN?>3=f| zOHeCOqke02Y`*Mv!P@=%oBB^W@0cT5C+5bWzVb4IZo&<|3)en0E8Vwn%DwBbi|JDR z{bCKRzBf0fil4|ka6zutmM0`R@PySdn%X{J!(_K@f z*q_X9jXkm{_-xJU9rZFy_gCpnzWyXX%;;9rY1yXE)0%=)cFj4+u%LKnk)>E{-h-+w zEprvjd7>A&%2vi&6*Opf8m!rQDZc;URH=`h8tY7qj90Brs!3Xx^>FeFt#F5B*QYdE zriF7$NN!xe)$QEMb=!_@pOyW?>V|a8>v;c1Q6d}kR%UYwCmUTiVo_aI|02rtoaef& zi+0aY&~@D5-_R)-K21^0@#F*^L9Vv?62jrD1YzI;Mk8<~@s%UO)hMlK2C&P>q?Si9T3zwC7P z|9`v6Pd`3=`f%ZPoBcmu-gy7NuJGslyPwWJeD(F;tJH>jZQ-ZyPm`aPAMdsQrtbM~ z&)vTZt^PWtR{JRTzNDR1t2nP*Ge0}y`wiQwC)1wi{rvag(SvF4?}%SFxBtlgK3+zz z_DlV<$J5`vUSIwrQZT@5{s9N3)dFnVCzEYBHP*7P5X%=(@qV>2|Ayq(oyJ}^X8$Hv z)Uj`7&DW{!63N-HeoODhD&5j9^NXk18bWG~XEnC@W^Gx$FJm^#5@`l51}0O()%OQ?YnTgg-LPJmVY>z#+a*MGi!rimBZ3mi~<&{?@c&Qm@$YPJ$&AAQq58m)rgqx$rWZB z>{kgqcT;C{b6j(E)_PN4rdv+SSX-2vt>Xk|Bt1`1QD=P0%h39uI>V8>cZ2K4Jy#+f zQcIax3cqbHbgge&zCbbS!q%c&47mrSHE$YkXs&Hzbh2R6JXLzm;<+x*geMPr16Aj+ zCM%>U?AYe%AT6QrVv7D5E2%wVk20RP*`0lK^T0oa9``qscQYo<=$XUvE=TA*+c$TX zOFbqN9JP!s3_m`&s2XHI^4`?%k}WApERdQwpNCceIDjd5F<_h(Q4 z?}zX5Zqk`pcQ|}rob0*z?>A~~x2ga8t}{CBO}+K5@b8jezq~nHx4nk@(eKlbw?4l0 z(duSl?T(#R_v63&Y_tD${NLB3H_hAc$D}I=@4uv>>wkXThjqzux1X2Zi+{X&jgJ5~ zxA6AsyMLRktBg6l<67a~SXphM?ctK)vezB`*==RNlw7zBVdPxc?0BBdR{BfMg?cz^ zv!gy=RpEv1<~W%zj~0lt@3nYw6e8r^94GbV(t_!1dre*}jjmcBX3DO5VWA?IX2+Vy z%tp(O)I&F~UDXZFD@o<}l(>nPxTlJy4z;{z09`F?4T{Xl~VKZqjIW^Z}o)(u9+A3d=R=bq4lT7UT85w6YgPfe!m*tMr#$>Z~yBE?GhuAGj9U@YK01t>9MSs!~=9X$$7=0>cwQORvn^EGbiN{dT&U=H|kBp-Bv_ z<_{7(IMNM{OWt0xlD%Ixq2S$@Q(F|7rg=KdHu<_J-9AS5ZrQ~LJ4#m-yE;UFNu9uL zvLjdbY&utPz!R^{4cju#9O(W$hqqBvr~gp*>5#bk+1GPt?SKDPGD+uwVsnI`Cl8bQ z$2IS-nXdGYT@V>}eGLzb|Lb33)~zAiTr?`1zMr}9GeVNnuP|-0m|byBCfCxWgFD!d zuRZtZ<|5ASC1#tavNy{Ju&?4eJm1sdHT#K64T~=pDhdWf9etENw_uU<7U>83y_2+- z+P<9D#(KNud{lk>LKef_Z6&u4C+~}18MS<3&V`3QCtPnVZtC(*3tnF_m*d9u^*g;p z;wwESZngQ;^3!MX<$zmkbB$8ldlJK)jgC&9eb9T(=YZVi0`G)aFZ*>TKU><|Vq?uT zn;71D^|Q|pk9m)SBNFDxxb*0Jx@oex=0?BQQ~tjig{o8Uy{WITuYVQC{i?S3)k57B zIr3WC&Z zZ{F|Pd+zkCS#JJ#ab<*A_ws@x%bz(m|F%4G{#^6JkGc{1uAdfs5u1C`EAH-HlRH-m z4=bPg`A$}@SGWBAm*VxC;<7il)%QPHb*24OsHE;rqo|_PEk90We4M%|ty_;%`x9G= zj{B~b6-|3r#P$BE@hti46#lN&Yx7f?#-uXZ`RfqmsXUQ)xG5p&!2X^{qyYdfX2=L zj{Q6<`ZaOq&U^8-U!OgD^tJBi&qr_nt)9;x{{CFw^?%bJ@7^ANZ+rgIvp2U_f3{1$ zZ#U!n@^86c4~xj(TI4UWnO%C>w~2|Xo-S-#$#*!Uy*_c(>Up9L58eq|pEq&Q{HomZ zCayGC#J}yrYO#nLhLaC`a(s99LtMhbAIe$Tn)8osTEy64<2CQs#O+=O4L5ZDPiK}h zJ^rbFo14b-t><2z-CH^T;%xqBrF&O?{IVxu--^6-@!vyU@t^t@Fg5F=^3*J=r9m6F z_J?S#U+JXqoO{vQ-I~sNoSKyn>+NUTKKZmy{-3?E`fe3a(-n0?h^c`EWF$22660qM zd8^x>{vJO2e&Vix2rOz1w>R8o{J<(7C;PLm{Ij`iQ&|EQRR+`hA2QZ68cyeb#OTXt z*dF_caeM3|rU_S=j3LvDOs3|L4V!bry(ix`pL^<#(&I^{rKYSkJ_y} zstT8H_9zJZ6y(x$k{lK}3oWCnyvus}{b(#I;yNO?}=m{2XSayGA zYHzx}=d;55zgCC&{&@dpnyR_i%ZiC2Ht#-6y4ZVSPyOV)mLx0Plb-73C;WSlPyS?7 zHv81Ypj6(CtL~m_(!6`_+Ei|v_Y>#TOqhR@{mosrywVr1mzoPm{9Ra{)-A5TNxnn) z&4u%iSe~!h^|UTK>V3onOEyh@N2h2X=3mW~>u!I$eowOI6^=AVoHIm&Wz8CPR%&6Ig$Hb;F7}VTt*pV_J%E5ZZ8YmCj~Dr+LTbUrCCu(fVDp5 zLXV*3inEs-|AiYkEi$&<*LRJ1?osCTc`vJf|NDA-d-IHE`}ST~zqsvjgKmcYq5VY@ zc5iBtvRfS2|H`?*sZ+m5ZOM!$c~8$hNLZoz@j|p;*s(*oO)Yn~=bYP}&MBhP!h5(p z0ewzu}ywhjwe{pTb)dYsGQ9jMruGYW37jr_&jPYLOg*-2{V%ChQKHPtE zx9nq`zrtiO_ll6?yH7D4o3l||>#5~}t|?ESa_nJPQO(@3>D{?m_1~Ap%I(WsHz8sD zm1eFI&8RC2K6h2{POCV)zg*HZ8u?^wDPifkN)EW|I?LLQXHvtgG*AJ}|-UgzSZeF9)jc zB>(@UVqtj2c}*kl7OO|f5r4{)`>JZx7c8!sX!+{<%cG2Y8oRf)X!!61l^k5OvuUwu zu-5#~pK5Mu_C0->{`#EAy9;wSO={dG&$dISd%{A8KPCr6C$F+#uK#f;Y<``Zd zeh#f+Yu2v3(3T+WB(3QuuQNmYbH~xeO@90ho(sL4_>WEMyda(=_sgkR?es%~bit~t z>KQ9!7flU`cdA#5EIae$;04dUp{h%=X3jf%W#RtSIU33iGTEXM>w`VtGsY<1P&DP& zS-8-(@MnGW%;pnkluk`npQ}?pHFHn?>|gRPX6L7rsHWE3QiVlXzxuB2EuAFKU9a}f zMkb^1lgFgT9X;2lM&{hOHGR3!6HSgg`*v}wMO;`@k3V}4BZ{WZdF*BS7hhEv}NsIWV?6k5rNzB&+c*0 z*m$_d=b)O#qu+b$%ntT1zHsgrhR8q7wJsW*-7%l9&0W3Jyl+h5JFdBB;bgFXu$EpM$odnYqrEh9=w zku7T3`deb1kN#FLFX&j*bmySc^2zU8Z@Zd@i%wwN7h=1BeOI?jVr9t+QHQr3OJ(ck zxwiW&bG-R{eAf$)dQ0JAr}d{8f2`be`|xa*%~Ougw$(9KU%ft(xur95TR#7Rt2<8k zEHiE?shzRWD$2mrdd`MD6<6LFeYyNIX?6UDa4~iL2Uocn_9(x(7T|em(wXUsSC>50 zs*4kA^_#i&>VjEEE^;l6?^pjA`;q0=GN!7vrJ5hVUHWdusj3;O^zzN4dK1^mm>CvZ ze0vuz>@6tse#o{W)#Lf63CkF&y5{huH~%rwdrW-a%lcq zdB6I#G6MH~zpeY8uc8yN@htcICF|HycioFsUEt`Q&SS)Inmh0BJn=&;HtP}^+di)h zp0DN|IyFje>zgf6?%J0kS4&$(mpv|e8E2|<`{LXm*Q%GOo!Yj3`LVhq0;Y$qF!)O> zUboZbrg=qPjE(nny}W0_FTSie7i|CX*|+eB)7{O7y6ewPYQCK;$h>lEBfG@RD9$>~ zcZCL1{xjFSYL`AMcu4B|*}VKy?l%SUw?FyboDh7wQnTGL>%iSxzg~zPk+FJvOmBhG z?ApX*!vEJWby}V>{(X*Z=hV1c(>}aknD?`9<8`LPJ-5~8#~ZvB^HY;~=qxPit9(Uo z;|5M9dtEQx4L>S0>)p36-Rl>!NW_gJYK}hd^LhK<{_7~&e*0{sp4f*+MK}A*7z`?3 ztrqoAjdW36GWAr>A7QER$rr9J4WAmy9-W?5zewaxez4yTwfkl|ha%jZD_4m78n7RK zy((>0?&O@;g@Whyel*%{;ituN&?U%RnZo1ydUQy#-Kg&LKPpoSF#s$x6DkIl1 zPk(bJu7Wj2>tB-ksYt$?1?viZa=G_D`&An(@@1c zCzZ%`+g7S6Fge-Nz}5Lei163fOT}{h<1$(T51s4cS0(!;|@Hzx9y`^e^&S{-`Ky+tj@RV zB~K?7u+CSO_G0yHT$MG?$#-w1L+y?qK^J#^dsHu3{5zxKQE@fudqa?~vCJ2cX`lHR>!&zv)XtKHplfq#xy2;)noqu>1lH`r{?pKTK(`1eb} z_jwFe%`cn1J?ruhd@sbUf z);*OelC-&zVe;#)?ftv|zbN0I`(<@T`7PJo^3y)v{k!_ToyyBT_ca|{`*z#E`!q+i zaM$TYO|C*^e7om2|K5D7y-=t5rICj3<$oT@SGU(Y-(Q($^t;d?yL5qmseAHEhS~SO zDRG{fcy0b7l}n*Fca-KIUpN1O@baUMzFBuZFIa2s-n2MX;A&~O6#dUSJIif$5&LpsAxq0u9uw2)wHlK&Dr~M_owYmNF_|xRw@?L1MgLbdyngBs- z{S$5lMq0gl#J@d#Hd#>M%od|B^$JHd&MsS+JHH_@-LSa3O{US(;MQr6pFI0SK74K4 zy5WC>|MS*$RZCtL+*4n$ze~wr2s-;ZL1ov$c$3YS zJUnG4zU2rxv2EUkUxzG&4j#WbW9x)1{#6?i4m{qXrYshg&N%0f^gD@KQS)D~#MLC~ zlWMX%3a4yvQ8_0t`(I%1`(Hb)r#wzoeY=)5-LO0O-ML8nZ#~?V=UlejG3P&Q{GR)< zQnE$-#=YC5e5~5i*trs}Fp2(qRe11f-MZy`C)u~yKmNcNF;#?DxC=W5Rxkr@g&p83EE4`mg^ESoY$3 zXnN-&W$CIfm%CP;ZwY0xU|DhLh~t90?yPp&TiLn|5~kQ@?YFEkwT$U|wW8tj)Xwrr zSKglzx?%C<>K&#E&pfv6Jkt4z6D${Rllbko^Ze4gOmCM>chx>_bkk$XZ@ES>*1lUR zoJ?|`rRzc;x7PE?h;qH0X!nz~G2y!OiTO+F{98DDU${Cv-gIfTag*(1j)XmDy?EAL zoTsLq`Z(yho{{%jhpDGM@9wLgsA+k6{m<7muh-=#*`~Wr;xN%Upqs2FJUiA??VDo% zB8?w%9ooGuwvtS9yp+@`x6MhK^I+4~dO;oGna1CnU0)vNa9OgTevg=th&|iHkOL+j zJ0IzA{7$|x?N-}S)``BE%iNdF(Jl~c>K0y-tT{NT z6*~BEXX}5}%p&fY4tdJcr_0oy5K8#*h($8l&SXx;W(RfozpMdo8RTZ|`z3nEb&9^B z!{bXCQ*Opqw5^t|cAL@K`lJ4=#EO{~aZ)B~)d${Q?vUC0*;c2`$M)P2CsU^)`Im*q zD)h`gCU@&jIpD3hdFwCfC5O68mge5OVz$LVyQhBr*DdExo-n`jgY|rF<&i}-f)l(K zX*|s;`TuB6uhC}J>Gm={>s|<*s53BR30`;ob#tN?kD{X5Rhz9(9E>*buK2k2ZoRlq z%0_>`Y~3l7RJq;H+nF`!opzmWe`Rs<(t|snX|0;@?QW0@pW|Cmsp$u@_nq8v|N8@( zy7_UxP2AIT{4PEJG512#x`6#_wM>1komGGFqtd1GM)rEyruR`iALkmn%x6CtIqi9T zdgYw^vyRPwV{cY-mbJUP=I@X9Q`a54wPN=7t@SHY3jZ)QZtmUX^lFCN{dMaOdC&2g zvE$k12!Zd*>$W8(zuJ3-r7r#E^P);C@ux8xOuXL+PqP2Svf;DW-_8F&-mRYh=F*&# ze}0C2-5X}x{zI*w?&C8FEDFhpq86|$v<-<5yW6~@1g$ynRxm+y;< zVh_K#xUtk|9TC>NcuZ@d(M~mgweK7&(Y`+U23n6`A>)WJqcSEjZHi)>0UfDX1m#Vh3#9Ba8|TsWOr zbXdLkgzCxd2BG;g*w;Bno0R3$FAO@8b#dW(LqYcZtf+}`SsTO;+C05wYiO*Q^Plf_ z^py)bAI=o!y}91EZ`zhEvO-ZM#lI6$ChWQq#8MR?y7hX{l~P~ZX;av{<_63w%$r^D z;AT&1;PcC-OA?9>FDMChO<2F`?cbx7`1!A*oaYBlZ(qsMdL{pa$^w>O99d=e{p(XdGdgcFpWIZb^CbN7N2ZVbp|2`S ze4Or7PrqZmZ`ZxozL$>No&N08vH2G`!$dw#ciwP9;q)E1_0QWMT*}z+yjE#<>g~J1 zo-6mbH8W26|2Fu=r5CCz&b=~V;{Q9<@z5lT-=8mi|9|`lL)S@nsmf2;+>-9 zw@=!Q-XU$4M}>a;`F6LxHt*jK6Am}2>Go3@nEp@N!h1WwMf0@L&R(mhmuBU+FLk(S z<#Be!&+ivYgXdj+|0jm$b=@gPN2|*@-GPFIT#BAe%W_ZL`E&m3^xxtCS<5!ue}>r* zGc_C7h4 z%7$W@y)^+(RxVz%sL(xV7Q^3<)$clj{;XP}vgLZi!ODOqGfx-KS4jQ|o~2Xb6?%HLwkX3t?%pWwshpm>s1Q#v-_%>{L98^IlH z43g&OEYCb;$(^7cXZh2vY)MQ3r}&zfGie7T4y7Jj{($|SiqEUHpZ=cTd)T$Z>t2QO zW7QY|y$;bRH}Ul~0w?B8>6es$_)+V(NrL{P9;14nkS8BJ-%M6I@4(0zq;GX%Hq%2< zyWT}UeHT|wmzl?8D6n9*;U|Y9K6wY2uBq%v6kN1NaN@~ywVC&mm=5{AXnf?kU!g}m z(ynVSms*0(0zSU(181}iXgJC!JZ(AZ32;flo&lY%>4!d4*A8tifNj7H?nrSo1eF8xWD_?%_mztUuNyEuZyy&-YTIxtGW5% z$-VDf1Cd7 z%H3~{o!w&|^mnoN*_$a}mi%4f$LiVe@5q~b39|y*?>nV_UUmQR%{4~@mhbJX7tu*l z3SX^A@Ba7i`N=o?n;%ZzW}UsO&g*m9kM$2fKfD}#`##4B!+m@{ zm*af=JZ3FCtT(Z51N#Q8h(Ndf$M<@~uY9=q+mg_Tb?n7|iY}cqu@~_SZDc&YV6ous zC#42^eXj?|-tc%^yhrrt`^leEuV+LHvt(z~>-ubAe0|iyO1JKK^WDx%VUYp05}R1$ zp7GkbbgLFhUOrq^G2difZmXc)VT(6UcTI2Haf|;+OX}UL>K2O=L(9J@>nQ0wDbM&k zkE_P@<^K5DxjPn~owmo|W|5*AT_!_W0&#C=!@dE#`KMi&Iw>HPd{#qF2^EJydSYPe&y1Di9^k?yZ zu3zzd^G3J+$tRP#6w}_WsjLWPm~AS_Q*T+f@Xb@xt$XDA^}cUjbfnIef%CSO;Dh{W zlID?TB6czgaQzIMSCcrw=ku@W+uyssPg(X{Ugg`9_ltVX%`@sBU)pZPxcyfar*C*} zA=^3&X7{B}FST7dHp}mj)q2mQ8E-Z$=*YD(kuQ`}vYLB$ucX`jUNx5{#jf>}DlA{+ zuui+kvFQEjaK*A~oD(A$*7C+I_c*L<#bfy5$$M{!i&@P93J1&sCmBQvM|1A~+Q-T% zsw%j5T8ZYKYnT1rFHwfyx3M>3-gtiIMVt? z<7G$5P1kqM;aqHT_unV+UVWmkTEVW_ETZEvWy|a7Mb^_!7wk||=vJ96a4h}FtqHq) zC1iIvShbw}8JGH)$A|SITX*v$&y`vAI;QpFUVoM>2@U)ttr?x!IPHNe&)wA#Dtouo z&U!iV$4xosw(1WB{GFBhr;eQC$uW8&l@we@Z zpRQpKn`qVWWXYnPZ7N!NH(!W(gkL{>wTD5~bed80wGZqmD#p{aHkfsO>;Hdb?uB`r zXQ$Q~oUflD8F~F&o#Ujkif^%hZA>oA*syuNYmav8wYh&C?iSSU*{wI1wOKk?|Fd7o z;Y79XYxyR7opL!^ShVx`*V@7*F*2Is?x&7UECMkzHTq1ZOwpP0(MeJtM65sId2N<~9LakI0MOzstt$7Y9%%^W}2 zNt=J&vL}I&FSj}8Wr~KaNmmJ9p1j8XtH+xZlo~AeHcp#j+;y4jcSGgh>{=5K;Wa7q z98_OAHMC6Vf8YG<=bPkO3$Y~=*YdcCF3J-+H2G<6f!pTKnYG6X*pd(2GOcEIIxyvP z+0H%L=jwM|++sJ4qj|2mHw*K!zxRKv;GNQ4cFSg;^hpH`vkfY%=T5Cl=6m<@o6|x6 zuj%D$j@GT)%I?|q?ag*h=0y^v>hEVAU12BHoYBAUhQ&6Ar;q(ij=xvCy3ym3($QU} zVw`PzZ)ZI@rpxyK`zPmG9iF}u@2nO*da-AUf9Wl`l5?|PzOVOx&(oi-JNte1=B6in zj`z(h-p|{zdGjxeHJ5kt8;9?5<_oO9lXY(w|L0#8VNd<<%@8r-<9rv^XfpY8+Bd=G zEwQy0im!M~GPhdUd8sC>Zp_}znY5*D`QyAbbJW|!miA8ltdp5{OITRx>UYu4YU(?e z+)wzF5IE(s+<$kUY{SMA^*8gFwBH|0-+lGj8GW_#tto6v%<2}$D5=ffF7^0m%B~fC z&fg9O|4QnJJ;l+oy)ESV{M~_fW2$>wCnkC8Jr8%SW%u2jxLR@EnOS*;E8lBR{Q0`2 zCqr4xsp@34!b~QueDcg_d zPt#)0J+n{jN7Y@8w}p>ZoqO1(eOqAqE8Y7Mp`7oI9V^-JJJ*N3eDNwFZ&BrGT5ejQ zJzEZGq(2PPojT21+ADf%)x(s_Trba7d0(rK_B42OP4}j?cE0k>m;L`lbzBzl#y2ia z+bdFh>R6=1p{Y-8G}ka!-WKP1^sVXOmcN@{&f9YO=FJtWcRbX5e#Yk+uaes0V!q!B zQE@SMSe3F@*iShTbZO$@(;EbfWUeT^cz*ZvR4t{GVeJ~b_j^`rZuLGPq4Lr2);;sy zn^n5*QGuxvNn$+vKzwUiGi(PNel}k@wtex|H!V%k7|5A3c zru*!<9$O@SVA_ITwH!`UIJPahQ*CqlrS`-Fb5BS+k;6sDAtBUEW29!}_xK{>n$VGW|wtp0XxoahaJ+H#B7tW;QZ2m>wv>qBVWO17^N@ zg&#At>?kCY;r7`h%Ur!7fjQ&LZs{Kn ze|=UryZwsW>h`%8Z<6ot+r96{!)BlKo=Ht&Ic0liKDE?zu{xdMn8Bp{`lkNp*K>Ep zY*3p0zwG4GJ$K~KrrYI*mgi(|-DaHIkp*ZxTLs>1NWG_wF-J-MbNbYty~3uh;bUXU=Yx zUAFC|)b)2VOusknP5D`~y5#!fm8+lLo4a9^_0?&y#Vf+f5@KJjTN8e2p_AprDa=Mq zCzfouaVP99-?@$T0(J6l)|B;zt^BbrOlDMc1CHM2kp}3TXp65wHKy!Rx?=zmvYW&YTaa|pfrg^>}}rJDy4~^ z--*q*1Z=*@pGE zj`qIMm(NzyDI`iGk8C;8{FPLX^N+|rvXFS z@kaA)y1AR}C~CZ4w{hk^1f0Go1lK$q%i|qK=YhM5K)-G*8Ld@U0hb({c#32$DXg-w4X7qTGZgMdc~ks zy@i^qx)c^DRl10#dKo$I{jVMRWWT@sR?Yt3c}4GDY&7;0y7fLVIYaLDvBqBIr^X_2 zX?tt`y-e%4e#!CS(%>s5B4*Np*^`&0HqW2J|I727qUO}}SL-hu*E!W2-j!bvQ#51O zlYm`XY<)8-WTWQ)yzzgj^p=$!zQU}nvdikZ49*1{{5RvyE3Gn%1czf)KTCX)j9jEA znel%VGfYtX(AOn)D*nChzGG!PDqlRW@N8$|@2TJmaL|zIE!MF3@+i}K(~UlcY3zS~ zODTsJ*qxF2we*;DQ9)Fb$oD|`$5VyEzFZWyc4gV%f6&XOZK|S^-MQIGOEy*P<;%ac zxpK07{kFwDAKPrt%x?U&Q0S3h^(-fa2`M@M!k4SwJr|;|V0+UYxzF{_PR}v8w&m)z zD|Ra#mdjiBYPO|be*A=A=!1Z@pQ8qE-)FNju@ATBEDvT}sJ`^$TTXvlm;666opzd5 ze?%oJ{n!5g5@mHZUdMcImc_*lS5;>5nC@;VIwT}0_4s0a=pl=iH#I+QPUrvKU{sc5 zuvS39U*~Jc+an1zj!*qExX25mM#F69{`3TCTL1o$ccv&5!FWWZx@Ini9}{??Q4*Ux2MF*ZjGE zn#A~mQa|6^!*Kf2tVJ1yn{;peGdgy>AtWy)RVGx%TWYbMy~Y!8llxw3uRzH7hIf6Dx~x%1@s*;KwG z?_BrqwRG<&eMxpdm{OI_=6wG-@}yy`MVu0Pj0Gt zRlj`kA<-!m&cCF zL>=dSaZiwnV%_jalH2svt*W|t>|wLS-*ry@9e(TB{=`H7e((lsbv`+ER@6vrZra2b zS9Bg_=k17(%%3XzRbs8E#Zl)}yUKJZds(lEtxWpk#Jk^3?$#fd zC~KKNizjwGk4{mj4+=IfI>p>%c=ne{g5=3}Id>D@Fz!F@C9)xOqJ7kBjxK?k4<;8C zrYzB{=h^(k=1kXS18FXe{6Dg5vKAXn2{^HJQ~Jc*M`t=7I4)drY4WZ^n|`KQSBK{B zo?EZl*k7_pRW#(zBgdD1j3*U@i!)m|HOiisZt-K>!&ZCdI%$t@J zx=VeX|2=Q%@%0~?*2FU{JP@DCIzvakvydijKevyd*&9p2+sb$`Onjn z+$Vpv^eB0%>Lj1ImKk~Urq<8T`rfbgv@C>dax&(h6AyWC(=5LJ{rYc9=ROht78$En zwn6)u%B-jIlR~FHo9Qib+kNx$xwW%|ZJ1x}Stk$XJ`vR!t$9s&z>-?rvkHtrDMWpz5SorhD9`*y0C9iNhlWxmF} z_@}G;KeHZA+2(gI(P#6LEA_#vR1@!QOS-II-a4^x(>D98m0vS@ubfNtIihneYgWZp zud>j+D;RzD>psri`^3HZh>YFOqP6Xn8}(l6d)NL+aO808ay3X;AaP3W&N`Q?IaBk? zE2pJQ^-oD`2~la|`14kno87c6(6=g2+&^$NtKKH2)*YeGbLXV(Q`K}7?A%qaTFdS- zw@Kt=YrZJ6=6m^`)sd6Vbxw197(JzMiOY@XX;uF0zgnVK-PtX)P-Dv5dmo=~nR95l z<-#zA{ZAH!6*Sy_pE*_Mv(~<dAbUODMl z_x1BTWRBFcvm4H+KXKVd{zN%n0ZYuu$4T!hy9*Cglw9GFZM&D)csj*oR!Q`|7pGg2 zCw%-JvpGMNL0aHR_b%>pEGzgna&Z5Cxqd^pwC~#8?{;Rzw;bef&p9#4_1UU3U)9rR z3Cf7fKEQWxj}7-dDXu;aLlNIwf&2Go9E@EboV&^``|HWFs`{|3WAk>&>p5ldZCW5w zvfVH6UZ9qYk#;(Vp;N%)e4m>4l5c|L`+3eR44pJ>Z`A8xb?%Rwty{v4S~TUYy8dbM zUtRW9B6Dx_%rzGbKQ`&qe7b5-xtZ^T_>w)Xx3)G$DjPGfnYjqLvq{Rfw z)=gw@dCHLkiakupHizqz9}3+y*Yi1Tv8GUP`;peZD4!K_A`(@1QjU~!pS|nrcKphJ zmRV{u<}Z+Je&&?EfB)0<^Z&nK)p(OG^u6DI`|n;2&YSk1wl8#fCs({Dbat@JT^6C{ zEo}}7JD5G#pLU6BFFO8-@#3d2-^B|w@0va6XN@wEG%@44m6*oW;38xcTyJnP;A@m` zP1Wj`{V7kQt&i-r6IMQc%f)wT`fBdkEVoY{D_ihw_oe%0t5)C8%vC<2ptRIYQsPT* zi{RP4UwVH`+$R{^yiJg$x9+xw|Kne|>TWYEpN8LfeRIy?m`^vqrtaFcW`F)I*Q%t~ z<`Or`1gBOkiA~v;bK8~ajeq4W*D05k>)$GIes!|&Y?b7ST<`ue_w9x-ZgbWQwvTOb z?$PJ}{@A!~mXY>FO>M^AIa|079|)Uy|F3*S?ea?wVLj`4Tnv7gEN5D^YpseyrV4e{lDxtex`2C%U3Jkk38nAn62`}FLUM9ADl0a zEYSU_mamtws;0$L>8W{#e9g{0hwk9C+EZ)%XMRmiyOvay_BS}{j?(6P%rX44k}oG) znsFc1&~BEQJ^QQN!@RIX9w!nf`EHz?5?t-=E87`#$)kP>U!HZsyCt_xaxUlY4Vs;I z`PnWOw$fd`?w8(LolQ$PePyTKh3|T6b~+?ooOt>sM^T2M<;`j4YPY#QPPpg2O_zVu z@ywfM%acrQPpf^Po^pH9^xW*qS-1TJ(#vnJ>=Amw9=+yr?xd-uhnAgOqxM3+de#Hu z`c)i{E}iwr=IbcPwy(c;>dDN|?ejKw$>@rAY@u51zmS2|7e97Nge0Ls{M#cX6 z!@XkWi$h1)`#!!UdTiM{(%Hp!7k!v%?)N(J_GF2jc`7VxoSZ%eTb5|G z`#rs|QpRek^YWq>8&5Bk%V3!l=;o}^^1xtApIeJ{h`s*#f2=muaU7Vnnz;dZq=d!L z($aML!38W@^(QCYHWS$UT6@OqkkmsF91SH}?8l>TPAxLKd(5st#bc4XQtG5nM}Gb? z5z~9%VB9r1L{&4sEqe9Ezg6!m_xyRPE|fc4vTvJUU)$oH;x5-a8fjLQBbQ|l_+{cWt1ixm3%FaQ+bSkSR_2Fpyt_3_%x1stt+{)Hxeqe^ao8Jio;?EzEx6zZOT@H~GgrcL0ANKL^$2L6JSyge<-iY>(q-X0YyfodDK)>|E# z!eswez3s)S=Vk(dE`?TtCmtUPnD*_{p7*M997&B!81B19Sje!KoZIlz?7%VMmTyfx zU(N|6vq%`us^IXx?`g`o$1||~to57+0+$>PU3U4+v}jVl%ly3&=j_gTEGcH_T(Lw$ zQIkc`@xkBKhu^%i?Ys8jt#3;p)4RHC4SvD;r3-rbHrIZ6{U&|-8k@^s_Xsr!y?Rh3 z?cl7`vo*uR;9=vd&)xx(oFw=|o>v(5Pj3!C#c_yX)AFy=L@Jteji-Cu-`K(~)5eey z$n#-(4BiI$`;Qnw0tT&dsu_ zJaNT|TmN6nQtL;v3%06izU|YAnSb%!mFC{AwG$d!oEGd*sdyl{E?`o+Z0ou;jCL0e z3Mi>FzT3=baibvMrm3&6U!Gd?ZN7NZd3oL^ibr>R zlPX$&o#o-1TXv>%p5GIxPtCS!Ub{;CLezo@!AEpd1==p6>Hs_P#l*zdr5a)P)`gh(SHN6D;z@3Z4Z}dZ<`8(A|sR>No z(*G{b`MQIYVD*bbQvT7=Cl$`B{<|0)Xe&5l`c~`fIaj!BTMS(tCv08Y2d*0-SUm{tbKHL7y^TfPPm!59!aOsVUzwNM(U3+EY+4bM`nCxCU zO?mIXs-BaL??%*@4>GHlNlbt2{VLT%@AMVn*E?@LSzc>BQBz~myftkToml(}OeQPO z3XPqSB>qG@;ncaR?NxTSl9wF$8l^dR9mkjDr{eOfNI4bS5h}l(yZLFwx!d z?E5VH2JU{9&9$6+#J(lXQrt05YOCejw|n2pWNeo^$$xzB?~Q@7c2AB!{%3q5dH#a@ z?AJ1L4t(5oPI@u#omo2E_BFpBcmG)M=~+m5d{xLCzmQoi4@29Y`gI@gkoh#Z&gbEg zZz0p)Md#^1eObW!FMXeQz1k#YC6!45hMkS4O~a4)a$fne@#Blzm))lY&z&BRHrAP#T{r)I=MD4rRfU%vZRSk}XPQ!gj9;TzWe` z^YJ6kEivKCi{@URpSxqts!L@hXIB`@8tJ#WFa%pHzk6%SK?^3~+kY~5-d(L$FJk{e zm~U~>^g9pLJ8br3o;BSsV4dz=e?Ds^^XjW}8`rPCaJa~Hk7sM+r%Ae6svUe!b5&lZ z+{>c4$`TO}pwdGur@8{1x(|-AV z=#*;PQ}sF_5=&AhU0h#1<^LtQ)+N8>XH?m!SNSU5{qI>bdvCS_ z|LRRtnV8uY#Fl^i$>T1?t`om5|Ggi#cXElJ2j?UgCTZ_&y8gaP>+fIr?PdLF!fFrp zL)TyP9(}2`eTwv<%U7G<$!}eE*ZcpDw)MT$H@9c62|N4q%Fge5?(J%fKHEEc?*A8( zGN;OR|FHa|)Vb4R_8H9$iU#c~C%^k=&>{b#%h+YcjuopPG_K?EeDJ)p+^|l@a6|uc z2acmR5*k-Xbbd1wRhd-s<$&{5k^1?LA5Efjzn;(Z%DTJr`kfnP8-A9j>Fm{fn0)a{ zZQQkaTkKyXUdVb|mnKKylXMgRV|Allyg8FSC+bGF@kw9bXzd#&5l>9h9Vt=;@<-<{8W zyD}!{gQ0xltLIaer@obZZCZ1ud6KM8a=Ma^WKve*qT@nF`5up&&!64&uJrfmSq%SA zX?8YCgtG`GUig@Ng-1hmv1m|oOp;eeWx~{B74?&NdhPy}OjYd)UCrAja7dEV^iTE8 zuZbsr=44I%_sT15_uHh^D@FcTgfS=I_N#vVB=q`>`FA8UFD<#Np7-JL@7+%pFHPWx zp54!S`~3S^*EZkCJH0O_%V7QFH!1hltdDEAzr&HldecGo^o%c$1P(D9iLaALog=JV zn^vsIaqYUHZoQ-mucWPImc^4^!7P*5n8&G$JRYlkGx2}6NKd%!V_=J-h;{6OY%?{D ztdz&AGnNK96x@hMAEs>doZ$)l1ihGT%9K<^4RhKQCXM z*E;ny=81j8s(=+Ix0yw&|6S$8wx(XIy7vB;%CF~U=)BU-Ird4q>UF2Yc`IG+S;z9< znv`z7{K9p)?aeSr3l~owX4Yzf*$ixZSrcTwY?Hm!F~M-LN5Do0iQ3C$o9BKMdT?Xr zyCs&}y^jbU=ed+w!=1)3=|Fu?@yEk{^OId#{?s$DonV@%%fLL>=@tXqDI?~k8vHsQ zKUw5gr106zILT>uVc|z(nRy3!WQrPAOB*)Vh#7M%G1$#$9OEwUZ|N#{xa}f`)eatK z7T%egqD4&4I&@gDeAYGPDbou}e8RwPG);Zo&i0clcZ#1e{r>G`l6+foG5_QG)Z%>g z<92Z$GB0M=+AI}X8KP(P)4-;AoAea##dnR8F4rYW{o!4>GWW;B!i5jh)h=%Ozx3&L zvCo;@cBu^MEgZGKwym7AFZX%ChmAMqY4i8FXFT2iG}N^HyoK!QW$jmkj~@K2+{ZYX z|AF=YH-gJt{d(QsyI!30`kwFnl4!Hrn>6Zwug@-+;96Gn_1uq(PD~5hQ?__p+swAw zy5sVytJVj4md(1I_1w1V+P;3NMAy~3_qA?$_qV-J?ucxc2FKR3w~Kz{PQ311%Dc_; zEq}7yzFp6E7F*qFN_z6oO2;zf)vubG3%MOzx}1Z>thlaSve)+#*4KE;x^(Y?E%{5B zsu^eLJJf$pTd*>&;n{qKj7_f{K3@r`7xt`-xpb$)F!-pR=e`}&n#>|&-Dm#UzSyUA$CK09nyO9Nnx-*}4kQ@N z7h3!?A>%Cj`JF!>l&0A+Pc?dXdrjxU7|~k~M9njIJ5}vH&;5ZG!!9ddf5eO8)sL>>{`?K=gf=HH*R9fcEoEp zFOaEu%=Z7`h5ED2mQxw(lQf$dnyyDO?Cfkj7o*_4@z&O#fx9JNS5=%#6yEb~>DN7y zrvH|gGPmX2JuP5u%y#XfT8tYtNk-YE&2zCfYe1F)&6N;I3B(*+U!-g>-YBm%&sr&xvKjQOq;&o z<{A_CYfmLbp5D)lWt_Pw=DMuD!iKOT>h&@#zV6I7Bj*0eIp@lup)}uGyz%XulDZYA zk`8=WzD)b~vajvJ(=S@pGrm4u6FFy^qk~`TM}boLq?|h)_Zb#H1X0aE})t-J_a-g=WrPuGveHNLBKuMQ>{M%YLEEGMSe_?IkyZ?#TEYALq zGkjz6x!&=oUaH(h<-fP<|0*x3vzc-<(b42}!fxl{b=w|py!R(x)zK_LOMzQKddAAs zeb0|6DKtI$9=|mpR{*m$U}il1;3P&3J_}34(O-r})4}&ppN+boFTGQ+?t1*e>U7PRp zAAV@Q`S8>edKR6JHgT37btx24Q+DkO@oR#ZYU!TlK$u^LhyUya&MX3uXl`;}+_?jBErCx};PIr5~N{{W2 zx=hRxt_ePRY6^mVde4|d=EQ8-$&oG|DlGLTY3t0532ujk6H7HGX^Kx5y8ZU5D&G!n zV}G+Yj-4Ss?u)#ymZ%(zxmuDiG2=i>tREZm4&(G$9BH$cMuZpcOqixrfAwjWm6S|y zljBqw_oF%{R_6rIGkK+*%}6=!buIPSu{}q>I4$8+(_);lgTZ0Ni;bqrKC+jEgKRE6 zaCchlV4k#T#*`zcmi0e9WYs09QOa+W-DY($p=@KS?#Z?zp^oKeB^GVCe4#Y)Xkx0# zm1%Ox3@w{x%HGXNU^Tvy#J~Q@7O(nw9ACI3m(7alY+ITZUbNxiP0?d1CJydz#aC#| zIXpq+=oym-(}mV5W^_1~Ep6jDa;-t{OoY|}Be_`TGi+kK!E3LE{!j@>4;M}h3XMsP z=8ITY#@*7oM)hWFz`7_kE?X`ULuI8ci*6Y&vNV6Tj%7LDni&=cJDb-|653-Sq7Zzh zeole$GM9odC5zr$Zm;g#D>*r*x~R}_=D!DdEcPtlulfG}cz!;^r9CGPyX1ZR@$m5O zlilL}FI5%u|5>b>zUugAx34SG^0Rj?{=U3_wfy?9%~$_CN~-$%jo0zcIT_#h{Uu+R z{;OR+{WR&Rp5C1=LVnW{x8UFzZZ8l z{M|9%`+o{vF1!A@Uwb=a@!$RTpS_sz*J{2`{Ns(EkG^7@cl)m0%zbn1b>!dYKmVb5 z^{apV?EU*^?~SS}F=zAMP#5*s+9s{6zdF}`&DS_RF>jvI%O7Va8rDU7X9msInfpg} z$-93izr6bRJhc38{q@~P_p4nFKmGgr=il!xKD_(o{N?>V@%IDD6BF_cy;nsz3pZZwYMLiFJJKaZqdWd>c1A>e5;V4^v9+9 zr{jkWnQI;iSC}va>BhGf?f&!O{>{J3znAl`zWJ!^-^=N$Xa0YGIy-zle|@`_>(^uV zctevuN%|SHoYwiWbK)ZVB~!h=9J{Xa>Y$C@${$=^3x#Z4@1FKMee}<(Jk$Mg>(b=) z&Zf0DPj~*v$#eDaY0k~t9jqDhkHoo&TGqIUJ}^D@B7X5aSzGSu4$LBpt7L4Gp6`fT zBj;Eh(qH^(WzXx>2vwzLeXl0|vXz@%zoB*_Yws&XpNj6K>`AxIpDb-Jo1YZ5LQzpL zQ=B6v@>lhQPbs|jT~9>qQ%ISbuli&UTbk#+sG!LkPhLq;&dWP;ws*%)LG$Tqw<|6k zn`}03%f}_X>bW+Vk4>{9{kBib-IHdKX*M}6$@}@WO})!=ZJs8x2zVZhK6is%V99;E z`8M?pEj$9#W=XLtmbjeI`^#eSuy)1A<^KQY-PPse=oGx{v2B9aryPBL<_Y_j9Imi% z2ZtqaIn^#wwJRzGE(ZEu*)7<;Ry6lc zhbV*d-PjhRL*PJsoF^^ zy?FT5#en6#ic7-#Ynu6;4O(wJ(v_GVJ<`nSY*_N^RJv-DT#!GD^8`O978g#<_iY>+ zM%O<6ak+5#Rc8XnbipyWGfwkX_Pt)J*VpsP^{mI8<5xFypO(v7S$xZu=ez9F_3GU*{^G~V zPQ_b`uAduqnJjMKUin?Rp**JA^V`nVng^zTFp`@3;T(IlD?<&_g+KQFo8?YF zoP1v6MBUb$ZBZ@)7h}$EzPf1cZjW0zTTk@(Sj;V6{dK~xwPq|YO-?RPI_P0`GF|h- zlKPr|Pc|RCr81v+hhOo5tkT1|?>Nn$Pnmc2V-|bfk)ef;O48Hg^JlNB5|g~HouF|m*=E8{qu$p`A8dWKBd)>STkfhdi|DDB zJ((}kPd>Xaam}se;eRi9EH?d6uDasx_d09NRmZ-p<*d)j?aavS%!pNAbc<*4S)N-u z3HJlmre+zLpY-*bd@DtIeeIeQzx~rnrW`Rntp4bmvrOXZvr9j_1pk=4J^$yg3@y)^ z8=Lvcmt@>>ezo|ez>>)>!SDR$K6+N*zIf`abM-qeC*<;#vlYzMILLlH`EkBb4Ic;3 zd5wedhi|L=VE*72RDbzwO5eWP=Cgu*^Ujy<2rf>aJCDPtEdIjgeFwiys8W(>Dw%ay zwjyYYzsB#wb2ohdc|DN7Tx!kRhkh296(j0*1W(AFsw?P{($RQov*n%44M`gEW=I997*jT(5fAReK z`#SaR+uykK^TaDYmi_p9`Rmos=1uw>Zj$FtJgVC4@j~gKYR);r6RC z^|PswGw*-fFx5Bmi-2pa`Rh%mtZypq_I~qjlULG_q<}OfBBJ4nIm+IrJ@1!*uIEt@zwrN-?A_OXcKWf!`bVMz&eVefuZj^!jaYPm-labmzs(Z?$wfLx1=S;ukSxr z>B@2~tX`)4)Uh+0YqlGU$NvAdD`)o}EuMysyp(eF)YQgz(*&fley_UJ<9hk&{L`Lf+hZ^QBu9S~pq#J;3y3-QI1d z`Ja8iAr+TsUBR4D^YxU05td_2a&zGGptvL|a zpc?t?82jfv?WfP4Uv~2QrG{Cy8})TQbY9xP6uy=5%xWo-`!ignrA;Ko8p~32D|vFF z-^5yE6#F=)H*@ElT363(x%aAv^UnqC-%Hlk#5l&UoY5zK_U)mVJ=N8${s-TDJ#1$` zOT43N+JP?%wO^l#`99Gh_WT5I1Gmf?%cN8d@4q|xecEbPeq1i-q9k|sxwp_;{#$1g z&Tlf^-@Yu2?bFhj?31h2r)i}|T3d>HfApBS=e+2>ZGFS%~qU-e&5|JnzEH9Q-2V((;Luw@Yvt}O4akNbN#Ol;pj3C2c&-fqTqhTqw~ ziAs9S%epU-bf+XU1)u-6#^HTfT z9-N3ekny+bZi`K8(q6r(++Rdz7IMs$kN=^+E@>4f<9;`jty7<{d$qEsiMR%+v4mbp z&wE!UlQv1`pwec>9O*0ak7_iw#W5*4zke&CRWqeY`Bb}-e#GHdN$Q@C-&yP<}aD4PGb;Z0@4KcT~%VQ{@X? z@eE!|qbOa7DKK^9K4PT$$dp&43Exs6#_J7=po&2bJ$Y383i;YZSx9T^21 z*c)B!zUiKed-*0Vd$;(v??u0+*tZo_aK-b>sA_m`5WXGupiRdtz_IDzeuYxYfL$za z%w;ZW&XSxWKa+L!vx#fnRtU~KKmXvf&(9Zsa{6q!bmQ{CSrt8(Zqy5F^u`Cxs)$+| z=$`poV3S0k;o>dEm%?&+k{@imAk-R>>Y%*v{?XSe%!jx;Pp^K*mXT&G>KnT9Xjd|O zA*)sphu#I#!$Rf(waj@h&#o@*h;ovgV9oM4VJ^><&x#!9A2#mFl-c^$IpaZ*k6WcO z@60NO;`$ZZnN>Lnt8YJ>Te+e>DpU4%1XIz1x);HTTUM4%JhdojKacqCTRZ|cE-X6y zwD-<4Z?31InO;oFd^;8d-k$1KBk)+a>-)BvP+70y>}b);mh-;!%9n~ycU-3Z_O`Q& zS;@_--*()8eUEpYum19XC+0~R+bz7Ps4xAyO*8OD#DxtR8OdtA(+jk-VudFbtgb)9 z#5_N6Va}p}c~usf1?!%OD(g4x^H&gA=^Grd@a^fi)<1@hO)NnkM)JKeaepVU#JyPZ z$No&>BSk*-$Sa3ap0Qjg|5E6;bAT7f4JtfW{(SrBnVf8a1ug;~_r@siAx{LXzriYmNquVFAX7RVyZgP>F z?Qu?Rv(C;rr#JP?i8`Nh?tRqxJraU!2b?z?YO%~yP zl>0+-i{jPPat1E{o67&U{_3iCU$xHfxQh=%@r2kb>!rkfkGaT{y*Tcoxntgf$(9r4 zH&&(0X}VY+yJ6SHpBCw5UkuaS>+ihDxi}%lV0Xzwhq=bqRVUx<`KuQZTXgW%ymbyf za-j-p{hO?mUd){2>f5Z~z9NuC()5hXoXLXy4J_P_vWKKZ!tC8^{DQdnDlIy)ZQe;+ zZ1F9(?9+I4mgo58O{#&*j`@FH=>1AXX2-`oiz(Ascc~)&5&RGa7XWA5aa6=gEMTq9a%2OF0>9EMS+MCD)(w zIK)5JTG(mQ#edC=FMhl`weH3%4GFO?}-3jpgaf zXTN$ND*R34@mZ6l{TiPQ{#)MrBQKS27nJ$tdBx{T6~ZZ&bvsk+EENJbu8z*!6HwpI z?CnzTzf3JiQSu1qqhz7zb`3AZvrE!h>sKyQ@;9>aE%{bD`^!0ljc20|hvvO&*RMa5 zyO(p~RDqV`F;T5OM~oX!&$BgG6tyVkHG7dF8S><0$?A$S?OW`34}9>ieXz(#N3!4k zdeP#^YftS>3=}wY{#^IfHJW>E^q;-_S!wu0>%EKTZ25pJ_w5zO_^z(dww}+LnE(7r zbEiUmqmO)~eXDBFq&X2v9}1&SZ=7~bJ3cj;Kl=0Gg)84LjCu9s-9ei>Q*9N$zP>@XU}^cz8agplGQucoWHwcvHKH~Uz@iq7i_YayJ9DM9{;9| zo9ou~Ev>Qs%JxHMw$me(Nx=&y#eCXO;luem`Tnf$?Z02uYpYIj+g|jeNMXHG^wN#5 z-(8)Ao z)R!&EZhOGKTwpsVr*G=Hxsvl*++40an3)#vaQQZ751SdF#tN_bQPbU6`WL2V;CavO z{t_&{oC?twYl?qAve)~zOA?D(O9Qal>1L5^+S7k2vIy35O<+wkntYH??BKhc_nI@C zZ%xZhO*y&oNlAL$UorVbF6M8)sm(pZ_M+R>Q*~2B{N9MC&#&+QJ6YxRJ1+ItEb9Az zyzajqemDbB^E~y)W#c!CyjepLrJYV2fo={;9pP_ow{Ljoc;f zdOy$Fde7QlzNR+Yrhlz-3%Mm%c4F;Z-|O?9a|yamwrovri4e%e zGZN(JR?xcQu(!)s;*GST$n3V1j?^55sN>%j2nfgBFfZNxgSl*8>dQ^_HSLDEr_S9I z`&Oh9QSpeC`|-M4VWk__+uyvsuQYr@$M34$*|RsjO#Z#FYoX5P>bRB}>^8*dH5~dUZj^?dl4dKX(&%>rOAbbFRa~{?&ZP z%q{b7TwJ%}+rnc<%9>d-3_mWq-^^D(@kX3eZv8`#kOgThYKMKA=4qY-(RVo5IREBNtWne*%mBZoHQe zuQL{UD#TySXdQ4;=0o72NnvrN?p9qIA8*<2=&W&45IC&0t-HZc%dtRZrcPOte$NuK z`X`(ZtB;HF?RcadUf=CAS#eVJ%uvHUtU?FO85Nc;RWdw$HelY<#cvGz6sIhP6oT`A-QfoA*d>ljhq@hM1(DcN`lFR2k}>Oh3u$NqndkpQ?1mCiZ=8j%`*= zUJIA}`*X7&o}N+3+E?<@(0coS4H4S4y(*-Kq7*s5&dCBp~ZJRg;%A~>(|O<*=nPHCCJ zKiMfklqs;F{(g_b$<2n38$~qy|IcuI7y4?&&zE8RicPN_Izyv$#GbA*zbN`5&(76Y zMM-et8=ptwA7*)~xT|V^>uW!xcSAOB*QV|Lx2Ep>HhY`&3bj8gg8vk7efw1TlVf6L zaL#EfE5p-_CZέw~WSFX)HRconYA>dIo{ei{oGR^3#Ym)1w*sqbrC-SQ%iFB41%6-NgnWDL z8hr09gXD=Teu>J=8;qOhsGe~AA6UBA+i-5d z+KWCsYSWe^w_G(5KOAf65L92jmQ%s3?9KH~*+1V-hkm*iP~g&2_4Dw|>U~-5SITy- zDY1&V(zki;zSkyw`iJkv^a&N56Zl{_ZGLm#)|2~L=3bPwSy(J4E7t1X;F|R7#fOf? zThBi_eD*{1!^L{X+GAV#&y=cc{jlPEV>*X(VU5Dh!1(i3%M?GD*fnmd%m4A@!&J>} zwcGyk2>#V)I*~5y&oGx^MgHrec$03Uu7LVw{raC?@3h$eE3)Un#Z`fU`;2=euBqz$ zQ5@7Di)cwgaruIk9J+d_V+xxv%tRzE)VRp#|#fn=S%cSE{+XD`aQwsdjy+tQu4 z&uqQ@_ICa5tmrSlEVAViYbUy~{gTO?7wXG@jQRQDti+q@k_Gcym(N#aSjOw4e<);^ z?Tn>~A>zv}Zn}20%)ymylRT~?R&BOXCFx09{np@YMGIo z>rgLTSAE5&fna@$z;}7o7sNbBnz&_Oe?;`72%eA-VS%wF6Uu()_!VDO#Z#^7T=J5?VVtd=KL;ux})XSd44|Ubk~-5 z^%oVL?%>NclQ+LRXV=@d`h7QIY+f+Ss;5s}(LMi{+`)~OCQ}XEx_LT3rtG$y7+mcC zG3`_Ow%@i^{JZ|&4yxDDU0``=vT&h^w6dk4>KcZV;kqr~cmH!eGpD!vjNF+M&-(JD zTIvjP#Lc(fKIWb*a%<0`udOn7=Je0ny^UF6tKBV^n}64H|G2U}TRz1}?TyI6dv#j7 zkM1+d5?Jr>(R0m=MGR(-u1H_{^NvGsHpdRNmuFg7&!!q*bLh&*a}YU_Rd16e;E;K} z=ayGnbJ>$EFBTU&%&GOfc-*3Mg@?q2j~mzW9J{ja_Td{Ueb+rsL@3XcI(G8c**OUo z=}-LkuKmCG-Zk6iMFv|RDH*&r&z0AI7PLS%+r;r%%GvwrewY7e@L8^$)N%SxiQlYN z%a7@%uB;culy?I=58!U5+ZOR~2^cX_-<~>oAGk z#Xdg%uef(xB$hF43j+hxF>UCOw!w7A6O0=5PorRK?=IX~vP!V2mEnZn(+5Ysg#<~e zKi;x>*{N@hx*M;q@mO@|Xx{nt^S^JHz{0w9m#p>V9(^TOo1FZg_n2x*zkW(LyKN#~ zvTf$YoA!P4?#IQ}e2rNpxmabflTSukKTRQawB}V_ZuVGsH{Ul{x?OACY@BByT03e%BR|!)2`mDTbXyJ zg~#LNntNy7oc6Z=YOp}8#kWa0hTcNVPu~T+?XKl!t~Yj{*K=~ZO)86vNwkq;%A}il z`m45e7|mU-^7KsqKD|7#o^zk`Zr_@_Kf1v3{PwxRZZ~hFd$p}(57b|(Wa9ncq$krN z6K6FSy=gr`R{z)C%Igk|e#Gy*qA;{{Nq+ zgOxcyKRw2`ZS((}_p=Y#eb+X>urRB~$XrFOe`$-an$QuB`!hCp@7;BDALsn|{MA?2 z8?5daBFqq z=UYayc9zQy&raNxuYc@M+cD1ljVu!mY%Q;j9Xd{{fC zHoah9B^b1{F?Zsc@HJ*;lNeN9hnpOjwCG_;%ol}kr8&tSg=NW}8w~&bG*^?~WN4R@ zbCMxg@8iKY%>P}>xZS33THej8S}zlSL~JF;`5)<17u#qaU-6cm>sNWe?~sVa+kfrf zs#m}C+yA-N-Hn2ar6#nwC)l=}VY$%1RHlMe!$UT0-KV#!Zc8~c&q>eY>^Z;MIr<#~ z=cl!Q87+<^+J_^zOr?5gKM_kVFA}Wi;vA(BGt6Qal_l( zdr_gg^k!Xq<#$=OYZr@Xo?6zibBeaj4@{(;rcDm07gLf^l3RK9#%h7HlWumrs^=9< zF#fx5)!vU=4s5Ky^KnZ-&bC6k8RpEaff;fe?z?==di2-O|NO73KC=&e*;r?~K}ws~ z)5InH_^p~lMaOQ*B)BbFe9Pv7j^PHenHRInu0GqS_DBKZk~2H+#^u{%4(S=DzmV+uYwCZ**+9^woUkY}w^&jgbM*A3rTyVc`5@Lx9j7PoJV$FBBcEgoQNcyX7YR;+^HTvTni36K|3iwFl^A zr4*ic7qMi5lS8qe;pFqHXJ{>(acc>qqV?gs3-e|L^rY^6lz1-nv!u^NKh-$($$Ik} zo3!3GGc{f`{W05ode};lHO@_bob?wpU+HjMZeOv+;HK1X@hYwxKc+X`NSq>_^XB#D zWSbe5@@r2#+M~4Ezhi?E(+0)G%>NUEuc&xFyT7BzRU?kWP9wt0ZA*bz%7hP(ZeBf_ zzwX2lh3IgW6_a?3r0k;K>c#C}y4lp^ufgIEuIKJaACm21)=shbS@!Mp(fvuO*6SEu z>klxiX)@oR-TUd#%Q>?OUd(zRe8Xg}=$DJ~zDEBh-s4B+RJ!~M=c-m*;7`NKkJ3;Uv@laJagIU%OR6wtCxyOo9}bl zJrtX2pek`HW%?s)7TNk$H=GQj8x5a|7uNq&Jsh>eBE0se$WigsZvF37JZyEvE???H zY9BuD*8e1Ubov*^qvCb>jSaot`VwCjKl)<2ck9);-&3o*(@SooaqEBhxNMc<&QodW z``2@?G2eIiSIx$?eEU|vH(U4m@bl~Mc=(eSRy}S~Dn4T_KKb$9pV2ybUiA@2b9e44 z?OgNdm~OJ_q$>GMjWufRIok_XdgsZn&bmMC_qtb7^N-7P{jIW4UzN8=)YImQNPUKD zklg|$&HX33o;3F;{VWmnl#5`^+V8#iZsxSJJ*zWV79L~m)?a-`Vo91xRfgVyz)WGj z-adwUo!Q&AyMF$2RVKQ=qQ8GtoOxjV8>aU&y9#v|?ms;tfA*_8woGDs-3pr1yVE+p z-kKw~__v9+^^DCaDd$pe6mmwia7Q|A)BMZ%>+!nm8<#J0oOktllF+kVea5^mx4ta- z+WzQUkD1u3W|_%$J^G7-P6b88N^!lkZn*ep-QJ#gUCtecutb*AlUM_f2J1f7!U(vRjX?{(YaD|OvvB=|W=7-m2wk&Mn`~GiB zMp$X4h;~)Fi(`&?ORB&7^WV3ACf0mh{_)n_V}~!#KlXk8isE^R{=rL)^Uvm9&AtBZ z@2#zTjtpVKTW9=#a@aHH=+-S|FJ5gZnd-3n-iHeLwe@T-rfgHYH8b?U{ym+ZtT~>V zwx2lce@Dv%vMp7Z?-3jB^J-U?z#`7(?&-BALc*B^wMXwZHHd!qY5M-{@In^0T>BgQ z_3NTkO6pqcr=%)edd$eZ@5hIeC3|#bt$Q{JoVL`HNNC?J`LO2CX6r3H$L(I{$GBd* zp7#1&v~T>0+}fk{;Bp46dhE+~ z?u(tgcw^oh(Zw^AS@%0tuds9|*|zd?^XH}41yqxc{E#~@eS#&(brDDSnZ#9pBz$bI z&AqTKI6BpueeK>ydt_u!&RFs3U-O2NJLY|xbbJ+5J^rZ}tX^htn|oco<&)J(H$^lK zT;r~{{&v%F!MOvknBLd0C+=BN^6#MS|Ke9`+!p=iO}A^9aC=eiqw)_znTxJ&ygSD= zwBtQne`V?#PlLBMduoq=eYa~HGjme0NztE(guLSIx5|7imso8(+0tS7=3s$A@2e-D zi=^Gy!qYh(6jmA|;PD1W;?!W&TF58vIAt}A#{bAva`?V#t9KO$vw zB=#KR;?uZ%&@^nb*lxCJ?Q?ZSep2zr#dD`~Io5yE!?di|L-~tA`ig*iN|p z{_T;F2@5wp!b^;r^-`d%x8L5azYrLkdhmwlw$tsAk3yEIg=+dg z7dhXk>!|Ce66758?%n?R-#;7(4bbnjof_jJP{DF z>&^4;)tXc(TAZ#>6EnZNUgG+PZIORAT{&Y=xm9S+=cn;z@#|RPpFO>myDsd~ zho|)`PrjGoU9D?-d+zRE-_P3LtM$235x>xA+A^`eueYzYr#UBFeyloYdG(6YQj4&q z+R`J1GBM?Aa8F4x`{jMyGS8xpZtYUX(Ixo?yM}@wK1-{@QXrT71LF%wGXh zjy^0|Fx}t&-|P4JnLF=3eRy~g=ZUrcrMeR#KnBG;vz4>*skhEiyhiOI*!+{oqDvg{^gyz+9QKtX*?= z*G?2)e(fxuW09?CjaU7#>Drmoe*SwRaiDPH9z{WIr`c_;w|D$C>yfT{=fL<)C2s4U z+9m0?Yv*jg+UQnZT55G^!>+&m(c9-ezxk;y+?4UhjOzy)uU$>d_Ma_3Ct>y;-D^jD z=48cG*QL00Z`tOvQtZrit+cj6kuE*9`|g@oVz zqsK70PxPs5ZrPgETeD|1EOKVs&KF@ZX}@C7c2h1d#;hfpLCr58<)t>7ToBr&7{jTM zwrIJ5{iWaqUYV}DI2sx=f;R5q{a{ibD1LP%XS%&ytg-FtHK(R-zh2|d9oOhSzxkAz z&a#W<*6SB@eK_SURWVQNN5)=lx1t*@SKX_c@>s=IIcV1f@2=&0lh1jp;x*etp)2Wm z6+VAeb}aXK9ryRnx87p<)IGX9|4Txy@RCrlwlVyrBH{+~oozf2;LUX|MO>e7kpMLi8cM z{Phm+{dEsc6K%X2I(xFz>EGN{pIs1swM<%g&VxxyxAm{pSl8e$ z9k4^U#>0i_Rl}5QhFX2=c_m+#o=%%CFYD>adG?LY9fo>mzX0(EGpjBorYYR@UOcz+ zjfBa2o23dfC!afT;`N!|D?P&E@;Hw&ncRZystq zh*XIyt-8v#ygL5Cx2Hb0>Q{eL%wk*Nyw&pUUGF9976-|v^DGKZmr(f3<&)-Ol{T?` z<%^w~+d8_oZ=SZyjgzs?!ZRkbTE6RV$0s|9pjTbW{_8y0bv*0~t}Oke@zi^l!_SwK z_i()It2|cRsq;aGeeb--rv<#~Kk%;kCF^zTaQ|OXzX_Kr4XR2cBWC36PR-x(f`7-G zO?po_6dAM2cV}d2vrIO7U2}cghonFE*#CI%be-QBGkN)?Fhjnnk1a%1&ieoM(f-=$ z>RD{MXt_dd{x8v}8MhUESQj&|D4fT^eYuKFZO=u<7{B$h^BYv9wmft&RjyoCGN-=O zZOw_<>fKZKYtJ;`Z2f#n;#j5Clm}X2!P+N= z(-G}8#q+-1xp%}MbXEkHQ~Ua&svpl7=IT2HKQ^s)v+(ySi$A`yCHR;4)x|to8Ko10 zI8u_mf{#she4g~%wXg%uRo1mK$an)i2vzH~XBH)S}icdV&!TzStaNegBKS zK{EbhH=ojS_Y?i<+KM?UchY6s#!< z+W1FID|l7!zfmM*b;Px&oQ!I+2Q}_9a?YM&crbIBrW{uL{t;2WM9XCuXdoy!U z^)iE3f%>x~ub;a7@EYr*)ww4Q8l5&mdp&v%A54- zkr}_>%1LL}we(Lp@4d}R4hBIsA}ofsQS8&IXb$VlNgUjC#zqZp;8fb$hco#B_v?i;?#xu3u>pD z83tK2a4k`JTM_QELrHQ#o|_rl)584gve=7;GO?Bgo+PWh}m*@I{HP7cBDRL+$5X|I&-9iO!D zh>_jL7kA3qon6_l_WB%jXAaO{ta;SBwO+*hU!0%n6{BO%TeF2NlrEpYH_LJ6O z>r0&6?{>pq6KuY2_3^OHcl!2y#s!}TGtZl`2`@T*X5)pG)1^Ze`oF#0!+GUnVOIU~ zRn6J2>kF>G%CbcyVGU2GyT=N_iF3WfzyR9~VA9{&Zhx_6sJ?EJf|N zpLVzZDY)}HO+#eK?o|=LgQOa^#dasWlVqK-t1h&py3M=(o2z9{?YTKD@3V!HRD+^~ zQun=Y{Jv4RZ)SmD=C10%Cyqb3neWCvTVl)L5Z7_cV@tM_fX~BNv6`|K8#*7p7Z1^z zw#D|^hbzGzEXFhEy()>k`sAa-%MZmekxnPdI1ajezOm(8H}|*S3zvqzx7YnAxY$y* zX8rB@N!y*B>>nw%u34_QxLslDf@=<6PA}WFI$bUxYC`X&SFSgI1Pirk zEWWg{#olEvCqv1lr#I$bKalbuur}UA;%~?@_G!MiUNr7iU;o5FZcg9U#SE5Pi}-p3 z&cDi^vg>C&zm8ju_q@&7x6l6n)bO2gA7}UCTTf^IyCo{X^WFZ6|Ew)4*Xlz%dpGY6 zetS4|i@sI%f`6McZe$)@59H^E z>u$5T)N|!j#HTfh4R7YXdh|HCw#<8v@wpClXT@ZnW8Q{`)B+4+_Hdrrp{pj+bM(l8 z9lmN^_s+F-`tr5SbdOQ`w`6;_r@-U~KCg~62_904P^e$tk)40SaW9Kc2kYd76XI*+ z7cG?F6gE3@vtLEUd6nlP<0-1MblSLbr!6}4OT0nfRsCKCd*p-9eqY=S=4~)>v2~on z{muPouZr8_+T~#ejZvL9e>hla&M;7`IKZCc#gw9Cz_sH;r>$CqXGwmKDA&vR4il3z zp7nGtddMW?xI(4A-SZOX%m;J*4y^9C;+&Dnq}*(y`BqrCN~s^2^E=ia%QKRY1Sv+ZxZ$hst8Ho z+G#9#kmZ3$kk+al4_+R!h+Qr$!?T*v!gS6W;n1GriM}^_*GU%|G+k!jSb4>8@iE1$ z!pK}PtxdsU8^Y8ACd(c)OT4wCm-B{tyS?k)Uf0c1QjA`GH>8u-o|)%%^WZUyl{`My zmRDz8DJX3^E^Iba)+ch0(iP779;@VsF$Fx5HU|_I$b|)7*<{qS%EfE(>eYdtUv2MS zn>p`X+UKh)DtG=%y&C)9WbWVeD>e4=FM8IeR+?`S^m%A#g}c&>m%3IM?SjvvL@~3ulHvrt1H+4 z`Cp|{;MgtPwq4A71Bd^;Rgu9;uPt~IJEy%coALa{?EZ*{t(pJ6zMtP4#npZGf<^TH z`v1=s$n@}?;Xip`UrtLh-^qu6tee=M#vEGL{`IKL0XF_qm4(w1wlx>YtYur}xU-@5 z!UsEzF41Me7WYJd-d=u{UqAeDXm#n;JynIy67_1y&Sy6-Z=3hv{)(OR&WFuqj8T?w z4L5tWPOv9v{covr@+ZHFa|FA5Wpa~Uy5AwDD|4}f>3yANlc($YTre>|zux!rs=r%| z^2^r#O8b*-oi&fq**aQR@WAflSIee<{+e`2Z}*IQcYnG6F0=Yq_wQuMwRt98qWqut zO6q^mxp2+hy52o9DbzQ<%XRbhG@jC)(kE8S@@k6Z+E=fe@3Drt`Rdon=goraM6N%N z$+_6Ha93SXieStCHLw3i8fY-*HGb5LR?!kRicHC^2x7ALIH;hZx>Nj2%C4-p{f}?v z{Qdnt_)3V2Hhcd5dHrb3-;Z-1TLu12I-eTAw^Z)Z(|UvJaeGR?FMVlinY2yizx+z>q!qVBHDjOF_rhJ1e_PC(@_Wm=yQgboisjmipP6}G6k8*=X>(K5+=6|Mx0gT4 zwV4oj>;JmrrV4Wm>)59Uc4U5kz1B><@y4HQ(Rj`sGym}dnZ}bL`I|%LUzW^zIfd`- z|Cst6AqTHGzv5n&JV8%bYWowH^sk}!r^&djIP*`XNbU92KX-S3o*b;0d(x8WrPGrN zhC;!sbGIoc?U9?l&&T<0JfBM6?~|758oJ9*ATs!c!8d)|F&O~cu&?`7VETH zm-wVZ!cS>={ogNw&buwrSEX-BDeTt#kz_mRhG2lW8vBxh@VjMCj?B3b@FVzU<-K#y zRamnT<3PkNuPZGT)W<( zxlSC>C58*?!w*~ayfZR6`shL0hhp~bbFaQ@EO36cNNLS4X{DFha_=wNzE)ov_4x2H55O!*tz-bqLJzHa%vXo8&a+V2y7ZK>nAl6uXlMO0dd(#Escgp@?|lE36YsaUo2NT)qo&O> z=|zWSUwi7emPy@a-?skd-Q4)o&9|?|+&&X?`%KX7V?nns1pSYDGAB3X{R#!nNQ*D? zy7(>?arDPHe_c=&Z`<}NrZDHbcIUMnn&tLl8-C?Vt?hCPQb~Nf>GQ+&D(9cQuD@Dj z6<78A(NEz7mL7pmW{hr6l-}?A8ZMMF{m|^3Ii1#*J3pA7J@%4e#>cFG57);o|6h4= z-|m_E%eitY-P%mfZB%@(Gs8S?|79j=R;!2@xdSD(wfEn-|1C&#Qk#S{ODxNm%+Uuc%R zM)|to)xcLX^gm_=?{_M-_r3kk#ZBiz{c9unXPnJWU$+0ctuNmdYR4gYK(_Yeh94Vh zen&Q+mOQLCTl~`bz3~?o)LfOQVL7|@$O+pC_6)~cUq)iKWGsv=rx!Z1i7=UhH`Zy@ z-z~ngO|Txc$$z(`e2;%qff~P`aQU2`RecU<+^dBzS z{5oY$-~1EI(+<2#+F#dQUH9*q`?Q$Sbd#N48K17RpU*#ce%}6|%tIQ6S2jHPV`OM@ z@rr=f!|QsLyQ_}xjQU^m@9ziR8U>+a9f4iD`Rh5ZGo{IV{hf5%eC^Wue_ElJOP8v6 zv2V&=GUNT4jwxCJf3~FctS#8e8(y+C_nWzI?3G&aXxreH&WDdL>FY07kycRfxv3s_ zN#SYytX=x=eu@8MHhdf*%qa8AwENSl70Vy#hJC-X`D%RL_M^V@<3m_aeW*M8LTf#r z>vyGP49Xs->JQc3_1&jy7F#%Zdu9Bag2q*Es%oChZ`LQ*Yb9)$Xi!{T6MBgA zNDABRDKA}OdA7e@^CWNjzg-6welM#pFR@_!RsMLML-oBqdk?YPczx_0=PRbiCRb*+ z9ooA`bMnk|Rp~EFd7ry%dh_^i{*>}}s+n#nWxM$IEuO-D`EJwVC#kX5!kaZ$U%orp z^TDK($Nx?)X7tPX$H5-@e|P=A`p@mx{~uZ(;9I&+f6?zp;quS4n=(wli>7^fp#81( zop#xij`aqU?H*~1oQpoz^nH%v!Omw@?=;H%OGJJ@`*UEQh3$^mwcR%+%E;edmRX+4 zdr-%t;aY3)xm`_%S4@%EcVXsco3xZ0o@ab6`1Pp$5S8J1to(Gx)R=`vM_1{7lI?p^ ze|zm?oi+Cr8vjSFv(ld!5o`9=?tS5x3!=LdO_s$lO8UQW+?iYWGx_q=Z!Ei$KWbbK zj*nww*KC~h`$dACn$??Ar%x}^eU^T(re7VoxpBD>ku5hKkz02KJpDgZLA1zXPsONK2PEa zsodMWZmH+7&^IlMFPgVLStH-ycxjo++<%c>Q@WR}?Al{z`!4ob`>Oai!c)DQMK2vJ zn0@;63%Pl(oVf+(@~Qv6^|bKy+lYxBo~}x3HXf~5?9zKQO?Yco4X;T+P2pjujS693 z6YB%F)E%C^ZKGNJzkPRh8u7d7y<2?kn9-zpNjtc-b}GJmviAOF7Uit`TZ{O2KdJk_ zC$C|nSiOVG_pBX95_B|_Z-we_SaZ_p=cBiOBHu(Tuo0%X5l~+_jwkA%k$ze{R zNePFnGOw@M1U4thkYg&XYgn3!ILhX|I$EW?sU&JE??L55%Qx|SaI9Y_C}&`nE8*E% z*TR2+CtAtsIvs<#R)TWinCwfRv>U^_UA}Q*7OtP@b>7*wxvE>e zN0=?^%gVWzCDJtm&xrjIzLflYmEE%#@ra29dCQ)2?dsl?+F_WJnDIu@`N7Aa-WeGd zhbH=2I2f~iIuRs!^2r{SDvjIq$I{}W52YR1FtdUCto9-Yr;37HwzKYqGq3KMkv(sX z`J~f~E|MLKLX(Rh&&&*Tcek01J|<`YcF1pl@j6C+n1;*IP-qa?U0Vz zChnOt*_)2`b?xp}>&d)UY^d&=>zg4j@arG*yUvedb&rKtoivTMlyCdKYEAc^qxC=c zoqf%>dc(un6JAeza4l^rTYZJZ^d!w!-=rUld3fjkRJkS@ySL;n+Yi-3|Jm>FvQK*; zZSD8ryY_0Y9yI|eUWHE9xXJ~eaudG`?VI<+X123>o(N&Wk_}!QLqo;SwZzh+Yw9{n;#aPk(O4BxTUs|%)>%&vt1-rJtyIsQfbwh%P z(CQ$Y1m=}GChmU(cOQ0EzGK>I?ym9dPe5Vtm3{dyBxXsKZrHdomi>5GU!nLBi!)&o z>&sN8H7L&XJ~8)7G0THikNWu^j(lW0bhWlSs!O#0P^fN+&I^SF+kdXJDJd>%cYWsc z!!v#E*@tRMN}aMl+?orQ2#N3}`}i!-UH(8Sbn{uiC+Bn4>p!RKE${uf z`a~w-!b_2PlZ$8cJo|Alv^(8kZlkfrb~~Sfhe@|48VCj}9}(SnWs%LQqq{xUny*}V zS>TuQO=qX7!i#1BzFx;8yAMy@y)a)c+Ec*xTjQ})hD*C=h4VDkihk|UJet|`@w~r* z#>ADS*|WdLx5Nu(9=y<7QP6jD@uPnN$wu|9v!?xD_h{APM{a+GnH2_vYz<#-hQT~X6GQ_^;P}y zlCFf6B`ZDc)S6D%Nl$a^J>FQoFlY10zzw*ZA6OjUpw~d^) zeAs!&wSM*H_vg;nea)PwYO{F3Z4rk_OOsEQ)qnezKI=`wr{65gc6jBD$w31x1P8Hv%^t?fZN!H-bCM((&e* zqiKC7a!#FFW5(q4H6$v!H7n~wU3-T33tzD_?jEAd7a3f1>YL6jiP>i1rlheh^4ErK z^W`k18#TLS7cp_oEvRNSx?$`r^QcNB>y4y=WU-$1wt}L<+MpR#Yf_V|Ba^Z!=HJ?R zsr5tEt+N*Q;vT9War|tnuqv{Ku3v&RjHGA zUCI;iW?z?MA1^r1v8H}gZYroM z;&$-=ghQ7d5)I>ccTBp;nJ{@~ZJ)2YdDYu^o##KEt#a*-?B(>h?4!8Ju_LFZ(_-f{ zmmZd@OVYaAdfcrT(&r_fJ5qf~+GBg{kLXtS8v-pmOBon0zEozoeSWV>{l{$n-~J-D z&mZPr-k-bUx&Aia&^yW7SKTeWXw@h*>+HWXjRMynN$?l;D|juKz+ySS!OOf(Qt!>@ zyXQi0ew%l;@Yyb#F@8lI`-#73qx~7n}`+eEP-#s_~2e!R1 z(3~Lle?~xn@DhPIk!G0`H=cF#jy*_?-BLT#{qwCgPG1G~)J{<1 z`0dRc64##z8u0y_y)=+f{*QR?@>eG(X!vt>e(H>>FPd(5^pTZ`_rs$}9~nDdpZTrf zbEdxW$Ct?kQVzCr+P>WltLR&9D0yb0okP)_j|OuZWp)2aJum#V=&592Gh27?A5R}W z|CV*XRD9O`ubB}uzvblD|J-WV)f0>UvQDmdEB(6sz>_&n0);c?2n$cR`ufLT9#Q^x zOVSPq6<9ARN-NB$6514^uH^ldHL}ie+I+)JS9&4@OgA!2i%iH0no~Sah}W?)Ip5Ej zzvr{$)$-@*|5?8+oyLWw32$l!-k!#6YGMI897DUl`0+8peXqj})F+2NtGLIX`}4t` z7(Z3L>ruw16lv=0&)KLV8Ah6PmzFtSKBznk~&-!A(Xvu9to z-*_{&)-}D{*y{H_`+pywy_&sW%Q|_A#j6`{o|UEjI1}K$q9y+I&DlTuQzz?BbGlSn zJm0iH?T*duoImwT*Jy4(dTM_D=3VDrD+K7a%xr)DY7Zy(lz)1k?ekA-afsahn|AQo z(N!6CdQ)aiKB{kC&wTVtgyA}kK(D5IYvatnyS|l=pL)A?=jn3Coo^TB?ULTDrd{@r z-J>P+XhrBUk%{Y~Mc%I5J0mRFP_c8{BH`V>Ygt}vT=f)i3Oa4z+fx5-`cCheJEzPN zR=t{Yl0{~&ci#NuzY8q&W#LoX|6YIiD(|iTsy&t= zyRBlrw%10A`)+)Y_3w7m%F2k0@*De3uV&q$w`Stwv+cE058Jh0J+L$3kPnC7jw!}& zTQ0{v+&*RFw|kR>kC{Xm-}$|6`|Wyx^cDQpNxkzpFP;1_C0}LY2F}xttGGoZD+4_E zn$*5MxX;bQ9kOfB*W>ZxJUzdDF!HBvT^F3cWy*!b`}c!fU+*dYvP|#eL~XY1FW2mv z{d4m5`|)S*Z4sJOA^+v2*t+eF_w_c$H9tNbyNz?!+mGSA>l3ekZ1(2h3Q0MsXc6%| z`CNUd$}{Ilg3CqR-^xC8bJ+7Z`~;2-VTbP(XErb2nZU9z#`e^zjf*z2 zZJDflX!WZa*K?KO6PHvMPM^e?)oHkQ=GAR+>Zf_uXqT#Ay)JfVa>|Cnqn%gFwzVjy zD&7b%e|yw-3A0Mq!@Yd3lj8F})u)s{cyidve{H_x#`-g5{4vhD%^6?MSGwo^UcUIj zxm{8l63X~W6N<#kRU%WT_jtzFS;V9)(%$y+(aQrRWtV2{_!sGH@>?bKiV&lv!{b*g zOXE#9GG&RLQj2>Z!zF%PuQht@~IX?nY7Nc3XvT;hxS)!7VYVv#%yjHvKuvp{K~||H6;vZVk$9-(6Op;B!A9ykPIV z9V+*qyqLV^*Nf)z()n8hYp)+oxw1dvgu(UO^OxtCyUeu9nw>P8-QvjJ`rA)-?|ydg zzgLkCL|;*Orz--gm+W`?V0?RuuweVU*1*+% zt<4K2btuYxQr=<3V3Aj_y&`)5(j$5Emn-n9to`gCVeN9U;Nn^1di{ielI63FA8wl; zwxDHc&H0_GL3X#CD@*w0g*JEOI~F7{rf&&S)SX#n)7!Je%~i2!Nm<;>2WndRq+{iUsCht(&{|nWL27wNO{YmQnnyH;zt7NS2t347>3U%JuzRXiw zmQ_jP0K?IhpAGnbzq_@z$n4G4XvNT^qpGS>=cawAl2qxA+v~{Vld?B>zwevHYG=N_ zlL@ew_KPuUEtQQ`ueFC!qho(OBolgz2n+b zre4OlbnUNuty1Om2h+CXUTu}1+xO7UdDoKTUzBFn@$7be{YdDW`if&eor~wH$npq!#UDDT z)10y8OZn>1efgWpWl#Q>u1_o3X8EM_Q!by)!DE_#8ASa8t^P~&?U#Q&J@iZE!j)Zr z)$%XtHLP?fl79X3`5!auoLQZdJY{)B45Y5gYPdM=eb^&dHHDR1+ec(Y_yUt-o|^6!g)k^RqKU+a=M@oi=O1iy<0 zH=gp$oUpv`@TtajsW8b+LRIn`WOo;`)-~JmEm_z$QEJxhpRYHabTjcN5!zT6D zat>>M(`liNHnrJ_NrArV^EV#*B*qcpi_D;f9>qDB< zM1HCGu3+g%k;T{rQ3MZ8@Asl&l9ZwSRPvT zPt@rwfA0L|>)i!QJ?n2g7LgKGJFmnYk@-eBg_CRAKhdv={Lv>~)<|k_GC$sMEUJsu zJ|sP3#%ZaX2~&QzH2TQDFS%4Ja`MFT;97ULz}kx%tL%?zNNtpGe{_gXl&N6F7rE1W z*l#n|v-)qC_3$g#97B87*AuB$k0Mt*c5b<^Hto>Q ziz+kbcL*N5q%L!AZJ(>PU-_vJO6eJ55N&leWo`?ho2NB^wZ7QVY)s|U=v zVCE@N96f1Ax`_K#wqKg(ChBeZVzM}6fnK7on%9jT!t<_~&uFp`44Sj~$H)Igz4zTG z9w|ICPh-~tA)7-B7jLW&W;6EU6?px4-d?8m7Z>&|{nDNzGvW7NMz4ge(!ZweU^^h7 z_~t?zZ;IpF$v5hQo1YxjyzZE{}|_XxxssVum7o7nYYP{x*#57|TkSw0%ZneMeI+g|tW(_hz&|SKp!jUTg$Dmw|2rQ4Xux~$@MWDD zN4l;V+;_kHv_6LIaejX~!%>^yi>Bg?U6pDMhT@E;jBl&y{p~t^=|A7m(D}KmbzCC+ z+4^26YTdG{&@@@7#=y|e{6^nA{6Cwo_#WA>Sel6z(3PgQ zlNO(H>`M+`y2)bIx|kGsi@R?!kL7GS>bm&j_2;%aDhCxSkabw&WX3VG-H+8C&TdI-;o4!HbI-;6=r^st(30!Z zYU8g|C@N4Aa?UQPoU%G$rtbK&R&?D_ z_MOxCceZW6<{{an=D32ZF>-sy^MpjB&Ub#U(JeRnC+=4LZ)dY(O60R`Q|1~z_!koK zcx}FRcKwygT8@uXITpzoJbQe?v;G(Mc8_eA|Uoxw`H{JKI zP~K!6E3>tc`rCZm-me$9`m8J6aN&YO+G5S}DQuo~`$AZ~)Sm|SIn8Q#IML3oPpIO>JjNJy5Zw`TGN4YRB=!)@5H8Q2O`(_xt<8yi*b@>I2x8mXPnH)(R zvp#*89I$7v5YwEH)P1Ud7QgI%El^cIPiX1}|HJ#w33_kp7Yv#uXsSBXxlu1@ag*hC zwgZn>Xjg4++9)Zm$L$py|9r-O_n`i_VJA5DiYnfjd&<`8yXK7Znx3JLmMZs(^6-9| z=xDoZ>BqfOUJIR`Y{8a1FZH6``ftvx2VXb*Y}@#Pjkof}*~|Z)eDj^xSDv>u@6EA4 zMJwyQdY=7Sdu(rPgo^KFxl>XbZhYU;^US*EqVx^3U5t{xsZDntR&^(uYgNnty*olhKC$q@Kw*@-`Y1hKQ8ec{J%chZSkXjeE%Ds zFPOUQ0mI7h-=(eHN})X`)&ELK~7PIHy$D7Z3? zvMfbKJgws8_6d#})A<)YnG-O-$#BcgGZ#gxKPkTS5)yg8#_2nAp4TLmp9!xH$hrIW zPVjYIXESqU%W<&-=7J6AUc7OIi(`(-s3e93< zv%4y?eCxskGv3FGyT7P>y*KogO}u`h^QU9l>i-gak7lxMeYr^WXL0cNqxHY-BEmXb zjszdQy+zfd!0q6s6yx2tFV=ti{m5wbjr)nmPOo0baa`s_k?3sGn1g!!d%P+tKkAkh zUwG}BKXdnkcS>>D?}FC*9D8;yfJ67zLfHiy-!=Pe3VCIB|M92ak7n?P?oTk(xYXht z{XFn|hw}Wk^jHRxIQN>H-VXl^N?kK|1m%~M(WMElmA>ys``H#zf^ zW7hIJXRQ>k7P_U(s&ZD1WqI+=>(;eTj*k{ynEKJ-O?sY%<^C@D{=ajM+?k!BeD5!3 z#tP0YFKjx?)VJT6n*L(0pW3$no8#>N z%Wr)5t;QtoK)8`|R_Tp^}Daf#!E+ zRC3xFgdE(r%7}aVve#bG5kAfBdN(FK{t@G=m}2Md^|!X=(#xo%&Ov__y8{J-zYq!+qz@Kee-A7ic;4<6~x| zn#Y{9I?mnBTBlE&@>xe*`Fi&0qVxkY=?A0?C8E1$2b3I`XUGt7Wl>w~&Y!z)__{_; zUZA^dipu2&+1q`6Z?%UDu5LG+=il)l&n5MJ_bNuIgHBbs231je@@E$Zi`M^MxJkil z_s;B9iL>H2>L_~dS#jpV$uA3}uNs$dI0QEHnnq5Ky}bSG(mS(TXFuC}b76XLMq^n* z_hZ$~i&jhNM4fSSpE++%!i<13XXZbcxmoUhknD?_3phQEy7#SS+_uTS*M!~KYggR7 z)lVB+^k;9>tjfD{=ai?@`Rk3{v&HbSnOhtWD;>&Fd!YI&zU${Mm_PbN0{J(AsTmItj&N*`+S+E?ceJP&?lXxZbuWO1a``FW2!oc{MGcioh*pP|1_V!1_+f@F8@DTljU z%NEUEb@RWJ%&!22NSpd|OX5S*x{gf#D}TN3pj)h{P$gB&a#&DM<4lvBv_gZ|L*+Rc{r8>1nfH@MiPmbuTa%`f6r zO?$yTt>?&1b;dubPcKL+Y|{CA-*)e0tNJJ)f7!@ha9PDQXi}qXh573Q@$S}%b7wzpUN-ygV&CmoE*>_X96w*nPQ~kRU5_w} z--F32la#u@{#kXxe7k*3LU-)%F1<4DT|eq7{{8)Sb@ull9SK#-vo{}=?e_SowA6AT z(>}BAes4z+&pf-k|9+qSZNkZ}HfM=VYv!5y4ZAc;uZqS-hRe_T_5WM@%QKS7lBfUh z=jVrUEvtyJ+_a7R=CrlBRxE$3R=?dGwfp|{ z(z`jQR=p_kmdVvxl6!Q9LePn$UCzqhI=$Q51g7b~|MvBl`uF=SoKBN$g41U%c+$ez zwWQ~_{I-qtma2k5zXV$*+%Vy3StMkiA$~i^%g8VwY|ZswH@23U&%GZOE%S%1TkO7t z!LN=dyC)v~(_dO^aZNPG$jyR%uV<0mL$@9~SNG5kpJg2UC*HqumY&_Ryk$AFeB5!h zC{ES03q-vgj_j1Z_2MmifbH(<5~Uifg=I;eLbHAgKCF4~U4P-$i8+!&)*IRz7y}-b z=m;7(UpJq6??L#cKQ)J+Zo2XPR^7C53cg zJuH)8kDgW8)abnSuio9y^^d#urq1^`!+cRQ_rK=tJgeva<{MVjRUKfr=vk4LGUdWV zQTrgz=(m5b?pynDdU#Ibsk?8)zCCS!AFpdSOR&ix&8>p}&8_XFkC)xZ;bHIEyZFp3 zWu3$K{OV&g^Een+t4`8%=X+jcbVf^8dFPZnrwliUCx_)H&-O`}BQfXqhJ(HJ|0V{- zOSagtekx!ZuW4H3mQ*(TtOh2Jgq7rz~K|=QKx%c`rcP86tDohoew$a|p<7TMS zr0X1-jREr=XZ+%AGyeW9(9uxqzl7n>isJg95X--tJ2KyG4ELNRc=TqH>cQI^YmO{= zWTckcpZfJ&%b^ozm<;mHrDc54IuLnd***5nhwRE!-FnZfHT{^_|CDpb%MArQxm<^* z?tOPB+*pqYFEw#=%pTOiXgI4stmEGvQsJ3A>*Q3xlAV2;YMxat{tP zneH(S&*c%VZTS+r^Zg=e=EPp9y2RwN$ot=3SjL#&t=(H(FTuQTx79HwHoo@$gCC9f z1valdv$D|Z{BtgC4-t=PT`T#{=$37oG3QA?d+e6l#|Q84oKpD0`P^f!zU&ul%&K3H z)q1H~Scrc$syiYhbzZ^Kt7v!r&+E*KK1mDwebuny7n{reIt8u$j2G93_;f{a{E`;R z?b$ogNUlx9OrTJ{x2oQyC*|M!71x)3Ke741*B9Ih^YpuIS~-{{npfNj_Fa3ueQ(46 z<3VR{e9t@bU~`mm)2oa776tZlx+?7QTl~}h)vC+=v0L`22Tk%2b+o=*d3VFfE$@AF zH}Cjdc+Vj(n4@dm6m<^MW{sa53BEzQYKqRsH$8dG^WeoSp}?P=Z<}XSnALN>y8klw z;``l_y@5i(ek^lcia6f(?fS@j=j}<8lV=ScUM^P)HAu96B{oH24)2`8QjaxX&2H`G z3%htLKicPr;?nHK+LKG;%Gpdi4zAttzfhh3`?i1?`m1+Yiv0d0zSr<}f$`3TZx`G= z$#UkQ&F~P&l_bcJ2Nf>+65lUVJI|@932#!HMxLw}bTqc}^J2RFzh; zo?0^R;);oTk1Tgxuv#EkoiTAmJJ+3JkDO{E++oq?#m6|mTPddZv9yqp`YQFqNgtRV1KDN{|OuR?bcRehquh} z%lfyI|HS!4(#yVGKRHuauYKXMq~hqcCjw`#TDRucuJW_D_eEJxZg$ywLq2QrB!_;t zRcq#&`zM_3t?N}65BpGdVgvJH`TiI4?uO_sZq!UXIQ42#y_(|BfSRmhFU-nngLfQO z*Ex3Mr|_#iEw;Kj3Qw7}Z%ny*?ptC|`?c)JyB2gb&;9jWu9j=tqVfaF9Jw9#22EOi z#fznAMo80wW{;JAb5=Q8a2;=~6nJ}1+waFL71fX@;-xB3a}|f;(#z6|*K+>5I88dZyOB}u-y*S@ z_KTAipHMApy`v%fI{oXtTZNB*auoiqys$~TUGK8&u__I5YX|nH(&zd8#T4o%ZO{;% zx2y4GiEm)o;ajQZyFPg87RNspliRYI)h6Q0rtirOJGZ?&DSz;K`wYEDjRpUlmdlo} z=TyjcJDAS#;i!@1=>wmNB!7tPc%r|r|HB?J8_lJx5>LFd4t;vU+wv#qL;8e|Pr?&s zK3L}zU@vWJA^lx`$GdlJy0!b=*%G%eFRXvnwNZ7=dP(b))9t^DYVF^=T(?F2p21m@ zITE)|ih53+!`hW8sDJ*Mt4)Tbndz$+=^M&7+xHtU)LyanaQKhe&D$?T-8jB(E8pp^UTvy4~xuwZ*pkE=BjfCH?^+hdMx+y&Os#>?;!clm(HAR@U>v> zaJs#IQ+EB=y6odKUNq$H*vXvHSyvk;Km7e-Ujrp{I#b<7FNh4LY)Q*Bz-#8{|)?eRdGLQ9pn@;SslHix$ zq!w)A-k$WKuj@&8M7mbfu5lgDUb20SPzl@La(j2K z#e6P9E=IqV-75v^B@Y}nwoDaLtl044kYwN|)=Ys}`o70|TTgQ5%(!{YOIgdCy+PgQen&i|pzui^zdH2x@#{{mh-?MW& zRauRgXUvbAD8f-}nKet)z$M=4*DS_ag-#aU&;P}p&oe&C!WS^7Q~Z$z|4*iW{z8A& z#jy661*8dh$~1d=Oo{v!zRT$-%Lg9gi!6%b+n=0ywd?<$+OOJ+1y4lB zqlzXn{eJxWtYE*6py&Y2B-8pM_glOM-)v;)`rscF( zN=vxrU7Zq}=;Xa_#nv|}(b01}=3P~JF}r|2((lFcby-EKEXyU&*BeJ2+)*LNthQFN zdHIYBxpzGF`47yq^7q2cAU{o{ES{(%kMU@|i^3CYJI9IqK^@N9kq|Hi}A1&%#rXfPpmBj*9?&48QUvGT0 z=iR~7w36fdV@%HGe7qSJU|GNWj{eM}fm=!qznR^7_N0Sbdgj%@SLO|cireA^&Z)&P z>D|y%=xI#brlQ2KUiG2V5!W?SBxY&9aOkPjGHZ$`47_-EN;J16-?sCuvMG#fM2=hD zvUntMH*IUk@of{gYHaBX)D}B=_1HlsulsioxE^d^@;`35=;1pk$y24B7%Yp`_DLGxQmV7ZvOZ&U)Lab&& z$_lLqwQIAkb%jg$bVn@s_G`sn#%ud_-pOv#kBivPTwWQO+W2zC+ulP-Af4sQNZZ}Yy)``T72~dJ5^ua7y?K*! zZSU{<`P|p{?%5Z&F8%K9+w-sg{d<4iy84-=_B#1?dU^NQE7E>k_`CFX_V-t{Z}QXb z&OZ9|*53Awzj`hv^T_??I2>}n<|KRQiM=K1>FcUr@0vgD{j_z}Z~v9-{PX4h&$II8 z``6k1E8P6!`_cNM(yjZV;@1Cr6Srr^!}r@4pOUFD}J3?1=rJl4m*Rj>QGdfW3quP#55-0smGexruj?PQr&FH?0+d))5trZ+?K zW4`y-|Kq;*xaDYc%#MA3zq~xWxTwJGj{nIGimh+`PfdLwdd@&|`ic6(xyz4m%xX6G z?F#&$=y!e=>x)NUDrP3GQuROml*3(Gy!%3v!n@gmLA%;N9zXwj{=Ie2Umv|0`TgBl zSC?YT@{QGBFC7*CVf^~s^y{zhah%ibQLg#IJU{w?>#e(Y6l4N<4*PC9b16^YzGs`X z_s&d-1E2Vs{yk%hc2BKH_H=8zC{RCF^+Q3kfQ;E>sV&{JpFX|Kdgex{`1%%*a{?$qQzxwIhvriAnoqTrjzPSAQXZAYwyYD6I)OM=< zIB@h2Tdm;dOy%p=x4AY;c^l}s37P3`Eo1(1__KxPi}rLEey)z_8?j3m*L!>uNjwy? zynfFXoA@0aQnijwK7!{sg1sEn3JR8J^@n^>m~{2+dF_&W37sD$o3##EHUDurDs|8^ z$n6s2PcOzYzf_}D=dPcQ4?i#Ycw%nZ!v&!MD-A7@H;TOcydYwidb*&SZNCa zII2GtxGCgubw$i6$)AU2WPY=}{A5Ak4expLY&O}|OWb?c{q#}yDHgX4jE|dV39w!^ zcR6@C>2BPH8k=ixT}(O-F88k0IAA9xG+&B!XN@51%y}}b=GvQ$Pc4&uw{+{)t+QQk ze@wZ2?AkVsQ$H;iKNDEp6>{TQ>>4d8n{(pJJ3|%T**W}lUZZt%kJWswu-u1RB23wy zTb!x5AS8Te)2pz0Zyu&8r!%Kqc^=-f$I;VbI#aOi)JfY4W=%TwKqlN%(kp4sA9htq z@1=A67BB7D?6o1w<8qLH>&p+iijw{~0DC-aN*r1mecUBrHIUer&!x0-J^giF26+?~vN#`kuH ze{_1T_nO@5HDx<9Z$AvY1-jL&-fZ3p!wkXI2Nd2#1O~|aPt9-L^X6GJi>_VbKG_F6 zKg(FoO+3}QcFw5`VVQi5SB-nx)v`SoSqra@1qES)8H&Tr*2LyO~Izi3$e>$p>2 zYw>a?&-`D9Pc~%zC@^YzwPT(fXZix6_xt9Eypeuc{@^9^rnk!{3#KGL-BcV3DOl@Os;C&dW=Q^-bA+Q|&av}vrL7;b z*#EG+S#Rm`BcyI$>*YT+Jm(7k&T;rC`m^9eu~X5xIsR{6M2DQccsxM%`eox2{CEGp zYHPY-R?FUZuYtGDj_u8ky0|OTi=IC-t@`(?Uw=WT6rZ-_`_s06m>2vuV(o0+;dg3d zsLNxNi7;81 zf!YXK^^xBBw=D$reGmVU!EAcEJVHTvJvh0aeSdy_{GML|Zo*B1$LILuO&9J{ zH+;sy{$Z-Go&Wv-sdNAK{yqJ+kvGSQ<58l=S2mYqHtqUZQCqGq+ZpsFc^}V!FKv-<1102|V+EK6Brn$$VWxE<>{JhQ;1y%G-mS9vb z%$h3_`)Ub)rQ+T`C5sw4b4^~qU0whCb{l+rzDY z?=1m>k z?2oyRv(5#Cn#zP8kogo@Gf!gj`FhPWf@w$Yu3LJ3qJvXXoy%Vh84Dv9#ig<@FG-7O zG$==NwM^*e?G)&ixp?Y!cfb>!RkobZpCwLr5BfQkJvcEf)@A1TsBODjDuqJ zGoEJd6J5(4)EgEzt8n^iw;f3V>6^@sDLVfyT)}yxHBjGqvf~EDQ!z((m522S_HR`6 zU}F2VxZ|c)#$)S4&UTJWcK3q!+NquW`Q>59mIt0oYQK9eo<1j6VgqxgfCr0~;K4kX zGbawqIW-G!|NQl4oR{CNwSSJrRmo-E-+Sp;oK}4;W4*%K>sE^vA9LBqwdRw=rK!A^ zzrEj+*&g{jRQzeX^;hQ38x`FmZWf7uO-gvhwoz(InvR3G4gIjUMBmV`%6~d*_IR-;s5HLPS@No%yt?_C$2t{ zU%LF$*9Zoa-;?Fcw>b%&6#jaBV(ep%!nrT^Zr(rLH|n|7xjpT@4>oLMp8o#(*%<}5 zw_iCRj7Ro@ELxl%2kX=*6Ho_uEVK~>i)hhI0IiIY2E zJ=;lkX-L>hALiFHXYM=0zcG+c*5x%eS(QTy{;1`{q5*o3gj3WPRSaDqUr! zld2U{KWEymnRA-^Io%oi{pMuPsF@HxJwh+4k1a4wel__-;{+SEf)1M%`;Yc-IAC+yd{fRYKTdVCpMlS}bsVnu z*?sMTyj$f=vE65Gx+NDMTQ)m(_v>x%7yCS}@p9apaHa9v!s!CD3k^0*_2(^RSiMzp z=B^Vh??ZDJ70D&A2~Lmx6cQ1~eLCy)_>}^>=6PoLKlJEV_2hvt3ykZoBGVtgJ5h|6;LA@bQhQ*&h??%6nH^ zzMVLy$?)Mjwai_8XY6jg-m(4SuI0;?iWD5Q4%(z)Hs^nPd2Pk=yDocdZ8-#&?*C_N zDA8s2S7|-hBmcdT7rou)W}MLQUGB}h%%wAPtT~e|9#(BrTg%0rwr0ZKSHGg8qds1GzoIQR zwQhB5)qB&^hkSBZKU%oP%<{-2_AdaRvd_TSkdSoeMXi|r-Kmp6I5DiL7WX3jUK zJz;}nN^y>yg;4dZj;L2JK2&^q9ei{VU)Igyn;a9`-9E2Vdi`tFmv7IGXK&m2`d-WI z-M%}19@hV7e`inSZ%scl9iC4H>9c1aR^vC%oWY*RvbX4S|J(C(j_y&APmEW$4}C92*U|FPTW4zc?*uOU&lUX4f~@_9|QK{Gv8+MX`RqcJ*O>Yq7jk(-rmSysgDQlqkPkmtR`@T-Eip zjFuWuE)GppE`>8CB2b9xBB_~^_jc&FWX;bu`*2j%EhJA^{Y1}>d5_k)fG0s z`tFsww1@-Gt?$b;PS-f&xzmR`RFTVgO3O?Bt^d9!Jm{s9B*Eo$Ei9teY}-m;I_)Wd~+% z-(~jw&{FjYJM5Gvmrde`GK$}_gfmkdI1r3k*S(D>h0xIMJ?7b zO)+Y`{OIhw!)+$@z3wl$A|<0gN>uYK|14fH^?U7lzx36I6zneLM2b4AR+rv9KcVXS zm-=bCFS=LNJ%8NcY<>F2<9F=$v`;)(*c>I>+P1`zbvpgrZ{zJ z(%;E<3YRo)TP6N$Q<9NzV?xc@r;pFoYcQ6k2xrf4oagalTd=L^3GOxTl|Lz@z7+o6 z>A=0r)V{qiVpVgcYK6%Qqb*--RPtMv$mF*$FE&5)ZSOj*oQ-Q`w%*y4{!ctAukGaf z2SFuixK0%+UYz zP3Pf58MW8q|3CZMA;@7?`7yCRu=Tptq3QQOvfthJX+?cTSyTDc?{_QZjzrq%YuCEJ zRhDzKiDEnuBp=Gj^>2%X<5JcGEL`_&x(-%2E52W`Hv0`PmtIzSpkRC4qD6;amaTYw zvDx+HH?gg?4*HU=w>L?eU-k9pt#t6VSaIl^?lUR>tWfrMOmoaPOj%^Pg)5+WQ+syy zwQ2R{yX0pt)Y3guzgk;5Fz>j9#g?sF>H-})0ml=Ba;9`e?B8vCP z@_bovtikRlme-sOOfJeLiyrYkEO8=jdwQZo-uj6QceZJ|PuO|DSkADu#pFQj`4bZ> zxhf=)xIeVw@yg_R(*@qG&Dt#}?IC?uYi&%3!rNHcG}9wrrpeStem&>vro)_= z;yCG8f72pYg}A0g&sV>){?u7}xoq(-#qGyx*6jIRz4X<`xop}8cW;wCcQ-$*K<}9v z%WU^^afd6)uYLXPz3ug`o#i5b-NK4zcOR&~J;5-M|B!4!)N~W&m+yH#dNhg_T}qhq zBg@BhJCpQcEwenw@b5czEdRGK*RTFtij={^dkfd|C8WOi;k!L!*0w9v*%>A5$1h}Y z>|XMB^Dh0=|B{hR9`P%-O|N=mQo8cvw7J)%nKnGj{Ili-qf@e{nV#+vRfW~-7EUv) z{2@Q}d)K?xm(xCS1#dfOyzxrGovwWS+wG?3uekdZ|9zO;o^b3?w+6F=-kt9UGqP<@ z>C|s&&HcJqviw(zM4L4V zofodkI<%*uiOayw=6V)`_hp51v0wh*Tp&5Y)AN1%iT>pkCVgVg*BAS#*(@qqvGuXA z+>(Eub^(vCDJV`6b=VRZW8o;!73BIts6$9X^~Scv_1`WyN*733-23Y!w`0zv0E2aW zwVek`Uw$k0pUhT&iFLAqxHgODM^@!24|$7oK5S&mf4JaH#s+BvRrAwwZ;YDXCmdki zZ(z_EAJH1wz*}$P5arceW%FkZSFgC#Ny>lc_Lplk51O>?r3;h(jq1a&wjpKw{P;~y8?6QR{G`-gi&{i@5)!6RoD)r)frHKhV+=u^I&OE{zzK5@O-E<#@v~wSS zEV7@s<@Mr2A#a=P-GZKLI_OQ_73%h;&CYz%&#t3P!CU_nhV#8p>6rYY{?X~Zq0=?` z;^vjb*}Rti@=4XPt^L7F*4Gun6@ME%qbBXh6aN&LCMtTr zF-(HFq28!LCH7V6q#aX*Uj+YRJI$5s!X`W`arSiQ-}b9=bvB9#Rc%t0FyFcDxY4(1 zrO$UU+&#YieY<+=UbbK4`ra_g%PN}kC&*Liv6ruPBKl@rcJ)l7`}qp~xT z)m(paLZ5B@)VZ>g7#?n(u-;=`iK&N0xlyB_&<9PAs0;58=HQd)3_ZR{Q8ml z=KJXv11FsOm1Z~Z!NqU$7__dOxF7iLgEd#;QW3w1>3tk+KB-Y!T**C$oZjz!H)Zxj zU-?a;JG*w+q=ZyFTCjg+?+%+%vA_SGovmk7sXiKqt?g%tcG1f8ga^zlj3$t_;NA$& z&5ySU?mNH!!o*cl2N@U(W`^(;KAKsiRkkxm|8)=ll#b=?T^^@Yz8*WZ-rrnm0Y_)P z$vhqPq)fA_pBK3IRsHzLzVR0S`X5>QAFVFG{QY%%c>Lb0H@ynNJ_W6jlM8n}=rwa~ zQJm4bgr#wN{rBa%U*3N8VL@EFRps7$9&u{*2C?~p0-5H1OXyZDQ zWlK-~DAcXEbn%H~=jy|n0cHJP*1jk<+50wY_u`xDtOaWQKOcWr@S@=1;^%)-GA`V> zX12UdZQIIkY6cnCyACgOQeSp=O?}mm$63lo%OAUWEDQCt>f4rmzadRQ!-(~halr+d zJ~NXWq3!i|Uk3CpTlRCC)S(U8FTEc6GTGxoinwKiAV znGmHEx^RUtn;V zeZ{uBE7z|6=dpKVke)ey!Yb{GO0feN0^tKw7is}HS-DA61CUguYN4IomId& z%_==+dE>Q4DGB+UWOt$BnoZ2Qawj7fR66gQ#+n|aZ*lwX#q`U+t;OD`>V?-kuWd)h{)*m$Ndj7C}?v-cE&ojFZvSmIu6x?2IJnxs8 z!J@62C)ffF&OO*Co3Zrmu@~(54Uz)QYwK?ZZ#Mlq`^UL1rZW?abd8jLO;~2NXvZ<{ zlb2%HSgw>wXrBefDlwB@18rj|khP zi(fz3!+u4s{r-_xxki(wmt6VZ*;l{e@AOv{S#N**zy7V;=GIrS18)wUs?DvOwn961 zD#xu=CiOpmh9vGyj16m@drzj?n4!MBc0$vawzaw~H+k>z{m;H%sd(pI@_o}SaTgCI z*vvIvko@+v7?;^i(QoCk*RM;wK6{`;>1@95SBE$cW&IO7#V_p?zZ4z6eDeCIXRb5n zM*crKqwv#J_LkiJR&9s1&rI-Ex1ZUjcM=b1Ih=cM+tMg^;2+uTQBv&DV6hE4QBS8-YsL~ zFWJX*=d9py2DCIR+1(&KLbq{N>O&8MY~lEF%_7*?3l;^)1gf z3+D6J0xEZ|w&70SASktWTw~H z{=p~wd+c)OW1Fi#3crfyy?X3@t$3pId4rW)3ttQHy)R$rdSF-8N(Ny~mV|oK#D&(q z2~XLdd=&d1_o>R#_2IjY=fOAM>PYAmzEYIxW6$ReSDDb-A27kPX4C3B6S*cm-aO@h z+N43vdv@^{4N`jK5_o3h%mn?%hoQ?S#Nud ztADG~F)4}J8`^&NzQ45ef{#dQ&2)7cKl7(j{)fBoT5c)yzb=@tvA1nsgJ+LYvCnV2 zsA*ic>iMe;f_3Db1j=n6sJdOqDz&i^ow#lB`rPc_Ij<-0ewX?xh26rr=JS7+n~67m za>yLq=aVk=VCY_UDet;%l~ctx)SLO7pIT@TXZ%$rW5-ghwc6-(j;_Ya4r-r8E>z2))G7w+p6r&eAOIh8YQM&Yx2`Fm#H^|$?7 z!YCK_@cNgoz}ET&x~2T}?i+Ku?G`fdUrorL>%a9=zL~|XqsKzTle12>ZTXdC)WYXh z^!N27#m8R9IVbWhoUrK5*{!>?wte(q3hh>E*c7nv-f31<;i6S%w{4TUu&Sc}(igYq z0dZ5Co@VY0h&w4W-#7T3Z8rbZYQsZM1!5N-u)WNs8YZ)IK_~P7Llf@r3rMNo%@}KX;pZ zhDrIpSY6jex71lx$8Q?P=g#-J+k8EKQ*_z#ynrg9{rPQGfo2D}0`ELE-uqN?xA|M+ zy=FR7xiuGT+!5cnqBE`jU3`sX$JCgbo%PKQnh~cy&t~5v(E0z#{H?Jq`L91HR8(I7 zrdj_j%i5o7|Es<46JrCUoAfu#Ft3yBwKn?Nzvo@=)t<|@SKjW7FaBFSk9X4CAj2e6CJWYGLw$XES$g=?Fg1BQ!f{PO^qFLwMbgKAooC)AxrQ!9< zeR+0N{XHpjtu0<0w_U65t`ZaAKQ-t4gq?zXs#g;9J-KIyEO^lRs(y`y#7`knjjf(F z<;qLjg}*HS7kc;V_MDuOrk#C;qvo}S4$tCW2Ap-S+4I2_77b^Q7n{Yt9k7vC- zd;6qH@tF%J%jkSM-_*LiYJZ7JNX5z>>`s4Km;W_))R;71Or?1X^BTqO!u-o+N|zj_ zq%Vn&wD{;+nfh~w*-25CvJ?K3JPQLIJ``|1i?vq~eQ`_Rw9e_jbG^GeUd?U~|IhYH z^+hJUnZ}a~V&*4haao#JLQk$RGKE}z5qUTNv6)c){r!gy?A3T1wNxWep7mX#`CZ)r zk@iL659D^)Hf(#@5)t{yt4Qeock{!NmnI!9;ohSET`2glqUD^K_iGI9-~Ic`d)qGg z`yE&RdabGB+5i6iy_)ZVQ&;;e>CM=5^=@70$xzi{#Eoi$6fgcon; zw^%i)KDXZD+uWCGvo0K8eDSb{ynk6$f|22TtKUzLMCVj*-ak?6r%KD6s5=k7@1F0_ zQl-}vq7=G_jdL!`?E}F}eN|<=Cth>i7nPnlbNZ3gnc0PsQ&;7fCjU~Iaw5oaQ_eY+ z`+P2^To(DiW%(@W>&LJ2aijd(l)z`lXZxu7Y`vTE;q$$Eo-LiftJ0RbyqjWb$}#_^ zb?HRwm0JRiUVpzu&ui+bT`cExayQkK8H>1n*n8yb-k>`SK5etgR&)YUoreyN7d znp53Yl4o6->-zT_NB6tjf7Qn(eYoY{hK+M?3R=&)Z`A&c=dH3<0Ka*w$33QvlTH@C z_;|&A_u{FhD`NcXQqt;$c+;$SW#7I#^XSMGb~)eYi#dfJi(cPoJ&ED%$pzEBUVbsn zE0s=}bgA-{%jJ~UZ?D8Jdo8ii>sMn~jpfUeJagY#2Ys^=SE{UEc5h5je~8M8Fm z_iaA1si85^MmD2??O?ohZ{14w#A!Y6j_CZ9)M1QXD94iNFp+7_9Irq8RP)=di1wP0BLldEy%6qhY#E7yDyIQeJW zb^*5UEboHO9=v@bRM+@@M24YfAg<)#BAIZxJ~7XGUdG zy216UijT`SxU+^Us^lcz2>3*VD>mvSFmon1-1DEoba&mchl1_R+ZI1(DsZhg+5C)KM^Coz--nu>xLH9< zI5f|v+iZSsyDpN8{rTNKrBkdA58hW?wahzX{c5GPDMx?k{TJHT{Ks43s*>)fPv;l^ zKKxl`bG`kF%^?R{|4Up+WjzI>=?3anUpP7nw zc-OD{#$q+i_Y+h4lZ5)P(v{U6?`lrurdD3w$z1GD zJ{li0(?wI%F^|{G@89PHt3?}SmPUzP=zEl2cJ1f}+b@bHtrxvMvq}C<(0KJL?{3h~ z$L9|VG_r=@Z0MM*UFoHx(6;un=9?wE=T2`q`o}Z>ckkEV*7qWO1-Uxc)u;DgG!NRa zFSpz7_p}%6e=S>^G!yo6h z-ezMx8ZP)bZpG=94-Z@{J-RRR_uKSUCrm%jIvBKgV&TaCn(Xs#e737p z^SbZXFV(%A3NKgMUwBdX!vFZi-*#U#o;*2W-1lu?_s-4!6ZRdipBPi3!{f9wiu0@c z)3;aaA3II%O3SOcGjnmerr61qUW{AkeVuRk|8SDRoWJW|6kcF&t1&oyMzwbR(guyS z3csIxIP5PcaO4T^0?t1#znM&m5}dR=&pS8hiAG~|?5&T{F9H_?$Lx_#_G?2E}qpQ{p6(ob&xQv7dyjp|`h*IL7_=7)3h%ht0N z{axqm(^s&33d@$Wl^0c?pFAI+{)2U+@0~}D6@mAbAM~62a@y{{NowamJN8fB>?2+f zQrz@)Cf|BPefd7;{nqt?NtsOGGK})94PVf2P>ndzs4{1gz13URd;A17R*I%lB zxxDhCRNyYRIX^Gd_#QU(u@GU~o4q(D@c(ny69*1HU3$1m>dQx2m-~8J9a;ybyz&zG z_y1UokltN~uI7ue0sY-U4kfjgHSD(5?Gt^ccCD$Xw~afYwKzR1Ij%Od)W`K!jO})& z$Reqg8=lNvpe*@!cgfVn^B*43Y1t_nK2geIj`PEW^Hs&)=p5ZMewc;al^G)V`G7dAiTJtpH z)b<9oWcPi!Szh0^{c9%U^+1&)k2WlH2&tN{aWrWA(?t)P4SLHoSXAOptGC?W#=6wu zO|g{T-Nk-uV!qd^aK5jy`Ty@||6}u|T&C|!8P!8qwS3aMZg)(+V?p@oR}22sev#y# zG;fbzmEQI>qA7uWVKs~oM16g2{wuVVe^I_}ZQyHeG;iXU6T1$7tY7-)pnizyzpP&$ z)ee3%KA*5=#>OYFf95&+EDT@gaY^4RdP$A5y@%|KFS_|!)93Gu{$f;f?40C&p360- z^Z!iyZ2RogZO28I?_N976PD0DRkz2ieoxE-ZS8FF2MQCHZ<@HpMX&i}`)>39%oXmB zGeFJ2;*z4&M0kUc${!byOG|L?`#v?_kR71$39o}Sea^GsYQpytlXqs zcI>0$r$+Cjw1|fjl$)+(eR_SFzrp#^gfLOHgrqaD`_WRi4-_-w$-eEb*dZT6D zk!SkBzt8@AcXW0{u9M&sC4TeYht5~x?k-} zUf$MzC|v)Jhrf`;`q=5Y`PXm%e|cRyNBY*aYRkkELG|_j4hf5@X#M=G7ZY`J>D1V| zjc*i^U+rYye(d%+{dr+(>sc))9~DdROn9r6^r$@OSay{~xWtn}os&nIXZqa>?qlQo zmX>pR;k&5&oJEovFCu?UzIw%p$zV^0(VqO>pHpQHEK1SYmU_MB#>tB4FE)BTxo?f$ zp8MN8xzX)zF*6a+8)dCJkKpR?pFy%qxsA&Ic@v$`tPls zk(VdCeyis1UroC{7q#tBxVmK4^ zb!>6yi;R+^dlx?5wkbXO#trr6)dy`T4NZbz%}nOk{>sv7y^w^_u?lzzPN zP-Jtf|KWs(xdqNo;`xKv0)_q+&c731uYXHEQh~SYxomNl?eAE%Z6|UbCamEz@Rs{l zCGq>3=C_Z#F0n<=ik^3OqyGULPNj)9k0&d#BwaZ8zuSM;+_=}yjBNXE9jjg>!sF^Q zJzw_h_FmPPx1W1HuU6Q5^jUnlVB3|;?-=#i^R}AZ@IJ`gqSg0ZVXeo{O@*>DYo6cR zxx=V_;m#ME>|!dvy2Kf`KfZu1EN{=QzTy(g<$e5LdOyA74RWpEo+Y9Nb3R|mxhyZ_$(ZM{WnBd58MH?v~#4ZYUOF7>lN)qMYEzHw!OV1tCpy`0Z3 zOP=>`Qe1TN&);|I@+H$PYZO#I1{HppFTe5aui}eW{wtaPKQl4W=%DqNMD>}hMwQP# z1gdei)b<{Bmt1teqVmW0WWyKx<~E%D^oL)|JL7+=v!$)e%^-e*eH)9P_kZ%A8{esL zYV*>CKU)HfJf6C=*RKqGa$DZ|kpF>N3sL6$bBYpH!D?-F7sGtEe_)8v;C7aj%d9%R z`mN6Du;~+ab^qJt{pju9rAB$qUKQcpt_N=}iD3;)^LSa-pc`wX;pP!_G@!YHw~#N- z@y)as2huETk4<=VxW%$*zQ%`gMvYsCguj$Ms(O=s`hU=ufE7F)`)%v1S{At;(g->8 zk)46NglESS5vTVXUn{ld;GuAo69=EQTp`y zwQ&oUZH%Aipm)KE|7c{a(cYaRs&fwP;QheYxoty_ys5BJi{hel;njB;db>og)vG>9 zmvZgU6uHveY<8i02Gd3EbsuLY)H5{|GM9%WbEHZ?{AtOt%bk;jH95w~pw)(9gYC7o z?e{)h5q>JTB<0xOtDcn(kDA{xUNU6dWq)X&OV`_fOKR2U-qll3-@|hzyFVpHNHpy- z1HbilR(|fhc^YTqDjjA7oHG*howw!Uo!I;vThCto>g8Sh;tks_4gWjQntocGnH%c! z-mot&%*-maxp8Bf<#Xvbt_h*@zj9SFt&#h+h;2bl{o=|MUtG6~W=?5{%$2oy)~(E* z)BP+f%bGjgx^!w}<7N90ZM&;i3x2s6%07Q}+WSbnfvirz3l@Xxzvj+;FUGZ|zS1#$ z4ojs}om`2RAe&PPH_u1=PD}l{E2p13UATQsy`o{Qtj4Swsjj9;`{ekJcI8=JpEp50 zk+&-7q12{N)0PD^MdrsJHC!TjbJBw2tQxm!6OYBszZshF&|sm{@$=#$lJ|9T`7iLQ z-H3MG6{IuIQT38*;fut*ON3G%>-#m#57Il_Sn4S^A%gps>b0dSPv2+CIn!{%CHvUX$>L`SNpFiJwypCsoYtEbKBi)ZgXPvp7`knC7V?cU+Hd&R6;P zXX@bq-OZgTA`Wxzv^Y*u=aXvxCTnqS+D8)(=bkF_OX2q}uuU_(8W$GMKe6fjBGWgH zg?)RkZ9l$GOn8NNH$I!ZSl(0sF7`;6j^1D~H>{8sI-<*s1Bq=)rOpWB%J zciA&Ba!>8ov$OS+g?`FeRt%$xGoayeoDq%scb>2o5UgHI`Hc4Hz z+Wto@_u@5emD^!9jCp;MJGMP*KO)kTFTe6=_M}a5O=}<9ZDVO&J7HN{g7+Jy`)~hU za;k8iyK+tu+g6i#S%B{t^hj=4ne)+(`?W~)0^YaJmKF1K9V~yMdG^M99kX8-9_zZx ze|J9?`gQue``cfi3jJmlVdS&E`upy-7*_ik&%>%_u*XMSmF?K^Gt`EElTPx@DG>s- z+xP!A|9Iz)9%e(#(%b+tgF3zaHX|>SrQvjgau%)n2+zrPwu$b09sWi4jh1O^>+1YT zGP@@gg$7--u#2!v@F+1CGP`;7=;D*>&sSG4Y=7vZ9X6?Gnz!)Z4;%LI-e=#l^Y_30 zn(|k18}DWwFS~E|bKmajug_*%+$CEP7n?#q7_SO02%k@Axomnm&RJOz^<@%?$Vdgk0mNsqR>E?i%~ch~wkjP~y> zxkF4}yj!h%{fUv!vA@%I8Hk7Gu5<0`Ub^pE?8RBx`Ln8u->GmJcW8XRB`+zw^<6@I zXMtRs+tWuEzkZ3ou4+Ovy2w!Be{=;JZTiitD_Re=Z$oOP>EB z^I7DS#}*vl*(FsE-o3el@oT}(>t^*VyPJ(qSt*qX2ARG(dT{Tu^=1Z}W0ko?I)9ZF z%)S2Ej!(`yc!J=^DUBEEdKc*|;5}CN;ljb3Cf4>#KQ}Ddd3WEPX%CCHpI2!2zopM# zXIj0bSo>_s8RvP+?CcJI-KDoB)goAO+0Pa06nvy7%P9%AR!Zp_KRr0*Z(3@XNLH5T_{PAodGOMYL1oz$F0ap_4F_8073=LcucndQqpL5HcoD>Qii3eSb-Yj$lp z7Rpmnn_{?n_Pz7EGcFrmUE-{{Me1ExWy6c#UoBOfFPiI>&)Ld--KV-Hm)}*#ZCkd# zbym&)x2x~^o81UJar4oQBa5dv^309j?E11Z;Mrrr`bWky*?ZT9Wlirb3)&#4`1Vtp9hk2`ufzGE-EcxCbb!YR{lHJ{pck$qWQ+3RiLac)c3Xw7~vr2J-8 z_qV+tCfqu;S?9^k8RqF%<7V9wv0t_7)wVl~D`%g$DEr;5^r2Maq^Ft3opTP|ls#ti zQ+3DIK)?95X!{2(_5XR!2vyE_{z)vY(Bj#T|0-!GFPh7rVeQ(tcFtnOzvepq$_!0E zSa)r*a?LHSdvx&3Qy%H(6K!T+p4lMyFJ|^Ska;(I*`)*Sc~hL7cIU_ z-W8*5tG81yb=#J;Cb8>ZIpw$Ndg-{F3%c`OrcdNXfjh73eD&L|5BIpa+UOU`+_*el zv3`51&5s4Y?^Q{*+NN@DIi}ONZKd^to38gORegKEKYkW-eyL{rsX)H;h;%L(uQ zBdRELTSi9YnOVcFGi)!m%x-yqswz8>OKj&(dk3M#g6BWm&tMM9cm4k+B5BcOzn`x( zSf++uRexKSbkb?dF5!tXdpCCN4?B9Zxa;)Rm8Eyr*9W$Kc*t$|v^_edv)JLL=Iy-A zO9g{dUgb?Nn(A_Dg(WMOsX>57>8zxeM~((O+;GI};@oc0WmZ3U@13?fWvCZ%BIT3J z=le&N>YUlJDtF3-g)19UY!}VhA^5WOCUaaP7h$Z$-lj)-d8kpKm5E%IqzMc(8kVMrdF*G-|518 z@-kkP`%hP>w0J!$MLAH~x$)A`lN@tbWtsly{#O#dRjy~Yx}eIU%u|+o7n^V2cv>X- zTm72*dyZdDViK;}&~jOcjU_>|msyVM%Ut7QO}lHQ9QpnpwJZE}eZ|84e1E&wXGi2a zbQI~;bFR3^RDa0p#-VN#uEj4m?BY$YU-0)*beHp*sh-EvYG!|U&u2dG#-gK}zZLuE zWS+SE&so23m#~eJgr|<@mbrEtvs_Wro&lD3Lj6}@WqD@>hDA|B^oyQjQ?nfsAP zcJDgLT#4x#6OC>KbV;0ba}|7X^QqtmJ;$~4GryOn-M(C4!&@I-S|1(KeEX~mOCIO8 zr!S`SXLE~o6hAcmm!fkk_RQOU+eGtLTZYF5lY`&fIyc|vYQOtq+rrdPmB$`wHD9W? zuTcmvH(9K)c%gFLZL{WInLn!DKB(xL;o(#sZTd!p`LMa`!anD^_qEb-QnLeIhYLCy zP3hTPb${E|Q?sw`T(fAVSH*_THtDa5m1rMK(w)pq%U5U1zmf^7-s7P&93 z>X^~oWcBOy)%cus+<{yR_&iVb>iTWcXQ_JWy}&({Yk~SbzN+oLufDCGFun1<-@d;( zPdByY1tR|1^X%I`>^+x zD`?$zR;ZsFX|*jOb;YM&>F4gOlsmL8OULl&!`q=}@9he%e{<|x$LsmR4}NoV%wOg) z;bTW$eN1D8N1($$rAEew2RQGse4MnPB`8^Y>Z9oow#r$ao^Ia8xb5V`^m}si-*LBZ zXuI-P?lzOR3k%cJ(|M=6XZAO1G+(bOes+7CbKL!{u?xe5dF!7&h&ef1;{Sql3E|j< z_q5r)`dFswKX+Jm{r}F${Xdc<3r_j{=hd9xY!IXJmnD7uN$*J;8@{T~`x-y_M(V;A zYaL%Td1ll1$qJ^O7K-&Wgi>*{CmYg`r8Xq93AX{4I(#j$~Ficn(C#QG`!jK14T zyG7P4zd5<}oO+Lt3gcoC#>H0@RVHOl|9Y)2;OyG#zgl?uPaW#*cz<{0%SJPc2JT=d zW}TQdDkq)hOogTli1q4<|w^7EjPof0K2q{@}Uf#j?vZZXMp3+t6%v>kP{hmQ4pP{4259 zHdkℑ9%d>xI4urpa`%r~dBezpiBWJv8y0!qtNTI~ST+vzh%VYq-$OmY*q=u}yLp zQytHze=EAY*ymZ!zasNm>Z}**oVE8^a<|3bT`i*2R%QA&Qu0A*YF>%;g?6>TfSUv_uR*{@9(ckty3+&bF7e_SL74GdG_S{ z2M3Kha{e5ftb4*e?eN6q4`h-T&8R);IsIVt)4dDLCRx?HG4yr{zF2+bTKvjg_YT~D zcvHQ`a`&;XoboB>#f~vp`t%*&c{-dcd77feEr!*BOx$(1uc|vT1t)jMulj%K{FHZ= z-f1u8zNJk}aTHooUHjD5|NAou#u?%!XLd0yUVPc%a#zG0@xz=#_ilQrhbO&Dm}zhF zEydKp%H!vP#3I4j_v_yraGu`WdhWIncl*M{SNCS|XT9)=OE)PA-+N(U_*cHQA5X9K z*GP=wH9Ez0_gE@B z1hciIC@3Z~WN@!|(2~4f#_{0>MTy5h%G?w`-dP?N#xa|3Pn3{U&Mq~b`qI0vp4#mC zZSv5=KVLrN@#kg^oAk@`e>=+NxL39btm5(yl|LAGXTqI-E$`oSOqe*o@7?FM1+JY1 zGbQRyZ@Q$t@twl6JgZ`5L+wu*^MC40$ct@w>D;Eo#WS~Rb^pBW^SV0iT0Cu8T&kEx%ua?)kvFoq4_bOgAAIN6tLxNk zxv$kXWG}M;C-d!fYi7x$ltuTh+v{~*JLnf%>DnDN2HE0vb0nXw%eZi8W4V>!Uz2$p z{`EU|U%H<3`}O(nAtvc11!f*==L z!0Z?A=V_ddIePezF%#F9{2Y-W32Y513&?^b6AR<%2N$sD)Zf`AxbJoN8QnQrygULd zj>}H5pX`e9d*gNL-W(bE9Wv+iv}$}fE^Yes`ZBM{kEp&a6Q_7j5^g-USi1M!zg-8{ zzpMMxZDDgm{LhDi2krUG-@o219=|vAq+`Lf&oMIZ^xAFGH%?Sd#~@ZTF>5oJafyxuM(?Q)W68Q z`df7K@kRN&u1(pOzJ70}{Ed%Gg5~ZW6jQLBbMf?UtH*90nv0ihSSRZ4TK!E$pT$Hk zHa=+cn<#6Mw-1(=O+V{XE-~RCfBf!+S?s}A>NdQ{yteZduN+rifU9WX?k};Ar~B@1 zeAKl}YSq1WcMZO~2mN!ont$MR%-r`r!L`CI^>=pKDkdG<%5}ZH{qD`^6d!L{wbs4& zuO(adutptwcTGko%x~I9p)(=R3nEOGSKFkm5#I4_*Wu0kt(R#vt)4WqBX0H~tEG+k zm8sG8l0PhFUFHxHd-mX+*)&e?NjbGU{m!4*wc}8##j%;@x+;AA$Er@<;waFG(CV7^ za)o|Fq5QOZQQfUpw>}tdklfX_&1UvKt@dBF7BTZ0WuHD&4t(CX%_-=@GKFD!qxyAnc?qgG?9rH21_KvUf zgYl-81;_axT}Xa%_*nn_eGJD8d4E=Lw8Y<-RrKlO2a)DL)hG2)g=@kl@5$wyrY*Xg z;l;F?Gh2eT8tEoXIGT9z@w~5^1}!RQesG@oAM<6!G!s_gl6z@g4>gn?_i(NFe)Yq; zRVyC9XUfZ!EGRhO$}F=$^5wOhgbcodx|old;t3whv>x>w&D^x_=0;QIGvd|heXOTl zDg3GlUS-Yf8ylkb+8z9P^VyPxC4%(XV%#|3&1<^HLi zwJ37k&T^4ysx!nG=VjWz{(8@?>!b+B=lV6)MJfBdW<)Gf^ZzmH+e!0{*=Cy7kr#CO z)1qEBr&PXrexy2#Enr6Dh0i)IhH~!jAE>Re-6m9%)BpZbx8j>~h8)kE`# zf`8cr4Y8(oa#G9IR>jLEoEKNPQRKF1&JIJN1vRs1zJMcrGgBNWcweaE2K z!FkjAbJo)%H(t41*D+Mxx=KH(LbSA6#zVc5|g%h~-j zM1ZGy!|DjD_G9bwkGz%q_bB>+&09t`#-pq53P-Bw^lolFlf-@`Fy*JGf}TCgBhF^2 zs>PjO=Sd1j={U-~ui|Jkt`w6x@I_|BqlLn1&z>{v=D+c-Wc!Q+wdh~<8hq`i9oAb_ zeo`@B-eLUXW>>+29q%tR+n6k9`yagYMeNm>?+45t>rDLbrc_XV#inVm76-RpQNYW6 zCmGCsZgbw_x^J(C)U%q|C7+kiu55hLbN*X}vc3S9_3P*#@4b1h6n|>^QWp2%)eOE* z&QaDn>%Me9z+)#@&nQCTm1=(s`Gvo9rLt8CVaou9B}!5lUx(WmpS>&-5e zj=s`m^yl7=?$19Pr8={-Yy%&nDUUOggdPO=nNkhfXa4 zZtu%~ZU`7P9-Q1hHK_4HD5tSGd;7xo3ui4~wCii}vUHQGa}!%C&tG@en`bA@ApYRP zvW)t574g-(I>HT}D$85w^Xqs2SSBu{l(GF?;RVHApVq(mv3520&HN3?#y1|gi$CY% ze!pN};r^1(T6Si0ycC{J^jb-u76nywZT#hsWX`p_Ajut7om`&O<^yS^-2 zqQzbVtt*FD%+ zWGFo|rZe;P{w?MPFT1bJTD7z?BcuALQpogWX5aTp8g@_dyi#plJXOE`TdW(y{qXho z<&685_b%=Fmz60YzpnOf_ukJU1q+QE+iE?();t%#zRZyMtl_pL=?y7~%r}Z1&Hm_> zK45k6-p^Hj{!#qt!0x&rZ`-Pi@^7`aJea^*X{i0_B}>qq$IWLpJbLf7;-@^f^#g78 zNw>~LM0FgRx$TYiFJH~(R~rpeJ?e8kMV_xY!C&OoEd5BBUr6c(!=CK#7Vq{yV7jxP zJK{?3_rs@Oy5C<`@q?r6_Y1RR!zCsAJc1^@Y}vq;wfjqjP($oR{tf**+Y=`xQClj71c$Y+5Z(8zVqTm1DYm-D%Pp;jQX5_$EyisFQ#2T%-uaoBA-TTKk z@7-_h`r`c`&F%fqKQ9kIpI5qL;y#bRA$jlkW}ApQt})vXMsR#QB(rIwl%7gNs2QKj z3vKnr7~957y}lQp*X6WtS{W|d?W7p|_Q$`V@6P7WocWbj9+B=_S}%L_+O8D_5i`Q1 zs?v5Ev*_`)t=QZc{<2iVzfJ9eo9x9fljM8-COzu&4o_V9J@P!y{a?5Kf9L)&)rU#u z_rWcjx0^108)2O-=&PmlQTs*}_agJVvpgSptjI9hTG4FM5M8fqF54u|u3x{eY3qdP z9G46}=Iss+d=<<8CC6cEUt3B&v&_OffBg;oB17k-%L zHP~Oew*6na~Cp8b|jo{srVFptkQ1YF|FAvr0@9tyK<37lfU`*%=K6IxIL?H zxhNB~qFUh5v0JZR>YJvdp18Yd-h9*D?^nvMo>yy`JYPlQ&;m8y%2__T=lnEWSCu9x ziXSoSdb@=!z2{|uL*kyhp7+1+eIEJmxAQg8-Fqyz-VAtmdXQt}6$k7-FOF!^w0m&S z`LT#bHP@^)4-RR3-m@ab!;pWz-m`;07H(;OxMpE`y5Hu4@C#2CX8V~a&3@S6+q7Ck zy(RIj_xp3ZSkC?1S9?Ad|0XJwmmWbfr{Mb z2e$G;RgLL)^W=Vh3}ChYat`p2Y}KSN`)*P6Rki;nzUmG`h~ z>+_=Zy_24Qdfpg!ZdZcj?h{WJYcB|RllrZ!{@Pq_v#ES{#ky)Ze3wsdjMl%VtS)FRvtrXc*?yVA5lLSnapta&y87Z)z01reli@~^wMuz zR;#2|cSHS>HQcMZPBTfb5LIcoAFdYvZKW4$ci5uiGgc`1i*RyI^#VoA_eper#`b(^I zS?om~y@h&4vtJ#Oc;i!6aJ{woN?HqN*w?9y0leGVI~6ML)j#UYa9#3xS+;wU&dK8k zPx7A*bFE6^?^-YMvt(_H z;Azj>at_x%ewEMU|8Oqv;jC+3S+bn6FV?^3$h(mnBYae`;X^L>4@tY6iRXX(c%J1f zGsj2?erq9c_pN)KSqet}n zqw4L)8CU$6r52F={*Y*yp@h&>9;St%2h=6}!UxYVoGm>w`MT{A!VUaw)jzWf@8 z2eA?Rj{I53Iek-MMw$2L<5_*t6^AF(?&Yn0|7_ZR_hT_~M;0E|JaeXiYm5EHikFYN zU3rdr8=U-JsC7RMY3boP|RpD>8* zJk2e$WB--SlOis&yGvHqW`Fv$_C5QTwSn~~i^aF=Fl=z1}dwu8Z=yRrDrbzC$ zX?R@tJ7V{@lbil6vJIWp;qdbOO<|!Z8ND|@_m@^DCGOawuJx-x=dd6Vl7%M{yQ zf3R-MsZX48`hoNjA&*J#1#915Fw?%M_tAC5zK7CJ@0xwwd-9yW-s9U!YY)u}tXnB} z@ZbOAom*Z_p7^bK<*YgOw(++NLcUE~{;jrEd`9H!%{P3*r<9t_xGH^6|Iy|0$uI52 zxB9G5nmGSK`PcQkSAUODJl)&0$)LlmP>bQk&zG;xTGt03;0g-4$)t4P*}+S5&AJLh zbK_$FPXC`5BePN|f$=GCL6GMEyEoY8{}tNbEi_TBp`cakqw0#M`yCYC{AbKItDcCZ zfn#Vmed9egH316?3&auCh8C979ZxW7)E|wypD(>ruwV%(-SQS4wHFyDy!2w6 z*O}HYOjg|9^RS3}N{x+I;|cbo?j7CbUJ98K?IHm?{5DxFdsUvL@b%yo>!oaGD`Kq^ zxkGO5Z!XOG>i#0)oBNMxqV+8k*9tFl;8iwXcHm~J1*=+&X`9&&CbsDZ9!+izi;$5> zFOfR1nKexFMaF|wGp0W%4G$GQ@nFBFncML{e5{@`>SMNb_5G6No3t=KgGu(|byitt zc3}af6@EG$76vtLUh0b-x7=DH8gXpFiLej5M6YY4?5aE{_bAyULF?o~F|O7RS%+D; zb_aH~1SLET^U_##?_z*XYEO*w$CW0k7nmxz>=tg&duL$vYKHWW34i()JU(>vy+wtq z`yA~9OMbAu%Lu5?waMHtUFysA1lhO$nh#~4x_9!0#Y8QMX=kiuvdV(3RqtN$)eZ4_ z@xXZM!r5UTJ$S@gd{;MVuFYBzx;NPINlRbgh9|}Cx;itZ zc%#*^O1RaGr~k^#n?hCwQjMS6G94nCL$4GO`~L^NFmx#uN8Gu4XV3gS6&w9|YI-D{b5H*L`1x1+ z_SZM7>dMS&zduu2ymMBoP3>Q!C*nVhXU@|Xe_c=}w(Pk=!;)>1pJjHniT>smU_7#C zf5Eh8|Cm-ys;Y0?$)R&8zG20M`d`nO=IQT}ytTh_V^rMUx$6(7&WNk2ms|G!+5GDd z89(p-Uo-3R!8ea`R-`*`RE&u!c^-+8E%i*W5w*Oo;+o{U_@8vJYU%ozlC-%pZ z^$T=QX^KtQvrK4i-VxoXviKE&S*>?YpPQ6__)GiK-Kh-T{|dJ5`T0HPYwFk2Z`<`Z zfBiK5_WL_bj}NT0e0IEGmP`3B=YnVdcg_0!Y(>ZZH4YCJZZGor z6#B|?|Gt_1D;6!=xLTzu!AVo;h&8-3#+%G1y1GrfHc2VlddZ^O{@1&w zclVor*57>odh)LD%nS9c|JXQ9v`z%JE8M;J_euT7e{RlFsWuK8-iwssFd-^!5@_VL_kK4u@%qo7jT2DAnn766@(Ts`-YqYfV7l|zms86@Ja#h80 zmdw(H^QU|Ku8)n|Q)QdPu&C>RGXDyjwC-un8`!oynJW2l@hP6voRtq$-i8%K7j;zK zTqHiPxrp`!g>e*R#y zN&S|YjodW80{>raUX}T_d-k{8TQx<#{_0_Wt<@4J(;j&L)4|T!$n<(9$3!Uw700rXZFRP z7s`GH_&;mzJIU_Zq0!>BS89#ozT=HY-b6EMdRu1bOjqu}IwbOB9jL9{VKR0zW7A%#UrtG@s`&wK6)ulQ`_Gxeb&Bze*sVw-O zpzZMMnD73Zg{$~atm8j%(oW&8UPI3-?vCz@Z z$?=dt5k}AC`>T%@Nj=rEo@DiA>f4pUrzZMo-p)yzJfoyO;>_zgA@k;*`0f0SBQWYS zpR>1h*FxWNiKt(HS6_M`Keg`vsxN1B|NaYIx!A4v!_gY|-PdLu5P#UUrf(CEw~<`Z z*%jWQ>$SC}v#YRrNKE~(F`(p3>na!LC+7;1%d_tv5zeZ6!H|CHaKx*Q)v_w8_fyV4 z;kz5qko;BH$UDT&NxMGRMy2VgmDbm41*f*7S=Mr1b!_XtM9A$Z(h;kZdTSyp{&w4w z4SQalv{GR&xLCe`{VB_7&&`gOOvbA}nzx+)>sX|{;hkoYfA5Uh4ZB4R&A%S@6x@9O z;CsWL2d{KYG~E2W#NKe~3-=k4+P5CDr>@!e$!^g(S;M`>zIF3dde}^o>b37~+uL#d zp1Xr&dHbHO_xl3E{~3!tt2^fPW_DOv*XymyvFmepIxIEOSiJIR(5VG7!pEoN2Iz&W zuw))Cn$f)F|9z=1A>X&$ZCW-j=E9YI4J&IIgR9NgF5a~=-z4>0aiufYgLiXOcCHTS zGC2HDO2%_#&rAhXp{wi~8j_24s`5M3S8n6seD+%|>e%+Hf7+Sr8d%eeTvz_GKlh;%zd-|J~I;wC)cK$K&!V~^wk{YWEq~<+~3*o@6Vs( z?>&od&UyI6=-|oyf4W1^%}IRuYU6U=JlUew{vg( zY~r%nJyY1`biLW`KR^Fm|6G6g{LLTFCn@zwYP_$jn4G^V^bn$pIM@B2 zIV&|b=k_A4>aQ<Yw?%&N1W2iGU)40Ts4m5rYvw()OyhWXiK=uipi53%LN$=bloQ1 zKQ6ZP;)Yijua!KAa%p$1?U)f*ub>usMmjk9RP}A6xif^;n3PGU>CE6i{_Jtb>X$V~ z4nMiT7H@NkMN`O#<;moSC0xQBOSVd#{~noR#M>9he?(6*vbZZ?o}c2Wq=@(ewF5Z~ zGG2n0^tj&X_2uh;UzI3H;sE!mL663%6;sjZ&MrwIKh??)x#aH&nk1HE$~r&nQy{!Ra)+JU_Ha=r)l`7URil8_N(Y3<7L zS5II6x0Fgx+^sT&Ti}?yEd)(_hjKz9@nFsP1^FZXL{!5|A@7CK5h4F?%;pDjvLn|ocDE~?B1Mu zs-A;0?2x+Rk=@($!hULUJT#d*O(3)DMxb4ROUf^E#dnS!{)gMl1+O^I+*9g#efut1 zfnRc$*6n?t`M={z#qK!s%4)8xJ+ZTU%WnDk@ONgc>ifuSr1Px)^J5EpzgfCZ93~XM zPUl^7;?*{5eM9BvUrXjVf6-{qU>C`~d1bl4cZ;v}KR(WSkk=${t9LswMJ?*->vL)e zi=JPcoW5?tg-;%W^ZDF6_1EU*h;=*)P`q%$SnAdX->c6qvIeYRU3vYTXVK$bqC3v^ z6fFI#xv@QlwKk<;SLS>1IZ?HOmlq1i`)zLj>l5YC zbmha}=ck>kYCIg+RM^Bbo}OoPVix3^bKn)H>(QUi3nV}6JNZmxw@m$`{x&_Rh zeI+WT{RGcntCpR~SGO6ZT&rg?`k%*M@%rn`Y zUe90fnDL;-ZT6OlFBlT@*c@gA)^l)Z7lghwd-t{VcjDW6b)ADnR(%nyQJ{0yH>frz1`{~HzIgjV;);$%Px~*E;{`x_W3(7}?G#|A7 z;q3VO#47fW>A6z5mRTkJ$}Fq=?#`{sTCs7;?{nfoPiBAK{GWMRRR3!D$i{T3RV>`% z2IyxxmSiZHnwd}k_<~Kderrf<{$&G^+V|^EB>%c#UH>fE$>Z^24mq|a1w})-JJ)i1 zcP;UnGi`o<@a@P;lFK%J6xnV2{l~q>#WjI7|5_IN8arN8bGo>@`hNJ)CrRffb10t( z>|2~9`&7d#kgsFrU9Deo_XQ3ux9{Sw?bTc$cx*zkpC7A3P}V=og|D~mu{u$&zbj1p zW@zjgVY`&`0tT}xzFc!U##@lkQ`wR{OR(=zR_^|)*L4Q%Q&-)&(K|y(M1I+fmr*{c0lms)gsOBQS~}ym-rhd%04h!66>dU@ZXBss~T%}b*|N! z<~Y-D_glBN-5W#}tKB=XHKY93n&t-^G#Sg5EAY*GV6a?yhyB9HYgy|FOAffdy3xNTKn$qzT)Ex{)wepc_xNMc#?-#Y%!%a6aR{{Fiia6ahHspp;{-=4dKev@K0n!pnnVoQS@r5CUojKd_gP!*iBa%YzHjUR(8DQ@MfFoyX|(b zd|PX`jw$54g0=qTDHBh`KB-*$iGNy`uil&q7M}aA&Dtnum36=IU`va@qtIf9Ne2XT z_h@k(?g&s@W@Rxw)$Gb&AI5vXk1IaB^7G}@+^e$MvHYv|O)h=;G_O4SS<;icPjk0A zU;k*-qjZS5{`d#cU+J@SQd#+K{4zNzBovswFsAAMmg$?Otj#HUnLL5RN%^_ksp<>? zAvUkgCJ#OdSbmq6vTlFhb0wKWG<~({VojEdKb|vd#ja!8c&Gl*!mRF>V!qv6ss93ktfQv)Hg=vE;tWu;WzDGXFI`s4Z zck?!Ek1YK1RG=iX-sR}2LjljXM{d6O>xl4b-{6HaDzAO{dQT@V*wMK9OI`R=H(7^0 z_usAYyLo9w=8Cr~&BIux9IY?jxc1GioaA7hD@@<&raDa7%KM~s`GQc3)hl)>KkeBW zy85yDjf0M>8h*?Xjy!6R+;;W+>a7b(e%_AVcK52lk*cs0o1Eg(rp@dR73Y(G-SYp( znKO2dB{Kz&Y?6G!6|>3d`6lj9dDjmubyz*`b(G|V3GRQ?-nBeCaCFnzZI>oZpLVX^ z^_t_iiGR}UEjLYGu=&vsE4fS`!_O){Vv{U-_RpxeZnaYFLocWA+s57NYShiwpX0s1 zeR}>nzm0#H^~yDOuabD8x@+#ukB?^l{FHEZa^dQ<2|q4RTXyfX=NXQAqfZn2g#I=- zZRz{7%*@RwS+?K!c3;_Mr867{C;wW>za!py$AUHWQuj-3(th|gH`uOlKOUcWvP3rE z)#aDBroHP_nH^kMGlx6%XIQD|vHJ4BtJ4z0uBU|GnbCQ*cHT{k-7}>b?ySgqyW@8G z-aB>?M>70QGE}Tvc*@C4-m&3a_Qg#hrE9|$HvDN6JGS)R63;nDwt191JD=OO^JYrg zW+uHQ3)@|l4AbiK6Bo=-JW=+5XZN;E8$>0yP3sj*ymRSmTIKA&i*K#EKYQlEZNFwn zP1-f>DbI8vjn%C;=WkW3UEkcXL}%VA7t>u%9B-#+{5ZbqLg-Tt)$+r6%cHoLMp?W& zv+jLL+)F2=3kh@IoLC|o@j`}qr<&KkrHK=Gm2Pyes=t}$%9{55*=~mVyrX;%UZmWA zFyY*4we{_f>`uI2$NF^j+Pn+vn%6#ZpLKF0-{R6+f`)aDmkgLzoO@ht)y5*VX3F2` zR&CNtvu2vc#kGB4JTPZ2+p|?W#p~rO?l2z+77D(8de8o;3E^xW&rMjw6U2_mvmKoL zMULg1hr*?H#Se#Pas&saU3IW1%2KRXzC5Aui_?svxyl7QgQI72NEGxkeydN;!E%MCIAJsd~A0E@--z zyhyG4y0Php*qy^2=OtT}FU}Qa4M_93t9ip^63428DlX4YvYf40;FMvz=vJWWIhKxs zv-LvHlIPDl!1iT9BfF>k*(J}p-Ga2Qa?jT~SkJ`wtvp2is%Bk>)lc(PpEtYYnC{y4 zPun8#bNbZ4+ZQf;REe^?KfCVB3Z~?CsaIuevu*FLk=lMtG0fApAU373INJSVJ1>X1 z^zYcr7gYs~x7Jv`{?AlA?ZvY97o;C&ywNRuyrYf3K1{CV`J(Ju)(bL@o%2|wQ@iWv zC5fE}4!qtR!QEqPsnvWd`|yH`t7k_&D=5COkRwQA>a+PflPA1V%AZye#94a2X})er z((T0T6?*aet<6vGy!9@Gc~-%muc;6Dzbx0eJ!4~BbL~xrtK2<&VhjOE_gNTbpAC>P znHsS|$7AQjO0$ys&qa3nx9@(@+^|3N@ieDxqR(t6|EaQeV==GRE=iYP8qQp!5FNc` zL0cVL<2ANRYYtCf5c|z1vE)`v+5L}suWFu3I=FKG^eSE zAKav(<|$Mw`R0JGr_9m+&2#gatmA**IKk<^_+;|p2j^P;d^n>j;a0!M-N?Z^@rc~4 zY$wHOy+$^CeaC!`9dy0Bd4_@9{oMtnHA}C*kG))f>&%Y?akkUuQY+8;J#W7(ef9P_ z_W+?5<>#k&DoGO}M< z!b}!eIE79-vnBPz>khBw_pJY3@QRFH_RA~TlDScDf=lGDq#JqP)#F>wJ#(zuU|^g0 zaLObNo_CuK%GC7uz9s)Ed0IN{=cR@YjTi?-#f=-b-reJ3G3)+1xxd`57w)V8*X)cY zkaoevNLE{Jp4{p0&-ds5ccEiJX(r&YW6 z?@RZmZ*NP#d~5siZ|aZQ&3k|TGW%frl>2e}t=sSRcvL5*xGYl6pIx0F{;+ECk}0dr zU2ln9t=oICF=lCK{XPCmpYDk1*2?C54|x9e*YvmXjkzy0HHBtsq-gK${pR{c`_Zpm zI+@;k7vFz(@X~{S%I6B@k3NjJ)x6f~^p@VUuWCd8$O zO7!$>{P4H&kzTvC==&vCw!PH9preufa?KHrl_BR>KG^)n@T8lhYRZxV1txpNOZnLs z9{+xKby7*43eOpX%WL%Nol}>cjhS-Oa!+p2nb$g-kL&H#|0%bBt>~V@%1v({oh+DJ zu*3JZ>5n>Zcfq;Vo%7#W@AmdjHMg#B<>!1_QNE;Azdihqv3$ZYm5m=3J2Kw=$#IE& zQjSEu`+CENGKY3IE!p#a_SUFp>zoW$I5HeRvr%`|oqh3-q<<{9_~1~vr)rd|lG*0) zf9JME23y>YzfvyICGlszWWM}`_dPvTS9cqpJ-Rx$yRO|h_N?}~g7WlvuF_UE6c_e=pLybKv%dGn1>W!b|+`U;Dcvy)(IF z-KA|wul`9FrE@VpT;9U)rFTo@mopAc6(6r^7(|@jF0du%n&^wHg#8DzK1e*TX8jc) z&#`*zd$9+TR4+dBR??8Q6s@(eIf_Hu&YsYP#>y-d@SkMgS4 zUAE^&EzgcQGk5h*vrCtjVPAdi(dJKw{?1gp8JDP5`crV3#+AcoT$Ap#ylWHb=Xd>f zAh;&vz`199xicQCHa}X{#MiJ{_w176$&oi|-f=UqPT{dXE_veNzV$hq?e%9S>$K({ znqGaxe%7Md%fG$3Vp1WZ!Q#e?rnXZ=fM*7SbR?|SI4kJWf*?wj@M(W%c>GpAf~Qg_yRSI@uZRo{}I zcg?4kuR4hUt`Cr}7Gxhnlb8>wtKL0rSF7NzZ-=e*v zur8~uxQ#cr&|<1)R^)^Y3;2@{X_o9e{J3O?*XKPBK>TnbhWom&dFw}*B8<;k9&29ew!E;vo!95c$3eK*M`sB?p$>idZ`Ttt; zvIIru$QMSKS8{Lv6naHnKv>$x`p67B&fNzY9OU?FrrTF8wY*Z3J*(+@$)E4OUhCSw zRMh`|E33`>{py$5SJ^$d&isui?~u5>X|7z+ff-NS0)D3G=_Jcqeq(*||1tk|-FXTR ztgI9#dn>3teOcHxd(y`9M>sc^em?Qy>+I+-JKrt`&(*7e_)8qeU6d3nzFJafUBQ^EgK zzV9}&5NP~julhE5%f{Q*6?2xBNI7YWu0HSm>%^>sbBxv4s=q&P%*$C+a&cv+-qXqx zYd=NJx*lNZ-12);rrnSGr#|VoUFw{WXyW%-&BH>E)!CObcwJYEWZOoc@Xso>ec5VJ zFXS%uUAuMpV}yBZ{q6J7v(8;IdaUEFU8?VNw^4hirnqYaPmjpjt>;;~ciuCr+1u&G zp`SnTf3EzuV|wPb37ShJzZ_ohY~~fQ8B_Ta>MWxY+qj$L99WeZM0+kZMSs?hQVd9_ zntw!#)xo!V&FVc7t3`Ex?_DnS&A0x;S>C7G`;M+DTOX4)G3(tnjwSU|URpDpa+S*S zW?1`L%p=cj#lF7_)GpX{s6Wu{bA5FF)l^mE>l-I9KN0Dcomsf}c@=l&6|E_klbnxC zk9s_Nb&X4S$K%B9PaM?5w657Iu6`$YWq-v6&eonu|1YpU`pKF$A=1Us#O=)F=Zk`F z1eEt~C=lt4G*Q{iT`SJcQnjF|sQ&iZnfIIvcb@;e@MUqVH#c+hz4nPI9EyF5<^{}( z6ew(;|8ja(nSx{Hh53g%F8!(QxoJClSE}3YWp-aCyY8NH%yQRHh0^P{irCG09?e*^ zpr7x70ZVO6hG)&c7hTPFpM1+$ednswvFp<-T5sn>KVjY&Y{&Dei(UPY*OnLeIKBm^ z)H?)o9iHl(u_0&nv8`VNZX7+$a3_EMHgUV%SC1JyelGH#HR4@scB0VNPy2ogUAbX; zE$^AASj*x)61(``eimBc!6_S;c|7|JtLK;h_YO{X5Z&1Er?Or;$$kFk0-JM{Y8QG` zudFC)>}OdAgyrPy#sldyvqTq}gU48N=r^tklE zp(8o>7{}G=40E3+7T<~0IKO^_Q@I1<+&I;bTFlL^mk)omJ%90jYTmOwcN(TF{$;$k z-0}Uh-*3;Ze{=ZM<%UZ`t%IlRacyb`S&B^xd&A@sW)i3c1leQjR zs1f|nqO|pOOiLrTW@p^rweKPtLpDwH+9}>tW00hCb1_q_>*33BJ`Zkov`utyv0^(Q z$-%7l%Gpj0v8oZqEqu1t-r z8*aRheX#nr`TEKN^O%hf^b!tkzx==Z_UiR6wwuG6U{^mkseMihgy!tad3|*5MB;PVqLDL^EH|-Ws&_)%r@g zd$s}3W8?F(uJ#>1`*rv2_YC5e$6Zw_Lr#bUT+NvBTGuJ|@855)o@?{%)p^i(W|BvT zkFw6A1-Ih&)*f%-?Wq;t;2~C7uwL=!qQt=c?_bvk-rZOA_prD8BTuo^rsx}&@0nlM zKAG@2`{1F+87Uic?rvtNyxwcXE^}p}%QaK}9sV1HcJ?fpqUV}5<(vioaalb<@rS$g z*k7$WTVH8mvNcYm?RcNn_t<>39_wD#FQsc29Xp;qu_ZNL*~pw_tG@k}x3aw3?|RH_ z&y#pnx>!sjr~Xx3=we4EmJhSkS7@{;@3?p^FL#+#6w}o?ho^4nm}2v$|82y3(E>|P zmmgW(dk^do6R%Scurk~BVh8iV2V1VX$%gD^)Kz6z{jzG7)T^^BJued0tFf5%HQSl+ zUQ6RUDfY?uVMmKxSnd6;FP*|%ovoJmKHFg_1tY`?guUe9RlP36c*rgd|Sx_yd)liXT1-{k)oaI7D-P0Fxfmz8y=B#w$HE*=57$ z{m1*z+l`qkm|p~b-5RLy#-Z$?{YCZ!Uat)=-D5m2erOS@o1v>^ye<6ky4!aI8rf2- zs<(#j&C`=X-#(19h@Q+k;$-{WaX+4(NuJV)VK z>x`?vr}|&u>%G-nGo@{#k{^es;Q0wxUa9CO&a^u;X`04uUQ@j@XKmEyw4|oF7;ku& zWVHCd+TbSl8RSt`UcX``}6z_*D}3ob;>IkWOWSCIY7WlJTuZL2@N z&FRn-UXMfzyBPJt3TL&GNt;#DEF}!r9ta8Q{%~{B?=4SS{^=)K`6?F0&8wa_r!VP4 zi1mw|%k12nxGua&3#pCH`qRq5G_}0T&7||e{Rtdw+gHi-@0DEUm$yc`C#yRo^0#^P z0xQ1c?dl6Qs$9Qtpif#V&fkhpzCDkHbM5K+V>v5%cN%Q-GOv=lFm3J*W9vDoepgM8 z?cx_)#ll@5a_ae)0}@Y-?XSu8Jv0-F0%| zvCg11ixaP}dMWVy_iGbQW$nsHmCLRbAAGmRU)Q~vaQ~*P%nh#&83P2c9UPV+bbJBY+9F5|0eKBLqW&mx7v$z>-ewo z>6rW8Sj1K!`{=!6)K-ZX|KeuGKD%gL$9z@ORHEUNplj@QF;&~Qf_r->7JOtM zjJ0WQJ;)gCr+@viXGwjLZrH`o3f)~j6XV<_Br_-~7?~G(y}d2GhOtG;SmW%5E8dVKEO^iF+mXmd-)o)zFHdtixVhS?I@Nzn=+gFy z-XbS6NAzB0ZqyW}!sqF-9cQImoo-~U=D)Pz?N)D(T!&t!plz|-a!U;Bg6CI}dnXw`wNdcbG0S%=p@ggEIzmujva-EWXO!D^! ztwla!8{+27=2@Iss}$^#8TiLfNqL@1?VCySPTTz19IhwSYg^26XrsIefAQw$&;7Ix z)}?VDK5ntyNP10@<{}$*RnfvJ(dnPO!Wq}>6L+on-DP!P@ms}La^K8FR{1hKxg>Bz zx87ss5_yGPreQl*OqmcpyXo;_#tl=oH-GuN?waMHoKEYQ-8oX5jb_Zx>hcp@qiW#t z>WP~1^?wgI&$Y-s-OAT`;qF(FsPhZFeqCO-!$6W+7{kpjWEl87U#zn)U`={q{PEM(prjfn@A)W@xjl>TnivVoKD?{(+xpWe=H z7MOdgX#O85N%7z>b~4pkrJ<)Hj_DM4<<4p3XDvJu#G=jfzOKpQiuZM%WQHX(BHXyv zRd+N?UXV}E*nGUrjD6eljT?k_e3+TivDTp{obO4>w9lJEFR72P!t0UQ8E2LHMZgu3TB^>)- zMy;{>es7X_!;_y=&b|It_&4tQ<&Vtg8~%%~G5q%6(Z%`6?bkNmVG+D>;nj2Qe;?b{ z%!qmZ;AB~lhf2w;>7K%iYCg=oYw>6%M_Pa}_q_U=5kM(-FO9e<@z7?Pxt=JKUcl^{&nvFAIC%@O{I55G47t}Hb;NmA-_AU zkItns{4gy1-rMdY$r0bD?s>-Rk~8P?1^+)B<+iLZkiT;*XRiIv3lB@Wzq8mKU4Jm$ zvm%g#U4C)INs;pFx7k04mEAM>oryxF>6Cqfd3r71}I)Ur8d~ukdB{f2jxk zVuGJnE_$P*_8_Oo>$BaD)p|Z6(@!&1PH|vk2of`t_$ebjL2v4{t*RRqPG&NC$GuBY z#X5Gz`J~+I0`%SV2($Q{2L}Hn$Fy?XyS$%uIaa3>v!#cD^=WW92@=K z%H)Or-6xfgR;>SfG+S^f&u57r{%e`rGR`jlGQn`3(D&!_l%mcol6h@^|ata>wXrc;C7zv zc2X&Ub3Vj-Hy+-;?_cbjqF-f4m&p{BqVb@#WIx#e&wWx4ioOFu7ZN+l)W; z?)P>mwVg13Jm2%_7pD-`MwtWW7id+x?=@TTC^obH#nlY`&0mu>;^wTI_|jKQRI6am z%NI-i61DfA^esq-phrHPOIXYX7MB7xB2f04F7gp6ht-^cWpH;Vys#*p;oZwu{ zXK-V6k;OMJd*f5WLcN!IE?!(jL&X| z?mqgeeAVsM8`o)iF|(QW>5nR>?@UuHj5440EcNy^I}h)3B3}Y;xc=Me zG%HplNbdAb&29P@)=UtR+P3}m@!0bA{53k4x`S`Lp7qjo-u6wCGpo*>?dy?RE z|Ipb5c`v3aU%W1n?6G#nZ!MJciqk0!CAgMcE|6!eRb94 zpU>XbxYucL;*igqckjwGrBbx+sV0iGNV%Q5>;L&tQh zPwqM%DSOGju*oBROUdQ?T_yEZ4nZ63zgE^q&Wzru9(Z)0)Qej)WZc?Unm^T+=zOqm zv3cIig|lx7DW@h!)ji%Z<99UYq=!Zyp8Z|R@bVSA(ykeDB9~`O%E&Z7^!LiSSH(3a3`P$8jbj$AbN^unP zzBQ>s;<8^x`re@9346nZkD8|}%82|SR&wd9&0@9X2UpLOmFk>VnDMgs1%r;Z&-e0l zvBwcl58L#XCWt*~(&OJ3_{q3(spzrV=#tXC+bWeR`k5=^pB|UextV;h%u+C7(bYA7 zH|g&>c0uDc$Gb4Arsws^_r6bk$zHYUN7R#2!`b{c&ktv>S5=q1A-AK;r^&$k`Zt;U zHvV-?tYaNaMk4)Wnl!{IJEurc->6}PjaHIDwl}n8wrv(4r zecZNTRlv_X1-6kQ8GFAtNk7$%-LufUq)1e2ipvxgZ>0@ia=vYzKUHM&lX~ycwnV1i z@<+5HPflI)tebi2!fUCALXItGO;8SaZq#9#-D>iy6* z!GbGflM1)%n~sB4Q+R@I+-sf^zWH~9;IZWaoHwIuU3=By*IoRoB^Y|5B(Cco2{J;ZUq655qM)w@l?a&hrDTVZWdi1BiZs)t_S8yers^%;LNh(o4&_jMmWon z3){YUa_vd__+LQb+No~E;&XOs$%bnzj(hKtS5ONMYus4PB3o%#X1iA>Jt7B zPwJBvn+JW5bzZEq^XN~0Hgxgyu++MxQ>f6;T7jB4# zMu~__YE@F-U9#lF?_Z5O=OwD`+NvEtiFayic!TtXdV%E5hv}!Y9+q7^RBe0m_nhK; zXI}AzNK1xwG%vWIo6UYD=7jgFqnBV@_G$h+@E z*_P_Q9|x|;9*kiUlI@?Kc4l=I$Br0}6otmyS)us_fts_qXXc$+KCS;Cw1Ok|1FrynLV@$m;OwH5q2 z&8L@2o`ahaR51_Vkw7zNx?WoYB86rLv{1{Zr=7 z=LOtSFJ7Gt^;e8Me}*Hktv%6%*SOSr(^f{#gUY9m7;kV|n)KB6z~3z)d9TARJN(R_ z%kiv4TU(p!&t-;9x2kk+?q7Ml*nIA}bJYrpszuqVPgWe-mYp;G(A6%@^Z6Y;na1nes;qgHw9&h3t=1FfDuJ8KA>)YWJC{jGjS3!k0*w!fb^!)f{YnzSp z42vB9T7;!>ta$s$+5AI$z!bCC>aE|hkNK=iP)@4fz&JTSHeXR)rDEU9y{d*=)0pC) zN+pR3wg@UuuxL=Is}@L<_*CZ9wYjcUpee85yQOdRT=(t*#T*Te@5P7Q_+vs|M;Euf zRJE~WNJ-v(N#b0#-}bPj79l0Mkvrq&`F%gzGV6%B`#+9NTYv9Tm)hbiv%&k|Z0(qZ z>9-A8oQ^-LzvRfbNv+YJW0iP{nPf6wr15dN;QuTOc23js;@&;=R4c2@gSN$S?fNy$ z#tT1Qkx*P5^6vjVOSL;TDrU_5-^!}*TzhbO(_-@g-;2Cuv2rhD6HR31uw8raq;XsG zkA+mnmZt}|udtlq%B{@!biVbwNj1AFMcDmI`oo$H6q|$|l-K7r=45PRI8tZyczb=o z2WOGUtqo~&mzqtOZF%{(R$k*)zgIIRe2!#J|3CX?%z@Ww?h87^3p1Lv+qa!ieBHV% z#-G#mhR!dA6rm-aDcZk0K5TmWT<7=MT$Vz9h0HpZ6ZS=Ba|)}?Z#Ai@v8)zYV6%{& zr8avGoBUR`7wkRf1-9nYdldh*J6-s6OOLWx)#+1!@u-)H6E%J^j0&XWPW%4v1?Pnk;IjF&y`@6Lprkv&5P}TIcbZ>R}XMMZI$g>)vuAcRxS`6>k z#ngOwH)n5cSlw5qpT;bgK3